Standardized the selection of required and optional fields in BCs, fvOptions, functionObjects etc.

In most boundary conditions, fvOptions etc. required and optional fields
to be looked-up from the objectRegistry are selected by setting the
keyword corresponding to the standard field name in the BC etc. to the
appropriate name in the objectRegistry.  Usually a default is provided
with sets the field name to the keyword name, e.g. in the
totalPressureFvPatchScalarField the velocity is selected by setting the
keyword 'U' to the appropriate name which defaults to 'U':

        Property     | Description             | Required    | Default value
        U            | velocity field name     | no          | U
        phi          | flux field name         | no          | phi
        .
        .
        .

However, in some BCs and functionObjects and many fvOptions another
convention is used in which the field name keyword is appended by 'Name'
e.g.

        Property     | Description             | Required    | Default value
        pName        | pressure field name     | no          | p
        UName        | velocity field name     | no          | U

This difference in convention is unnecessary and confusing, hinders code
and dictionary reuse and complicates code maintenance.  In this commit
the appended 'Name' is removed from the field selection keywords
standardizing OpenFOAM on the first convention above.
This commit is contained in:
Henry Weller 2016-05-21 20:28:20 +01:00
parent a84ffc3968
commit 3eec5854be
181 changed files with 232 additions and 440 deletions

View File

@ -47,9 +47,9 @@ Description
\heading Patch usage
\table
Property | Description | Required | Default value
pName | Pressure field name | no | p
psiName | Compressibility field name | no | thermo:psi
Property | Description | Required | Default value
p | Pressure field name | no | p
psi | Compressibility field name | no | thermo:psi
\endtable
Example of the boundary condition specification:

View File

@ -77,7 +77,7 @@ Foam::solidBodyMotionFvMesh::solidBodyMotionFvMesh(const IOobject& io)
),
pointIDs_(),
moveAllCells_(false),
UName_(dynamicMeshCoeffs_.lookupOrDefault<word>("UName", "U"))
UName_(dynamicMeshCoeffs_.lookupOrDefault<word>("U", "U"))
{
if (undisplacedPoints_.size() != nPoints())
{

View File

@ -34,8 +34,8 @@ Description
For a mass-based flux:
- the flow rate should be provided in kg/s
- if \c rhoName is "none" the flow rate is in m3/s
- otherwise \c rhoName should correspond to the name of the density field
- if \c rho is "none" the flow rate is in m3/s
- otherwise \c rho should correspond to the name of the density field
- if the density field cannot be found in the database, the user must
specify the inlet density using the \c rhoInlet entry

View File

@ -68,7 +68,7 @@ mappedPatchFieldBase<Type>::mappedPatchFieldBase
(
dict.template lookupOrDefault<word>
(
"fieldName",
"field",
patchField_.internalField().name()
)
),
@ -314,7 +314,7 @@ tmp<Field<Type>> mappedPatchFieldBase<Type>::mappedField() const
template<class Type>
void mappedPatchFieldBase<Type>::write(Ostream& os) const
{
os.writeKeyword("fieldName") << fieldName_ << token::END_STATEMENT << nl;
os.writeKeyword("field") << fieldName_ << token::END_STATEMENT << nl;
os.writeKeyword("setAverage") << setAverage_ << token::END_STATEMENT << nl;
os.writeKeyword("average") << average_ << token::END_STATEMENT << nl;
os.writeKeyword("interpolationScheme") << interpolationScheme_

View File

@ -69,7 +69,7 @@ outletMappedUniformInletFvPatchField
)
:
fixedValueFvPatchField<Type>(p, iF, dict),
outletPatchName_(dict.lookup("outletPatchName")),
outletPatchName_(dict.lookup("outletPatch")),
phiName_(dict.lookupOrDefault<word>("phi", "phi"))
{}
@ -168,7 +168,7 @@ template<class Type>
void Foam::outletMappedUniformInletFvPatchField<Type>::write(Ostream& os) const
{
fvPatchField<Type>::write(os);
os.writeKeyword("outletPatchName")
os.writeKeyword("outletPatch")
<< outletPatchName_ << token::END_STATEMENT << nl;
if (phiName_ != "phi")
{

View File

@ -40,7 +40,7 @@ phaseHydrostaticPressureFvPatchScalarField
)
:
mixedFvPatchScalarField(p, iF),
phaseName_("alpha"),
phaseFraction_("alpha"),
rho_(0.0),
pRefValue_(0.0),
pRefPoint_(Zero)
@ -60,7 +60,7 @@ phaseHydrostaticPressureFvPatchScalarField
)
:
mixedFvPatchScalarField(p, iF),
phaseName_(dict.lookupOrDefault<word>("phaseName", "alpha")),
phaseFraction_(dict.lookupOrDefault<word>("phaseFraction", "alpha")),
rho_(readScalar(dict.lookup("rho"))),
pRefValue_(readScalar(dict.lookup("pRefValue"))),
pRefPoint_(dict.lookup("pRefPoint"))
@ -94,7 +94,7 @@ phaseHydrostaticPressureFvPatchScalarField
)
:
mixedFvPatchScalarField(ptf, p, iF, mapper),
phaseName_(ptf.phaseName_),
phaseFraction_(ptf.phaseFraction_),
rho_(ptf.rho_),
pRefValue_(ptf.pRefValue_),
pRefPoint_(ptf.pRefPoint_)
@ -108,7 +108,7 @@ phaseHydrostaticPressureFvPatchScalarField
)
:
mixedFvPatchScalarField(ptf),
phaseName_(ptf.phaseName_)
phaseFraction_(ptf.phaseFraction_)
{}
@ -120,7 +120,7 @@ phaseHydrostaticPressureFvPatchScalarField
)
:
mixedFvPatchScalarField(ptf, iF),
phaseName_(ptf.phaseName_),
phaseFraction_(ptf.phaseFraction_),
rho_(ptf.rho_),
pRefValue_(ptf.pRefValue_),
pRefPoint_(ptf.pRefPoint_)
@ -139,7 +139,7 @@ void Foam::phaseHydrostaticPressureFvPatchScalarField::updateCoeffs()
const scalarField& alphap =
patch().lookupPatchField<volScalarField, scalar>
(
phaseName_
phaseFraction_
);
const uniformDimensionedVectorField& g =
@ -161,10 +161,10 @@ void Foam::phaseHydrostaticPressureFvPatchScalarField::updateCoeffs()
void Foam::phaseHydrostaticPressureFvPatchScalarField::write(Ostream& os) const
{
fvPatchScalarField::write(os);
if (phaseName_ != "alpha")
if (phaseFraction_ != "alpha")
{
os.writeKeyword("phaseName")
<< phaseName_ << token::END_STATEMENT << nl;
os.writeKeyword("phaseFraction")
<< phaseFraction_ << token::END_STATEMENT << nl;
}
os.writeKeyword("rho") << rho_ << token::END_STATEMENT << nl;
os.writeKeyword("pRefValue") << pRefValue_ << token::END_STATEMENT << nl;
@ -182,8 +182,7 @@ void Foam::phaseHydrostaticPressureFvPatchScalarField::operator=
{
fvPatchScalarField::operator=
(
valueFraction()*refValue()
+ (1 - valueFraction())*ptf
valueFraction()*refValue() + (1 - valueFraction())*ptf
);
}

View File

@ -51,11 +51,11 @@ Description
\heading Patch usage
\table
Property | Description | Required | Default value
phaseName | phase field name | no | alpha
rho | density field name | no | rho
pRefValue | reference pressure [Pa] | yes |
pRefPoint | reference pressure location | yes |
Property | Description | Required | Default value
phaseFraction | phase-fraction field name | no | alpha
rho | density field name | no | rho
pRefValue | reference pressure [Pa] | yes |
pRefPoint | reference pressure location | yes |
\endtable
Example of the boundary condition specification:
@ -63,7 +63,7 @@ Description
myPatch
{
type phaseHydrostaticPressure;
phaseName alpha1;
phaseFraction alpha1;
rho rho;
pRefValue 1e5;
pRefPoint (0 0 0);
@ -103,7 +103,7 @@ protected:
// Protected data
//- Name of phase-fraction field
word phaseName_;
word phaseFraction_;
//- Constant density in the far-field
scalar rho_;
@ -196,16 +196,16 @@ public:
// Access
//- Return the phaseName
const word& phaseName() const
//- Return the phaseFraction
const word& phaseFraction() const
{
return phaseName_;
return phaseFraction_;
}
//- Return reference to the phaseName to allow adjustment
word& phaseName()
//- Return reference to the phaseFraction to allow adjustment
word& phaseFraction()
{
return phaseName_;
return phaseFraction_;
}
//- Return the constant density in the far-field

View File

@ -149,7 +149,7 @@ void Foam::prghTotalHydrostaticPressureFvPatchScalarField::write
writeEntryIfDifferent<word>(os, "U", "U", UName_);
writeEntryIfDifferent<word>(os, "phi", "phi", phiName_);
writeEntryIfDifferent<word>(os, "rho", "rho", rhoName_);
writeEntryIfDifferent<word>(os, "ph_rghName", "ph_rghName", ph_rghName_);
writeEntryIfDifferent<word>(os, "ph_rgh", "ph_rgh", ph_rghName_);
writeEntry("value", os);
}

View File

@ -98,7 +98,7 @@ timeVaryingMappedFixedValueFvPatchField
}
dict.readIfPresent("fieldTableName", fieldTableName_);
dict.readIfPresent("fieldTable", fieldTableName_);
if (dict.found("value"))
{
@ -565,7 +565,7 @@ void Foam::timeVaryingMappedFixedValueFvPatchField<Type>::write
if (fieldTableName_ != this->internalField().name())
{
os.writeKeyword("fieldTableName") << fieldTableName_
os.writeKeyword("fieldTable") << fieldTableName_
<< token::END_STATEMENT << nl;
}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2015 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2015-2016 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -29,7 +29,7 @@ License
// * * * * * * * * * * * * * * Static Data Members * * * * * * * * * * * * * //
Foam::word Foam::fv::localEulerDdt::rDeltaTName("rDeltaT");
Foam::word Foam::fv::localEulerDdt::rSubDeltaTName("rSubDeltaTName");
Foam::word Foam::fv::localEulerDdt::rSubDeltaTName("rSubDeltaT");
// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //

View File

@ -59,7 +59,7 @@ uniformInterpolatedDisplacementPointPatchVectorField
)
:
fixedValuePointPatchField<vector>(p, iF, dict),
fieldName_(dict.lookup("fieldName")),
fieldName_(dict.lookup("field")),
interpolationScheme_(dict.lookup("interpolationScheme"))
{
const pointMesh& pMesh = this->internalField().mesh();
@ -260,7 +260,7 @@ void uniformInterpolatedDisplacementPointPatchVectorField::write(Ostream& os)
const
{
pointPatchField<vector>::write(os);
os.writeKeyword("fieldName")
os.writeKeyword("field")
<< fieldName_ << token::END_STATEMENT << nl;
os.writeKeyword("interpolationScheme")
<< interpolationScheme_ << token::END_STATEMENT << nl;

View File

@ -37,7 +37,7 @@ Description
{
type uniformInterpolatedDisplacement;
value uniform (0 0 0);
fieldName wantedDisplacement;
field wantedDisplacement;
interpolationScheme linear;
}
\endverbatim

View File

@ -84,7 +84,7 @@ Foam::fv::fixedTemperatureConstraint::fixedTemperatureConstraint
}
case tmLookup:
{
TName_ = coeffs_.lookupOrDefault<word>("TName", "T");
TName_ = coeffs_.lookupOrDefault<word>("T", "T");
break;
}
default:
@ -157,7 +157,7 @@ bool Foam::fv::fixedTemperatureConstraint::read(const dictionary& dict)
);
}
coeffs_.readIfPresent("TName", TName_);
coeffs_.readIfPresent("T", TName_);
return true;
}

View File

@ -33,11 +33,11 @@ Description
{
mode uniform; // uniform or lookup
// uniform option
// For uniform option
temperature constant 500; // fixed temperature with time [K]
// lookup option
// TName T; // optional temperature field name
// For lookup option
// T <Tname>; // optional temperature field name
}
Note:

View File

@ -56,9 +56,9 @@ Foam::fv::buoyancyEnergy::buoyancyEnergy
)
:
option(sourceName, modelType, dict, mesh),
UName_(coeffs_.lookupOrDefault<word>("UName", "U"))
UName_(coeffs_.lookupOrDefault<word>("U", "U"))
{
coeffs_.lookup("fieldNames") >> fieldNames_;
coeffs_.lookup("fields") >> fieldNames_;
if (fieldNames_.size() != 1)
{

View File

@ -68,7 +68,7 @@ Foam::fv::buoyancyForce::buoyancyForce
)
)
{
coeffs_.lookup("fieldNames") >> fieldNames_;
coeffs_.lookup("fields") >> fieldNames_;
if (fieldNames_.size() != 1)
{

View File

@ -156,9 +156,9 @@ Foam::fv::effectivenessHeatExchangerSource::effectivenessHeatExchangerSource
secondaryInletT_(readScalar(coeffs_.lookup("secondaryInletT"))),
primaryInletT_(readScalar(coeffs_.lookup("primaryInletT"))),
eTable_(),
UName_(coeffs_.lookupOrDefault<word>("UName", "U")),
TName_(coeffs_.lookupOrDefault<word>("TName", "T")),
phiName_(coeffs_.lookupOrDefault<word>("phiName", "phi")),
UName_(coeffs_.lookupOrDefault<word>("U", "U")),
TName_(coeffs_.lookupOrDefault<word>("T", "T")),
phiName_(coeffs_.lookupOrDefault<word>("phi", "phi")),
faceZoneName_(coeffs_.lookup("faceZone")),
zoneID_(mesh_.faceZones().findZoneID(faceZoneName_)),
faceId_(),

View File

@ -130,9 +130,9 @@ bool Foam::fv::explicitPorositySource::read(const dictionary& dict)
{
coeffs_.lookup("UNames") >> fieldNames_;
}
else if (coeffs_.found("UName"))
else if (coeffs_.found("U"))
{
word UName(coeffs_.lookup("UName"));
word UName(coeffs_.lookup("U"));
fieldNames_ = wordList(1, UName);
}
else

View File

@ -93,7 +93,7 @@ Foam::fv::meanVelocityForce::meanVelocityForce
relaxation_(coeffs_.lookupOrDefault<scalar>("relaxation", 1.0)),
rAPtr_(NULL)
{
coeffs_.lookup("fieldNames") >> fieldNames_;
coeffs_.lookup("fields") >> fieldNames_;
if (fieldNames_.size() != 1)
{

View File

@ -586,7 +586,7 @@ bool Foam::fv::rotorDiskSource::read(const dictionary& dict)
{
if (cellSetOption::read(dict))
{
coeffs_.lookup("fieldNames") >> fieldNames_;
coeffs_.lookup("fields") >> fieldNames_;
applied_.setSize(fieldNames_.size(), false);
// Read co-ordinate system/geometry invariant properties

View File

@ -193,10 +193,10 @@ Foam::fv::solidificationMeltingSource::solidificationMeltingSource
relax_(coeffs_.lookupOrDefault("relax", 0.9)),
mode_(thermoModeTypeNames_.read(coeffs_.lookup("thermoMode"))),
rhoRef_(readScalar(coeffs_.lookup("rhoRef"))),
TName_(coeffs_.lookupOrDefault<word>("TName", "T")),
CpName_(coeffs_.lookupOrDefault<word>("CpName", "Cp")),
UName_(coeffs_.lookupOrDefault<word>("UName", "U")),
phiName_(coeffs_.lookupOrDefault<word>("phiName", "phi")),
TName_(coeffs_.lookupOrDefault<word>("T", "T")),
CpName_(coeffs_.lookupOrDefault<word>("Cp", "Cp")),
UName_(coeffs_.lookupOrDefault<word>("U", "U")),
phiName_(coeffs_.lookupOrDefault<word>("phi", "phi")),
Cu_(coeffs_.lookupOrDefault<scalar>("Cu", 100000)),
q_(coeffs_.lookupOrDefault("q", 0.001)),
beta_(readScalar(coeffs_.lookup("beta"))),

View File

@ -75,11 +75,11 @@ Description
relax | Relaxation coefficient [0-1] | no | 0.9
thermoMode | Thermo mode [thermo|lookup] | yes |
rhoRef | Reference (solid) density | yes |
rhoName | Name of density field | no | rho
TName | Name of temperature field | no | T
CpName | Name of specific heat capacity field | no | Cp
UName | Name of velocity field | no | U
phiName | Name of flux field | no | phi
rho | Name of density field | no | rho
T | Name of temperature field | no | T
Cp | Name of specific heat capacity field | no | Cp
U | Name of velocity field | no | U
phi | Name of flux field | no | phi
Cu | Model coefficient | no | 100000
q | Model coefficient | no | 0.001
beta | Thermal expansion coefficient [1/K] | yes |

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2014-2015 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2014-2016 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -39,8 +39,8 @@ bool Foam::fv::solidificationMeltingSource::read(const dictionary& dict)
mode_ = thermoModeTypeNames_.read(coeffs_.lookup("thermoMode"));
coeffs_.lookup("rhoRef") >> rhoRef_;
coeffs_.readIfPresent("TName", TName_);
coeffs_.readIfPresent("UName", UName_);
coeffs_.readIfPresent("T", TName_);
coeffs_.readIfPresent("U", UName_);
coeffs_.readIfPresent("Cu", Cu_);
coeffs_.readIfPresent("q", q_);

View File

@ -58,7 +58,7 @@ Foam::fv::tabulatedAccelerationSource::tabulatedAccelerationSource
:
option(name, modelType, dict, mesh),
motion_(coeffs_, mesh.time()),
UName_(coeffs_.lookupOrDefault<word>("UName", "U")),
UName_(coeffs_.lookupOrDefault<word>("U", "U")),
g0_("g0", dimAcceleration, Zero)
{
fieldNames_.setSize(1, UName_);

View File

@ -118,8 +118,8 @@ Foam::fv::interRegionExplicitPorositySource::interRegionExplicitPorositySource
interRegionOption(name, modelType, dict, mesh),
porosityPtr_(NULL),
firstIter_(true),
UName_(coeffs_.lookupOrDefault<word>("UName", "U")),
muName_(coeffs_.lookupOrDefault<word>("muName", "thermo:mu"))
UName_(coeffs_.lookupOrDefault<word>("U", "U")),
muName_(coeffs_.lookupOrDefault<word>("mu", "thermo:mu"))
{
if (active_)
{
@ -289,8 +289,8 @@ bool Foam::fv::interRegionExplicitPorositySource::read(const dictionary& dict)
{
if (interRegionOption::read(dict))
{
coeffs_.readIfPresent("UName", UName_);
coeffs_.readIfPresent("muName", muName_);
coeffs_.readIfPresent("U", UName_);
coeffs_.readIfPresent("mu", muName_);
// Reset the porosity model?

View File

@ -119,7 +119,7 @@ Foam::fv::interRegionHeatTransferModel::interRegionHeatTransferModel
dict,
mesh
),
nbrModelName_(coeffs_.lookup("nbrModelName")),
nbrModelName_(coeffs_.lookup("nbrModel")),
nbrModel_(NULL),
firstIter_(true),
timeIndex_(-1),
@ -143,12 +143,12 @@ Foam::fv::interRegionHeatTransferModel::interRegionHeatTransferModel
zeroGradientFvPatchScalarField::typeName
),
semiImplicit_(false),
TName_(coeffs_.lookupOrDefault<word>("TName", "T")),
TNbrName_(coeffs_.lookupOrDefault<word>("TNbrName", "T"))
TName_(coeffs_.lookupOrDefault<word>("T", "T")),
TNbrName_(coeffs_.lookupOrDefault<word>("TNbr", "T"))
{
if (active())
{
coeffs_.lookup("fieldNames") >> fieldNames_;
coeffs_.lookup("fields") >> fieldNames_;
applied_.setSize(fieldNames_.size(), false);
coeffs_.lookup("semiImplicit") >> semiImplicit_;

View File

@ -93,8 +93,8 @@ Foam::fv::tabulatedHeatTransfer::tabulatedHeatTransfer
)
:
interRegionHeatTransferModel(name, modelType, dict, mesh),
UName_(coeffs_.lookupOrDefault<word>("UName", "U")),
UNbrName_(coeffs_.lookupOrDefault<word>("UNbrName", "U")),
UName_(coeffs_.lookupOrDefault<word>("U", "U")),
UNbrName_(coeffs_.lookupOrDefault<word>("UNbr", "U")),
hTable_(),
AoV_(),
startTimeName_(mesh.time().timeName())

View File

@ -55,7 +55,7 @@ Foam::fv::variableHeatTransfer::variableHeatTransfer
)
:
interRegionHeatTransferModel(name, modelType, dict, mesh),
UNbrName_(coeffs_.lookupOrDefault<word>("UNbrName", "U")),
UNbrName_(coeffs_.lookupOrDefault<word>("UNbr", "U")),
a_(0),
b_(0),
c_(0),
@ -130,7 +130,7 @@ bool Foam::fv::variableHeatTransfer::read(const dictionary& dict)
{
if (interRegionHeatTransferModel::read(dict))
{
coeffs_.readIfPresent("UNbrName", UNbrName_);
coeffs_.readIfPresent("UNbr", UNbrName_);
coeffs_.readIfPresent("a", a_);
coeffs_.readIfPresent("b", b_);

View File

@ -1107,7 +1107,7 @@ Foam::InteractionLists<ParticleType>::InteractionLists(const polyMesh& mesh)
cellIndexAndTransformToDistribute_(),
wallFaceIndexAndTransformToDistribute_(),
referredWallFaces_(),
UName_("unknown_UName"),
UName_("unknown_U"),
referredWallData_(),
referredParticles_()
{}

View File

@ -39,7 +39,7 @@ Foam::ParticleTrap<CloudType>::ParticleTrap
CloudFunctionObject<CloudType>(dict, owner, modelName, typeName),
alphaName_
(
this->coeffDict().template lookupOrDefault<word>("alphaName", "alpha")
this->coeffDict().template lookupOrDefault<word>("alpha", "alpha")
),
alphaPtr_(NULL),
gradAlphaPtr_(NULL),

View File

@ -591,7 +591,7 @@ Foam::PairCollision<CloudType>::PairCollision
false
)
),
this->coeffDict().lookupOrDefault("UName", word("U"))
this->coeffDict().lookupOrDefault("U", word("U"))
)
{}

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2011-2013 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2011-2016 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -110,7 +110,7 @@ Foam::PatchInteractionModel<CloudType>::PatchInteractionModel
)
:
CloudSubModelBase<CloudType>(owner),
UName_("unknown_UName")
UName_("unknown_U")
{}
@ -123,7 +123,7 @@ Foam::PatchInteractionModel<CloudType>::PatchInteractionModel
)
:
CloudSubModelBase<CloudType>(owner, dict, typeName, type),
UName_(this->coeffDict().lookupOrDefault("UName", word("U")))
UName_(this->coeffDict().lookupOrDefault("U", word("U")))
{}

View File

@ -59,9 +59,6 @@ functions
setFormat vtk; //gnuplot, raw etc. See sampleDict.
// Velocity field to use for tracking.
UName U;
// Interpolation method. Default is cellPoint. See sampleDict.
//interpolationScheme pointMVC;

View File

@ -324,9 +324,9 @@ bool Foam::functionObjects::streamLine::read(const dictionary& dict)
Info<< type() << " " << name() << ":" << nl;
dict.lookup("fields") >> fields_;
if (dict.found("UName"))
if (dict.found("U"))
{
dict.lookup("UName") >> UName_;
dict.lookup("U") >> UName_;
}
else
{

View File

@ -40,7 +40,6 @@ Description
libs ("libfieldFunctionObjects.so");
...
setFormat vtk;
UName U;
trackForward yes;
fields
(
@ -66,15 +65,15 @@ Description
\heading Function object usage
\table
Property | Description | Required | Default value
type | type name: streamLine | yes |
setFormat | output data type | yes |
UName | tracking velocity field name | yes |
fields | fields to sample | yes |
lifetime | maximum number of particle tracking steps | yes |
trackLength | tracking segment length | no |
nSubCycle | number of tracking steps per cell | no|
cloudName | cloud name to use | yes |
seedSampleSet| seeding method (see below)| yes |
type | Type name: streamLine | yes |
setFormat | Output data type | yes |
U | Tracking velocity field name | yes |
fields | Fields to sample | yes |
lifetime | Maximum number of particle tracking steps | yes |
trackLength | Tracking segment length | no |
nSubCycle | Number of tracking steps per cell | no|
cloudName | Cloud name to use | yes |
seedSampleSet| Seeding method (see below)| yes |
\endtable
\linebreak

View File

@ -92,7 +92,7 @@ functions
setFormat vtk; //gnuplot; //xmgr; //raw; //jplot;
// Velocity field to use for tracking.
UName UNear;
U UNear;
// Interpolation method. Default is cellPoint. See sampleDict.
//interpolationScheme pointMVC;

View File

@ -441,9 +441,9 @@ bool Foam::functionObjects::wallBoundedStreamLine::read(const dictionary& dict)
{
//dict_ = dict;
dict.lookup("fields") >> fields_;
if (dict.found("UName"))
if (dict.found("U"))
{
dict.lookup("UName") >> UName_;
dict.lookup("U") >> UName_;
}
else
{

View File

@ -40,7 +40,7 @@ Description
libs ("libfieldFunctionObjects.so");
...
setFormat vtk;
UName UNear;
U UNear;
trackForward yes;
fields
(
@ -65,15 +65,15 @@ Description
\heading Function object usage
\table
Property | Description | Required | Default value
type | type name: wallBoundedStreamLine| yes |
setFormat | output data type | yes |
UName | tracking velocity field name | yes |
fields | fields to sample | yes |
lifetime | maximum number of particle tracking steps | yes |
trackLength | tracking segment length | no |
nSubCycle | number of tracking steps per cell | no|
cloudName | cloud name to use | yes |
seedSampleSet| seeding method (see below)| yes |
type | Type name: wallBoundedStreamLine| yes |
setFormat | Output data type | yes |
U | Tracking velocity field name | yes |
fields | Fields to sample | yes |
lifetime | Maximum number of particle tracking steps | yes |
trackLength | Tracking segment length | no |
nSubCycle | Number of tracking steps per cell | no|
cloudName | Cloud name to use | yes |
seedSampleSet| Seeding method (see below)| yes |
\endtable
\linebreak

View File

@ -624,14 +624,14 @@ bool Foam::functionObjects::forces::read(const dictionary& dict)
if (directForceDensity_)
{
// Optional entry for fDName
fDName_ = dict.lookupOrDefault<word>("fDName", "fD");
fDName_ = dict.lookupOrDefault<word>("fD", "fD");
}
else
{
// Optional entries U and p
pName_ = dict.lookupOrDefault<word>("pName", "p");
UName_ = dict.lookupOrDefault<word>("UName", "U");
rhoName_ = dict.lookupOrDefault<word>("rhoName", "rho");
pName_ = dict.lookupOrDefault<word>("p", "p");
UName_ = dict.lookupOrDefault<word>("U", "U");
rhoName_ = dict.lookupOrDefault<word>("rho", "rho");
// Reference density needed for incompressible calculations
rhoRef_ = readScalar(dict.lookup("rhoInf"));

View File

@ -57,15 +57,15 @@ Description
\heading Function object usage
\table
Property | Description | Required | Default value
type | type name: forces | yes |
log | write force data to standard output | no | no
patches | patches included in the forces calculation | yes |
pName | pressure field name | no | p
UName | velocity field name | no | U
rhoName | density field name (see below) | no | rho
CofR | centre of rotation (see below) | no |
directForceDensity | force density supplied directly (see below)|no|no
fDName | name of force density field (see below) | no | fD
type | Type name: forces | yes |
log | Write force data to standard output | no | no
patches | Patches included in the forces calculation | yes |
p | Pressure field name | no | p
U | Velocity field name | no | U
rho | Density field name (see below) | no | rho
CofR | Centre of rotation (see below) | no |
directForceDensity | Force density supplied directly (see below)|no|no
fD | Name of force density field (see below) | no | fD
\endtable
Bin data is optional, but if the dictionary is present, the entries must
@ -77,7 +77,7 @@ Description
\endtable
Note
- For incompressible cases, set \c rhoName to \c rhoInf. You will then be
- For incompressible cases, set \c rho to \c rhoInf. You will then be
required to provide a \c rhoInf value corresponding to the free-stream
constant density.
- If the force density is supplied directly, set the \c directForceDensity
@ -222,7 +222,7 @@ protected:
//- Dynamic viscosity field
tmp<volScalarField> mu() const;
//- Return rho if rhoName is specified otherwise rhoRef
//- Return rho if specified otherwise rhoRef
tmp<volScalarField> rho() const;
//- Return rhoRef if the pressure field is dynamic, i.e. p/rho

View File

@ -240,9 +240,9 @@ Foam::functionObjects::pressureTools::~pressureTools()
bool Foam::functionObjects::pressureTools::read(const dictionary& dict)
{
dict.readIfPresent("pName", pName_);
dict.readIfPresent("UName", UName_);
dict.readIfPresent("rhoName", rhoName_);
dict.readIfPresent("p", pName_);
dict.readIfPresent("U", UName_);
dict.readIfPresent("rho", rhoName_);
if (rhoName_ == "rhoInf")
{

View File

@ -64,8 +64,8 @@ Foam::functionObjects::blendingFactor::~blendingFactor()
bool Foam::functionObjects::blendingFactor::read(const dictionary& dict)
{
phiName_ = dict.lookupOrDefault<word>("phiName", "phi");
dict.lookup("fieldName") >> fieldName_;
phiName_ = dict.lookupOrDefault<word>("phi", "phi");
dict.lookup("field") >> fieldName_;
return true;
}

View File

@ -197,9 +197,9 @@ bool Foam::functionObjects::scalarTransport::read(const dictionary& dict)
{
Info<< type() << ":" << nl;
phiName_ = dict.lookupOrDefault<word>("phiName", "phi");
UName_ = dict.lookupOrDefault<word>("UName", "U");
rhoName_ = dict.lookupOrDefault<word>("rhoName", "rho");
phiName_ = dict.lookupOrDefault<word>("phi", "phi");
UName_ = dict.lookupOrDefault<word>("U", "U");
rhoName_ = dict.lookupOrDefault<word>("rho", "rho");
userDT_ = false;
if (dict.readIfPresent("DT", DT_))

View File

@ -116,7 +116,7 @@ Foam::functionObjects::yPlus::~yPlus()
bool Foam::functionObjects::yPlus::read(const dictionary& dict)
{
writeFiles::read(dict);
phiName_ = dict.lookupOrDefault<word>("phiName", "phi");
phiName_ = dict.lookupOrDefault<word>("phi", "phi");
return true;
}

View File

@ -66,7 +66,7 @@ constantFilmThermo::constantFilmThermo
)
:
filmThermoModel(typeName, owner, dict),
name_(coeffDict_.lookup("specieName")),
name_(coeffDict_.lookup("specie")),
rho0_("rho0"),
mu0_("mu0"),
sigma0_("sigma0"),

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2013 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2013-2016 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -59,27 +59,23 @@ public:
struct thermoData
{
// private:
word name_;
scalar value_;
bool set_;
// public:
thermoData()
:
name_("unknown"),
value_(0.0),
set_(false)
{}
thermoData(const word& n)
:
name_(n),
value_(0.0),
set_(false)
{}
// virtual ~thermoData()
// {}
};

View File

@ -114,7 +114,7 @@ Foam::rigidBodyMeshMotion::rigidBodyMeshMotion
),
test_(coeffDict().lookupOrDefault<Switch>("test", false)),
rhoInf_(1.0),
rhoName_(coeffDict().lookupOrDefault<word>("rhoName", "rho")),
rhoName_(coeffDict().lookupOrDefault<word>("rho", "rho")),
curTimeIndex_(-1)
{
if (rhoName_ == "rhoInf")
@ -253,7 +253,7 @@ void Foam::rigidBodyMeshMotion::solve()
forcesDict.add("type", functionObjects::forces::typeName);
forcesDict.add("patches", bodyMeshes_[bi].patches_);
forcesDict.add("rhoInf", rhoInf_);
forcesDict.add("rhoName", rhoName_);
forcesDict.add("rho", rhoName_);
forcesDict.add("CofR", vector::zero);
functionObjects::forces f("forces", db(), forcesDict);

View File

@ -108,7 +108,7 @@ class rigidBodyMeshMotion
Switch test_;
//- Reference density required by the forces object for
// incompressible calculations, required if rhoName == rhoInf
// incompressible calculations, required if rho == rhoInf
scalar rhoInf_;
//- Name of density field, optional unless used for an

View File

@ -68,7 +68,7 @@ sixDoFRigidBodyDisplacementPointPatchVectorField
fixedValuePointPatchField<vector>(p, iF, dict),
motion_(dict, dict),
rhoInf_(1.0),
rhoName_(dict.lookupOrDefault<word>("rhoName", "rho")),
rhoName_(dict.lookupOrDefault<word>("rho", "rho")),
lookupGravity_(-1),
g_(Zero),
curTimeIndex_(-1)
@ -213,7 +213,7 @@ void sixDoFRigidBodyDisplacementPointPatchVectorField::updateCoeffs()
forcesDict.add("type", functionObjects::forces::typeName);
forcesDict.add("patches", wordList(1, ptPatch.name()));
forcesDict.add("rhoInf", rhoInf_);
forcesDict.add("rhoName", rhoName_);
forcesDict.add("rho", rhoName_);
forcesDict.add("CofR", motion_.centreOfRotation());
functionObjects::forces f("forces", db(), forcesDict);
@ -255,7 +255,7 @@ void sixDoFRigidBodyDisplacementPointPatchVectorField::write(Ostream& os) const
{
pointPatchField<vector>::write(os);
os.writeKeyword("rhoName") << rhoName_ << token::END_STATEMENT << nl;
os.writeKeyword("rho") << rhoName_ << token::END_STATEMENT << nl;
if (rhoName_ == "rhoInf")
{

View File

@ -60,7 +60,7 @@ class sixDoFRigidBodyDisplacementPointPatchVectorField
pointField initialPoints_;
//- Reference density required by the forces object for
// incompressible calculations, required if rhoName == rhoInf
// incompressible calculations, required if rho == rhoInf
scalar rhoInf_;
//- Name of density field, optional unless used for an

View File

@ -87,7 +87,7 @@ Foam::sixDoFRigidBodyMotionSolver::sixDoFRigidBodyMotionSolver
do_(readScalar(coeffDict().lookup("outerDistance"))),
test_(coeffDict().lookupOrDefault<Switch>("test", false)),
rhoInf_(1.0),
rhoName_(coeffDict().lookupOrDefault<word>("rhoName", "rho")),
rhoName_(coeffDict().lookupOrDefault<word>("rho", "rho")),
scale_
(
IOobject
@ -219,7 +219,7 @@ void Foam::sixDoFRigidBodyMotionSolver::solve()
forcesDict.add("type", functionObjects::forces::typeName);
forcesDict.add("patches", patches_);
forcesDict.add("rhoInf", rhoInf_);
forcesDict.add("rhoName", rhoName_);
forcesDict.add("rho", rhoName_);
forcesDict.add("CofR", motion_.centreOfRotation());
functionObjects::forces f("forces", db(), forcesDict);

View File

@ -2,7 +2,7 @@
========= |
\\ / F ield | OpenFOAM: The Open Source CFD Toolbox
\\ / O peration |
\\ / A nd | Copyright (C) 2013-2015 OpenFOAM Foundation
\\ / A nd | Copyright (C) 2013-2016 OpenFOAM Foundation
\\/ M anipulation |
-------------------------------------------------------------------------------
License
@ -75,7 +75,7 @@ class sixDoFRigidBodyMotionSolver
Switch test_;
//- Reference density required by the forces object for
// incompressible calculations, required if rhoName == rhoInf
// incompressible calculations, required if rho == rhoInf
scalar rhoInf_;
//- Name of density field, optional unless used for an

View File

@ -88,7 +88,7 @@ Foam::radiation::mixtureFractionSoot<ThermoType>::mixtureFractionSoot
sootMax_(-1),
mappingFieldName_
(
coeffsDict_.lookupOrDefault<word>("mappingFieldName", "none")
coeffsDict_.lookupOrDefault<word>("mappingField", "none")
),
mapFieldMax_(1),
thermo_(mesh.lookupObject<fluidThermo>(basicThermo::dictName)),

View File

@ -47,7 +47,7 @@ Description
{
nuSoot 0.015;
Wsoot 12;
mappingFieldName P;
mappingField P;
}
SourceFiles

View File

@ -31,7 +31,7 @@ Description
\table
Property | Description | Required | Default value
TName | Temperature field name | no | T
T | Temperature field name | no | T
theta0 | Contact angle data | yes |
\endtable

View File

@ -44,7 +44,6 @@ boundaryField
openingTime 0.01;
maxOpenFractionDelta 0.1;
openFraction 0;
p p;
minThresholdValue 8000;
forceBased 0;
}

View File

@ -56,7 +56,6 @@ dictionaryReplacement
openingTime 0.01;
maxOpenFractionDelta 0.1;
openFraction 0;
p p;
minThresholdValue 8000;
forceBased 0;
value uniform (0 0 0);

View File

@ -45,16 +45,12 @@ boundaryField
inlet
{
type totalFlowRateAdvectiveDiffusive;
phi phi;
rho rho;
value uniform 1;
}
region0_to_pyrolysisRegion_coupledWall
{
type totalFlowRateAdvectiveDiffusive;
phi phi;
rho rho;
massFluxFraction 1.0;
value $internalField;
}

View File

@ -24,7 +24,6 @@ boundaryField
region0_to_pyrolysisRegion_coupledWall
{
type greyDiffusiveRadiation;
T T;
emissivityMode solidRadiation;
emissivity uniform 1.0;
value uniform 0;
@ -38,7 +37,6 @@ boundaryField
".*"
{
type greyDiffusiveRadiation;
T T;
emissivityMode lookup;
emissivity uniform 1.0;
value uniform 0;

View File

@ -50,8 +50,6 @@ boundaryField
region0_to_pyrolysisRegion_coupledWall
{
type totalFlowRateAdvectiveDiffusive;
phi phi;
rho rho;
massFluxFraction 0.0;
value $internalField;
}

View File

@ -52,10 +52,9 @@ boundaryField
pyrolysisRegion pyrolysisRegion;
filmRegion filmRegion;
Tnbr T;
kappa fluidThermo;
kappaMethod fluidThermo;
QrNbr none;
Qr Qr;
kappaName none;
filmDeltaDry 0.0;
filmDeltaWet 2e-4;
value $internalField;

View File

@ -38,7 +38,6 @@ boundaryField
side
{
type pressureInletOutletVelocity;
phi phi;
value $internalField;
}
@ -52,9 +51,7 @@ boundaryField
region0_to_pyrolysisRegion_coupledWall
{
type mappedFlowRate;
phi phi;
nbrPhi phiGas;
rho rho;
value uniform (0 0 0);
}
}

View File

@ -44,16 +44,12 @@ boundaryField
inlet
{
type fixedValue;
phi phi;
rho rho;
value uniform 0;
}
region0_to_pyrolysisRegion_coupledWall
{
type totalFlowRateAdvectiveDiffusive;
phi phi;
rho rho;
massFluxFraction 0.0;
value $internalField;
}

View File

@ -29,7 +29,7 @@ boundaryField
sampleMode nearestPatchFace;
samplePatch region0_to_pyrolysisRegion_coupledWall;
offset (0 0 0);
fieldName T;
field T;
setAverage no;
average 0;
value uniform 298;

View File

@ -38,7 +38,7 @@ boundaryField
sampleMode nearestPatchFace;
samplePatch region0_to_pyrolysisRegion_coupledWall;
offset (0 0 0);
fieldName Qr; // this is the name of Qr field in region0
field Qr; // this is the name of Qr field in region0
setAverage no;
average 0;
value uniform 0;

View File

@ -37,8 +37,7 @@ boundaryField
pyrolysisRegion pyrolysisRegion;
filmRegion filmRegion;
Tnbr T;
kappa solidThermo;
kappaName none;
kappaMethod solidThermo;
QrNbr Qr;
Qr none;
filmDeltaDry 0.0;

View File

@ -40,15 +40,11 @@ boundaryField
burner
{
type totalFlowRateAdvectiveDiffusive;
phi phi;
rho rho;
value uniform 1.0;
}
"(region0_to.*)"
{
type totalFlowRateAdvectiveDiffusive;
phi phi;
rho rho;
value $internalField;
}
}

View File

@ -23,7 +23,6 @@ boundaryField
".*"
{
type MarshakRadiation;
T T;
emissivityMode lookup;
emissivity uniform 1.0;
value uniform 0;
@ -32,7 +31,6 @@ boundaryField
"(region0_to.*)"
{
type MarshakRadiation;
T T;
emissivityMode solidRadiation;
value uniform 0;
}

View File

@ -23,7 +23,6 @@ boundaryField
".*"
{
type greyDiffusiveRadiation;
T T;
emissivityMode lookup;
emissivity uniform 1.0;
value uniform 0;
@ -31,7 +30,6 @@ boundaryField
"(region0_to.*)"
{
type greyDiffusiveRadiation;
T T;
emissivityMode solidRadiation;
value uniform 0;
}

View File

@ -50,10 +50,9 @@ boundaryField
{
type compressible::turbulentTemperatureRadCoupledMixed;
Tnbr T;
kappa fluidThermo;
kappaMethod fluidThermo;
QrNbr none;
Qr Qr;
kappaName none;
value $internalField;
}
}

View File

@ -37,16 +37,13 @@ boundaryField
"(top|sides)"
{
type pressureInletOutletVelocity;
phi phi;
value $internalField;
}
"(region0_to.*)"
{
type mappedFlowRate;
phi phi;
nbrPhi phiGas;
rho rho;
value uniform (0 0 0);
}
}

View File

@ -43,7 +43,7 @@ boundaryField
sampleMode nearestPatchFace;
samplePatch region0_to_panelRegion_fLeft_zone;
offset (0 0 0);
fieldName Qr;
field Qr;
setAverage no;
average 0;
value uniform 0;
@ -56,7 +56,7 @@ boundaryField
sampleMode nearestPatchFace;
samplePatch region0_to_panelRegion_fRight_zone;
offset (0 0 0);
fieldName Qr;
field Qr;
setAverage no;
average 0;
value uniform 0;

View File

@ -41,8 +41,7 @@ boundaryField
{
type compressible::turbulentTemperatureRadCoupledMixed;
Tnbr T;
kappa solidThermo;
kappaName none;
kappaMethod solidThermo;
QrNbr Qr;
Qr none;
value uniform 298.15;

View File

@ -23,7 +23,6 @@ boundaryField
".*"
{
type MarshakRadiation;
T T;
emissivityMode lookup;
emissivity uniform 1.0;
value uniform 0;

View File

@ -23,7 +23,6 @@ boundaryField
".*"
{
type greyDiffusiveRadiation;
T T;
emissivityMode lookup;
emissivity uniform 1.0;
value uniform 0;

View File

@ -23,7 +23,6 @@ boundaryField
".*"
{
type MarshakRadiation;
T T;
emissivityMode lookup;
emissivity uniform 1.0;
value uniform 0;

View File

@ -23,7 +23,6 @@ boundaryField
".*"
{
type greyDiffusiveRadiation;
T T;
emissivityMode lookup;
emissivity uniform 1;
value uniform 0;

View File

@ -25,7 +25,6 @@ boundaryField
{
type pressureInletOutletVelocity;
value uniform (0 0 0);
phi phi;
}
base

View File

@ -33,8 +33,6 @@ boundaryField
{
type totalPressure;
p0 $internalField;
U U;
phi phi;
rho none;
psi none;
gamma 1;

View File

@ -33,8 +33,6 @@ boundaryField
{
type totalPressure;
p0 $internalField;
U U;
phi phi;
rho none;
psi none;
gamma 1;

View File

@ -39,8 +39,6 @@ boundaryField
{
type totalPressure;
p0 $internalField;
U U;
phi phi;
rho none;
psi none;
gamma 1;

View File

@ -36,8 +36,6 @@ boundaryField
type totalTemperature;
value uniform 297;
T0 uniform 297;
U U;
phi phi;
rho none;
psi thermo:psi;
gamma 1.4;

View File

@ -30,8 +30,6 @@ boundaryField
{
type waveTransmissive;
field p;
phi phi;
rho rho;
psi thermo:psi;
fieldInf 101325;
gamma 1.4;
@ -44,8 +42,6 @@ boundaryField
type totalPressure;
value uniform 101325;
p0 uniform 101325;
U U;
phi phi;
rho none;
psi thermo:psi;
gamma 1.4;

View File

@ -1241,8 +1241,6 @@ boundaryField
freestream
{
type totalTemperature;
U U;
phi phi;
psi thermo:psi;
gamma 1.4;
T0 uniform 297;

View File

@ -1233,8 +1233,6 @@ boundaryField
{
type waveTransmissive;
field p;
phi phi;
rho rho;
psi thermo:psi;
gamma 1.4;
fieldInf 101325;
@ -1272,8 +1270,6 @@ boundaryField
freestream
{
type totalPressure;
U U;
phi phi;
rho none;
psi thermo:psi;
gamma 1.4;

View File

@ -44,8 +44,6 @@ outlet
type totalPressure;
value uniform 1e5;
p0 uniform 1e5;
U U;
phi phi;
rho rho;
psi none;
gamma 1.4;

View File

@ -24,8 +24,6 @@ boundaryField
inlet
{
type flowRateInletVelocity;
phi phi;
rho rho;
massFlowRate 0.0001;
value uniform (0 0 0);
}
@ -51,8 +49,6 @@ boundaryField
plenum
{
type pressureInletVelocity;
phi phi;
rho rho;
value uniform (0 0 0);
}
}

View File

@ -28,7 +28,6 @@ boundaryField
outlet
{
type waveTransmissive;
phi phi;
psi thermo:psi;
gamma 1.3;
fieldInf 1e5;

View File

@ -39,8 +39,6 @@ boundaryField
{
type totalPressure;
p0 $internalField;
U U;
phi phi;
rho none;
psi none;
gamma 1;

View File

@ -30,8 +30,6 @@ boundaryField
{
type waveTransmissive;
field p;
phi phi;
rho rho;
psi thermo:psi;
gamma 1.4;
fieldInf 1;

View File

@ -29,8 +29,6 @@ boundaryField
{
type waveTransmissive;
field p;
phi phi;
rho rho;
psi thermo:psi;
gamma 1.3;
fieldInf 100000;

View File

@ -59,8 +59,6 @@ functions
WALL10
);
pName p;
UName U;
log true;
rhoInf 1;
CofR (0 0 0);

View File

@ -30,8 +30,6 @@ boundaryField
{
type waveTransmissive;
field p;
phi phi;
rho rho;
psi thermo:psi;
gamma 1.3;
fieldInf 100000;

View File

@ -24,8 +24,7 @@ boundaryField
bottom
{
type compressible::thermalBaffle;
kappa solidThermo;
kappaName none;
kappaMethod solidThermo;
value uniform 300;
}
side
@ -35,8 +34,7 @@ boundaryField
top
{
type compressible::thermalBaffle;
kappa solidThermo;
kappaName none;
kappaMethod solidThermo;
value uniform 300;
}
}

View File

@ -9,18 +9,16 @@
T
{
type compressible::thermalBaffle;
kappa fluidThermo;
kappaName none;
kappaMethod fluidThermo;
value uniform 300;
regionName ${baffleRegionName};
active yes;
regionName ${baffleRegionName};
active yes;
# include "3DbaffleSolidThermo"
// New fvMesh (region) information
# include "extrudeModel"
}
// ************************************************************************* //

View File

@ -23,7 +23,6 @@ boundaryField
floor
{
type MarshakRadiation;
T T;
emissivityMode lookup;
emissivity uniform 1.0;
value uniform 0;
@ -32,7 +31,6 @@ boundaryField
fixedWalls
{
type MarshakRadiation;
T T;
emissivityMode lookup;
emissivity uniform 1.0;
value uniform 0;
@ -41,7 +39,6 @@ boundaryField
ceiling
{
type MarshakRadiation;
T T;
emissivityMode lookup;
emissivity uniform 1.0;
value uniform 0;
@ -50,7 +47,6 @@ boundaryField
box
{
type MarshakRadiation;
T T;
emissivityMode lookup;
emissivity uniform 1.0;
value uniform 0;

View File

@ -23,7 +23,6 @@ boundaryField
".*"
{
type MarshakRadiation;
T T;
emissivityMode lookup;
emissivity uniform 1.0;
value uniform 0;

View File

@ -23,7 +23,6 @@ boundaryField
".*"
{
type greyDiffusiveRadiation;
T T;
emissivityMode lookup;
emissivity uniform 1.0;
value uniform 0;

View File

@ -52,24 +52,21 @@ boundaryField
type compressible::turbulentTemperatureCoupledBaffleMixed;
value uniform 300;
Tnbr T;
kappa fluidThermo;
kappaName none;
kappaMethod fluidthermo;
}
bottomWater_to_leftSolid
{
type compressible::turbulentTemperatureCoupledBaffleMixed;
value uniform 300;
Tnbr T;
kappa fluidThermo;
kappaName none;
kappaMethod fluidthermo;
}
bottomWater_to_heater
{
type compressible::turbulentTemperatureCoupledBaffleMixed;
value uniform 300;
Tnbr T;
kappa fluidThermo;
kappaName none;
kappaMethod fluidthermo;
}
}

View File

@ -70,8 +70,7 @@ dictionaryReplacement
{
type compressible::turbulentTemperatureCoupledBaffleMixed;
Tnbr T;
kappa fluidThermo;
kappaName none;
kappaMethod fluidThermo;
value uniform 300;
}
}

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