diff --git a/applications/solvers/combustion/PDRFoam/XiModels/XiEqModels/XiEqModel/XiEqModel.C b/applications/solvers/combustion/PDRFoam/XiModels/XiEqModels/XiEqModel/XiEqModel.C index 7e3b2536b1..0c610fc6b5 100644 --- a/applications/solvers/combustion/PDRFoam/XiModels/XiEqModels/XiEqModel/XiEqModel.C +++ b/applications/solvers/combustion/PDRFoam/XiModels/XiEqModels/XiEqModel/XiEqModel.C @@ -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; } diff --git a/applications/solvers/combustion/reactingFoam/setRDeltaT.H b/applications/solvers/combustion/reactingFoam/setRDeltaT.H index b0f9c02b65..0a0ecd7cfc 100644 --- a/applications/solvers/combustion/reactingFoam/setRDeltaT.H +++ b/applications/solvers/combustion/reactingFoam/setRDeltaT.H @@ -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 ); } diff --git a/applications/solvers/compressible/rhoCentralFoam/BCs/U/maxwellSlipUFvPatchVectorField.C b/applications/solvers/compressible/rhoCentralFoam/BCs/U/maxwellSlipUFvPatchVectorField.C index 4656fe7281..43cc740a9b 100644 --- a/applications/solvers/compressible/rhoCentralFoam/BCs/U/maxwellSlipUFvPatchVectorField.C +++ b/applications/solvers/compressible/rhoCentralFoam/BCs/U/maxwellSlipUFvPatchVectorField.C @@ -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); } } } diff --git a/applications/solvers/heatTransfer/chtMultiRegionFoam/solid/createSolidFields.H b/applications/solvers/heatTransfer/chtMultiRegionFoam/solid/createSolidFields.H index 857f97f245..a39aa32df2 100644 --- a/applications/solvers/heatTransfer/chtMultiRegionFoam/solid/createSolidFields.H +++ b/applications/solvers/heatTransfer/chtMultiRegionFoam/solid/createSolidFields.H @@ -103,7 +103,7 @@ IOobject::NO_WRITE ), solidRegions[i], - dimensionedScalar("1", dimless, scalar(1.0)) + dimensionedScalar("1", dimless, scalar(1)) ) ); } diff --git a/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H b/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H index c31ad040a1..a97b811db3 100644 --- a/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H +++ b/applications/solvers/lagrangian/coalChemistryFoam/setRDeltaT.H @@ -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 ); } diff --git a/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H b/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H index 28bc211e05..15f114afbc 100644 --- a/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H +++ b/applications/solvers/lagrangian/reactingParcelFoam/setRDeltaT.H @@ -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 ); } diff --git a/applications/solvers/multiphase/VoF/setRDeltaT.H b/applications/solvers/multiphase/VoF/setRDeltaT.H index 26b237e795..f9725ec972 100644 --- a/applications/solvers/multiphase/VoF/setRDeltaT.H +++ b/applications/solvers/multiphase/VoF/setRDeltaT.H @@ -126,7 +126,7 @@ rDeltaT = max ( rDeltaT, - (scalar(1.0) - rDeltaTDampingCoeff)*rDeltaT0 + (scalar(1) - rDeltaTDampingCoeff)*rDeltaT0 ); Info<< "Damped flow time scale min/max = " diff --git a/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/BlendedInterfacialModel/blendingMethods/linear/linear.C b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/BlendedInterfacialModel/blendingMethods/linear/linear.C index f89804bb7d..428cfc3142 100644 --- a/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/BlendedInterfacialModel/blendingMethods/linear/linear.C +++ b/applications/solvers/multiphase/twoPhaseEulerFoam/twoPhaseSystem/BlendedInterfacialModel/blendingMethods/linear/linear.C @@ -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::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::blendingMethods::linear::f2 ( (maxPartAlpha - phase2) /(maxPartAlpha - maxFullAlpha + SMALL), - scalar(0.0) + scalar(0) ), - scalar(1.0) + scalar(1) ); } diff --git a/src/OpenFOAM/primitives/one/one.H b/src/OpenFOAM/primitives/one/one.H index a184af000d..b9a88d4412 100644 --- a/src/OpenFOAM/primitives/one/one.H +++ b/src/OpenFOAM/primitives/one/one.H @@ -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. diff --git a/src/dynamicMesh/polyMeshFilter/polyMeshFilter.C b/src/dynamicMesh/polyMeshFilter/polyMeshFilter.C index 58bc03ff1b..7b1bd791d0 100644 --- a/src/dynamicMesh/polyMeshFilter/polyMeshFilter.C +++ b/src/dynamicMesh/polyMeshFilter/polyMeshFilter.C @@ -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(0.0)); + syncTools::syncEdgeList(mesh_, minEdgeLen_, minEqOp(), scalar(0)); for (label smoothIter = 0; smoothIter < maxSmoothIters(); ++smoothIter) { @@ -614,7 +614,7 @@ void Foam::polyMeshFilter::checkMeshEdgesAndRelaxEdges mesh_, minEdgeLen_, minEqOp(), - scalar(0.0) + scalar(0) ); } } @@ -824,7 +824,7 @@ void Foam::polyMeshFilter::mapOldMeshEdgeFieldToNewMesh newMesh, newMeshMinEdgeLen, maxEqOp(), - scalar(0.0) + scalar(0) ); } diff --git a/src/finiteVolume/fields/fvPatchFields/derived/phaseHydrostaticPressure/phaseHydrostaticPressureFvPatchScalarField.C b/src/finiteVolume/fields/fvPatchFields/derived/phaseHydrostaticPressure/phaseHydrostaticPressureFvPatchScalarField.C index 3fed1bf97b..3567b32751 100644 --- a/src/finiteVolume/fields/fvPatchFields/derived/phaseHydrostaticPressure/phaseHydrostaticPressureFvPatchScalarField.C +++ b/src/finiteVolume/fields/fvPatchFields/derived/phaseHydrostaticPressure/phaseHydrostaticPressureFvPatchScalarField.C @@ -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_ diff --git a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/CoBlended/CoBlended.H b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/CoBlended/CoBlended.H index bd1ad10af7..de2766e3ef 100644 --- a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/CoBlended/CoBlended.H +++ b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/CoBlended/CoBlended.H @@ -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) ); } diff --git a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/cellCoBlended/cellCoBlended.H b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/cellCoBlended/cellCoBlended.H index 213633d120..de622ca01c 100644 --- a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/cellCoBlended/cellCoBlended.H +++ b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/cellCoBlended/cellCoBlended.H @@ -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) ); } diff --git a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/fixedBlended/fixedBlended.H b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/fixedBlended/fixedBlended.H index 97c02cdb16..c1cae7e7e1 100644 --- a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/fixedBlended/fixedBlended.H +++ b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/fixedBlended/fixedBlended.H @@ -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) ); } diff --git a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/limiterBlended/limiterBlended.H b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/limiterBlended/limiterBlended.H index 77fc9a0015..ec78c0df22 100644 --- a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/limiterBlended/limiterBlended.H +++ b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/limiterBlended/limiterBlended.H @@ -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) ); } diff --git a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/localBlended/localBlended.H b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/localBlended/localBlended.H index f1a30e1efc..686bbe213b 100644 --- a/src/finiteVolume/interpolation/surfaceInterpolation/schemes/localBlended/localBlended.H +++ b/src/finiteVolume/interpolation/surfaceInterpolation/schemes/localBlended/localBlended.H @@ -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) ); } diff --git a/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyLayerDriverShrink.C b/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyLayerDriverShrink.C index bf127f51b1..49be42c67a 100644 --- a/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyLayerDriverShrink.C +++ b/src/mesh/snappyHexMesh/snappyHexMeshDriver/snappyLayerDriverShrink.C @@ -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(0.0) // null value + scalar(0) // null value ); forAll(invSumWeight, pointi) diff --git a/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C b/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C index d864f726c9..782b72896e 100644 --- a/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C +++ b/src/regionModels/pyrolysisModels/reactingOneDim/reactingOneDim.C @@ -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(); diff --git a/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.C b/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.C index dac63860b8..7d02783f89 100644 --- a/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.C +++ b/src/regionModels/regionCoupling/derivedFvPatchFields/filmPyrolysisRadiativeCoupledMixed/filmPyrolysisRadiativeCoupledMixedFvPatchScalarField.C @@ -336,9 +336,9 @@ void filmPyrolysisRadiativeCoupledMixedFvPatchScalarField::updateCoeffs() max ( (filmDelta - filmDeltaDry_)/(filmDeltaWet_ - filmDeltaDry_), - scalar(0.0) + scalar(0) ), - scalar(1.0) + scalar(1) ) ); diff --git a/src/regionModels/surfaceFilmModels/submodels/kinematic/injectionModel/curvatureSeparation/curvatureSeparation.C b/src/regionModels/surfaceFilmModels/submodels/kinematic/injectionModel/curvatureSeparation/curvatureSeparation.C index fb7ced6e9c..bc445dc7a9 100644 --- a/src/regionModels/surfaceFilmModels/submodels/kinematic/injectionModel/curvatureSeparation/curvatureSeparation.C +++ b/src/regionModels/surfaceFilmModels/submodels/kinematic/injectionModel/curvatureSeparation/curvatureSeparation.C @@ -212,7 +212,7 @@ tmp curvatureSeparation::calcCosAngle volCosAngle.write(); } - return max(min(cosAngle, scalar(1.0)), scalar(-1.0)); + return max(min(cosAngle, scalar(1)), scalar(-1)); } diff --git a/src/regionModels/surfaceFilmModels/submodels/thermo/phaseChangeModel/standardPhaseChange/standardPhaseChange.C b/src/regionModels/surfaceFilmModels/submodels/thermo/phaseChangeModel/standardPhaseChange/standardPhaseChange.C index 35a72f12cb..4926ebede5 100644 --- a/src/regionModels/surfaceFilmModels/submodels/thermo/phaseChangeModel/standardPhaseChange/standardPhaseChange.C +++ b/src/regionModels/surfaceFilmModels/submodels/thermo/phaseChangeModel/standardPhaseChange/standardPhaseChange.C @@ -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) diff --git a/src/sampling/sampledSurface/isoSurface/sampledIsoSurfaceCell.C b/src/sampling/sampledSurface/isoSurface/sampledIsoSurfaceCell.C index a44c155d04..61f95c58a1 100644 --- a/src/sampling/sampledSurface/isoSurface/sampledIsoSurfaceCell.C +++ b/src/sampling/sampledSurface/isoSurface/sampledIsoSurfaceCell.C @@ -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++) diff --git a/src/thermophysicalModels/radiation/derivedFvPatchFields/MarshakRadiationFixedTemperature/MarshakRadiationFixedTemperatureFvPatchScalarField.C b/src/thermophysicalModels/radiation/derivedFvPatchFields/MarshakRadiationFixedTemperature/MarshakRadiationFixedTemperatureFvPatchScalarField.C index b55812ace1..0de768c5cf 100644 --- a/src/thermophysicalModels/radiation/derivedFvPatchFields/MarshakRadiationFixedTemperature/MarshakRadiationFixedTemperatureFvPatchScalarField.C +++ b/src/thermophysicalModels/radiation/derivedFvPatchFields/MarshakRadiationFixedTemperature/MarshakRadiationFixedTemperatureFvPatchScalarField.C @@ -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); diff --git a/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveRadiation/greyDiffusiveRadiationMixedFvPatchScalarField.C b/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveRadiation/greyDiffusiveRadiationMixedFvPatchScalarField.C index 4eabcb20c2..ec4f0ba7dc 100644 --- a/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveRadiation/greyDiffusiveRadiationMixedFvPatchScalarField.C +++ b/src/thermophysicalModels/radiation/derivedFvPatchFields/greyDiffusiveRadiation/greyDiffusiveRadiationMixedFvPatchScalarField.C @@ -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; diff --git a/src/thermophysicalModels/reactionThermo/mixtures/singleStepReactingMixture/singleStepReactingMixture.C b/src/thermophysicalModels/reactionThermo/mixtures/singleStepReactingMixture/singleStepReactingMixture.C index cd54215071..4ecdfc00c1 100644 --- a/src/thermophysicalModels/reactionThermo/mixtures/singleStepReactingMixture/singleStepReactingMixture.C +++ b/src/thermophysicalModels/reactionThermo/mixtures/singleStepReactingMixture/singleStepReactingMixture.C @@ -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::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)); } } diff --git a/src/transportModels/incompressible/viscosityModels/powerLaw/powerLaw.C b/src/transportModels/incompressible/viscosityModels/powerLaw/powerLaw.C index ec84ba2028..9ce16ca21c 100644 --- a/src/transportModels/incompressible/viscosityModels/powerLaw/powerLaw.C +++ b/src/transportModels/incompressible/viscosityModels/powerLaw/powerLaw.C @@ -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) ) ) ); diff --git a/tutorials/mesh/refineMesh/refineFieldDirs/calcRadiusField/calcRadiusField.C b/tutorials/mesh/refineMesh/refineFieldDirs/calcRadiusField/calcRadiusField.C index a607777d03..7cdab1c93d 100644 --- a/tutorials/mesh/refineMesh/refineFieldDirs/calcRadiusField/calcRadiusField.C +++ b/tutorials/mesh/refineMesh/refineFieldDirs/calcRadiusField/calcRadiusField.C @@ -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();