diff --git a/applications/solvers/combustion/dieselEngineFoam/createSpray.H b/applications/solvers/combustion/dieselEngineFoam/createSpray.H index b86b3684c2..ac473957e5 100644 --- a/applications/solvers/combustion/dieselEngineFoam/createSpray.H +++ b/applications/solvers/combustion/dieselEngineFoam/createSpray.H @@ -32,7 +32,5 @@ if (dieselSpray.twoD()) gasMass0 *= 2.0*mathematicalConstant::pi/dieselSpray.angleOfWedge(); } -reduce(gasMass0, sumOp()); - gasMass0 -= dieselSpray.injectedMass(runTime.value()) - dieselSpray.liquidMass(); diff --git a/applications/solvers/combustion/dieselEngineFoam/spraySummary.H b/applications/solvers/combustion/dieselEngineFoam/spraySummary.H index 907784b438..5b251e2290 100644 --- a/applications/solvers/combustion/dieselEngineFoam/spraySummary.H +++ b/applications/solvers/combustion/dieselEngineFoam/spraySummary.H @@ -23,8 +23,6 @@ gasMass *= 2.0*mathematicalConstant::pi/dieselSpray.angleOfWedge(); } - reduce(gasMass, sumOp()); - scalar addedMass = gasMass - gasMass0; Info<< "Added gas mass................. | " << 1e6*addedMass << " mg" diff --git a/applications/utilities/mesh/generation/extrudeMesh/extrudeMesh.C b/applications/utilities/mesh/generation/extrudeMesh/extrudeMesh.C index 0bb37f6727..37860e27b2 100644 --- a/applications/utilities/mesh/generation/extrudeMesh/extrudeMesh.C +++ b/applications/utilities/mesh/generation/extrudeMesh/extrudeMesh.C @@ -52,19 +52,18 @@ using namespace Foam; int main(int argc, char *argv[]) { -# include "setRoots.H" -# include "createTimeExtruded.H" + #include "setRoots.H" + #include "createTimeExtruded.H" - - if (args.options().found("sourceRoot") == args.options().found("surface")) + if (args.options().found("sourceCase") == args.options().found("surface")) { FatalErrorIn(args.executable()) - << "Need to specify either -sourceRoot/Case/Patch or -surface" - << " option to specify the source of the patch to extrude" + << "Specify either -sourceCase and -sourcePatch" + " or -surface options\n" + " to specify the source of the patch to extrude" << exit(FatalError); } - autoPtr meshPtr(NULL); autoPtr model @@ -84,23 +83,24 @@ int main(int argc, char *argv[]) ) ); - if (args.options().found("sourceRoot")) + if (args.options().found("sourceCase")) { - fileName rootDirSource(args.options()["sourceRoot"]); - fileName caseDirSource(args.options()["sourceCase"]); - fileName patchName(args.options()["sourcePatch"]); + fileName sourceCasePath(args.options()["sourceCase"]); + fileName sourceRootDir = sourceCasePath.path(); + fileName sourceCaseDir = sourceCasePath.name(); + word patchName(args.options()["sourcePatch"]); Info<< "Extruding patch " << patchName - << " on mesh " << rootDirSource << ' ' << caseDirSource << nl + << " on mesh " << sourceCasePath << nl << endl; Time runTime ( Time::controlDictName, - rootDirSource, - caseDirSource + sourceRootDir, + sourceCaseDir ); -# include "createPolyMesh.H" + #include "createPolyMesh.H" label patchID = mesh.boundaryMesh().findPatchID(patchName); @@ -171,7 +171,7 @@ int main(int argc, char *argv[]) fMesh, model() ) - ); + ); } extrudedMesh& mesh = meshPtr(); @@ -180,7 +180,7 @@ int main(int argc, char *argv[]) const vector span = bb.span(); const scalar mergeDim = 1E-4 * bb.minDim(); - Pout<< "Mesh bounding box:" << bb << nl + Info<< "Mesh bounding box:" << bb << nl << " with span:" << span << nl << "Merge distance :" << mergeDim << nl << endl; @@ -201,7 +201,7 @@ int main(int argc, char *argv[]) // ~~~~~~~~~~~~~~ { - Pout<< "Collapsing edges < " << mergeDim << " ..." << nl << endl; + Info<< "Collapsing edges < " << mergeDim << " ..." << nl << endl; // Edge collapsing engine edgeCollapser collapser(mesh); @@ -217,7 +217,7 @@ int main(int argc, char *argv[]) if (d < mergeDim) { - Pout<< "Merging edge " << e << " since length " << d + Info<< "Merging edge " << e << " since length " << d << " << " << mergeDim << nl; // Collapse edge to e[0] @@ -252,8 +252,8 @@ int main(int argc, char *argv[]) if (args.options().found("mergeFaces")) { - Pout<< "Assuming full 360 degree axisymmetric case;" - << " stitching faces on patches " + Info<< "Assuming full 360 degree axisymmetric case;" + << " stitching faces on patches " << patches[origPatchID].name() << " and " << patches[otherPatchID].name() << " together ..." << nl << endl; diff --git a/applications/utilities/mesh/generation/extrudeMesh/extrudeModel/wedge/wedge.C b/applications/utilities/mesh/generation/extrudeMesh/extrudeModel/wedge/wedge.C index 27dec921b7..6da971a1bf 100644 --- a/applications/utilities/mesh/generation/extrudeMesh/extrudeModel/wedge/wedge.C +++ b/applications/utilities/mesh/generation/extrudeMesh/extrudeModel/wedge/wedge.C @@ -48,7 +48,7 @@ wedge::wedge(const dictionary& dict) : extrudeModel(typeName, dict), axisPt_(coeffDict_.lookup("axisPt")), - axisNormal_(coeffDict_.lookup("axisNormal")), + axis_(coeffDict_.lookup("axis")), angle_ ( readScalar(coeffDict_.lookup("angle")) @@ -96,7 +96,7 @@ point wedge::operator() // of surface point and surface normal. point d = surfacePoint - axisPt_; - d -= (axisNormal_ & d)*axisNormal_; + d -= (axis_ & d)*axis_; scalar dMag = mag(d); @@ -107,7 +107,7 @@ point wedge::operator() if (dMag > VSMALL) { - vector n = (d/dMag) ^ axisNormal_; + vector n = (d/dMag) ^ axis_; rotatedPoint += + cos(sliceAngle)*d @@ -124,4 +124,3 @@ point wedge::operator() } // End namespace Foam // ************************************************************************* // - diff --git a/applications/utilities/mesh/generation/extrudeMesh/extrudeModel/wedge/wedge.H b/applications/utilities/mesh/generation/extrudeMesh/extrudeModel/wedge/wedge.H index 38b862630d..39c4b4a2d3 100644 --- a/applications/utilities/mesh/generation/extrudeMesh/extrudeModel/wedge/wedge.H +++ b/applications/utilities/mesh/generation/extrudeMesh/extrudeModel/wedge/wedge.H @@ -60,13 +60,13 @@ class wedge { // Private data - //- point on axis + //- Point on axis const point axisPt_; - //- normalized direction of axis - const vector axisNormal_; + //- Normalized direction of axis + const vector axis_; - //- overall angle (radians) + //- Overall angle (radians) const scalar angle_; @@ -80,6 +80,7 @@ public: //- Construct from components wedge(const dictionary& dict); + //- Destrcuctor ~wedge(); diff --git a/applications/utilities/mesh/generation/extrudeMesh/extrudeProperties b/applications/utilities/mesh/generation/extrudeMesh/extrudeProperties index c9b7977508..ecbe160a15 100644 --- a/applications/utilities/mesh/generation/extrudeMesh/extrudeProperties +++ b/applications/utilities/mesh/generation/extrudeMesh/extrudeProperties @@ -24,7 +24,7 @@ nLayers 1; wedgeCoeffs { axisPt (0 0 0); - axisNormal (0 -1 0); + axis (0 -1 0); angle 2.0; } @@ -47,4 +47,3 @@ sigmaRadialCoeffs // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // - diff --git a/applications/utilities/mesh/generation/extrudeMesh/setRoots.H b/applications/utilities/mesh/generation/extrudeMesh/setRoots.H index 255949426b..9c13db28d1 100644 --- a/applications/utilities/mesh/generation/extrudeMesh/setRoots.H +++ b/applications/utilities/mesh/generation/extrudeMesh/setRoots.H @@ -1,7 +1,6 @@ argList::validArgs.clear(); argList::noParallel(); - argList::validOptions.insert("sourceRoot", "source root"); argList::validOptions.insert("sourceCase", "source case"); argList::validOptions.insert("sourcePatch", "source patch"); @@ -15,4 +14,3 @@ { FatalError.exit(); } - diff --git a/src/OpenFOAM/db/IOstreams/Sstreams/ISstream.C b/src/OpenFOAM/db/IOstreams/Sstreams/ISstream.C index 01b92cacee..482abb8bf3 100644 --- a/src/OpenFOAM/db/IOstreams/Sstreams/ISstream.C +++ b/src/OpenFOAM/db/IOstreams/Sstreams/ISstream.C @@ -224,7 +224,16 @@ Foam::Istream& Foam::ISstream::read(token& t) } else { - t = label(atol(numberBuffer)); + long lt = atol(numberBuffer); + t = label(lt); + + // If the integer is too large to be represented as a label + // return it as a scalar + if (t.labelToken() != lt) + { + isScalar = true; + t = scalar(atof(numberBuffer)); + } } } else diff --git a/src/engine/engineMesh/engineMesh/engineMesh.C b/src/engine/engineMesh/engineMesh/engineMesh.C index d425ee75f2..329c1a3963 100644 --- a/src/engine/engineMesh/engineMesh/engineMesh.C +++ b/src/engine/engineMesh/engineMesh/engineMesh.C @@ -43,7 +43,7 @@ Foam::engineMesh::engineMesh(const IOobject& io) linerIndex_(-1), cylinderHeadIndex_(-1), deckHeight_("deckHeight", dimLength, GREAT), - pistonPosition_("deckHeight", dimLength, GREAT) + pistonPosition_("pistonPosition", dimLength, -GREAT) { bool foundPiston = false; bool foundLiner = false; @@ -80,14 +80,14 @@ Foam::engineMesh::engineMesh(const IOobject& io) } if (!foundLiner) - { + { FatalErrorIn("engineMesh::engineMesh(const IOobject& io)") << "cannot find liner patch" << exit(FatalError); } if (!foundCylinderHead) - { + { FatalErrorIn("engineMesh::engineMesh(const IOobject& io)") << "cannot find cylinderHead patch" << exit(FatalError); @@ -96,17 +96,25 @@ Foam::engineMesh::engineMesh(const IOobject& io) { if (pistonIndex_ != -1) { - pistonPosition_.value() = - max(boundary()[pistonIndex_].patch().localPoints()).z(); + pistonPosition_.value() = -GREAT; + if (boundary()[pistonIndex_].patch().localPoints().size()) + { + pistonPosition_.value() = + max(boundary()[pistonIndex_].patch().localPoints()).z(); + } } - reduce(pistonPosition_.value(), minOp()); + reduce(pistonPosition_.value(), maxOp()); if (cylinderHeadIndex_ != -1) { - deckHeight_.value() = min - ( - boundary()[cylinderHeadIndex_].patch().localPoints() - ).z(); + deckHeight_.value() = GREAT; + if (boundary()[cylinderHeadIndex_].patch().localPoints().size()) + { + deckHeight_.value() = min + ( + boundary()[cylinderHeadIndex_].patch().localPoints() + ).z(); + } } reduce(deckHeight_.value(), minOp()); diff --git a/src/finiteVolume/fields/fvPatchFields/derived/fixedInternalValueFvPatchField/fixedInternalValueFvPatchField.C b/src/finiteVolume/fields/fvPatchFields/derived/fixedInternalValueFvPatchField/fixedInternalValueFvPatchField.C index eba3522e36..1cbd6fd72d 100644 --- a/src/finiteVolume/fields/fvPatchFields/derived/fixedInternalValueFvPatchField/fixedInternalValueFvPatchField.C +++ b/src/finiteVolume/fields/fvPatchFields/derived/fixedInternalValueFvPatchField/fixedInternalValueFvPatchField.C @@ -63,9 +63,7 @@ Foam::fixedInternalValueFvPatchField::fixedInternalValueFvPatchField ) : zeroGradientFvPatchField(p, iF, dict) -{ - fvPatchField::operator=(this->patchInternalField()); -} +{} template diff --git a/src/turbulenceModels/compressible/RAS/LRR/LRR.C b/src/turbulenceModels/compressible/RAS/LRR/LRR.C index 6521d8130c..a6588ba17c 100644 --- a/src/turbulenceModels/compressible/RAS/LRR/LRR.C +++ b/src/turbulenceModels/compressible/RAS/LRR/LRR.C @@ -337,7 +337,7 @@ void LRR::correct() RASModel::correct(); volSymmTensorField P = -twoSymm(R_ & fvc::grad(U_)); - volScalarField G("G", 0.5*mag(tr(P))); + volScalarField G("RASModel::G", 0.5*mag(tr(P))); // Update espsilon and G at the wall epsilon_.boundaryField().updateCoeffs(); diff --git a/src/turbulenceModels/compressible/RAS/LaunderGibsonRSTM/LaunderGibsonRSTM.C b/src/turbulenceModels/compressible/RAS/LaunderGibsonRSTM/LaunderGibsonRSTM.C index 4a9987131f..e677d86a50 100644 --- a/src/turbulenceModels/compressible/RAS/LaunderGibsonRSTM/LaunderGibsonRSTM.C +++ b/src/turbulenceModels/compressible/RAS/LaunderGibsonRSTM/LaunderGibsonRSTM.C @@ -367,7 +367,7 @@ void LaunderGibsonRSTM::correct() } volSymmTensorField P = -twoSymm(R_ & fvc::grad(U_)); - volScalarField G("G", 0.5*mag(tr(P))); + volScalarField G("RASModel::G", 0.5*mag(tr(P))); // Update espsilon and G at the wall epsilon_.boundaryField().updateCoeffs(); diff --git a/src/turbulenceModels/compressible/RAS/RNGkEpsilon/RNGkEpsilon.C b/src/turbulenceModels/compressible/RAS/RNGkEpsilon/RNGkEpsilon.C index 3d294ebceb..9e50de343f 100644 --- a/src/turbulenceModels/compressible/RAS/RNGkEpsilon/RNGkEpsilon.C +++ b/src/turbulenceModels/compressible/RAS/RNGkEpsilon/RNGkEpsilon.C @@ -300,7 +300,7 @@ void RNGkEpsilon::correct() volScalarField S2 = (tgradU() && dev(twoSymm(tgradU()))); tgradU.clear(); - volScalarField G("G", mut_*S2); + volScalarField G("RASModel::G", mut_*S2); volScalarField eta = sqrt(mag(S2))*k_/epsilon_; volScalarField eta3 = eta*sqr(eta); diff --git a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.C b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.C index 387f54df33..d7b7547e0a 100644 --- a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.C +++ b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.C @@ -67,7 +67,7 @@ epsilonWallFunctionFvPatchScalarField::epsilonWallFunctionFvPatchScalarField fixedInternalValueFvPatchField(p, iF), UName_("U"), kName_("k"), - GName_("G"), + GName_("RASModel::G"), rhoName_("rho"), muName_("mu"), mutName_("mut") @@ -106,7 +106,7 @@ epsilonWallFunctionFvPatchScalarField::epsilonWallFunctionFvPatchScalarField fixedInternalValueFvPatchField(p, iF, dict), UName_(dict.lookupOrDefault("U", "U")), kName_(dict.lookupOrDefault("k", "k")), - GName_(dict.lookupOrDefault("G", "G")), + GName_(dict.lookupOrDefault("G", "RASModel::G")), rhoName_(dict.lookupOrDefault("rho", "rho")), muName_(dict.lookupOrDefault("mu", "mu")), mutName_(dict.lookupOrDefault("mut", "mut")) @@ -229,7 +229,7 @@ void epsilonWallFunctionFvPatchScalarField::write(Ostream& os) const fixedInternalValueFvPatchField::write(os); writeEntryIfDifferent(os, "U", "U", UName_); writeEntryIfDifferent(os, "k", "k", kName_); - writeEntryIfDifferent(os, "G", "G", GName_); + writeEntryIfDifferent(os, "G", "RASModel::G", GName_); writeEntryIfDifferent(os, "rho", "rho", rhoName_); writeEntryIfDifferent(os, "mu", "mu", muName_); writeEntryIfDifferent(os, "mut", "mut", mutName_); diff --git a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/omegaWallFunctions/omegaWallFunction/omegaWallFunctionFvPatchScalarField.C b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/omegaWallFunctions/omegaWallFunction/omegaWallFunctionFvPatchScalarField.C index eacf26b1d4..897a8c1162 100644 --- a/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/omegaWallFunctions/omegaWallFunction/omegaWallFunctionFvPatchScalarField.C +++ b/src/turbulenceModels/compressible/RAS/derivedFvPatchFields/wallFunctions/omegaWallFunctions/omegaWallFunction/omegaWallFunctionFvPatchScalarField.C @@ -68,7 +68,7 @@ omegaWallFunctionFvPatchScalarField::omegaWallFunctionFvPatchScalarField UName_("U"), rhoName_("rho"), kName_("k"), - GName_("G"), + GName_("RASModel::G"), muName_("mu"), mutName_("mut") { @@ -107,7 +107,7 @@ omegaWallFunctionFvPatchScalarField::omegaWallFunctionFvPatchScalarField UName_(dict.lookupOrDefault("U", "U")), rhoName_(dict.lookupOrDefault("rho", "rho")), kName_(dict.lookupOrDefault("k", "k")), - GName_(dict.lookupOrDefault("G", "G")), + GName_(dict.lookupOrDefault("G", "RASModel::G")), muName_(dict.lookupOrDefault("mu", "mu")), mutName_(dict.lookupOrDefault("mut", "mut")) { @@ -221,7 +221,7 @@ void omegaWallFunctionFvPatchScalarField::write(Ostream& os) const writeEntryIfDifferent(os, "U", "U", UName_); writeEntryIfDifferent(os, "rho", "rho", rhoName_); writeEntryIfDifferent(os, "k", "k", kName_); - writeEntryIfDifferent(os, "G", "G", GName_); + writeEntryIfDifferent(os, "G", "RASModel::G", GName_); writeEntryIfDifferent(os, "mu", "mu", muName_); writeEntryIfDifferent(os, "mut", "mut", mutName_); writeEntry("value", os); diff --git a/src/turbulenceModels/compressible/RAS/kEpsilon/kEpsilon.C b/src/turbulenceModels/compressible/RAS/kEpsilon/kEpsilon.C index 609ee8300d..3e076722a2 100644 --- a/src/turbulenceModels/compressible/RAS/kEpsilon/kEpsilon.C +++ b/src/turbulenceModels/compressible/RAS/kEpsilon/kEpsilon.C @@ -278,7 +278,7 @@ void kEpsilon::correct() } tmp tgradU = fvc::grad(U_); - volScalarField G("G", mut_*(tgradU() && dev(twoSymm(tgradU())))); + volScalarField G("RASModel::G", mut_*(tgradU() && dev(twoSymm(tgradU())))); tgradU.clear(); // Update espsilon and G at the wall diff --git a/src/turbulenceModels/compressible/RAS/kOmegaSST/kOmegaSST.C b/src/turbulenceModels/compressible/RAS/kOmegaSST/kOmegaSST.C index 52cfaf2df8..e8a7e06895 100644 --- a/src/turbulenceModels/compressible/RAS/kOmegaSST/kOmegaSST.C +++ b/src/turbulenceModels/compressible/RAS/kOmegaSST/kOmegaSST.C @@ -381,7 +381,7 @@ void kOmegaSST::correct() tmp tgradU = fvc::grad(U_); volScalarField S2 = magSqr(symm(tgradU())); volScalarField GbyMu = (tgradU() && dev(twoSymm(tgradU()))); - volScalarField G("G", mut_*GbyMu); + volScalarField G("RASModel::G", mut_*GbyMu); tgradU.clear(); // Update omega and G at the wall diff --git a/src/turbulenceModels/compressible/RAS/realizableKE/realizableKE.C b/src/turbulenceModels/compressible/RAS/realizableKE/realizableKE.C index d55321fdb4..c08516aa27 100644 --- a/src/turbulenceModels/compressible/RAS/realizableKE/realizableKE.C +++ b/src/turbulenceModels/compressible/RAS/realizableKE/realizableKE.C @@ -317,7 +317,7 @@ void realizableKE::correct() volScalarField eta = magS*k_/epsilon_; volScalarField C1 = max(eta/(scalar(5) + eta), scalar(0.43)); - volScalarField G("G", mut_*(gradU && dev(twoSymm(gradU)))); + volScalarField G("RASModel::G", mut_*(gradU && dev(twoSymm(gradU)))); // Update espsilon and G at the wall epsilon_.boundaryField().updateCoeffs(); diff --git a/src/turbulenceModels/incompressible/RAS/LRR/LRR.C b/src/turbulenceModels/incompressible/RAS/LRR/LRR.C index f720a0312d..0c361c97ff 100644 --- a/src/turbulenceModels/incompressible/RAS/LRR/LRR.C +++ b/src/turbulenceModels/incompressible/RAS/LRR/LRR.C @@ -297,7 +297,7 @@ void LRR::correct() } volSymmTensorField P = -twoSymm(R_ & fvc::grad(U_)); - volScalarField G("G", 0.5*mag(tr(P))); + volScalarField G("RASModel::G", 0.5*mag(tr(P))); // Update espsilon and G at the wall epsilon_.boundaryField().updateCoeffs(); diff --git a/src/turbulenceModels/incompressible/RAS/LaunderGibsonRSTM/LaunderGibsonRSTM.C b/src/turbulenceModels/incompressible/RAS/LaunderGibsonRSTM/LaunderGibsonRSTM.C index 6f130f2a31..60f32bf14f 100644 --- a/src/turbulenceModels/incompressible/RAS/LaunderGibsonRSTM/LaunderGibsonRSTM.C +++ b/src/turbulenceModels/incompressible/RAS/LaunderGibsonRSTM/LaunderGibsonRSTM.C @@ -329,7 +329,7 @@ void LaunderGibsonRSTM::correct() } volSymmTensorField P = -twoSymm(R_ & fvc::grad(U_)); - volScalarField G("G", 0.5*mag(tr(P))); + volScalarField G("RASModel::G", 0.5*mag(tr(P))); // Update espsilon and G at the wall epsilon_.boundaryField().updateCoeffs(); diff --git a/src/turbulenceModels/incompressible/RAS/LienCubicKE/LienCubicKE.C b/src/turbulenceModels/incompressible/RAS/LienCubicKE/LienCubicKE.C index bb442dc240..41e6a851b7 100644 --- a/src/turbulenceModels/incompressible/RAS/LienCubicKE/LienCubicKE.C +++ b/src/turbulenceModels/incompressible/RAS/LienCubicKE/LienCubicKE.C @@ -328,7 +328,7 @@ void LienCubicKE::correct() volScalarField G ( - "G", + "RASModel::G", Cmu_*sqr(k_)/epsilon_*S2 - (nonlinearStress_ && gradU_) ); diff --git a/src/turbulenceModels/incompressible/RAS/RNGkEpsilon/RNGkEpsilon.C b/src/turbulenceModels/incompressible/RAS/RNGkEpsilon/RNGkEpsilon.C index 6285fb17bf..533aca878a 100644 --- a/src/turbulenceModels/incompressible/RAS/RNGkEpsilon/RNGkEpsilon.C +++ b/src/turbulenceModels/incompressible/RAS/RNGkEpsilon/RNGkEpsilon.C @@ -249,7 +249,7 @@ void RNGkEpsilon::correct() volScalarField S2 = 2*magSqr(symm(fvc::grad(U_))); - volScalarField G("G", nut_*S2); + volScalarField G("RASModel::G", nut_*S2); volScalarField eta = sqrt(S2)*k_/epsilon_; volScalarField R = diff --git a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.C b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.C index ae8a57c303..371d912c8a 100644 --- a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.C +++ b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.C @@ -67,7 +67,7 @@ epsilonWallFunctionFvPatchScalarField::epsilonWallFunctionFvPatchScalarField fixedInternalValueFvPatchField(p, iF), UName_("U"), kName_("k"), - GName_("G"), + GName_("RASModel::G"), nuName_("nu"), nutName_("nut") { @@ -104,7 +104,7 @@ epsilonWallFunctionFvPatchScalarField::epsilonWallFunctionFvPatchScalarField fixedInternalValueFvPatchField(p, iF, dict), UName_(dict.lookupOrDefault("U", "U")), kName_(dict.lookupOrDefault("k", "k")), - GName_(dict.lookupOrDefault("G", "G")), + GName_(dict.lookupOrDefault("G", "RASModel::G")), nuName_(dict.lookupOrDefault("nu", "nu")), nutName_(dict.lookupOrDefault("nut", "nut")) { @@ -219,7 +219,7 @@ void epsilonWallFunctionFvPatchScalarField::write(Ostream& os) const fixedInternalValueFvPatchField::write(os); writeEntryIfDifferent(os, "U", "U", UName_); writeEntryIfDifferent(os, "k", "k", kName_); - writeEntryIfDifferent(os, "G", "G", GName_); + writeEntryIfDifferent(os, "G", "RASModel::G", GName_); writeEntryIfDifferent(os, "nu", "nu", nuName_); writeEntryIfDifferent(os, "nut", "nut", nutName_); writeEntry("value", os); diff --git a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/omegaWallFunctions/omegaWallFunction/omegaWallFunctionFvPatchScalarField.C b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/omegaWallFunctions/omegaWallFunction/omegaWallFunctionFvPatchScalarField.C index f6a3b6a191..d4351bf243 100644 --- a/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/omegaWallFunctions/omegaWallFunction/omegaWallFunctionFvPatchScalarField.C +++ b/src/turbulenceModels/incompressible/RAS/derivedFvPatchFields/wallFunctions/omegaWallFunctions/omegaWallFunction/omegaWallFunctionFvPatchScalarField.C @@ -67,7 +67,7 @@ omegaWallFunctionFvPatchScalarField::omegaWallFunctionFvPatchScalarField fixedInternalValueFvPatchField(p, iF), UName_("U"), kName_("k"), - GName_("G"), + GName_("RASModel::G"), nuName_("nu"), nutName_("nut") { @@ -104,7 +104,7 @@ omegaWallFunctionFvPatchScalarField::omegaWallFunctionFvPatchScalarField fixedInternalValueFvPatchField(p, iF, dict), UName_(dict.lookupOrDefault("U", "U")), kName_(dict.lookupOrDefault("k", "k")), - GName_(dict.lookupOrDefault("G", "G")), + GName_(dict.lookupOrDefault("G", "RASModel::G")), nuName_(dict.lookupOrDefault("nu", "nu")), nutName_(dict.lookupOrDefault("nut", "nut")) { @@ -210,7 +210,7 @@ void omegaWallFunctionFvPatchScalarField::write(Ostream& os) const fixedInternalValueFvPatchField::write(os); writeEntryIfDifferent(os, "U", "U", UName_); writeEntryIfDifferent(os, "k", "k", kName_); - writeEntryIfDifferent(os, "G", "G", GName_); + writeEntryIfDifferent(os, "G", "RASModel::G", GName_); writeEntryIfDifferent(os, "nu", "nu", nuName_); writeEntryIfDifferent(os, "nut", "nut", nutName_); writeEntry("value", os); diff --git a/src/turbulenceModels/incompressible/RAS/kEpsilon/kEpsilon.C b/src/turbulenceModels/incompressible/RAS/kEpsilon/kEpsilon.C index a5953a4cb7..1f65b2d2ba 100644 --- a/src/turbulenceModels/incompressible/RAS/kEpsilon/kEpsilon.C +++ b/src/turbulenceModels/incompressible/RAS/kEpsilon/kEpsilon.C @@ -129,7 +129,7 @@ kEpsilon::kEpsilon autoCreateNut("nut", mesh_) ) { - nut_ == Cmu_*sqr(k_)/(epsilon_ + epsilonSmall_); + nut_ = Cmu_*sqr(k_)/(epsilon_ + epsilonSmall_); nut_.correctBoundaryConditions(); printCoeffs(); @@ -216,7 +216,7 @@ void kEpsilon::correct() return; } - volScalarField G("G", nut_*2*magSqr(symm(fvc::grad(U_)))); + volScalarField G("RASModel::G", nut_*2*magSqr(symm(fvc::grad(U_)))); // Update espsilon and G at the wall epsilon_.boundaryField().updateCoeffs(); @@ -259,7 +259,7 @@ void kEpsilon::correct() // Re-calculate viscosity - nut_ == Cmu_*sqr(k_)/epsilon_; + nut_ = Cmu_*sqr(k_)/epsilon_; nut_.correctBoundaryConditions(); } diff --git a/src/turbulenceModels/incompressible/RAS/kOmega/kOmega.C b/src/turbulenceModels/incompressible/RAS/kOmega/kOmega.C index a45ff8c33b..d29291885a 100644 --- a/src/turbulenceModels/incompressible/RAS/kOmega/kOmega.C +++ b/src/turbulenceModels/incompressible/RAS/kOmega/kOmega.C @@ -225,7 +225,7 @@ void kOmega::correct() return; } - volScalarField G("G", nut_*2*magSqr(symm(fvc::grad(U_)))); + volScalarField G("RASModel::G", nut_*2*magSqr(symm(fvc::grad(U_)))); // Update omega and G at the wall omega_.boundaryField().updateCoeffs(); diff --git a/src/turbulenceModels/incompressible/RAS/kOmegaSST/kOmegaSST.C b/src/turbulenceModels/incompressible/RAS/kOmegaSST/kOmegaSST.C index 6a737fce49..2ae7d8be6a 100644 --- a/src/turbulenceModels/incompressible/RAS/kOmegaSST/kOmegaSST.C +++ b/src/turbulenceModels/incompressible/RAS/kOmegaSST/kOmegaSST.C @@ -343,7 +343,7 @@ void kOmegaSST::correct() } volScalarField S2 = magSqr(symm(fvc::grad(U_))); - volScalarField G("G", nut_*2*S2); + volScalarField G("RASModel::G", nut_*2*S2); // Update omega and G at the wall omega_.boundaryField().updateCoeffs(); diff --git a/src/turbulenceModels/incompressible/RAS/realizableKE/realizableKE.C b/src/turbulenceModels/incompressible/RAS/realizableKE/realizableKE.C index 2f70b0ed2a..d92a765ee2 100644 --- a/src/turbulenceModels/incompressible/RAS/realizableKE/realizableKE.C +++ b/src/turbulenceModels/incompressible/RAS/realizableKE/realizableKE.C @@ -277,7 +277,7 @@ void realizableKE::correct() volScalarField eta = magS*k_/epsilon_; volScalarField C1 = max(eta/(scalar(5) + eta), scalar(0.43)); - volScalarField G("G", nut_*S2); + volScalarField G("RASModel::G", nut_*S2); // Update espsilon and G at the wall epsilon_.boundaryField().updateCoeffs();