multiphase: Update phase-naming to use the new convention e.g. alpha.water

This commit is contained in:
Henry 2013-08-13 23:21:46 +01:00
parent 208f63027d
commit 2780df8365
177 changed files with 313 additions and 622 deletions

View File

@ -0,0 +1,11 @@
{
alphav = max(min((rho - rholSat)/(rhovSat - rholSat), scalar(1)), scalar(0));
alphal = 1.0 - alphav;
Info<< "max-min alphav: " << max(alphav).value()
<< " " << min(alphav).value() << endl;
psiModel->correct();
//Info<< "min a: " << 1.0/sqrt(max(psi)).value() << endl;
}

View File

@ -72,7 +72,7 @@ int main(int argc, char *argv[])
while (pimple.loop())
{
#include "rhoEqn.H"
#include "gammaPsi.H"
#include "alphavPsi.H"
#include "UEqn.H"
// --- Pressure corrector loop

View File

@ -1,5 +1,5 @@
{
volScalarField thermoRho = psi*p + gamma2*rhol0;
volScalarField thermoRho = psi*p + alphal*rhol0;
dimensionedScalar totalMass = fvc::domainIntegrate(rho);

View File

@ -44,19 +44,19 @@
Info<< "Reading transportProperties\n" << endl;
incompressibleTwoPhaseMixture twoPhaseProperties(U, phiv, "gamma");
incompressibleTwoPhaseMixture twoPhaseProperties(U, phiv);
volScalarField& gamma(twoPhaseProperties.alpha1());
gamma.oldTime();
volScalarField& alphav(twoPhaseProperties.alpha1());
alphav.oldTime();
volScalarField& gamma2(twoPhaseProperties.alpha2());
volScalarField& alphal(twoPhaseProperties.alpha2());
Info<< "Creating compressibilityModel\n" << endl;
autoPtr<barotropicCompressibilityModel> psiModel =
barotropicCompressibilityModel::New
(
thermodynamicProperties,
gamma
alphav
);
const volScalarField& psi = psiModel->psi();
@ -64,8 +64,8 @@
rho == max
(
psi*p
+ gamma2*rhol0
+ ((gamma*psiv + gamma2*psil) - psi)*pSat,
+ alphal*rhol0
+ ((alphav*psiv + alphal*psil) - psi)*pSat,
rhoMin
);

View File

@ -1,11 +0,0 @@
{
gamma = max(min((rho - rholSat)/(rhovSat - rholSat), scalar(1)), scalar(0));
gamma2 = 1.0 - gamma;
Info<< "max-min gamma: " << max(gamma).value()
<< " " << min(gamma).value() << endl;
psiModel->correct();
//Info<< "min a: " << 1.0/sqrt(max(psi)).value() << endl;
}

View File

@ -4,8 +4,8 @@
p =
(
rho
- gamma2*rhol0
- ((gamma*psiv + gamma2*psil) - psi)*pSat
- alphal*rhol0
- ((alphav*psiv + alphal*psil) - psi)*pSat
)/psi;
}
@ -29,7 +29,7 @@
fvScalarMatrix pEqn
(
fvm::ddt(psi, p)
- (rhol0 + (psil - psiv)*pSat)*fvc::ddt(gamma) - pSat*fvc::ddt(psi)
- (rhol0 + (psil - psiv)*pSat)*fvc::ddt(alphav) - pSat*fvc::ddt(psi)
+ fvc::div(phiv, rho)
+ fvc::div(phiGradp)
- fvm::laplacian(rAUf, p)
@ -49,18 +49,18 @@
rho == max
(
psi*p
+ gamma2*rhol0
+ ((gamma*psiv + gamma2*psil) - psi)*pSat,
+ alphal*rhol0
+ ((alphav*psiv + alphal*psil) - psi)*pSat,
rhoMin
);
#include "gammaPsi.H"
#include "alphavPsi.H"
p =
(
rho
- gamma2*rhol0
- ((gamma*psiv + gamma2*psil) - psi)*pSat
- alphal*rhol0
- ((alphav*psiv + alphal*psil) - psi)*pSat
)/psi;
p.correctBoundaryConditions();

View File

@ -49,12 +49,12 @@ Foam::twoPhaseMixtureThermo::twoPhaseMixtureThermo
thermo2_(NULL)
{
{
volScalarField T1("T" + phase1Name(), T_);
volScalarField T1(IOobject::groupName("T", phase1Name()), T_);
T1.write();
}
{
volScalarField T2("T" + phase2Name(), T_);
volScalarField T2(IOobject::groupName("T", phase2Name()), T_);
T2.write();
}

View File

@ -42,11 +42,10 @@ namespace phaseChangeTwoPhaseMixtures
Foam::phaseChangeTwoPhaseMixtures::Kunz::Kunz
(
const volVectorField& U,
const surfaceScalarField& phi,
const word& alpha1Name
const surfaceScalarField& phi
)
:
phaseChangeTwoPhaseMixture(typeName, U, phi, alpha1Name),
phaseChangeTwoPhaseMixture(typeName, U, phi),
UInf_(phaseChangeTwoPhaseMixtureCoeffs_.lookup("UInf")),
tInf_(phaseChangeTwoPhaseMixtureCoeffs_.lookup("tInf")),

View File

@ -91,8 +91,7 @@ public:
Kunz
(
const volVectorField& U,
const surfaceScalarField& phi,
const word& alpha1Name = "alpha1"
const surfaceScalarField& phi
);

View File

@ -42,11 +42,10 @@ namespace phaseChangeTwoPhaseMixtures
Foam::phaseChangeTwoPhaseMixtures::Merkle::Merkle
(
const volVectorField& U,
const surfaceScalarField& phi,
const word& alpha1Name
const surfaceScalarField& phi
)
:
phaseChangeTwoPhaseMixture(typeName, U, phi, alpha1Name),
phaseChangeTwoPhaseMixture(typeName, U, phi),
UInf_(phaseChangeTwoPhaseMixtureCoeffs_.lookup("UInf")),
tInf_(phaseChangeTwoPhaseMixtureCoeffs_.lookup("tInf")),

View File

@ -85,8 +85,7 @@ public:
Merkle
(
const volVectorField& U,
const surfaceScalarField& phi,
const word& alpha1Name = "alpha1"
const surfaceScalarField& phi
);

View File

@ -49,11 +49,10 @@ namespace phaseChangeTwoPhaseMixtures
Foam::phaseChangeTwoPhaseMixtures::SchnerrSauer::SchnerrSauer
(
const volVectorField& U,
const surfaceScalarField& phi,
const word& alpha1Name
const surfaceScalarField& phi
)
:
phaseChangeTwoPhaseMixture(typeName, U, phi, alpha1Name),
phaseChangeTwoPhaseMixture(typeName, U, phi),
n_(phaseChangeTwoPhaseMixtureCoeffs_.lookup("n")),
dNuc_(phaseChangeTwoPhaseMixtureCoeffs_.lookup("dNuc")),

View File

@ -98,8 +98,7 @@ public:
SchnerrSauer
(
const volVectorField& U,
const surfaceScalarField& phi,
const word& alpha1Name = "alpha1"
const surfaceScalarField& phi
);

View File

@ -32,8 +32,7 @@ Foam::autoPtr<Foam::phaseChangeTwoPhaseMixture>
Foam::phaseChangeTwoPhaseMixture::New
(
const volVectorField& U,
const surfaceScalarField& phi,
const word& alpha1Name
const surfaceScalarField& phi
)
{
IOdictionary transportPropertiesDict
@ -73,7 +72,7 @@ Foam::phaseChangeTwoPhaseMixture::New
<< exit(FatalError);
}
return autoPtr<phaseChangeTwoPhaseMixture>(cstrIter()(U, phi, alpha1Name));
return autoPtr<phaseChangeTwoPhaseMixture>(cstrIter()(U, phi));
}

View File

@ -39,11 +39,10 @@ Foam::phaseChangeTwoPhaseMixture::phaseChangeTwoPhaseMixture
(
const word& type,
const volVectorField& U,
const surfaceScalarField& phi,
const word& alpha1Name
const surfaceScalarField& phi
)
:
incompressibleTwoPhaseMixture(U, phi, alpha1Name),
incompressibleTwoPhaseMixture(U, phi),
phaseChangeTwoPhaseMixtureCoeffs_(subDict(type + "Coeffs")),
pSat_(lookup("pSat"))
{}

View File

@ -91,10 +91,9 @@ public:
components,
(
const volVectorField& U,
const surfaceScalarField& phi,
const word& alpha1Name
const surfaceScalarField& phi
),
(U, phi, alpha1Name)
(U, phi)
);
@ -104,8 +103,7 @@ public:
static autoPtr<phaseChangeTwoPhaseMixture> New
(
const volVectorField& U,
const surfaceScalarField& phi,
const word& alpha1Name = "alpha1"
const surfaceScalarField& phi
);
@ -116,8 +114,7 @@ public:
(
const word& type,
const volVectorField& U,
const surfaceScalarField& phi,
const word& alpha1Name = "alpha1"
const surfaceScalarField& phi
);

View File

@ -1,5 +1,5 @@
{
word alphaScheme("div(phi,alpha1)");
word alphaScheme("div(phi,alpha)");
surfaceScalarField phiAlpha
(

View File

@ -39,7 +39,8 @@ Foam::variableHeightFlowRateInletVelocityFvPatchVectorField
)
:
fixedValueFvPatchField<vector>(p, iF),
flowRate_(0)
flowRate_(0),
alphaName_("none")
{}
@ -53,7 +54,8 @@ Foam::variableHeightFlowRateInletVelocityFvPatchVectorField
)
:
fixedValueFvPatchField<vector>(ptf, p, iF, mapper),
flowRate_(ptf.flowRate_)
flowRate_(ptf.flowRate_),
alphaName_(ptf.alphaName_)
{}
@ -66,7 +68,8 @@ Foam::variableHeightFlowRateInletVelocityFvPatchVectorField
)
:
fixedValueFvPatchField<vector>(p, iF, dict),
flowRate_(readScalar(dict.lookup("flowRate")))
flowRate_(readScalar(dict.lookup("flowRate"))),
alphaName_(dict.lookup("alpha"))
{}
@ -77,7 +80,8 @@ Foam::variableHeightFlowRateInletVelocityFvPatchVectorField
)
:
fixedValueFvPatchField<vector>(ptf),
flowRate_(ptf.flowRate_)
flowRate_(ptf.flowRate_),
alphaName_(ptf.alphaName_)
{}
@ -89,7 +93,8 @@ Foam::variableHeightFlowRateInletVelocityFvPatchVectorField
)
:
fixedValueFvPatchField<vector>(ptf, iF),
flowRate_(ptf.flowRate_)
flowRate_(ptf.flowRate_),
alphaName_(ptf.alphaName_)
{}
@ -104,7 +109,7 @@ void Foam::variableHeightFlowRateInletVelocityFvPatchVectorField
}
scalarField alphap =
patch().lookupPatchField<volScalarField, scalar>("alpha1");
patch().lookupPatchField<volScalarField, scalar>(alphaName_);
alphap = max(alphap, scalar(0));
alphap = min(alphap, scalar(1));
@ -129,6 +134,8 @@ void Foam::variableHeightFlowRateInletVelocityFvPatchVectorField::write
os.writeKeyword("flowRate") << flowRate_
<< token::END_STATEMENT << nl;
os.writeKeyword("alpha") << alphaName_
<< token::END_STATEMENT << nl;
writeEntry("value", os);
}

View File

@ -39,6 +39,7 @@ Description
\table
Property | Description | Required | Default value
flowRate | volumetric flow rate [m3/s] | yes |
alpha | phase-fraction field | yes |
\endtable
Example of the boundary condition specification:
@ -47,6 +48,7 @@ Description
{
type variableHeightFlowRateInletVelocity;
flowRate 0.2;
alpha alpha.water;
value uniform (0 0 0); // placeholder
}
\endverbatim
@ -87,6 +89,9 @@ class variableHeightFlowRateInletVelocityFvPatchVectorField
//- Inlet integral flow rate
scalar flowRate_;
//- Name of the phase-fraction field
word alphaName_;
public:

View File

@ -53,9 +53,7 @@ void Foam::incompressibleTwoPhaseMixture::calcNu()
Foam::incompressibleTwoPhaseMixture::incompressibleTwoPhaseMixture
(
const volVectorField& U,
const surfaceScalarField& phi,
const word& alpha1Name,
const word& alpha2Name
const surfaceScalarField& phi
)
:
IOdictionary
@ -69,14 +67,14 @@ Foam::incompressibleTwoPhaseMixture::incompressibleTwoPhaseMixture
IOobject::NO_WRITE
)
),
twoPhaseMixture(U.mesh(), *this, alpha1Name, alpha2Name),
twoPhaseMixture(U.mesh(), *this),
nuModel1_
(
viscosityModel::New
(
"nu1",
subDict(phase1Name_ == "1" ? "phase1": phase1Name_),
subDict(phase1Name_),
U,
phi
)
@ -86,7 +84,7 @@ Foam::incompressibleTwoPhaseMixture::incompressibleTwoPhaseMixture
viscosityModel::New
(
"nu2",
subDict(phase2Name_ == "2" ? "phase2": phase2Name_),
subDict(phase2Name_),
U,
phi
)

View File

@ -86,9 +86,7 @@ public:
incompressibleTwoPhaseMixture
(
const volVectorField& U,
const surfaceScalarField& phi,
const word& alpha1Name = "alpha1",
const word& alpha2Name = "alpha2"
const surfaceScalarField& phi
);

View File

@ -31,29 +31,17 @@ License
Foam::twoPhaseMixture::twoPhaseMixture
(
const fvMesh& mesh,
const dictionary& dict,
const word& alpha1Name,
const word& alpha2Name
const dictionary& dict
)
:
phase1Name_
(
dict.found("phases")
? wordList(dict.lookup("phases"))[0]
: "1"
),
phase2Name_
(
dict.found("phases")
? wordList(dict.lookup("phases"))[1]
: "2"
),
phase1Name_(wordList(dict.lookup("phases"))[0]),
phase2Name_(wordList(dict.lookup("phases"))[1]),
alpha1_
(
IOobject
(
dict.found("phases") ? word("alpha" + phase1Name_) : alpha1Name,
IOobject::groupName("alpha", phase1Name_),
mesh.time().timeName(),
mesh,
IOobject::MUST_READ,
@ -66,7 +54,7 @@ Foam::twoPhaseMixture::twoPhaseMixture
(
IOobject
(
dict.found("phases") ? word("alpha" + phase2Name_) : alpha2Name,
IOobject::groupName("alpha", phase2Name_),
mesh.time().timeName(),
mesh
),

View File

@ -67,9 +67,7 @@ public:
twoPhaseMixture
(
const fvMesh& mesh,
const dictionary& dict,
const word& alpha1Name = "alpha1",
const word& alpha2Name = "alpha2"
const dictionary& dict
);

View File

@ -8,7 +8,7 @@ cd ${0%/*} || exit 1 # run from this directory
\rm -f constant/triSurface/wigley-scaled-oriented.stl.gz
cleanCase
rm 0/alpha1.gz 0/cellLevel.gz 0/pointLevel.gz constant/polyMesh/boundary \
rm 0/alpha.water.gz 0/cellLevel.gz 0/pointLevel.gz constant/polyMesh/boundary \
> /dev/null 2>&1
# ----------------------------------------------------------------- end-of-file

View File

@ -13,7 +13,7 @@ if [ ! -e log.transformPoints ]
then
transformPoints -scale '(2 1 1)' > log.transformPoints 2>&1
fi
cp 0/alpha1.org 0/alpha1
cp 0/alpha.water.org 0/alpha.water
runApplication setFields
runApplication `getApplication`

View File

@ -15,14 +15,16 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
phase1
phases (water air);
water
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1e-06;
rho rho [ 1 -3 0 0 0 0 0 ] 1000;
}
phase2
air
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1.48e-05;

View File

@ -55,7 +55,7 @@ fluxRequired
default no;
p_rgh;
pcorr;
alpha1;
alpha.water;
}

View File

@ -17,7 +17,7 @@ FoamFile
solvers
{
alpha1
alpha.water
{
nAlphaCorr 1;
nAlphaSubCycles 1;

View File

@ -17,7 +17,7 @@ FoamFile
defaultFieldValues
(
volScalarFieldValue alpha1 0
volScalarFieldValue alpha.water 0
);
regions
@ -27,7 +27,7 @@ regions
box (-100 -100 -100) (100 100 0);
fieldValues
(
volScalarFieldValue alpha1 1
volScalarFieldValue alpha.water 1
);
}
);

View File

@ -11,7 +11,7 @@ FoamFile
format ascii;
class volScalarField;
location "0";
object alpha1;
object alpha.water;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

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

View File

@ -15,14 +15,16 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
phase1
phases (water oir);
water
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1e-4;
rho rho [ 1 -3 0 0 0 0 0 ] 1000;
}
phase2
oir
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1e-4;

View File

@ -53,7 +53,7 @@ fluxRequired
default no;
p_rgh ;
pcorr ;
alpha1 ;
alpha.water ;
}

View File

@ -17,7 +17,7 @@ FoamFile
solvers
{
alpha1
alpha.water
{
nAlphaCorr 1;
nAlphaSubCycles 2;

View File

@ -17,7 +17,7 @@ FoamFile
defaultFieldValues
(
volScalarFieldValue alpha1 0
volScalarFieldValue alpha.water 0
);
regions
@ -27,7 +27,7 @@ regions
box (0 0 -1) (1 1 1);
fieldValues
(
volScalarFieldValue alpha1 1
volScalarFieldValue alpha.water 1
);
}
);

View File

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

View File

@ -19,14 +19,9 @@ mul mul [ 1 -1 -1 0 0 ] 0.0065;
muv muv [ 1 -1 -1 0 0 ] 5.953e-06;
twoPhase
{
transportModel twoPhase;
phase1 phase1;
phase2 phase2;
}
phases (vapour water);
phase1
water
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 7.831e-06;
@ -48,7 +43,7 @@ phase1
}
}
phase2
vapour
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 4.252e-05;

View File

@ -73,7 +73,7 @@ functions
base time;
}
gamma
alpha.vapour
{
mean on;
prime2Mean off;

View File

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

View File

@ -1,48 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class volVectorField;
object U;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [0 1 -1 0 0];
internalField uniform (0 0 0);
boundaryField
{
inlet
{
type zeroGradient;
value uniform (0 0 0);
}
outlet
{
type zeroGradient;
value uniform (0 0 0);
}
walls
{
type fixedValue;
value uniform (0 0 0);
}
frontBack
{
type fixedValue;
value uniform (0 0 0);
}
}
// ************************************************************************* //

View File

@ -1,48 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class volScalarField;
object gamma;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [0 0 0 0 0];
internalField uniform 0;
boundaryField
{
inlet
{
type calculated;
value uniform 0;
}
outlet
{
type calculated;
value uniform 0;
}
walls
{
type calculated;
value uniform 0;
}
frontBack
{
type calculated;
value uniform 0;
}
}
// ************************************************************************* //

View File

@ -1,47 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class volScalarField;
object k;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [0 2 -2 0 0];
internalField uniform 10;
boundaryField
{
inlet
{
type turbulentIntensityKineticEnergyInlet;
intensity 0.05;
value uniform 0.05;
}
outlet
{
type zeroGradient;
}
walls
{
type kqRWallFunction;
value uniform 10;
}
frontBack
{
type zeroGradient;
}
}
// ************************************************************************* //

View File

@ -1,47 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class volScalarField;
location "0";
object nuSgs;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [0 2 -1 0 0 0 0];
internalField uniform 0;
boundaryField
{
inlet
{
type calculated;
value uniform 0;
}
outlet
{
type calculated;
value uniform 0;
}
walls
{
type nutUSpaldingWallFunction;
value uniform 0;
}
frontBack
{
type nutUSpaldingWallFunction;
value uniform 0;
}
}
// ************************************************************************* //

View File

@ -1,51 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class volScalarField;
object p;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [1 -1 -2 0 0];
internalField uniform 300e5;
boundaryField
{
inlet
{
type totalPressure;
U U;
phi phiv;
rho rho;
psi none;
gamma 1;
p0 uniform 300e5;
}
outlet
{
type fixedValue;
value uniform 100e5;
}
walls
{
type zeroGradient;
}
frontBack
{
type zeroGradient;
}
}
// ************************************************************************* //

View File

@ -1,46 +0,0 @@
/*--------------------------------*- C++ -*----------------------------------*\
| ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: dev |
| \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | |
\*---------------------------------------------------------------------------*/
FoamFile
{
version 2.0;
format ascii;
class volScalarField;
object rho;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
dimensions [1 -3 0 0 0];
internalField uniform 845;
boundaryField
{
inlet
{
type fixedValue;
value uniform 845;
}
outlet
{
type fixedValue;
value uniform 835;
}
walls
{
type zeroGradient;
}
frontBack
{
type zeroGradient;
}
}
// ************************************************************************* //

View File

@ -6,7 +6,6 @@ cd ${0%/*} || exit 1 # run from this directory
rm -rf constant/polyMesh/sets > /dev/null 2>&1
rm -rf 0 > /dev/null 2>&1
cp -r 0.org 0
rm system/topoSetDict > /dev/null 2>&1
rm -rf processor[0-9] > /dev/null 2>&1
cleanCase

View File

@ -19,14 +19,9 @@ mul mul [ 1 -1 -1 0 0 ] 0.0065;
muv muv [ 1 -1 -1 0 0 ] 5.953e-06;
twoPhase
{
transportModel twoPhase;
phase1 phase1;
phase2 phase2;
}
phases (vapour water);
phase1
water
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 7.831e-06;
@ -48,7 +43,7 @@ phase1
}
}
phase2
vapour
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 4.252e-05;

View File

@ -73,7 +73,7 @@ functions
base time;
}
gamma
alpha.vapour
{
mean on;
prime2Mean off;

View File

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

View File

@ -19,14 +19,9 @@ mul mul [ 1 -1 -1 0 0 ] 0.0065;
muv muv [ 1 -1 -1 0 0 ] 5.953e-06;
twoPhase
{
transportModel twoPhase;
phase1 phase1;
phase2 phase2;
}
phases (vapour water);
phase1
water
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 7.831e-06;
@ -48,7 +43,7 @@ phase1
}
}
phase2
vapour
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 4.252e-05;

View File

@ -10,7 +10,7 @@ FoamFile
version 2.0;
format ascii;
class volScalarField;
object alphawater;
object alpha.water;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -3,4 +3,4 @@ cd ${0%/*} || exit 1 # run from this directory
foamCleanTutorials cases
rm -rf processor*
rm -rf 0/p_rgh.gz 0/p.gz 0/alphawater.gz 0/T*.gz
rm -rf 0/p_rgh.gz 0/p.gz 0/alpha.water.gz 0/T*.gz

View File

@ -8,7 +8,7 @@ cd ${0%/*} || exit 1 # run from this directory
application=`getApplication`
runApplication blockMesh
cp 0/alphawater.org 0/alphawater
cp 0/alpha.water.org 0/alpha.water
cp 0/p_rgh.org 0/p_rgh
cp 0/p.org 0/p
cp 0/T.org 0/T

View File

@ -31,8 +31,8 @@ divSchemes
div(phirb,alpha) Gauss interfaceCompression 1;
div(rho*phi,U) Gauss upwind;
div(phi,thermo:rhowater) Gauss upwind;
div(phi,thermo:rhoair) Gauss upwind;
div(phi,thermo:rho.water) Gauss upwind;
div(phi,thermo:rho.air) Gauss upwind;
div(rho*phi,T) Gauss upwind;
div(rho*phi,K) Gauss upwind;
div(phi,p) Gauss upwind;

View File

@ -17,7 +17,7 @@ FoamFile
solvers
{
alphawater
alpha.water
{
nAlphaCorr 1;
nAlphaSubCycles 1;

View File

@ -17,7 +17,7 @@ FoamFile
defaultFieldValues
(
volScalarFieldValue alphawater 1
volScalarFieldValue alpha.water 1
volScalarFieldValue p_rgh 1e5
volScalarFieldValue p 1e5
volScalarFieldValue T 300
@ -31,7 +31,7 @@ regions
radius 0.1;
fieldValues
(
volScalarFieldValue alphawater 0
volScalarFieldValue alpha.water 0
volScalarFieldValue p_rgh 1e6
volScalarFieldValue p 1e6
volScalarFieldValue T 578
@ -42,7 +42,7 @@ regions
box (-10 1 -1) (10 10 1);
fieldValues
(
volScalarFieldValue alphawater 0
volScalarFieldValue alpha.water 0
);
}
);

View File

@ -3,6 +3,6 @@ cd ${0%/*} || exit 1 # run from this directory
foamCleanTutorials cases
rm -rf processor*
rm -rf 0/p_rgh.gz 0/p.gz 0/alphawater.gz 0/T.gz
rm -rf 0/p_rgh.gz 0/p.gz 0/alpha.water.gz 0/T.gz
# ----------------------------------------------------------------- end-of-file

View File

@ -8,7 +8,7 @@ cd ${0%/*} || exit 1 # run from this directory
application=`getApplication`
runApplication blockMesh
cp 0/alphawater.org 0/alphawater
cp 0/alpha.water.org 0/alpha.water
cp 0/p_rgh.org 0/p_rgh
cp 0/p.org 0/p
cp 0/T.org 0/T

View File

@ -31,8 +31,8 @@ divSchemes
div(phirb,alpha) Gauss interfaceCompression 1;
div(rho*phi,U) Gauss upwind;
div(phi,thermo:rhowater) Gauss upwind;
div(phi,thermo:rhoair) Gauss upwind;
div(phi,thermo:rho.water) Gauss upwind;
div(phi,thermo:rho.air) Gauss upwind;
div(rho*phi,T) Gauss upwind;
div(rho*phi,K) Gauss upwind;
div(phi,p) Gauss upwind;

View File

@ -17,7 +17,7 @@ FoamFile
solvers
{
alphawater
alpha.water
{
nAlphaCorr 1;
nAlphaSubCycles 1;

View File

@ -17,7 +17,7 @@ FoamFile
defaultFieldValues
(
volScalarFieldValue alphawater 1
volScalarFieldValue alpha.water 1
volScalarFieldValue p_rgh 1e5
volScalarFieldValue p 1e5
volScalarFieldValue T 300
@ -31,7 +31,7 @@ regions
radius 0.1;
fieldValues
(
volScalarFieldValue alphawater 0
volScalarFieldValue alpha.water 0
volScalarFieldValue p_rgh 1e6
volScalarFieldValue p 1e6
volScalarFieldValue T 578
@ -42,7 +42,7 @@ regions
box (-10 1 -1) (10 10 1);
fieldValues
(
volScalarFieldValue alphawater 0
volScalarFieldValue alpha.water 0
);
}
);

View File

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

View File

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

View File

@ -22,7 +22,7 @@ dynamicRefineFvMeshCoeffs
// How often to refine
refineInterval 1;
// Field to be refinement on
field alpha1;
field alpha.water;
// Refine field inbetween lower..upper
lowerRefineLevel 0.001;
upperRefineLevel 0.999;

View File

@ -15,7 +15,9 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
phase1
phases (water air);
water
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1e-06;
@ -37,7 +39,7 @@ phase1
}
}
phase2
air
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1.48e-05;

View File

@ -17,7 +17,7 @@ FoamFile
solvers
{
alpha1
alpha.water
{
nAlphaCorr 1;
nAlphaSubCycles 3;

View File

@ -17,7 +17,7 @@ FoamFile
defaultFieldValues
(
volScalarFieldValue alpha1 0
volScalarFieldValue alpha.water 0
volVectorFieldValue U ( 0 0 0 )
);
@ -28,7 +28,7 @@ regions
box ( 0 0 0 ) ( 0.6 0.1875 0.75 );
fieldValues
(
volScalarFieldValue alpha1 1
volScalarFieldValue alpha.water 1
);
}
);

View File

@ -11,7 +11,7 @@ FoamFile
format ascii;
class volScalarField;
location "0";
object alpha1;
object alpha.water;
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -15,14 +15,16 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
phase1
phases (water air);
water
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1e-06;
rho rho [ 1 -3 0 0 0 0 0 ] 998.2;
}
phase2
air
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1.48e-05;

View File

@ -29,7 +29,7 @@ solvers
mergeLevels 1;
}
alpha1
alpha.water
{
nAlphaCorr 1;
nAlphaSubCycles 3;

View File

@ -17,7 +17,7 @@ FoamFile
defaultFieldValues
(
volScalarFieldValue alpha1 0
volScalarFieldValue alpha.water 0
);
regions
@ -25,13 +25,13 @@ regions
boxToCell
{
box ( -100 -100 -100 ) ( 100 100 0.5368 );
fieldValues ( volScalarFieldValue alpha1 1 );
fieldValues ( volScalarFieldValue alpha.water 1 );
}
boxToCell
{
box ( 0.7 0.8 -100 ) ( 100 100 0.65 );
fieldValues ( volScalarFieldValue alpha1 1 );
fieldValues ( volScalarFieldValue alpha.water 1 );
}
);

View File

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

View File

@ -15,21 +15,16 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
twoPhase
{
transportModel twoPhase;
phase1 phase1;
phase2 phase2;
}
phases (water air);
phase1
water
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1e-06;
rho rho [ 1 -3 0 0 0 0 0 ] 300;
}
phase2
air
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1e-6;

View File

@ -17,7 +17,7 @@ FoamFile
solvers
{
alpha1
alpha.water
{
nAlphaCorr 1;
nAlphaSubCycles 2;

View File

@ -17,7 +17,7 @@ FoamFile
defaultFieldValues
(
volScalarFieldValue alpha1 1
volScalarFieldValue alpha.water 1
);
regions
@ -27,7 +27,7 @@ regions
box (-4 -4 -1) (4 4 0.74);
fieldValues
(
volScalarFieldValue alpha1 0
volScalarFieldValue alpha.water 0
);
}
);

View File

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

View File

@ -2,6 +2,6 @@
cd ${0%/*} || exit 1 # run from this directory
foamCleanTutorials cases
rm -rf 0/alpha1 0/alpha1.gz probes wallPressure pRefProbe
rm -rf 0/alpha.water 0/alpha.water.gz probes wallPressure pRefProbe
# ----------------------------------------------------------------- end-of-file

View File

@ -6,7 +6,7 @@ cd ${0%/*} || exit 1 # run from this directory
m4 constant/polyMesh/blockMeshDict.m4 > constant/polyMesh/blockMeshDict
runApplication blockMesh
cp 0/alpha1.org 0/alpha1
cp 0/alpha.water.org 0/alpha.water
runApplication setFields
runApplication `getApplication`

View File

@ -15,14 +15,16 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
phase1
phases (water air);
water
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1e-06;
rho rho [ 1 -3 0 0 0 0 0 ] 998.2;
}
phase2
air
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1.48e-05;

View File

@ -17,7 +17,7 @@ FoamFile
solvers
{
alpha1
alpha.water
{
nAlphaCorr 1;
nAlphaSubCycles 3;

View File

@ -17,7 +17,7 @@ FoamFile
defaultFieldValues
(
volScalarFieldValue alpha1 0
volScalarFieldValue alpha.water 0
);
regions
@ -27,7 +27,7 @@ regions
box ( -100 -100 -100 ) ( 100 100 0 );
fieldValues
(
volScalarFieldValue alpha1 1
volScalarFieldValue alpha.water 1
);
}
);

View File

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

View File

@ -2,6 +2,6 @@
cd ${0%/*} || exit 1 # run from this directory
foamCleanTutorials cases
rm -rf 0/alpha1 0/alpha1.gz probes wallPressure pRefProbe
rm -rf 0/alpha.water 0/alpha.water.gz probes wallPressure pRefProbe
# ----------------------------------------------------------------- end-of-file

View File

@ -6,7 +6,7 @@ cd ${0%/*} || exit 1 # run from this directory
m4 constant/polyMesh/blockMeshDict.m4 > constant/polyMesh/blockMeshDict
runApplication blockMesh
cp 0/alpha1.org 0/alpha1
cp 0/alpha.water.org 0/alpha.water
runApplication setFields
runApplication `getApplication`

View File

@ -15,14 +15,16 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
phase1
phases (water air);
water
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1e-06;
rho rho [ 1 -3 0 0 0 0 0 ] 998.2;
}
phase2
air
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1.48e-05;

View File

@ -17,7 +17,7 @@ FoamFile
solvers
{
alpha1
alpha.water
{
nAlphaCorr 1;
nAlphaSubCycles 3;

View File

@ -17,7 +17,7 @@ FoamFile
defaultFieldValues
(
volScalarFieldValue alpha1 0
volScalarFieldValue alpha.water 0
);
regions
@ -27,7 +27,7 @@ regions
box ( -100 -100 -100 ) ( 100 100 0 );
fieldValues
(
volScalarFieldValue alpha1 1
volScalarFieldValue alpha.water 1
);
}
);

View File

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

View File

@ -2,6 +2,6 @@
cd ${0%/*} || exit 1 # run from this directory
foamCleanTutorials cases
rm -rf 0/alpha1 0/alpha1.gz probes wallPressure pRefProbe
rm -rf 0/alpha.water 0/alpha.water.gz probes wallPressure pRefProbe
# ----------------------------------------------------------------- end-of-file

View File

@ -6,7 +6,7 @@ cd ${0%/*} || exit 1 # run from this directory
m4 constant/polyMesh/blockMeshDict.m4 > constant/polyMesh/blockMeshDict
runApplication blockMesh
cp 0/alpha1.org 0/alpha1
cp 0/alpha.water.org 0/alpha.water
runApplication setFields
runApplication `getApplication`

View File

@ -15,14 +15,16 @@ FoamFile
}
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
phase1
phases (water air);
water
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1e-06;
rho rho [ 1 -3 0 0 0 0 0 ] 998.2;
}
phase2
air
{
transportModel Newtonian;
nu nu [ 0 2 -1 0 0 0 0 ] 1.48e-05;

View File

@ -17,7 +17,7 @@ FoamFile
solvers
{
alpha1
alpha.water
{
nAlphaCorr 1;
nAlphaSubCycles 3;

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