Merge branch 'master' of ssh://noisy/home/noisy3/OpenFOAM/OpenFOAM-dev

This commit is contained in:
henry
2009-06-25 15:40:45 +01:00
99 changed files with 523 additions and 401 deletions

View File

@ -46,11 +46,14 @@ using namespace Foam;
int main(int argc, char *argv[]) int main(int argc, char *argv[])
{ {
timeSelector::addOptions();
#include "addRegionOption.H"
#include "setRootCase.H" #include "setRootCase.H"
#include "createTime.H" #include "createTime.H"
instantList timeDirs = timeSelector::select0(runTime, args); instantList timeDirs = timeSelector::select0(runTime, args);
#include "createMesh.H" #include "createNamedMesh.H"
#include "createFields.H" #include "createFields.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -0,0 +1,17 @@
#!/bin/sh
# Source tutorial run functions
. $WM_PROJECT_DIR/bin/tools/RunFunctions
# Get application name from directory
application="XiFoam"
cases=" \
pitzDaily \
pitzDaily3D
"
for i in $cases; do
blockMesh -case $i
$application -case $i
done

View File

@ -0,0 +1,49 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 |
| \\ / A nd | Web: http://www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class volScalarField;
object alphaSgs;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [1 -1 -1 0 0 0 0];
internalField uniform 0;
boundaryField
{
inlet
{
type zeroGradient;
}
outlet
{
type zeroGradient;
}
upperWall
{
type zeroGradient;
}
lowerWall
{
type zeroGradient;
}
frontAndBack
{
type empty;
}
}
// ************************************************************************* //

View File

@ -0,0 +1,49 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 |
| \\ / A nd | Web: http://www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class volScalarField;
object alphaSgs;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [1 -1 -1 0 0 0 0];
internalField uniform 0;
boundaryField
{
inlet
{
type zeroGradient;
}
outlet
{
type zeroGradient;
}
upperWall
{
type zeroGradient;
}
lowerWall
{
type zeroGradient;
}
frontAndBack
{
type cyclic;
}
}
// ************************************************************************* //

View File

@ -1,7 +1,7 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
@ -23,7 +23,7 @@ boundaryField
{ {
walls walls
{ {
type alphatWallFunction; type compressible::alphatWallFunction;
value uniform 0; value uniform 0;
} }
} }

View File

@ -1,7 +1,7 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
@ -23,7 +23,7 @@ boundaryField
{ {
walls walls
{ {
type epsilonWallFunction; type compressible::epsilonWallFunction;
value uniform 90; value uniform 90;
} }
} }

View File

@ -1,7 +1,7 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
@ -23,7 +23,7 @@ boundaryField
{ {
walls walls
{ {
type kQRWallFunction; type compressible::kQRWallFunction;
value uniform 1; value uniform 1;
} }
} }

View File

@ -1,7 +1,7 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/

View File

@ -15,9 +15,11 @@ FoamFile
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
psiChemistryModel ODEChemistryModel<gasThermoPhysics>;
chemistry off; chemistry off;
chemistrySolver ODE; chemistrySolver ode;
initialChemicalTimeStep 1e-07; initialChemicalTimeStep 1e-07;
@ -32,7 +34,7 @@ EulerImplicitCoeffs
equilibriumRateLimiter off; equilibriumRateLimiter off;
} }
ODECoeffs odeCoeffs
{ {
ODESolver SIBS; ODESolver SIBS;
eps 0.05; eps 0.05;

View File

@ -15,7 +15,7 @@ FoamFile
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
thermoType hMixtureThermo<reactingMixture>; thermoType hPsiMixtureThermo<reactingMixture<gasThermoPhysics>>;
CHEMKINFile "$FOAM_CASE/chemkin/chem.inp"; CHEMKINFile "$FOAM_CASE/chemkin/chem.inp";

View File

@ -23,22 +23,22 @@ boundaryField
{ {
front front
{ {
type alphatWallFunction; type compressible::alphatWallFunction;
value uniform 0; value uniform 0;
} }
back back
{ {
type alphatWallFunction; type compressible::alphatWallFunction;
value uniform 0; value uniform 0;
} }
wall wall
{ {
type alphatWallFunction; type compressible::alphatWallFunction;
value uniform 0; value uniform 0;
} }
porosityWall porosityWall
{ {
type alphatWallFunction; type compressible::alphatWallFunction;
value uniform 0; value uniform 0;
} }
inlet inlet

View File

@ -23,27 +23,27 @@ boundaryField
{ {
front front
{ {
type epsilonWallFunction; type compressible::epsilonWallFunction;
value uniform 200; value uniform 200;
} }
back back
{ {
type epsilonWallFunction; type compressible::epsilonWallFunction;
value uniform 200; value uniform 200;
} }
wall wall
{ {
type epsilonWallFunction; type compressible::epsilonWallFunction;
value uniform 200; value uniform 200;
} }
porosityWall porosityWall
{ {
type epsilonWallFunction; type compressible::epsilonWallFunction;
value uniform 200; value uniform 200;
} }
inlet inlet
{ {
type turbulentMixingLengthDissipationRateInlet; type compressible::turbulentMixingLengthDissipationRateInlet;
mixingLength 0.005; mixingLength 0.005;
value uniform 200; value uniform 200;
} }

View File

@ -23,22 +23,22 @@ boundaryField
{ {
front front
{ {
type kQRWallFunction; type compressible::kQRWallFunction;
value uniform 1; value uniform 1;
} }
back back
{ {
type kQRWallFunction; type compressible::kQRWallFunction;
value uniform 1; value uniform 1;
} }
wall wall
{ {
type kQRWallFunction; type compressible::kQRWallFunction;
value uniform 1; value uniform 1;
} }
porosityWall porosityWall
{ {
type kQRWallFunction; type compressible::kQRWallFunction;
value uniform 1; value uniform 1;
} }
inlet inlet

View File

@ -22,25 +22,25 @@ boundaryField
{ {
floor floor
{ {
type calculated; type fixedFluxBuoyantPressure;
value uniform 100000; value uniform 100000;
} }
ceiling ceiling
{ {
type calculated; type fixedFluxBuoyantPressure;
value uniform 100000; value uniform 100000;
} }
fixedWalls fixedWalls
{ {
type calculated; type fixedFluxBuoyantPressure;
value uniform 100000; value uniform 100000;
} }
box box
{ {
type calculated; type fixedFluxBuoyantPressure;
value uniform 100000; value uniform 100000;
} }
} }

View File

@ -1,48 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 |
| \\ / A nd | Web: http://www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class volScalarField;
object pd;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [1 -1 -2 0 0 0 0];
internalField uniform 0;
boundaryField
{
floor
{
type fixedFluxBuoyantPressure;
value uniform 0;
}
ceiling
{
type fixedFluxBuoyantPressure;
value uniform 0;
}
fixedWalls
{
type fixedFluxBuoyantPressure;
value uniform 0;
}
box
{
type fixedFluxBuoyantPressure;
value uniform 0;
}
}
// ************************************************************************* //

View File

@ -41,7 +41,7 @@ laplacianSchemes
{ {
default none; default none;
laplacian(muEff,U) Gauss linear corrected; laplacian(muEff,U) Gauss linear corrected;
laplacian((rho*(1|A(U))),pd) Gauss linear corrected; laplacian((rho*(1|A(U))),p) Gauss linear corrected;
laplacian(alphaEff,h) Gauss linear corrected; laplacian(alphaEff,h) Gauss linear corrected;
laplacian(DkEff,k) Gauss linear corrected; laplacian(DkEff,k) Gauss linear corrected;
laplacian(DepsilonEff,epsilon) Gauss linear corrected; laplacian(DepsilonEff,epsilon) Gauss linear corrected;
@ -62,7 +62,7 @@ snGradSchemes
fluxRequired fluxRequired
{ {
default no; default no;
pd ; p;
} }

View File

@ -17,7 +17,7 @@ FoamFile
solvers solvers
{ {
pd p
{ {
solver PCG; solver PCG;
preconditioner DIC; preconditioner DIC;
@ -69,14 +69,14 @@ solvers
SIMPLE SIMPLE
{ {
nNonOrthogonalCorrectors 0; nNonOrthogonalCorrectors 0;
pdRefCell 0; pRefCell 0;
pdRefValue 0; pRefValue 0;
} }
relaxationFactors relaxationFactors
{ {
rho 1; rho 1;
pd 0.3; p 0.3;
U 0.7; U 0.7;
h 0.7; h 0.7;
k 0.7; k 0.7;

View File

@ -22,25 +22,25 @@ boundaryField
{ {
floor floor
{ {
type calculated; type fixedFluxBuoyantPressure;
value uniform 100000; value uniform 100000;
} }
ceiling ceiling
{ {
type calculated; type fixedFluxBuoyantPressure;
value uniform 100000; value uniform 100000;
} }
fixedWalls fixedWalls
{ {
type calculated; type fixedFluxBuoyantPressure;
value uniform 100000; value uniform 100000;
} }
box box
{ {
type calculated; type fixedFluxBuoyantPressure;
value uniform 100000; value uniform 100000;
} }
} }

View File

@ -1,48 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 |
| \\ / A nd | Web: http://www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class volScalarField;
object pd;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [1 -1 -2 0 0 0 0];
internalField uniform 0;
boundaryField
{
floor
{
type fixedFluxBuoyantPressure;
value uniform 0;
}
ceiling
{
type fixedFluxBuoyantPressure;
value uniform 0;
}
fixedWalls
{
type fixedFluxBuoyantPressure;
value uniform 0;
}
box
{
type fixedFluxBuoyantPressure;
value uniform 0;
}
}
// ************************************************************************* //

View File

@ -42,7 +42,7 @@ laplacianSchemes
{ {
default none; default none;
laplacian(muEff,U) Gauss linear corrected; laplacian(muEff,U) Gauss linear corrected;
laplacian((rho*(1|A(U))),pd) Gauss linear corrected; laplacian((rho*(1|A(U))),p) Gauss linear corrected;
laplacian(alphaEff,h) Gauss linear corrected; laplacian(alphaEff,h) Gauss linear corrected;
laplacian(DkEff,k) Gauss linear corrected; laplacian(DkEff,k) Gauss linear corrected;
laplacian(DepsilonEff,epsilon) Gauss linear corrected; laplacian(DepsilonEff,epsilon) Gauss linear corrected;
@ -63,7 +63,7 @@ snGradSchemes
fluxRequired fluxRequired
{ {
default no; default no;
pd ; p;
} }

View File

@ -17,7 +17,7 @@ FoamFile
solvers solvers
{ {
pd p
{ {
solver GAMG; solver GAMG;
tolerance 1e-06; tolerance 1e-06;
@ -73,14 +73,14 @@ solvers
SIMPLE SIMPLE
{ {
nNonOrthogonalCorrectors 0; nNonOrthogonalCorrectors 0;
pdRefCell 0; pRefCell 0;
pdRefValue 0; pRefValue 0;
} }
relaxationFactors relaxationFactors
{ {
rho 1.0; rho 1.0;
pd 0.3; p 0.3;
U 0.7; U 0.7;
h 0.7; h 0.7;
k 0.7; k 0.7;

View File

@ -15,13 +15,13 @@ runApplication splitMeshRegions -cellZones
for i in bottomAir topAir heater leftSolid rightSolid for i in bottomAir topAir heater leftSolid rightSolid
do do
changeDictionary -region $i changeDictionary -region $i >& log.changeDictionary.$i
done done
# remove fluid fields from solid regions (important for post-processing) # remove fluid fields from solid regions (important for post-processing)
for i in heater leftSolid rightSolid for i in heater leftSolid rightSolid
do do
rm -f 0*/$i/{mut,alphat,epsilon,k,p,pd,U} rm -f 0*/$i/{mut,alphat,epsilon,k,p,p,U}
done done
# remove solid fields from fluid regions (important for post-processing) # remove solid fields from fluid regions (important for post-processing)
@ -37,7 +37,7 @@ done
# Decompose # Decompose
for i in bottomAir topAir heater leftSolid rightSolid for i in bottomAir topAir heater leftSolid rightSolid
do do
decomposePar -region $i decomposePar -region $i >& log.decomposePar.$i
done done
# Run # Run
@ -47,7 +47,7 @@ runParallel chtMultiRegionFoam 4 system/machines
# Reconstruct # Reconstruct
for i in bottomAir topAir heater leftSolid rightSolid for i in bottomAir topAir heater leftSolid rightSolid
do do
reconstructPar -region $i reconstructPar -region $i >& log.reconstructPar.$i
done done

View File

@ -1,11 +1,13 @@
#!/bin/sh #!/bin/sh
set -x
m4 < constant/polyMesh/blockMeshDict.m4 > constant/polyMesh/blockMeshDict m4 < constant/polyMesh/blockMeshDict.m4 > constant/polyMesh/blockMeshDict
blockMesh blockMesh >& log.blockMesh
cellSet cellSet >& log.cellSet
#- MRF determines its own faceZone if not supplied #- MRF determines its own faceZone if not supplied
#cp system/faceSetDict_rotorFaces system/faceSetDict #cp system/faceSetDict_rotorFaces system/faceSetDict
#faceSet #faceSet
#cp system/faceSetDict_noBoundaryFaces system/faceSetDict #cp system/faceSetDict_noBoundaryFaces system/faceSetDict
#faceSet #faceSet
setsToZones -noFlipMap setsToZones -noFlipMap >& log.setsToZones

View File

@ -17,7 +17,7 @@ FoamFile
radiation off; radiation off;
radiationModel noRadiation; radiationModel none;
solverFreq 10; solverFreq 10;

View File

@ -4,9 +4,10 @@ EXE_INC = \
-I$(LIB_SRC)/finiteVolume/lnInclude \ -I$(LIB_SRC)/finiteVolume/lnInclude \
-I$(LIB_SRC)/thermophysicalModels/specie/lnInclude \ -I$(LIB_SRC)/thermophysicalModels/specie/lnInclude \
-I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \ -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \
-I$(LIB_SRC)/thermophysicalModels/combustion/lnInclude \ -I$(LIB_SRC)/thermophysicalModels/reactionThermo/lnInclude \
-I$(LIB_SRC)/thermophysicalModels/radiation/lnInclude \ -I$(LIB_SRC)/thermophysicalModels/radiation/lnInclude \
-I$(LIB_SRC)/turbulenceModels/compressible/turbulenceModel \ -I$(LIB_SRC)/turbulenceModels/compressible/turbulenceModel \
-I$(LIB_SRC)/meshTools/lnInclude
EXE_LIBS = \ EXE_LIBS = \
-llagrangian \ -llagrangian \
@ -15,7 +16,7 @@ EXE_LIBS = \
-lmeshTools \ -lmeshTools \
-lthermophysicalFunctions \ -lthermophysicalFunctions \
-lbasicThermophysicalModels \ -lbasicThermophysicalModels \
-lcombustionThermophysicalModels \ -lreactionThermophysicalModels \
-lspecie \ -lspecie \
-lradiation \ -lradiation \
-lcompressibleRASModels \ -lcompressibleRASModels \

View File

@ -4,8 +4,8 @@
+ fvm::div(phi, U) + fvm::div(phi, U)
+ turbulence->divDevRhoReff(U) + turbulence->divDevRhoReff(U)
== ==
thermoCloud1.SU1() thermoCloud1.SU()
+ kinematicCloud1.SU1() + kinematicCloud1.SU()
+ rho.dimensionedInternalField()*g + rho.dimensionedInternalField()*g
); );

View File

@ -5,7 +5,7 @@
rho, rho,
U, U,
g, g,
thermo() thermo
); );
Info<< "Constructing kinematicCloud1" << endl; Info<< "Constructing kinematicCloud1" << endl;
@ -14,7 +14,7 @@
"kinematicCloud1", "kinematicCloud1",
rho, rho,
U, U,
thermo().mu(), thermo.mu(),
g g
); );

View File

@ -1,13 +1,14 @@
Info<< "Reading thermophysical properties\n" << endl; Info<< "Reading thermophysical properties\n" << endl;
autoPtr<basicThermo> thermo autoPtr<basicPsiThermo> pThermo
( (
basicThermo::New(mesh) basicPsiThermo::New(mesh)
); );
basicPsiThermo& thermo = pThermo();
volScalarField& p = thermo->p(); volScalarField& p = thermo.p();
volScalarField& h = thermo->h(); volScalarField& h = thermo.h();
const volScalarField& psi = thermo->psi(); const volScalarField& psi = thermo.psi();
volScalarField rho volScalarField rho
( (
@ -19,7 +20,7 @@
IOobject::NO_READ, IOobject::NO_READ,
IOobject::AUTO_WRITE IOobject::AUTO_WRITE
), ),
thermo->rho() thermo.rho()
); );
Info<< "\nReading field U\n" << endl; Info<< "\nReading field U\n" << endl;
@ -48,7 +49,7 @@
rho, rho,
U, U,
phi, phi,
thermo() thermo
) )
); );

View File

@ -6,12 +6,12 @@
- fvm::laplacian(turbulence->alphaEff(), h) - fvm::laplacian(turbulence->alphaEff(), h)
== ==
DpDt DpDt
+ thermoCloud1.Sh1() + thermoCloud1.Sh()
); );
hEqn.relax(); hEqn.relax();
hEqn.solve(); hEqn.solve();
thermo->correct(); thermo.correct();
} }

View File

@ -1,4 +1,4 @@
rho = thermo->rho(); rho = thermo.rho();
volScalarField rUA = 1.0/UEqn.A(); volScalarField rUA = 1.0/UEqn.A();
U = rUA*UEqn.H(); U = rUA*UEqn.H();
@ -8,7 +8,7 @@ if (transonic)
surfaceScalarField phid surfaceScalarField phid
( (
"phid", "phid",
fvc::interpolate(thermo->psi()) fvc::interpolate(psi)
*( *(
(fvc::interpolate(U) & mesh.Sf()) (fvc::interpolate(U) & mesh.Sf())
+ fvc::ddtPhiCorr(rUA, rho, U, phi) + fvc::ddtPhiCorr(rUA, rho, U, phi)
@ -35,8 +35,8 @@ if (transonic)
else else
{ {
phi = phi =
fvc::interpolate(rho)* fvc::interpolate(rho)
( *(
(fvc::interpolate(U) & mesh.Sf()) (fvc::interpolate(U) & mesh.Sf())
+ fvc::ddtPhiCorr(rUA, rho, U, phi) + fvc::ddtPhiCorr(rUA, rho, U, phi)
); );

View File

@ -31,7 +31,7 @@ Description
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "fvCFD.H" #include "fvCFD.H"
#include "basicThermo.H" #include "basicPsiThermo.H"
#include "turbulenceModel.H" #include "turbulenceModel.H"
#include "basicThermoCloud.H" #include "basicThermoCloud.H"
@ -41,7 +41,6 @@ Description
int main(int argc, char *argv[]) int main(int argc, char *argv[])
{ {
#include "setRootCase.H" #include "setRootCase.H"
#include "createTime.H" #include "createTime.H"
@ -55,7 +54,7 @@ int main(int argc, char *argv[])
#include "compressibleCourantNo.H" #include "compressibleCourantNo.H"
#include "setInitialDeltaT.H" #include "setInitialDeltaT.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
Info<< "\nStarting time loop\n" << endl; Info<< "\nStarting time loop\n" << endl;
@ -70,11 +69,9 @@ int main(int argc, char *argv[])
Info<< "Time = " << runTime.timeName() << nl << endl; Info<< "Time = " << runTime.timeName() << nl << endl;
Info<< "Evolving thermoCloud1" << endl;
thermoCloud1.evolve(); thermoCloud1.evolve();
thermoCloud1.info(); thermoCloud1.info();
Info<< "Evolving kinematicCloud1" << endl;
kinematicCloud1.evolve(); kinematicCloud1.evolve();
kinematicCloud1.info(); kinematicCloud1.info();
@ -96,7 +93,7 @@ int main(int argc, char *argv[])
turbulence->correct(); turbulence->correct();
rho = thermo->rho(); rho = thermo.rho();
runTime.write(); runTime.write();

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
location "0";
object epsilon; object epsilon;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -22,28 +23,28 @@ boundaryField
{ {
top top
{ {
type zeroGradient; type compressible::epsilonWallFunction;
value uniform 5390.5;
} }
bottom bottom
{ {
type zeroGradient; type compressible::epsilonWallFunction;
value uniform 5390.5;
} }
walls walls
{ {
type zeroGradient; type compressible::epsilonWallFunction;
value uniform 5390.5;
} }
symmetry symmetry
{ {
type symmetryPlane; type symmetryPlane;
} }
frontAndBack frontAndBack
{ {
type empty; type empty;
} }
} }
// ************************************************************************* // // ************************************************************************* //

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
location "0";
object k; object k;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -22,28 +23,28 @@ boundaryField
{ {
top top
{ {
type zeroGradient; type compressible::kQRWallFunction;
value uniform 37.5;
} }
bottom bottom
{ {
type zeroGradient; type compressible::kQRWallFunction;
value uniform 37.5;
} }
walls walls
{ {
type zeroGradient; type compressible::kQRWallFunction;
value uniform 37.5;
} }
symmetry symmetry
{ {
type symmetryPlane; type symmetryPlane;
} }
frontAndBack frontAndBack
{ {
type empty; type empty;
} }
} }
// ************************************************************************* // // ************************************************************************* //

View File

@ -21,20 +21,27 @@ DragModel SphereDrag;
DispersionModel StochasticDispersionRAS; DispersionModel StochasticDispersionRAS;
WallInteractionModel StandardWallInteraction; PatchInteractionModel StandardWallInteraction;
minParticleMass minParticleMass [ 1 0 0 0 0 ] 1e-15; PostProcessingModel none;
rho0 rho0 [ 1 -3 0 0 0 ] 5000;
coupled true; coupled true;
cellValueSourceCorrection on;
parcelTypeId 2; parcelTypeId 2;
constantProperties
{
rhoMin rhoMin [ 1 -3 0 0 0 ] 1e-15;
minParticleMass minParticleMass [ 1 0 0 0 0 ] 1e-15;
rho0 rho0 [ 1 -3 0 0 0 ] 5000;
}
interpolationSchemes interpolationSchemes
{ {
rho cell; rho cell;
U cellPointFace; U cellPoint;
mu cell; mu cell;
} }
@ -43,12 +50,21 @@ integrationSchemes
U Euler; U Euler;
} }
particleForces
{
gravity on;
virtualMass off;
Cvm 0.5;
pressureGradient off;
gradU gradU;
}
ManualInjectionCoeffs ManualInjectionCoeffs
{ {
parcelBasisType mass;
massTotal massTotal [ 1 0 0 0 0 ] 0.0002; massTotal massTotal [ 1 0 0 0 0 ] 0.0002;
parcelBasisType mass;
SOI 0; SOI 0;
positionsFile kinematicCloud1Positions; positionsFile "kinematicCloud1Positions";
U0 ( 0 0 0 ); U0 ( 0 0 0 );
parcelPDF parcelPDF
{ {
@ -70,29 +86,10 @@ ConeInjectionCoeffs
position ( 0.25 0.25 0.05 ); position ( 0.25 0.25 0.05 );
direction ( 0 -1 0 ); direction ( 0 -1 0 );
parcelsPerSecond 10000; parcelsPerSecond 10000;
volumeFlowRate Constant; volumeFlowRate Constant 0.01;
volumeFlowRateCoeffs Umag Constant 50;
{ thetaInner Constant 0;
value 0.01; thetaOuter Constant 30;
}
Umag Constant;
UmagCoeffs
{
value 50;
}
thetaInner Constant;
thetaInnerCoeffs
{
value 0;
}
thetaOuter Constant;
thetaOuterCoeffs
{
value 30;
}
parcelPDF parcelPDF
{ {

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class polyBoundaryMesh; class polyBoundaryMesh;
location "constant/polyMesh";
object boundary; object boundary;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -21,33 +21,37 @@ DragModel SphereDrag;
DispersionModel StochasticDispersionRAS; DispersionModel StochasticDispersionRAS;
WallInteractionModel StandardWallInteraction; PatchInteractionModel StandardWallInteraction;
HeatTransferModel RanzMarshall; HeatTransferModel RanzMarshall;
PostProcessingModel none;
radiation off; radiation off;
minParticleMass minParticleMass [ 1 0 0 0 0 ] 1e-15;
rho0 rho0 [ 1 -3 0 0 0 ] 2500;
T0 T0 [ 0 0 0 1 0 ] 300;
cp0 cp0 [ 0 2 -2 -1 0 ] 900;
epsilon0 epsilon0 [ 0 0 0 0 0 ] 1;
f0 f0 [ 0 0 0 0 0 ] 0.5;
coupled true; coupled true;
cellValueSourceCorrection on;
parcelTypeId 1; parcelTypeId 1;
constantProperties
{
rhoMin rhoMin [ 1 -3 0 0 0 ] 1e-15;
TMin TMin [ 0 0 0 1 0 ] 200;
minParticleMass minParticleMass [ 1 0 0 0 0 ] 1e-15;
rho0 rho0 [ 1 -3 0 0 0 ] 2500;
T0 T0 [ 0 0 0 1 0 ] 300;
cp0 cp0 [ 0 2 -2 -1 0 ] 900;
epsilon0 epsilon0 [ 0 0 0 0 0 ] 1;
f0 f0 [ 0 0 0 0 0 ] 0.5;
}
interpolationSchemes interpolationSchemes
{ {
rho cell; rho cell;
U cellPointFace;
mu cell; mu cell;
U cellPoint;
T cell; T cell;
Cp cell; Cp cell;
} }
@ -58,12 +62,21 @@ integrationSchemes
T Analytical; T Analytical;
} }
particleForces
{
gravity on;
virtualMass off;
Cvm 0.5;
pressureGradient off;
gradU gradU;
}
ManualInjectionCoeffs ManualInjectionCoeffs
{ {
massTotal massTotal [ 1 0 0 0 0 ] 0.0001; massTotal massTotal [ 1 0 0 0 0 ] 0.0001;
parcelBasisType mass; parcelBasisType mass;
SOI 0; SOI 0;
positionsFile thermoCloud1Positions; positionsFile "thermoCloud1Positions";
U0 ( 0 0 0 ); U0 ( 0 0 0 );
parcelPDF parcelPDF
{ {

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: 1.5.x |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,11 +10,12 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class dictionary; class dictionary;
object spray; location "constant";
object turbulenceProperties;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
( simulationType RASModel;
)
// ************************************************************************* // // ************************************************************************* //

View File

@ -8,7 +8,7 @@
FoamFile FoamFile
{ {
version 2.0; version 2.0;
format binary; format ascii;
class dictionary; class dictionary;
location "system"; location "system";
object cellSetDict.1; object cellSetDict.1;
@ -19,7 +19,13 @@ name c0;
action new; action new;
topoSetSources ( boxToCell { box ( 0.004 -0.001 -1 ) ( 0.012 0.001 1 ) ; } ); topoSetSources
(
boxToCell
{
box (0.004 -0.001 -1) (0.012 0.001 1);
}
);
// ************************************************************************* // // ************************************************************************* //

View File

@ -8,7 +8,7 @@
FoamFile FoamFile
{ {
version 2.0; version 2.0;
format binary; format ascii;
class dictionary; class dictionary;
location "system"; location "system";
object cellSetDict.2; object cellSetDict.2;
@ -19,7 +19,13 @@ name c0;
action new; action new;
topoSetSources ( boxToCell { box ( 0.0045 -0.00075 -1 ) ( 0.0095 0.00075 1 ) ; } ); topoSetSources
(
boxToCell
{
box (0.0045 -0.00075 -1) (0.0095 0.00075 1);
}
);
// ************************************************************************* // // ************************************************************************* //

View File

@ -8,7 +8,7 @@
FoamFile FoamFile
{ {
version 2.0; version 2.0;
format binary; format ascii;
class dictionary; class dictionary;
location "system"; location "system";
object cellSetDict.3; object cellSetDict.3;
@ -19,7 +19,13 @@ name c0;
action new; action new;
topoSetSources ( boxToCell { box ( 0.00475 -0.000375 -1 ) ( 0.009 0.000375 1 ) ; } ); topoSetSources
(
boxToCell
{
box (0.00475 -0.000375 -1) (0.009 0.000375 1);
}
);
// ************************************************************************* // // ************************************************************************* //

View File

@ -8,7 +8,7 @@
FoamFile FoamFile
{ {
version 2.0; version 2.0;
format binary; format ascii;
class dictionary; class dictionary;
location "system"; location "system";
object cellSetDict.1; object cellSetDict.1;
@ -19,7 +19,13 @@ name c0;
action new; action new;
topoSetSources ( boxToCell { box ( 0.004 -0.001 -1 ) ( 0.012 0.001 1 ) ; } ); topoSetSources
(
boxToCell
{
box ( 0.004 -0.001 -1 ) ( 0.012 0.001 1 );
}
);
// ************************************************************************* // // ************************************************************************* //

View File

@ -8,7 +8,7 @@
FoamFile FoamFile
{ {
version 2.0; version 2.0;
format binary; format ascii;
class dictionary; class dictionary;
location "system"; location "system";
object cellSetDict.2; object cellSetDict.2;
@ -19,7 +19,13 @@ name c0;
action new; action new;
topoSetSources ( boxToCell { box ( 0.0045 -0.00075 -1 ) ( 0.0095 0.00075 1 ) ; } ); topoSetSources
(
boxToCell
{
box ( 0.0045 -0.00075 -1 ) ( 0.0095 0.00075 1 );
}
);
// ************************************************************************* // // ************************************************************************* //

View File

@ -8,7 +8,7 @@
FoamFile FoamFile
{ {
version 2.0; version 2.0;
format binary; format ascii;
class dictionary; class dictionary;
location "system"; location "system";
object cellSetDict.3; object cellSetDict.3;
@ -19,7 +19,13 @@ name c0;
action new; action new;
topoSetSources ( boxToCell { box ( 0.00475 -0.000375 -1 ) ( 0.009 0.000375 1 ) ; } ); topoSetSources
(
boxToCell
{
box ( 0.00475 -0.000375 -1 ) ( 0.009 0.000375 1 );
}
);
// ************************************************************************* // // ************************************************************************* //

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object pd; object p;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -7,6 +7,6 @@ application="compressibleInterFoam"
runApplication blockMesh runApplication blockMesh
cp 0/alpha1.org 0/alpha1 cp 0/alpha1.org 0/alpha1
cp 0/pd.org 0/pd cp 0/p.org 0/p
runApplication setFields runApplication setFields
runApplication $application runApplication $application

View File

@ -30,7 +30,7 @@ divSchemes
div(rho*phi,U) Gauss upwind; div(rho*phi,U) Gauss upwind;
div(phi,alpha) Gauss vanLeer; div(phi,alpha) Gauss vanLeer;
div(phirb,alpha) Gauss interfaceCompression 1; div(phirb,alpha) Gauss interfaceCompression 1;
div(phi,pd) Gauss upwind; div(phi,p) Gauss upwind;
div(phi,k) Gauss vanLeer; div(phi,k) Gauss vanLeer;
div((nuEff*dev(grad(U).T()))) Gauss linear; div((nuEff*dev(grad(U).T()))) Gauss linear;
} }
@ -53,7 +53,7 @@ snGradSchemes
fluxRequired fluxRequired
{ {
default no; default no;
pd ; p;
pcorr; pcorr;
gamma; gamma;
} }

View File

@ -45,7 +45,7 @@ solvers
solver diagonal; solver diagonal;
} }
pd p
{ {
solver GAMG; solver GAMG;
tolerance 1e-07; tolerance 1e-07;
@ -60,7 +60,7 @@ solvers
mergeLevels 1; mergeLevels 1;
} }
pdFinal pFinal
{ {
solver PCG; solver PCG;
preconditioner preconditioner

View File

@ -15,9 +15,33 @@ FoamFile
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
defaultFieldValues ( volScalarFieldValue alpha1 1 volScalarFieldValue pd 100000 ); defaultFieldValues
(
volScalarFieldValue alpha1 1
volScalarFieldValue p 100000
);
regions ( sphereToCell { centre ( 0.5 0.5 0 ) ; radius 0.1 ; fieldValues ( volScalarFieldValue alpha1 0 volScalarFieldValue pd 1000000 ) ; } boxToCell { box ( -10 1 -1 ) ( 10 10 1 ) ; fieldValues ( volScalarFieldValue alpha1 0 ) ; } ); regions
(
sphereToCell
{
centre ( 0.5 0.5 0 );
radius 0.1;
fieldValues
(
volScalarFieldValue alpha1 0
volScalarFieldValue p 1000000
);
}
boxToCell
{
box ( -10 1 -1 ) ( 10 10 1 );
fieldValues
(
volScalarFieldValue alpha1 0
);
}
);
// ************************************************************************* // // ************************************************************************* //

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object pd.org; object p.org;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -2,4 +2,4 @@
foamCleanTutorials cases foamCleanTutorials cases
rm -rf processor* rm -rf processor*
rm -rf 0/pd.gz 0/alpha1.gz rm -rf 0/p.gz 0/alpha1.gz

View File

@ -7,7 +7,7 @@ application="compressibleInterFoam"
runApplication blockMesh runApplication blockMesh
cp 0/alpha1.org 0/alpha1 cp 0/alpha1.org 0/alpha1
cp 0/pd.org 0/pd cp 0/p.org 0/p
runApplication setFields runApplication setFields
runApplication decomposePar runApplication decomposePar
hostname > system/machines hostname > system/machines

View File

@ -30,7 +30,7 @@ divSchemes
div(rho*phi,U) Gauss upwind; div(rho*phi,U) Gauss upwind;
div(phi,alpha) Gauss vanLeer; div(phi,alpha) Gauss vanLeer;
div(phirb,alpha) Gauss interfaceCompression 1; div(phirb,alpha) Gauss interfaceCompression 1;
div(phi,pd) Gauss upwind; div(phi,p) Gauss upwind;
div(phi,k) Gauss vanLeer; div(phi,k) Gauss vanLeer;
div((nuEff*dev(grad(U).T()))) Gauss linear; div((nuEff*dev(grad(U).T()))) Gauss linear;
} }
@ -53,7 +53,7 @@ snGradSchemes
fluxRequired fluxRequired
{ {
default no; default no;
pd ; p;
pcorr; pcorr;
gamma; gamma;
} }

View File

@ -45,7 +45,7 @@ solvers
solver diagonal; solver diagonal;
} }
pd p
{ {
solver GAMG; solver GAMG;
tolerance 1e-07; tolerance 1e-07;
@ -60,7 +60,7 @@ solvers
mergeLevels 1; mergeLevels 1;
} }
pdFinal pFinal
{ {
solver PCG; solver PCG;
preconditioner preconditioner

View File

@ -15,9 +15,33 @@ FoamFile
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
defaultFieldValues ( volScalarFieldValue alpha1 1 volScalarFieldValue pd 100000 ); defaultFieldValues
(
volScalarFieldValue alpha1 1
volScalarFieldValue p 100000
);
regions ( sphereToCell { centre ( 0.5 0.5 0.5 ) ; radius 0.1 ; fieldValues ( volScalarFieldValue alpha1 0 volScalarFieldValue pd 1000000 ) ; } boxToCell { box ( -10 1 -1 ) ( 10 10 1 ) ; fieldValues ( volScalarFieldValue alpha1 0 ) ; } ); regions
(
sphereToCell
{
centre ( 0.5 0.5 0.5 );
radius 0.1;
fieldValues
(
volScalarFieldValue alpha1 0
volScalarFieldValue p 1000000
);
}
boxToCell
{
box ( -10 1 -1 ) ( 10 10 1 );
fieldValues
(
volScalarFieldValue alpha1 0
);
}
);
// ************************************************************************* // // ************************************************************************* //

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object pd; object p;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object pd; object p;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -52,7 +52,7 @@ snGradSchemes
fluxRequired fluxRequired
{ {
default no; default no;
pd ; p;
pcorr; pcorr;
alpha; alpha;
} }

View File

@ -40,7 +40,7 @@ solvers
maxIter 100; maxIter 100;
} }
pd p
{ {
solver GAMG; solver GAMG;
tolerance 1e-08; tolerance 1e-08;
@ -55,7 +55,7 @@ solvers
mergeLevels 1; mergeLevels 1;
} }
pdFinal pFinal
{ {
solver PCG; solver PCG;
preconditioner preconditioner
@ -122,8 +122,7 @@ PISO
nAlphaSubCycles 3; nAlphaSubCycles 3;
cAlpha 1; cAlpha 1;
pdRefPoint (0.51 0.51 0.51); pRefPoint (0.51 0.51 0.51);
pdRefValue 0;
pRefValue 0; pRefValue 0;
} }

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object pd; object p;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -54,7 +54,7 @@ functions
probes probes
{ {
type probes; type probes;
name probes; functionObjectLibs ( "libsampling.so" );
outputControl timeStep; outputControl timeStep;
outputInterval 1; outputInterval 1;
probeLocations probeLocations

View File

@ -52,7 +52,7 @@ snGradSchemes
fluxRequired fluxRequired
{ {
default no; default no;
pd ; p;
pcorr; pcorr;
alpha; alpha;
} }

View File

@ -40,7 +40,7 @@ solvers
maxIter 100; maxIter 100;
} }
pd p
{ {
solver GAMG; solver GAMG;
tolerance 1e-08; tolerance 1e-08;
@ -55,7 +55,7 @@ solvers
mergeLevels 1; mergeLevels 1;
} }
pdFinal pFinal
{ {
solver PCG; solver PCG;
preconditioner preconditioner
@ -99,8 +99,7 @@ PISO
cAlpha 1.5; cAlpha 1.5;
correctPhi no; correctPhi no;
pdRefPoint (0 0 0.15); pRefPoint (0 0 0.15);
pdRefValue 0;
pRefValue 1e5; pRefValue 1e5;
} }

View File

@ -25,7 +25,10 @@ regions
boxToCell boxToCell
{ {
box ( -100 -100 -100 ) ( 100 100 0 ); box ( -100 -100 -100 ) ( 100 100 0 );
fieldValues ( volScalarFieldValue alpha1 1 ); fieldValues
(
volScalarFieldValue alpha1 1
);
} }
); );

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object pd; object p;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -52,7 +52,7 @@ snGradSchemes
fluxRequired fluxRequired
{ {
default no; default no;
pd ; p;
pcorr; pcorr;
alpha; alpha;
} }

View File

@ -40,7 +40,7 @@ solvers
maxIter 100; maxIter 100;
} }
pd p
{ {
solver GAMG; solver GAMG;
tolerance 1e-08; tolerance 1e-08;
@ -55,7 +55,7 @@ solvers
mergeLevels 1; mergeLevels 1;
} }
pdFinal pFinal
{ {
solver PCG; solver PCG;
preconditioner preconditioner
@ -99,8 +99,7 @@ PISO
cAlpha 1.5; cAlpha 1.5;
correctPhi no; correctPhi no;
pdRefPoint (0 0 0.15); pRefPoint (0 0 0.15);
pdRefValue 0;
pRefValue 1e5; pRefValue 1e5;
} }

View File

@ -25,7 +25,10 @@ regions
boxToCell boxToCell
{ {
box ( -100 -100 -100 ) ( 100 100 0 ); box ( -100 -100 -100 ) ( 100 100 0 );
fieldValues ( volScalarFieldValue alpha1 1 ); fieldValues
(
volScalarFieldValue alpha1 1
);
} }
); );

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object pd; object p;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -52,7 +52,7 @@ snGradSchemes
fluxRequired fluxRequired
{ {
default no; default no;
pd ; p;
pcorr; pcorr;
alpha; alpha;
} }

View File

@ -40,7 +40,7 @@ solvers
maxIter 100; maxIter 100;
} }
pd p
{ {
solver GAMG; solver GAMG;
tolerance 1e-08; tolerance 1e-08;
@ -55,7 +55,7 @@ solvers
mergeLevels 1; mergeLevels 1;
} }
pdFinal pFinal
{ {
solver PCG; solver PCG;
preconditioner preconditioner
@ -99,8 +99,7 @@ PISO
cAlpha 1.5; cAlpha 1.5;
correctPhi no; correctPhi no;
pdRefPoint (0 0 0.15); pRefPoint (0 0 0.15);
pdRefValue 0;
pRefValue 1e5; pRefValue 1e5;
} }

View File

@ -25,7 +25,10 @@ regions
boxToCell boxToCell
{ {
box ( -100 -100 -100 ) ( 100 100 0 ); box ( -100 -100 -100 ) ( 100 100 0 );
fieldValues ( volScalarFieldValue alpha1 1 ); fieldValues
(
volScalarFieldValue alpha1 1
);
} }
); );

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object pd; object p;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -52,7 +52,7 @@ snGradSchemes
fluxRequired fluxRequired
{ {
default no; default no;
pd ; p;
pcorr; pcorr;
alpha; alpha;
} }

View File

@ -40,7 +40,7 @@ solvers
maxIter 100; maxIter 100;
} }
pd p
{ {
solver GAMG; solver GAMG;
tolerance 1e-08; tolerance 1e-08;
@ -55,7 +55,7 @@ solvers
mergeLevels 1; mergeLevels 1;
} }
pdFinal pFinal
{ {
solver PCG; solver PCG;
preconditioner preconditioner
@ -99,8 +99,7 @@ PISO
cAlpha 1.5; cAlpha 1.5;
correctPhi no; correctPhi no;
pdRefPoint (0 0 0.15); pRefPoint (0 0 0.15);
pdRefValue 0;
pRefValue 1e5; pRefValue 1e5;
} }

View File

@ -25,7 +25,10 @@ regions
boxToCell boxToCell
{ {
box ( -100 -100 -100 ) ( 100 100 0 ); box ( -100 -100 -100 ) ( 100 100 0 );
fieldValues ( volScalarFieldValue alpha1 1 ); fieldValues
(
volScalarFieldValue alpha1 1
);
} }
); );

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object pd; object p;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -52,7 +52,7 @@ snGradSchemes
fluxRequired fluxRequired
{ {
default no; default no;
pd ; p;
pcorr; pcorr;
alpha; alpha;
} }

View File

@ -40,7 +40,7 @@ solvers
maxIter 100; maxIter 100;
} }
pd p
{ {
solver GAMG; solver GAMG;
tolerance 1e-08; tolerance 1e-08;
@ -55,7 +55,7 @@ solvers
mergeLevels 1; mergeLevels 1;
} }
pdFinal pFinal
{ {
solver PCG; solver PCG;
preconditioner preconditioner
@ -99,8 +99,7 @@ PISO
cAlpha 1.5; cAlpha 1.5;
correctPhi no; correctPhi no;
pdRefPoint (0 0 0.15); pRefPoint (0 0 0.15);
pdRefValue 0;
pRefValue 1e5; pRefValue 1e5;
} }

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object pd; object p;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -52,7 +52,7 @@ snGradSchemes
fluxRequired fluxRequired
{ {
default no; default no;
pd ; p;
pcorr; pcorr;
alpha1; alpha1;
} }

View File

@ -25,7 +25,7 @@ solvers
relTol 0; relTol 0;
} }
pd p
{ {
solver PCG; solver PCG;
preconditioner DIC; preconditioner DIC;
@ -33,7 +33,7 @@ solvers
relTol 0.05; relTol 0.05;
} }
pdFinal pFinal
{ {
solver PCG; solver PCG;
preconditioner DIC; preconditioner DIC;

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object pd; object p;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -56,9 +56,9 @@ snGradSchemes
fluxRequired fluxRequired
{ {
default no; default no;
pd ; p;
pcorr; pcorr;
alpha1 ; alpha;
} }

View File

@ -40,7 +40,7 @@ solvers
maxIter 100; maxIter 100;
} }
pd p
{ {
solver GAMG; solver GAMG;
tolerance 1e-07; tolerance 1e-07;
@ -55,7 +55,7 @@ solvers
mergeLevels 1; mergeLevels 1;
} }
pdFinal pFinal
{ {
solver PCG; solver PCG;
preconditioner preconditioner

View File

@ -32,7 +32,7 @@ cloneCase damBreak damBreakFine
cd damBreakFine cd damBreakFine
# Modify case # Modify case
setDamBreakFine setDamBreakFine
cp ../damBreak/0/gamma.org 0/gamma cp ../damBreak/0/alpha1.org 0/alpha1
# And execute # And execute
runApplication blockMesh runApplication blockMesh
runApplication setFields runApplication setFields

View File

@ -1,8 +1,8 @@
/*--------------------------------*- C++ -*----------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.5 | | \\ / O peration | Version: dev |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
@ -10,6 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volVectorField; class volVectorField;
location "0";
object U; object U;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
@ -38,7 +39,6 @@ boundaryField
atmosphere atmosphere
{ {
type pressureInletOutletVelocity; type pressureInletOutletVelocity;
phi phi;
value uniform (0 0 0); value uniform (0 0 0);
} }
defaultFaces defaultFaces
@ -47,4 +47,5 @@ boundaryField
} }
} }
// ************************************************************************* // // ************************************************************************* //

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object gamma; object alpha1;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object gamma; object alpha1;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -24,28 +24,24 @@ boundaryField
leftWall leftWall
{ {
type epsilonWallFunction; type epsilonWallFunction;
value uniform 0; value uniform 0.1;
} }
rightWall rightWall
{ {
type epsilonWallFunction; type epsilonWallFunction;
value uniform 0; value uniform 0.1;
} }
lowerWall lowerWall
{ {
type epsilonWallFunction; type epsilonWallFunction;
value uniform 0; value uniform 0.1;
} }
atmosphere atmosphere
{ {
type inletOutlet; type inletOutlet;
inletValue uniform 0.1; inletValue uniform 0.1;
value uniform 0.1; value uniform 0.1;
} }
defaultFaces defaultFaces
{ {
type empty; type empty;

View File

@ -24,28 +24,24 @@ boundaryField
leftWall leftWall
{ {
type kQRWallFunction; type kQRWallFunction;
value uniform 0; value uniform 0.1;
} }
rightWall rightWall
{ {
type kQRWallFunction; type kQRWallFunction;
value uniform 0; value uniform 0.1;
} }
lowerWall lowerWall
{ {
type kQRWallFunction; type kQRWallFunction;
value uniform 0; value uniform 0.1;
} }
atmosphere atmosphere
{ {
type inletOutlet; type inletOutlet;
inletValue uniform 0.1; inletValue uniform 0.1;
value uniform 0.1; value uniform 0.1;
} }
defaultFaces defaultFaces
{ {
type empty; type empty;

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object pd; object p;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -28,8 +28,8 @@ gradSchemes
divSchemes divSchemes
{ {
div(rho*phi,U) Gauss linear; div(rho*phi,U) Gauss linear;
div(phi,gamma) Gauss vanLeer; div(phi,alpha) Gauss vanLeer;
div(phirb,gamma) Gauss interfaceCompression; div(phirb,alpha) Gauss interfaceCompression;
div(phi,k) Gauss upwind; div(phi,k) Gauss upwind;
div(phi,epsilon) Gauss upwind; div(phi,epsilon) Gauss upwind;
div(phi,R) Gauss upwind; div(phi,R) Gauss upwind;
@ -57,9 +57,9 @@ snGradSchemes
fluxRequired fluxRequired
{ {
default no; default no;
pd ; p;
pcorr; pcorr;
gamma ; alpha;
} }

View File

@ -25,7 +25,7 @@ solvers
relTol 0; relTol 0;
} }
pd p
{ {
solver PCG; solver PCG;
preconditioner DIC; preconditioner DIC;
@ -33,7 +33,7 @@ solvers
relTol 0.05; relTol 0.05;
} }
pdFinal pFinal
{ {
solver PCG; solver PCG;
preconditioner DIC; preconditioner DIC;
@ -87,9 +87,9 @@ PISO
momentumPredictor no; momentumPredictor no;
nCorrectors 3; nCorrectors 3;
nNonOrthogonalCorrectors 0; nNonOrthogonalCorrectors 0;
nGammaCorr 1; nAlphaCorr 1;
nGammaSubCycles 4; nAlphaSubCycles 4;
cGamma 2; cAlpha 2;
} }

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object pd; object p;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -40,7 +40,7 @@ solvers
maxIter 100; maxIter 100;
} }
pd p
{ {
solver GAMG; solver GAMG;
tolerance 1e-07; tolerance 1e-07;
@ -55,7 +55,7 @@ solvers
mergeLevels 1; mergeLevels 1;
} }
pdFinal pFinal
{ {
solver PCG; solver PCG;
preconditioner preconditioner

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0; version 2.0;
format ascii; format ascii;
class volScalarField; class volScalarField;
object pd; object p;
} }
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -40,7 +40,7 @@ solvers
maxIter 100; maxIter 100;
} }
pd p
{ {
solver GAMG; solver GAMG;
tolerance 1e-07; tolerance 1e-07;
@ -55,7 +55,7 @@ solvers
mergeLevels 1; mergeLevels 1;
} }
pdFinal pFinal
{ {
solver PCG; solver PCG;
preconditioner preconditioner