Merge branch 'master' into cvm

This commit is contained in:
graham
2010-12-13 14:40:52 +00:00
48 changed files with 387 additions and 84 deletions

View File

@ -157,7 +157,7 @@ int main(int argc, char *argv[])
+ aphiv_neg*(rho_neg*(e_neg + 0.5*magSqr(U_neg)) + p_neg)
+ aSf*p_pos - aSf*p_neg;
volTensorField tauMC("tauMC", mu*dev2(fvc::grad(U)().T()));
volTensorField tauMC("tauMC", mu*dev2(Foam::T(fvc::grad(U))));
// --- Solve density
Info<< max(rho) << " " << min(rho) << endl;

View File

@ -139,7 +139,7 @@ int main(int argc, char *argv[])
+ aphiv_neg*(rho_neg*(e_neg + 0.5*magSqr(U_neg)) + p_neg)
+ aSf*p_pos - aSf*p_neg;
volTensorField tauMC("tauMC", mu*dev2(fvc::grad(U)().T()));
volTensorField tauMC("tauMC", mu*dev2(Foam::T(fvc::grad(U))));
// --- Solve density
solve(fvm::ddt(rho) + fvc::div(phi));

View File

@ -259,7 +259,8 @@ unset MPI_ARCH_PATH MPI_HOME
case "$WM_MPLIB" in
OPENMPI)
mpi_version=openmpi-1.4.1
#mpi_version=openmpi-1.4.1
mpi_version=openmpi-1.5
export MPI_ARCH_PATH=$WM_THIRD_PARTY_DIR/platforms/$WM_ARCH$WM_COMPILER/$mpi_version
# Tell OpenMPI where to find its install directory

View File

@ -36,6 +36,7 @@ namespace Foam
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
UNARY_FUNCTION(tensor, tensor, T, transform)
UNARY_FUNCTION(scalar, tensor, tr, transform)
UNARY_FUNCTION(sphericalTensor, tensor, sph, transform)
UNARY_FUNCTION(symmTensor, tensor, symm, transform)

View File

@ -49,6 +49,7 @@ namespace Foam
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
UNARY_FUNCTION(tensor, tensor, T, transform)
UNARY_FUNCTION(scalar, tensor, tr, transform)
UNARY_FUNCTION(sphericalTensor, tensor, sph, transform)
UNARY_FUNCTION(symmTensor, tensor, symm, transform)

View File

@ -736,7 +736,7 @@ Foam::argList::argList
{
Info<< "Slaves : " << slaveProcs << nl;
if (roots.size())
{
{
Info<< "Roots : " << roots << nl;
}
Info<< "Pstream initialized with:" << nl
@ -770,7 +770,8 @@ Foam::argList::argList
if (bannerEnabled)
{
Info<< "Monitoring run-time modified files using "
Info<< "fileModificationChecking : "
<< "Monitoring run-time modified files using "
<< regIOobject::fileCheckTypesNames
[
regIOobject::fileModificationChecking

View File

@ -2,5 +2,6 @@ LESdelta/LESdelta.C
cubeRootVolDelta/cubeRootVolDelta.C
PrandtlDelta/PrandtlDelta.C
smoothDelta/smoothDelta.C
maxhxhyhzDelta/maxhxhyhzDelta.C
LIB = $(FOAM_LIBBIN)/libLESdeltas

View File

@ -0,0 +1,142 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2010-2010 OpenCFD Ltd.
\\/ 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 "maxhxhyhzDelta.H"
#include "addToRunTimeSelectionTable.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
namespace Foam
{
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
defineTypeNameAndDebug(maxhxhyhzDelta, 0);
addToRunTimeSelectionTable(LESdelta, maxhxhyhzDelta, dictionary);
// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * //
void maxhxhyhzDelta::calcDelta()
{
label nD = mesh().nGeometricD();
tmp<volScalarField> hmax
(
new volScalarField
(
IOobject
(
"hmax",
mesh().time().timeName(),
mesh(),
IOobject::NO_READ,
IOobject::NO_WRITE
),
mesh(),
dimensionedScalar("zrero", dimLength, 0.0)
)
);
const cellList& cells = mesh().cells();
forAll(cells,cellI)
{
scalar deltaMaxTmp = 0.0;
const labelList& cFaces = mesh().cells()[cellI];
const point& centrevector = mesh().cellCentres()[cellI];
forAll(cFaces, cFaceI)
{
label faceI = cFaces[cFaceI];
const point& facevector = mesh().faceCentres()[faceI];
scalar tmp = mag(facevector - centrevector);
if (tmp > deltaMaxTmp)
{
deltaMaxTmp = tmp;
}
}
hmax()[cellI] = deltaCoeff_*deltaMaxTmp;
}
if (nD == 3)
{
delta_.internalField() = hmax();
}
else if (nD == 2)
{
WarningIn("maxhxhyhzDelta::calcDelta()")
<< "Case is 2D, LES is not strictly applicable\n"
<< endl;
delta_.internalField() = hmax();
}
else
{
FatalErrorIn("maxhxhyhzDelta::calcDelta()")
<< "Case is not 3D or 2D, LES is not applicable"
<< exit(FatalError);
}
}
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
maxhxhyhzDelta::maxhxhyhzDelta
(
const word& name,
const fvMesh& mesh,
const dictionary& dd
)
:
LESdelta(name, mesh),
deltaCoeff_(readScalar(dd.subDict(type() + "Coeffs").lookup("deltaCoeff")))
{
calcDelta();
}
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
void maxhxhyhzDelta::read(const dictionary& dd)
{
dd.subDict(type() + "Coeffs").lookup("deltaCoeff") >> deltaCoeff_;
calcDelta();
}
void maxhxhyhzDelta::correct()
{
if (mesh_.changing())
{
calcDelta();
}
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
} // End namespace Foam
// ************************************************************************* //

View File

@ -0,0 +1,111 @@
/*---------------------------------------------------------------------------*\
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2010-2010 OpenCFD Ltd.
\\/ 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::maxhxhyhzDelta
Description
maxhxhyhzDelta takes the maximum of the three dimensions per cell:
max(hx, hy, hz). Valid for structures hexahedral cells only.
SourceFiles
maxhxhyhzDelta.C
\*---------------------------------------------------------------------------*/
#ifndef maxhxhyhzDeltaDelta_H
#define maxhxhyhzDeltaDelta_H
#include "LESdelta.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
namespace Foam
{
/*---------------------------------------------------------------------------*\
Class maxhxhyhzDelta Declaration
\*---------------------------------------------------------------------------*/
class maxhxhyhzDelta
:
public LESdelta
{
// Private data
scalar deltaCoeff_; //
// Private Member Functions
//- Disallow default bitwise copy construct and assignment
maxhxhyhzDelta(const maxhxhyhzDelta&);
void operator=(const maxhxhyhzDelta&);
// Calculate the delta values
void calcDelta();
public:
//- Runtime type information
TypeName("maxhxhyhzDelta");
// Constructors
//- Construct from name, mesh and IOdictionary
maxhxhyhzDelta
(
const word& name,
const fvMesh& mesh,
const dictionary&
);
//- Destructor
virtual ~maxhxhyhzDelta()
{}
// Member Functions
//- Read the LESdelta dictionary
virtual void read(const dictionary&);
// Correct values
virtual void correct();
};
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
} // End namespace Foam
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
#endif
// ************************************************************************* //

View File

@ -134,7 +134,7 @@ tmp<fvVectorMatrix> GenEddyVisc::divDevRhoBeff(volVectorField& U) const
{
return
(
- fvm::laplacian(muEff(), U) - fvc::div(muEff()*dev2(fvc::grad(U)().T()))
- fvm::laplacian(muEff(), U) - fvc::div(muEff()*dev2(T(fvc::grad(U))))
);
}

View File

@ -143,7 +143,7 @@ tmp<fvVectorMatrix> GenSGSStress::divDevRhoBeff(volVectorField& U) const
fvc::div(rho()*B_ + 0.05*muSgs_*fvc::grad(U))
+ fvc::laplacian(0.95*muSgs_, U, "laplacian(muEff,U)")
- fvm::laplacian(muEff(), U)
- fvc::div(mu()*dev2(fvc::grad(U)().T()))
- fvc::div(mu()*dev2(T(fvc::grad(U))))
);
}

View File

@ -285,7 +285,7 @@ tmp<fvVectorMatrix> SpalartAllmaras::divDevRhoBeff(volVectorField& U) const
{
return
(
- fvm::laplacian(muEff(), U) - fvc::div(muEff()*dev2(fvc::grad(U)().T()))
- fvm::laplacian(muEff(), U) - fvc::div(muEff()*dev2(T(fvc::grad(U))))
);
}

View File

@ -274,7 +274,7 @@ tmp<fvVectorMatrix> LRR::divDevRhoReff(volVectorField& U) const
fvc::div(rho_*R_ + couplingFactor_*mut_*fvc::grad(U))
+ fvc::laplacian((1.0 - couplingFactor_)*mut_, U)
- fvm::laplacian(muEff(), U)
- fvc::div(mu()*dev2(fvc::grad(U)().T()))
- fvc::div(mu()*dev2(T(fvc::grad(U))))
);
}
else
@ -284,7 +284,7 @@ tmp<fvVectorMatrix> LRR::divDevRhoReff(volVectorField& U) const
fvc::div(rho_*R_)
+ fvc::laplacian(mut_, U)
- fvm::laplacian(muEff(), U)
- fvc::div(mu()*dev2(fvc::grad(U)().T()))
- fvc::div(mu()*dev2(T(fvc::grad(U))))
);
}
}

View File

@ -303,7 +303,7 @@ tmp<fvVectorMatrix> LaunderGibsonRSTM::divDevRhoReff(volVectorField& U) const
fvc::div(rho_*R_ + couplingFactor_*mut_*fvc::grad(U))
+ fvc::laplacian((1.0 - couplingFactor_)*mut_, U)
- fvm::laplacian(muEff(), U)
- fvc::div(mu()*dev2(fvc::grad(U)().T()))
- fvc::div(mu()*dev2(T(fvc::grad(U))))
);
}
else
@ -313,7 +313,7 @@ tmp<fvVectorMatrix> LaunderGibsonRSTM::divDevRhoReff(volVectorField& U) const
fvc::div(rho_*R_)
+ fvc::laplacian(mut_, U)
- fvm::laplacian(muEff(), U)
- fvc::div(mu()*dev2(fvc::grad(U)().T()))
- fvc::div(mu()*dev2(T(fvc::grad(U))))
);
}
}

View File

@ -248,7 +248,7 @@ tmp<fvVectorMatrix> LaunderSharmaKE::divDevRhoReff(volVectorField& U) const
{
return
(
- fvm::laplacian(muEff(), U) - fvc::div(muEff()*dev2(fvc::grad(U)().T()))
- fvm::laplacian(muEff(), U) - fvc::div(muEff()*dev2(T(fvc::grad(U))))
);
}

View File

@ -247,7 +247,7 @@ tmp<fvVectorMatrix> RNGkEpsilon::divDevRhoReff(volVectorField& U) const
{
return
(
- fvm::laplacian(muEff(), U) - fvc::div(muEff()*dev2(fvc::grad(U)().T()))
- fvm::laplacian(muEff(), U) - fvc::div(muEff()*dev2(T(fvc::grad(U))))
);
}

View File

@ -345,7 +345,7 @@ tmp<fvVectorMatrix> SpalartAllmaras::divDevRhoReff(volVectorField& U) const
return
(
- fvm::laplacian(muEff_, U)
- fvc::div(muEff_*dev2(fvc::grad(U)().T()))
- fvc::div(muEff_*dev2(T(fvc::grad(U))))
);
}

View File

@ -230,7 +230,7 @@ tmp<fvVectorMatrix> kEpsilon::divDevRhoReff(volVectorField& U) const
return
(
- fvm::laplacian(muEff(), U)
- fvc::div(muEff()*dev2(fvc::grad(U)().T()))
- fvc::div(muEff()*dev2(T(fvc::grad(U))))
);
}

View File

@ -327,7 +327,7 @@ tmp<fvVectorMatrix> kOmegaSST::divDevRhoReff(volVectorField& U) const
{
return
(
- fvm::laplacian(muEff(), U) - fvc::div(muEff()*dev2(fvc::grad(U)().T()))
- fvm::laplacian(muEff(), U) - fvc::div(muEff()*dev2(T(fvc::grad(U))))
);
}

View File

@ -194,7 +194,7 @@ tmp<fvVectorMatrix> laminar::divDevRhoReff(volVectorField& U) const
return
(
- fvm::laplacian(muEff(), U)
- fvc::div(muEff()*dev2(fvc::grad(U)().T()))
- fvc::div(muEff()*dev2(T(fvc::grad(U))))
);
}

View File

@ -261,7 +261,7 @@ tmp<fvVectorMatrix> realizableKE::divDevRhoReff(volVectorField& U) const
{
return
(
- fvm::laplacian(muEff(), U) - fvc::div(muEff()*dev2(fvc::grad(U)().T()))
- fvm::laplacian(muEff(), U) - fvc::div(muEff()*dev2(T(fvc::grad(U))))
);
}

View File

@ -215,7 +215,7 @@ tmp<fvVectorMatrix> laminar::divDevRhoReff(volVectorField& U) const
return
(
- fvm::laplacian(muEff(), U)
- fvc::div(muEff()*dev2(fvc::grad(U)().T()))
- fvc::div(muEff()*dev2(T(fvc::grad(U))))
);
}

View File

@ -97,7 +97,7 @@ tmp<fvVectorMatrix> GenEddyVisc::divDevBeff(volVectorField& U) const
{
return
(
- fvm::laplacian(nuEff(), U) - fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvm::laplacian(nuEff(), U) - fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -182,7 +182,7 @@ public:
}
//- Access function to filter width
inline const volScalarField& delta() const
virtual const volScalarField& delta() const
{
return delta_();
}

View File

@ -96,7 +96,7 @@ tmp<fvVectorMatrix> Smagorinsky2::divDevBeff
return
(
- fvm::laplacian(aniNuEff, U) - fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvm::laplacian(aniNuEff, U) - fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -349,7 +349,7 @@ tmp<fvVectorMatrix> SpalartAllmaras::divDevBeff(volVectorField& U) const
{
return
(
- fvm::laplacian(nuEff(), U) - fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvm::laplacian(nuEff(), U) - fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -25,6 +25,7 @@ License
#include "IDDESDelta.H"
#include "addToRunTimeSelectionTable.H"
#include "wallDistReflection.H"
#include "wallDist.H"
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
@ -42,25 +43,50 @@ void Foam::IDDESDelta::calcDelta()
{
label nD = mesh().nGeometricD();
volScalarField delta
const volScalarField& hmax = hmax_();
// initialise wallNorm
wallDistReflection wallNorm(mesh());
const volVectorField& n = wallNorm.n();
tmp<volScalarField> faceToFacenMax
(
IOobject
new volScalarField
(
"delta",
mesh_.time().timeName(),
mesh_,
IOobject::NO_READ,
IOobject::NO_WRITE
),
mesh_,
dimensionedScalar("zero", dimLength, SMALL),
calculatedFvPatchScalarField::typeName
IOobject
(
"faceToFaceMax",
mesh().time().timeName(),
mesh(),
IOobject::NO_READ,
IOobject::NO_WRITE
),
mesh(),
dimensionedScalar("zrero", dimLength, 0.0)
)
);
delta.internalField() = pow(mesh_.V(), 1.0/3.0);
const cellList& cells = mesh().cells();
// initialise hwn as wall distance
volScalarField hwn = wallDist(mesh()).y();
forAll(cells,cellI)
{
scalar deltaMaxTmp = 0.0;
const labelList& cFaces = mesh().cells()[cellI];
const point& faceCentre = mesh().faceCentres()[cFaces[0]];
const vector nCell = n[cellI];
forAll(cFaces, cFaceI)
{
label faceI = cFaces[cFaceI];
const point& faceCentreTwo = mesh().faceCentres()[faceI];
scalar tmp = (faceCentre - faceCentreTwo) & nCell;
if (tmp > deltaMaxTmp)
{
deltaMaxTmp = tmp;
}
}
faceToFacenMax()[cellI] = deltaMaxTmp;
}
if (nD == 3)
{
@ -68,8 +94,12 @@ void Foam::IDDESDelta::calcDelta()
deltaCoeff_
*min
(
max(max(cw_*wallDist(mesh()).y(), cw_*delta), hwn),
delta
max
(
max(cw_*wallDist(mesh()).y(), cw_*hmax),
faceToFacenMax()
),
hmax
);
}
else if (nD == 2)
@ -82,8 +112,8 @@ void Foam::IDDESDelta::calcDelta()
deltaCoeff_
*min
(
max(max(cw_*wallDist(mesh()).y(), cw_*delta), hwn),
delta
max(max(cw_*wallDist(mesh()).y(), cw_*hmax), faceToFacenMax()),
hmax
);
}
else
@ -105,8 +135,12 @@ Foam::IDDESDelta::IDDESDelta
)
:
LESdelta(name, mesh),
deltaCoeff_(readScalar(dd.subDict(type() + "Coeffs").lookup("deltaCoeff"))),
cw_(0)
hmax_(LESdelta::New("hmax", mesh, dd.parent())),
deltaCoeff_
(
readScalar(dd.subDict(type()+"Coeffs").lookup("deltaCoeff"))
),
cw_(0.15)
{
dd.subDict(type() + "Coeffs").readIfPresent("cw", cw_);
calcDelta();
@ -127,6 +161,7 @@ void Foam::IDDESDelta::correct()
if (mesh_.changing())
{
calcDelta();
hmax_().correct();
}
}

View File

@ -54,6 +54,7 @@ class IDDESDelta
{
// Private data
autoPtr<LESdelta> hmax_;
scalar deltaCoeff_;
scalar cw_;
@ -85,9 +86,10 @@ public:
);
//- Destructor
~IDDESDelta()
{}
// Destructor
~IDDESDelta()
{}
// Member Functions

View File

@ -44,26 +44,9 @@ addToRunTimeSelectionTable(LESModel, SpalartAllmarasIDDES, dictionary);
tmp<volScalarField> SpalartAllmarasIDDES::alpha() const
{
volScalarField delta
(
IOobject
(
"delta",
mesh_.time().timeName(),
mesh_,
IOobject::NO_READ,
IOobject::NO_WRITE
),
mesh_,
dimensionedScalar("zero", dimLength, SMALL),
calculatedFvPatchScalarField::typeName
);
delta.internalField() = pow(mesh_.V(), 1.0/3.0);
return max
(
0.25 - y_/delta,
0.25 - y_/static_cast<const volScalarField&>(hmax_()),
scalar(-5)
);
}
@ -166,7 +149,24 @@ SpalartAllmarasIDDES::SpalartAllmarasIDDES
)
:
SpalartAllmaras(U, phi, transport, turbulenceModelName, modelName),
hmax_
(
LESdelta::New
(
"hmax",
mesh_,
*this
)
),
IDDESDelta_
(
LESdelta::New
(
"IDDESDelta",
mesh_,
this->subDict(typeName + "Coeffs")
)
),
fwStar_
(
dimensioned<scalar>::lookupOrAddToDict

View File

@ -58,6 +58,8 @@ class SpalartAllmarasIDDES
// Model constants
autoPtr<LESdelta> hmax_;
autoPtr<LESdelta> IDDESDelta_;
dimensionedScalar fwStar_;
dimensionedScalar cl_;
dimensionedScalar ct_;
@ -117,6 +119,12 @@ public:
// Member Functions
//- Access function to filter width
virtual const volScalarField& delta() const
{
return IDDESDelta_();
}
//- Read LESProperties dictionary
virtual bool read();
};

View File

@ -435,7 +435,7 @@ tmp<fvVectorMatrix> kOmegaSSTSAS::divDevBeff(volVectorField& U) const
{
return
(
- fvm::laplacian(nuEff(), U) - fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvm::laplacian(nuEff(), U) - fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -146,7 +146,7 @@ tmp<fvVectorMatrix> laminar::divDevBeff(volVectorField& U) const
{
return
(
- fvm::laplacian(nu(), U) - fvc::div(nu()*dev(fvc::grad(U)().T()))
- fvm::laplacian(nu(), U) - fvc::div(nu()*dev(T(fvc::grad(U))))
);
}

View File

@ -199,7 +199,7 @@ tmp<fvVectorMatrix> LamBremhorstKE::divDevReff(volVectorField& U) const
return
(
- fvm::laplacian(nuEff(), U)
- fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -205,7 +205,7 @@ tmp<fvVectorMatrix> LaunderSharmaKE::divDevReff(volVectorField& U) const
return
(
- fvm::laplacian(nuEff(), U)
- fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -294,7 +294,7 @@ tmp<fvVectorMatrix> LienCubicKE::divDevReff(volVectorField& U) const
(
fvc::div(nonlinearStress_)
- fvm::laplacian(nuEff(), U)
- fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -358,7 +358,7 @@ tmp<fvVectorMatrix> LienCubicKELowRe::divDevReff(volVectorField& U) const
(
fvc::div(nonlinearStress_)
- fvm::laplacian(nuEff(), U)
- fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -244,7 +244,7 @@ tmp<fvVectorMatrix> LienLeschzinerLowRe::divDevReff(volVectorField& U) const
(
- fvm::laplacian(nuEff(), U)
//- (fvc::grad(U) & fvc::grad(nuEff()))
- fvc::div(nuEff()*fvc::grad(U)().T())
- fvc::div(nuEff()*T(fvc::grad(U)))
);
}

View File

@ -284,7 +284,7 @@ tmp<fvVectorMatrix> NonlinearKEShih::divDevReff(volVectorField& U) const
(
fvc::div(nonlinearStress_)
- fvm::laplacian(nuEff(), U)
- fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -215,7 +215,7 @@ tmp<fvVectorMatrix> RNGkEpsilon::divDevReff(volVectorField& U) const
return
(
- fvm::laplacian(nuEff(), U)
- fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -325,7 +325,7 @@ tmp<fvVectorMatrix> SpalartAllmaras::divDevReff(volVectorField& U) const
return
(
- fvm::laplacian(nuEff_, U)
- fvc::div(nuEff_*dev(fvc::grad(U)().T()))
- fvc::div(nuEff_*dev(T(fvc::grad(U))))
);
}

View File

@ -187,7 +187,7 @@ tmp<fvVectorMatrix> kEpsilon::divDevReff(volVectorField& U) const
return
(
- fvm::laplacian(nuEff(), U)
- fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -196,7 +196,7 @@ tmp<fvVectorMatrix> kOmega::divDevReff(volVectorField& U) const
return
(
- fvm::laplacian(nuEff(), U)
- fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -303,7 +303,7 @@ tmp<fvVectorMatrix> kOmegaSST::divDevReff(volVectorField& U) const
return
(
- fvm::laplacian(nuEff(), U)
- fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -172,7 +172,7 @@ tmp<fvVectorMatrix> laminar::divDevReff(volVectorField& U) const
return
(
- fvm::laplacian(nuEff(), U)
- fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -257,7 +257,7 @@ tmp<fvVectorMatrix> qZeta::divDevReff(volVectorField& U) const
return
(
- fvm::laplacian(nuEff(), U)
- fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -237,7 +237,7 @@ tmp<fvVectorMatrix> realizableKE::divDevReff(volVectorField& U) const
return
(
- fvm::laplacian(nuEff(), U)
- fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -198,7 +198,7 @@ tmp<fvVectorMatrix> laminar::divDevReff(volVectorField& U) const
return
(
- fvm::laplacian(nuEff(), U)
- fvc::div(nuEff()*dev(fvc::grad(U)().T()))
- fvc::div(nuEff()*dev(T(fvc::grad(U))))
);
}

View File

@ -36,7 +36,7 @@ divSchemes
div(phi,R) Gauss upwind;
div(R) Gauss linear;
div(phi,nuTilda) Gauss upwind;
div((nuEff*dev(grad(U).T()))) Gauss linear;
div((nuEff*dev(T(grad(U))))) Gauss linear;
}
laplacianSchemes