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

This commit is contained in:
andy
2010-06-23 09:45:34 +01:00
1506 changed files with 15484 additions and 5274 deletions

23
TODO Normal file
View File

@ -0,0 +1,23 @@
- check
new fvMesh
new fvMeshSubset
for consistency with createMesh.H
- Check the following:
doc/changes/inotify.txt

View File

@ -7,7 +7,7 @@
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@
"turbulenceProperties", "turbulenceProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -23,7 +23,7 @@
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -39,7 +39,7 @@
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -50,10 +50,11 @@ PDRkEpsilon::PDRkEpsilon
const volScalarField& rho, const volScalarField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const basicThermo& thermophysicalModel const basicThermo& thermophysicalModel,
const word& turbulenceModelName
) )
: :
RASModel(typeName, rho, U, phi, thermophysicalModel), RASModel(typeName, rho, U, phi, thermophysicalModel, turbulenceModelName),
Cmu_ Cmu_
( (

View File

@ -112,7 +112,8 @@ public:
const volScalarField& rho, const volScalarField& rho,
const volVectorField& U, const volVectorField& U,
const surfaceScalarField& phi, const surfaceScalarField& phi,
const basicThermo& thermophysicalModel const basicThermo& thermophysicalModel,
const word& turbulenceModelName = turbulenceModel::typeName
); );

View File

@ -62,7 +62,7 @@ Foam::XiEqModels::SCOPEXiEq::SCOPEXiEq
"combustionProperties", "combustionProperties",
Su.mesh().time().constant(), Su.mesh().time().constant(),
Su.mesh(), Su.mesh(),
IOobject::MUST_READ IOobject::MUST_READ_IF_MODIFIED
) )
), ),
thermo thermo

View File

@ -110,7 +110,7 @@
"PDRProperties", "PDRProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@
"combustionProperties", "combustionProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@
"combustionProperties", "combustionProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@ IOdictionary combustionProperties
"combustionProperties", "combustionProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -65,7 +65,7 @@ IOdictionary combustionProperties
"combustionProperties", "combustionProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@ IOdictionary chemistryProperties
"chemistryProperties", "chemistryProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE, IOobject::NO_WRITE,
false false
) )

View File

@ -7,7 +7,7 @@ IOdictionary chemistryProperties
"chemistryProperties", "chemistryProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE, IOobject::NO_WRITE,
false false
) )

View File

@ -29,14 +29,9 @@ License
#include "volFields.H" #include "volFields.H"
#include "mathematicalConstants.H" #include "mathematicalConstants.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
namespace Foam
{
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
smoluchowskiJumpTFvPatchScalarField::smoluchowskiJumpTFvPatchScalarField Foam::smoluchowskiJumpTFvPatchScalarField::smoluchowskiJumpTFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
@ -52,7 +47,8 @@ smoluchowskiJumpTFvPatchScalarField::smoluchowskiJumpTFvPatchScalarField
valueFraction() = 0.0; valueFraction() = 0.0;
} }
smoluchowskiJumpTFvPatchScalarField::smoluchowskiJumpTFvPatchScalarField
Foam::smoluchowskiJumpTFvPatchScalarField::smoluchowskiJumpTFvPatchScalarField
( (
const smoluchowskiJumpTFvPatchScalarField& ptf, const smoluchowskiJumpTFvPatchScalarField& ptf,
const fvPatch& p, const fvPatch& p,
@ -67,7 +63,7 @@ smoluchowskiJumpTFvPatchScalarField::smoluchowskiJumpTFvPatchScalarField
{} {}
smoluchowskiJumpTFvPatchScalarField::smoluchowskiJumpTFvPatchScalarField Foam::smoluchowskiJumpTFvPatchScalarField::smoluchowskiJumpTFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
@ -118,7 +114,7 @@ smoluchowskiJumpTFvPatchScalarField::smoluchowskiJumpTFvPatchScalarField
} }
smoluchowskiJumpTFvPatchScalarField::smoluchowskiJumpTFvPatchScalarField Foam::smoluchowskiJumpTFvPatchScalarField::smoluchowskiJumpTFvPatchScalarField
( (
const smoluchowskiJumpTFvPatchScalarField& ptpsf, const smoluchowskiJumpTFvPatchScalarField& ptpsf,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
@ -134,7 +130,7 @@ smoluchowskiJumpTFvPatchScalarField::smoluchowskiJumpTFvPatchScalarField
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
// Map from self // Map from self
void smoluchowskiJumpTFvPatchScalarField::autoMap void Foam::smoluchowskiJumpTFvPatchScalarField::autoMap
( (
const fvPatchFieldMapper& m const fvPatchFieldMapper& m
) )
@ -144,7 +140,7 @@ void smoluchowskiJumpTFvPatchScalarField::autoMap
// Reverse-map the given fvPatchField onto this fvPatchField // Reverse-map the given fvPatchField onto this fvPatchField
void smoluchowskiJumpTFvPatchScalarField::rmap void Foam::smoluchowskiJumpTFvPatchScalarField::rmap
( (
const fvPatchField<scalar>& ptf, const fvPatchField<scalar>& ptf,
const labelList& addr const labelList& addr
@ -155,7 +151,7 @@ void smoluchowskiJumpTFvPatchScalarField::rmap
// Update the coefficients associated with the patch field // Update the coefficients associated with the patch field
void smoluchowskiJumpTFvPatchScalarField::updateCoeffs() void Foam::smoluchowskiJumpTFvPatchScalarField::updateCoeffs()
{ {
if (updated()) if (updated())
{ {
@ -174,11 +170,16 @@ void smoluchowskiJumpTFvPatchScalarField::updateCoeffs()
// Prandtl number reading consistent with rhoCentralFoam // Prandtl number reading consistent with rhoCentralFoam
const dictionary& thermophysicalProperties = const dictionary& thermophysicalProperties =
db().lookupObject<IOdictionary>("thermophysicalProperties"); db().lookupObject<IOdictionary>("thermophysicalProperties");
dimensionedScalar Pr = dimensionedScalar("Pr", dimless, 1.0);
if (thermophysicalProperties.found("Pr")) dimensionedScalar Pr
{ (
Pr = thermophysicalProperties.lookup("Pr"); dimensionedScalar::lookupOrDefault
} (
"Pr",
thermophysicalProperties,
1.0
)
);
Field<scalar> C2 = pmu/prho Field<scalar> C2 = pmu/prho
*sqrt(ppsi*constant::mathematical::piByTwo) *sqrt(ppsi*constant::mathematical::piByTwo)
@ -197,7 +198,7 @@ void smoluchowskiJumpTFvPatchScalarField::updateCoeffs()
// Write // Write
void smoluchowskiJumpTFvPatchScalarField::write(Ostream& os) const void Foam::smoluchowskiJumpTFvPatchScalarField::write(Ostream& os) const
{ {
fvPatchScalarField::write(os); fvPatchScalarField::write(os);
os.writeKeyword("accommodationCoeff") os.writeKeyword("accommodationCoeff")
@ -211,10 +212,12 @@ void smoluchowskiJumpTFvPatchScalarField::write(Ostream& os) const
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
namespace Foam
{
makePatchTypeField(fvPatchScalarField, smoluchowskiJumpTFvPatchScalarField); makePatchTypeField(fvPatchScalarField, smoluchowskiJumpTFvPatchScalarField);
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // }
} // End namespace Foam
// ************************************************************************* // // ************************************************************************* //

View File

@ -1,7 +1,6 @@
word fluxScheme("Kurganov"); word fluxScheme("Kurganov");
if (mesh.schemesDict().found("fluxScheme")) if (mesh.schemesDict().readIfPresent("fluxScheme", fluxScheme))
{ {
fluxScheme = word(mesh.schemesDict().lookup("fluxScheme"));
if ((fluxScheme == "Tadmor") || (fluxScheme == "Kurganov")) if ((fluxScheme == "Tadmor") || (fluxScheme == "Kurganov"))
{ {
Info<< "fluxScheme: " << fluxScheme << endl; Info<< "fluxScheme: " << fluxScheme << endl;

View File

@ -9,14 +9,18 @@ IOdictionary thermophysicalProperties
"thermophysicalProperties", "thermophysicalProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );
dimensionedScalar Pr = dimensionedScalar("Pr", dimless, 1.0); dimensionedScalar Pr
(
dimensionedScalar::lookupOrDefault
(
"Pr",
thermophysicalProperties,
1.0
)
);
if (thermophysicalProperties.found("Pr"))
{
Pr = thermophysicalProperties.lookup("Pr");
}

View File

@ -70,22 +70,13 @@
dimensionedScalar initialMass = fvc::domainIntegrate(rho); dimensionedScalar initialMass = fvc::domainIntegrate(rho);
thermalPorousZones pZones(mesh); thermalPorousZones pZones(mesh);
Switch pressureImplicitPorosity(false);
// nUCorrectors used for pressureImplicitPorosity
int nUCorr = 0; int nUCorr = 0;
if (pZones.size()) const bool pressureImplicitPorosity =
{ (
// nUCorrectors for pressureImplicitPorosity pZones.size()
if (mesh.solutionDict().subDict("SIMPLE").found("nUCorrectors")) && mesh.solutionDict().subDict("SIMPLE").readIfPresent("nUCorrectors", nUCorr)
{ && (nUCorr > 0)
nUCorr = readInt );
(
mesh.solutionDict().subDict("SIMPLE").lookup("nUCorrectors")
);
}
if (nUCorr > 0)
{
pressureImplicitPorosity = true;
}
}

View File

@ -7,7 +7,7 @@
"thermodynamicProperties", "thermodynamicProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@
"thermodynamicProperties", "thermodynamicProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );
@ -26,8 +26,13 @@
dimensionedScalar gamma = Cp/Cv; dimensionedScalar gamma = Cp/Cv;
dimensionedScalar Pr = dimensionedScalar("Pr", dimless, 1.0); dimensionedScalar Pr
if (thermodynamicProperties.found("Pr")) (
{ dimensionedScalar::lookupOrDefault
Pr = thermodynamicProperties.lookup("Pr"); (
} "Pr",
thermodynamicProperties,
1.0
)
);

View File

@ -7,7 +7,7 @@
"thermodynamicProperties", "thermodynamicProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@
"thermodynamicProperties", "thermodynamicProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@ IOdictionary mdEquilibrationDict
"mdEquilibrationDict", "mdEquilibrationDict",
runTime.system(), runTime.system(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@
"physicalProperties", "physicalProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -21,7 +21,7 @@
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -1,3 +1,4 @@
const dictionary& Bpiso = mesh.solutionDict().subDict("BPISO"); const dictionary& Bpiso = mesh.solutionDict().subDict("BPISO");
const int nBcorr = Bpiso.lookupOrDefault<int>("nCorrectors", 1);
int nBcorr(readInt(Bpiso.lookup("nCorrectors")));

View File

@ -7,7 +7,7 @@
"financialProperties", "financialProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -6,10 +6,12 @@ EXE_INC = \
-I$(LIB_SRC)/meshTools/lnInclude \ -I$(LIB_SRC)/meshTools/lnInclude \
-I$(LIB_SRC)/finiteVolume/lnInclude \ -I$(LIB_SRC)/finiteVolume/lnInclude \
-I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \ -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \
-I$(LIB_SRC)/thermophysicalModels/basicSolidThermo/lnInclude \
-I$(LIB_SRC)/turbulenceModels/compressible/turbulenceModel -I$(LIB_SRC)/turbulenceModels/compressible/turbulenceModel
EXE_LIBS = \ EXE_LIBS = \
-lbasicThermophysicalModels \ -lbasicThermophysicalModels \
-lbasicSolidThermo \
-lspecie \ -lspecie \
-lcompressibleRASModels \ -lcompressibleRASModels \
-lcompressibleLESModels \ -lcompressibleLESModels \

View File

@ -37,6 +37,7 @@ Description
#include "regionProperties.H" #include "regionProperties.H"
#include "compressibleCourantNo.H" #include "compressibleCourantNo.H"
#include "solidRegionDiffNo.H" #include "solidRegionDiffNo.H"
#include "basicSolidThermo.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -7,6 +7,7 @@ EXE_INC = \
-I$(LIB_SRC)/finiteVolume/lnInclude \ -I$(LIB_SRC)/finiteVolume/lnInclude \
-I$(LIB_SRC)/meshTools/lnInclude \ -I$(LIB_SRC)/meshTools/lnInclude \
-I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \ -I$(LIB_SRC)/thermophysicalModels/basic/lnInclude \
-I$(LIB_SRC)/thermophysicalModels/basicSolidThermo/lnInclude \
-I$(LIB_SRC)/turbulenceModels \ -I$(LIB_SRC)/turbulenceModels \
-I$(LIB_SRC)/turbulenceModels/compressible/turbulenceModel/lnInclude \ -I$(LIB_SRC)/turbulenceModels/compressible/turbulenceModel/lnInclude \
-I$(LIB_SRC)/turbulenceModels/compressible/RAS/lnInclude -I$(LIB_SRC)/turbulenceModels/compressible/RAS/lnInclude
@ -14,5 +15,6 @@ EXE_INC = \
EXE_LIBS = \ EXE_LIBS = \
-lfiniteVolume \ -lfiniteVolume \
-lbasicThermophysicalModels \ -lbasicThermophysicalModels \
-lbasicSolidThermo \
-lspecie \ -lspecie \
-lcompressibleRASModels -lcompressibleRASModels

View File

@ -35,6 +35,7 @@ Description
#include "fixedGradientFvPatchFields.H" #include "fixedGradientFvPatchFields.H"
#include "regionProperties.H" #include "regionProperties.H"
#include "compressibleCourantNo.H" #include "compressibleCourantNo.H"
#include "basicSolidThermo.H"
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -1,25 +1,11 @@
dictionary simple = fluidRegions[i].solutionDict().subDict("SIMPLE"); const dictionary& simple = fluidRegions[i].solutionDict().subDict("SIMPLE");
int nNonOrthCorr = 0; const int nNonOrthCorr =
if (simple.found("nNonOrthogonalCorrectors")) simple.lookupOrDefault<int>("nNonOrthogonalCorrectors", 0);
{
nNonOrthCorr = readInt(simple.lookup("nNonOrthogonalCorrectors"));
}
bool momentumPredictor = true; const bool momentumPredictor =
if (simple.found("momentumPredictor")) simple.lookupOrDefault("momentumPredictor", true);
{
momentumPredictor = Switch(simple.lookup("momentumPredictor"));
}
bool fluxGradp = false; const bool transonic =
if (simple.found("fluxGradp")) simple.lookupOrDefault("transonic", false);
{
fluxGradp = Switch(simple.lookup("fluxGradp"));
}
bool transonic = false;
if (simple.found("transonic"))
{
transonic = Switch(simple.lookup("transonic"));
}

View File

@ -1,8 +1,5 @@
// Initialise solid field pointer lists // Initialise solid field pointer lists
PtrList<volScalarField> rhos(solidRegions.size()); PtrList<basicSolidThermo> thermos(solidRegions.size());
PtrList<volScalarField> cps(solidRegions.size());
PtrList<volScalarField> Ks(solidRegions.size());
PtrList<volScalarField> Ts(solidRegions.size());
// Populate solid field pointer lists // Populate solid field pointer lists
forAll(solidRegions, i) forAll(solidRegions, i)
@ -10,75 +7,10 @@
Info<< "*** Reading solid mesh thermophysical properties for region " Info<< "*** Reading solid mesh thermophysical properties for region "
<< solidRegions[i].name() << nl << endl; << solidRegions[i].name() << nl << endl;
Info<< " Adding to rhos\n" << endl; Info<< " Adding to thermos\n" << endl;
rhos.set thermos.set
( (
i, i,
new volScalarField basicSolidThermo::New(solidRegions[i])
(
IOobject
(
"rho",
runTime.timeName(),
solidRegions[i],
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
solidRegions[i]
)
);
Info<< " Adding to cps\n" << endl;
cps.set
(
i,
new volScalarField
(
IOobject
(
"cp",
runTime.timeName(),
solidRegions[i],
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
solidRegions[i]
)
);
Info<< " Adding to Ks\n" << endl;
Ks.set
(
i,
new volScalarField
(
IOobject
(
"K",
runTime.timeName(),
solidRegions[i],
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
solidRegions[i]
)
);
Info<< " Adding to Ts\n" << endl;
Ts.set
(
i,
new volScalarField
(
IOobject
(
"T",
runTime.timeName(),
solidRegions[i],
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
solidRegions[i]
)
); );
} }

View File

@ -1,7 +1,5 @@
dictionary simple = solidRegions[i].solutionDict().subDict("SIMPLE"); const dictionary& simple = solidRegions[i].solutionDict().subDict("SIMPLE");
const int nNonOrthCorr =
simple.lookupOrDefault<int>("nNonOrthogonalCorrectors", 0);
int nNonOrthCorr = 0;
if (simple.found("nNonOrthogonalCorrectors"))
{
nNonOrthCorr = readInt(simple.lookup("nNonOrthogonalCorrectors"));
}

View File

@ -1,6 +1,14 @@
fvMesh& mesh = solidRegions[i]; fvMesh& mesh = solidRegions[i];
basicSolidThermo& thermo = thermos[i];
volScalarField& rho = rhos[i]; tmp<volScalarField> trho = thermo.rho();
volScalarField& cp = cps[i]; const volScalarField& rho = trho();
volScalarField& K = Ks[i];
volScalarField& T = Ts[i]; tmp<volScalarField> tcp = thermo.cp();
const volScalarField& cp = tcp();
tmp<volScalarField> tK = thermo.K();
//tmp<volSymmTensorField> tK = thermo.directionalK();
const volScalarField& K = tK();
volScalarField& T = thermo.T();

View File

@ -1,9 +1,11 @@
const dictionary& pimple = mesh.solutionDict().subDict("PIMPLE"); const dictionary& pimple = mesh.solutionDict().subDict("PIMPLE");
int nCorr(readInt(pimple.lookup("nCorrectors"))); const int nCorr =
pimple.lookupOrDefault<int>("nCorrectors", 1);
int nNonOrthCorr = const int nNonOrthCorr =
pimple.lookupOrDefault<int>("nNonOrthogonalCorrectors", 0); pimple.lookupOrDefault<int>("nNonOrthogonalCorrectors", 0);
bool momentumPredictor = const bool momentumPredictor =
pimple.lookupOrDefault<Switch>("momentumPredictor", true); pimple.lookupOrDefault("momentumPredictor", true);

View File

@ -1,27 +1,17 @@
dictionary piso = fluidRegions[i].solutionDict().subDict("PISO"); const dictionary& piso = fluidRegions[i].solutionDict().subDict("PISO");
int nCorr(readInt(piso.lookup("nCorrectors"))); const int nOuterCorr =
piso.lookupOrDefault<int>("nOuterCorrectors", 1);
int nNonOrthCorr = 0; const int nCorr =
if (piso.found("nNonOrthogonalCorrectors")) piso.lookupOrDefault<int>("nCorrectors", 1);
{
nNonOrthCorr = readInt(piso.lookup("nNonOrthogonalCorrectors"));
}
bool momentumPredictor = true; const int nNonOrthCorr =
if (piso.found("momentumPredictor")) piso.lookupOrDefault<int>("nNonOrthogonalCorrectors", 0);
{
momentumPredictor = Switch(piso.lookup("momentumPredictor"));
}
bool transonic = false; const bool momentumPredictor =
if (piso.found("transonic")) piso.lookupOrDefault("momentumPredictor", true);
{
transonic = Switch(piso.lookup("transonic")); const bool transonic =
} piso.lookupOrDefault("transonic", false);
int nOuterCorr = 1;
if (piso.found("nOuterCorrectors"))
{
nOuterCorr = readInt(piso.lookup("nOuterCorrectors"));
}

View File

@ -4,4 +4,6 @@
const dictionary& pimple = solutionDict.subDict("PIMPLE"); const dictionary& pimple = solutionDict.subDict("PIMPLE");
int nOuterCorr(readInt(pimple.lookup("nOuterCorrectors"))); const int nOuterCorr =
pimple.lookupOrDefault<int>("nOuterCorrectors", 1);

View File

@ -36,7 +36,7 @@ Foam::regionProperties::regionProperties(const Time& runTime)
"regionProperties", "regionProperties",
runTime.time().constant(), runTime.time().constant(),
runTime.db(), runTime.db(),
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
), ),

View File

@ -1,8 +1,5 @@
// Initialise solid field pointer lists // Initialise solid field pointer lists
PtrList<volScalarField> rhos(solidRegions.size()); PtrList<basicSolidThermo> thermos(solidRegions.size());
PtrList<volScalarField> cps(solidRegions.size());
PtrList<volScalarField> Ks(solidRegions.size());
PtrList<volScalarField> Ts(solidRegions.size());
// Populate solid field pointer lists // Populate solid field pointer lists
forAll(solidRegions, i) forAll(solidRegions, i)
@ -10,75 +7,10 @@
Info<< "*** Reading solid mesh thermophysical properties for region " Info<< "*** Reading solid mesh thermophysical properties for region "
<< solidRegions[i].name() << nl << endl; << solidRegions[i].name() << nl << endl;
Info<< " Adding to rhos\n" << endl; Info<< " Adding to thermos\n" << endl;
rhos.set thermos.set
( (
i, i,
new volScalarField basicSolidThermo::New(solidRegions[i])
(
IOobject
(
"rho",
runTime.timeName(),
solidRegions[i],
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
solidRegions[i]
)
);
Info<< " Adding to cps\n" << endl;
cps.set
(
i,
new volScalarField
(
IOobject
(
"cp",
runTime.timeName(),
solidRegions[i],
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
solidRegions[i]
)
);
Info<< " Adding to Ks\n" << endl;
Ks.set
(
i,
new volScalarField
(
IOobject
(
"K",
runTime.timeName(),
solidRegions[i],
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
solidRegions[i]
)
);
Info<< " Adding to Ts\n" << endl;
Ts.set
(
i,
new volScalarField
(
IOobject
(
"T",
runTime.timeName(),
solidRegions[i],
IOobject::MUST_READ,
IOobject::AUTO_WRITE
),
solidRegions[i]
)
); );
} }

View File

@ -1,7 +1,5 @@
const dictionary& piso = solidRegions[i].solutionDict().subDict("PISO"); const dictionary& piso = solidRegions[i].solutionDict().subDict("PISO");
int nNonOrthCorr = 0; const int nNonOrthCorr =
if (piso.found("nNonOrthogonalCorrectors")) piso.lookupOrDefault<int>("nNonOrthogonalCorrectors", 0);
{
nNonOrthCorr = readInt(piso.lookup("nNonOrthogonalCorrectors"));
}

View File

@ -1,6 +1,14 @@
fvMesh& mesh = solidRegions[i]; fvMesh& mesh = solidRegions[i];
basicSolidThermo& thermo = thermos[i];
volScalarField& rho = rhos[i]; tmp<volScalarField> trho = thermo.rho();
volScalarField& cp = cps[i]; const volScalarField& rho = trho();
volScalarField& K = Ks[i];
volScalarField& T = Ts[i]; tmp<volScalarField> tcp = thermo.cp();
const volScalarField& cp = tcp();
tmp<volScalarField> tK = thermo.K();
//tmp<volSymmTensorField> tK = thermo.directionalK();
const volScalarField& K = tK();
volScalarField& T = thermo.T();

View File

@ -1,15 +1,17 @@
scalar DiNum = -GREAT; scalar DiNum = -GREAT;
forAll(solidRegions, regionI) forAll(solidRegions, i)
{ {
# include "setRegionSolidFields.H"
DiNum = max DiNum = max
( (
solidRegionDiffNo solidRegionDiffNo
( (
solidRegions[regionI], solidRegions[i],
runTime, runTime,
rhos[regionI]*cps[regionI], rho*cp,
Ks[regionI] K
), ),
DiNum DiNum
); );

View File

@ -44,7 +44,7 @@
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -6,7 +6,7 @@
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE, IOobject::NO_WRITE,
false false
) )

View File

@ -7,7 +7,7 @@
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -1,14 +1,9 @@
#include "readTimeControls.H" #include "readTimeControls.H"
#include "readPIMPLEControls.H" #include "readPIMPLEControls.H"
bool correctPhi = false; const bool correctPhi =
if (pimple.found("correctPhi")) pimple.lookupOrDefault("correctPhi", false);
{
correctPhi = Switch(pimple.lookup("correctPhi")); const bool checkMeshCourantNo =
} pimple.lookupOrDefault("checkMeshCourantNo", false);
bool checkMeshCourantNo = false;
if (pimple.found("checkMeshCourantNo"))
{
checkMeshCourantNo = Switch(pimple.lookup("checkMeshCourantNo"));
}

View File

@ -43,22 +43,13 @@
porousZones pZones(mesh); porousZones pZones(mesh);
Switch pressureImplicitPorosity(false);
// nUCorrectors used for pressureImplicitPorosity
int nUCorr = 0; int nUCorr = 0;
if (pZones.size()) const bool pressureImplicitPorosity =
{ (
// nUCorrectors for pressureImplicitPorosity pZones.size()
if (mesh.solutionDict().subDict("SIMPLE").found("nUCorrectors")) && mesh.solutionDict().subDict("SIMPLE").readIfPresent("nUCorrectors", nUCorr)
{ && (nUCorr > 0)
nUCorr = readInt );
(
mesh.solutionDict().subDict("SIMPLE").lookup("nUCorrectors")
);
}
if (nUCorr > 0)
{
pressureImplicitPorosity = true;
}
}

View File

@ -7,7 +7,7 @@ IOdictionary gravitationalProperties
"gravitationalProperties", "gravitationalProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@ IOdictionary chemistryProperties
"chemistryProperties", "chemistryProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE, IOobject::NO_WRITE,
false false
) )

View File

@ -7,7 +7,7 @@
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@ IOdictionary chemistryProperties
"chemistryProperties", "chemistryProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE, IOobject::NO_WRITE,
false false
) )

View File

@ -97,7 +97,7 @@
"additionalControls", "additionalControls",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@ IOdictionary chemistryProperties
"chemistryProperties", "chemistryProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE, IOobject::NO_WRITE,
false false
) )

View File

@ -7,7 +7,7 @@ IOdictionary chemistryProperties
"chemistryProperties", "chemistryProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE, IOobject::NO_WRITE,
false false
) )

View File

@ -91,7 +91,7 @@
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -5,7 +5,7 @@
"RASProperties", "RASProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );
@ -96,7 +96,7 @@
) )
); );
if (RASProperties.lookupOrDefault<Switch>("printCoeffs", false)) if (RASProperties.lookupOrDefault("printCoeffs", false))
{ {
Info<< "kEpsilonCoeffs" << kEpsilonDict << nl Info<< "kEpsilonCoeffs" << kEpsilonDict << nl
<< "wallFunctionCoeffs" << wallFunctionDict << endl; << "wallFunctionCoeffs" << wallFunctionDict << endl;

View File

@ -7,7 +7,7 @@
"thermodynamicProperties", "thermodynamicProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -1,5 +1,5 @@
#include "readPISOControls.H" #include "readPISOControls.H"
#include "readTimeControls.H" #include "readTimeControls.H"
label nAlphaCorr label nAlphaCorr
( (
@ -19,14 +19,9 @@
<< exit(FatalError); << exit(FatalError);
} }
bool correctPhi = true; const bool correctPhi =
if (piso.found("correctPhi")) piso.lookupOrDefault("correctPhi", true);
{
correctPhi = Switch(piso.lookup("correctPhi")); const bool checkMeshCourantNo =
} piso.lookupOrDefault("checkMeshCourantNo", false);
bool checkMeshCourantNo = false;
if (piso.found("checkMeshCourantNo"))
{
checkMeshCourantNo = Switch(piso.lookup("checkMeshCourantNo"));
}

View File

@ -1,14 +1,9 @@
# include "readTimeControls.H" # include "readTimeControls.H"
# include "readPISOControls.H" # include "readPISOControls.H"
bool correctPhi = true; const bool correctPhi =
if (piso.found("correctPhi")) piso.lookupOrDefault("correctPhi", true);
{
correctPhi = Switch(piso.lookup("correctPhi")); const bool checkMeshCourantNo =
} piso.lookupOrDefault("checkMeshCourantNo", false);
bool checkMeshCourantNo = false;
if (piso.found("checkMeshCourantNo"))
{
checkMeshCourantNo = Switch(piso.lookup("checkMeshCourantNo"));
}

View File

@ -46,7 +46,7 @@ Foam::phaseChangeTwoPhaseMixture::New
"transportProperties", "transportProperties",
U.time().constant(), U.time().constant(),
U.db(), U.db(),
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE, IOobject::NO_WRITE,
false false
) )

View File

@ -1,5 +1,5 @@
multiphaseMixture/phase/phase.C multiphaseMixture/phase/phase.C
multiphaseMixture/alphaContactAngle/alphaContactAngleFvPatchScalarField.C multiphaseMixture/multiphaseAlphaContactAngle/multiphaseAlphaContactAngleFvPatchScalarField.C
multiphaseMixture/multiphaseMixture.C multiphaseMixture/multiphaseMixture.C
multiphaseInterFoam.C multiphaseInterFoam.C

View File

@ -2,17 +2,15 @@ EXE_INC = \
-I../interFoam \ -I../interFoam \
-ImultiphaseMixture \ -ImultiphaseMixture \
-ImultiphaseMixture/phase \ -ImultiphaseMixture/phase \
-ImultiphaseMixture/alphaContactAngle \ -ImultiphaseMixture/multiphaseAlphaContactAngle \
-I$(LIB_SRC)/transportModels \ -I$(LIB_SRC)/transportModels \
-I$(LIB_SRC)/transportModels/incompressible/lnInclude \ -I$(LIB_SRC)/transportModels/incompressible/lnInclude \
-I$(LIB_SRC)/transportModels/interfaceProperties/lnInclude \
-I$(LIB_SRC)/turbulenceModels/incompressible/turbulenceModel \ -I$(LIB_SRC)/turbulenceModels/incompressible/turbulenceModel \
-I$(LIB_SRC)/finiteVolume/lnInclude -I$(LIB_SRC)/finiteVolume/lnInclude
EXE_LIBS = \ EXE_LIBS = \
-linterfaceProperties \ -linterfaceProperties \
-lincompressibleTransportModels \ -lincompressibleTransportModels \
-lincompressibleTransportModels \
-lincompressibleRASModels \ -lincompressibleRASModels \
-lincompressibleLESModels \ -lincompressibleLESModels \
-lfiniteVolume -lfiniteVolume

View File

@ -26,7 +26,7 @@
mesh mesh
); );
# include "createPhi.H" #include "createPhi.H"
multiphaseMixture mixture(U, phi); multiphaseMixture mixture(U, phi);

View File

@ -80,7 +80,7 @@ int main(int argc, char *argv[])
#include "continuityErrs.H" #include "continuityErrs.H"
turbulence->correct(); //turbulence->correct();
runTime.write(); runTime.write();

View File

@ -23,7 +23,7 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "alphaContactAngleFvPatchScalarField.H" #include "multiphaseAlphaContactAngleFvPatchScalarField.H"
#include "addToRunTimeSelectionTable.H" #include "addToRunTimeSelectionTable.H"
#include "fvPatchFieldMapper.H" #include "fvPatchFieldMapper.H"
@ -32,7 +32,8 @@ License
namespace Foam namespace Foam
{ {
alphaContactAngleFvPatchScalarField::interfaceThetaProps::interfaceThetaProps multiphaseAlphaContactAngleFvPatchScalarField::interfaceThetaProps::
interfaceThetaProps
( (
Istream& is Istream& is
) )
@ -47,7 +48,7 @@ alphaContactAngleFvPatchScalarField::interfaceThetaProps::interfaceThetaProps
Istream& operator>> Istream& operator>>
( (
Istream& is, Istream& is,
alphaContactAngleFvPatchScalarField::interfaceThetaProps& tp multiphaseAlphaContactAngleFvPatchScalarField::interfaceThetaProps& tp
) )
{ {
is >> tp.theta0_ >> tp.uTheta_ >> tp.thetaA_ >> tp.thetaR_; is >> tp.theta0_ >> tp.uTheta_ >> tp.thetaA_ >> tp.thetaR_;
@ -58,7 +59,7 @@ Istream& operator>>
Ostream& operator<< Ostream& operator<<
( (
Ostream& os, Ostream& os,
const alphaContactAngleFvPatchScalarField::interfaceThetaProps& tp const multiphaseAlphaContactAngleFvPatchScalarField::interfaceThetaProps& tp
) )
{ {
os << tp.theta0_ << token::SPACE os << tp.theta0_ << token::SPACE
@ -72,7 +73,8 @@ Ostream& operator<<
// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
alphaContactAngleFvPatchScalarField::alphaContactAngleFvPatchScalarField multiphaseAlphaContactAngleFvPatchScalarField::
multiphaseAlphaContactAngleFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
@ -82,9 +84,10 @@ alphaContactAngleFvPatchScalarField::alphaContactAngleFvPatchScalarField
{} {}
alphaContactAngleFvPatchScalarField::alphaContactAngleFvPatchScalarField multiphaseAlphaContactAngleFvPatchScalarField::
multiphaseAlphaContactAngleFvPatchScalarField
( (
const alphaContactAngleFvPatchScalarField& gcpsf, const multiphaseAlphaContactAngleFvPatchScalarField& gcpsf,
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
const fvPatchFieldMapper& mapper const fvPatchFieldMapper& mapper
@ -95,7 +98,8 @@ alphaContactAngleFvPatchScalarField::alphaContactAngleFvPatchScalarField
{} {}
alphaContactAngleFvPatchScalarField::alphaContactAngleFvPatchScalarField multiphaseAlphaContactAngleFvPatchScalarField::
multiphaseAlphaContactAngleFvPatchScalarField
( (
const fvPatch& p, const fvPatch& p,
const DimensionedField<scalar, volMesh>& iF, const DimensionedField<scalar, volMesh>& iF,
@ -109,9 +113,10 @@ alphaContactAngleFvPatchScalarField::alphaContactAngleFvPatchScalarField
} }
alphaContactAngleFvPatchScalarField::alphaContactAngleFvPatchScalarField multiphaseAlphaContactAngleFvPatchScalarField::
multiphaseAlphaContactAngleFvPatchScalarField
( (
const alphaContactAngleFvPatchScalarField& gcpsf, const multiphaseAlphaContactAngleFvPatchScalarField& gcpsf,
const DimensionedField<scalar, volMesh>& iF const DimensionedField<scalar, volMesh>& iF
) )
: :
@ -122,7 +127,7 @@ alphaContactAngleFvPatchScalarField::alphaContactAngleFvPatchScalarField
// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
void alphaContactAngleFvPatchScalarField::write(Ostream& os) const void multiphaseAlphaContactAngleFvPatchScalarField::write(Ostream& os) const
{ {
fvPatchScalarField::write(os); fvPatchScalarField::write(os);
os.writeKeyword("thetaProperties") os.writeKeyword("thetaProperties")
@ -133,7 +138,7 @@ void alphaContactAngleFvPatchScalarField::write(Ostream& os) const
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
makePatchTypeField(fvPatchScalarField, alphaContactAngleFvPatchScalarField); makePatchTypeField(fvPatchScalarField, multiphaseAlphaContactAngleFvPatchScalarField);
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * // // * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -22,19 +22,19 @@ License
along with OpenFOAM. If not, see <http://www.gnu.org/licenses/>. along with OpenFOAM. If not, see <http://www.gnu.org/licenses/>.
Class Class
Foam::alphaContactAngleFvPatchScalarField Foam::multiphaseAlphaContactAngleFvPatchScalarField
Description Description
Contact-angle boundary condition for multi-phase interface-capturing Contact-angle boundary condition for multi-phase interface-capturing
simulations. Used in conjuction with multiphaseMixture. simulations. Used in conjuction with multiphaseMixture.
SourceFiles SourceFiles
alphaContactAngleFvPatchScalarField.C multiphaseAlphaContactAngleFvPatchScalarField.C
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#ifndef alphaContactAngleFvPatchScalarField_H #ifndef multiphaseAlphaContactAngleFvPatchScalarField_H
#define alphaContactAngleFvPatchScalarField_H #define multiphaseAlphaContactAngleFvPatchScalarField_H
#include "zeroGradientFvPatchFields.H" #include "zeroGradientFvPatchFields.H"
#include "multiphaseMixture.H" #include "multiphaseMixture.H"
@ -45,10 +45,10 @@ namespace Foam
{ {
/*---------------------------------------------------------------------------*\ /*---------------------------------------------------------------------------*\
Class alphaContactAngleFvPatch Declaration Class multiphaseAlphaContactAngleFvPatch Declaration
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
class alphaContactAngleFvPatchScalarField class multiphaseAlphaContactAngleFvPatchScalarField
: :
public zeroGradientFvPatchScalarField public zeroGradientFvPatchScalarField
{ {
@ -132,31 +132,31 @@ private:
public: public:
//- Runtime type information //- Runtime type information
TypeName("alphaContactAngle"); TypeName("multiphaseAlphaContactAngle");
// Constructors // Constructors
//- Construct from patch and internal field //- Construct from patch and internal field
alphaContactAngleFvPatchScalarField multiphaseAlphaContactAngleFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
//- Construct from patch, internal field and dictionary //- Construct from patch, internal field and dictionary
alphaContactAngleFvPatchScalarField multiphaseAlphaContactAngleFvPatchScalarField
( (
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
const dictionary& const dictionary&
); );
//- Construct by mapping given alphaContactAngleFvPatchScalarField //- Construct by mapping given multiphaseAlphaContactAngleFvPatchScalarField
// onto a new patch // onto a new patch
alphaContactAngleFvPatchScalarField multiphaseAlphaContactAngleFvPatchScalarField
( (
const alphaContactAngleFvPatchScalarField&, const multiphaseAlphaContactAngleFvPatchScalarField&,
const fvPatch&, const fvPatch&,
const DimensionedField<scalar, volMesh>&, const DimensionedField<scalar, volMesh>&,
const fvPatchFieldMapper& const fvPatchFieldMapper&
@ -167,14 +167,14 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new alphaContactAngleFvPatchScalarField(*this) new multiphaseAlphaContactAngleFvPatchScalarField(*this)
); );
} }
//- Construct as copy setting internal field reference //- Construct as copy setting internal field reference
alphaContactAngleFvPatchScalarField multiphaseAlphaContactAngleFvPatchScalarField
( (
const alphaContactAngleFvPatchScalarField&, const multiphaseAlphaContactAngleFvPatchScalarField&,
const DimensionedField<scalar, volMesh>& const DimensionedField<scalar, volMesh>&
); );
@ -186,7 +186,7 @@ public:
{ {
return tmp<fvPatchScalarField> return tmp<fvPatchScalarField>
( (
new alphaContactAngleFvPatchScalarField(*this, iF) new multiphaseAlphaContactAngleFvPatchScalarField(*this, iF)
); );
} }

View File

@ -24,7 +24,7 @@ License
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
#include "multiphaseMixture.H" #include "multiphaseMixture.H"
#include "alphaContactAngleFvPatchScalarField.H" #include "multiphaseAlphaContactAngleFvPatchScalarField.H"
#include "Time.H" #include "Time.H"
#include "subCycle.H" #include "subCycle.H"
#include "fvCFD.H" #include "fvCFD.H"
@ -351,10 +351,11 @@ void Foam::multiphaseMixture::correctContactAngle
forAll(boundary, patchi) forAll(boundary, patchi)
{ {
if (isA<alphaContactAngleFvPatchScalarField>(gbf[patchi])) if (isA<multiphaseAlphaContactAngleFvPatchScalarField>(gbf[patchi]))
{ {
const alphaContactAngleFvPatchScalarField& acap = const multiphaseAlphaContactAngleFvPatchScalarField& acap =
refCast<const alphaContactAngleFvPatchScalarField>(gbf[patchi]); refCast<const multiphaseAlphaContactAngleFvPatchScalarField>
(gbf[patchi]);
vectorField& nHatPatch = nHatb[patchi]; vectorField& nHatPatch = nHatb[patchi];
@ -362,7 +363,7 @@ void Foam::multiphaseMixture::correctContactAngle
mesh_.Sf().boundaryField()[patchi] mesh_.Sf().boundaryField()[patchi]
/mesh_.magSf().boundaryField()[patchi]; /mesh_.magSf().boundaryField()[patchi];
alphaContactAngleFvPatchScalarField::thetaPropsTable:: multiphaseAlphaContactAngleFvPatchScalarField::thetaPropsTable::
const_iterator tp = const_iterator tp =
acap.thetaProps().find(interfacePair(alpha1, alpha2)); acap.thetaProps().find(interfacePair(alpha1, alpha2));

View File

@ -210,7 +210,7 @@ public:
//- Destructor //- Destructor
~multiphaseMixture() virtual ~multiphaseMixture()
{} {}

View File

@ -50,7 +50,7 @@
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );
@ -184,7 +184,7 @@
"RASProperties", "RASProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );
@ -276,7 +276,7 @@
) )
); );
if (RASProperties.lookupOrDefault<Switch>("printCoeffs", false)) if (RASProperties.lookupOrDefault("printCoeffs", false))
{ {
Info<< "kEpsilonCoeffs" << kEpsilonDict << nl Info<< "kEpsilonCoeffs" << kEpsilonDict << nl
<< "wallFunctionCoeffs" << wallFunctionDict << endl; << "wallFunctionCoeffs" << wallFunctionDict << endl;

View File

@ -7,7 +7,7 @@
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );
@ -153,7 +153,7 @@
"interfacialProperties", "interfacialProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );
@ -175,10 +175,8 @@
); );
word dragPhase("blended"); word dragPhase("blended");
if (interfacialProperties.found("dragPhase")) if (interfacialProperties.readIfPresent("dragPhase", dragPhase))
{ {
dragPhase = word(interfacialProperties.lookup("dragPhase"));
bool validDrag = bool validDrag =
dragPhase == "a" || dragPhase == "b" || dragPhase == "blended"; dragPhase == "a" || dragPhase == "b" || dragPhase == "blended";

View File

@ -56,7 +56,7 @@ Foam::kineticTheoryModel::kineticTheoryModel
"kineticTheoryProperties", "kineticTheoryProperties",
Ua_.time().constant(), Ua_.time().constant(),
Ua_.mesh(), Ua_.mesh(),
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
), ),

View File

@ -5,7 +5,7 @@
"ppProperties", "ppProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -7,7 +7,7 @@
"mechanicalProperties", "mechanicalProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -1,5 +1,6 @@
const dictionary& stressControl = mesh.solutionDict().subDict("stressAnalysis"); const dictionary& stressControl = mesh.solutionDict().subDict("stressAnalysis");
int nCorr(readInt(stressControl.lookup("nCorrectors"))); const int nCorr = stressControl.lookupOrDefault<int>("nCorrectors", 1);
scalar convergenceTolerance(readScalar(stressControl.lookup("D"))); scalar convergenceTolerance(readScalar(stressControl.lookup("D")));
Switch compactNormalStress(stressControl.lookup("compactNormalStress")); Switch compactNormalStress(stressControl.lookup("compactNormalStress"));

View File

@ -7,7 +7,7 @@
"thermalProperties", "thermalProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -43,6 +43,9 @@ int main(int argc, char *argv[])
dl.append(2); dl.append(2);
dl.append(1); dl.append(1);
Pout<< "appending : dl:" << dl << endl; Pout<< "appending : dl:" << dl << endl;
dl[2] *= 10;
Pout<< "assigning : dl:" << dl << endl;
} }
{ {

View File

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

View File

@ -7,7 +7,7 @@
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -48,7 +48,7 @@ int main(int argc, char *argv[])
"dataEntryProperties", "dataEntryProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -1,10 +1,10 @@
/*-------------------------------*- C++ -*---------------------------------*\ /*--------------------------------*- C++ -*----------------------------------*\
| ========= | | ========= | |
| \\ / OpenFOAM | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / | | \\ / O peration | Version: 1.6 |
| \\ / The Open Source CFD Toolbox | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ http://www.OpenFOAM.org | | \\/ M anipulation | |
\*-------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile
{ {
version 2.0; version 2.0;

View File

@ -116,7 +116,7 @@ int main(int argc, char *argv[])
dictName, dictName,
"system", "system",
runTime, runTime,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE, IOobject::NO_WRITE,
false false
) )

View File

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

View File

@ -2,7 +2,7 @@
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.6 | | \\ / O peration | Version: 1.6 |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile

View File

@ -2,7 +2,7 @@
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.6 | | \\ / O peration | Version: 1.6 |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
( (

View File

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

View File

@ -57,7 +57,7 @@ int main(int argc, char *argv[])
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -56,7 +56,7 @@ int main(int argc, char *argv[])
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -57,7 +57,7 @@ int main(int argc, char *argv[])
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -58,7 +58,7 @@ int main(int argc, char *argv[])
"transportProperties", "transportProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -639,7 +639,7 @@ int main(int argc, char *argv[])
"motionProperties", "motionProperties",
runTime.constant(), runTime.constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
); );
@ -669,7 +669,7 @@ int main(int argc, char *argv[])
"autoRefineMeshDict", "autoRefineMeshDict",
runTime.system(), runTime.system(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -2,7 +2,7 @@
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.6 | | \\ / O peration | Version: 1.6 |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile

View File

@ -74,7 +74,7 @@ void checkSnapMesh
"snapMeshDict", "snapMeshDict",
runTime.system(), runTime.system(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -346,7 +346,7 @@ int main(int argc, char *argv[])
"modifyMeshDict", "modifyMeshDict",
runTime.system(), runTime.system(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
) )
); );

View File

@ -2,7 +2,7 @@
| ========= | | | ========= | |
| \\ / F ield | OpenFOAM: The Open Source CFD Toolbox | | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox |
| \\ / O peration | Version: 1.6 | | \\ / O peration | Version: 1.6 |
| \\ / A nd | Web: http://www.OpenFOAM.org | | \\ / A nd | Web: www.OpenFOAM.org |
| \\/ M anipulation | | | \\/ M anipulation | |
\*---------------------------------------------------------------------------*/ \*---------------------------------------------------------------------------*/
FoamFile FoamFile

View File

@ -78,7 +78,7 @@ Foam::edgeStats::edgeStats(const polyMesh& mesh)
"motionProperties", "motionProperties",
mesh.time().constant(), mesh.time().constant(),
mesh, mesh,
IOobject::MUST_READ, IOobject::MUST_READ_IF_MODIFIED,
IOobject::NO_WRITE IOobject::NO_WRITE
); );

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