readInitialConditions.H File Reference

Go to the source code of this file.

Functions

const word constProp (initialConditions.lookup("constantProperty"))
 
 if ((constProp !="pressure") &&(constProp !="volume") &&(constProp !="temperature"))
 
const word fractionBasis (initialConditions.lookup("fractionBasis"))
 
 if ((fractionBasis !="mass") &&(fractionBasis !="mole"))
 
const scalarList W (::W(thermo))
 
scalarList Y0 (nSpecie, 0.0)
 
scalarList X0 (nSpecie, 0.0)
 
dictionary fractions (initialConditions.subDict("fractions"))
 
 if (fractionBasis=="mole")
 
 forAll (Y, i)
 
thermo he ()
 
thermo correct ()
 

Variables

const label nSpecie = Y.size()
 
 else
 
const scalar mTot = sum(Y0)
 
const scalar mw = 1.0/invW
 
const scalar h0 = ::h0(thermo, Y0, p[0], T0)
 
 rho = thermo.rho()
 
scalar rho0 = rho[0]
 
scalar u0 = h0 - p0/rho0
 
scalar R0 = p0/(rho0*T0)
 
 Rspecific [0] = R0
 
scalar integratedHeat = 0.0
 

Function Documentation

◆ constProp()

const word constProp ( initialConditions.  lookup"constantProperty")

Referenced by if().

Here is the caller graph for this function:

◆ if() [1/3]

if ( (constProp !="pressure") &&(constProp !="volume") &&(constProp !="temperature")  )

Definition at line 2 of file readInitialConditions.H.

References constProp(), Foam::exit(), Foam::FatalError, and Foam::nl.

Here is the call graph for this function:

◆ fractionBasis()

const word fractionBasis ( initialConditions.  lookup"fractionBasis")

Referenced by if().

Here is the caller graph for this function:

◆ if() [2/3]

if ( (fractionBasis !="mass") &&(fractionBasis !="mole")  )

Definition at line 17 of file readInitialConditions.H.

References Foam::exit(), Foam::FatalError, fractionBasis(), and Foam::nl.

Here is the call graph for this function:

◆ W()

const scalarList W ( ::W(thermo )

◆ Y0()

scalarList Y0 ( nSpecie  ,
0.  0 
)

Referenced by forAll(), if(), and chemistryModel< ThermoType >::solve().

Here is the caller graph for this function:

◆ X0()

scalarList X0 ( nSpecie  ,
0.  0 
)

◆ fractions()

dictionary fractions ( initialConditions.  subDict"fractions")

Referenced by if(), and fvMatrix< Type >::setValues().

Here is the caller graph for this function:

◆ if() [3/3]

if ( fractionBasis  = = "mole")

Definition at line 31 of file readInitialConditions.H.

References forAll(), fractions(), mTot, mw, Foam::name(), Foam::sum(), W(), X0(), Y, and Y0().

Here is the call graph for this function:

◆ forAll()

forAll ( Y  ,
 
)

Definition at line 68 of file readInitialConditions.H.

References mTot, W(), and Y0().

Referenced by if().

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

◆ he()

◆ correct()

thermo correct ( )

Variable Documentation

◆ nSpecie

◆ else

else
Initial value:
{
forAll(Y, i)
{
const word& name = Y[i].name();
if (fractions.found(name))
{
Y0[i] = fractions.lookup<scalar>(name);
}
}
scalar invW = 0.0
word name(const complex &)
Return a string representation of a complex.
Definition: complex.C:47
forAll(Y, i)
dictionary fractions(initialConditions.subDict("fractions"))
scalarList Y0(nSpecie, 0.0)
PtrList< volScalarField > & Y

Definition at line 55 of file readInitialConditions.H.

◆ mTot

const scalar mTot = sum(Y0)

◆ mw

const scalar mw = 1.0/invW

Definition at line 73 of file readInitialConditions.H.

Referenced by if().

◆ h0

const scalar h0 = ::h0(thermo, Y0, p[0], T0)

Definition at line 81 of file readInitialConditions.H.

Referenced by if().

◆ rho

rho = thermo.rho()

Definition at line 91 of file readInitialConditions.H.

Referenced by MRFZoneList::absolute(), Foam::fvc::absolute(), solidEquilibriumEnergySource::addSup(), VoFSolidificationMeltingSource::addSup(), VoFFilmTransfer::addSup(), phaseTurbulenceStabilisation::addSup(), filmCloudTransfer::addSup(), filmVoFTransfer::addSup(), VoFCavitation::addSup(), interfaceTurbulenceDamping::addSup(), buoyancyEnergy::addSup(), solidificationMeltingSource::addSup(), accelerationSource::addSup(), actuationDiskSource::addSup(), buoyancyForce::addSup(), radialActuationDiskSource::addSup(), rotorDiskSource::addSup(), sixDoFAccelerationSource::addSup(), isotropicDamping::addSup(), verticalDamping::addSup(), waveForcing::addSup(), turbulentShear::addToCoalescenceRate(), densityChangeDrift::addToDriftRate(), wallBoiling::addToNucleationRate(), reactionDriven::addToNucleationRate(), compressibleMultiphaseVoFMixture::alphaEff(), Boussinesq< Specie >::alphav(), icoPolynomial< Specie, PolySize >::alphav(), icoTabulated< Specie >::alphav(), perfectFluid< Specie >::alphav(), rhoTabulated< Specie >::alphav(), rPolynomial< Specie >::alphav(), cellCoBlended< Type >::blendingFactor(), CoBlended< Type >::blendingFactor(), XiFluid::bSolve(), Implicit< CloudType >::cacheFields(), SprayParcel< ParcelType >::calc(), SprayParcel< ParcelType >::calcAtomisation(), SprayParcel< ParcelType >::calcBreakup(), targetCoeffTrim::calcCoeffs(), powerLawLopesdaCosta::calcForce(), DarcyForchheimer::calcForce(), powerLaw::calcForce(), solidification::calcForce(), forces::calcForcesMoment(), ThermoParcel< ParcelType >::calcHeatTransfer(), chemistryModel< ThermoType >::calculate(), rotorDiskSource::calculate(), compressibleInterPhaseTransportModel::compressibleInterPhaseTransportModel(), Foam::constrainPressure(), fluidSolver::continuityErrors(), BrunDripping::correct(), curvatureSeparation::correct(), dripping::correct(), kineticTheoryModel::correct(), IATE::correct(), kEpsilonLopesdaCosta< BasicMomentumTransportModel >::correct(), infinitelyFastChemistry::correct(), kOmegaSST< MomentumTransportModel, BasicMomentumTransportModel >::correct(), Maxwell< BasicMomentumTransportModel >::correct(), DeardorffDiffStress< BasicMomentumTransportModel >::correct(), dynamicKEqn< BasicMomentumTransportModel >::correct(), dynamicLagrangian< BasicMomentumTransportModel >::correct(), kEqn< BasicMomentumTransportModel >::correct(), SpalartAllmarasDES< BasicMomentumTransportModel >::correct(), kEpsilon< BasicMomentumTransportModel >::correct(), kOmega< BasicMomentumTransportModel >::correct(), kOmega2006< BasicMomentumTransportModel >::correct(), LaunderSharmaKE< BasicMomentumTransportModel >::correct(), LRR< BasicMomentumTransportModel >::correct(), realizableKE< BasicMomentumTransportModel >::correct(), RNGkEpsilon< BasicMomentumTransportModel >::correct(), SpalartAllmaras< BasicMomentumTransportModel >::correct(), SSG< BasicMomentumTransportModel >::correct(), v2f< BasicMomentumTransportModel >::correct(), Foam::MULES::correct(), relaxation::correct(), targetCoeffTrim::correct(), powerLawLopesdaCosta::correct(), DarcyForchheimer::correct(), fixedCoeff::correct(), powerLaw::correct(), solidification::correct(), phaseSystem::correctContinuityError(), MovingPhaseModel< BasePhaseModel >::correctContinuityError(), fluidSolver::correctCoNum(), kOmegaSSTLM< BasicMomentumTransportModel >::correctReThetatGammaInt(), Foam::fvc::correctRhoUf(), targetCoeffTrim::correctTrim(), Foam::correctUphiBCs(), perfectFluid< Specie >::Cp(), perfectFluid< Specie >::CpMCv(), interfaceCompositionModel::D(), Foam::fvm::d2dt2(), Foam::fvc::d2dt2(), basicSubGrid::Db(), instabilityG::Db(), Foam::fvc::ddt(), Foam::fvm::ddt(), MRFZoneList::DDt(), Foam::fvc::ddtCorr(), Fickian< BasicThermophysicalTransportModel >::DEff(), MaxwellStefan< BasicThermophysicalTransportModel >::DEff(), forces::devTau(), ReynoldsStress< BasicMomentumTransportModel >::DivDevRhoReff(), incompressibleInterPhaseTransportModel::divDevTau(), Maxwell< BasicMomentumTransportModel >::divDevTau(), linearViscousStress< BasicMomentumTransportModel >::divDevTau(), nonlinearEddyViscosity< BasicMomentumTransportModel >::divDevTau(), ReynoldsStress< BasicMomentumTransportModel >::divDevTau(), CloudFilmTransfer< CloudType >::drySplashInteraction(), linear< Type >::E(), hTabulatedThermo< EquationOfState >::Ea(), Ea(), XiFluid::EaSolve(), XiFluid::EauSolve(), MomentumParcel< ParcelType >::Eo(), dispersedPhaseInterface::Eo(), LaheyKEpsilon< BasicMomentumTransportModel >::epsilonSource(), hTabulatedThermo< EquationOfState >::Es(), Es(), age::execute(), phaseScalarTransport::execute(), scalarTransport::execute(), Foam::MULES::explicitSolve(), PatchFlowRateInjection< CloudType >::flowRate(), EulerD2dt2Scheme< Type >::fvcD2dt2(), steadyStateD2dt2Scheme< Type >::fvcD2dt2(), backwardDdtScheme< Type >::fvcDdt(), boundedDdtScheme< Type >::fvcDdt(), CoEulerDdtScheme< Type >::fvcDdt(), CrankNicolsonDdtScheme< Type >::fvcDdt(), EulerDdtScheme< Type >::fvcDdt(), localEulerDdtScheme< Type >::fvcDdt(), SLTSDdtScheme< Type >::fvcDdt(), steadyStateDdtScheme< Type >::fvcDdt(), backwardDdtScheme< Type >::fvcDdtPhiCorr(), boundedDdtScheme< Type >::fvcDdtPhiCorr(), CoEulerDdtScheme< Type >::fvcDdtPhiCorr(), CrankNicolsonDdtScheme< Type >::fvcDdtPhiCorr(), EulerDdtScheme< Type >::fvcDdtPhiCorr(), localEulerDdtScheme< Type >::fvcDdtPhiCorr(), SLTSDdtScheme< Type >::fvcDdtPhiCorr(), steadyStateDdtScheme< Type >::fvcDdtPhiCorr(), backwardDdtScheme< Type >::fvcDdtUfCorr(), boundedDdtScheme< Type >::fvcDdtUfCorr(), CoEulerDdtScheme< Type >::fvcDdtUfCorr(), CrankNicolsonDdtScheme< Type >::fvcDdtUfCorr(), EulerDdtScheme< Type >::fvcDdtUfCorr(), localEulerDdtScheme< Type >::fvcDdtUfCorr(), SLTSDdtScheme< Type >::fvcDdtUfCorr(), steadyStateDdtScheme< Type >::fvcDdtUfCorr(), EulerD2dt2Scheme< Type >::fvmD2dt2(), steadyStateD2dt2Scheme< Type >::fvmD2dt2(), backwardDdtScheme< Type >::fvmDdt(), boundedDdtScheme< Type >::fvmDdt(), CoEulerDdtScheme< Type >::fvmDdt(), CrankNicolsonDdtScheme< Type >::fvmDdt(), EulerDdtScheme< Type >::fvmDdt(), localEulerDdtScheme< Type >::fvmDdt(), SLTSDdtScheme< Type >::fvmDdt(), steadyStateDdtScheme< Type >::fvmDdt(), ddtScheme< Type >::fvmDdt(), eConstThermo< EquationOfState >::Gstd(), ePolynomialThermo< EquationOfState, PolySize >::Gstd(), ePowerThermo< EquationOfState >::Gstd(), Boussinesq< Specie >::H(), icoPolynomial< Specie, PolySize >::H(), icoTabulated< Specie >::H(), incompressiblePerfectGas< Specie >::H(), linear< Type >::H(), perfectFluid< Specie >::H(), eTabulatedThermo< EquationOfState >::Ha(), Ha(), AnisothermalPhaseModel< BasePhaseModel >::heEqn(), eTabulatedThermo< EquationOfState >::Hs(), Hs(), Foam::hydrostaticInitialisation(), if(), NicenoKEqn< BasicMomentumTransportModel >::kSource(), LaheyKEpsilon< BasicMomentumTransportModel >::kSource(), Foam::MULES::limit(), Foam::MULES::limitCorr(), PhiScheme< Type, PhiLimiter >::limiter(), Foam::MULES::limiter(), Foam::MULES::limiterCorr(), main(), MRFZone::makeAbsolute(), MRFZoneList::makeAbsolute(), Foam::fvc::makeAbsolute(), makeMomentumTransportModelTypes(), MRFZone::makeRelative(), MRFZoneList::makeRelative(), Foam::fvc::makeRelative(), zeroDimensionalFixedPressureConstraint::massSource(), Foam::fvc::meshPhi(), IATEsource::Mo(), dispersedPhaseInterface::Mo(), isothermalFilm::momentumPredictor(), solidParticleCloud::move(), forces::mu(), laminarModel< BasicMomentumTransportModel >::New(), LESModel< BasicMomentumTransportModel >::New(), RASModel< BasicMomentumTransportModel >::New(), filmCompressibleMomentumTransportModel::New(), phaseCompressibleMomentumTransportModel::New(), PDRDragModel::New(), XiModel::New(), momentumTransportModel::New(), Foam::filmCompressible::New(), Foam::phaseCompressible::New(), compressibleMomentumTransportModel::New(), Foam::compressible::New(), parcelCloud::New(), rhoMagSqr< Type >::operator()(), parcelCloudList::parcelCloudList(), continuousGasKEqn< BasicMomentumTransportModel >::phaseTransferCoeff(), NicenoKEqn< BasicMomentumTransportModel >::phaseTransferCoeff(), continuousGasKEpsilon< BasicMomentumTransportModel >::phaseTransferCoeff(), LaheyKEpsilon< BasicMomentumTransportModel >::phaseTransferCoeff(), isothermalFluid::postSolve(), kineticTheoryModel::pPrime(), compressibleMultiphaseVoF::prePredictor(), isothermalFluid::preSolve(), solidDisplacement::pressureCorrector(), isothermalFluid::pressureWork(), rPolynomial< Specie >::psi(), compressibleMultiphaseVoFMixture::psiByRho(), wallBoiling::R(), phaseChange::R(), chemistryModel< ThermoType >::reactionRR(), MomentumParcel< ParcelType >::readFields(), Foam::fvc::relative(), phaseSystem::rho(), SpecieMixture< MixtureType >::rho(), liquidMixtureProperties::rho(), valueMulticomponentMixture< ThermoType >::thermoMixture::rho(), ConeInjection< CloudType >::setProperties(), populationBalanceModel::solve(), SprayParcel< ParcelType >::solveTABEq(), fvModels::source(), fvModel::source(), ReactingCloud< CloudType >::Srho(), ParcelCloudBase< ParticleType >::Srho(), parcelCloudList::Srho(), exponential::tau(), Lun::tau(), ParticleStressModel::tau(), chemistryModel< ThermoType >::tc(), solid::thermophysicalPredictor(), MovingPhaseModel< BasePhaseModel >::UEqn(), MovingPhaseModel< BasePhaseModel >::UfEqn(), ETAB< CloudType >::update(), PilchErdman< CloudType >::update(), ReitzDiwakar< CloudType >::update(), ReitzKHRT< CloudType >::update(), SHF< CloudType >::update(), TAB< CloudType >::update(), BlobsSheetAtomisation< CloudType >::update(), LISAAtomisation< CloudType >::update(), matchedFlowRateOutletVelocityFvPatchVectorField::updateCoeffs(), alphaFixedPressureFvPatchScalarField::updateCoeffs(), dynamicPressureFvPatchScalarField::updateCoeffs(), uniformTotalPressureFvPatchScalarField::updateCoeffs(), IATEsource::Ur(), CloudFilmTransfer< CloudType >::wetSplashInteraction(), MomentumParcel< ParcelType >::writeFields(), MulticomponentPhaseModel< BasePhaseModel >::YiEqn(), adiabaticPerfectFluid< Specie >::Z(), Boussinesq< Specie >::Z(), icoPolynomial< Specie, PolySize >::Z(), icoTabulated< Specie >::Z(), incompressiblePerfectGas< Specie >::Z(), linear< Type >::Z(), perfectFluid< Specie >::Z(), rhoConst< Specie >::Z(), rhoTabulated< Specie >::Z(), and rPolynomial< Specie >::Z().

◆ rho0

◆ u0

scalar u0 = h0 - p0/rho0

◆ R0

scalar R0 = p0/(rho0*T0)

Definition at line 94 of file readInitialConditions.H.

◆ Rspecific

Rspecific[0] = R0

Definition at line 95 of file readInitialConditions.H.

Referenced by if().

◆ integratedHeat

scalar integratedHeat = 0.0

Definition at line 97 of file readInitialConditions.H.

Referenced by if().