twoPhaseEulerFoam: Now in fully-conservative form

This commit is contained in:
Henry
2014-04-29 15:47:39 +01:00
committed by Andrew Heather
parent 2bfa9c18f5
commit 85da9e6a54
278 changed files with 902 additions and 776 deletions

View File

@ -4,7 +4,7 @@ set -x
wclean libso twoPhaseSystem wclean libso twoPhaseSystem
wclean libso interfacialModels wclean libso interfacialModels
wclean libso phaseIncompressibleTurbulenceModels wclean libso phaseCompressibleTurbulenceModels
wclean wclean
# ----------------------------------------------------------------- end-of-file # ----------------------------------------------------------------- end-of-file

View File

@ -5,7 +5,7 @@ set -x
wmakeLnInclude interfacialModels wmakeLnInclude interfacialModels
wmake libso twoPhaseSystem wmake libso twoPhaseSystem
wmake libso interfacialModels wmake libso interfacialModels
wmake libso phaseIncompressibleTurbulenceModels wmake libso phaseCompressibleTurbulenceModels
wmake wmake
# ----------------------------------------------------------------- end-of-file # ----------------------------------------------------------------- end-of-file

View File

@ -9,48 +9,58 @@
fvScalarMatrix he1Eqn fvScalarMatrix he1Eqn
( (
fvm::ddt(alpha1, he1) + fvm::div(alphaPhi1, he1) fvm::ddt(alpha1, rho1, he1) + fvm::div(alphaRhoPhi1, he1)
+ fvc::ddt(alpha1, K1) + fvc::div(alphaPhi1, K1) - fvm::Sp(fvc::ddt(alpha1, rho1) + fvc::div(alphaRhoPhi1), he1)
// Compressibity correction + fvc::ddt(alpha1, rho1, K1) + fvc::div(alphaRhoPhi1, K1)
- fvm::Sp(fvc::ddt(alpha1) + fvc::div(alphaPhi1), he1) - (fvc::ddt(alpha1, rho1) + fvc::div(alphaRhoPhi1))*K1
- (fvc::ddt(alpha1) + fvc::div(alphaPhi1))*K1
+ ( + (
he1.name() == thermo1.phasePropertyName("e") he1.name() == thermo1.phasePropertyName("e")
? fvc::ddt(alpha1)*p + fvc::div(alphaPhi1, p) ? fvc::ddt(alpha1)*p + fvc::div(alphaPhi1, p)
: -alpha1*dpdt : -alpha1*dpdt
)/rho1 )
- fvm::laplacian
(
fvc::interpolate(alpha1)
*fvc::interpolate(thermo1.alphaEff(phase1.turbulence().mut())),
he1
)
//***HGW- fvm::laplacian(alpha1*turbulence1->alphaEff(), he1)
- fvm::laplacian(alpha1*phase1.turbulence().nuEff(), he1)
== ==
heatTransferCoeff*(thermo2.T() - thermo1.T())/rho1
+ heatTransferCoeff*he1/Cpv1/rho1 heatTransferCoeff*(thermo2.T() - thermo1.T())
- fvm::Sp(heatTransferCoeff/Cpv1/rho1, he1) + heatTransferCoeff*he1/Cpv1
- fvm::Sp(heatTransferCoeff/Cpv1, he1)
); );
fvScalarMatrix he2Eqn fvScalarMatrix he2Eqn
( (
fvm::ddt(alpha2, he2) + fvm::div(alphaPhi2, he2) fvm::ddt(alpha2, rho2, he2) + fvm::div(alphaRhoPhi2, he2)
+ fvc::ddt(alpha2, K2) + fvc::div(alphaPhi2, K2) - fvm::Sp(fvc::ddt(alpha2, rho2) + fvc::div(alphaRhoPhi2), he2)
// Compressibity correction + fvc::ddt(alpha2, rho2, K2) + fvc::div(alphaRhoPhi2, K2)
- fvm::Sp(fvc::ddt(alpha2) + fvc::div(alphaPhi2), he2) - (fvc::ddt(alpha2, rho2) + fvc::div(alphaRhoPhi2))*K2
- (fvc::ddt(alpha2) + fvc::div(alphaPhi2))*K2
+ ( + (
he2.name() == thermo2.phasePropertyName("e") he2.name() == thermo2.phasePropertyName("e")
? fvc::ddt(alpha2)*p + fvc::div(alphaPhi2, p) ? fvc::ddt(alpha2)*p + fvc::div(alphaPhi2, p)
: -alpha2*dpdt : -alpha2*dpdt
)/rho2 )
- fvm::laplacian
(
fvc::interpolate(alpha2)
*fvc::interpolate(thermo2.alphaEff(phase2.turbulence().mut())),
he2
)
//***HGW- fvm::laplacian(alpha2*turbulence2->alphaEff(), he2)
- fvm::laplacian(alpha2*phase2.turbulence().nuEff(), he2)
== ==
heatTransferCoeff*(thermo1.T() - thermo2.T())/rho2
+ heatTransferCoeff*he2/Cpv2/rho2 heatTransferCoeff*(thermo1.T() - thermo2.T())
- fvm::Sp(heatTransferCoeff/Cpv2/rho2, he2) + heatTransferCoeff*he2/Cpv2
- fvm::Sp(heatTransferCoeff/Cpv2, he2)
); );
he1Eqn.relax(); he1Eqn.relax();

View File

@ -1,11 +1,12 @@
EXE_INC = \ EXE_INC = \
-I$(LIB_SRC)/transportModels/compressible/lnInclude \
-I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \ -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \
-I$(LIB_SRC)/finiteVolume/lnInclude \ -I$(LIB_SRC)/finiteVolume/lnInclude \
-I$(LIB_SRC)/transportModels/incompressible/lnInclude \ -I$(LIB_SRC)/transportModels/incompressible/lnInclude \
-I$(LIB_SRC)/TurbulenceModels/turbulenceModels/lnInclude \ -I$(LIB_SRC)/TurbulenceModels/turbulenceModels/lnInclude \
-I$(LIB_SRC)/TurbulenceModels/incompressible/lnInclude \ -I$(LIB_SRC)/TurbulenceModels/compressible/lnInclude \
-I$(LIB_SRC)/TurbulenceModels/phaseIncompressible/lnInclude \ -I$(LIB_SRC)/TurbulenceModels/phaseCompressible/lnInclude \
-IphaseIncompressibleTurbulenceModels/lnInclude \ -IphaseCompressibleTurbulenceModels/lnInclude \
-IinterfacialModels/lnInclude \ -IinterfacialModels/lnInclude \
-ItwoPhaseSystem/lnInclude \ -ItwoPhaseSystem/lnInclude \
-Iaveraging -Iaveraging
@ -14,8 +15,8 @@ EXE_LIBS = \
-lfluidThermophysicalModels \ -lfluidThermophysicalModels \
-lspecie \ -lspecie \
-lturbulenceModels \ -lturbulenceModels \
-lincompressibleTurbulenceModels \ -lcompressibleTurbulenceModels \
-lphaseIncompressibleTurbulenceModels \ -lphaseCompressibleTurbulenceModels \
-lincompressibleTransportModels \ -lincompressibleTransportModels \
-lcompressibleTwoPhaseSystem \ -lcompressibleTwoPhaseSystem \
-lcompressibleEulerianInterfacialModels \ -lcompressibleEulerianInterfacialModels \

View File

@ -2,8 +2,8 @@ mrfZones.correctBoundaryVelocity(U1);
mrfZones.correctBoundaryVelocity(U2); mrfZones.correctBoundaryVelocity(U2);
mrfZones.correctBoundaryVelocity(U); mrfZones.correctBoundaryVelocity(U);
fvVectorMatrix U1Eqn(U1, U1.dimensions()*dimVol/dimTime); fvVectorMatrix U1Eqn(U1, rho1.dimensions()*U1.dimensions()*dimVol/dimTime);
fvVectorMatrix U2Eqn(U2, U2.dimensions()*dimVol/dimTime); fvVectorMatrix U2Eqn(U2, rho2.dimensions()*U2.dimensions()*dimVol/dimTime);
volScalarField dragCoeff(fluid.dragCoeff()); volScalarField dragCoeff(fluid.dragCoeff());
@ -17,18 +17,18 @@ volScalarField dragCoeff(fluid.dragCoeff());
{ {
U1Eqn = U1Eqn =
( (
fvm::ddt(alpha1, U1) fvm::ddt(alpha1, rho1, U1)
+ fvm::div(alphaPhi1, U1) + fvm::div(alphaRhoPhi1, U1)
- fvm::Sp(fvc::ddt(alpha1) + fvc::div(alphaPhi1), U1) - fvm::Sp(fvc::ddt(alpha1, rho1) + fvc::div(alphaRhoPhi1), U1)
+ phase1.turbulence().divDevReff(U1) + phase1.turbulence().divDevRhoReff(U1)
== ==
- fvm::Sp(dragCoeff/rho1, U1) - fvm::Sp(dragCoeff, U1)
- ( - (
liftForce liftForce
+ wallLubricationForce + wallLubricationForce
+ turbulentDispersionForce + turbulentDispersionForce
)/rho1 )
- virtualMassCoeff/rho1 - virtualMassCoeff
*( *(
fvm::ddt(U1) fvm::ddt(U1)
+ fvm::div(phi1, U1) + fvm::div(phi1, U1)
@ -36,25 +36,25 @@ volScalarField dragCoeff(fluid.dragCoeff());
- DDtU2 - DDtU2
) )
); );
mrfZones.addCoriolis(alpha1 + virtualMassCoeff/rho1, U1Eqn); mrfZones.addCoriolis(alpha1*rho1 + virtualMassCoeff, U1Eqn);
U1Eqn.relax(); U1Eqn.relax();
} }
{ {
U2Eqn = U2Eqn =
( (
fvm::ddt(alpha2, U2) fvm::ddt(alpha2, rho2, U2)
+ fvm::div(alphaPhi2, U2) + fvm::div(alphaRhoPhi2, U2)
- fvm::Sp(fvc::ddt(alpha2) + fvc::div(alphaPhi2), U2) - fvm::Sp(fvc::ddt(alpha2, rho2) + fvc::div(alphaRhoPhi2), U2)
+ phase2.turbulence().divDevReff(U2) + phase2.turbulence().divDevRhoReff(U2)
== ==
- fvm::Sp(dragCoeff/rho2, U2) - fvm::Sp(dragCoeff, U2)
+ ( + (
liftForce liftForce
+ wallLubricationForce + wallLubricationForce
+ turbulentDispersionForce + turbulentDispersionForce
)/rho2 )
- virtualMassCoeff/rho2 - virtualMassCoeff
*( *(
fvm::ddt(U2) fvm::ddt(U2)
+ fvm::div(phi2, U2) + fvm::div(phi2, U2)
@ -62,7 +62,7 @@ volScalarField dragCoeff(fluid.dragCoeff());
- DDtU1 - DDtU1
) )
); );
mrfZones.addCoriolis(alpha2 + virtualMassCoeff/rho2, U2Eqn); mrfZones.addCoriolis(alpha2*rho2 + virtualMassCoeff, U2Eqn);
U2Eqn.relax(); U2Eqn.relax();
} }
} }

View File

@ -10,11 +10,13 @@
volVectorField& U1 = phase1.U(); volVectorField& U1 = phase1.U();
surfaceScalarField& phi1 = phase1.phi(); surfaceScalarField& phi1 = phase1.phi();
surfaceScalarField& alphaPhi1 = phase1.phiAlpha(); surfaceScalarField& alphaPhi1 = phase1.alphaPhi();
surfaceScalarField& alphaRhoPhi1 = phase1.alphaRhoPhi();
volVectorField& U2 = phase2.U(); volVectorField& U2 = phase2.U();
surfaceScalarField& phi2 = phase2.phi(); surfaceScalarField& phi2 = phase2.phi();
surfaceScalarField& alphaPhi2 = phase2.phiAlpha(); surfaceScalarField& alphaPhi2 = phase2.alphaPhi();
surfaceScalarField& alphaRhoPhi2 = phase2.alphaRhoPhi();
surfaceScalarField& phi = fluid.phi(); surfaceScalarField& phi = fluid.phi();
@ -49,19 +51,6 @@
fluid.U() fluid.U()
); );
volScalarField rho
(
IOobject
(
"rho",
runTime.timeName(),
mesh,
IOobject::NO_READ,
IOobject::AUTO_WRITE
),
fluid.rho()
);
Info<< "Calculating field DDtU1 and DDtU2\n" << endl; Info<< "Calculating field DDtU1 and DDtU2\n" << endl;
volVectorField DDtU1 volVectorField DDtU1
@ -91,7 +80,7 @@
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionedScalar("zero", dimensionSet(0, 0, 1, 0, 0), 0.0) dimensionedScalar("zero", dimensionSet(-1, 3, 1, 0, 0), 0.0)
); );
volScalarField rAU2 volScalarField rAU2
@ -105,7 +94,7 @@
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
mesh, mesh,
dimensionedScalar("zero", dimensionSet(0, 0, 1, 0, 0), 0.0) dimensionedScalar("zero", dimensionSet(-1, 3, 1, 0, 0), 0.0)
); );
label pRefCell = 0; label pRefCell = 0;

View File

@ -1,10 +1,11 @@
EXE_INC = \ EXE_INC = \
-I$(LIB_SRC)/finiteVolume/lnInclude \ -I$(LIB_SRC)/finiteVolume/lnInclude \
-I$(LIB_SRC)/transportModels/compressible/lnInclude \
-I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \ -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \
-I$(LIB_SRC)/transportModels/incompressible/transportModel \ -I$(LIB_SRC)/transportModels/incompressible/transportModel \
-I$(LIB_SRC)/TurbulenceModels/turbulenceModels/lnInclude \ -I$(LIB_SRC)/TurbulenceModels/turbulenceModels/lnInclude \
-I$(LIB_SRC)/TurbulenceModels/incompressible/lnInclude \ -I$(LIB_SRC)/TurbulenceModels/compressible/lnInclude \
-I$(LIB_SRC)/TurbulenceModels/phaseIncompressible/lnInclude \ -I$(LIB_SRC)/TurbulenceModels/phaseCompressible/lnInclude \
-I../twoPhaseSystem/lnInclude -I../twoPhaseSystem/lnInclude
LIB_LIBS = \ LIB_LIBS = \

View File

@ -26,7 +26,7 @@ License
#include "Burns.H" #include "Burns.H"
#include "phasePair.H" #include "phasePair.H"
#include "fvc.H" #include "fvc.H"
#include "PhaseIncompressibleTurbulenceModel.H" #include "PhaseCompressibleTurbulenceModel.H"
#include "addToRunTimeSelectionTable.H" #include "addToRunTimeSelectionTable.H"
#include "dragModel.H" #include "dragModel.H"

View File

@ -26,7 +26,7 @@ License
#include "Gosman.H" #include "Gosman.H"
#include "phasePair.H" #include "phasePair.H"
#include "fvc.H" #include "fvc.H"
#include "PhaseIncompressibleTurbulenceModel.H" #include "PhaseCompressibleTurbulenceModel.H"
#include "addToRunTimeSelectionTable.H" #include "addToRunTimeSelectionTable.H"
#include "dragModel.H" #include "dragModel.H"

View File

@ -26,7 +26,7 @@ License
#include "constantTurbulentDispersionCoefficient.H" #include "constantTurbulentDispersionCoefficient.H"
#include "phasePair.H" #include "phasePair.H"
#include "fvc.H" #include "fvc.H"
#include "PhaseIncompressibleTurbulenceModel.H" #include "PhaseCompressibleTurbulenceModel.H"
#include "addToRunTimeSelectionTable.H" #include "addToRunTimeSelectionTable.H"
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
@ -73,7 +73,7 @@ Foam::tmp<Foam::volVectorField>
Foam::turbulentDispersionModels::constantTurbulentDispersionCoefficient:: Foam::turbulentDispersionModels::constantTurbulentDispersionCoefficient::
F() const F() const
{ {
return return
- Ctd_ - Ctd_
*pair_.dispersed() *pair_.dispersed()
*pair_.continuous().rho() *pair_.continuous().rho()

View File

@ -5,8 +5,8 @@
rAU1 = 1.0/U1Eqn.A(); rAU1 = 1.0/U1Eqn.A();
rAU2 = 1.0/U2Eqn.A(); rAU2 = 1.0/U2Eqn.A();
surfaceScalarField rAlphaAU1f(fvc::interpolate(alpha1*rAU1)); surfaceScalarField rAlphaAU1f(fvc::interpolate(alpha1*rho1*rAU1));
surfaceScalarField rAlphaAU2f(fvc::interpolate(alpha2*rAU2)); surfaceScalarField rAlphaAU2f(fvc::interpolate(alpha2*rho2*rAU2));
volVectorField HbyA1 volVectorField HbyA1
( (
@ -31,7 +31,7 @@
surfaceScalarField phiP1 surfaceScalarField phiP1
( (
"phiP1", "phiP1",
fvc::interpolate((1.0/rho1)*rAU1*phase1.turbulence().pPrime()) fvc::interpolate(rAU1*phase1.turbulence().pPrime())
*fvc::snGrad(alpha1)*mesh.magSf() *fvc::snGrad(alpha1)*mesh.magSf()
); );
phiP1.boundaryField() == 0; phiP1.boundaryField() == 0;
@ -40,7 +40,7 @@
surfaceScalarField phiP2 surfaceScalarField phiP2
( (
"phiP2", "phiP2",
fvc::interpolate((1.0/rho2)*rAU2*phase2.turbulence().pPrime()) fvc::interpolate(rAU2*phase2.turbulence().pPrime())
*fvc::snGrad(alpha2)*mesh.magSf() *fvc::snGrad(alpha2)*mesh.magSf()
); );
phiP2.boundaryField() == 0; phiP2.boundaryField() == 0;
@ -61,14 +61,14 @@
phiHbyA1 += phiHbyA1 +=
( (
fvc::interpolate((1.0/rho1)*rAU1*dragCoeff)*phi2 fvc::interpolate(rAU1*dragCoeff)*phi2
- phiP1 - phiP1
+ rAlphaAU1f*(g & mesh.Sf()) + rAlphaAU1f*(g & mesh.Sf())
); );
phiHbyA2 += phiHbyA2 +=
( (
fvc::interpolate((1.0/rho2)*rAU2*dragCoeff)*phi1 fvc::interpolate(rAU2*dragCoeff)*phi1
- phiP2 - phiP2
+ rAlphaAU2f*(g & mesh.Sf()) + rAlphaAU2f*(g & mesh.Sf())
); );
@ -82,8 +82,8 @@
surfaceScalarField phiHbyA("phiHbyA", alpha1f*phiHbyA1 + alpha2f*phiHbyA2); surfaceScalarField phiHbyA("phiHbyA", alpha1f*phiHbyA1 + alpha2f*phiHbyA2);
HbyA1 += (1.0/rho1)*rAU1*dragCoeff*U2; HbyA1 += rAU1*dragCoeff*U2;
HbyA2 += (1.0/rho2)*rAU2*dragCoeff*U1; HbyA2 += rAU2*dragCoeff*U1;
surfaceScalarField rAUf surfaceScalarField rAUf
( (
@ -129,7 +129,7 @@
pEqnComp1 = pEqnComp1 =
( (
fvc::ddt(alpha1, rho1) + fvc::div(alphaPhi1, rho1) fvc::ddt(alpha1, rho1) + fvc::div(alphaRhoPhi1)
- fvc::Sp(fvc::ddt(alpha1) + fvc::div(alphaPhi1), rho1) - fvc::Sp(fvc::ddt(alpha1) + fvc::div(alphaPhi1), rho1)
)/rho1 )/rho1
+ (alpha1/rho1)*correction + (alpha1/rho1)*correction
@ -142,7 +142,7 @@
pEqnComp2 = pEqnComp2 =
( (
fvc::ddt(alpha2, rho2) + fvc::div(alphaPhi2, rho2) fvc::ddt(alpha2, rho2) + fvc::div(alphaRhoPhi2)
- fvc::Sp(fvc::ddt(alpha2) + fvc::div(alphaPhi2), rho2) - fvc::Sp(fvc::ddt(alpha2) + fvc::div(alphaPhi2), rho2)
)/rho2 )/rho2
+ (alpha2/rho2)*correction + (alpha2/rho2)*correction
@ -157,14 +157,14 @@
{ {
pEqnComp1 = pEqnComp1 =
( (
fvc::ddt(alpha1, rho1) + fvc::div(alphaPhi1, rho1) fvc::ddt(alpha1, rho1) + fvc::div(alphaRhoPhi1)
- fvc::Sp(fvc::ddt(alpha1) + fvc::div(alphaPhi1), rho1) - fvc::Sp(fvc::ddt(alpha1) + fvc::div(alphaPhi1), rho1)
)/rho1 )/rho1
+ (alpha1*psi1/rho1)*correction(fvm::ddt(p)); + (alpha1*psi1/rho1)*correction(fvm::ddt(p));
pEqnComp2 = pEqnComp2 =
( (
fvc::ddt(alpha2, rho2) + fvc::div(alphaPhi2, rho2) fvc::ddt(alpha2, rho2) + fvc::div(alphaRhoPhi2)
- fvc::Sp(fvc::ddt(alpha2) + fvc::div(alphaPhi2), rho2) - fvc::Sp(fvc::ddt(alpha2) + fvc::div(alphaPhi2), rho2)
)/rho2 )/rho2
+ (alpha2*psi2/rho2)*correction(fvm::ddt(p)); + (alpha2*psi2/rho2)*correction(fvm::ddt(p));
@ -209,8 +209,8 @@
fluid.dgdt() = fluid.dgdt() =
( (
pos(alpha2)*(pEqnComp2 & p)/max(alpha2, scalar(1e-3)) alpha1*(pEqnComp2 & p)
- pos(alpha1)*(pEqnComp1 & p)/max(alpha1, scalar(1e-3)) - alpha2*(pEqnComp1 & p)
); );
p.relax(); p.relax();

View File

@ -1,4 +1,4 @@
phaseIncompressibleTurbulenceModels.C phaseCompressibleTurbulenceModels.C
phasePressureModel/phasePressureModel.C phasePressureModel/phasePressureModel.C
kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.C kineticTheoryModels/kineticTheoryModel/kineticTheoryModel.C
@ -35,4 +35,4 @@ kineticTheoryModels/frictionalStressModel/Schaeffer/SchaefferFrictionalStress.C
kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleTheta/JohnsonJacksonParticleThetaFvPatchScalarField.C kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleTheta/JohnsonJacksonParticleThetaFvPatchScalarField.C
kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleSlip/JohnsonJacksonParticleSlipFvPatchVectorField.C kineticTheoryModels/derivedFvPatchFields/JohnsonJacksonParticleSlip/JohnsonJacksonParticleSlipFvPatchVectorField.C
LIB = $(FOAM_LIBBIN)/libphaseIncompressibleTurbulenceModels LIB = $(FOAM_LIBBIN)/libphaseCompressibleTurbulenceModels

View File

@ -1,10 +1,11 @@
EXE_INC = \ EXE_INC = \
-I$(LIB_SRC)/foam/lnInclude \ -I$(LIB_SRC)/foam/lnInclude \
-I$(LIB_SRC)/finiteVolume/lnInclude \ -I$(LIB_SRC)/finiteVolume/lnInclude \
-I$(LIB_SRC)/transportModels/compressible/lnInclude \
-I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \ -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \
-I$(LIB_SRC)/transportModels/incompressible/transportModel \ -I$(LIB_SRC)/transportModels/incompressible/transportModel \
-I$(LIB_SRC)/TurbulenceModels/turbulenceModels/lnInclude \ -I$(LIB_SRC)/TurbulenceModels/turbulenceModels/lnInclude \
-I$(LIB_SRC)/TurbulenceModels/incompressible/lnInclude \ -I$(LIB_SRC)/TurbulenceModels/compressible/lnInclude \
-I$(LIB_SRC)/TurbulenceModels/phaseIncompressible/lnInclude \ -I$(LIB_SRC)/TurbulenceModels/phaseCompressible/lnInclude \
-I../twoPhaseSystem/lnInclude \ -I../twoPhaseSystem/lnInclude \
-I../interfacialModels/lnInclude -I../interfacialModels/lnInclude

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -80,7 +80,7 @@ Foam::kineticTheoryModels::conductivityModels::Gidaspow::kappa
{ {
const scalar sqrtPi = sqrt(constant::mathematical::pi); const scalar sqrtPi = sqrt(constant::mathematical::pi);
return da*sqrt(Theta)* return rho1*da*sqrt(Theta)*
( (
2.0*sqr(alpha1)*g0*(1.0 + e)/sqrtPi 2.0*sqr(alpha1)*g0*(1.0 + e)/sqrtPi
+ (9.0/8.0)*sqrtPi*g0*0.5*(1.0 + e)*sqr(alpha1) + (9.0/8.0)*sqrtPi*g0*0.5*(1.0 + e)*sqr(alpha1)

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -88,7 +88,7 @@ Foam::kineticTheoryModels::conductivityModels::HrenyaSinclair::kappa
scalar(1) + da/(6.0*sqrt(2.0)*(alpha1 + scalar(1.0e-5)))/L_ scalar(1) + da/(6.0*sqrt(2.0)*(alpha1 + scalar(1.0e-5)))/L_
); );
return da*sqrt(Theta)* return rho1*da*sqrt(Theta)*
( (
2.0*sqr(alpha1)*g0*(1.0 + e)/sqrtPi 2.0*sqr(alpha1)*g0*(1.0 + e)/sqrtPi
+ (9.0/8.0)*sqrtPi*g0*0.25*sqr(1.0 + e)*(2.0*e - 1.0)*sqr(alpha1) + (9.0/8.0)*sqrtPi*g0*0.25*sqr(1.0 + e)*(2.0*e - 1.0)*sqr(alpha1)

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -80,7 +80,7 @@ Foam::kineticTheoryModels::conductivityModels::Syamlal::kappa
{ {
const scalar sqrtPi = sqrt(constant::mathematical::pi); const scalar sqrtPi = sqrt(constant::mathematical::pi);
return da*sqrt(Theta)* return rho1*da*sqrt(Theta)*
( (
2.0*sqr(alpha1)*g0*(1.0 + e)/sqrtPi 2.0*sqr(alpha1)*g0*(1.0 + e)/sqrtPi
+ (9.0/8.0)*sqrtPi*g0*0.25*sqr(1.0 + e)*(2.0*e - 1.0)*sqr(alpha1) + (9.0/8.0)*sqrtPi*g0*0.25*sqr(1.0 + e)*(2.0*e - 1.0)*sqr(alpha1)

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -32,22 +32,22 @@ License
Foam::RASModels::kineticTheoryModel::kineticTheoryModel Foam::RASModels::kineticTheoryModel::kineticTheoryModel
( (
const volScalarField& alpha, const volScalarField& alpha,
const geometricOneField& rho, const volScalarField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& phase, const transportModel& phase,
const word& propertiesName, const word& propertiesName,
const word& type const word& type
) )
: :
eddyViscosity<RASModel<PhaseIncompressibleTurbulenceModel<phaseModel> > > eddyViscosity<RASModel<PhaseCompressibleTurbulenceModel<phaseModel> > >
( (
type, type,
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
phase, phase,
propertiesName propertiesName
@ -159,7 +159,7 @@ Foam::RASModels::kineticTheoryModel::kineticTheoryModel
IOobject::NO_WRITE IOobject::NO_WRITE
), ),
U.mesh(), U.mesh(),
dimensionedScalar("zero", dimensionSet(0, 2, -1, 0, 0), 0.0) dimensionedScalar("zero", dimensionSet(1, -1, -1, 0, 0), 0.0)
) )
{ {
if (type == typeName) if (type == typeName)
@ -183,7 +183,7 @@ bool Foam::RASModels::kineticTheoryModel::read()
( (
eddyViscosity eddyViscosity
< <
RASModel<PhaseIncompressibleTurbulenceModel<phaseModel> > RASModel<PhaseCompressibleTurbulenceModel<phaseModel> >
>::read() >::read()
) )
{ {
@ -383,7 +383,7 @@ void Foam::RASModels::kineticTheoryModel::correct()
// Local references // Local references
volScalarField alpha(max(this->alpha_, scalar(0))); volScalarField alpha(max(this->alpha_, scalar(0)));
const volScalarField& rho = phase_.rho(); const volScalarField& rho = phase_.rho();
const surfaceScalarField& alphaPhi = this->alphaPhi_; const surfaceScalarField& alphaRhoPhi = this->alphaRhoPhi_;
const volVectorField& U = this->U_; const volVectorField& U = this->U_;
const volVectorField& Uc_ = phase_.fluid().otherPhase(phase_).U(); const volVectorField& Uc_ = phase_.fluid().otherPhase(phase_).U();
@ -403,7 +403,7 @@ void Foam::RASModels::kineticTheoryModel::correct()
if (!equilibrium_) if (!equilibrium_)
{ {
// particle viscosity (Table 3.2, p.47) // Particle viscosity (Table 3.2, p.47)
nut_ = viscosityModel_->nu(alpha, Theta_, gs0_, rho, da, e_); nut_ = viscosityModel_->nu(alpha, Theta_, gs0_, rho, da, e_);
volScalarField ThetaSqrt(sqrt(Theta_)); volScalarField ThetaSqrt(sqrt(Theta_));
@ -412,31 +412,29 @@ void Foam::RASModels::kineticTheoryModel::correct()
lambda_ = (4.0/3.0)*sqr(alpha)*da*gs0_*(1.0 + e_)*ThetaSqrt/sqrtPi; lambda_ = (4.0/3.0)*sqr(alpha)*da*gs0_*(1.0 + e_)*ThetaSqrt/sqrtPi;
// Stress tensor, Definitions, Table 3.1, p. 43 // Stress tensor, Definitions, Table 3.1, p. 43
volSymmTensorField tau(2.0*nut_*D + (lambda_ - (2.0/3.0)*nut_)*tr(D)*I); volSymmTensorField tau
(
rho*(2.0*nut_*D + (lambda_ - (2.0/3.0)*nut_)*tr(D)*I)
);
// Dissipation (Eq. 3.24, p.50) // Dissipation (Eq. 3.24, p.50)
volScalarField gammaCoeff volScalarField gammaCoeff
( (
12.0*(1.0 - sqr(e_)) 12.0*(1.0 - sqr(e_))
*max(sqr(alpha), residualAlpha_) *max(sqr(alpha), residualAlpha_)
*gs0_*(1.0/da)*ThetaSqrt/sqrtPi *rho*gs0_*(1.0/da)*ThetaSqrt/sqrtPi
); );
// Drag // Drag
volScalarField magUr(mag(U - Uc_)); volScalarField beta(phase_.fluid().drag(phase_).K());
volScalarField alpha2Prim
(
phase_.fluid().drag(phase_).K()/rho
);
// Eq. 3.25, p. 50 Js = J1 - J2 // Eq. 3.25, p. 50 Js = J1 - J2
volScalarField J1(3.0*alpha2Prim); volScalarField J1(3.0*beta);
volScalarField J2 volScalarField J2
( (
0.25*sqr(alpha2Prim)*da*sqr(magUr) 0.25*sqr(beta)*da*magSqr(U - Uc_)
/( /(
max(alpha, residualAlpha_) max(alpha, residualAlpha_)*rho
*sqrtPi*(ThetaSqrt + ThetaSmallSqrt) *sqrtPi*(ThetaSqrt + ThetaSmallSqrt)
) )
); );
@ -450,7 +448,7 @@ void Foam::RASModels::kineticTheoryModel::correct()
gs0_, gs0_,
rho, rho,
e_ e_
)/rho )
); );
// 'thermal' conductivity (Table 3.3, p. 49) // 'thermal' conductivity (Table 3.3, p. 49)
@ -464,9 +462,9 @@ void Foam::RASModels::kineticTheoryModel::correct()
( (
1.5* 1.5*
( (
fvm::ddt(alpha, Theta_) fvm::ddt(alpha, rho, Theta_)
+ fvm::div(alphaPhi, Theta_) + fvm::div(alphaRhoPhi, Theta_)
- fvc::Sp(fvc::ddt(alpha) + fvc::div(alphaPhi), Theta_) - fvc::Sp(fvc::ddt(alpha, rho) + fvc::div(alphaRhoPhi), Theta_)
) )
- fvm::laplacian(kappa_, Theta_, "laplacian(kappa, Theta)") - fvm::laplacian(kappa_, Theta_, "laplacian(kappa, Theta)")
== ==
@ -489,7 +487,7 @@ void Foam::RASModels::kineticTheoryModel::correct()
( (
0.5*da*rho* 0.5*da*rho*
( (
(sqrtPi/(3.0*(3.0-e_))) (sqrtPi/(3.0*(3.0 - e_)))
*(1.0 + 0.4*(1.0 + e_)*(3.0*e_ - 1.0)*alpha*gs0_) *(1.0 + 0.4*(1.0 + e_)*(3.0*e_ - 1.0)*alpha*gs0_)
+1.6*alpha*gs0_*(1.0 + e_)/sqrtPi +1.6*alpha*gs0_*(1.0 + e_)/sqrtPi
) )

View File

@ -47,7 +47,7 @@ SourceFiles
#include "RASModel.H" #include "RASModel.H"
#include "eddyViscosity.H" #include "eddyViscosity.H"
#include "PhaseIncompressibleTurbulenceModel.H" #include "PhaseCompressibleTurbulenceModel.H"
#include "phaseModel.H" #include "phaseModel.H"
#include "dragModel.H" #include "dragModel.H"
#include "viscosityModel.H" #include "viscosityModel.H"
@ -72,7 +72,7 @@ class kineticTheoryModel
: :
public eddyViscosity public eddyViscosity
< <
RASModel<PhaseIncompressibleTurbulenceModel<phaseModel> > RASModel<PhaseCompressibleTurbulenceModel<phaseModel> >
> >
{ {
// Private data // Private data
@ -159,9 +159,9 @@ public:
kineticTheoryModel kineticTheoryModel
( (
const volScalarField& alpha, const volScalarField& alpha,
const geometricOneField& rho, const volScalarField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const phaseModel& transport, const phaseModel& transport,
const word& propertiesName = turbulenceModel::propertiesName, const word& propertiesName = turbulenceModel::propertiesName,

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation \\ / A nd | Copyright (C) 2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -23,7 +23,7 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "PhaseIncompressibleTurbulenceModel.H" #include "PhaseCompressibleTurbulenceModel.H"
#include "phaseModel.H" #include "phaseModel.H"
#include "twoPhaseSystem.H" #include "twoPhaseSystem.H"
#include "addToRunTimeSelectionTable.H" #include "addToRunTimeSelectionTable.H"
@ -36,19 +36,19 @@ License
makeBaseTurbulenceModel makeBaseTurbulenceModel
( (
volScalarField, volScalarField,
geometricOneField, volScalarField,
incompressibleTurbulenceModel, compressibleTurbulenceModel,
PhaseIncompressibleTurbulenceModel, PhaseCompressibleTurbulenceModel,
phaseModel phaseModel
); );
#define makeRASModel(Type) \ #define makeRASModel(Type) \
makeTemplatedTurbulenceModel \ makeTemplatedTurbulenceModel \
(phaseModelPhaseIncompressibleTurbulenceModel, RAS, Type) (phaseModelPhaseCompressibleTurbulenceModel, RAS, Type)
#define makeLESModel(Type) \ #define makeLESModel(Type) \
makeTemplatedTurbulenceModel \ makeTemplatedTurbulenceModel \
(phaseModelPhaseIncompressibleTurbulenceModel, LES, Type) (phaseModelPhaseCompressibleTurbulenceModel, LES, Type)
#include "kEpsilon.H" #include "kEpsilon.H"
makeRASModel(kEpsilon); makeRASModel(kEpsilon);
@ -79,11 +79,11 @@ makeLESModel(continuousGasKEqn);
#include "kineticTheoryModel.H" #include "kineticTheoryModel.H"
makeTurbulenceModel makeTurbulenceModel
(phaseModelPhaseIncompressibleTurbulenceModel, RAS, kineticTheoryModel); (phaseModelPhaseCompressibleTurbulenceModel, RAS, kineticTheoryModel);
#include "phasePressureModel.H" #include "phasePressureModel.H"
makeTurbulenceModel makeTurbulenceModel
(phaseModelPhaseIncompressibleTurbulenceModel, RAS, phasePressureModel); (phaseModelPhaseCompressibleTurbulenceModel, RAS, phasePressureModel);
// ************************************************************************* // // ************************************************************************* //

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -31,22 +31,22 @@ License
Foam::RASModels::phasePressureModel::phasePressureModel Foam::RASModels::phasePressureModel::phasePressureModel
( (
const volScalarField& alpha, const volScalarField& alpha,
const geometricOneField& rho, const volScalarField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& phase, const transportModel& phase,
const word& propertiesName, const word& propertiesName,
const word& type const word& type
) )
: :
eddyViscosity<RASModel<PhaseIncompressibleTurbulenceModel<phaseModel> > > eddyViscosity<RASModel<PhaseCompressibleTurbulenceModel<phaseModel> > >
( (
type, type,
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
phase, phase,
propertiesName propertiesName
@ -87,7 +87,7 @@ bool Foam::RASModels::phasePressureModel::read()
( (
eddyViscosity eddyViscosity
< <
RASModel<PhaseIncompressibleTurbulenceModel<phaseModel> > RASModel<PhaseCompressibleTurbulenceModel<phaseModel> >
>::read() >::read()
) )
{ {

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -53,7 +53,7 @@ SourceFiles
#include "RASModel.H" #include "RASModel.H"
#include "eddyViscosity.H" #include "eddyViscosity.H"
#include "PhaseIncompressibleTurbulenceModel.H" #include "PhaseCompressibleTurbulenceModel.H"
#include "phaseModel.H" #include "phaseModel.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -71,7 +71,7 @@ class phasePressureModel
: :
public eddyViscosity public eddyViscosity
< <
RASModel<PhaseIncompressibleTurbulenceModel<phaseModel> > RASModel<PhaseCompressibleTurbulenceModel<phaseModel> >
> >
{ {
// Private data // Private data
@ -120,9 +120,9 @@ public:
phasePressureModel phasePressureModel
( (
const volScalarField& alpha, const volScalarField& alpha,
const geometricOneField& rho, const volScalarField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const phaseModel& transport, const phaseModel& transport,
const word& propertiesName = turbulenceModel::propertiesName, const word& propertiesName = turbulenceModel::propertiesName,

View File

@ -32,7 +32,7 @@ Description
#include "fvCFD.H" #include "fvCFD.H"
#include "twoPhaseSystem.H" #include "twoPhaseSystem.H"
#include "PhaseIncompressibleTurbulenceModel.H" #include "PhaseCompressibleTurbulenceModel.H"
#include "pimpleControl.H" #include "pimpleControl.H"
#include "IOMRFZoneList.H" #include "IOMRFZoneList.H"
#include "fixedFluxPressureFvPatchScalarField.H" #include "fixedFluxPressureFvPatchScalarField.H"
@ -72,7 +72,6 @@ int main(int argc, char *argv[])
while (pimple.loop()) while (pimple.loop())
{ {
fluid.solve(); fluid.solve();
rho = fluid.rho();
fluid.correct(); fluid.correct();
#include "EEqns.H" #include "EEqns.H"

View File

@ -2,11 +2,12 @@ EXE_INC = \
-I../twoPhaseSystem \ -I../twoPhaseSystem \
-I../interfacialModels/lnInclude \ -I../interfacialModels/lnInclude \
-I$(LIB_SRC)/finiteVolume/lnInclude \ -I$(LIB_SRC)/finiteVolume/lnInclude \
-I$(LIB_SRC)/transportModels/compressible/lnInclude \
-I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \ -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \
-I$(LIB_SRC)/transportModels/incompressible/lnInclude \ -I$(LIB_SRC)/transportModels/incompressible/lnInclude \
-I$(LIB_SRC)/TurbulenceModels/turbulenceModels/lnInclude \ -I$(LIB_SRC)/TurbulenceModels/turbulenceModels/lnInclude \
-I$(LIB_SRC)/TurbulenceModels/incompressible/lnInclude \ -I$(LIB_SRC)/TurbulenceModels/compressible/lnInclude \
-I$(LIB_SRC)/TurbulenceModels/phaseIncompressible/lnInclude -I$(LIB_SRC)/TurbulenceModels/phaseCompressible/lnInclude
LIB_LIBS = \ LIB_LIBS = \
-lincompressibleTransportModels \ -lincompressibleTransportModels \

View File

@ -146,7 +146,7 @@ void Foam::diameterModels::IATE::correct()
residualAlpha_ residualAlpha_
) )
) )
*(fvc::ddt(phase_) + fvc::div(phase_.phiAlpha())) *(fvc::ddt(phase_) + fvc::div(phase_.alphaPhi()))
); );
// Accumulate the run-time selectable sources // Accumulate the run-time selectable sources

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -26,7 +26,7 @@ License
#include "IATEsource.H" #include "IATEsource.H"
#include "twoPhaseSystem.H" #include "twoPhaseSystem.H"
#include "fvMatrix.H" #include "fvMatrix.H"
#include "PhaseIncompressibleTurbulenceModel.H" #include "PhaseCompressibleTurbulenceModel.H"
#include "uniformDimensionedFields.H" #include "uniformDimensionedFields.H"
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * // // * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //

View File

@ -27,7 +27,7 @@ License
#include "twoPhaseSystem.H" #include "twoPhaseSystem.H"
#include "diameterModel.H" #include "diameterModel.H"
#include "fvMatrix.H" #include "fvMatrix.H"
#include "PhaseIncompressibleTurbulenceModel.H" #include "PhaseCompressibleTurbulenceModel.H"
#include "dragModel.H" #include "dragModel.H"
#include "heatTransferModel.H" #include "heatTransferModel.H"
#include "fixedValueFvPatchFields.H" #include "fixedValueFvPatchFields.H"
@ -77,7 +77,7 @@ Foam::phaseModel::phaseModel
), ),
fluid.mesh() fluid.mesh()
), ),
phiAlpha_ alphaPhi_
( (
IOobject IOobject
( (
@ -87,6 +87,17 @@ Foam::phaseModel::phaseModel
), ),
fluid.mesh(), fluid.mesh(),
dimensionedScalar("0", dimensionSet(0, 3, -1, 0, 0), 0) dimensionedScalar("0", dimensionSet(0, 3, -1, 0, 0), 0)
),
alphaRhoPhi_
(
IOobject
(
IOobject::groupName("alphaRhoPhi", name_),
fluid.mesh().time().timeName(),
fluid.mesh()
),
fluid.mesh(),
dimensionedScalar("0", dimensionSet(1, 0, -1, 0, 0), 0)
) )
{ {
thermo_->validate("phaseModel " + name_, "h", "e"); thermo_->validate("phaseModel " + name_, "h", "e");
@ -169,11 +180,12 @@ Foam::phaseModel::phaseModel
); );
turbulence_ = turbulence_ =
PhaseIncompressibleTurbulenceModel<phaseModel>::New PhaseCompressibleTurbulenceModel<phaseModel>::New
( (
*this, *this,
thermo_->rho(),
U_, U_,
phiAlpha_, alphaRhoPhi_,
phi(), phi(),
*this *this
); );
@ -199,13 +211,13 @@ Foam::tmp<Foam::volScalarField> Foam::phaseModel::d() const
return dPtr_().d(); return dPtr_().d();
} }
Foam::PhaseIncompressibleTurbulenceModel<Foam::phaseModel>& Foam::PhaseCompressibleTurbulenceModel<Foam::phaseModel>&
Foam::phaseModel::turbulence() Foam::phaseModel::turbulence()
{ {
return turbulence_(); return turbulence_();
} }
const Foam::PhaseIncompressibleTurbulenceModel<Foam::phaseModel>& const Foam::PhaseCompressibleTurbulenceModel<Foam::phaseModel>&
Foam::phaseModel::turbulence() const Foam::phaseModel::turbulence() const
{ {
return turbulence_(); return turbulence_();

View File

@ -49,7 +49,7 @@ class twoPhaseSystem;
class diameterModel; class diameterModel;
template<class Phase> template<class Phase>
class PhaseIncompressibleTurbulenceModel; class PhaseCompressibleTurbulenceModel;
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
@ -81,7 +81,10 @@ class phaseModel
volVectorField U_; volVectorField U_;
//- Volumetric flux of the phase //- Volumetric flux of the phase
surfaceScalarField phiAlpha_; surfaceScalarField alphaPhi_;
//- Mass flux of the phase
surfaceScalarField alphaRhoPhi_;
//- Volumetric flux of the phase //- Volumetric flux of the phase
autoPtr<surfaceScalarField> phiPtr_; autoPtr<surfaceScalarField> phiPtr_;
@ -90,7 +93,7 @@ class phaseModel
autoPtr<diameterModel> dPtr_; autoPtr<diameterModel> dPtr_;
//- turbulence model //- turbulence model
autoPtr<PhaseIncompressibleTurbulenceModel<phaseModel> > turbulence_; autoPtr<PhaseCompressibleTurbulenceModel<phaseModel> > turbulence_;
public: public:
@ -137,12 +140,12 @@ public:
tmp<volScalarField> d() const; tmp<volScalarField> d() const;
//- Return the turbulence model //- Return the turbulence model
const PhaseIncompressibleTurbulenceModel<phaseModel>& const PhaseCompressibleTurbulenceModel<phaseModel>&
turbulence() const; turbulence() const;
//- Return non-const access to the turbulence model //- Return non-const access to the turbulence model
// for correction // for correction
PhaseIncompressibleTurbulenceModel<phaseModel>& PhaseCompressibleTurbulenceModel<phaseModel>&
turbulence(); turbulence();
//- Return the thermophysical model //- Return the thermophysical model
@ -170,6 +173,18 @@ public:
return thermo_->nu(patchi); return thermo_->nu(patchi);
} }
//- Return the laminar dynamic viscosity
tmp<volScalarField> mu() const
{
return thermo_->mu();
}
//- Return the laminar dynamic viscosity for patch
tmp<scalarField> mu(const label patchi) const
{
return thermo_->mu(patchi);
}
//- Return the thermal conductivity //- Return the thermal conductivity
tmp<volScalarField> kappa() const tmp<volScalarField> kappa() const
{ {
@ -214,15 +229,27 @@ public:
} }
//- Return the volumetric flux of the phase //- Return the volumetric flux of the phase
const surfaceScalarField& phiAlpha() const const surfaceScalarField& alphaPhi() const
{ {
return phiAlpha_; return alphaPhi_;
} }
//- Return non-const access to the volumetric flux of the phase //- Return non-const access to the volumetric flux of the phase
surfaceScalarField& phiAlpha() surfaceScalarField& alphaPhi()
{ {
return phiAlpha_; return alphaPhi_;
}
//- Return the mass flux of the phase
const surfaceScalarField& alphaRhoPhi() const
{
return alphaRhoPhi_;
}
//- Return non-const access to the mass flux of the phase
surfaceScalarField& alphaRhoPhi()
{
return alphaRhoPhi_;
} }
//- Correct the phase properties //- Correct the phase properties

View File

@ -24,7 +24,7 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "twoPhaseSystem.H" #include "twoPhaseSystem.H"
#include "PhaseIncompressibleTurbulenceModel.H" #include "PhaseCompressibleTurbulenceModel.H"
#include "BlendedInterfacialModel.H" #include "BlendedInterfacialModel.H"
#include "dragModel.H" #include "dragModel.H"
#include "virtualMassModel.H" #include "virtualMassModel.H"
@ -104,9 +104,12 @@ Foam::twoPhaseSystem::twoPhaseSystem
( (
"dgdt", "dgdt",
mesh.time().timeName(), mesh.time().timeName(),
mesh mesh,
IOobject::READ_IF_PRESENT,
IOobject::AUTO_WRITE
), ),
pos(phase2_)*fvc::div(phi_)/max(phase2_, scalar(0.0001)) mesh,
dimensionedScalar("dgdt", dimless/dimTime, 0)
), ),
yWall_ yWall_
@ -124,8 +127,6 @@ Foam::twoPhaseSystem::twoPhaseSystem
// Blending // Blending
// ~~~~~~~~
forAllConstIter(dictionary, subDict("blending"), iter) forAllConstIter(dictionary, subDict("blending"), iter)
{ {
blendingMethods_.insert blendingMethods_.insert
@ -141,7 +142,6 @@ Foam::twoPhaseSystem::twoPhaseSystem
// Pairs // Pairs
// ~~~~~
phasePair::scalarTable sigmaTable(lookup("sigma")); phasePair::scalarTable sigmaTable(lookup("sigma"));
phasePair::dictTable aspectRatioTable(lookup("aspectRatio")); phasePair::dictTable aspectRatioTable(lookup("aspectRatio"));
@ -183,7 +183,6 @@ Foam::twoPhaseSystem::twoPhaseSystem
// Models // Models
// ~~~~~~
drag_.set drag_.set
( (
@ -396,10 +395,8 @@ void Foam::twoPhaseSystem::solve()
); );
pPrimeByA = pPrimeByA =
fvc::interpolate((1.0/phase1_.rho()) fvc::interpolate(rAU1*phase1_.turbulence().pPrime())
*rAU1*phase1_.turbulence().pPrime()) + fvc::interpolate(rAU2*phase2_.turbulence().pPrime());
+ fvc::interpolate((1.0/phase2_.rho())
*rAU2*phase2_.turbulence().pPrime());
surfaceScalarField phiP surfaceScalarField phiP
( (
@ -439,67 +436,90 @@ void Foam::twoPhaseSystem::solve()
forAll(dgdt_, celli) forAll(dgdt_, celli)
{ {
if (dgdt_[celli] > 0.0 && alpha1[celli] > 0.0) if (dgdt_[celli] > 0.0)
{ {
Sp[celli] -= dgdt_[celli]*alpha1[celli]; Sp[celli] -= dgdt_[celli]/max(1.0 - alpha1[celli], 1e-4);
Su[celli] += dgdt_[celli]*alpha1[celli]; Su[celli] += dgdt_[celli]/max(1.0 - alpha1[celli], 1e-4);
} }
else if (dgdt_[celli] < 0.0 && alpha1[celli] < 1.0) else if (dgdt_[celli] < 0.0)
{ {
Sp[celli] += dgdt_[celli]*(1.0 - alpha1[celli]); Sp[celli] += dgdt_[celli]/max(alpha1[celli], 1e-4);
} }
} }
dimensionedScalar totalDeltaT = runTime.deltaT(); surfaceScalarField alphaPhic1
if (nAlphaSubCycles > 1)
{
phase1_.phiAlpha() =
dimensionedScalar("0", phase1_.phiAlpha().dimensions(), 0);
}
for
( (
subCycle<volScalarField> alphaSubCycle(alpha1, nAlphaSubCycles); fvc::flux
!(++alphaSubCycle).end();
)
{
surfaceScalarField alphaPhic1
( (
fvc::flux phic,
( alpha1,
phic, alphaScheme
alpha1, )
alphaScheme + fvc::flux
) (
+ fvc::flux -fvc::flux(-phir, scalar(1) - alpha1, alpharScheme),
( alpha1,
-fvc::flux(-phir, scalar(1) - alpha1, alpharScheme), alpharScheme
alpha1, )
alpharScheme );
)
);
// Ensure that the flux at inflow BCs is preserved // Ensure that the flux at inflow BCs is preserved
forAll(alphaPhic1.boundaryField(), patchi) forAll(alphaPhic1.boundaryField(), patchi)
{
fvsPatchScalarField& alphaPhic1p =
alphaPhic1.boundaryField()[patchi];
if (!alphaPhic1p.coupled())
{ {
fvsPatchScalarField& alphaPhic1p = const scalarField& phi1p = phi1.boundaryField()[patchi];
alphaPhic1.boundaryField()[patchi]; const scalarField& alpha1p = alpha1.boundaryField()[patchi];
if (!alphaPhic1p.coupled()) forAll(alphaPhic1p, facei)
{ {
const scalarField& phi1p = phi1.boundaryField()[patchi]; if (phi1p[facei] < 0)
const scalarField& alpha1p = alpha1.boundaryField()[patchi];
forAll(alphaPhic1p, facei)
{ {
if (phi1p[facei] < 0) alphaPhic1p[facei] = alpha1p[facei]*phi1p[facei];
{
alphaPhic1p[facei] = alpha1p[facei]*phi1p[facei];
}
} }
} }
} }
}
if (nAlphaSubCycles > 1)
{
for
(
subCycle<volScalarField> alphaSubCycle(alpha1, nAlphaSubCycles);
!(++alphaSubCycle).end();
)
{
surfaceScalarField alphaPhic10(alphaPhic1);
MULES::explicitSolve
(
geometricOneField(),
alpha1,
phi_,
alphaPhic10,
(alphaSubCycle.index()*Sp)(),
(Su - (alphaSubCycle.index() - 1)*Sp*alpha1)(),
phase1_.alphaMax(),
0
);
if (alphaSubCycle.index() == 1)
{
phase1_.alphaPhi() = alphaPhic10;
}
else
{
phase1_.alphaPhi() += alphaPhic10;
}
}
phase1_.alphaPhi() /= nAlphaSubCycles;
}
else
{
MULES::explicitSolve MULES::explicitSolve
( (
geometricOneField(), geometricOneField(),
@ -512,14 +532,7 @@ void Foam::twoPhaseSystem::solve()
0 0
); );
if (nAlphaSubCycles > 1) phase1_.alphaPhi() = alphaPhic1;
{
phase1_.phiAlpha() += (runTime.deltaT()/totalDeltaT)*alphaPhic1;
}
else
{
phase1_.phiAlpha() = alphaPhic1;
}
} }
if (implicitPhasePressure) if (implicitPhasePressure)
@ -527,17 +540,22 @@ void Foam::twoPhaseSystem::solve()
fvScalarMatrix alpha1Eqn fvScalarMatrix alpha1Eqn
( (
fvm::ddt(alpha1) - fvc::ddt(alpha1) fvm::ddt(alpha1) - fvc::ddt(alpha1)
- fvm::laplacian(alpha1f*pPrimeByA, alpha1, "bounded") - fvm::laplacian(alpha1f*pPrimeByA(), alpha1, "bounded")
); );
alpha1Eqn.relax(); alpha1Eqn.relax();
alpha1Eqn.solve(); alpha1Eqn.solve();
phase1_.phiAlpha() += alpha1Eqn.flux(); phase1_.alphaPhi() += alpha1Eqn.flux();
} }
phase2_.phiAlpha() = phi_ - phase1_.phiAlpha(); phase1_.alphaRhoPhi() =
fvc::interpolate(phase1_.rho())*phase1_.alphaPhi();
phase2_.alphaPhi() = phi_ - phase1_.alphaPhi();
alpha2 = scalar(1) - alpha1; alpha2 = scalar(1) - alpha1;
phase2_.alphaRhoPhi() =
fvc::interpolate(phase2_.rho())*phase2_.alphaPhi();
Info<< alpha1.name() << " volume fraction = " Info<< alpha1.name() << " volume fraction = "
<< alpha1.weightedAverage(mesh_.V()).value() << alpha1.weightedAverage(mesh_.V()).value()

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -34,7 +34,7 @@ IncompressibleTurbulenceModel
const geometricOneField& alpha, const geometricOneField& alpha,
const geometricOneField& rho, const geometricOneField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const TransportModel& transportModel, const TransportModel& transportModel,
const word& propertiesName const word& propertiesName
@ -51,7 +51,7 @@ IncompressibleTurbulenceModel
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
transportModel, transportModel,
propertiesName propertiesName

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -75,7 +75,7 @@ public:
const geometricOneField& alpha, const geometricOneField& alpha,
const geometricOneField& rho, const geometricOneField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const TransportModel& trasportModel, const TransportModel& trasportModel,
const word& propertiesName const word& propertiesName

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -39,7 +39,7 @@ Foam::incompressibleTurbulenceModel::incompressibleTurbulenceModel
( (
const geometricOneField&, const geometricOneField&,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const word& propertiesName const word& propertiesName
) )
@ -47,7 +47,7 @@ Foam::incompressibleTurbulenceModel::incompressibleTurbulenceModel
turbulenceModel turbulenceModel
( (
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
propertiesName propertiesName
) )

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -86,7 +86,7 @@ public:
( (
const geometricOneField& rho, const geometricOneField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const word& propertiesName const word& propertiesName
); );

View File

@ -43,7 +43,7 @@ NicenoKEqn<BasicTurbulenceModel>::NicenoKEqn
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName, const word& propertiesName,
@ -55,7 +55,7 @@ NicenoKEqn<BasicTurbulenceModel>::NicenoKEqn
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
transport, transport,
propertiesName, propertiesName,
@ -123,7 +123,7 @@ bool NicenoKEqn<BasicTurbulenceModel>::read()
template<class BasicTurbulenceModel> template<class BasicTurbulenceModel>
const PhaseIncompressibleTurbulenceModel const PhaseCompressibleTurbulenceModel
< <
typename BasicTurbulenceModel::transportModel typename BasicTurbulenceModel::transportModel
>& >&
@ -139,7 +139,7 @@ NicenoKEqn<BasicTurbulenceModel>::gasTurbulence() const
gasTurbulencePtr_ = gasTurbulencePtr_ =
&U.db() &U.db()
.lookupObject<PhaseIncompressibleTurbulenceModel<transportModel> > .lookupObject<PhaseCompressibleTurbulenceModel<transportModel> >
( (
IOobject::groupName IOobject::groupName
( (
@ -156,7 +156,7 @@ NicenoKEqn<BasicTurbulenceModel>::gasTurbulence() const
template<class BasicTurbulenceModel> template<class BasicTurbulenceModel>
void NicenoKEqn<BasicTurbulenceModel>::correctNut() void NicenoKEqn<BasicTurbulenceModel>::correctNut()
{ {
const PhaseIncompressibleTurbulenceModel<transportModel>& gasTurbulence = const PhaseCompressibleTurbulenceModel<transportModel>& gasTurbulence =
this->gasTurbulence(); this->gasTurbulence();
this->nut_ = this->nut_ =
@ -171,7 +171,7 @@ void NicenoKEqn<BasicTurbulenceModel>::correctNut()
template<class BasicTurbulenceModel> template<class BasicTurbulenceModel>
tmp<volScalarField> NicenoKEqn<BasicTurbulenceModel>::bubbleG() const tmp<volScalarField> NicenoKEqn<BasicTurbulenceModel>::bubbleG() const
{ {
const PhaseIncompressibleTurbulenceModel<transportModel>& gasTurbulence = const PhaseCompressibleTurbulenceModel<transportModel>& gasTurbulence =
this->gasTurbulence(); this->gasTurbulence();
const transportModel& liquid = this->transport(); const transportModel& liquid = this->transport();
@ -218,7 +218,7 @@ tmp<fvScalarMatrix> NicenoKEqn<BasicTurbulenceModel>::kSource() const
const alphaField& alpha = this->alpha_; const alphaField& alpha = this->alpha_;
const rhoField& rho = this->rho_; const rhoField& rho = this->rho_;
const PhaseIncompressibleTurbulenceModel<transportModel>& gasTurbulence = const PhaseCompressibleTurbulenceModel<transportModel>& gasTurbulence =
this->gasTurbulence(); this->gasTurbulence();
const volScalarField phaseTransferCoeff(this->phaseTransferCoeff()); const volScalarField phaseTransferCoeff(this->phaseTransferCoeff());

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -81,7 +81,7 @@ class NicenoKEqn
{ {
// Private data // Private data
mutable const PhaseIncompressibleTurbulenceModel mutable const PhaseCompressibleTurbulenceModel
< <
typename BasicTurbulenceModel::transportModel typename BasicTurbulenceModel::transportModel
> *gasTurbulencePtr_; > *gasTurbulencePtr_;
@ -90,7 +90,7 @@ class NicenoKEqn
// Private Member Functions // Private Member Functions
//- Return the turbulence model for the gas phase //- Return the turbulence model for the gas phase
const PhaseIncompressibleTurbulenceModel const PhaseCompressibleTurbulenceModel
< <
typename BasicTurbulenceModel::transportModel typename BasicTurbulenceModel::transportModel
>& >&
@ -139,7 +139,7 @@ public:
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName = turbulenceModel::propertiesName, const word& propertiesName = turbulenceModel::propertiesName,

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -40,7 +40,7 @@ SmagorinskyZhang<BasicTurbulenceModel>::SmagorinskyZhang
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName, const word& propertiesName,
@ -52,7 +52,7 @@ SmagorinskyZhang<BasicTurbulenceModel>::SmagorinskyZhang
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
transport, transport,
propertiesName, propertiesName,
@ -98,7 +98,7 @@ bool SmagorinskyZhang<BasicTurbulenceModel>::read()
template<class BasicTurbulenceModel> template<class BasicTurbulenceModel>
const PhaseIncompressibleTurbulenceModel const PhaseCompressibleTurbulenceModel
< <
typename BasicTurbulenceModel::transportModel typename BasicTurbulenceModel::transportModel
>& >&
@ -114,7 +114,7 @@ SmagorinskyZhang<BasicTurbulenceModel>::gasTurbulence() const
gasTurbulencePtr_ = gasTurbulencePtr_ =
&U.db() &U.db()
.lookupObject<PhaseIncompressibleTurbulenceModel<transportModel> > .lookupObject<PhaseCompressibleTurbulenceModel<transportModel> >
( (
IOobject::groupName IOobject::groupName
( (
@ -131,7 +131,7 @@ SmagorinskyZhang<BasicTurbulenceModel>::gasTurbulence() const
template<class BasicTurbulenceModel> template<class BasicTurbulenceModel>
void SmagorinskyZhang<BasicTurbulenceModel>::correctNut() void SmagorinskyZhang<BasicTurbulenceModel>::correctNut()
{ {
const PhaseIncompressibleTurbulenceModel<transportModel>& gasTurbulence = const PhaseCompressibleTurbulenceModel<transportModel>& gasTurbulence =
this->gasTurbulence(); this->gasTurbulence();
volScalarField k(this->k(fvc::grad(this->U_))); volScalarField k(this->k(fvc::grad(this->U_)));

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -79,7 +79,7 @@ class SmagorinskyZhang
{ {
// Private data // Private data
mutable const PhaseIncompressibleTurbulenceModel mutable const PhaseCompressibleTurbulenceModel
< <
typename BasicTurbulenceModel::transportModel typename BasicTurbulenceModel::transportModel
> *gasTurbulencePtr_; > *gasTurbulencePtr_;
@ -88,7 +88,7 @@ class SmagorinskyZhang
// Private Member Functions // Private Member Functions
//- Return the turbulence model for the gas phase //- Return the turbulence model for the gas phase
const PhaseIncompressibleTurbulenceModel const PhaseCompressibleTurbulenceModel
< <
typename BasicTurbulenceModel::transportModel typename BasicTurbulenceModel::transportModel
>& >&
@ -132,7 +132,7 @@ public:
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName = turbulenceModel::propertiesName, const word& propertiesName = turbulenceModel::propertiesName,

View File

@ -42,7 +42,7 @@ continuousGasKEqn<BasicTurbulenceModel>::continuousGasKEqn
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName, const word& propertiesName,
@ -54,7 +54,7 @@ continuousGasKEqn<BasicTurbulenceModel>::continuousGasKEqn
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
transport, transport,
propertiesName, propertiesName,

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -124,7 +124,7 @@ public:
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName = turbulenceModel::propertiesName, const word& propertiesName = turbulenceModel::propertiesName,

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -34,7 +34,7 @@ PhaseCompressibleTurbulenceModel
const volScalarField& alpha, const volScalarField& alpha,
const volScalarField& rho, const volScalarField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName const word& propertiesName
@ -51,7 +51,7 @@ PhaseCompressibleTurbulenceModel
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
transport, transport,
propertiesName propertiesName
@ -68,7 +68,7 @@ Foam::PhaseCompressibleTurbulenceModel<TransportModel>::New
const volScalarField& alpha, const volScalarField& alpha,
const volScalarField& rho, const volScalarField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName const word& propertiesName
@ -88,7 +88,7 @@ Foam::PhaseCompressibleTurbulenceModel<TransportModel>::New
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
transport, transport,
propertiesName propertiesName
@ -97,4 +97,52 @@ Foam::PhaseCompressibleTurbulenceModel<TransportModel>::New
} }
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
template<class TransportModel>
Foam::tmp<Foam::volScalarField>
Foam::PhaseCompressibleTurbulenceModel<TransportModel>::pPrime() const
{
return tmp<volScalarField>
(
new volScalarField
(
IOobject
(
IOobject::groupName("pPrime", this->U_.group()),
this->runTime_.timeName(),
this->mesh_,
IOobject::NO_READ,
IOobject::NO_WRITE
),
this->mesh_,
dimensionedScalar("pPrimef", dimPressure, 0.0)
)
);
}
template<class TransportModel>
Foam::tmp<Foam::surfaceScalarField>
Foam::PhaseCompressibleTurbulenceModel<TransportModel>::pPrimef() const
{
return tmp<surfaceScalarField>
(
new surfaceScalarField
(
IOobject
(
IOobject::groupName("pPrimef", this->U_.group()),
this->runTime_.timeName(),
this->mesh_,
IOobject::NO_READ,
IOobject::NO_WRITE
),
this->mesh_,
dimensionedScalar("pPrimef", dimPressure, 0.0)
)
);
}
// ************************************************************************* // // ************************************************************************* //

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -75,7 +75,7 @@ public:
const alphaField& alpha, const alphaField& alpha,
const volScalarField& rho, const volScalarField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& trasport, const transportModel& trasport,
const word& propertiesName const word& propertiesName
@ -90,7 +90,7 @@ public:
const alphaField& alpha, const alphaField& alpha,
const volScalarField& rho, const volScalarField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& trasportModel, const transportModel& trasportModel,
const word& propertiesName = turbulenceModel::propertiesName const word& propertiesName = turbulenceModel::propertiesName
@ -139,6 +139,14 @@ public:
{ {
return mut(patchi) + mu(patchi); return mut(patchi) + mu(patchi);
} }
//- Return the phase-pressure'
// (derivative of phase-pressure w.r.t. phase-fraction)
virtual tmp<volScalarField> pPrime() const;
//- Return the face-phase-pressure'
// (derivative of phase-pressure w.r.t. phase-fraction)
virtual tmp<surfaceScalarField> pPrimef() const;
}; };

View File

@ -43,7 +43,7 @@ LaheyKEpsilon<BasicTurbulenceModel>::LaheyKEpsilon
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName, const word& propertiesName,
@ -55,7 +55,7 @@ LaheyKEpsilon<BasicTurbulenceModel>::LaheyKEpsilon
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
transport, transport,
propertiesName, propertiesName,
@ -134,7 +134,7 @@ bool LaheyKEpsilon<BasicTurbulenceModel>::read()
template<class BasicTurbulenceModel> template<class BasicTurbulenceModel>
const PhaseIncompressibleTurbulenceModel const PhaseCompressibleTurbulenceModel
< <
typename BasicTurbulenceModel::transportModel typename BasicTurbulenceModel::transportModel
>& >&
@ -150,7 +150,7 @@ LaheyKEpsilon<BasicTurbulenceModel>::gasTurbulence() const
gasTurbulencePtr_ = gasTurbulencePtr_ =
&U.db() &U.db()
.lookupObject<PhaseIncompressibleTurbulenceModel<transportModel> > .lookupObject<PhaseCompressibleTurbulenceModel<transportModel> >
( (
IOobject::groupName IOobject::groupName
( (
@ -167,7 +167,7 @@ LaheyKEpsilon<BasicTurbulenceModel>::gasTurbulence() const
template<class BasicTurbulenceModel> template<class BasicTurbulenceModel>
void LaheyKEpsilon<BasicTurbulenceModel>::correctNut() void LaheyKEpsilon<BasicTurbulenceModel>::correctNut()
{ {
const PhaseIncompressibleTurbulenceModel<transportModel>& gasTurbulence = const PhaseCompressibleTurbulenceModel<transportModel>& gasTurbulence =
this->gasTurbulence(); this->gasTurbulence();
this->nut_ = this->nut_ =
@ -182,7 +182,7 @@ void LaheyKEpsilon<BasicTurbulenceModel>::correctNut()
template<class BasicTurbulenceModel> template<class BasicTurbulenceModel>
tmp<volScalarField> LaheyKEpsilon<BasicTurbulenceModel>::bubbleG() const tmp<volScalarField> LaheyKEpsilon<BasicTurbulenceModel>::bubbleG() const
{ {
const PhaseIncompressibleTurbulenceModel<transportModel>& gasTurbulence = const PhaseCompressibleTurbulenceModel<transportModel>& gasTurbulence =
this->gasTurbulence(); this->gasTurbulence();
const transportModel& liquid = this->transport(); const transportModel& liquid = this->transport();
@ -232,7 +232,7 @@ tmp<fvScalarMatrix> LaheyKEpsilon<BasicTurbulenceModel>::kSource() const
const alphaField& alpha = this->alpha_; const alphaField& alpha = this->alpha_;
const rhoField& rho = this->rho_; const rhoField& rho = this->rho_;
const PhaseIncompressibleTurbulenceModel<transportModel>& gasTurbulence = const PhaseCompressibleTurbulenceModel<transportModel>& gasTurbulence =
this->gasTurbulence(); this->gasTurbulence();
const volScalarField phaseTransferCoeff(this->phaseTransferCoeff()); const volScalarField phaseTransferCoeff(this->phaseTransferCoeff());
@ -250,7 +250,7 @@ tmp<fvScalarMatrix> LaheyKEpsilon<BasicTurbulenceModel>::epsilonSource() const
const alphaField& alpha = this->alpha_; const alphaField& alpha = this->alpha_;
const rhoField& rho = this->rho_; const rhoField& rho = this->rho_;
const PhaseIncompressibleTurbulenceModel<transportModel>& gasTurbulence = const PhaseCompressibleTurbulenceModel<transportModel>& gasTurbulence =
this->gasTurbulence(); this->gasTurbulence();
const volScalarField phaseTransferCoeff(this->phaseTransferCoeff()); const volScalarField phaseTransferCoeff(this->phaseTransferCoeff());

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -82,7 +82,7 @@ class LaheyKEpsilon
{ {
// Private data // Private data
mutable const PhaseIncompressibleTurbulenceModel mutable const PhaseCompressibleTurbulenceModel
< <
typename BasicTurbulenceModel::transportModel typename BasicTurbulenceModel::transportModel
> *gasTurbulencePtr_; > *gasTurbulencePtr_;
@ -91,7 +91,7 @@ class LaheyKEpsilon
// Private Member Functions // Private Member Functions
//- Return the turbulence model for the gas phase //- Return the turbulence model for the gas phase
const PhaseIncompressibleTurbulenceModel const PhaseCompressibleTurbulenceModel
< <
typename BasicTurbulenceModel::transportModel typename BasicTurbulenceModel::transportModel
>& >&
@ -142,7 +142,7 @@ public:
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName = turbulenceModel::propertiesName, const word& propertiesName = turbulenceModel::propertiesName,

View File

@ -43,7 +43,7 @@ continuousGasKEpsilon<BasicTurbulenceModel>::continuousGasKEpsilon
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName, const word& propertiesName,
@ -55,7 +55,7 @@ continuousGasKEpsilon<BasicTurbulenceModel>::continuousGasKEpsilon
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
transport, transport,
propertiesName, propertiesName,

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -130,7 +130,7 @@ public:
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName = turbulenceModel::propertiesName, const word& propertiesName = turbulenceModel::propertiesName,

View File

@ -47,7 +47,7 @@ mixtureKEpsilon<BasicTurbulenceModel>::mixtureKEpsilon
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName, const word& propertiesName,
@ -60,7 +60,7 @@ mixtureKEpsilon<BasicTurbulenceModel>::mixtureKEpsilon
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
transport, transport,
propertiesName propertiesName
@ -547,7 +547,7 @@ void mixtureKEpsilon<BasicTurbulenceModel>::correct()
initMixtureFields(); initMixtureFields();
// Local references to gas-phase properties // Local references to gas-phase properties
const surfaceScalarField& phig = this->phi_; tmp<surfaceScalarField> phig = this->phi();
const volVectorField& Ug = this->U_; const volVectorField& Ug = this->U_;
const volScalarField& alphag = this->alpha_; const volScalarField& alphag = this->alpha_;
volScalarField& kg = this->k_; volScalarField& kg = this->k_;
@ -557,7 +557,7 @@ void mixtureKEpsilon<BasicTurbulenceModel>::correct()
// Local references to liquid-phase properties // Local references to liquid-phase properties
mixtureKEpsilon<BasicTurbulenceModel>& liquidTurbulence = mixtureKEpsilon<BasicTurbulenceModel>& liquidTurbulence =
this->liquidTurbulence(); this->liquidTurbulence();
const surfaceScalarField& phil = liquidTurbulence.phi_; tmp<surfaceScalarField> phil = liquidTurbulence.phi();
const volVectorField& Ul = liquidTurbulence.U_; const volVectorField& Ul = liquidTurbulence.U_;
const volScalarField& alphal = liquidTurbulence.alpha_; const volScalarField& alphal = liquidTurbulence.alpha_;
volScalarField& kl = liquidTurbulence.k_; volScalarField& kl = liquidTurbulence.k_;

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -215,7 +215,7 @@ public:
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName = turbulenceModel::propertiesName, const word& propertiesName = turbulenceModel::propertiesName,

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -34,7 +34,7 @@ PhaseIncompressibleTurbulenceModel
const volScalarField& alpha, const volScalarField& alpha,
const geometricOneField& rho, const geometricOneField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const TransportModel& transportModel, const TransportModel& transportModel,
const word& propertiesName const word& propertiesName
@ -51,7 +51,7 @@ PhaseIncompressibleTurbulenceModel
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
transportModel, transportModel,
propertiesName propertiesName
@ -67,7 +67,7 @@ Foam::PhaseIncompressibleTurbulenceModel<TransportModel>::New
( (
const volScalarField& alpha, const volScalarField& alpha,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const TransportModel& transportModel, const TransportModel& transportModel,
const word& propertiesName const word& propertiesName
@ -87,7 +87,7 @@ Foam::PhaseIncompressibleTurbulenceModel<TransportModel>::New
alpha, alpha,
geometricOneField(), geometricOneField(),
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
transportModel, transportModel,
propertiesName propertiesName

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -75,7 +75,7 @@ public:
const alphaField& alpha, const alphaField& alpha,
const geometricOneField& rho, const geometricOneField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const TransportModel& trasportModel, const TransportModel& trasportModel,
const word& propertiesName const word& propertiesName
@ -89,7 +89,7 @@ public:
( (
const alphaField& alpha, const alphaField& alpha,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const TransportModel& trasportModel, const TransportModel& trasportModel,
const word& propertiesName = turbulenceModel::propertiesName const word& propertiesName = turbulenceModel::propertiesName

View File

@ -46,7 +46,7 @@ Foam::LESModel<BasicTurbulenceModel>::LESModel
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName const word& propertiesName
@ -57,7 +57,7 @@ Foam::LESModel<BasicTurbulenceModel>::LESModel
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
transport, transport,
propertiesName propertiesName
@ -104,7 +104,7 @@ Foam::LESModel<BasicTurbulenceModel>::New
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName const word& propertiesName
@ -154,7 +154,7 @@ Foam::LESModel<BasicTurbulenceModel>::New
return autoPtr<LESModel> return autoPtr<LESModel>
( (
cstrIter()(alpha, rho, U, alphaPhi, phi, transport, propertiesName) cstrIter()(alpha, rho, U, alphaRhoPhi, phi, transport, propertiesName)
); );
} }

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -121,12 +121,12 @@ public:
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName const word& propertiesName
), ),
(alpha, rho, U, alphaPhi, phi, transport, propertiesName) (alpha, rho, U, alphaRhoPhi, phi, transport, propertiesName)
); );
@ -139,7 +139,7 @@ public:
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName const word& propertiesName
@ -154,7 +154,7 @@ public:
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName = turbulenceModel::propertiesName const word& propertiesName = turbulenceModel::propertiesName

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -40,7 +40,7 @@ Smagorinsky<BasicTurbulenceModel>::Smagorinsky
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName, const word& propertiesName,
@ -53,7 +53,7 @@ Smagorinsky<BasicTurbulenceModel>::Smagorinsky
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
transport, transport,
propertiesName propertiesName

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -122,7 +122,7 @@ public:
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName = turbulenceModel::propertiesName, const word& propertiesName = turbulenceModel::propertiesName,

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -41,7 +41,7 @@ LESeddyViscosity<BasicTurbulenceModel>::LESeddyViscosity
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName const word& propertiesName
@ -53,7 +53,7 @@ LESeddyViscosity<BasicTurbulenceModel>::LESeddyViscosity
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
transport, transport,
propertiesName propertiesName

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2013-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -87,7 +87,7 @@ public:
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName = turbulenceModel::propertiesName const word& propertiesName = turbulenceModel::propertiesName

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -40,7 +40,7 @@ kEqn<BasicTurbulenceModel>::kEqn
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName, const word& propertiesName,
@ -53,7 +53,7 @@ kEqn<BasicTurbulenceModel>::kEqn
alpha, alpha,
rho, rho,
U, U,
alphaPhi, alphaRhoPhi,
phi, phi,
transport, transport,
propertiesName propertiesName
@ -163,14 +163,13 @@ void kEqn<BasicTurbulenceModel>::correct()
// Local references // Local references
const alphaField& alpha = this->alpha_; const alphaField& alpha = this->alpha_;
const rhoField& rho = this->rho_; const rhoField& rho = this->rho_;
const surfaceScalarField& alphaPhi = this->alphaPhi_; const surfaceScalarField& alphaRhoPhi = this->alphaRhoPhi_;
const surfaceScalarField& phi = this->phi_;
const volVectorField& U = this->U_; const volVectorField& U = this->U_;
volScalarField& nut = this->nut_; volScalarField& nut = this->nut_;
LESeddyViscosity<BasicTurbulenceModel>::correct(); LESeddyViscosity<BasicTurbulenceModel>::correct();
volScalarField divU(fvc::div(fvc::absolute(phi/fvc::interpolate(rho), U))); volScalarField divU(fvc::div(fvc::absolute(this->phi(), U)));
tmp<volTensorField> tgradU(fvc::grad(U)); tmp<volTensorField> tgradU(fvc::grad(U));
volScalarField G(this->GName(), nut*(tgradU() && dev(twoSymm(tgradU())))); volScalarField G(this->GName(), nut*(tgradU() && dev(twoSymm(tgradU()))));
@ -179,8 +178,8 @@ void kEqn<BasicTurbulenceModel>::correct()
tmp<fvScalarMatrix> kEqn tmp<fvScalarMatrix> kEqn
( (
fvm::ddt(alpha, rho, k_) fvm::ddt(alpha, rho, k_)
+ fvm::div(alphaPhi, k_) + fvm::div(alphaRhoPhi, k_)
- fvm::Sp(fvc::ddt(alpha, rho) + fvc::div(alphaPhi), k_) - fvm::Sp(fvc::ddt(alpha, rho) + fvc::div(alphaRhoPhi), k_)
- fvm::laplacian(alpha*rho*DkEff(), k_) - fvm::laplacian(alpha*rho*DkEff(), k_)
== ==
alpha*rho*G alpha*rho*G

View File

@ -2,7 +2,7 @@
========= | ========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration | \\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation \\ / A nd | Copyright (C) 2011-2014 OpenFOAM Foundation
\\/ M anipulation | \\/ M anipulation |
------------------------------------------------------------------------------- -------------------------------------------------------------------------------
License License
@ -125,7 +125,7 @@ public:
const alphaField& alpha, const alphaField& alpha,
const rhoField& rho, const rhoField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& alphaPhi, const surfaceScalarField& alphaRhoPhi,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const transportModel& transport, const transportModel& transport,
const word& propertiesName = turbulenceModel::propertiesName, const word& propertiesName = turbulenceModel::propertiesName,

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