Merge commit 'OpenCFD/master' into olesenm

This commit is contained in:
Mark Olesen
2009-08-03 16:20:24 +02:00
63 changed files with 754 additions and 768 deletions

View File

@ -26,8 +26,8 @@ Application
boundaryFoam boundaryFoam
Description Description
Steady-state solver for 1D turbulent flow, typically to generate boundary Steady-state solver for incompressible, 1D turbulent flow, typically to
layer conditions at an inlet, for use in a simulation. generate boundary layer conditions at an inlet, for use in a simulation.
Boundary layer code to calculate the U, k and epsilon distributions. Boundary layer code to calculate the U, k and epsilon distributions.
Used to create inlet boundary conditions for experimental comparisons Used to create inlet boundary conditions for experimental comparisons
@ -42,7 +42,6 @@ Description
#include "wallFvPatch.H" #include "wallFvPatch.H"
#include "makeGraph.H" #include "makeGraph.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
int main(int argc, char *argv[]) int main(int argc, char *argv[])
@ -52,6 +51,7 @@ int main(int argc, char *argv[])
#include "createTime.H" #include "createTime.H"
#include "createMesh.H" #include "createMesh.H"
#include "createFields.H" #include "createFields.H"
#include "interrogateWallPatches.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -74,66 +74,24 @@ int main(int argc, char *argv[])
UEqn.solve(); UEqn.solve();
// Correct driving force for a constant mass flow rate // Correct driving force for a constant volume flow rate
dimensionedVector UbarStar = flowMask & U.weightedAverage(mesh.V()); dimensionedVector UbarStar = flowMask & U.weightedAverage(mesh.V());
U += (Ubar - UbarStar); U += (Ubar - UbarStar);
gradP += (Ubar - UbarStar)/(1.0/UEqn.A())().weightedAverage(mesh.V()); gradP += (Ubar - UbarStar)/(1.0/UEqn.A())().weightedAverage(mesh.V());
label id = y.size() - 1;
scalar wallShearStress =
flowDirection & turbulence->R()()[id] & wallNormal;
scalar yplusWall
// = ::sqrt(mag(wallShearStress))*y[id]/laminarTransport.nu()()[id];
= ::sqrt(mag(wallShearStress))*y[id]/turbulence->nuEff()()[id];
Info<< "Uncorrected Ubar = " << (flowDirection & UbarStar.value())<< tab
<< "pressure gradient = " << (flowDirection & gradP.value()) << tab
<< "min y+ = " << yplusWall << endl;
turbulence->correct(); turbulence->correct();
Info<< "Uncorrected Ubar = " << (flowDirection & UbarStar.value())
<< ", pressure gradient = " << (flowDirection & gradP.value())
<< endl;
#include "evaluateNearWall.H"
if (runTime.outputTime()) if (runTime.outputTime())
{ {
volSymmTensorField R #include "makeGraphs.H"
(
IOobject
(
"R",
runTime.timeName(),
mesh,
IOobject::NO_READ,
IOobject::AUTO_WRITE
),
turbulence->R()
);
runTime.write();
const word& gFormat = runTime.graphFormat();
makeGraph(y, flowDirection & U, "Uf", gFormat);
makeGraph(y, laminarTransport.nu(), gFormat);
makeGraph(y, turbulence->k(), gFormat);
makeGraph(y, turbulence->epsilon(), gFormat);
//makeGraph(y, flowDirection & R & flowDirection, "Rff", gFormat);
//makeGraph(y, wallNormal & R & wallNormal, "Rww", gFormat);
//makeGraph(y, flowDirection & R & wallNormal, "Rfw", gFormat);
//makeGraph(y, sqrt(R.component(tensor::XX)), "u", gFormat);
//makeGraph(y, sqrt(R.component(tensor::YY)), "v", gFormat);
//makeGraph(y, sqrt(R.component(tensor::ZZ)), "w", gFormat);
makeGraph(y, R.component(tensor::XY), "uv", gFormat);
makeGraph(y, mag(fvc::grad(U)), "gammaDot", gFormat);
} }
Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s" Info<< "ExecutionTime = " << runTime.elapsedCpuTime() << " s"

View File

@ -49,74 +49,14 @@
) )
); );
dimensionedVector Ubar dimensionedVector Ubar(transportProperties.lookup("Ubar"));
(
transportProperties.lookup("Ubar")
);
vector flowDirection = (Ubar/mag(Ubar)).value(); vector flowDirection = (Ubar/mag(Ubar)).value();
tensor flowMask = sqr(flowDirection); tensor flowMask = sqr(flowDirection);
// Search for wall patches faces and store normals
scalar nWallFaces(0);
vector wallNormal(vector::zero);
const fvPatchList& patches = mesh.boundary();
forAll(patches, patchi)
{
const fvPatch& currPatch = patches[patchi];
if (isType<wallFvPatch>(currPatch))
{
forAll(currPatch, facei)
{
nWallFaces++;
if (nWallFaces == 1)
{
wallNormal =
- mesh.Sf().boundaryField()[patchi][facei]
/mesh.magSf().boundaryField()[patchi][facei];
}
else if (nWallFaces == 2)
{
vector wallNormal2 =
mesh.Sf().boundaryField()[patchi][facei]
/mesh.magSf().boundaryField()[patchi][facei];
//- Check that wall faces are parallel
if
(
mag(wallNormal & wallNormal2) > 1.01
||mag(wallNormal & wallNormal2) < 0.99
)
{
Info<< "boundaryFoam: wall faces are not parallel"
<< endl
<< abort(FatalError);
}
}
else
{
Info<< "boundaryFoam: number of wall faces > 2"
<< endl
<< abort(FatalError);
}
}
}
}
//- create position array for graph generation
scalarField y = wallNormal & mesh.C().internalField();
dimensionedVector gradP dimensionedVector gradP
( (
"gradP", "gradP",
dimensionSet(0, 1, -2, 0, 0), dimensionSet(0, 1, -2, 0, 0),
vector(0, 0, 0) vector::zero
); );

View File

@ -0,0 +1,35 @@
{
// Evaluate near-wall behaviour
scalar nu = turbulence->nu().boundaryField()[patchId][faceId];
scalar nut = turbulence->nut()().boundaryField()[patchId][faceId];
symmTensor R = turbulence->devReff()().boundaryField()[patchId][faceId];
scalar epsilon = turbulence->epsilon()()[cellId];
// scalar omega = turbulence->omega()()[cellId];
scalar k = turbulence->k()()[cellId];
scalar Up =
flowDirection & (U[cellId] - U.boundaryField()[patchId][faceId]);
scalar tauw = flowDirection & R & wallNormal;
scalar uTau = ::sqrt(mag(tauw));
scalar yPlus = uTau*y[cellId]/(nu + ROOTVSMALL);
scalar uPlus = Up/(uTau + ROOTVSMALL);
scalar nutPlus = nut/nu;
scalar kPlus = k/(sqr(uTau) + ROOTVSMALL);
scalar epsilonPlus = epsilon*nu/(pow4(uTau) + ROOTVSMALL);
// scalar omegaPlus = omega*nu/(sqr(uTau) + ROOTVSMALL);
scalar Rey = Up*y[cellId]/nu;
Info<< "Rey = " << Rey << ", uTau = " << uTau << ", nut+ = " << nutPlus
<< ", y+ = " << yPlus << ", u+ = " << uPlus
<< ", k+ = " << kPlus << ", epsilon+ = " << epsilonPlus
<< endl;
}

View File

@ -0,0 +1,74 @@
// Search for wall patches faces and store normals
label faceId(-1);
label patchId(-1);
label nWallFaces(0);
vector wallNormal(vector::zero);
const fvPatchList& patches = mesh.boundary();
forAll(patches, patchi)
{
const fvPatch& currPatch = patches[patchi];
if (isType<wallFvPatch>(currPatch))
{
const vectorField nf = currPatch.nf();
forAll(nf, facei)
{
nWallFaces++;
if (nWallFaces == 1)
{
wallNormal = -nf[facei];
faceId = facei;
patchId = patchi;
}
else if (nWallFaces == 2)
{
const vector wallNormal2 = -nf[facei];
//- Check that wall faces are parallel
if
(
mag(wallNormal & wallNormal2) > 1.01
|| mag(wallNormal & wallNormal2) < 0.99
)
{
FatalErrorIn(args.executable())
<< "wall faces are not parallel for patches "
<< patches[patchId].name() << " and "
<< currPatch.name() << nl
<< exit(FatalError);
}
}
else
{
FatalErrorIn(args.executable()) << "number of wall faces > 2"
<< nl << exit(FatalError);
}
}
}
}
if (nWallFaces == 0)
{
FatalErrorIn(args.executable()) << "No wall patches identified"
<< exit(FatalError);
}
else
{
Info<< "Generating wall data for patch: " << patches[patchId].name() << endl;
}
// store local id of near-walll cell to process
label cellId = patches[patchId].faceCells()[faceId];
// create position array for graph generation
scalarField y =
wallNormal
& (mesh.C().internalField() - mesh.C().boundaryField()[patchId][faceId]);
Info<< " Height to first cell centre y0 = " << y[cellId] << endl;

View File

@ -0,0 +1,33 @@
volSymmTensorField R
(
IOobject
(
"R",
runTime.timeName(),
mesh,
IOobject::NO_READ,
IOobject::AUTO_WRITE
),
turbulence->R()
);
runTime.write();
const word& gFormat = runTime.graphFormat();
makeGraph(y, flowDirection & U, "Uf", gFormat);
makeGraph(y, turbulence->nu(), gFormat);
makeGraph(y, turbulence->k(), gFormat);
makeGraph(y, turbulence->epsilon(), gFormat);
makeGraph(y, flowDirection & R & flowDirection, "Rff", gFormat);
makeGraph(y, wallNormal & R & wallNormal, "Rww", gFormat);
makeGraph(y, flowDirection & R & wallNormal, "Rfw", gFormat);
makeGraph(y, sqrt(mag(R.component(tensor::XX))), "u", gFormat);
makeGraph(y, sqrt(mag(R.component(tensor::YY))), "v", gFormat);
makeGraph(y, sqrt(mag(R.component(tensor::ZZ))), "w", gFormat);
makeGraph(y, R.component(tensor::XY), "uv", gFormat);
makeGraph(y, mag(fvc::grad(U)), "gammaDot", gFormat);

View File

@ -38,11 +38,11 @@ Description
#include "incompressible/singlePhaseTransportModel/singlePhaseTransportModel.H" #include "incompressible/singlePhaseTransportModel/singlePhaseTransportModel.H"
#include "incompressible/RAS/RASModel/RASModel.H" #include "incompressible/RAS/RASModel/RASModel.H"
#include "nutWallFunction/nutWallFunctionFvPatchScalarField.H" #include "nutkWallFunction/nutkWallFunctionFvPatchScalarField.H"
#include "basicPsiThermo.H" #include "basicPsiThermo.H"
#include "compressible/RAS/RASModel/RASModel.H" #include "compressible/RAS/RASModel/RASModel.H"
#include "mutWallFunction/mutWallFunctionFvPatchScalarField.H" #include "mutkWallFunction/mutkWallFunctionFvPatchScalarField.H"
#include "wallDist.H" #include "wallDist.H"
@ -56,7 +56,7 @@ void calcIncompressibleYPlus
volScalarField& yPlus volScalarField& yPlus
) )
{ {
typedef incompressible::RASModels::nutWallFunctionFvPatchScalarField typedef incompressible::RASModels::nutkWallFunctionFvPatchScalarField
wallFunctionPatchField; wallFunctionPatchField;
#include "createPhi.H" #include "createPhi.H"
@ -108,7 +108,7 @@ void calcCompressibleYPlus
volScalarField& yPlus volScalarField& yPlus
) )
{ {
typedef compressible::RASModels::mutWallFunctionFvPatchScalarField typedef compressible::RASModels::mutkWallFunctionFvPatchScalarField
wallFunctionPatchField; wallFunctionPatchField;
IOobject rhoHeader IOobject rhoHeader

View File

@ -43,12 +43,12 @@ Description
#include "incompressible/RAS/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.H" #include "incompressible/RAS/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.H"
#include "incompressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.H" #include "incompressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.H"
#include "incompressible/RAS/derivedFvPatchFields/wallFunctions/nutWallFunctions/nutWallFunction/nutWallFunctionFvPatchScalarField.H" #include "incompressible/RAS/derivedFvPatchFields/wallFunctions/nutWallFunctions/nutkWallFunction/nutkWallFunctionFvPatchScalarField.H"
#include "incompressible/RAS/derivedFvPatchFields/wallFunctions/omegaWallFunctions/omegaWallFunction/omegaWallFunctionFvPatchScalarField.H" #include "incompressible/RAS/derivedFvPatchFields/wallFunctions/omegaWallFunctions/omegaWallFunction/omegaWallFunctionFvPatchScalarField.H"
#include "compressible/RAS/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.H" #include "compressible/RAS/derivedFvPatchFields/wallFunctions/epsilonWallFunctions/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.H"
#include "compressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.H" #include "compressible/RAS/derivedFvPatchFields/wallFunctions/kqRWallFunctions/kqRWallFunction/kqRWallFunctionFvPatchField.H"
#include "compressible/RAS/derivedFvPatchFields/wallFunctions/mutWallFunctions/mutWallFunction/mutWallFunctionFvPatchScalarField.H" #include "compressible/RAS/derivedFvPatchFields/wallFunctions/mutWallFunctions/mutkWallFunction/mutkWallFunctionFvPatchScalarField.H"
#include "compressible/RAS/derivedFvPatchFields/wallFunctions/omegaWallFunctions/omegaWallFunction/omegaWallFunctionFvPatchScalarField.H" #include "compressible/RAS/derivedFvPatchFields/wallFunctions/omegaWallFunctions/omegaWallFunction/omegaWallFunctionFvPatchScalarField.H"
using namespace Foam; using namespace Foam;
@ -234,7 +234,7 @@ void updateCompressibleCase(const fvMesh& mesh)
( (
mesh, mesh,
"mut", "mut",
compressible::RASModels::mutWallFunctionFvPatchScalarField::typeName, compressible::RASModels::mutkWallFunctionFvPatchScalarField::typeName,
"0" "0"
); );
replaceBoundaryType replaceBoundaryType
@ -286,7 +286,7 @@ void updateIncompressibleCase(const fvMesh& mesh)
( (
mesh, mesh,
"nut", "nut",
incompressible::RASModels::nutWallFunctionFvPatchScalarField::typeName, incompressible::RASModels::nutkWallFunctionFvPatchScalarField::typeName,
"0" "0"
); );
replaceBoundaryType replaceBoundaryType

View File

@ -17,11 +17,11 @@ alphatWallFunctions = $(wallFunctions)/alphatWallFunctions
$(alphatWallFunctions)/alphatWallFunction/alphatWallFunctionFvPatchScalarField.C $(alphatWallFunctions)/alphatWallFunction/alphatWallFunctionFvPatchScalarField.C
mutWallFunctions = $(wallFunctions)/mutWallFunctions mutWallFunctions = $(wallFunctions)/mutWallFunctions
$(mutWallFunctions)/mutWallFunction/mutWallFunctionFvPatchScalarField.C $(mutWallFunctions)/mutkRoughWallFunction/mutkRoughWallFunctionFvPatchScalarField.C
$(mutWallFunctions)/mutRoughWallFunction/mutRoughWallFunctionFvPatchScalarField.C $(mutWallFunctions)/mutkWallFunction/mutkWallFunctionFvPatchScalarField.C
$(mutWallFunctions)/mutSpalartAllmarasWallFunction/mutSpalartAllmarasWallFunctionFvPatchScalarField.C $(mutWallFunctions)/mutURoughWallFunction/mutURoughWallFunctionFvPatchScalarField.C
$(mutWallFunctions)/mutSpalartAllmarasStandardWallFunction/mutSpalartAllmarasStandardWallFunctionFvPatchScalarField.C $(mutWallFunctions)/mutUSpaldingWallFunction/mutUSpaldingWallFunctionFvPatchScalarField.C
$(mutWallFunctions)/mutSpalartAllmarasStandardRoughWallFunction/mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField.C $(mutWallFunctions)/mutUWallFunction/mutUWallFunctionFvPatchScalarField.C
epsilonWallFunctions = $(wallFunctions)/epsilonWallFunctions epsilonWallFunctions = $(wallFunctions)/epsilonWallFunctions
$(epsilonWallFunctions)/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.C $(epsilonWallFunctions)/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.C

View File

@ -249,6 +249,54 @@ SpalartAllmaras::SpalartAllmaras
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
tmp<volScalarField> SpalartAllmaras::k() const
{
WarningIn("tmp<volScalarField> SpalartAllmaras::k() const")
<< "Turbulence kinetic energy not defined for Spalart-Allmaras model. "
<< "Returning zero field"
<< endl;
return tmp<volScalarField>
(
new volScalarField
(
IOobject
(
"k",
runTime_.timeName(),
mesh_
),
mesh_,
dimensionedScalar("0", dimensionSet(0, 2, -2, 0, 0), 0)
)
);
}
tmp<volScalarField> SpalartAllmaras::epsilon() const
{
WarningIn("tmp<volScalarField> SpalartAllmaras::epsilon() const")
<< "Turbulence kinetic energy dissipation rate not defined for "
<< "Spalart-Allmaras model. Returning zero field"
<< endl;
return tmp<volScalarField>
(
new volScalarField
(
IOobject
(
"epslion",
runTime_.timeName(),
mesh_
),
mesh_,
dimensionedScalar("0", dimensionSet(0, 2, -3, 0, 0), 0)
)
);
}
tmp<volSymmTensorField> SpalartAllmaras::R() const tmp<volSymmTensorField> SpalartAllmaras::R() const
{ {
return tmp<volSymmTensorField> return tmp<volSymmTensorField>

View File

@ -188,42 +188,10 @@ public:
} }
//- Return the turbulence kinetic energy //- Return the turbulence kinetic energy
virtual tmp<volScalarField> k() const virtual tmp<volScalarField> k() const;
{
return tmp<volScalarField>
(
new volScalarField
(
IOobject
(
"k",
runTime_.timeName(),
mesh_
),
mesh_,
dimensionedScalar("0", dimensionSet(0, 2, -2, 0, 0), 0)
)
);
}
//- Return the turbulence kinetic energy dissipation rate //- Return the turbulence kinetic energy dissipation rate
virtual tmp<volScalarField> epsilon() const virtual tmp<volScalarField> epsilon() const;
{
return tmp<volScalarField>
(
new volScalarField
(
IOobject
(
"epslion",
runTime_.timeName(),
mesh_
),
mesh_,
dimensionedScalar("0", dimensionSet(0, 2, -3, 0, 0), 0)
)
);
}
//- Return the Reynolds stress tensor //- Return the Reynolds stress tensor
virtual tmp<volSymmTensorField> R() const; virtual tmp<volSymmTensorField> R() const;

View File

@ -28,7 +28,7 @@ License
#include "calculatedFvPatchField.H" #include "calculatedFvPatchField.H"
#include "alphatWallFunctionFvPatchScalarField.H" #include "alphatWallFunctionFvPatchScalarField.H"
#include "mutWallFunctionFvPatchScalarField.H" #include "mutkWallFunctionFvPatchScalarField.H"
#include "epsilonWallFunctionFvPatchScalarField.H" #include "epsilonWallFunctionFvPatchScalarField.H"
#include "kqRWallFunctionFvPatchField.H" #include "kqRWallFunctionFvPatchField.H"
#include "omegaWallFunctionFvPatchScalarField.H" #include "omegaWallFunctionFvPatchScalarField.H"
@ -146,7 +146,7 @@ tmp<volScalarField> autoCreateMut
if (isType<wallFvPatch>(bm[patchI])) if (isType<wallFvPatch>(bm[patchI]))
{ {
mutBoundaryTypes[patchI] = mutBoundaryTypes[patchI] =
RASModels::mutWallFunctionFvPatchScalarField::typeName; RASModels::mutkWallFunctionFvPatchScalarField::typeName;
} }
else else
{ {

View File

@ -24,7 +24,7 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField.H" #include "mutURoughWallFunctionFvPatchScalarField.H"
#include "fvPatchFieldMapper.H" #include "fvPatchFieldMapper.H"
#include "volFields.H" #include "volFields.H"
#include "RASModel.H" #include "RASModel.H"
@ -41,8 +41,7 @@ namespace RASModels
// * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * // // * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * //
tmp<scalarField> tmp<scalarField> mutURoughWallFunctionFvPatchScalarField::calcYPlus
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::calcYPlus
( (
const scalarField& magUp const scalarField& magUp
) const ) const
@ -90,7 +89,7 @@ mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::calcYPlus
} }
// Additional tuning parameter (fudge factor) - nominally = 1 // Additional tuning parameter (fudge factor) - nominally = 1
dKsPlusdYPlus *= roughnessFudgeFactor_; dKsPlusdYPlus *= roughnessFactor_;
do do
{ {
@ -172,8 +171,7 @@ mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::calcYPlus
} }
tmp<scalarField> tmp<scalarField> mutURoughWallFunctionFvPatchScalarField::calcMut() const
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::calcMut() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
@ -206,82 +204,76 @@ mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::calcMut() const
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField:: mutURoughWallFunctionFvPatchScalarField::mutURoughWallFunctionFvPatchScalarField
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
mutWallFunctionFvPatchScalarField(p, iF), mutkWallFunctionFvPatchScalarField(p, iF),
roughnessHeight_(pTraits<scalar>::zero), roughnessHeight_(pTraits<scalar>::zero),
roughnessConstant_(pTraits<scalar>::zero), roughnessConstant_(pTraits<scalar>::zero),
roughnessFudgeFactor_(pTraits<scalar>::zero) roughnessFactor_(pTraits<scalar>::zero)
{} {}
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField:: mutURoughWallFunctionFvPatchScalarField::mutURoughWallFunctionFvPatchScalarField
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField& ptf, const mutURoughWallFunctionFvPatchScalarField& ptf,
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const fvPatchFieldMapper& mapper const fvPatchFieldMapper& mapper
) )
: :
mutWallFunctionFvPatchScalarField(ptf, p, iF, mapper), mutkWallFunctionFvPatchScalarField(ptf, p, iF, mapper),
roughnessHeight_(ptf.roughnessHeight_), roughnessHeight_(ptf.roughnessHeight_),
roughnessConstant_(ptf.roughnessConstant_), roughnessConstant_(ptf.roughnessConstant_),
roughnessFudgeFactor_(ptf.roughnessFudgeFactor_) roughnessFactor_(ptf.roughnessFactor_)
{} {}
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField:: mutURoughWallFunctionFvPatchScalarField::mutURoughWallFunctionFvPatchScalarField
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const dictionary& dict const dictionary& dict
) )
: :
mutWallFunctionFvPatchScalarField(p, iF, dict), mutkWallFunctionFvPatchScalarField(p, iF, dict),
roughnessHeight_(readScalar(dict.lookup("roughnessHeight"))), roughnessHeight_(readScalar(dict.lookup("roughnessHeight"))),
roughnessConstant_(readScalar(dict.lookup("roughnessConstant"))), roughnessConstant_(readScalar(dict.lookup("roughnessConstant"))),
roughnessFudgeFactor_(readScalar(dict.lookup("roughnessFudgeFactor"))) roughnessFactor_(readScalar(dict.lookup("roughnessFactor")))
{} {}
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField:: mutURoughWallFunctionFvPatchScalarField::mutURoughWallFunctionFvPatchScalarField
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField& rwfpsf const mutURoughWallFunctionFvPatchScalarField& rwfpsf
) )
: :
mutWallFunctionFvPatchScalarField(rwfpsf), mutkWallFunctionFvPatchScalarField(rwfpsf),
roughnessHeight_(rwfpsf.roughnessHeight_), roughnessHeight_(rwfpsf.roughnessHeight_),
roughnessConstant_(rwfpsf.roughnessConstant_), roughnessConstant_(rwfpsf.roughnessConstant_),
roughnessFudgeFactor_(rwfpsf.roughnessFudgeFactor_) roughnessFactor_(rwfpsf.roughnessFactor_)
{} {}
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField:: mutURoughWallFunctionFvPatchScalarField::mutURoughWallFunctionFvPatchScalarField
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField& rwfpsf, const mutURoughWallFunctionFvPatchScalarField& rwfpsf,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
mutWallFunctionFvPatchScalarField(rwfpsf, iF), mutkWallFunctionFvPatchScalarField(rwfpsf, iF),
roughnessHeight_(rwfpsf.roughnessHeight_), roughnessHeight_(rwfpsf.roughnessHeight_),
roughnessConstant_(rwfpsf.roughnessConstant_), roughnessConstant_(rwfpsf.roughnessConstant_),
roughnessFudgeFactor_(rwfpsf.roughnessFudgeFactor_) roughnessFactor_(rwfpsf.roughnessFactor_)
{} {}
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
tmp<scalarField> tmp<scalarField> mutURoughWallFunctionFvPatchScalarField::yPlus() const
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::yPlus() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
@ -293,10 +285,7 @@ mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::yPlus() const
} }
void mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::write void mutURoughWallFunctionFvPatchScalarField::write(Ostream& os) const
(
Ostream& os
) const
{ {
fixedValueFvPatchScalarField::write(os); fixedValueFvPatchScalarField::write(os);
writeLocalEntries(os); writeLocalEntries(os);
@ -304,8 +293,8 @@ void mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::write
<< roughnessHeight_ << token::END_STATEMENT << nl; << roughnessHeight_ << token::END_STATEMENT << nl;
os.writeKeyword("roughnessConstant") os.writeKeyword("roughnessConstant")
<< roughnessConstant_ << token::END_STATEMENT << nl; << roughnessConstant_ << token::END_STATEMENT << nl;
os.writeKeyword("roughnessFudgeFactor") os.writeKeyword("roughnessFactor")
<< roughnessFudgeFactor_ << token::END_STATEMENT << nl; << roughnessFactor_ << token::END_STATEMENT << nl;
} }
@ -314,7 +303,7 @@ void mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::write
makePatchTypeField makePatchTypeField
( (
fvPatchScalarField, fvPatchScalarField,
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField mutURoughWallFunctionFvPatchScalarField
); );
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -23,21 +23,20 @@ License
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
Class Class
Foam::compressible::RASModels:: Foam::compressible::RASModels::mutURoughWallFunctionFvPatchScalarField
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField
Description Description
Wall function boundary condition for rough walls Wall function boundary condition for rough walls, based on velocity.
SourceFiles SourceFiles
mutSpalartAllamarasStandardWallFunctionFvPatchScalarField.C mutSpalartAllamarasStandardWallFunctionFvPatchScalarField.C
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#ifndef compressibleMutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField_H #ifndef compressibleMutURoughWallFunctionFvPatchScalarField_H
#define compressibleMutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField_H #define compressibleMutURoughWallFunctionFvPatchScalarField_H
#include "mutWallFunctionFvPatchScalarField.H" #include "mutkWallFunctionFvPatchScalarField.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -49,12 +48,12 @@ namespace RASModels
{ {
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField Declaration Class mutURoughWallFunctionFvPatchScalarField Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
class mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField class mutURoughWallFunctionFvPatchScalarField
: :
public mutWallFunctionFvPatchScalarField public mutkWallFunctionFvPatchScalarField
{ {
protected: protected:
@ -69,7 +68,7 @@ protected:
scalar roughnessConstant_; scalar roughnessConstant_;
//- Scale factor //- Scale factor
scalar roughnessFudgeFactor_; scalar roughnessFactor_;
// Protected member functions // Protected member functions
@ -84,20 +83,20 @@ protected:
public: public:
//- Runtime type information //- Runtime type information
TypeName("mutSpalartAllmarasStandardRoughWallFunction"); TypeName("mutURoughWallFunction");
// Constructors // Constructors
//- Construct from patch and internal field //- Construct from patch and internal field
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField mutURoughWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
//- Construct from patch, internal field and dictionary //- Construct from patch, internal field and dictionary
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField mutURoughWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
@ -105,20 +104,20 @@ public:
); );
//- Construct by mapping given //- Construct by mapping given
// mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField // mutURoughWallFunctionFvPatchScalarField
// onto a new patch // onto a new patch
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField mutURoughWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField&, const mutURoughWallFunctionFvPatchScalarField&,
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
const fvPatchFieldMapper& const fvPatchFieldMapper&
); );
//- Construct as copy //- Construct as copy
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField mutURoughWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField& const mutURoughWallFunctionFvPatchScalarField&
); );
//- Construct and return a clone //- Construct and return a clone
@ -126,17 +125,14 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField new mutURoughWallFunctionFvPatchScalarField(*this)
(
*this
)
); );
} }
//- Construct as copy setting internal field reference //- Construct as copy setting internal field reference
mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField mutURoughWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField&, const mutURoughWallFunctionFvPatchScalarField&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
@ -148,11 +144,7 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new mutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField new mutURoughWallFunctionFvPatchScalarField(*this, iF)
(
*this,
iF
)
); );
} }
@ -186,16 +178,16 @@ public:
} }
//- Return the roughness scale factor //- Return the roughness scale factor
const scalar& roughnessFudgeFactor() const const scalar& roughnessFactor() const
{ {
return roughnessFudgeFactor_; return roughnessFactor_;
} }
//- Return reference to the roughness scale factor to allow //- Return reference to the roughness scale factor to allow
// adjustment // adjustment
scalar& roughnessFudgeFactor() scalar& roughnessFactor()
{ {
return roughnessFudgeFactor_; return roughnessFactor_;
} }

View File

@ -24,7 +24,7 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "mutSpalartAllmarasWallFunctionFvPatchScalarField.H" #include "mutUSpaldingWallFunctionFvPatchScalarField.H"
#include "fvPatchFieldMapper.H" #include "fvPatchFieldMapper.H"
#include "volFields.H" #include "volFields.H"
#include "RASModel.H" #include "RASModel.H"
@ -41,7 +41,7 @@ namespace RASModels
// * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * // // * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * //
tmp<scalarField> mutSpalartAllmarasWallFunctionFvPatchScalarField::calcUTau tmp<scalarField> mutUSpaldingWallFunctionFvPatchScalarField::calcUTau
( (
const scalarField& magGradU const scalarField& magGradU
) const ) const
@ -105,8 +105,7 @@ tmp<scalarField> mutSpalartAllmarasWallFunctionFvPatchScalarField::calcUTau
} }
tmp<scalarField> tmp<scalarField> mutUSpaldingWallFunctionFvPatchScalarField::calcMut() const
mutSpalartAllmarasWallFunctionFvPatchScalarField::calcMut() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
@ -122,67 +121,66 @@ mutSpalartAllmarasWallFunctionFvPatchScalarField::calcMut() const
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
mutSpalartAllmarasWallFunctionFvPatchScalarField:: mutUSpaldingWallFunctionFvPatchScalarField::
mutSpalartAllmarasWallFunctionFvPatchScalarField mutUSpaldingWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
mutWallFunctionFvPatchScalarField(p, iF) mutkWallFunctionFvPatchScalarField(p, iF)
{} {}
mutSpalartAllmarasWallFunctionFvPatchScalarField:: mutUSpaldingWallFunctionFvPatchScalarField::
mutSpalartAllmarasWallFunctionFvPatchScalarField mutUSpaldingWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasWallFunctionFvPatchScalarField& ptf, const mutUSpaldingWallFunctionFvPatchScalarField& ptf,
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const fvPatchFieldMapper& mapper const fvPatchFieldMapper& mapper
) )
: :
mutWallFunctionFvPatchScalarField(ptf, p, iF, mapper) mutkWallFunctionFvPatchScalarField(ptf, p, iF, mapper)
{} {}
mutSpalartAllmarasWallFunctionFvPatchScalarField:: mutUSpaldingWallFunctionFvPatchScalarField::
mutSpalartAllmarasWallFunctionFvPatchScalarField mutUSpaldingWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const dictionary& dict const dictionary& dict
) )
: :
mutWallFunctionFvPatchScalarField(p, iF, dict) mutkWallFunctionFvPatchScalarField(p, iF, dict)
{} {}
mutSpalartAllmarasWallFunctionFvPatchScalarField:: mutUSpaldingWallFunctionFvPatchScalarField::
mutSpalartAllmarasWallFunctionFvPatchScalarField mutUSpaldingWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasWallFunctionFvPatchScalarField& wfpsf const mutUSpaldingWallFunctionFvPatchScalarField& wfpsf
) )
: :
mutWallFunctionFvPatchScalarField(wfpsf) mutkWallFunctionFvPatchScalarField(wfpsf)
{} {}
mutSpalartAllmarasWallFunctionFvPatchScalarField:: mutUSpaldingWallFunctionFvPatchScalarField::
mutSpalartAllmarasWallFunctionFvPatchScalarField mutUSpaldingWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasWallFunctionFvPatchScalarField& wfpsf, const mutUSpaldingWallFunctionFvPatchScalarField& wfpsf,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
mutWallFunctionFvPatchScalarField(wfpsf, iF) mutkWallFunctionFvPatchScalarField(wfpsf, iF)
{} {}
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
tmp<scalarField> tmp<scalarField> mutUSpaldingWallFunctionFvPatchScalarField::yPlus() const
mutSpalartAllmarasWallFunctionFvPatchScalarField::yPlus() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
@ -196,10 +194,7 @@ mutSpalartAllmarasWallFunctionFvPatchScalarField::yPlus() const
} }
void mutSpalartAllmarasWallFunctionFvPatchScalarField::write void mutUSpaldingWallFunctionFvPatchScalarField::write(Ostream& os) const
(
Ostream& os
) const
{ {
fvPatchField<scalar>::write(os); fvPatchField<scalar>::write(os);
writeLocalEntries(os); writeLocalEntries(os);
@ -209,7 +204,11 @@ void mutSpalartAllmarasWallFunctionFvPatchScalarField::write
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
makePatchTypeField(fvPatchScalarField, mutSpalartAllmarasWallFunctionFvPatchScalarField); makePatchTypeField
(
fvPatchScalarField,
mutUSpaldingWallFunctionFvPatchScalarField
);
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -23,21 +23,20 @@ License
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
Class Class
Foam::compressible::RASModels:: Foam::compressible::RASModels::mutUSpaldingWallFunctionFvPatchScalarField
mutSpalartAllmarasWallFunctionFvPatchScalarField
Description Description
Wall function boundary condition for walls Wall function boundary condition for walls
SourceFiles SourceFiles
mutSpalartAllmarasWallFunctionFvPatchScalarField.C mutUSpaldingWallFunctionFvPatchScalarField.C
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#ifndef compressibleMutSpalartAllmarasWallFunctionFvPatchScalarField_H #ifndef compressibleMutUSpaldingWallFunctionFvPatchScalarField_H
#define compressibleMutSpalartAllmarasWallFunctionFvPatchScalarField_H #define compressibleMutUSpaldingWallFunctionFvPatchScalarField_H
#include "mutWallFunctionFvPatchScalarField.H" #include "mutkWallFunctionFvPatchScalarField.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -49,12 +48,12 @@ namespace RASModels
{ {
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class mutSpalartAllmarasWallFunctionFvPatchScalarField Declaration Class mutUSpaldingWallFunctionFvPatchScalarField Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
class mutSpalartAllmarasWallFunctionFvPatchScalarField class mutUSpaldingWallFunctionFvPatchScalarField
: :
public mutWallFunctionFvPatchScalarField public mutkWallFunctionFvPatchScalarField
{ {
protected: protected:
@ -70,20 +69,20 @@ protected:
public: public:
//- Runtime type information //- Runtime type information
TypeName("mutSpalartAllmarasWallFunction"); TypeName("mutUSpaldingWallFunction");
// Constructors // Constructors
//- Construct from patch and internal field //- Construct from patch and internal field
mutSpalartAllmarasWallFunctionFvPatchScalarField mutUSpaldingWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
//- Construct from patch, internal field and dictionary //- Construct from patch, internal field and dictionary
mutSpalartAllmarasWallFunctionFvPatchScalarField mutUSpaldingWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
@ -91,20 +90,20 @@ public:
); );
//- Construct by mapping given //- Construct by mapping given
// mutSpalartAllmarasWallFunctionFvPatchScalarField // mutUSpaldingWallFunctionFvPatchScalarField
// onto a new patch // onto a new patch
mutSpalartAllmarasWallFunctionFvPatchScalarField mutUSpaldingWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasWallFunctionFvPatchScalarField&, const mutUSpaldingWallFunctionFvPatchScalarField&,
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
const fvPatchFieldMapper& const fvPatchFieldMapper&
); );
//- Construct as copy //- Construct as copy
mutSpalartAllmarasWallFunctionFvPatchScalarField mutUSpaldingWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasWallFunctionFvPatchScalarField& const mutUSpaldingWallFunctionFvPatchScalarField&
); );
//- Construct and return a clone //- Construct and return a clone
@ -112,14 +111,14 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new mutSpalartAllmarasWallFunctionFvPatchScalarField(*this) new mutUSpaldingWallFunctionFvPatchScalarField(*this)
); );
} }
//- Construct as copy setting internal field reference //- Construct as copy setting internal field reference
mutSpalartAllmarasWallFunctionFvPatchScalarField mutUSpaldingWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasWallFunctionFvPatchScalarField&, const mutUSpaldingWallFunctionFvPatchScalarField&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
@ -131,7 +130,7 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new mutSpalartAllmarasWallFunctionFvPatchScalarField(*this, iF) new mutUSpaldingWallFunctionFvPatchScalarField(*this, iF)
); );
} }

View File

@ -24,7 +24,7 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "mutSpalartAllmarasStandardWallFunctionFvPatchScalarField.H" #include "mutUWallFunctionFvPatchScalarField.H"
#include "RASModel.H" #include "RASModel.H"
#include "fvPatchFieldMapper.H" #include "fvPatchFieldMapper.H"
#include "volFields.H" #include "volFields.H"
@ -41,8 +41,7 @@ namespace RASModels
// * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * // // * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * //
tmp<scalarField> tmp<scalarField> mutUWallFunctionFvPatchScalarField::calcYPlus
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField::calcYPlus
( (
const scalarField& magUp const scalarField& magUp
) const ) const
@ -81,8 +80,7 @@ mutSpalartAllmarasStandardWallFunctionFvPatchScalarField::calcYPlus
} }
tmp<scalarField> tmp<scalarField> mutUWallFunctionFvPatchScalarField::calcMut() const
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField::calcMut() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
@ -112,67 +110,61 @@ mutSpalartAllmarasStandardWallFunctionFvPatchScalarField::calcMut() const
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField:: mutUWallFunctionFvPatchScalarField::mutUWallFunctionFvPatchScalarField
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
mutWallFunctionFvPatchScalarField(p, iF) mutkWallFunctionFvPatchScalarField(p, iF)
{} {}
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField:: mutUWallFunctionFvPatchScalarField::mutUWallFunctionFvPatchScalarField
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasStandardWallFunctionFvPatchScalarField& ptf, const mutUWallFunctionFvPatchScalarField& ptf,
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const fvPatchFieldMapper& mapper const fvPatchFieldMapper& mapper
) )
: :
mutWallFunctionFvPatchScalarField(ptf, p, iF, mapper) mutkWallFunctionFvPatchScalarField(ptf, p, iF, mapper)
{} {}
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField:: mutUWallFunctionFvPatchScalarField::mutUWallFunctionFvPatchScalarField
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const dictionary& dict const dictionary& dict
) )
: :
mutWallFunctionFvPatchScalarField(p, iF, dict) mutkWallFunctionFvPatchScalarField(p, iF, dict)
{} {}
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField:: mutUWallFunctionFvPatchScalarField::mutUWallFunctionFvPatchScalarField
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasStandardWallFunctionFvPatchScalarField& sawfpsf const mutUWallFunctionFvPatchScalarField& sawfpsf
) )
: :
mutWallFunctionFvPatchScalarField(sawfpsf) mutkWallFunctionFvPatchScalarField(sawfpsf)
{} {}
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField:: mutUWallFunctionFvPatchScalarField::mutUWallFunctionFvPatchScalarField
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasStandardWallFunctionFvPatchScalarField& sawfpsf, const mutUWallFunctionFvPatchScalarField& sawfpsf,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
mutWallFunctionFvPatchScalarField(sawfpsf, iF) mutkWallFunctionFvPatchScalarField(sawfpsf, iF)
{} {}
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
tmp<scalarField> tmp<scalarField> mutUWallFunctionFvPatchScalarField::yPlus() const
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField::yPlus() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
const RASModel& rasModel = db().lookupObject<RASModel>("RASProperties"); const RASModel& rasModel = db().lookupObject<RASModel>("RASProperties");
@ -183,10 +175,7 @@ mutSpalartAllmarasStandardWallFunctionFvPatchScalarField::yPlus() const
} }
void mutSpalartAllmarasStandardWallFunctionFvPatchScalarField::write void mutUWallFunctionFvPatchScalarField::write(Ostream& os) const
(
Ostream& os
) const
{ {
fvPatchField<scalar>::write(os); fvPatchField<scalar>::write(os);
writeLocalEntries(os); writeLocalEntries(os);
@ -199,7 +188,7 @@ void mutSpalartAllmarasStandardWallFunctionFvPatchScalarField::write
makePatchTypeField makePatchTypeField
( (
fvPatchScalarField, fvPatchScalarField,
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField mutUWallFunctionFvPatchScalarField
); );
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -23,21 +23,20 @@ License
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
Class Class
Foam::compressible::RASModels:: Foam::compressible::RASModels::mutUWallFunctionFvPatchScalarField
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField
Description Description
Wall function boundary condition for walls Wall function boundary condition for walls, based on velocity.
SourceFiles SourceFiles
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField.C mutUWallFunctionFvPatchScalarField.C
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#ifndef compressibleMutSpalartAllmarasStandardWallFunctionFvPatchScalarField_H #ifndef compressibleMutUWallFunctionFvPatchScalarField_H
#define compressibleMutSpalartAllmarasStandardWallFunctionFvPatchScalarField_H #define compressibleMutUWallFunctionFvPatchScalarField_H
#include "mutWallFunctionFvPatchScalarField.H" #include "mutkWallFunctionFvPatchScalarField.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -49,12 +48,12 @@ namespace RASModels
{ {
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class mutSpalartAllmarasStandardWallFunctionFvPatchScalarField Declaration Class mutUWallFunctionFvPatchScalarField Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
class mutSpalartAllmarasStandardWallFunctionFvPatchScalarField class mutUWallFunctionFvPatchScalarField
: :
public mutWallFunctionFvPatchScalarField public mutkWallFunctionFvPatchScalarField
{ {
protected: protected:
@ -70,20 +69,20 @@ protected:
public: public:
//- Runtime type information //- Runtime type information
TypeName("mutSpalartAllmarasStandardWallFunction"); TypeName("mutUWallFunction");
// Constructors // Constructors
//- Construct from patch and internal field //- Construct from patch and internal field
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField mutUWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
//- Construct from patch, internal field and dictionary //- Construct from patch, internal field and dictionary
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField mutUWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
@ -91,20 +90,20 @@ public:
); );
//- Construct by mapping given //- Construct by mapping given
// mutSpalartAllmarasStandardWallFunctionFvPatchScalarField // mutUWallFunctionFvPatchScalarField
// onto a new patch // onto a new patch
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField mutUWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasStandardWallFunctionFvPatchScalarField&, const mutUWallFunctionFvPatchScalarField&,
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
const fvPatchFieldMapper& const fvPatchFieldMapper&
); );
//- Construct as copy //- Construct as copy
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField mutUWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasStandardWallFunctionFvPatchScalarField& const mutUWallFunctionFvPatchScalarField&
); );
//- Construct and return a clone //- Construct and return a clone
@ -112,17 +111,14 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new mutSpalartAllmarasStandardWallFunctionFvPatchScalarField new mutUWallFunctionFvPatchScalarField(*this)
(
*this
)
); );
} }
//- Construct as copy setting internal field reference //- Construct as copy setting internal field reference
mutSpalartAllmarasStandardWallFunctionFvPatchScalarField mutUWallFunctionFvPatchScalarField
( (
const mutSpalartAllmarasStandardWallFunctionFvPatchScalarField&, const mutUWallFunctionFvPatchScalarField&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
@ -134,11 +130,7 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new mutSpalartAllmarasStandardWallFunctionFvPatchScalarField new mutUWallFunctionFvPatchScalarField(*this, iF)
(
*this,
iF
)
); );
} }

View File

@ -24,7 +24,7 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "mutRoughWallFunctionFvPatchScalarField.H" #include "mutkRoughWallFunctionFvPatchScalarField.H"
#include "RASModel.H" #include "RASModel.H"
#include "fvPatchFieldMapper.H" #include "fvPatchFieldMapper.H"
#include "volFields.H" #include "volFields.H"
@ -39,10 +39,9 @@ namespace compressible
namespace RASModels namespace RASModels
{ {
// * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * // // * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * //
scalar mutRoughWallFunctionFvPatchScalarField::fnRough scalar mutkRoughWallFunctionFvPatchScalarField::fnRough
( (
const scalar KsPlus, const scalar KsPlus,
const scalar Cs const scalar Cs
@ -65,7 +64,7 @@ scalar mutRoughWallFunctionFvPatchScalarField::fnRough
} }
tmp<scalarField> mutRoughWallFunctionFvPatchScalarField::calcMut() const tmp<scalarField> mutkRoughWallFunctionFvPatchScalarField::calcMut() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
@ -121,63 +120,63 @@ tmp<scalarField> mutRoughWallFunctionFvPatchScalarField::calcMut() const
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
mutRoughWallFunctionFvPatchScalarField::mutRoughWallFunctionFvPatchScalarField mutkRoughWallFunctionFvPatchScalarField::mutkRoughWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
mutWallFunctionFvPatchScalarField(p, iF), mutkWallFunctionFvPatchScalarField(p, iF),
Ks_(p.size(), 0.0), Ks_(p.size(), 0.0),
Cs_(p.size(), 0.0) Cs_(p.size(), 0.0)
{} {}
mutRoughWallFunctionFvPatchScalarField::mutRoughWallFunctionFvPatchScalarField mutkRoughWallFunctionFvPatchScalarField::mutkRoughWallFunctionFvPatchScalarField
( (
const mutRoughWallFunctionFvPatchScalarField& ptf, const mutkRoughWallFunctionFvPatchScalarField& ptf,
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const fvPatchFieldMapper& mapper const fvPatchFieldMapper& mapper
) )
: :
mutWallFunctionFvPatchScalarField(ptf, p, iF, mapper), mutkWallFunctionFvPatchScalarField(ptf, p, iF, mapper),
Ks_(ptf.Ks_, mapper), Ks_(ptf.Ks_, mapper),
Cs_(ptf.Cs_, mapper) Cs_(ptf.Cs_, mapper)
{} {}
mutRoughWallFunctionFvPatchScalarField::mutRoughWallFunctionFvPatchScalarField mutkRoughWallFunctionFvPatchScalarField::mutkRoughWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const dictionary& dict const dictionary& dict
) )
: :
mutWallFunctionFvPatchScalarField(p, iF, dict), mutkWallFunctionFvPatchScalarField(p, iF, dict),
Ks_("Ks", dict, p.size()), Ks_("Ks", dict, p.size()),
Cs_("Cs", dict, p.size()) Cs_("Cs", dict, p.size())
{} {}
mutRoughWallFunctionFvPatchScalarField::mutRoughWallFunctionFvPatchScalarField mutkRoughWallFunctionFvPatchScalarField::mutkRoughWallFunctionFvPatchScalarField
( (
const mutRoughWallFunctionFvPatchScalarField& rwfpsf const mutkRoughWallFunctionFvPatchScalarField& rwfpsf
) )
: :
mutWallFunctionFvPatchScalarField(rwfpsf), mutkWallFunctionFvPatchScalarField(rwfpsf),
Ks_(rwfpsf.Ks_), Ks_(rwfpsf.Ks_),
Cs_(rwfpsf.Cs_) Cs_(rwfpsf.Cs_)
{} {}
mutRoughWallFunctionFvPatchScalarField::mutRoughWallFunctionFvPatchScalarField mutkRoughWallFunctionFvPatchScalarField::mutkRoughWallFunctionFvPatchScalarField
( (
const mutRoughWallFunctionFvPatchScalarField& rwfpsf, const mutkRoughWallFunctionFvPatchScalarField& rwfpsf,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
mutWallFunctionFvPatchScalarField(rwfpsf, iF), mutkWallFunctionFvPatchScalarField(rwfpsf, iF),
Ks_(rwfpsf.Ks_), Ks_(rwfpsf.Ks_),
Cs_(rwfpsf.Cs_) Cs_(rwfpsf.Cs_)
{} {}
@ -185,34 +184,34 @@ mutRoughWallFunctionFvPatchScalarField::mutRoughWallFunctionFvPatchScalarField
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
void mutRoughWallFunctionFvPatchScalarField::autoMap void mutkRoughWallFunctionFvPatchScalarField::autoMap
( (
const fvPatchFieldMapper& m const fvPatchFieldMapper& m
) )
{ {
mutWallFunctionFvPatchScalarField::autoMap(m); mutkWallFunctionFvPatchScalarField::autoMap(m);
Ks_.autoMap(m); Ks_.autoMap(m);
Cs_.autoMap(m); Cs_.autoMap(m);
} }
void mutRoughWallFunctionFvPatchScalarField::rmap void mutkRoughWallFunctionFvPatchScalarField::rmap
( (
const fvPatchScalarField& ptf, const fvPatchScalarField& ptf,
const labelList& addr const labelList& addr
) )
{ {
mutWallFunctionFvPatchScalarField::rmap(ptf, addr); mutkWallFunctionFvPatchScalarField::rmap(ptf, addr);
const mutRoughWallFunctionFvPatchScalarField& nrwfpsf = const mutkRoughWallFunctionFvPatchScalarField& nrwfpsf =
refCast<const mutRoughWallFunctionFvPatchScalarField>(ptf); refCast<const mutkRoughWallFunctionFvPatchScalarField>(ptf);
Cs_.rmap(nrwfpsf.Cs_, addr); Cs_.rmap(nrwfpsf.Cs_, addr);
Ks_.rmap(nrwfpsf.Ks_, addr); Ks_.rmap(nrwfpsf.Ks_, addr);
} }
void mutRoughWallFunctionFvPatchScalarField::write(Ostream& os) const void mutkRoughWallFunctionFvPatchScalarField::write(Ostream& os) const
{ {
fvPatchField<scalar>::write(os); fvPatchField<scalar>::write(os);
writeLocalEntries(os); writeLocalEntries(os);
@ -224,7 +223,11 @@ void mutRoughWallFunctionFvPatchScalarField::write(Ostream& os) const
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
makePatchTypeField(fvPatchScalarField, mutRoughWallFunctionFvPatchScalarField); makePatchTypeField
(
fvPatchScalarField,
mutkRoughWallFunctionFvPatchScalarField
);
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -27,7 +27,7 @@ Class
Description Description
Boundary condition for turbulent (kinematic) viscosity when using wall Boundary condition for turbulent (kinematic) viscosity when using wall
functions for rough walls. functions for rough walls, based on turbulence kinetic energy.
Manipulates the E parameter to account for roughness effects, based on Manipulates the E parameter to account for roughness effects, based on
KsPlus. KsPlus.
@ -36,14 +36,14 @@ Description
- roughness constant = 0.5-1.0 (0.5 default) - roughness constant = 0.5-1.0 (0.5 default)
SourceFiles SourceFiles
mutRoughWallFunctionFvPatchScalarField.C mutkRoughWallFunctionFvPatchScalarField.C
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#ifndef compressibleMutRoughWallFunctionFvPatchScalarField_H #ifndef compressibleMutkRoughWallFunctionFvPatchScalarField_H
#define compressibleMutRoughWallFunctionFvPatchScalarField_H #define compressibleMutkRoughWallFunctionFvPatchScalarField_H
#include "mutWallFunctionFvPatchScalarField.H" #include "mutkWallFunctionFvPatchScalarField.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -55,12 +55,12 @@ namespace RASModels
{ {
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class mutRoughWallFunctionFvPatchScalarField Declaration Class mutkRoughWallFunctionFvPatchScalarField Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
class mutRoughWallFunctionFvPatchScalarField class mutkRoughWallFunctionFvPatchScalarField
: :
public mutWallFunctionFvPatchScalarField public mutkWallFunctionFvPatchScalarField
{ {
protected: protected:
@ -85,20 +85,20 @@ protected:
public: public:
//- Runtime type information //- Runtime type information
TypeName("mutRoughWallFunction"); TypeName("mutkRoughWallFunction");
// Constructors // Constructors
//- Construct from patch and internal field //- Construct from patch and internal field
mutRoughWallFunctionFvPatchScalarField mutkRoughWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
//- Construct from patch, internal field and dictionary //- Construct from patch, internal field and dictionary
mutRoughWallFunctionFvPatchScalarField mutkRoughWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
@ -106,20 +106,20 @@ public:
); );
//- Construct by mapping given //- Construct by mapping given
// mutRoughWallFunctionFvPatchScalarField // mutkRoughWallFunctionFvPatchScalarField
// onto a new patch // onto a new patch
mutRoughWallFunctionFvPatchScalarField mutkRoughWallFunctionFvPatchScalarField
( (
const mutRoughWallFunctionFvPatchScalarField&, const mutkRoughWallFunctionFvPatchScalarField&,
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
const fvPatchFieldMapper& const fvPatchFieldMapper&
); );
//- Construct as copy //- Construct as copy
mutRoughWallFunctionFvPatchScalarField mutkRoughWallFunctionFvPatchScalarField
( (
const mutRoughWallFunctionFvPatchScalarField& const mutkRoughWallFunctionFvPatchScalarField&
); );
//- Construct and return a clone //- Construct and return a clone
@ -127,14 +127,14 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new mutRoughWallFunctionFvPatchScalarField(*this) new mutkRoughWallFunctionFvPatchScalarField(*this)
); );
} }
//- Construct as copy setting internal field reference //- Construct as copy setting internal field reference
mutRoughWallFunctionFvPatchScalarField mutkRoughWallFunctionFvPatchScalarField
( (
const mutRoughWallFunctionFvPatchScalarField&, const mutkRoughWallFunctionFvPatchScalarField&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
@ -146,7 +146,7 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new mutRoughWallFunctionFvPatchScalarField(*this, iF) new mutkRoughWallFunctionFvPatchScalarField(*this, iF)
); );
} }
@ -156,10 +156,7 @@ public:
// Mapping functions // Mapping functions
//- Map (and resize as needed) from self given a mapping object //- Map (and resize as needed) from self given a mapping object
virtual void autoMap virtual void autoMap(const fvPatchFieldMapper&);
(
const fvPatchFieldMapper&
);
//- Reverse map the given fvPatchField onto this fvPatchField //- Reverse map the given fvPatchField onto this fvPatchField
virtual void rmap virtual void rmap

View File

@ -24,7 +24,7 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "mutWallFunctionFvPatchScalarField.H" #include "mutkWallFunctionFvPatchScalarField.H"
#include "RASModel.H" #include "RASModel.H"
#include "fvPatchFieldMapper.H" #include "fvPatchFieldMapper.H"
#include "volFields.H" #include "volFields.H"
@ -50,11 +50,11 @@ static const scalar defaultE_(9.8);
// * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * // // * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * //
void mutWallFunctionFvPatchScalarField::checkType() void mutkWallFunctionFvPatchScalarField::checkType()
{ {
if (!isA<wallFvPatch>(patch())) if (!isA<wallFvPatch>(patch()))
{ {
FatalErrorIn("mutWallFunctionFvPatchScalarField::checkType()") FatalErrorIn("mutkWallFunctionFvPatchScalarField::checkType()")
<< "Invalid wall function specification" << nl << "Invalid wall function specification" << nl
<< " Patch type for patch " << patch().name() << " Patch type for patch " << patch().name()
<< " must be wall" << nl << " must be wall" << nl
@ -64,7 +64,7 @@ void mutWallFunctionFvPatchScalarField::checkType()
} }
scalar mutWallFunctionFvPatchScalarField::calcYPlusLam scalar mutkWallFunctionFvPatchScalarField::calcYPlusLam
( (
const scalar kappa, const scalar kappa,
const scalar E const scalar E
@ -81,7 +81,7 @@ scalar mutWallFunctionFvPatchScalarField::calcYPlusLam
} }
tmp<scalarField> mutWallFunctionFvPatchScalarField::calcMut() const tmp<scalarField> mutkWallFunctionFvPatchScalarField::calcMut() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
const RASModel& rasModel = db().lookupObject<RASModel>("RASProperties"); const RASModel& rasModel = db().lookupObject<RASModel>("RASProperties");
@ -113,7 +113,7 @@ tmp<scalarField> mutWallFunctionFvPatchScalarField::calcMut() const
} }
void mutWallFunctionFvPatchScalarField::writeLocalEntries(Ostream& os) const void mutkWallFunctionFvPatchScalarField::writeLocalEntries(Ostream& os) const
{ {
writeEntryIfDifferent<scalar>(os, "Cmu", defaultCmu_, Cmu_); writeEntryIfDifferent<scalar>(os, "Cmu", defaultCmu_, Cmu_);
writeEntryIfDifferent<scalar>(os, "kappa", defaultKappa_, kappa_); writeEntryIfDifferent<scalar>(os, "kappa", defaultKappa_, kappa_);
@ -123,7 +123,7 @@ void mutWallFunctionFvPatchScalarField::writeLocalEntries(Ostream& os) const
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
mutWallFunctionFvPatchScalarField::mutWallFunctionFvPatchScalarField mutkWallFunctionFvPatchScalarField::mutkWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
@ -137,9 +137,9 @@ mutWallFunctionFvPatchScalarField::mutWallFunctionFvPatchScalarField
{} {}
mutWallFunctionFvPatchScalarField::mutWallFunctionFvPatchScalarField mutkWallFunctionFvPatchScalarField::mutkWallFunctionFvPatchScalarField
( (
const mutWallFunctionFvPatchScalarField& ptf, const mutkWallFunctionFvPatchScalarField& ptf,
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const fvPatchFieldMapper& mapper const fvPatchFieldMapper& mapper
@ -153,7 +153,7 @@ mutWallFunctionFvPatchScalarField::mutWallFunctionFvPatchScalarField
{} {}
mutWallFunctionFvPatchScalarField::mutWallFunctionFvPatchScalarField mutkWallFunctionFvPatchScalarField::mutkWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
@ -168,9 +168,9 @@ mutWallFunctionFvPatchScalarField::mutWallFunctionFvPatchScalarField
{} {}
mutWallFunctionFvPatchScalarField::mutWallFunctionFvPatchScalarField mutkWallFunctionFvPatchScalarField::mutkWallFunctionFvPatchScalarField
( (
const mutWallFunctionFvPatchScalarField& wfpsf const mutkWallFunctionFvPatchScalarField& wfpsf
) )
: :
fixedValueFvPatchScalarField(wfpsf), fixedValueFvPatchScalarField(wfpsf),
@ -181,9 +181,9 @@ mutWallFunctionFvPatchScalarField::mutWallFunctionFvPatchScalarField
{} {}
mutWallFunctionFvPatchScalarField::mutWallFunctionFvPatchScalarField mutkWallFunctionFvPatchScalarField::mutkWallFunctionFvPatchScalarField
( (
const mutWallFunctionFvPatchScalarField& wfpsf, const mutkWallFunctionFvPatchScalarField& wfpsf,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
@ -197,7 +197,7 @@ mutWallFunctionFvPatchScalarField::mutWallFunctionFvPatchScalarField
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
void mutWallFunctionFvPatchScalarField::updateCoeffs() void mutkWallFunctionFvPatchScalarField::updateCoeffs()
{ {
operator==(calcMut()); operator==(calcMut());
@ -205,7 +205,7 @@ void mutWallFunctionFvPatchScalarField::updateCoeffs()
} }
tmp<scalarField> mutWallFunctionFvPatchScalarField::yPlus() const tmp<scalarField> mutkWallFunctionFvPatchScalarField::yPlus() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
@ -222,7 +222,7 @@ tmp<scalarField> mutWallFunctionFvPatchScalarField::yPlus() const
} }
void mutWallFunctionFvPatchScalarField::write(Ostream& os) const void mutkWallFunctionFvPatchScalarField::write(Ostream& os) const
{ {
fvPatchField<scalar>::write(os); fvPatchField<scalar>::write(os);
writeLocalEntries(os); writeLocalEntries(os);
@ -232,7 +232,7 @@ void mutWallFunctionFvPatchScalarField::write(Ostream& os) const
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
makePatchTypeField(fvPatchScalarField, mutWallFunctionFvPatchScalarField); makePatchTypeField(fvPatchScalarField, mutkWallFunctionFvPatchScalarField);
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -23,15 +23,15 @@ License
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
Class Class
Foam::compressible::RASModels::mutWallFunctionFvPatchScalarField Foam::compressible::RASModels::mutkWallFunctionFvPatchScalarField
Description Description
Boundary condition for turbulent (kinematic) viscosity when using wall Boundary condition for turbulent (kinematic) viscosity when using wall
functions functions, based on turbulence kinetic energy.
- replicates OpenFOAM v1.5 (and earlier) behaviour - replicates OpenFOAM v1.5 (and earlier) behaviour
SourceFiles SourceFiles
mutWallFunctionFvPatchScalarField.C mutkWallFunctionFvPatchScalarField.C
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
@ -50,10 +50,10 @@ namespace RASModels
{ {
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class mutWallFunctionFvPatchScalarField Declaration Class mutkWallFunctionFvPatchScalarField Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
class mutWallFunctionFvPatchScalarField class mutkWallFunctionFvPatchScalarField
: :
public fixedValueFvPatchScalarField public fixedValueFvPatchScalarField
{ {
@ -92,20 +92,20 @@ protected:
public: public:
//- Runtime type information //- Runtime type information
TypeName("mutWallFunction"); TypeName("mutkWallFunction");
// Constructors // Constructors
//- Construct from patch and internal field //- Construct from patch and internal field
mutWallFunctionFvPatchScalarField mutkWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
//- Construct from patch, internal field and dictionary //- Construct from patch, internal field and dictionary
mutWallFunctionFvPatchScalarField mutkWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
@ -113,20 +113,20 @@ public:
); );
//- Construct by mapping given //- Construct by mapping given
// mutWallFunctionFvPatchScalarField // mutkWallFunctionFvPatchScalarField
// onto a new patch // onto a new patch
mutWallFunctionFvPatchScalarField mutkWallFunctionFvPatchScalarField
( (
const mutWallFunctionFvPatchScalarField&, const mutkWallFunctionFvPatchScalarField&,
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
const fvPatchFieldMapper& const fvPatchFieldMapper&
); );
//- Construct as copy //- Construct as copy
mutWallFunctionFvPatchScalarField mutkWallFunctionFvPatchScalarField
( (
const mutWallFunctionFvPatchScalarField& const mutkWallFunctionFvPatchScalarField&
); );
//- Construct and return a clone //- Construct and return a clone
@ -134,14 +134,14 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new mutWallFunctionFvPatchScalarField(*this) new mutkWallFunctionFvPatchScalarField(*this)
); );
} }
//- Construct as copy setting internal field reference //- Construct as copy setting internal field reference
mutWallFunctionFvPatchScalarField mutkWallFunctionFvPatchScalarField
( (
const mutWallFunctionFvPatchScalarField&, const mutkWallFunctionFvPatchScalarField&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
@ -153,7 +153,7 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new mutWallFunctionFvPatchScalarField(*this, iF) new mutkWallFunctionFvPatchScalarField(*this, iF)
); );
} }

View File

@ -21,11 +21,11 @@ LamBremhorstKE/LamBremhorstKE.C
wallFunctions = derivedFvPatchFields/wallFunctions wallFunctions = derivedFvPatchFields/wallFunctions
nutWallFunctions = $(wallFunctions)/nutWallFunctions nutWallFunctions = $(wallFunctions)/nutWallFunctions
$(nutWallFunctions)/nutWallFunction/nutWallFunctionFvPatchScalarField.C $(nutWallFunctions)/nutkRoughWallFunction/nutkRoughWallFunctionFvPatchScalarField.C
$(nutWallFunctions)/nutRoughWallFunction/nutRoughWallFunctionFvPatchScalarField.C $(nutWallFunctions)/nutkWallFunction/nutkWallFunctionFvPatchScalarField.C
$(nutWallFunctions)/nutSpalartAllmarasWallFunction/nutSpalartAllmarasWallFunctionFvPatchScalarField.C $(nutWallFunctions)/nutURoughWallFunction/nutURoughWallFunctionFvPatchScalarField.C
$(nutWallFunctions)/nutSpalartAllmarasStandardWallFunction/nutSpalartAllmarasStandardWallFunctionFvPatchScalarField.C $(nutWallFunctions)/nutUSpaldingWallFunction/nutUSpaldingWallFunctionFvPatchScalarField.C
$(nutWallFunctions)/nutSpalartAllmarasStandardRoughWallFunction/nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField.C $(nutWallFunctions)/nutUWallFunction/nutUWallFunctionFvPatchScalarField.C
epsilonWallFunctions = $(wallFunctions)/epsilonWallFunctions epsilonWallFunctions = $(wallFunctions)/epsilonWallFunctions
$(epsilonWallFunctions)/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.C $(epsilonWallFunctions)/epsilonWallFunction/epsilonWallFunctionFvPatchScalarField.C

View File

@ -233,6 +233,10 @@ tmp<volScalarField> SpalartAllmaras::DnuTildaEff() const
tmp<volScalarField> SpalartAllmaras::k() const tmp<volScalarField> SpalartAllmaras::k() const
{ {
WarningIn("tmp<volScalarField> SpalartAllmaras::k() const")
<< "Turbulence kinetic energy not defined for Spalart-Allmaras model. "
<< "Returning zero field" << endl;
return tmp<volScalarField> return tmp<volScalarField>
( (
new volScalarField new volScalarField
@ -252,6 +256,11 @@ tmp<volScalarField> SpalartAllmaras::k() const
tmp<volScalarField> SpalartAllmaras::epsilon() const tmp<volScalarField> SpalartAllmaras::epsilon() const
{ {
WarningIn("tmp<volScalarField> SpalartAllmaras::epsilon() const")
<< "Turbulence kinetic energy dissipation rate not defined for "
<< "Spalart-Allmaras model. Returning zero field"
<< endl;
return tmp<volScalarField> return tmp<volScalarField>
( (
new volScalarField new volScalarField

View File

@ -27,7 +27,7 @@ License
#include "backwardsCompatibilityWallFunctions.H" #include "backwardsCompatibilityWallFunctions.H"
#include "calculatedFvPatchField.H" #include "calculatedFvPatchField.H"
#include "nutWallFunctionFvPatchScalarField.H" #include "nutkWallFunctionFvPatchScalarField.H"
#include "epsilonWallFunctionFvPatchScalarField.H" #include "epsilonWallFunctionFvPatchScalarField.H"
#include "kqRWallFunctionFvPatchField.H" #include "kqRWallFunctionFvPatchField.H"
#include "omegaWallFunctionFvPatchScalarField.H" #include "omegaWallFunctionFvPatchScalarField.H"
@ -75,7 +75,7 @@ tmp<volScalarField> autoCreateNut
if (isType<wallFvPatch>(bm[patchI])) if (isType<wallFvPatch>(bm[patchI]))
{ {
nutBoundaryTypes[patchI] = nutBoundaryTypes[patchI] =
RASModels::nutWallFunctionFvPatchScalarField::typeName; RASModels::nutkWallFunctionFvPatchScalarField::typeName;
} }
else else
{ {

View File

@ -24,7 +24,7 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField.H" #include "nutURoughWallFunctionFvPatchScalarField.H"
#include "RASModel.H" #include "RASModel.H"
#include "fvPatchFieldMapper.H" #include "fvPatchFieldMapper.H"
#include "volFields.H" #include "volFields.H"
@ -41,8 +41,7 @@ namespace RASModels
// * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * // // * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * //
tmp<scalarField> tmp<scalarField> nutURoughWallFunctionFvPatchScalarField::calcNut() const
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::calcNut() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
@ -73,8 +72,7 @@ nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::calcNut() const
} }
tmp<scalarField> tmp<scalarField> nutURoughWallFunctionFvPatchScalarField::calcYPlus
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::calcYPlus
( (
const scalarField& magUp const scalarField& magUp
) const ) const
@ -120,8 +118,8 @@ nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::calcYPlus
dKsPlusdYPlus = 1; dKsPlusdYPlus = 1;
} }
// Additional tuning parameter (fudge factor) - nominally = 1 // Additional tuning parameter - nominally = 1
dKsPlusdYPlus *= roughnessFudgeFactor_; dKsPlusdYPlus *= roughnessFactor_;
do do
{ {
@ -200,82 +198,76 @@ nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::calcYPlus
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField:: nutURoughWallFunctionFvPatchScalarField::nutURoughWallFunctionFvPatchScalarField
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
nutWallFunctionFvPatchScalarField(p, iF), nutkWallFunctionFvPatchScalarField(p, iF),
roughnessHeight_(pTraits<scalar>::zero), roughnessHeight_(pTraits<scalar>::zero),
roughnessConstant_(pTraits<scalar>::zero), roughnessConstant_(pTraits<scalar>::zero),
roughnessFudgeFactor_(pTraits<scalar>::zero) roughnessFactor_(pTraits<scalar>::zero)
{} {}
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField:: nutURoughWallFunctionFvPatchScalarField::nutURoughWallFunctionFvPatchScalarField
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField& ptf, const nutURoughWallFunctionFvPatchScalarField& ptf,
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const fvPatchFieldMapper& mapper const fvPatchFieldMapper& mapper
) )
: :
nutWallFunctionFvPatchScalarField(ptf, p, iF, mapper), nutkWallFunctionFvPatchScalarField(ptf, p, iF, mapper),
roughnessHeight_(ptf.roughnessHeight_), roughnessHeight_(ptf.roughnessHeight_),
roughnessConstant_(ptf.roughnessConstant_), roughnessConstant_(ptf.roughnessConstant_),
roughnessFudgeFactor_(ptf.roughnessFudgeFactor_) roughnessFactor_(ptf.roughnessFactor_)
{} {}
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField:: nutURoughWallFunctionFvPatchScalarField::nutURoughWallFunctionFvPatchScalarField
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const dictionary& dict const dictionary& dict
) )
: :
nutWallFunctionFvPatchScalarField(p, iF, dict), nutkWallFunctionFvPatchScalarField(p, iF, dict),
roughnessHeight_(readScalar(dict.lookup("roughnessHeight"))), roughnessHeight_(readScalar(dict.lookup("roughnessHeight"))),
roughnessConstant_(readScalar(dict.lookup("roughnessConstant"))), roughnessConstant_(readScalar(dict.lookup("roughnessConstant"))),
roughnessFudgeFactor_(readScalar(dict.lookup("roughnessFudgeFactor"))) roughnessFactor_(readScalar(dict.lookup("roughnessFactor")))
{} {}
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField:: nutURoughWallFunctionFvPatchScalarField::nutURoughWallFunctionFvPatchScalarField
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField& rwfpsf const nutURoughWallFunctionFvPatchScalarField& rwfpsf
) )
: :
nutWallFunctionFvPatchScalarField(rwfpsf), nutkWallFunctionFvPatchScalarField(rwfpsf),
roughnessHeight_(rwfpsf.roughnessHeight_), roughnessHeight_(rwfpsf.roughnessHeight_),
roughnessConstant_(rwfpsf.roughnessConstant_), roughnessConstant_(rwfpsf.roughnessConstant_),
roughnessFudgeFactor_(rwfpsf.roughnessFudgeFactor_) roughnessFactor_(rwfpsf.roughnessFactor_)
{} {}
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField:: nutURoughWallFunctionFvPatchScalarField::nutURoughWallFunctionFvPatchScalarField
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField& rwfpsf, const nutURoughWallFunctionFvPatchScalarField& rwfpsf,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
nutWallFunctionFvPatchScalarField(rwfpsf, iF), nutkWallFunctionFvPatchScalarField(rwfpsf, iF),
roughnessHeight_(rwfpsf.roughnessHeight_), roughnessHeight_(rwfpsf.roughnessHeight_),
roughnessConstant_(rwfpsf.roughnessConstant_), roughnessConstant_(rwfpsf.roughnessConstant_),
roughnessFudgeFactor_(rwfpsf.roughnessFudgeFactor_) roughnessFactor_(rwfpsf.roughnessFactor_)
{} {}
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
tmp<scalarField> tmp<scalarField> nutURoughWallFunctionFvPatchScalarField::yPlus() const
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::yPlus() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
@ -287,10 +279,7 @@ nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::yPlus() const
} }
void nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::write void nutURoughWallFunctionFvPatchScalarField::write(Ostream& os) const
(
Ostream& os
) const
{ {
fvPatchField<scalar>::write(os); fvPatchField<scalar>::write(os);
writeLocalEntries(os); writeLocalEntries(os);
@ -298,8 +287,8 @@ void nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::write
<< roughnessHeight_ << token::END_STATEMENT << nl; << roughnessHeight_ << token::END_STATEMENT << nl;
os.writeKeyword("roughnessConstant") os.writeKeyword("roughnessConstant")
<< roughnessConstant_ << token::END_STATEMENT << nl; << roughnessConstant_ << token::END_STATEMENT << nl;
os.writeKeyword("roughnessFudgeFactor") os.writeKeyword("roughnessFactor")
<< roughnessFudgeFactor_ << token::END_STATEMENT << nl; << roughnessFactor_ << token::END_STATEMENT << nl;
writeEntry("value", os); writeEntry("value", os);
} }
@ -309,7 +298,7 @@ void nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField::write
makePatchTypeField makePatchTypeField
( (
fvPatchScalarField, fvPatchScalarField,
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField nutURoughWallFunctionFvPatchScalarField
); );
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -23,21 +23,20 @@ License
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
Class Class
Foam::incompressible::RASModels:: Foam::incompressible::RASModels::nutURoughWallFunctionFvPatchScalarField
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField
Description Description
Wall function boundary condition for rough walls Wall function boundary condition for rough walls, based on velocity.
SourceFiles SourceFiles
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField.C nutSpalartAllmarasStandardWallFunctionFvPatchScalarField.C
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#ifndef nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField_H #ifndef nutURoughWallFunctionFvPatchScalarField_H
#define nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField_H #define nutURoughWallFunctionFvPatchScalarField_H
#include "nutWallFunctionFvPatchScalarField.H" #include "nutkWallFunctionFvPatchScalarField.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -49,12 +48,12 @@ namespace RASModels
{ {
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField Declaration Class nutURoughWallFunctionFvPatchScalarField Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
class nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField class nutURoughWallFunctionFvPatchScalarField
: :
public nutWallFunctionFvPatchScalarField public nutkWallFunctionFvPatchScalarField
{ {
// Private data // Private data
@ -67,7 +66,7 @@ class nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField
scalar roughnessConstant_; scalar roughnessConstant_;
//- Scale factor //- Scale factor
scalar roughnessFudgeFactor_; scalar roughnessFactor_;
// Protected member functions // Protected member functions
@ -82,20 +81,20 @@ class nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField
public: public:
//- Runtime type information //- Runtime type information
TypeName("nutSpalartAllmarasStandardRoughWallFunction"); TypeName("nutURoughWallFunction");
// Constructors // Constructors
//- Construct from patch and internal field //- Construct from patch and internal field
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField nutURoughWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
//- Construct from patch, internal field and dictionary //- Construct from patch, internal field and dictionary
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField nutURoughWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
@ -103,20 +102,20 @@ public:
); );
//- Construct by mapping given //- Construct by mapping given
// nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField // nutURoughWallFunctionFvPatchScalarField
// onto a new patch // onto a new patch
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField nutURoughWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField&, const nutURoughWallFunctionFvPatchScalarField&,
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
const fvPatchFieldMapper& const fvPatchFieldMapper&
); );
//- Construct as copy //- Construct as copy
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField nutURoughWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField& const nutURoughWallFunctionFvPatchScalarField&
); );
//- Construct and return a clone //- Construct and return a clone
@ -124,17 +123,14 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField new nutURoughWallFunctionFvPatchScalarField(*this)
(
*this
)
); );
} }
//- Construct as copy setting internal field reference //- Construct as copy setting internal field reference
nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField nutURoughWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField&, const nutURoughWallFunctionFvPatchScalarField&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
@ -146,11 +142,7 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new nutSpalartAllmarasStandardRoughWallFunctionFvPatchScalarField new nutURoughWallFunctionFvPatchScalarField(*this, iF)
(
*this,
iF
)
); );
} }
@ -185,16 +177,16 @@ public:
} }
//- Return the roughness scale factor //- Return the roughness scale factor
const scalar& roughnessFudgeFactor() const const scalar& roughnessFactor() const
{ {
return roughnessFudgeFactor_; return roughnessFactor_;
} }
//- Return reference to the roughness scale factor to allow //- Return reference to the roughness scale factor to allow
// adjustment // adjustment
scalar& roughnessFudgeFactor() scalar& roughnessFactor()
{ {
return roughnessFudgeFactor_; return roughnessFactor_;
} }

View File

@ -24,7 +24,7 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "nutSpalartAllmarasWallFunctionFvPatchScalarField.H" #include "nutUSpaldingWallFunctionFvPatchScalarField.H"
#include "RASModel.H" #include "RASModel.H"
#include "fvPatchFieldMapper.H" #include "fvPatchFieldMapper.H"
#include "volFields.H" #include "volFields.H"
@ -41,8 +41,7 @@ namespace RASModels
// * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * // // * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * //
tmp<scalarField> tmp<scalarField> nutUSpaldingWallFunctionFvPatchScalarField::calcNut() const
nutSpalartAllmarasWallFunctionFvPatchScalarField::calcNut() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
@ -55,7 +54,7 @@ nutSpalartAllmarasWallFunctionFvPatchScalarField::calcNut() const
} }
tmp<scalarField> nutSpalartAllmarasWallFunctionFvPatchScalarField::calcUTau tmp<scalarField> nutUSpaldingWallFunctionFvPatchScalarField::calcUTau
( (
const scalarField& magGradU const scalarField& magGradU
) const ) const
@ -114,67 +113,66 @@ tmp<scalarField> nutSpalartAllmarasWallFunctionFvPatchScalarField::calcUTau
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
nutSpalartAllmarasWallFunctionFvPatchScalarField:: nutUSpaldingWallFunctionFvPatchScalarField::
nutSpalartAllmarasWallFunctionFvPatchScalarField nutUSpaldingWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
nutWallFunctionFvPatchScalarField(p, iF) nutkWallFunctionFvPatchScalarField(p, iF)
{} {}
nutSpalartAllmarasWallFunctionFvPatchScalarField:: nutUSpaldingWallFunctionFvPatchScalarField::
nutSpalartAllmarasWallFunctionFvPatchScalarField nutUSpaldingWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasWallFunctionFvPatchScalarField& ptf, const nutUSpaldingWallFunctionFvPatchScalarField& ptf,
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const fvPatchFieldMapper& mapper const fvPatchFieldMapper& mapper
) )
: :
nutWallFunctionFvPatchScalarField(ptf, p, iF, mapper) nutkWallFunctionFvPatchScalarField(ptf, p, iF, mapper)
{} {}
nutSpalartAllmarasWallFunctionFvPatchScalarField:: nutUSpaldingWallFunctionFvPatchScalarField::
nutSpalartAllmarasWallFunctionFvPatchScalarField nutUSpaldingWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const dictionary& dict const dictionary& dict
) )
: :
nutWallFunctionFvPatchScalarField(p, iF, dict) nutkWallFunctionFvPatchScalarField(p, iF, dict)
{} {}
nutSpalartAllmarasWallFunctionFvPatchScalarField:: nutUSpaldingWallFunctionFvPatchScalarField::
nutSpalartAllmarasWallFunctionFvPatchScalarField nutUSpaldingWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasWallFunctionFvPatchScalarField& wfpsf const nutUSpaldingWallFunctionFvPatchScalarField& wfpsf
) )
: :
nutWallFunctionFvPatchScalarField(wfpsf) nutkWallFunctionFvPatchScalarField(wfpsf)
{} {}
nutSpalartAllmarasWallFunctionFvPatchScalarField:: nutUSpaldingWallFunctionFvPatchScalarField::
nutSpalartAllmarasWallFunctionFvPatchScalarField nutUSpaldingWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasWallFunctionFvPatchScalarField& wfpsf, const nutUSpaldingWallFunctionFvPatchScalarField& wfpsf,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
nutWallFunctionFvPatchScalarField(wfpsf, iF) nutkWallFunctionFvPatchScalarField(wfpsf, iF)
{} {}
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
tmp<scalarField> tmp<scalarField> nutUSpaldingWallFunctionFvPatchScalarField::yPlus() const
nutSpalartAllmarasWallFunctionFvPatchScalarField::yPlus() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
@ -187,10 +185,7 @@ nutSpalartAllmarasWallFunctionFvPatchScalarField::yPlus() const
} }
void nutSpalartAllmarasWallFunctionFvPatchScalarField::write void nutUSpaldingWallFunctionFvPatchScalarField::write(Ostream& os) const
(
Ostream& os
) const
{ {
fvPatchField<scalar>::write(os); fvPatchField<scalar>::write(os);
writeLocalEntries(os); writeLocalEntries(os);
@ -203,7 +198,7 @@ void nutSpalartAllmarasWallFunctionFvPatchScalarField::write
makePatchTypeField makePatchTypeField
( (
fvPatchScalarField, fvPatchScalarField,
nutSpalartAllmarasWallFunctionFvPatchScalarField nutUSpaldingWallFunctionFvPatchScalarField
); );
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -23,21 +23,21 @@ License
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
Class Class
Foam::incompressible::RASModels:: Foam::incompressible::RASModels::nutUSpaldingWallFunctionFvPatchScalarField
nutSpalartAllmarasWallFunctionFvPatchScalarField
Description Description
Wall function boundary condition for walls Wall function boundary condition for walls, based on velocity, using
Spaldings law to give a continuous nut profile to the wall (y+ = 0)
SourceFiles SourceFiles
nutSpalartAllmarasWallFunctionFvPatchScalarField.C nutUSpaldingWallFunctionFvPatchScalarField.C
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#ifndef nutSpalartAllmarasWallFunctionFvPatchScalarField_H #ifndef nutUSpaldingWallFunctionFvPatchScalarField_H
#define nutSpalartAllmarasWallFunctionFvPatchScalarField_H #define nutUSpaldingWallFunctionFvPatchScalarField_H
#include "nutWallFunctionFvPatchScalarField.H" #include "nutkWallFunctionFvPatchScalarField.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -49,12 +49,12 @@ namespace RASModels
{ {
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class nutSpalartAllmarasWallFunctionFvPatch Declaration Class nutUSpaldingWallFunctionFvPatch Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
class nutSpalartAllmarasWallFunctionFvPatchScalarField class nutUSpaldingWallFunctionFvPatchScalarField
: :
public nutWallFunctionFvPatchScalarField public nutkWallFunctionFvPatchScalarField
{ {
protected: protected:
@ -70,20 +70,20 @@ protected:
public: public:
//- Runtime type information //- Runtime type information
TypeName("nutSpalartAllmarasWallFunction"); TypeName("nutUSpaldingWallFunction");
// Constructors // Constructors
//- Construct from patch and internal field //- Construct from patch and internal field
nutSpalartAllmarasWallFunctionFvPatchScalarField nutUSpaldingWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
//- Construct from patch, internal field and dictionary //- Construct from patch, internal field and dictionary
nutSpalartAllmarasWallFunctionFvPatchScalarField nutUSpaldingWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
@ -91,20 +91,20 @@ public:
); );
//- Construct by mapping given //- Construct by mapping given
// nutSpalartAllmarasWallFunctionFvPatchScalarField // nutUSpaldingWallFunctionFvPatchScalarField
// onto a new patch // onto a new patch
nutSpalartAllmarasWallFunctionFvPatchScalarField nutUSpaldingWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasWallFunctionFvPatchScalarField&, const nutUSpaldingWallFunctionFvPatchScalarField&,
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
const fvPatchFieldMapper& const fvPatchFieldMapper&
); );
//- Construct as copy //- Construct as copy
nutSpalartAllmarasWallFunctionFvPatchScalarField nutUSpaldingWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasWallFunctionFvPatchScalarField& const nutUSpaldingWallFunctionFvPatchScalarField&
); );
//- Construct and return a clone //- Construct and return a clone
@ -112,14 +112,14 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new nutSpalartAllmarasWallFunctionFvPatchScalarField(*this) new nutUSpaldingWallFunctionFvPatchScalarField(*this)
); );
} }
//- Construct as copy setting internal field reference //- Construct as copy setting internal field reference
nutSpalartAllmarasWallFunctionFvPatchScalarField nutUSpaldingWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasWallFunctionFvPatchScalarField&, const nutUSpaldingWallFunctionFvPatchScalarField&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
@ -131,7 +131,7 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new nutSpalartAllmarasWallFunctionFvPatchScalarField(*this, iF) new nutUSpaldingWallFunctionFvPatchScalarField(*this, iF)
); );
} }

View File

@ -24,7 +24,7 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "nutSpalartAllmarasStandardWallFunctionFvPatchScalarField.H" #include "nutUWallFunctionFvPatchScalarField.H"
#include "RASModel.H" #include "RASModel.H"
#include "fvPatchFieldMapper.H" #include "fvPatchFieldMapper.H"
#include "volFields.H" #include "volFields.H"
@ -41,8 +41,7 @@ namespace RASModels
// * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * // // * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * //
tmp<scalarField> tmp<scalarField> nutUWallFunctionFvPatchScalarField::calcNut() const
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField::calcNut() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
@ -70,8 +69,7 @@ nutSpalartAllmarasStandardWallFunctionFvPatchScalarField::calcNut() const
} }
tmp<scalarField> tmp<scalarField> nutUWallFunctionFvPatchScalarField::calcYPlus
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField::calcYPlus
( (
const scalarField& magUp const scalarField& magUp
) const ) const
@ -111,67 +109,61 @@ nutSpalartAllmarasStandardWallFunctionFvPatchScalarField::calcYPlus
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField:: nutUWallFunctionFvPatchScalarField::nutUWallFunctionFvPatchScalarField
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
nutWallFunctionFvPatchScalarField(p, iF) nutkWallFunctionFvPatchScalarField(p, iF)
{} {}
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField:: nutUWallFunctionFvPatchScalarField::nutUWallFunctionFvPatchScalarField
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasStandardWallFunctionFvPatchScalarField& ptf, const nutUWallFunctionFvPatchScalarField& ptf,
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const fvPatchFieldMapper& mapper const fvPatchFieldMapper& mapper
) )
: :
nutWallFunctionFvPatchScalarField(ptf, p, iF, mapper) nutkWallFunctionFvPatchScalarField(ptf, p, iF, mapper)
{} {}
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField:: nutUWallFunctionFvPatchScalarField::nutUWallFunctionFvPatchScalarField
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const dictionary& dict const dictionary& dict
) )
: :
nutWallFunctionFvPatchScalarField(p, iF, dict) nutkWallFunctionFvPatchScalarField(p, iF, dict)
{} {}
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField:: nutUWallFunctionFvPatchScalarField::nutUWallFunctionFvPatchScalarField
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasStandardWallFunctionFvPatchScalarField& sawfpsf const nutUWallFunctionFvPatchScalarField& sawfpsf
) )
: :
nutWallFunctionFvPatchScalarField(sawfpsf) nutkWallFunctionFvPatchScalarField(sawfpsf)
{} {}
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField:: nutUWallFunctionFvPatchScalarField::nutUWallFunctionFvPatchScalarField
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasStandardWallFunctionFvPatchScalarField& sawfpsf, const nutUWallFunctionFvPatchScalarField& sawfpsf,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
nutWallFunctionFvPatchScalarField(sawfpsf, iF) nutkWallFunctionFvPatchScalarField(sawfpsf, iF)
{} {}
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
tmp<scalarField> tmp<scalarField> nutUWallFunctionFvPatchScalarField::yPlus() const
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField::yPlus() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
const RASModel& rasModel = db().lookupObject<RASModel>("RASProperties"); const RASModel& rasModel = db().lookupObject<RASModel>("RASProperties");
@ -182,10 +174,7 @@ nutSpalartAllmarasStandardWallFunctionFvPatchScalarField::yPlus() const
} }
void nutSpalartAllmarasStandardWallFunctionFvPatchScalarField::write void nutUWallFunctionFvPatchScalarField::write(Ostream& os) const
(
Ostream& os
) const
{ {
fvPatchField<scalar>::write(os); fvPatchField<scalar>::write(os);
writeLocalEntries(os); writeLocalEntries(os);
@ -198,7 +187,7 @@ void nutSpalartAllmarasStandardWallFunctionFvPatchScalarField::write
makePatchTypeField makePatchTypeField
( (
fvPatchScalarField, fvPatchScalarField,
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField nutUWallFunctionFvPatchScalarField
); );
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -23,21 +23,20 @@ License
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
Class Class
Foam::incompressible::RASModels:: Foam::incompressible::RASModels::nutUWallFunctionFvPatchScalarField
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField
Description Description
Wall function boundary condition for walls Wall function boundary condition for walls, based on velocity.
SourceFiles SourceFiles
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField.C nutUWallFunctionFvPatchScalarField.C
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#ifndef nutSpalartAllmarasStandardWallFunctionFvPatchScalarField_H #ifndef nutUWallFunctionFvPatchScalarField_H
#define nutSpalartAllmarasStandardWallFunctionFvPatchScalarField_H #define nutUWallFunctionFvPatchScalarField_H
#include "nutWallFunctionFvPatchScalarField.H" #include "nutkWallFunctionFvPatchScalarField.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -49,12 +48,12 @@ namespace RASModels
{ {
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class nutSpalartAllmarasStandardWallFunctionFvPatchScalarField Declaration Class nutUWallFunctionFvPatchScalarField Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
class nutSpalartAllmarasStandardWallFunctionFvPatchScalarField class nutUWallFunctionFvPatchScalarField
: :
public nutWallFunctionFvPatchScalarField public nutkWallFunctionFvPatchScalarField
{ {
protected: protected:
@ -70,20 +69,20 @@ protected:
public: public:
//- Runtime type information //- Runtime type information
TypeName("nutSpalartAllmarasStandardWallFunction"); TypeName("nutUWallFunction");
// Constructors // Constructors
//- Construct from patch and internal field //- Construct from patch and internal field
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField nutUWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
//- Construct from patch, internal field and dictionary //- Construct from patch, internal field and dictionary
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField nutUWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
@ -91,20 +90,20 @@ public:
); );
//- Construct by mapping given //- Construct by mapping given
// nutSpalartAllmarasStandardWallFunctionFvPatchScalarField // nutUWallFunctionFvPatchScalarField
// onto a new patch // onto a new patch
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField nutUWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasStandardWallFunctionFvPatchScalarField&, const nutUWallFunctionFvPatchScalarField&,
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
const fvPatchFieldMapper& const fvPatchFieldMapper&
); );
//- Construct as copy //- Construct as copy
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField nutUWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasStandardWallFunctionFvPatchScalarField& const nutUWallFunctionFvPatchScalarField&
); );
//- Construct and return a clone //- Construct and return a clone
@ -112,17 +111,14 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new nutSpalartAllmarasStandardWallFunctionFvPatchScalarField new nutUWallFunctionFvPatchScalarField(*this)
(
*this
)
); );
} }
//- Construct as copy setting internal field reference //- Construct as copy setting internal field reference
nutSpalartAllmarasStandardWallFunctionFvPatchScalarField nutUWallFunctionFvPatchScalarField
( (
const nutSpalartAllmarasStandardWallFunctionFvPatchScalarField&, const nutUWallFunctionFvPatchScalarField&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
@ -134,11 +130,7 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new nutSpalartAllmarasStandardWallFunctionFvPatchScalarField new nutUWallFunctionFvPatchScalarField(*this, iF)
(
*this,
iF
)
); );
} }

View File

@ -24,7 +24,7 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "nutRoughWallFunctionFvPatchScalarField.H" #include "nutkRoughWallFunctionFvPatchScalarField.H"
#include "RASModel.H" #include "RASModel.H"
#include "fvPatchFieldMapper.H" #include "fvPatchFieldMapper.H"
#include "volFields.H" #include "volFields.H"
@ -41,7 +41,7 @@ namespace RASModels
// * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * // // * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * //
scalar nutRoughWallFunctionFvPatchScalarField::fnRough scalar nutkRoughWallFunctionFvPatchScalarField::fnRough
( (
const scalar KsPlus, const scalar KsPlus,
const scalar Cs const scalar Cs
@ -64,7 +64,7 @@ scalar nutRoughWallFunctionFvPatchScalarField::fnRough
} }
tmp<scalarField> nutRoughWallFunctionFvPatchScalarField::calcNut() const tmp<scalarField> nutkRoughWallFunctionFvPatchScalarField::calcNut() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
@ -128,63 +128,63 @@ tmp<scalarField> nutRoughWallFunctionFvPatchScalarField::calcNut() const
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
nutRoughWallFunctionFvPatchScalarField::nutRoughWallFunctionFvPatchScalarField nutkRoughWallFunctionFvPatchScalarField::nutkRoughWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
nutWallFunctionFvPatchScalarField(p, iF), nutkWallFunctionFvPatchScalarField(p, iF),
Ks_(p.size(), 0.0), Ks_(p.size(), 0.0),
Cs_(p.size(), 0.0) Cs_(p.size(), 0.0)
{} {}
nutRoughWallFunctionFvPatchScalarField::nutRoughWallFunctionFvPatchScalarField nutkRoughWallFunctionFvPatchScalarField::nutkRoughWallFunctionFvPatchScalarField
( (
const nutRoughWallFunctionFvPatchScalarField& ptf, const nutkRoughWallFunctionFvPatchScalarField& ptf,
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const fvPatchFieldMapper& mapper const fvPatchFieldMapper& mapper
) )
: :
nutWallFunctionFvPatchScalarField(ptf, p, iF, mapper), nutkWallFunctionFvPatchScalarField(ptf, p, iF, mapper),
Ks_(ptf.Ks_, mapper), Ks_(ptf.Ks_, mapper),
Cs_(ptf.Cs_, mapper) Cs_(ptf.Cs_, mapper)
{} {}
nutRoughWallFunctionFvPatchScalarField::nutRoughWallFunctionFvPatchScalarField nutkRoughWallFunctionFvPatchScalarField::nutkRoughWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const dictionary& dict const dictionary& dict
) )
: :
nutWallFunctionFvPatchScalarField(p, iF, dict), nutkWallFunctionFvPatchScalarField(p, iF, dict),
Ks_("Ks", dict, p.size()), Ks_("Ks", dict, p.size()),
Cs_("Cs", dict, p.size()) Cs_("Cs", dict, p.size())
{} {}
nutRoughWallFunctionFvPatchScalarField::nutRoughWallFunctionFvPatchScalarField nutkRoughWallFunctionFvPatchScalarField::nutkRoughWallFunctionFvPatchScalarField
( (
const nutRoughWallFunctionFvPatchScalarField& rwfpsf const nutkRoughWallFunctionFvPatchScalarField& rwfpsf
) )
: :
nutWallFunctionFvPatchScalarField(rwfpsf), nutkWallFunctionFvPatchScalarField(rwfpsf),
Ks_(rwfpsf.Ks_), Ks_(rwfpsf.Ks_),
Cs_(rwfpsf.Cs_) Cs_(rwfpsf.Cs_)
{} {}
nutRoughWallFunctionFvPatchScalarField::nutRoughWallFunctionFvPatchScalarField nutkRoughWallFunctionFvPatchScalarField::nutkRoughWallFunctionFvPatchScalarField
( (
const nutRoughWallFunctionFvPatchScalarField& rwfpsf, const nutkRoughWallFunctionFvPatchScalarField& rwfpsf,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
nutWallFunctionFvPatchScalarField(rwfpsf, iF), nutkWallFunctionFvPatchScalarField(rwfpsf, iF),
Ks_(rwfpsf.Ks_), Ks_(rwfpsf.Ks_),
Cs_(rwfpsf.Cs_) Cs_(rwfpsf.Cs_)
{} {}
@ -192,34 +192,34 @@ nutRoughWallFunctionFvPatchScalarField::nutRoughWallFunctionFvPatchScalarField
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
void nutRoughWallFunctionFvPatchScalarField::autoMap void nutkRoughWallFunctionFvPatchScalarField::autoMap
( (
const fvPatchFieldMapper& m const fvPatchFieldMapper& m
) )
{ {
nutWallFunctionFvPatchScalarField::autoMap(m); nutkWallFunctionFvPatchScalarField::autoMap(m);
Ks_.autoMap(m); Ks_.autoMap(m);
Cs_.autoMap(m); Cs_.autoMap(m);
} }
void nutRoughWallFunctionFvPatchScalarField::rmap void nutkRoughWallFunctionFvPatchScalarField::rmap
( (
const fvPatchScalarField& ptf, const fvPatchScalarField& ptf,
const labelList& addr const labelList& addr
) )
{ {
nutWallFunctionFvPatchScalarField::rmap(ptf, addr); nutkWallFunctionFvPatchScalarField::rmap(ptf, addr);
const nutRoughWallFunctionFvPatchScalarField& nrwfpsf = const nutkRoughWallFunctionFvPatchScalarField& nrwfpsf =
refCast<const nutRoughWallFunctionFvPatchScalarField>(ptf); refCast<const nutkRoughWallFunctionFvPatchScalarField>(ptf);
Ks_.rmap(nrwfpsf.Ks_, addr); Ks_.rmap(nrwfpsf.Ks_, addr);
Cs_.rmap(nrwfpsf.Cs_, addr); Cs_.rmap(nrwfpsf.Cs_, addr);
} }
void nutRoughWallFunctionFvPatchScalarField::write(Ostream& os) const void nutkRoughWallFunctionFvPatchScalarField::write(Ostream& os) const
{ {
fvPatchField<scalar>::write(os); fvPatchField<scalar>::write(os);
writeLocalEntries(os); writeLocalEntries(os);
@ -231,7 +231,11 @@ void nutRoughWallFunctionFvPatchScalarField::write(Ostream& os) const
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
makePatchTypeField(fvPatchScalarField, nutRoughWallFunctionFvPatchScalarField); makePatchTypeField
(
fvPatchScalarField,
nutkRoughWallFunctionFvPatchScalarField
);
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -23,11 +23,11 @@ License
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
Class Class
Foam::incompressible::RASModels::nutRoughWallFunctionFvPatchScalarField Foam::incompressible::RASModels::nutkRoughWallFunctionFvPatchScalarField
Description Description
Boundary condition for turbulent (kinematic) viscosity when using wall Boundary condition for turbulent (kinematic) viscosity when using wall
functions for rough walls. functions for rough walls, based on turbulence kinetic energy.
Manipulates the E parameter to account for roughness effects, based on Manipulates the E parameter to account for roughness effects, based on
KsPlus. KsPlus.
@ -36,14 +36,14 @@ Description
- roughness constant = 0.5-1.0 (0.5 default) - roughness constant = 0.5-1.0 (0.5 default)
SourceFiles SourceFiles
nutRoughWallFunctionFvPatchScalarField.C nutkRoughWallFunctionFvPatchScalarField.C
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#ifndef nutRoughWallFunctionFvPatchScalarField_H #ifndef nutkRoughWallFunctionFvPatchScalarField_H
#define nutRoughWallFunctionFvPatchScalarField_H #define nutkRoughWallFunctionFvPatchScalarField_H
#include "nutWallFunctionFvPatchScalarField.H" #include "nutkWallFunctionFvPatchScalarField.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -55,12 +55,12 @@ namespace RASModels
{ {
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class nutRoughWallFunctionFvPatchScalarField Declaration Class nutkRoughWallFunctionFvPatchScalarField Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
class nutRoughWallFunctionFvPatchScalarField class nutkRoughWallFunctionFvPatchScalarField
: :
public nutWallFunctionFvPatchScalarField public nutkWallFunctionFvPatchScalarField
{ {
protected: protected:
@ -85,20 +85,20 @@ protected:
public: public:
//- Runtime type information //- Runtime type information
TypeName("nutRoughWallFunction"); TypeName("nutkRoughWallFunction");
// Constructors // Constructors
//- Construct from patch and internal field //- Construct from patch and internal field
nutRoughWallFunctionFvPatchScalarField nutkRoughWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
//- Construct from patch, internal field and dictionary //- Construct from patch, internal field and dictionary
nutRoughWallFunctionFvPatchScalarField nutkRoughWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
@ -106,20 +106,20 @@ public:
); );
//- Construct by mapping given //- Construct by mapping given
// nutRoughWallFunctionFvPatchScalarField // nutkRoughWallFunctionFvPatchScalarField
// onto a new patch // onto a new patch
nutRoughWallFunctionFvPatchScalarField nutkRoughWallFunctionFvPatchScalarField
( (
const nutRoughWallFunctionFvPatchScalarField&, const nutkRoughWallFunctionFvPatchScalarField&,
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
const fvPatchFieldMapper& const fvPatchFieldMapper&
); );
//- Construct as copy //- Construct as copy
nutRoughWallFunctionFvPatchScalarField nutkRoughWallFunctionFvPatchScalarField
( (
const nutRoughWallFunctionFvPatchScalarField& const nutkRoughWallFunctionFvPatchScalarField&
); );
//- Construct and return a clone //- Construct and return a clone
@ -127,14 +127,14 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new nutRoughWallFunctionFvPatchScalarField(*this) new nutkRoughWallFunctionFvPatchScalarField(*this)
); );
} }
//- Construct as copy setting internal field reference //- Construct as copy setting internal field reference
nutRoughWallFunctionFvPatchScalarField nutkRoughWallFunctionFvPatchScalarField
( (
const nutRoughWallFunctionFvPatchScalarField&, const nutkRoughWallFunctionFvPatchScalarField&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
@ -146,7 +146,7 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new nutRoughWallFunctionFvPatchScalarField(*this, iF) new nutkRoughWallFunctionFvPatchScalarField(*this, iF)
); );
} }

View File

@ -24,7 +24,7 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "nutWallFunctionFvPatchScalarField.H" #include "nutkWallFunctionFvPatchScalarField.H"
#include "RASModel.H" #include "RASModel.H"
#include "fvPatchFieldMapper.H" #include "fvPatchFieldMapper.H"
#include "volFields.H" #include "volFields.H"
@ -50,11 +50,11 @@ static const scalar defaultE_(9.8);
// * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * // // * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * //
void nutWallFunctionFvPatchScalarField::checkType() void nutkWallFunctionFvPatchScalarField::checkType()
{ {
if (!isA<wallFvPatch>(patch())) if (!isA<wallFvPatch>(patch()))
{ {
FatalErrorIn("nutWallFunctionFvPatchScalarField::checkType()") FatalErrorIn("nutkWallFunctionFvPatchScalarField::checkType()")
<< "Invalid wall function specification" << nl << "Invalid wall function specification" << nl
<< " Patch type for patch " << patch().name() << " Patch type for patch " << patch().name()
<< " must be wall" << nl << " must be wall" << nl
@ -64,7 +64,7 @@ void nutWallFunctionFvPatchScalarField::checkType()
} }
scalar nutWallFunctionFvPatchScalarField::calcYPlusLam scalar nutkWallFunctionFvPatchScalarField::calcYPlusLam
( (
const scalar kappa, const scalar kappa,
const scalar E const scalar E
@ -81,7 +81,7 @@ scalar nutWallFunctionFvPatchScalarField::calcYPlusLam
} }
tmp<scalarField> nutWallFunctionFvPatchScalarField::calcNut() const tmp<scalarField> nutkWallFunctionFvPatchScalarField::calcNut() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
@ -112,7 +112,7 @@ tmp<scalarField> nutWallFunctionFvPatchScalarField::calcNut() const
} }
void nutWallFunctionFvPatchScalarField::writeLocalEntries(Ostream& os) const void nutkWallFunctionFvPatchScalarField::writeLocalEntries(Ostream& os) const
{ {
writeEntryIfDifferent<scalar>(os, "Cmu", defaultCmu_, Cmu_); writeEntryIfDifferent<scalar>(os, "Cmu", defaultCmu_, Cmu_);
writeEntryIfDifferent<scalar>(os, "kappa", defaultKappa_, kappa_); writeEntryIfDifferent<scalar>(os, "kappa", defaultKappa_, kappa_);
@ -122,7 +122,7 @@ void nutWallFunctionFvPatchScalarField::writeLocalEntries(Ostream& os) const
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
nutWallFunctionFvPatchScalarField::nutWallFunctionFvPatchScalarField nutkWallFunctionFvPatchScalarField::nutkWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
@ -138,9 +138,9 @@ nutWallFunctionFvPatchScalarField::nutWallFunctionFvPatchScalarField
} }
nutWallFunctionFvPatchScalarField::nutWallFunctionFvPatchScalarField nutkWallFunctionFvPatchScalarField::nutkWallFunctionFvPatchScalarField
( (
const nutWallFunctionFvPatchScalarField& ptf, const nutkWallFunctionFvPatchScalarField& ptf,
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const fvPatchFieldMapper& mapper const fvPatchFieldMapper& mapper
@ -156,7 +156,7 @@ nutWallFunctionFvPatchScalarField::nutWallFunctionFvPatchScalarField
} }
nutWallFunctionFvPatchScalarField::nutWallFunctionFvPatchScalarField nutkWallFunctionFvPatchScalarField::nutkWallFunctionFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
@ -173,9 +173,9 @@ nutWallFunctionFvPatchScalarField::nutWallFunctionFvPatchScalarField
} }
nutWallFunctionFvPatchScalarField::nutWallFunctionFvPatchScalarField nutkWallFunctionFvPatchScalarField::nutkWallFunctionFvPatchScalarField
( (
const nutWallFunctionFvPatchScalarField& wfpsf const nutkWallFunctionFvPatchScalarField& wfpsf
) )
: :
fixedValueFvPatchScalarField(wfpsf), fixedValueFvPatchScalarField(wfpsf),
@ -188,9 +188,9 @@ nutWallFunctionFvPatchScalarField::nutWallFunctionFvPatchScalarField
} }
nutWallFunctionFvPatchScalarField::nutWallFunctionFvPatchScalarField nutkWallFunctionFvPatchScalarField::nutkWallFunctionFvPatchScalarField
( (
const nutWallFunctionFvPatchScalarField& wfpsf, const nutkWallFunctionFvPatchScalarField& wfpsf,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
@ -206,7 +206,7 @@ nutWallFunctionFvPatchScalarField::nutWallFunctionFvPatchScalarField
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
void nutWallFunctionFvPatchScalarField::updateCoeffs() void nutkWallFunctionFvPatchScalarField::updateCoeffs()
{ {
operator==(calcNut()); operator==(calcNut());
@ -214,7 +214,7 @@ void nutWallFunctionFvPatchScalarField::updateCoeffs()
} }
tmp<scalarField> nutWallFunctionFvPatchScalarField::yPlus() const tmp<scalarField> nutkWallFunctionFvPatchScalarField::yPlus() const
{ {
const label patchI = patch().index(); const label patchI = patch().index();
@ -230,7 +230,7 @@ tmp<scalarField> nutWallFunctionFvPatchScalarField::yPlus() const
} }
void nutWallFunctionFvPatchScalarField::write(Ostream& os) const void nutkWallFunctionFvPatchScalarField::write(Ostream& os) const
{ {
fvPatchField<scalar>::write(os); fvPatchField<scalar>::write(os);
writeLocalEntries(os); writeLocalEntries(os);
@ -240,7 +240,7 @@ void nutWallFunctionFvPatchScalarField::write(Ostream& os) const
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
makePatchTypeField(fvPatchScalarField, nutWallFunctionFvPatchScalarField); makePatchTypeField(fvPatchScalarField, nutkWallFunctionFvPatchScalarField);
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -23,20 +23,20 @@ License
Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA Inc., 51 Franklin St, Fifth Floor, Boston, MA 02110-1301 USA
Class Class
Foam::incompressible::RASModels::nutWallFunctionFvPatchScalarField Foam::incompressible::RASModels::nutkWallFunctionFvPatchScalarField
Description Description
Boundary condition for turbulent (kinematic) viscosity when using wall Boundary condition for turbulent (kinematic) viscosity when using wall
functions functions, based on turbulence kinetic energy.
- replicates OpenFOAM v1.5 (and earlier) behaviour - replicates OpenFOAM v1.5 (and earlier) behaviour
SourceFiles SourceFiles
nutWallFunctionFvPatchScalarField.C nutkWallFunctionFvPatchScalarField.C
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#ifndef nutWallFunctionFvPatchScalarField_H #ifndef nutkWallFunctionFvPatchScalarField_H
#define nutWallFunctionFvPatchScalarField_H #define nutkWallFunctionFvPatchScalarField_H
#include "fixedValueFvPatchFields.H" #include "fixedValueFvPatchFields.H"
@ -50,10 +50,10 @@ namespace RASModels
{ {
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class nutWallFunctionFvPatchScalarField Declaration Class nutkWallFunctionFvPatchScalarField Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
class nutWallFunctionFvPatchScalarField class nutkWallFunctionFvPatchScalarField
: :
public fixedValueFvPatchScalarField public fixedValueFvPatchScalarField
{ {
@ -92,20 +92,20 @@ protected:
public: public:
//- Runtime type information //- Runtime type information
TypeName("nutWallFunction"); TypeName("nutkWallFunction");
// Constructors // Constructors
//- Construct from patch and internal field //- Construct from patch and internal field
nutWallFunctionFvPatchScalarField nutkWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
//- Construct from patch, internal field and dictionary //- Construct from patch, internal field and dictionary
nutWallFunctionFvPatchScalarField nutkWallFunctionFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
@ -113,20 +113,20 @@ public:
); );
//- Construct by mapping given //- Construct by mapping given
// nutWallFunctionFvPatchScalarField // nutkWallFunctionFvPatchScalarField
// onto a new patch // onto a new patch
nutWallFunctionFvPatchScalarField nutkWallFunctionFvPatchScalarField
( (
const nutWallFunctionFvPatchScalarField&, const nutkWallFunctionFvPatchScalarField&,
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
const fvPatchFieldMapper& const fvPatchFieldMapper&
); );
//- Construct as copy //- Construct as copy
nutWallFunctionFvPatchScalarField nutkWallFunctionFvPatchScalarField
( (
const nutWallFunctionFvPatchScalarField& const nutkWallFunctionFvPatchScalarField&
); );
//- Construct and return a clone //- Construct and return a clone
@ -134,14 +134,14 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new nutWallFunctionFvPatchScalarField(*this) new nutkWallFunctionFvPatchScalarField(*this)
); );
} }
//- Construct as copy setting internal field reference //- Construct as copy setting internal field reference
nutWallFunctionFvPatchScalarField nutkWallFunctionFvPatchScalarField
( (
const nutWallFunctionFvPatchScalarField&, const nutkWallFunctionFvPatchScalarField&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
@ -153,7 +153,7 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new nutWallFunctionFvPatchScalarField(*this, iF) new nutkWallFunctionFvPatchScalarField(*this, iF)
); );
} }

View File

@ -23,7 +23,7 @@ boundaryField
{ {
walls walls
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
} }

View File

@ -23,7 +23,7 @@ boundaryField
{ {
piston piston
{ {
type mutWallFunction; type mutkWallFunction;
Cmu 0.09; Cmu 0.09;
kappa 0.41; kappa 0.41;
E 9.8; E 9.8;
@ -31,7 +31,7 @@ boundaryField
} }
liner liner
{ {
type mutWallFunction; type mutkWallFunction;
Cmu 0.09; Cmu 0.09;
kappa 0.41; kappa 0.41;
E 9.8; E 9.8;
@ -39,7 +39,7 @@ boundaryField
} }
cylinderHead cylinderHead
{ {
type mutWallFunction; type mutkWallFunction;
Cmu 0.09; Cmu 0.09;
kappa 0.41; kappa 0.41;
E 9.8; E 9.8;

View File

@ -23,22 +23,22 @@ boundaryField
{ {
front front
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
back back
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
wall wall
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
porosityWall porosityWall
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
inlet inlet

View File

@ -23,7 +23,7 @@ boundaryField
{ {
movingWall movingWall
{ {
type mutWallFunction; type mutkWallFunction;
Cmu 0.09; Cmu 0.09;
kappa 0.41; kappa 0.41;
E 9.8; E 9.8;
@ -31,7 +31,7 @@ boundaryField
} }
fixedWalls fixedWalls
{ {
type mutWallFunction; type mutkWallFunction;
Cmu 0.09; Cmu 0.09;
kappa 0.41; kappa 0.41;
E 9.8; E 9.8;

View File

@ -23,25 +23,25 @@ boundaryField
{ {
front front
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
back back
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
wall wall
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
porosityWall porosityWall
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }

View File

@ -43,7 +43,7 @@ boundaryField
} }
prismWall prismWall
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
defaultFaces defaultFaces

View File

@ -23,17 +23,17 @@ boundaryField
{ {
floor floor
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
ceiling ceiling
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
fixedWalls fixedWalls
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
} }

View File

@ -23,17 +23,17 @@ boundaryField
{ {
floor floor
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
ceiling ceiling
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
fixedWalls fixedWalls
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
} }

View File

@ -23,25 +23,25 @@ boundaryField
{ {
ground ground
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
igloo_region0 igloo_region0
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
twoFridgeFreezers_seal_0 twoFridgeFreezers_seal_0
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
twoFridgeFreezers_herring_1 twoFridgeFreezers_herring_1
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
} }

View File

@ -23,17 +23,17 @@ boundaryField
{ {
floor floor
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
ceiling ceiling
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
fixedWalls fixedWalls
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
} }

View File

@ -23,7 +23,7 @@ boundaryField
{ {
floor floor
{ {
type mutWallFunction; type mutkWallFunction;
Cmu 0.09; Cmu 0.09;
kappa 0.41; kappa 0.41;
E 9.8; E 9.8;
@ -31,7 +31,7 @@ boundaryField
} }
ceiling ceiling
{ {
type mutWallFunction; type mutkWallFunction;
Cmu 0.09; Cmu 0.09;
kappa 0.41; kappa 0.41;
E 9.8; E 9.8;
@ -39,7 +39,7 @@ boundaryField
} }
fixedWalls fixedWalls
{ {
type mutWallFunction; type mutkWallFunction;
Cmu 0.09; Cmu 0.09;
kappa 0.41; kappa 0.41;
E 9.8; E 9.8;

View File

@ -23,22 +23,22 @@ boundaryField
{ {
box box
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
floor floor
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
ceiling ceiling
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
fixedWalls fixedWalls
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
} }

View File

@ -23,7 +23,7 @@ boundaryField
{ {
box box
{ {
type mutWallFunction; type mutkWallFunction;
Cmu 0.09; Cmu 0.09;
kappa 0.41; kappa 0.41;
E 9.8; E 9.8;
@ -31,7 +31,7 @@ boundaryField
} }
floor floor
{ {
type mutWallFunction; type mutkWallFunction;
Cmu 0.09; Cmu 0.09;
kappa 0.41; kappa 0.41;
E 9.8; E 9.8;
@ -39,7 +39,7 @@ boundaryField
} }
ceiling ceiling
{ {
type mutWallFunction; type mutkWallFunction;
Cmu 0.09; Cmu 0.09;
kappa 0.41; kappa 0.41;
E 9.8; E 9.8;
@ -47,7 +47,7 @@ boundaryField
} }
fixedWalls fixedWalls
{ {
type mutWallFunction; type mutkWallFunction;
Cmu 0.09; Cmu 0.09;
kappa 0.41; kappa 0.41;
E 9.8; E 9.8;

View File

@ -23,13 +23,13 @@ boundaryField
{ {
rotor rotor
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
stator stator
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }

View File

@ -23,12 +23,12 @@ boundaryField
{ {
lowerWall lowerWall
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
upperWall upperWall
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
frontBack frontBack

View File

@ -41,7 +41,7 @@ boundaryField
defaultFaces defaultFaces
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
} }

View File

@ -23,12 +23,12 @@ boundaryField
{ {
movingWall movingWall
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
fixedWalls fixedWalls
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
frontAndBack frontAndBack

View File

@ -34,7 +34,7 @@ boundaryField
wall wall
{ {
type nutSpalartAllmarasWallFunction; type nutUSpaldingWallFunction;
value uniform 0; value uniform 0;
} }

View File

@ -41,7 +41,7 @@ boundaryField
lowerWall lowerWall
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
@ -53,7 +53,7 @@ boundaryField
"motorBike_.*" "motorBike_.*"
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
} }

View File

@ -33,12 +33,12 @@ boundaryField
} }
upperWall upperWall
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
lowerWall lowerWall
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
frontAndBack frontAndBack

View File

@ -33,12 +33,12 @@ boundaryField
} }
upperWall upperWall
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
lowerWall lowerWall
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
frontAndBack frontAndBack

View File

@ -33,13 +33,13 @@ boundaryField
} }
innerWall innerWall
{ {
type nutWallFunction; type nutkWallFunction;
U Urel; U Urel;
value uniform 0; value uniform 0;
} }
outerWall outerWall
{ {
type nutWallFunction; type nutkWallFunction;
U Urel; U Urel;
value uniform 0; value uniform 0;
} }

View File

@ -23,17 +23,17 @@ boundaryField
{ {
top top
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
bottom bottom
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
walls walls
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
symmetry symmetry

View File

@ -23,7 +23,7 @@ boundaryField
{ {
walls walls
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
inlet inlet

View File

@ -23,7 +23,7 @@ boundaryField
{ {
walls walls
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
inlet inlet

View File

@ -23,17 +23,17 @@ boundaryField
{ {
top top
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
bottom bottom
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
walls walls
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
symmetry symmetry

View File

@ -33,7 +33,7 @@ boundaryField
} }
walls walls
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
frontBack frontBack

View File

@ -23,19 +23,19 @@ boundaryField
{ {
leftWall leftWall
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
rightWall rightWall
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }
lowerWall lowerWall
{ {
type mutWallFunction; type mutkWallFunction;
value uniform 0; value uniform 0;
} }

View File

@ -23,17 +23,17 @@ boundaryField
{ {
leftWall leftWall
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
rightWall rightWall
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
lowerWall lowerWall
{ {
type nutWallFunction; type nutkWallFunction;
value uniform 0; value uniform 0;
} }
atmosphere atmosphere