Simplified scalar(0.0) -> scalar(0) and scalar(1.0) -> scalar(1)

This commit is contained in:
Henry Weller
2017-07-21 17:37:37 +01:00
parent 2c3826ebd9
commit 53a524a280
27 changed files with 65 additions and 65 deletions

View File

@ -147,10 +147,10 @@ Foam::XiEqModel::calculateSchelkinEffect(const scalar uPrimeCoef) const
const scalarField upLocal(uPrimeCoef*sqrt((U & CT & U)*cellWidth));
const scalarField deltaUp(upLocal*(max(scalar(1.0), pow(nr, 0.5)) - 1.0));
const scalarField deltaUp(upLocal*(max(scalar(1), pow(nr, 0.5)) - 1.0));
// Re use tN
N.primitiveFieldRef() = upLocal*(max(scalar(1.0), pow(nr, 0.5)) - 1.0);
N.primitiveFieldRef() = upLocal*(max(scalar(1), pow(nr, 0.5)) - 1.0);
return tN;
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2013-2016 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2013-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -170,7 +170,7 @@ License
rDeltaT = max
(
rDeltaT,
(scalar(1.0) - rDeltaTDampingCoeff)*rDeltaT0
(scalar(1) - rDeltaTDampingCoeff)*rDeltaT0
);
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -120,7 +120,7 @@ Foam::maxwellSlipUFvPatchVectorField::maxwellSlipUFvPatchVectorField
else
{
this->refValue() = *this;
this->valueFraction() = scalar(1.0);
this->valueFraction() = scalar(1);
}
}
}

View File

@ -103,7 +103,7 @@
IOobject::NO_WRITE
),
solidRegions[i],
dimensionedScalar("1", dimless, scalar(1.0))
dimensionedScalar("1", dimless, scalar(1))
)
);
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -122,7 +122,7 @@ License
rDeltaT = max
(
rDeltaT,
(scalar(1.0) - rDeltaTDampingCoeff)*rDeltaT0
(scalar(1) - rDeltaTDampingCoeff)*rDeltaT0
);
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -121,7 +121,7 @@ License
rDeltaT = max
(
rDeltaT,
(scalar(1.0) - rDeltaTDampingCoeff)*rDeltaT0
(scalar(1) - rDeltaTDampingCoeff)*rDeltaT0
);
}

View File

@ -126,7 +126,7 @@
rDeltaT = max
(
rDeltaT,
(scalar(1.0) - rDeltaTDampingCoeff)*rDeltaT0
(scalar(1) - rDeltaTDampingCoeff)*rDeltaT0
);
Info<< "Damped flow time scale min/max = "

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2014-2015 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2014-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -129,9 +129,9 @@ Foam::tmp<Foam::volScalarField> Foam::blendingMethods::linear::f1
(
(phase1 - maxFullAlpha)
/(maxPartAlpha - maxFullAlpha + SMALL),
scalar(0.0)
scalar(0)
),
scalar(1.0)
scalar(1)
);
}
@ -154,9 +154,9 @@ Foam::tmp<Foam::volScalarField> Foam::blendingMethods::linear::f2
(
(maxPartAlpha - phase2)
/(maxPartAlpha - maxFullAlpha + SMALL),
scalar(0.0)
scalar(0)
),
scalar(1.0)
scalar(1)
);
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -25,7 +25,7 @@ Class
Foam::one
Description
A class representing the concept of 1 (scalar(1.0)) used to avoid
A class representing the concept of 1 (scalar(1)) used to avoid
unnecessary manipulations for objects which are known to be one at
compile-time.

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2012-2016 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2012-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -578,7 +578,7 @@ void Foam::polyMeshFilter::checkMeshEdgesAndRelaxEdges
}
}
syncTools::syncEdgeList(mesh_, minEdgeLen_, minEqOp<scalar>(), scalar(0.0));
syncTools::syncEdgeList(mesh_, minEdgeLen_, minEqOp<scalar>(), scalar(0));
for (label smoothIter = 0; smoothIter < maxSmoothIters(); ++smoothIter)
{
@ -614,7 +614,7 @@ void Foam::polyMeshFilter::checkMeshEdgesAndRelaxEdges
mesh_,
minEdgeLen_,
minEqOp<scalar>(),
scalar(0.0)
scalar(0)
);
}
}
@ -824,7 +824,7 @@ void Foam::polyMeshFilter::mapOldMeshEdgeFieldToNewMesh
newMesh,
newMeshMinEdgeLen,
maxEqOp<scalar>(),
scalar(0.0)
scalar(0)
);
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -148,7 +148,7 @@ void Foam::phaseHydrostaticPressureFvPatchScalarField::updateCoeffs()
// scalar rhor = 1000;
// scalarField alphap1 = max(min(alphap, 1.0), 0.0);
// valueFraction() = alphap1/(alphap1 + rhor*(1.0 - alphap1));
valueFraction() = max(min(alphap, scalar(1.0)), scalar(0.0));
valueFraction() = max(min(alphap, scalar(1)), scalar(0));
refValue() =
pRefValue_

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2012-2016 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2012-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -245,7 +245,7 @@ public:
return
bf*tScheme1_().weights(vf)
+ (scalar(1.0) - bf)*tScheme2_().weights(vf);
+ (scalar(1) - bf)*tScheme2_().weights(vf);
}
@ -261,7 +261,7 @@ public:
return
bf*tScheme1_().interpolate(vf)
+ (scalar(1.0) - bf)*tScheme2_().interpolate(vf);
+ (scalar(1) - bf)*tScheme2_().interpolate(vf);
}
@ -290,7 +290,7 @@ public:
(
bf
* tScheme1_().correction(vf)
+ (scalar(1.0) - bf)
+ (scalar(1) - bf)
* tScheme2_().correction(vf)
);
}
@ -307,7 +307,7 @@ public:
{
return
(
(scalar(1.0) - bf)
(scalar(1) - bf)
* tScheme2_().correction(vf)
);
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015-2016 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2015-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -273,7 +273,7 @@ public:
return
bf*tScheme1_().weights(vf)
+ (scalar(1.0) - bf)*tScheme2_().weights(vf);
+ (scalar(1) - bf)*tScheme2_().weights(vf);
}
@ -289,7 +289,7 @@ public:
return
bf*tScheme1_().interpolate(vf)
+ (scalar(1.0) - bf)*tScheme2_().interpolate(vf);
+ (scalar(1) - bf)*tScheme2_().interpolate(vf);
}
@ -318,7 +318,7 @@ public:
(
bf
* tScheme1_().correction(vf)
+ (scalar(1.0) - bf)
+ (scalar(1) - bf)
* tScheme2_().correction(vf)
);
}
@ -335,7 +335,7 @@ public:
{
return
(
(scalar(1.0) - bf)
(scalar(1) - bf)
* tScheme2_().correction(vf)
);
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -173,7 +173,7 @@ public:
{
return
blendingFactor_*tScheme1_().weights(vf)
+ (scalar(1.0) - blendingFactor_)*tScheme2_().weights(vf);
+ (scalar(1) - blendingFactor_)*tScheme2_().weights(vf);
}
@ -187,7 +187,7 @@ public:
{
return
blendingFactor_*tScheme1_().interpolate(vf)
+ (scalar(1.0) - blendingFactor_)*tScheme2_().interpolate(vf);
+ (scalar(1) - blendingFactor_)*tScheme2_().interpolate(vf);
}
@ -214,7 +214,7 @@ public:
(
blendingFactor_
* tScheme1_().correction(vf)
+ (scalar(1.0) - blendingFactor_)
+ (scalar(1) - blendingFactor_)
* tScheme2_().correction(vf)
);
}
@ -231,7 +231,7 @@ public:
{
return
(
(scalar(1.0) - blendingFactor_)
(scalar(1) - blendingFactor_)
* tScheme2_().correction(vf)
);
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -194,7 +194,7 @@ public:
(
blendingFactor
* tScheme1_().correction(vf)
+ (scalar(1.0) - blendingFactor)
+ (scalar(1) - blendingFactor)
* tScheme2_().correction(vf)
);
}
@ -211,7 +211,7 @@ public:
{
return
(
(scalar(1.0) - blendingFactor)
(scalar(1) - blendingFactor)
* tScheme2_().correction(vf)
);
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -206,7 +206,7 @@ public:
(
blendingFactor
* tScheme1_().correction(vf)
+ (scalar(1.0) - blendingFactor)
+ (scalar(1) - blendingFactor)
* tScheme2_().correction(vf)
);
}
@ -223,7 +223,7 @@ public:
{
return
(
(scalar(1.0) - blendingFactor)
(scalar(1) - blendingFactor)
* tScheme2_().correction(vf)
);
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -84,7 +84,7 @@ void Foam::snappyLayerDriver::sumWeights
meshPoints,
invSumWeight,
plusEqOp<scalar>(),
scalar(0.0) // null value
scalar(0) // null value
);
forAll(invSumWeight, pointi)

View File

@ -108,7 +108,7 @@ void reactingOneDim::updateqr()
// qr is positive going in the solid
// If the surface is emitting the radiative flux is set to zero
qrBf[patchi] = max(qrBf[patchi], scalar(0.0));
qrBf[patchi] = max(qrBf[patchi], scalar(0));
}
const vectorField& cellC = regionMesh().cellCentres();

View File

@ -336,9 +336,9 @@ void filmPyrolysisRadiativeCoupledMixedFvPatchScalarField::updateCoeffs()
max
(
(filmDelta - filmDeltaDry_)/(filmDeltaWet_ - filmDeltaDry_),
scalar(0.0)
scalar(0)
),
scalar(1.0)
scalar(1)
)
);

View File

@ -212,7 +212,7 @@ tmp<scalarField> curvatureSeparation::calcCosAngle
volCosAngle.write();
}
return max(min(cosAngle, scalar(1.0)), scalar(-1.0));
return max(min(cosAngle, scalar(1)), scalar(-1));
}

View File

@ -117,7 +117,7 @@ void standardPhaseChange::correctModel
const vectorField dU(film.UPrimary() - film.Us());
const scalarField limMass
(
max(scalar(0.0), availableMass - deltaMin_*rho*magSf)
max(scalar(0), availableMass - deltaMin_*rho*magSf)
);
forAll(dMass, celli)

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -121,7 +121,7 @@ bool Foam::sampledIsoSurfaceCell::updateGeometry() const
if (average_)
{
//- From point field and interpolated cell.
scalarField cellAvg(fvm.nCells(), scalar(0.0));
scalarField cellAvg(fvm.nCells(), scalar(0));
labelField nPointCells(fvm.nCells(), 0);
{
for (label pointi = 0; pointi < fvm.nPoints(); pointi++)

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011-2015 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -178,7 +178,7 @@ void Foam::MarshakRadiationFixedTemperatureFvPatchScalarField::updateCoeffs()
const scalarField temissivity = emissivity();
const scalarField Ep(temissivity/(2.0*(scalar(2.0) - temissivity)));
const scalarField Ep(temissivity/(2*(2 - temissivity)));
// Set value fraction
valueFraction() = 1.0/(1.0 + gamma*patch().deltaCoeffs()/Ep);

View File

@ -212,7 +212,7 @@ updateCoeffs()
valueFraction()[facei] = 1.0;
refValue()[facei] =
(
Ir[facei]*(scalar(1.0) - temissivity[facei])
Ir[facei]*(scalar(1) - temissivity[facei])
+ temissivity[facei]*physicoChemical::sigma.value()
* pow4(Tp[facei])
)/pi;

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -144,11 +144,11 @@ void Foam::singleStepReactingMixture<ThermoType>::fresCorrect()
const label speciei = reaction.lhs()[i].index;
if (speciei == fuelIndex_)
{
fres_[speciei] = max(YFuel - YO2/s_, scalar(0.0));
fres_[speciei] = max(YFuel - YO2/s_, scalar(0));
}
else if (speciei == O2Index)
{
fres_[speciei] = max(YO2 - YFuel*s_, scalar(0.0));
fres_[speciei] = max(YO2 - YFuel*s_, scalar(0));
}
}

View File

@ -63,7 +63,7 @@ Foam::viscosityModels::powerLaw::calcNu() const
dimensionedScalar("one", dimTime, 1.0)*strainRate(),
dimensionedScalar("VSMALL", dimless, VSMALL)
),
n_.value() - scalar(1.0)
n_.value() - scalar(1)
)
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2016 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2016-2017 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -112,7 +112,7 @@ int main(int argc, char *argv[])
),
mesh.C()/magSqr(mesh.C())
);
radialDirection.replace(vector::Z, scalar(0.0));
radialDirection.replace(vector::Z, scalar(0));
radialDirection /= sqrt(magSqr(radialDirection));
radialDirection.write();
@ -135,7 +135,7 @@ int main(int argc, char *argv[])
),
transform2Tangencial & mesh.C()
);
angularDirection.replace(vector::Z, scalar(0.0));
angularDirection.replace(vector::Z, scalar(0));
angularDirection /= sqrt(magSqr(angularDirection));
angularDirection.write();