dimensioned< Type > Class Template Reference

Generic dimensioned Type class. More...

Inheritance diagram for dimensioned< Type >:
[legend]

Public Types

typedef Type value_type
 The underlying data type. More...
 
typedef pTraits< Type >::cmptType cmptType
 Component type. More...
 

Public Member Functions

 dimensioned ()
 A dimensionless Zero, named "0". More...
 
 dimensioned (const dimensionSet &dims)
 A dimensioned Zero, named "0". More...
 
 dimensioned (const dimensionSet &dims, const Foam::zero)
 A dimensioned Zero, named "0". More...
 
 dimensioned (const dimensionSet &dims, const Foam::one)
 A dimensioned pTraits::one, named "1". More...
 
 dimensioned (const Type &val)
 Implicit construct dimensionless from given value. More...
 
 dimensioned (const dimensionSet &dims, const Type &val)
 Construct dimensioned from given value. More...
 
 dimensioned (const word &name, const dimensionSet &dims, const Type &val)
 Construct from components (name, dimensions, value). More...
 
 dimensioned (const word &name, const dimensioned< Type > &dt)
 Copy construct dimensioned Type with a new name. More...
 
 dimensioned (const primitiveEntry &e)
 Construct from primitive entry with given name. More...
 
 dimensioned (const primitiveEntry &e, const dimensionSet &dims)
 Construct from primitive entry with given name and dimensions. More...
 
 dimensioned (const word &name, const dictionary &dict)
 Construct from dictionary lookup with a given name. More...
 
 dimensioned (const word &name, const dimensionSet &dims, const dictionary &dict)
 Construct from dictionary lookup with a given name and dimensions. More...
 
 dimensioned (const word &name, const dimensionSet &dims, const dictionary &dict, const word &entryName)
 Construct from dictionary lookup with a given name and dimensions. More...
 
 dimensioned (const word &name, const dimensionSet &dims, const Type &val, const dictionary &dict)
 
const wordname () const
 Return const reference to name. More...
 
wordname ()
 Return non-const reference to name. More...
 
const dimensionSetdimensions () const
 Return const reference to dimensions. More...
 
dimensionSetdimensions ()
 Return non-const reference to dimensions. More...
 
const Type & value () const
 Return const reference to value. More...
 
Type & value ()
 Return non-const reference to value. More...
 
dimensioned< cmptTypecomponent (const direction d) const
 Return a component as a dimensioned<cmptType> More...
 
void replace (const direction d, const dimensioned< cmptType > &dc)
 Return a component with a dimensioned<cmptType> More...
 
dimensioned< Type > T () const
 Return transpose. More...
 
bool read (const dictionary &dict)
 
bool readIfPresent (const dictionary &dict)
 
bool read (const word &entryName, const dictionary &dict)
 
bool readIfPresent (const word &entryName, const dictionary &dict)
 
Istreamread (Istream &is, const bool readName=true)
 
Istreamread (Istream &is, const dictionary &readSet)
 
Istreamread (Istream &is, const HashTable< dimensionedScalar > &readSet)
 
void writeEntry (const word &keyword, Ostream &os) const
 Write as a dictionary entry with keyword. More...
 
dimensioned< cmptTypeoperator[] (const direction d) const
 Return a component as a dimensioned<cmptType> More...
 
void operator+= (const dimensioned< Type > &dt)
 
void operator-= (const dimensioned< Type > &dt)
 
void operator*= (const scalar s)
 
void operator/= (const scalar s)
 
 dimensioned (Istream &is)
 
 dimensioned (const word &name, Istream &is)
 
 dimensioned (const word &name, const dimensionSet &dims, Istream &is)
 

Static Public Member Functions

static dimensioned< Type > getOrDefault (const word &name, const dictionary &dict, const dimensionSet &dims=dimless, const Type &deflt=Type(Zero))
 Construct dimensioned from dictionary, with default value. More...
 
static dimensioned< Type > getOrDefault (const word &name, const dictionary &dict, const Type &deflt=Type(Zero))
 Construct dimensionless from dictionary, with default value. More...
 
static dimensioned< Type > getOrAddToDict (const word &name, dictionary &dict, const dimensionSet &dims=dimless, const Type &deflt=Type(Zero))
 Construct dimensioned from dictionary, with default value. More...
 
static dimensioned< Type > getOrAddToDict (const word &name, dictionary &dict, const Type &deflt=Type(Zero))
 Construct dimensionless from dictionary, with default value. More...
 
static dimensioned< Type > lookupOrDefault (const word &name, const dictionary &dict, const dimensionSet &dims=dimless, const Type &deflt=Type(Zero))
 
static dimensioned< Type > lookupOrDefault (const word &name, const dictionary &dict, const Type &deflt=Type(Zero))
 Construct dimensionless from dictionary, with default value. More...
 
static dimensioned< Type > lookupOrAddToDict (const word &name, dictionary &dict, const dimensionSet &dims=dimless, const Type &deflt=Type(Zero))
 Construct dimensioned from dictionary, with default value. More...
 
static dimensioned< Type > lookupOrAddToDict (const word &name, dictionary &dict, const Type &deflt=Type(Zero))
 Construct dimensionless from dictionary, with default value. More...
 

Friends

Istreamoperator>> (Istream &is, dimensioned< Type > &dt)
 Read from stream. The name and dimensions are optional. More...
 

Detailed Description

template<class Type>
class Foam::dimensioned< Type >

Generic dimensioned Type class.

Source files

Definition at line 66 of file dimensionedType.H.

Member Typedef Documentation

◆ value_type

typedef Type value_type

The underlying data type.

Definition at line 117 of file dimensionedType.H.

◆ cmptType

typedef pTraits<Type>::cmptType cmptType

Component type.

Definition at line 120 of file dimensionedType.H.

Constructor & Destructor Documentation

◆ dimensioned() [1/17]

A dimensionless Zero, named "0".

Definition at line 113 of file dimensionedType.C.

◆ dimensioned() [2/17]

dimensioned ( const dimensionSet dims)
explicit

A dimensioned Zero, named "0".

Definition at line 122 of file dimensionedType.C.

◆ dimensioned() [3/17]

dimensioned ( const dimensionSet dims,
const Foam::zero   
)
explicit

A dimensioned Zero, named "0".

Definition at line 131 of file dimensionedType.C.

◆ dimensioned() [4/17]

dimensioned ( const dimensionSet dims,
const Foam::one   
)
explicit

A dimensioned pTraits::one, named "1".

Definition at line 144 of file dimensionedType.C.

◆ dimensioned() [5/17]

dimensioned ( const Type &  val)
inline

Implicit construct dimensionless from given value.

Definition at line 138 of file dimensionedType.H.

◆ dimensioned() [6/17]

dimensioned ( const dimensionSet dims,
const Type &  val 
)

Construct dimensioned from given value.

Definition at line 157 of file dimensionedType.C.

◆ dimensioned() [7/17]

dimensioned ( const word name,
const dimensionSet dims,
const Type &  val 
)

Construct from components (name, dimensions, value).

Definition at line 170 of file dimensionedType.C.

◆ dimensioned() [8/17]

dimensioned ( const word name,
const dimensioned< Type > &  dt 
)

Copy construct dimensioned Type with a new name.

Definition at line 184 of file dimensionedType.C.

◆ dimensioned() [9/17]

dimensioned ( const primitiveEntry e)
explicit

Construct from primitive entry with given name.

The entry may contain optional name and dimensions.

[name] [dims] value

If the optional name is found, it is used for renaming. If the optional dimensions are present, they are read and used without further verification. If no dimensions are found, the quantity is dimensionless. Fatal if not primitiveEntry or if number of tokens is incorrect.

Definition at line 197 of file dimensionedType.C.

◆ dimensioned() [10/17]

dimensioned ( const primitiveEntry e,
const dimensionSet dims 
)
explicit

Construct from primitive entry with given name and dimensions.

The entry may contain optional name and dimensions.

[name] [dims] value

If the optional name is found, it is used for renaming. If the optional dimensions are present, they are read and verified against the expected dimensions. Fatal if not primitiveEntry or if number of tokens is incorrect.

Definition at line 216 of file dimensionedType.C.

References e.

◆ dimensioned() [11/17]

dimensioned ( const word name,
const dictionary dict 
)

Construct from dictionary lookup with a given name.

The entry may contain optional name and dimensions.

[name] [dims] value

If the optional name is found, it is used for renaming. If the optional dimensions are present, they are read and used without further verification. If no dimensions are found, the quantity is dimensionless.

Definition at line 236 of file dimensionedType.C.

◆ dimensioned() [12/17]

dimensioned ( const word name,
const dimensionSet dims,
const dictionary dict 
)

Construct from dictionary lookup with a given name and dimensions.

The entry may contain optional name and dimensions.

[name] [dims] value

If the optional name is found, it is used for renaming. If the optional dimensions are present, they are read and verified against the expected dimensions.

Definition at line 252 of file dimensionedType.C.

◆ dimensioned() [13/17]

dimensioned ( const word name,
const dimensionSet dims,
const dictionary dict,
const word entryName 
)

Construct from dictionary lookup with a given name and dimensions.

The entry may contain optional name and dimensions.

[name] [dims] value

If the optional name is found, it is used for renaming. If the optional dimensions are present, they are read and verified against the expected dimensions.

Parameters
entryNamedictionary lookup name

Definition at line 269 of file dimensionedType.C.

◆ dimensioned() [14/17]

dimensioned ( const word name,
const dimensionSet dims,
const Type &  val,
const dictionary dict 
)

Construct from components (name, dimensions, value) with optional dictionary override.

The entry may contain optional name and dimensions.

[name] [dims] value

Definition at line 287 of file dimensionedType.C.

◆ dimensioned() [15/17]

dimensioned ( Istream is)
explicit

Deprecated(2018-11) Construct from Istream (expects name, dimensions, value)

Deprecated:
(2018-11) - should generally use construct from dictionary or primitiveEntry instead (additional checks on the input stream).

Definition at line 305 of file dimensionedType.C.

◆ dimensioned() [16/17]

dimensioned ( const word name,
Istream is 
)

Deprecated(2018-11) Construct from Istream with given name (expects dimensions, value)

Deprecated:
(2018-11) - should generally use construct from dictionary or primitiveEntry instead (additional checks on the input stream).

Definition at line 314 of file dimensionedType.C.

◆ dimensioned() [17/17]

dimensioned ( const word name,
const dimensionSet dims,
Istream is 
)

Deprecated(2018-11) Construct from Istream with given name and expected dimensions.

Expects value, but supports optional name and dimensions. If the optional dimensions are present, they are read and verified against the expected dimensions.

Deprecated:
(2018-11) - should generally use construct from dictionary or primitiveEntry instead (additional checks on the input stream).

Definition at line 328 of file dimensionedType.C.

Member Function Documentation

◆ getOrDefault() [1/2]

Foam::dimensioned< Type > getOrDefault ( const word name,
const dictionary dict,
const dimensionSet dims = dimless,
const Type &  deflt = Type(Zero) 
)
static

Construct dimensioned from dictionary, with default value.

FatalIOError if there are excess tokens.

Definition at line 347 of file dimensionedType.C.

Referenced by dimensioned< Type >::lookupOrDefault().

Here is the caller graph for this function:

◆ getOrDefault() [2/2]

Foam::dimensioned< Type > getOrDefault ( const word name,
const dictionary dict,
const Type &  deflt = Type(Zero) 
)
static

Construct dimensionless from dictionary, with default value.

FatalIOError if it is found and there are excess tokens.

Definition at line 361 of file dimensionedType.C.

References dict, Foam::dimless, and Foam::name().

Here is the call graph for this function:

◆ getOrAddToDict() [1/2]

Foam::dimensioned< Type > getOrAddToDict ( const word name,
dictionary dict,
const dimensionSet dims = dimless,
const Type &  deflt = Type(Zero) 
)
static

Construct dimensioned from dictionary, with default value.

If the value is not found, it is added into the dictionary. FatalIOError if it is found and there are excess tokens.

Definition at line 373 of file dimensionedType.C.

◆ getOrAddToDict() [2/2]

Foam::dimensioned< Type > getOrAddToDict ( const word name,
dictionary dict,
const Type &  deflt = Type(Zero) 
)
static

Construct dimensionless from dictionary, with default value.

If the value is not found, it is added into the dictionary. FatalIOError if it is found and there are excess tokens.

Definition at line 392 of file dimensionedType.C.

◆ name() [1/2]

◆ name() [2/2]

Foam::word & name

Return non-const reference to name.

Definition at line 413 of file dimensionedType.C.

◆ dimensions() [1/2]

const Foam::dimensionSet & dimensions

Return const reference to dimensions.

Definition at line 420 of file dimensionedType.C.

Referenced by ObukhovLength::calcOL(), Foam::cbrt(), Foam::checkMethod(), Foam::cof(), relaxation::correct(), Foam::det(), Foam::dev(), Foam::dev2(), dimensionSets::dimensionSets(), Foam::eigenValues(), comfort::execute(), EulerFaD2dt2Scheme< Type >::facD2dt2(), backwardFaDdtScheme< Type >::facDdt(), EulerFaDdtScheme< Type >::facDdt(), steadyStateFaDdtScheme< Type >::facDdt(), boundedBackwardFaDdtScheme::facDdt(), boundedBackwardFaDdtScheme::facDdt0(), steadyStateFaDdtScheme< Type >::facDdt0(), backwardFaDdtScheme< Type >::facDdt0(), EulerFaDdtScheme< Type >::facDdt0(), EulerD2dt2Scheme< Type >::fvcD2dt2(), backwardDdtScheme< Type >::fvcDdt(), CoEulerDdtScheme< Type >::fvcDdt(), CrankNicolsonDdtScheme< Type >::fvcDdt(), EulerDdtScheme< Type >::fvcDdt(), localEulerDdtScheme< Type >::fvcDdt(), SLTSDdtScheme< Type >::fvcDdt(), steadyStateDdtScheme< Type >::fvcDdt(), Foam::innerSqr(), Foam::inv(), Foam::makeDimensionedMinMax(), Foam::neg(), Foam::neg0(), Foam::negPart(), Foam::operator*(), DimensionedField< Type, GeoMesh >::operator=(), Foam::pos(), Foam::pos0(), Foam::posPart(), Foam::pow(), Foam::pow025(), Foam::pow3(), Foam::pow4(), Foam::pow5(), Foam::pow6(), dimensionSet::read(), Foam::sign(), Foam::skew(), Foam::sqr(), Foam::sqrt(), Foam::stabilise(), Foam::symm(), dimensioned< Type >::T(), Foam::tr(), Foam::twoSymm(), prghPressureFvPatchScalarField::updateCoeffs(), prghTotalPressureFvPatchScalarField::updateCoeffs(), and prghPermeableAlphaTotalPressureFvPatchScalarField::updateSnGrad().

◆ dimensions() [2/2]

Foam::dimensionSet & dimensions

Return non-const reference to dimensions.

Definition at line 427 of file dimensionedType.C.

◆ value() [1/2]

const Type & value

Return const reference to value.

Definition at line 434 of file dimensionedType.C.

Referenced by objective::accumulateJMean(), externalHeatFluxSource::addSup(), SemiImplicitSource< Type >::addSup(), interRegionHeatTransferModel::addSup(), powerLawUniformBinary::addToBinaryBreakupRate(), hydrodynamic::addToCoalescenceRate(), wallBoiling::addToNucleationRate(), porosityModel::adjustNegativeResistance(), Foam::atan2(), coordSetWriter::beginTime(), surfaceWriter::beginTime(), Foam::bound(), NonInertialFrameForce< CloudType >::cacheFields(), SprayParcel< ParcelType >::calcAtomization(), BrownianMotionForce< CloudType >::calcCoupled(), forceCoeffs::calcForceCoeffs(), ThermoParcel< ParcelType >::calcHeatTransfer(), forceCoeffs::calcMomentCoeffs(), ParamagneticForce< CloudType >::calcNonCoupled(), SRFForce< CloudType >::calcNonCoupled(), powerLaw::calcNu(), viewFactor::calculate(), MultiComponentPhaseModel< BasePhaseModel, phaseThermo >::calculateVolumeFractions(), Foam::cbrt(), SIMPLEControlSingleRun::checkEndTime(), timeVaryingMappedFixedValuePointPatchField< Type >::checkTable(), GeometricField< Type, PatchField, GeoMesh >::clip(), Foam::cof(), fixedTemperatureConstraint::constrain(), adjointkOmegaSST::correct(), adjointSpalartAllmaras::correct(), BrunDrippingInjection::correct(), waxSolventEvaporation::correctModel(), liquidFilmBase::CourantNumber(), logFiles::createFiles(), curvatureSeparation::curvatureSeparation(), filmTurbulenceModel::Cw(), liquid::D(), thermoCoupleProbes::derivatives(), DEShybrid< Type >::DEShybrid(), Foam::det(), Foam::dev(), Foam::dev2(), adjointSpalartAllmaras::diffusionCoeffVar1(), Foam::eigenValues(), Foam::eigenVectors(), energyTransport::energyTransport(), engineMesh::engineMesh(), DSMCCloud< ParcelType >::equipartitionInternalEnergy(), dimensionedScalarEntry::evaluate(), comfort::execute(), exprResult::exprResult(), EulerFaD2dt2Scheme< Type >::facD2dt2(), backwardFaDdtScheme< Type >::facDdt(), EulerFaDdtScheme< Type >::facDdt(), boundedBackwardFaDdtScheme::facDdt(), backwardFaDdtScheme< Type >::facDdt0(), EulerFaDdtScheme< Type >::facDdt0(), boundedBackwardFaDdtScheme::facDdt0(), interfaceTrackingFvMesh::freeSurfacePressureJump(), basicCombustionMixture::fres(), EulerD2dt2Scheme< Type >::fvcD2dt2(), backwardDdtScheme< Type >::fvcDdt(), CoEulerDdtScheme< Type >::fvcDdt(), EulerDdtScheme< Type >::fvcDdt(), SLTSDdtScheme< Type >::fvcDdt(), CrankNicolsonDdtScheme< Type >::fvcDdt(), waveMakerPointPatchVectorField::g(), populationBalanceModel::gamma(), GeometricField< symmTensor, fvPatchField, volMesh >::GeometricField(), kinematicSingleLayer::gTan(), liquid::h(), thermoSingleLayer::hs(), if(), reactingOneDim::info(), InjectionModel< CloudType >::inject(), InjectionModel< CloudType >::injectSteadyState(), InjectionModel< Foam::KinematicCloud< Foam::DSMCCloud > >::injectSteadyState(), Foam::innerSqr(), Foam::inv(), Foam::invTransform(), objective::isWithinIntegrationTime(), JohnsonJacksonParticleSlipFvPatchVectorField::JohnsonJacksonParticleSlipFvPatchVectorField(), JohnsonJacksonParticleThetaFvPatchScalarField::JohnsonJacksonParticleThetaFvPatchScalarField(), polynomialSolidTransport< Thermo, PolySize >::kappa(), polynomialTransport< Thermo, PolySize >::kappa(), liquid::kappa(), kEpsilonPhitF< BasicTurbulenceModel >::kEpsilonPhitF(), kineticGasEvaporation< Thermo, OtherThermo >::kineticGasEvaporation(), laminarFlameSpeed::laminarFlameSpeed(), hexRef8::level0EdgeLength(), pressureControl::limit(), ArdenBuck::lnPSat(), adjointSimple::mainIter(), Foam::makeDimensionedMinMax(), MarshakRadiationFixedTemperatureFvPatchScalarField::MarshakRadiationFixedTemperatureFvPatchScalarField(), GeometricField< Type, PatchField, GeoMesh >::max(), GeometricField< Type, PatchField, GeoMesh >::min(), solidParticleCloud::move(), polynomialTransport< Thermo, PolySize >::mu(), liquid::mu(), Foam::neg(), Foam::neg0(), Foam::negPart(), JohnsonJacksonSchaeffer::nu(), Schaeffer::nu(), Foam::operator*(), Time::operator+=(), GeometricField< Type, PatchField, GeoMesh >::operator=(), DimensionedField< Type, GeoMesh >::operator=(), GeometricField< Type, PatchField, GeoMesh >::operator==(), UniformDimensionedField< Type >::operator[](), PatchFlowRateInjection< CloudType >::parcelsToInject(), freePiston::pistonPosition(), pointHistory::pointHistory(), Foam::pos(), Foam::pos0(), Foam::posPart(), Foam::pow(), Foam::pow025(), Foam::pow3(), Foam::pow4(), Foam::pow5(), Foam::pow6(), pressureControl::pressureControl(), randomCoalescence::R(), turbulentBreakUp::R(), comfort::read(), dimensionSet::read(), SIMPLEControlSingleRun::readIters(), GeometricField< Type, PatchField, GeoMesh >::replace(), incompressibleTwoPhaseInteractingMixture::rho(), rpm::rpm(), timeSelector::selectIfPresent(), exponential::setBreakupRate(), powerLaw::setBreakupRate(), Time::setDeltaT(), Time::setEndTime(), masterUncollatedFileOperation::setTime(), vtmWriter::setTime(), Time::setTime(), constantRadiation::Shs(), temperatureDependent::sigma(), Foam::sign(), simpleControl::simpleControl(), Foam::skew(), rigidBodyMeshMotion::solve(), rigidBodyMeshMotionSolver::solve(), sixDoFRigidBodyMotionSolver::solve(), thermalBaffle::solveEnergy(), MultiComponentPhaseModel< BasePhaseModel, phaseThermo >::solveYi(), Foam::fvc::spreadSource(), Foam::sqr(), Foam::sqrt(), Foam::stabilise(), particle< Type >::stepFractionSpan(), Foam::symm(), dimensioned< Type >::T(), Foam::tr(), Foam::transform(), Foam::twoSymm(), interfaceTrackingFvMesh::update(), SRFFreestreamVelocityFvPatchVectorField::updateCoeffs(), fixedPressureCompressibleDensityFvPatchScalarField::updateCoeffs(), phaseHydrostaticPressureFvPatchScalarField::updateCoeffs(), prghPressureFvPatchScalarField::updateCoeffs(), prghTotalPressureFvPatchScalarField::updateCoeffs(), uniformDensityHydrostaticPressureFvPatchScalarField::updateCoeffs(), waveSurfacePressureFvPatchScalarField::updateCoeffs(), angularOscillatingDisplacementPointPatchVectorField::updateCoeffs(), angularOscillatingVelocityPointPatchVectorField::updateCoeffs(), oscillatingDisplacementPointPatchVectorField::updateCoeffs(), oscillatingVelocityPointPatchVectorField::updateCoeffs(), waveDisplacementPointPatchVectorField::updateCoeffs(), JohnsonJacksonParticleSlipFvPatchVectorField::updateCoeffs(), JohnsonJacksonParticleThetaFvPatchScalarField::updateCoeffs(), sixDoFRigidBodyDisplacementPointPatchVectorField::updateCoeffs(), uncoupledSixDoFRigidBodyDisplacementPointPatchVectorField::updateCoeffs(), MarshakRadiationFvPatchScalarField::updateCoeffs(), MarshakRadiationFixedTemperatureFvPatchScalarField::updateCoeffs(), externalWallHeatFluxTemperatureFvPatchScalarField::updateCoeffs(), fixedIncidentRadiationFvPatchScalarField::updateCoeffs(), alphaFixedPressureFvPatchScalarField::updateCoeffs(), porousBafflePressureFvPatchField< Type >::updateCoeffs(), jouleHeatingSource::updateSigma(), prghPermeableAlphaTotalPressureFvPatchScalarField::updateSnGrad(), PatchFlowRateInjection< CloudType >::volumeToInject(), fvMesh::Vsc(), fvMesh::Vsc0(), dsmcFields::write(), sizeDistribution::write(), FacePostProcessing< CloudType >::write(), ParticleCollector< CloudType >::write(), objective::write(), dimensionSet::write(), sizeDistribution::writeFileHeader(), objective::writeInstantaneousValue(), and objective::writeMeanValue().

◆ value() [2/2]

Type & value

Return non-const reference to value.

Definition at line 441 of file dimensionedType.C.

◆ component()

Foam::dimensioned< typename Foam::dimensioned< Type >::cmptType > component ( const direction  d) const

Return a component as a dimensioned<cmptType>

Definition at line 449 of file dimensionedType.C.

References Foam::name().

Referenced by Foam::ComplexField(), Foam::ReComplexField(), and coordinateScaling< scalar >::transform().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ replace()

void replace ( const direction  d,
const dimensioned< cmptType > &  dc 
)

Return a component with a dimensioned<cmptType>

Definition at line 464 of file dimensionedType.C.

◆ T()

Return transpose.

Definition at line 38 of file dimensionedSphericalTensor.C.

References dimensioned< Type >::dimensions(), dimensioned< Type >::name(), dimensioned< Type >::T(), and dimensioned< Type >::value().

Referenced by eddy::eddy(), Foam::inv(), leastSquares::stencilWeights(), dimensioned< Type >::T(), and SVD::VSinvUt().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ read() [1/5]

bool read ( const dictionary dict)

Update the value of dimensioned<Type>, lookup in dictionary with the name().

Definition at line 476 of file dimensionedType.C.

References dict.

Referenced by atmPlantCanopyTurbSource::atmPlantCanopyTurbSource(), NonRandomTwoLiquid< Thermo, OtherThermo >::NonRandomTwoLiquid(), and Foam::unitSet().

Here is the caller graph for this function:

◆ readIfPresent() [1/2]

bool readIfPresent ( const dictionary dict)

Update the value of dimensioned<Type> if found in the dictionary, lookup in dictionary with the name().

Definition at line 483 of file dimensionedType.C.

References dict, and readIfPresent().

Referenced by adjointkOmegaSST::read(), adjointSpalartAllmaras::read(), phasePressureModel::read(), kkLOmega::read(), LamBremhorstKE::read(), LienCubicKE::read(), LienLeschziner::read(), qZeta::read(), ShihQuadraticKE::read(), SpalartAllmarasDES< BasicTurbulenceModel >::read(), SpalartAllmaras< BasicTurbulenceModel >::read(), and sixDoFRigidBodyMotionSolver::solve().

Here is the call graph for this function:
Here is the caller graph for this function:

◆ read() [2/5]

bool read ( const word entryName,
const dictionary dict 
)

Update the value of dimensioned<Type>, using an alternative entry name

Definition at line 490 of file dimensionedType.C.

References dict.

◆ readIfPresent() [2/2]

bool readIfPresent ( const word entryName,
const dictionary dict 
)

Update the value of dimensioned<Type> if found in the dictionary, using an alternative entry name

Definition at line 502 of file dimensionedType.C.

References dict.

◆ read() [3/5]

Foam::Istream & read ( Istream is,
const bool  readName = true 
)

Read (name, dimensions, value) from stream, using units from system table.

Optionally skip reading the name

Definition at line 514 of file dimensionedType.C.

References IOstream::check(), FUNCTION_NAME, and Istream::read().

Here is the call graph for this function:

◆ read() [4/5]

Foam::Istream & read ( Istream is,
const dictionary readSet 
)

Read (name, dimensions, value) from stream, using units from dictionary

Definition at line 537 of file dimensionedType.C.

References IOstream::check(), FUNCTION_NAME, and Istream::read().

Here is the call graph for this function:

◆ read() [5/5]

Foam::Istream & read ( Istream is,
const HashTable< dimensionedScalar > &  readSet 
)

Read (name, dimensions, value) from stream, using units from table

Definition at line 556 of file dimensionedType.C.

References IOstream::check(), FUNCTION_NAME, and Istream::read().

Here is the call graph for this function:

◆ writeEntry()

void writeEntry ( const word keyword,
Ostream os 
) const

Write as a dictionary entry with keyword.

The name is not written when it is identical to keyword. The dimensions are always written.

Definition at line 579 of file dimensionedType.C.

References Foam::endl(), FUNCTION_NAME, and os().

Here is the call graph for this function:

◆ operator[]()

Foam::dimensioned< typename Foam::dimensioned< Type >::cmptType > operator[] ( const direction  d) const

Return a component as a dimensioned<cmptType>

Definition at line 608 of file dimensionedType.C.

References Foam::component().

Here is the call graph for this function:

◆ operator+=()

void operator+= ( const dimensioned< Type > &  dt)

Definition at line 618 of file dimensionedType.C.

◆ operator-=()

void operator-= ( const dimensioned< Type > &  dt)

Definition at line 629 of file dimensionedType.C.

◆ operator*=()

void operator*= ( const scalar  s)

Definition at line 640 of file dimensionedType.C.

References s().

Here is the call graph for this function:

◆ operator/=()

void operator/= ( const scalar  s)

Definition at line 650 of file dimensionedType.C.

References s().

Here is the call graph for this function:

◆ lookupOrDefault() [1/2]

static dimensioned< Type > lookupOrDefault ( const word name,
const dictionary dict,
const dimensionSet dims = dimless,
const Type &  deflt = Type(Zero) 
)
inlinestatic

Construct dimensioned from dictionary, with default value. FatalIOError if there are excess tokens.

Definition at line 404 of file dimensionedType.H.

References dict, dimensioned< Type >::getOrDefault(), and dimensioned< Type >::name().

Here is the call graph for this function:

◆ lookupOrDefault() [2/2]

static dimensioned< Type > lookupOrDefault ( const word name,
const dictionary dict,
const Type &  deflt = Type(Zero) 
)
inlinestatic

Construct dimensionless from dictionary, with default value.

FatalIOError if it is found and there are excess tokens.

Definition at line 417 of file dimensionedType.H.

◆ lookupOrAddToDict() [1/2]

static dimensioned< Type > lookupOrAddToDict ( const word name,
dictionary dict,
const dimensionSet dims = dimless,
const Type &  deflt = Type(Zero) 
)
inlinestatic

Construct dimensioned from dictionary, with default value.

If the value is not found, it is added into the dictionary. FatalIOError if it is found and there are excess tokens.

Definition at line 430 of file dimensionedType.H.

◆ lookupOrAddToDict() [2/2]

static dimensioned< Type > lookupOrAddToDict ( const word name,
dictionary dict,
const Type &  deflt = Type(Zero) 
)
inlinestatic

Construct dimensionless from dictionary, with default value.

If the value is not found, it is added into the dictionary. FatalIOError if it is found and there are excess tokens.

Definition at line 444 of file dimensionedType.H.

Friends And Related Function Documentation

◆ operator>>

Istream & operator>> ( Istream is,
dimensioned< Type > &  dt 
)
friend

Read from stream. The name and dimensions are optional.

If the optional dimensions are present, they are used without further verification.


The documentation for this class was generated from the following files: