Renamed turbulenceProperties -> momentumTransport

Following the generalisation of the TurbulenceModels library to support
non-Newtonian laminar flow including visco-elasticity and extensible to other
form of non-Newtonian behaviour the name TurbulenceModels is misleading and does
not properly represent how general the OpenFOAM solvers now are.  The
TurbulenceModels now provides an interface to momentum transport modelling in
general and the plan is to rename it MomentumTransportModels and in preparation
for this the turbulenceProperties dictionary has been renamed momentumTransport
to properly reflect its new more general purpose.

The old turbulenceProperties name is supported for backward-compatibility.
This commit is contained in:
Henry Weller
2020-04-10 17:17:37 +01:00
parent b9c7428619
commit 7f5144312e
472 changed files with 2788 additions and 3219 deletions

View File

@ -1,10 +1,10 @@
Info<< "Reading turbulenceProperties\n" << endl;
Info<< "Reading momentumTransport\n" << endl;
IOdictionary turbulenceProperties
IOdictionary momentumTransport
(
IOobject
(
"turbulenceProperties",
"momentumTransport",
runTime.constant(),
mesh,
IOobject::MUST_READ_IF_MODIFIED,
@ -18,4 +18,4 @@
);
Kmesh K(mesh);
UOprocess forceGen(K, runTime.deltaTValue(), turbulenceProperties);
UOprocess forceGen(K, runTime.deltaTValue(), momentumTransport);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2018-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -52,7 +52,7 @@ Description
+ fluid: g
+ solid
+ materials
+ air: radiationProperties, thermophysicalProperties, turbulenceProperties
+ air: radiationProperties, thermophysicalProperties, momentumTransport
+ aluminium: radiationProperties, thermophysicalProperties
+ ...

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0;
format ascii;
class dictionary;
object turbulenceProperties;
object momentumTransport;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0;
format ascii;
class dictionary;
object turbulenceProperties;
object momentumTransport;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0;
format ascii;
class dictionary;
object turbulenceProperties;
object momentumTransport;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0;
format ascii;
class dictionary;
object turbulenceProperties;
object momentumTransport;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0;
format ascii;
class dictionary;
object turbulenceProperties;
object momentumTransport;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0;
format ascii;
class dictionary;
object turbulenceProperties;
object momentumTransport;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -0,0 +1,51 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
object momentumTransport;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType RAS;
RAS
{
RASModel kOmegaSST;
turbulence on;
printCoeffs on;
}
LES
{
LESModel SpalartAllmarasDDES;
delta cubeRootVol;
turbulence on;
printCoeffs on;
cubeRootVolCoeffs
{
deltaCoeff 1;
}
smoothCoeffs
{
delta cubeRootVol;
cubeRootVolCoeffs
{
deltaCoeff 1;
}
maxDeltaRatio 1.1;
}
}
// ************************************************************************* //

View File

@ -1,51 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
object turbulenceProperties;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType RAS;
RAS
{
RASModel kOmegaSST;
turbulence on;
printCoeffs on;
}
LES
{
LESModel SpalartAllmarasDDES;
delta cubeRootVol;
turbulence on;
printCoeffs on;
cubeRootVolCoeffs
{
deltaCoeff 1;
}
smoothCoeffs
{
delta cubeRootVol;
cubeRootVolCoeffs
{
deltaCoeff 1;
}
maxDeltaRatio 1.1;
}
}
// ************************************************************************* //

View File

@ -0,0 +1,51 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
object momentumTransport;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType RAS;
RAS
{
RASModel kOmegaSST;
turbulence on;
printCoeffs on;
}
LES
{
LESModel SpalartAllmarasDDES;
delta cubeRootVol;
turbulence on;
printCoeffs on;
cubeRootVolCoeffs
{
deltaCoeff 1;
}
smoothCoeffs
{
delta cubeRootVol;
cubeRootVolCoeffs
{
deltaCoeff 1;
}
maxDeltaRatio 1.1;
}
}
// ************************************************************************* //

View File

@ -1,51 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
object turbulenceProperties;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType RAS;
RAS
{
RASModel kOmegaSST;
turbulence on;
printCoeffs on;
}
LES
{
LESModel SpalartAllmarasDDES;
delta cubeRootVol;
turbulence on;
printCoeffs on;
cubeRootVolCoeffs
{
deltaCoeff 1;
}
smoothCoeffs
{
delta cubeRootVol;
cubeRootVolCoeffs
{
deltaCoeff 1;
}
maxDeltaRatio 1.1;
}
}
// ************************************************************************* //

View File

@ -72,7 +72,7 @@ protected:
public:
//- Runtime type information
TypeName("compressibleTurbulenceModel");
TypeName(turbulenceModel::typeName_());
// Constructors

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -115,7 +115,7 @@ void convectiveHeatTransferFvPatchScalarField::updateCoeffs()
(
IOobject::groupName
(
compressible::turbulenceModel::propertiesName,
compressible::turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2013-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2013-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -132,7 +132,7 @@ void Foam::externalCoupledTemperatureMixedFvPatchScalarField::transferData
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -85,7 +85,7 @@ Foam::tmp<Foam::scalarField> Foam::temperatureCoupledBase::kappa
const word turbulenceModelName
(
IOobject::groupName(turbulenceModel::propertiesName, phase)
IOobject::groupName(turbulenceModel::typeName, phase)
);
if (mesh.foundObject<turbulenceModel>(turbulenceModelName))

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -354,7 +354,7 @@ void thermalBaffle1DFvPatchScalarField<solidType>::updateCoeffs()
const compressible::turbulenceModel& turbModel =
db().template lookupObject<compressible::turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
);
// local properties

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -159,7 +159,7 @@ void Foam::totalFlowRateAdvectiveDiffusiveFvPatchScalarField::updateCoeffs()
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -165,7 +165,7 @@ void alphatJayatillekeWallFunctionFvPatchScalarField::updateCoeffs()
(
IOobject::groupName
(
compressible::turbulenceModel::propertiesName,
compressible::turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -112,7 +112,7 @@ void alphatWallFunctionFvPatchScalarField::updateCoeffs()
(
IOobject::groupName
(
compressibleTurbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -24,6 +24,9 @@ License
Typedef
Foam::compressible::turbulenceModel
Typedef
Foam::compressible::laminarModel
Typedef
Foam::compressible::RASModel

View File

@ -8,7 +8,4 @@ turbulentTransportModels/RAS/LienLeschziner/LienLeschziner.C
turbulentTransportModels/RAS/ShihQuadraticKE/ShihQuadraticKE.C
turbulentTransportModels/RAS/LienCubicKE/LienCubicKE.C
BCs = turbulentTransportModels/RAS/derivedFvPatchFields
turbulentTransportModels/derivedFvPatchFields/wallFunctions/alphatWallFunctions/alphatJayatillekeWallFunction/alphatJayatillekeWallFunctionFvPatchScalarField.C
LIB = $(FOAM_LIBBIN)/libincompressibleTurbulenceModels

View File

@ -72,7 +72,7 @@ protected:
public:
//- Runtime type information
TypeName("incompressibleTurbulenceModel");
TypeName(turbulenceModel::typeName_());
// Constructors

View File

@ -1,252 +0,0 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it
under the terms of the GNU General Public License as published by
the Free Software Foundation, either version 3 of the License, or
(at your option) any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
for more details.
You should have received a copy of the GNU General Public License
along with OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
\*---------------------------------------------------------------------------*/
#include "alphatJayatillekeWallFunctionFvPatchScalarField.H"
#include "turbulenceModel.H"
#include "addToRunTimeSelectionTable.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
namespace Foam
{
namespace incompressible
{
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
scalar alphatJayatillekeWallFunctionFvPatchScalarField::tolerance_ = 0.01;
label alphatJayatillekeWallFunctionFvPatchScalarField::maxIters_ = 10;
// * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * * //
scalar alphatJayatillekeWallFunctionFvPatchScalarField::Psmooth
(
const scalar Prat
) const
{
return 9.24*(pow(Prat, 0.75) - 1.0)*(1.0 + 0.28*exp(-0.007*Prat));
}
scalar alphatJayatillekeWallFunctionFvPatchScalarField::yPlusTherm
(
const nutWallFunctionFvPatchScalarField& nutw,
const scalar P,
const scalar Prat
) const
{
scalar ypt = 11.0;
for (int i=0; i<maxIters_; i++)
{
scalar f = ypt - (log(nutw.E()*ypt)/nutw.kappa() + P)/Prat;
scalar df = 1.0 - 1.0/(ypt*nutw.kappa()*Prat);
scalar yptNew = ypt - f/df;
if (yptNew < vSmall)
{
return 0;
}
else if (mag(yptNew - ypt) < tolerance_)
{
return yptNew;
}
else
{
ypt = yptNew;
}
}
return ypt;
}
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
alphatJayatillekeWallFunctionFvPatchScalarField::
alphatJayatillekeWallFunctionFvPatchScalarField
(
const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF
)
:
fixedValueFvPatchScalarField(p, iF),
Prt_(0.85)
{}
alphatJayatillekeWallFunctionFvPatchScalarField::
alphatJayatillekeWallFunctionFvPatchScalarField
(
const alphatJayatillekeWallFunctionFvPatchScalarField& ptf,
const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF,
const fvPatchFieldMapper& mapper
)
:
fixedValueFvPatchScalarField(ptf, p, iF, mapper),
Prt_(ptf.Prt_)
{}
alphatJayatillekeWallFunctionFvPatchScalarField::
alphatJayatillekeWallFunctionFvPatchScalarField
(
const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF,
const dictionary& dict
)
:
fixedValueFvPatchScalarField(p, iF, dict),
Prt_(dict.lookup<scalar>("Prt")) // force read to avoid ambiguity
{}
alphatJayatillekeWallFunctionFvPatchScalarField::
alphatJayatillekeWallFunctionFvPatchScalarField
(
const alphatJayatillekeWallFunctionFvPatchScalarField& wfpsf
)
:
fixedValueFvPatchScalarField(wfpsf),
Prt_(wfpsf.Prt_)
{}
alphatJayatillekeWallFunctionFvPatchScalarField::
alphatJayatillekeWallFunctionFvPatchScalarField
(
const alphatJayatillekeWallFunctionFvPatchScalarField& wfpsf,
const DimensionedField<scalar, volMesh>& iF
)
:
fixedValueFvPatchScalarField(wfpsf, iF),
Prt_(wfpsf.Prt_)
{}
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
void alphatJayatillekeWallFunctionFvPatchScalarField::updateCoeffs()
{
if (updated())
{
return;
}
const label patchi = patch().index();
// Retrieve turbulence properties from model
const turbulenceModel& turbModel = db().lookupObject<turbulenceModel>
(
IOobject::groupName
(
turbulenceModel::propertiesName,
internalField().group()
)
);
const nutWallFunctionFvPatchScalarField& nutw =
nutWallFunctionFvPatchScalarField::nutw(turbModel, patchi);
const scalar Cmu25 = pow(nutw.Cmu(), 0.25);
const scalarField& y = turbModel.y()[patchi];
const tmp<volScalarField> tnu = turbModel.nu();
const volScalarField& nu = tnu();
const scalarField& nuw = nu.boundaryField()[patchi];
const tmp<volScalarField> tk = turbModel.k();
const volScalarField& k = tk();
const IOdictionary& transportProperties =
db().lookupObject<IOdictionary>("transportProperties");
// Molecular Prandtl number
const scalar Pr
(
dimensionedScalar
(
"Pr",
dimless,
transportProperties.lookup("Pr")
).value()
);
// Populate boundary values
scalarField& alphatw = *this;
forAll(alphatw, facei)
{
const label celli = patch().faceCells()[facei];
const scalar yPlus = Cmu25*sqrt(k[celli])*y[facei]/nuw[facei];
// Molecular-to-turbulent Prandtl number ratio
const scalar Prat = Pr/Prt_;
// Thermal sublayer thickness
const scalar P = Psmooth(Prat);
const scalar yPlusTherm = this->yPlusTherm(nutw, P, Prat);
// Update turbulent thermal conductivity
if (yPlus > yPlusTherm)
{
const scalar nu = nuw[facei];
const scalar kt =
nu*(yPlus/(Prt_*(log(nutw.E()*yPlus)/nutw.kappa() + P)) - 1/Pr);
alphatw[facei] = max(0.0, kt);
}
else
{
alphatw[facei] = 0.0;
}
}
fixedValueFvPatchField<scalar>::updateCoeffs();
}
void alphatJayatillekeWallFunctionFvPatchScalarField::write(Ostream& os) const
{
fvPatchField<scalar>::write(os);
writeEntry(os, "Prt", Prt_);
writeEntry(os, "value", *this);
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
makePatchTypeField
(
fvPatchScalarField,
alphatJayatillekeWallFunctionFvPatchScalarField
);
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
} // End namespace incompressible
} // End namespace Foam
// ************************************************************************* //

View File

@ -1,210 +0,0 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
OpenFOAM is free software: you can redistribute it and/or modify it
under the terms of the GNU General Public License as published by
the Free Software Foundation, either version 3 of the License, or
(at your option) any later version.
OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
for more details.
You should have received a copy of the GNU General Public License
along with OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
Class
Foam::incompressible::alphatJayatillekeWallFunctionFvPatchScalarField
Description
This boundary condition provides a kinematic turbulent thermal conductivity
for using wall functions, using the Jayatilleke 'P' function.
Usage
\table
Property | Description | Required | Default value
Prt | turbulent Prandtl number | no | 0.85
Cmu | model coefficient | no | 0.09
kappa | Von Karman constant | no | 0.41
E | model coefficient | no | 9.8
\endtable
Example of the boundary condition specification:
\verbatim
<patchName>
{
type alphatJayatillekeWallFunction;
}
\endverbatim
Note
The units of kinematic turbulent thermal conductivity are [m^2/s]
See also
Foam::fixedValueFvPatchField
SourceFiles
alphatJayatillekeWallFunctionFvPatchScalarField.C
\*---------------------------------------------------------------------------*/
#ifndef alphatJayatillekeWallFunctionFvPatchScalarField_H
#define alphatJayatillekeWallFunctionFvPatchScalarField_H
#include "fixedValueFvPatchFields.H"
#include "nutWallFunctionFvPatchScalarField.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
namespace Foam
{
namespace incompressible
{
/*---------------------------------------------------------------------------*\
Class alphatJayatillekeWallFunctionFvPatchScalarField Declaration
\*---------------------------------------------------------------------------*/
class alphatJayatillekeWallFunctionFvPatchScalarField
:
public fixedValueFvPatchScalarField
{
protected:
// Protected data
//- Turbulent Prandtl number
scalar Prt_;
//- Cmu coefficient
scalar Cmu_;
//- Von Karman constant
scalar kappa_;
//- E coefficient
scalar E_;
// Solution parameters
static scalar tolerance_;
static label maxIters_;
// Protected member functions
//- `P' function
scalar Psmooth(const scalar Prat) const;
//- Calculate y+ at the edge of the thermal laminar sublayer
scalar yPlusTherm
(
const nutWallFunctionFvPatchScalarField& nutw,
const scalar P,
const scalar Prat
) const;
public:
//- Runtime type information
TypeName("alphatJayatillekeWallFunction");
// Constructors
//- Construct from patch and internal field
alphatJayatillekeWallFunctionFvPatchScalarField
(
const fvPatch&,
const DimensionedField<scalar, volMesh>&
);
//- Construct from patch, internal field and dictionary
alphatJayatillekeWallFunctionFvPatchScalarField
(
const fvPatch&,
const DimensionedField<scalar, volMesh>&,
const dictionary&
);
//- Construct by mapping given
// alphatJayatillekeWallFunctionFvPatchScalarField
// onto a new patch
alphatJayatillekeWallFunctionFvPatchScalarField
(
const alphatJayatillekeWallFunctionFvPatchScalarField&,
const fvPatch&,
const DimensionedField<scalar, volMesh>&,
const fvPatchFieldMapper&
);
//- Copy constructor
alphatJayatillekeWallFunctionFvPatchScalarField
(
const alphatJayatillekeWallFunctionFvPatchScalarField&
);
//- Construct and return a clone
virtual tmp<fvPatchScalarField> clone() const
{
return tmp<fvPatchScalarField>
(
new alphatJayatillekeWallFunctionFvPatchScalarField(*this)
);
}
//- Copy constructor setting internal field reference
alphatJayatillekeWallFunctionFvPatchScalarField
(
const alphatJayatillekeWallFunctionFvPatchScalarField&,
const DimensionedField<scalar, volMesh>&
);
//- Construct and return a clone setting internal field reference
virtual tmp<fvPatchScalarField> clone
(
const DimensionedField<scalar, volMesh>& iF
) const
{
return tmp<fvPatchScalarField>
(
new alphatJayatillekeWallFunctionFvPatchScalarField(*this, iF)
);
}
// Member Functions
// Evaluation functions
//- Update the coefficients associated with the patch field
virtual void updateCoeffs();
// I-O
//- Write
virtual void write(Ostream&) const;
};
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
} // End namespace incompressible
} // End namespace Foam
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
#endif
// ************************************************************************* //

View File

@ -141,7 +141,7 @@ NicenoKEqn<BasicTurbulenceModel>::gasTurbulence() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
gas.name()
)
);

View File

@ -117,7 +117,7 @@ SmagorinskyZhang<BasicTurbulenceModel>::gasTurbulence() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
gas.name()
)
);

View File

@ -113,7 +113,7 @@ continuousGasKEqn<BasicTurbulenceModel>::liquidTurbulence() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
liquid.name()
)
);

View File

@ -152,7 +152,7 @@ LaheyKEpsilon<BasicTurbulenceModel>::gasTurbulence() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
gas.name()
)
);

View File

@ -160,7 +160,7 @@ continuousGasKEpsilon<BasicTurbulenceModel>::liquidTurbulence() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
liquid.name()
)
);

View File

@ -369,7 +369,7 @@ mixtureKEpsilon<BasicTurbulenceModel>::liquidTurbulence() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
liquid.name()
)
)

View File

@ -130,20 +130,12 @@ Foam::LESModel<BasicTurbulenceModel>::New
const transportModel& transport
)
{
IOdictionary modelDict
const IOdictionary modelDict
(
IOobject
turbulenceModel::readModelDict
(
IOobject::groupName
(
turbulenceModel::propertiesName,
alphaRhoPhi.group()
),
U.time().constant(),
U.db(),
IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE,
false
alphaRhoPhi.group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -32,7 +32,7 @@ Description
delta = min(geometricDelta, (kappa/Cdelta)*y)
\endverbatim
Example specification in the turbulenceProperties dictionary:
Example specification in the momentumTransport dictionary:
\verbatim
delta Prandtl;

View File

@ -120,20 +120,12 @@ Foam::RASModel<BasicTurbulenceModel>::New
const transportModel& transport
)
{
IOdictionary modelDict
const IOdictionary modelDict
(
IOobject
turbulenceModel::readModelDict
(
IOobject::groupName
(
turbulenceModel::propertiesName,
alphaRhoPhi.group()
),
U.time().constant(),
U.db(),
IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE,
false
alphaRhoPhi.group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -130,7 +130,7 @@ void turbulentMixingLengthDissipationRateInletFvPatchScalarField::updateCoeffs()
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -126,7 +126,7 @@ void turbulentMixingLengthFrequencyInletFvPatchScalarField::updateCoeffs()
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -82,25 +82,12 @@ Foam::TurbulenceModel<Alpha, Rho, BasicTurbulenceModel, TransportModel>::New
const transportModel& transport
)
{
// get model name, but do not register the dictionary
// otherwise it is registered in the database twice
const word modelType
(
IOdictionary
turbulenceModel::readModelDict
(
IOobject
(
IOobject::groupName
(
turbulenceModel::propertiesName,
alphaRhoPhi.group()
),
U.time().constant(),
U.db(),
IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE,
false
)
U.db(),
alphaRhoPhi.group()
).lookup("simulationType")
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -104,7 +104,7 @@ void Foam::fixedShearStressFvPatchVectorField::updateCoeffs()
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -140,7 +140,7 @@ void Foam::porousBafflePressureFvPatchField::updateCoeffs()
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -365,7 +365,7 @@ void Foam::epsilonWallFunctionFvPatchScalarField::updateCoeffs()
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);
@ -417,7 +417,7 @@ void Foam::epsilonWallFunctionFvPatchScalarField::updateWeightedCoeffs
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2012-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2012-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -105,7 +105,7 @@ void fWallFunctionFvPatchScalarField::updateCoeffs()
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2012-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2012-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -107,7 +107,7 @@ void kLowReWallFunctionFvPatchScalarField::updateCoeffs()
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -105,7 +105,7 @@ tmp<scalarField> nutLowReWallFunctionFvPatchScalarField::yPlus() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -44,7 +44,7 @@ tmp<scalarField> nutURoughWallFunctionFvPatchScalarField::nut() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);
@ -90,7 +90,7 @@ tmp<scalarField> nutURoughWallFunctionFvPatchScalarField::yPlus
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -44,7 +44,7 @@ tmp<scalarField> nutUSpaldingWallFunctionFvPatchScalarField::nut() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);
@ -72,7 +72,7 @@ tmp<scalarField> nutUSpaldingWallFunctionFvPatchScalarField::calcUTau
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);
@ -196,7 +196,7 @@ tmp<scalarField> nutUSpaldingWallFunctionFvPatchScalarField::yPlus() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -44,7 +44,7 @@ tmp<scalarField> nutUTabulatedWallFunctionFvPatchScalarField::nut() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);
@ -186,7 +186,7 @@ tmp<scalarField> nutUTabulatedWallFunctionFvPatchScalarField::yPlus() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -44,7 +44,7 @@ tmp<scalarField> nutUWallFunctionFvPatchScalarField::nut() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);
@ -83,7 +83,7 @@ tmp<scalarField> nutUWallFunctionFvPatchScalarField::yPlus
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);
@ -186,7 +186,7 @@ tmp<scalarField> nutUWallFunctionFvPatchScalarField::yPlus() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -74,7 +74,7 @@ tmp<scalarField> nutkRoughWallFunctionFvPatchScalarField::nut() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -45,7 +45,7 @@ tmp<scalarField> nutkWallFunctionFvPatchScalarField::nut() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);
@ -141,7 +141,7 @@ tmp<scalarField> nutkWallFunctionFvPatchScalarField::yPlus() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -409,7 +409,7 @@ void omegaWallFunctionFvPatchScalarField::updateCoeffs()
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);
@ -459,7 +459,7 @@ void omegaWallFunctionFvPatchScalarField::updateWeightedCoeffs
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2012-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2012-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -104,7 +104,7 @@ void v2WallFunctionFvPatchScalarField::updateCoeffs()
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -104,7 +104,7 @@ public:
//- Const access to the coefficients dictionary
virtual const dictionary& coeffDict() const;
//- Read turbulenceProperties dictionary
//- Read momentumTransport dictionary
virtual bool read();
//- Return the turbulence viscosity, i.e. 0 for Stokes flow

View File

@ -118,7 +118,7 @@ public:
// Member Functions
//- Read turbulenceProperties dictionary
//- Read momentumTransport dictionary
virtual bool read();
//- Return the turbulence viscosity,

View File

@ -87,20 +87,12 @@ Foam::laminarModel<BasicTurbulenceModel>::New
const transportModel& transport
)
{
IOdictionary modelDict
const IOdictionary modelDict
(
IOobject
turbulenceModel::readModelDict
(
IOobject::groupName
(
turbulenceModel::propertiesName,
alphaRhoPhi.group()
),
U.time().constant(),
U.db(),
IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE,
false
alphaRhoPhi.group()
)
);

View File

@ -35,7 +35,52 @@ namespace Foam
defineTypeNameAndDebug(turbulenceModel, 0);
}
const Foam::word Foam::turbulenceModel::propertiesName("turbulenceProperties");
// * * * * * * * * * * * * * Protected Member Functions * * * * * * * * * * //
Foam::IOdictionary Foam::turbulenceModel::readModelDict
(
const objectRegistry& obr,
const word& group,
bool registerObject
)
{
IOobject momentumTransport
(
IOobject::groupName(typeName, group),
obr.time().constant(),
obr,
IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE,
registerObject
);
if (momentumTransport.typeHeaderOk<IOdictionary>(true))
{
return momentumTransport;
}
else
{
IOobject momentumTransport
(
IOobject::groupName("momentumTransport", group),
obr.time().constant(),
obr,
IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE,
registerObject
);
if (momentumTransport.typeHeaderOk<IOdictionary>(true))
{
return momentumTransport;
}
else
{
return momentumTransport;
}
}
}
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
@ -47,17 +92,7 @@ Foam::turbulenceModel::turbulenceModel
const surfaceScalarField& phi
)
:
IOdictionary
(
IOobject
(
IOobject::groupName(propertiesName, alphaRhoPhi.group()),
U.time().constant(),
U.db(),
IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE
)
),
IOdictionary(readModelDict(U.db(), alphaRhoPhi.group(), true)),
runTime_(U.time()),
mesh_(U.mesh()),
@ -66,7 +101,10 @@ Foam::turbulenceModel::turbulenceModel
alphaRhoPhi_(alphaRhoPhi),
phi_(phi),
y_(mesh_)
{}
{
// Ensure name of IOdictionary is typeName
rename(IOobject::groupName(typeName, alphaRhoPhi.group()));
}
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //

View File

@ -74,13 +74,20 @@ protected:
nearWallDist y_;
// Protected member functions
static IOdictionary readModelDict
(
const objectRegistry& obr,
const word& group,
bool registerObject = false
);
public:
//- Runtime type information
TypeName("turbulenceModel");
//- Default name of the turbulence properties dictionary
static const word propertiesName;
TypeName("momentumTransport");
// Constructors

View File

@ -44,7 +44,7 @@ tmp<scalarField> nutkAtmRoughWallFunctionFvPatchScalarField::nut() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -174,7 +174,7 @@ void FSD<ReactionThermo, ThermoType>::calculateSourceNorm()
const compressible::LESModel& lesModel =
YO2.db().lookupObject<compressible::LESModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
);
const volScalarField& delta = lesModel.delta();

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2013-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2013-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -56,7 +56,7 @@ bool Foam::functionObjects::PecletNo::calc()
(
mesh_.lookupObject<turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
).nuEff()
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2018-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2018-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -175,7 +175,7 @@ bool Foam::functionObjects::age::execute()
tmuEff =
mesh_.lookupObject<turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
).muEff();
laplacianScheme =
@ -212,7 +212,7 @@ bool Foam::functionObjects::age::execute()
tnuEff =
mesh_.lookupObject<turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
).nuEff();
laplacianScheme =

View File

@ -91,7 +91,7 @@ bool Foam::functionObjects::shearStress::execute()
const word turbulenceModelName
(
IOobject::groupName(turbulenceModel::propertiesName, phaseName_)
IOobject::groupName(turbulenceModel::typeName, phaseName_)
);
if (mesh_.foundObject<cmpModel>(turbulenceModelName))

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2013-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -118,7 +118,7 @@ Foam::functionObjects::turbulenceFields::~turbulenceFields()
const Foam::word& Foam::functionObjects::turbulenceFields::modelName()
{
return Foam::turbulenceModel::propertiesName;
return Foam::turbulenceModel::typeName;
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2018-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -96,11 +96,11 @@ bool Foam::functionObjects::turbulenceIntensity::read(const dictionary& dict)
bool Foam::functionObjects::turbulenceIntensity::execute()
{
if (mesh_.foundObject<turbulenceModel>(turbulenceModel::propertiesName))
if (mesh_.foundObject<turbulenceModel>(turbulenceModel::typeName))
{
const turbulenceModel& turbModel = mesh_.lookupObject<turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
);
volScalarField uPrime(sqrt((2.0/3.0)*turbModel.k()));

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2016-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2016-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -204,14 +204,14 @@ bool Foam::functionObjects::wallHeatFlux::execute()
(
foundObject<compressible::turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
)
)
{
const compressible::turbulenceModel& turbModel =
lookupObject<compressible::turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
);
return store

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2017-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2017-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -200,14 +200,14 @@ bool Foam::functionObjects::wallHeatTransferCoeff::execute()
(
foundObject<incompressible::turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
)
)
{
const incompressible::turbulenceModel& turbModel =
lookupObject<incompressible::turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
);
return store

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2013-2018 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2013-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -181,17 +181,17 @@ bool Foam::functionObjects::wallShearStress::execute()
typedef incompressible::turbulenceModel icoModel;
tmp<volSymmTensorField> Reff;
if (mesh_.foundObject<cmpModel>(turbulenceModel::propertiesName))
if (mesh_.foundObject<cmpModel>(turbulenceModel::typeName))
{
const cmpModel& model =
mesh_.lookupObject<cmpModel>(turbulenceModel::propertiesName);
mesh_.lookupObject<cmpModel>(turbulenceModel::typeName);
Reff = model.devRhoReff();
}
else if (mesh_.foundObject<icoModel>(turbulenceModel::propertiesName))
else if (mesh_.foundObject<icoModel>(turbulenceModel::typeName))
{
const icoModel& model =
mesh_.lookupObject<icoModel>(turbulenceModel::propertiesName);
mesh_.lookupObject<icoModel>(turbulenceModel::typeName);
Reff = model.devReff();
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2013-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2013-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -163,12 +163,12 @@ bool Foam::functionObjects::yPlus::execute()
{
if (mesh_.foundObject<turbulenceModel>
(
IOobject::groupName(turbulenceModel::propertiesName, phaseName_))
IOobject::groupName(turbulenceModel::typeName, phaseName_))
)
{
const turbulenceModel& model = mesh_.lookupObject<turbulenceModel>
(
IOobject::groupName(turbulenceModel::propertiesName, phaseName_)
IOobject::groupName(turbulenceModel::typeName, phaseName_)
);
word name(IOobject::groupName(type(), phaseName_));

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -221,17 +221,17 @@ Foam::functionObjects::forces::devRhoReff() const
typedef compressible::turbulenceModel cmpTurbModel;
typedef incompressible::turbulenceModel icoTurbModel;
if (obr_.foundObject<cmpTurbModel>(cmpTurbModel::propertiesName))
if (obr_.foundObject<cmpTurbModel>(turbulenceModel::typeName))
{
const cmpTurbModel& turb =
obr_.lookupObject<cmpTurbModel>(cmpTurbModel::propertiesName);
obr_.lookupObject<cmpTurbModel>(turbulenceModel::typeName);
return turb.devRhoReff();
}
else if (obr_.foundObject<icoTurbModel>(icoTurbModel::propertiesName))
else if (obr_.foundObject<icoTurbModel>(turbulenceModel::typeName))
{
const incompressible::turbulenceModel& turb =
obr_.lookupObject<icoTurbModel>(icoTurbModel::propertiesName);
obr_.lookupObject<icoTurbModel>(turbulenceModel::typeName);
return rho()*turb.devReff();
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2019-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -247,7 +247,7 @@ Foam::functionObjects::phaseScalarTransport::D
);
}
const word& nameNoPhase = turbulenceModel::propertiesName;
const word& nameNoPhase = turbulenceModel::typeName;
const word namePhase = IOobject::groupName(nameNoPhase, phaseName_);
const word& name =

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2012-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2012-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -72,20 +72,20 @@ Foam::tmp<Foam::volScalarField> Foam::functionObjects::scalarTransport::D
dimensionedScalar(Dname, phi.dimensions()/dimLength, D_)
);
}
else if (mesh_.foundObject<icoModel>(turbulenceModel::propertiesName))
else if (mesh_.foundObject<icoModel>(turbulenceModel::typeName))
{
const icoModel& model = mesh_.lookupObject<icoModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
);
return alphaD_*model.nu() + alphaDt_*model.nut();
}
else if (mesh_.foundObject<cmpModel>(turbulenceModel::propertiesName))
else if (mesh_.foundObject<cmpModel>(turbulenceModel::typeName))
{
const cmpModel& model = mesh_.lookupObject<cmpModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
);
return alphaD_*model.mu() + alphaDt_*model.mut();

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2019-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -90,7 +90,7 @@ Foam::tmp<Foam::volScalarField> Foam::fv::volumeFractionSource::D
const turbulenceModel& turbulence =
mesh().lookupObject<turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
);
return turbulence.nuEff();
@ -100,7 +100,7 @@ Foam::tmp<Foam::volScalarField> Foam::fv::volumeFractionSource::D
const compressible::turbulenceModel& turbulence =
mesh().lookupObject<compressible::turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
);
return

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -105,7 +105,7 @@ void Foam::fv::variableHeatTransfer::calculateHtc()
const compressible::turbulenceModel& nbrTurb =
nbrMesh.lookupObject<compressible::turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
);
const fluidThermo& nbrThermo =

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -37,7 +37,7 @@ Foam::DispersionRASModel<CloudType>::kModel() const
const word turbName =
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
this->owner().U().group()
);
@ -67,7 +67,7 @@ Foam::DispersionRASModel<CloudType>::epsilonModel() const
const word turbName =
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
this->owner().U().group()
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -60,7 +60,7 @@ Foam::BrownianMotionForce<CloudType>::kModel() const
const word turbName =
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
this->owner().U().group()
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2011-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -167,7 +167,7 @@ void alphatFilmWallFunctionFvPatchScalarField::updateCoeffs()
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -80,7 +80,7 @@ tmp<scalarField> nutkFilmWallFunctionFvPatchScalarField::calcUTau
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);
@ -131,7 +131,7 @@ tmp<scalarField> nutkFilmWallFunctionFvPatchScalarField::nut() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);
@ -223,7 +223,7 @@ tmp<scalarField> nutkFilmWallFunctionFvPatchScalarField::yPlus() const
(
IOobject::groupName
(
turbulenceModel::propertiesName,
turbulenceModel::typeName,
internalField().group()
)
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2019-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -112,7 +112,7 @@ Foam::adsorptionMassFractionFvPatchScalarField::calcPhiYp() const
const compressible::turbulenceModel& turb =
db().lookupObject<compressible::turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
);
const scalarField alphaEffDeltap
(

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2017-2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2017-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -127,7 +127,7 @@ Foam::semiPermeableBaffleMassFractionFvPatchScalarField::calcPhiYp() const
const compressible::turbulenceModel& turb =
db().lookupObject<compressible::turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
);
const scalarField alphaEffDeltap
(

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2019-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -255,7 +255,7 @@ void Foam::specieTransferMassFractionFvPatchScalarField::updateCoeffs()
patch().magSf()
*db().lookupObject<compressible::turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
)
.alphaEff(patch().index())
);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Copyright (C) 2019 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2019-2020 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -168,7 +168,7 @@ void Foam::specieTransferTemperatureFvPatchScalarField::updateCoeffs()
patch().magSf()
*db().lookupObject<compressible::turbulenceModel>
(
turbulenceModel::propertiesName
turbulenceModel::typeName
).alphaEff(patch().index())
);

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.air1;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.air2;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.air3;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.water;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.air1;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.air2;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.air3;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.water;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -1,20 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object turbulenceProperties.air3;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.air1;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.air2;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.air3;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.water;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -1,20 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object turbulenceProperties.air1;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -1,20 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object turbulenceProperties.air2;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -1,20 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object turbulenceProperties.air3;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.air1;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.air2;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.air3;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

View File

@ -0,0 +1,20 @@
/*--------------------------------*- C++ -*----------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | Website: https://openfoam.org
\\ / A nd | Version: dev
\\/ M anipulation |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class dictionary;
location "constant";
object momentumTransport.water;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
simulationType laminar;
// ************************************************************************* //

Some files were not shown because too many files have changed in this diff Show More