diff --git a/applications/modules/isothermalFilm/fvModels/filmCloudTransfer/cloudFilmTransfer/CloudFilmTransfer/CloudFilmTransfer.C b/applications/modules/isothermalFilm/fvModels/filmCloudTransfer/cloudFilmTransfer/CloudFilmTransfer/CloudFilmTransfer.C index 19bfa85a7d..19e3a49b7a 100644 --- a/applications/modules/isothermalFilm/fvModels/filmCloudTransfer/cloudFilmTransfer/CloudFilmTransfer/CloudFilmTransfer.C +++ b/applications/modules/isothermalFilm/fvModels/filmCloudTransfer/cloudFilmTransfer/CloudFilmTransfer/CloudFilmTransfer.C @@ -99,7 +99,7 @@ void Foam::CloudFilmTransfer::absorbInteraction facei, mass, // mass mass*Urel, // momentum - mass*liq.Hs(pc, p.T()) // energy + mass*liq.hs(pc, p.T()) // energy ); this->nParcelsTransferred()++; diff --git a/applications/test/liquid/Test-liquid.C b/applications/test/liquid/Test-liquid.C index 97db61b3ce..8a7d5586e4 100644 --- a/applications/test/liquid/Test-liquid.C +++ b/applications/test/liquid/Test-liquid.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -57,7 +57,7 @@ int main(int argc, char *argv[]) OFstream plotFile(liquidName + ".dat"); - plotFile << "# p T rho Cp Hs Ha pv hl Cpg mu mug kappa kappag sigma" << nl; + plotFile << "# p T rho Cp hs ha pv hl Cpg mu mug kappa kappag sigma" << nl; for (label pi = 0; pi < nP; ++ pi) { @@ -72,8 +72,8 @@ int main(int argc, char *argv[]) << T << ' ' << liquidPtr->rho(p, T) << ' ' << liquidPtr->Cp(p, T) << ' ' - << liquidPtr->Hs(p, T) << ' ' - << liquidPtr->Ha(p, T) << ' ' + << liquidPtr->hs(p, T) << ' ' + << liquidPtr->ha(p, T) << ' ' << liquidPtr->pv(p, T) << ' ' << liquidPtr->hl(p, T) << ' ' << liquidPtr->Cpg(p, T) << ' ' diff --git a/applications/test/thermoMixture/Test-thermoMixture.C b/applications/test/thermoMixture/Test-thermoMixture.C index c4b1a9eabf..81ceada137 100644 --- a/applications/test/thermoMixture/Test-thermoMixture.C +++ b/applications/test/thermoMixture/Test-thermoMixture.C @@ -22,7 +22,7 @@ License along with OpenFOAM. If not, see . Application - ThermoMixture + Test-thermoMixture Description @@ -33,9 +33,6 @@ Description #include "specie.H" #include "perfectGas.H" #include "hConstThermo.H" -#include "sensibleEnthalpy.H" -#include "thermo.H" -#include "constTransport.H" using namespace Foam; @@ -44,33 +41,41 @@ using namespace Foam; int main(int argc, char *argv[]) { - typedef constTransport - < - species::thermo - < - hConstThermo>, - sensibleEnthalpy - > - > ThermoType; + typedef hConstThermo> ThermoType; dictionary dict(IFstream("thermoDict")()); ThermoType t1("specie1", dict.subDict("specie1")); ThermoType t2("specie2", dict.subDict("specie2")); - Info<< "Checking Cp of mixture of hConstThermo" << endl; + Info<< "Checking Cp of mixture of hConstThermo:" << nl << endl; - Info<< "W 1, 2, (1 + 2) = " << t1.W() << " " << t2.W() << " " - << (t1 + t2).W() << endl; + ThermoType t1Plus2(0.5*t1 + 0.5*t2); - Info<< "Cp 1, 2, 1 + 2 = " << t1.cp(1, 1) << " " << t2.cp(1, 1) << " " - << (t1 + t2).cp(1, 1) << endl; + ThermoType t1PlusEq2(0.5*t1); + t1PlusEq2 += 0.5*t2; - ThermoType t3(t1); - t3 += t2; - Info<< "Cp (1 += 2) = " << t3.cp(1, 1) << endl; + Info<< " W_1/W_2/W_{1+2}/W_{1+=2} = " + << t1.W() << "/" + << t2.W() << "/" + << t1Plus2.W() << "/" + << t1PlusEq2.W() + << " [kg/kmol] " << nl << endl; - Info<< "\nEnd\n" << endl; + Info<< "Cp_1/Cp_2/Cp_{1+2}/Cp_{1+=2} = " + << t1.Cp(1, 1) << "/" + << t2.Cp(1, 1) << "/" + << t1Plus2.Cp(1, 1) << "/" + << t1PlusEq2.Cp(1, 1) + << " [J/kg/K]" << endl + << " = " + << t1.Cp(1, 1)*t1.W() << "/" + << t2.Cp(1, 1)*t2.W() << "/" + << t1Plus2.Cp(1, 1)*t1Plus2.W() << "/" + << t1PlusEq2.Cp(1, 1)*t1PlusEq2.W() + << " [J/kmol/K]" << nl << endl; + + Info<< "End" << nl << endl; return 0; } diff --git a/applications/test/thermoMixture/thermoDict b/applications/test/thermoMixture/thermoDict index e17e34c5e7..44e3f5d9fa 100644 --- a/applications/test/thermoMixture/thermoDict +++ b/applications/test/thermoMixture/thermoDict @@ -11,12 +11,6 @@ specie1 Cv 1; Hf 0; } - - transport - { - mu 1; - Pr 1; - } } specie2 @@ -32,10 +26,4 @@ specie2 Cv 2; Hf 0; } - - transport - { - mu 1; - Pr 1; - } } diff --git a/applications/utilities/thermophysical/adiabaticFlameT/adiabaticFlameT.C b/applications/utilities/thermophysical/adiabaticFlameT/adiabaticFlameT.C index d3d83f4c9e..ff4afd24cc 100644 --- a/applications/utilities/thermophysical/adiabaticFlameT/adiabaticFlameT.C +++ b/applications/utilities/thermophysical/adiabaticFlameT/adiabaticFlameT.C @@ -173,7 +173,7 @@ int main(int argc, char *argv[]) Info<< "products " << (1/products.Y())*products << ';' << endl; - scalar Tad = products.THa(reactants.Ha(P, T0), P, 1000.0); + scalar Tad = products.Tha(reactants.ha(P, T0), P, 1000.0); Info<< "Tad = " << Tad << nl << endl; } diff --git a/applications/utilities/thermophysical/equilibriumFlameT/equilibriumFlameT.C b/applications/utilities/thermophysical/equilibriumFlameT/equilibriumFlameT.C index 506bb20bcb..393431b91e 100644 --- a/applications/utilities/thermophysical/equilibriumFlameT/equilibriumFlameT.C +++ b/applications/utilities/thermophysical/equilibriumFlameT/equilibriumFlameT.C @@ -248,7 +248,7 @@ int main(int argc, char *argv[]) scalar equilibriumFlameTemperatureNew = - products.THa(reactants.Ha(P, T0), P, adiabaticFlameTemperature); + products.Tha(reactants.ha(P, T0), P, adiabaticFlameTemperature); if (j==0) { diff --git a/applications/utilities/thermophysical/mixtureAdiabaticFlameT/mixtureAdiabaticFlameT.C b/applications/utilities/thermophysical/mixtureAdiabaticFlameT/mixtureAdiabaticFlameT.C index 40aa945d9c..3fc074890b 100644 --- a/applications/utilities/thermophysical/mixtureAdiabaticFlameT/mixtureAdiabaticFlameT.C +++ b/applications/utilities/thermophysical/mixtureAdiabaticFlameT/mixtureAdiabaticFlameT.C @@ -133,7 +133,7 @@ int main(int argc, char *argv[]) } Info<< "Adiabatic flame temperature of mixture " << rMix.name() << " = " - << products.THa(reactants.Ha(p, T0), p, 1000.0) << " K" << endl; + << products.Tha(reactants.ha(p, T0), p, 1000.0) << " K" << endl; return 0; } diff --git a/src/ThermophysicalTransportModels/fluid/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.H b/src/ThermophysicalTransportModels/fluid/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.H index d11d1884c4..638ab2145a 100644 --- a/src/ThermophysicalTransportModels/fluid/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.H +++ b/src/ThermophysicalTransportModels/fluid/derivedFvPatchFields/thermalBaffle1D/thermalBaffle1DFvPatchScalarField.H @@ -60,7 +60,7 @@ Usage } thermodynamics { - Hf 0; + hf 0; Cv 10; } equationOfState diff --git a/src/functionObjects/field/totalEnthalpy/totalEnthalpy.H b/src/functionObjects/field/totalEnthalpy/totalEnthalpy.H index ba2d2682b6..f04e89cdf5 100644 --- a/src/functionObjects/field/totalEnthalpy/totalEnthalpy.H +++ b/src/functionObjects/field/totalEnthalpy/totalEnthalpy.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2020-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2020-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -25,8 +25,7 @@ Class Foam::functionObjects::totalEnthalpy Description - Calculates and writes the total enthalpy (ha + K) as the volScalarField - 'Ha'. + Calculates and writes the total enthalpy (ha + K) as the volScalarField Ha See also Foam::functionObjects::fvMeshFunctionObject diff --git a/src/lagrangian/parcel/parcels/Templates/ReactingMultiphaseParcel/ReactingMultiphaseParcel.C b/src/lagrangian/parcel/parcels/Templates/ReactingMultiphaseParcel/ReactingMultiphaseParcel.C index 6347cfa0ba..c30b724d0a 100644 --- a/src/lagrangian/parcel/parcels/Templates/ReactingMultiphaseParcel/ReactingMultiphaseParcel.C +++ b/src/lagrangian/parcel/parcels/Templates/ReactingMultiphaseParcel/ReactingMultiphaseParcel.C @@ -67,7 +67,7 @@ Foam::scalar Foam::ReactingMultiphaseParcel::CpEff template template -Foam::scalar Foam::ReactingMultiphaseParcel::HsEff +Foam::scalar Foam::ReactingMultiphaseParcel::hsEff ( TrackCloudType& cloud, trackingData& td, @@ -79,9 +79,9 @@ Foam::scalar Foam::ReactingMultiphaseParcel::HsEff ) const { return - this->Y_[GAS]*cloud.composition().Hs(idG, YGas_, p, T) - + this->Y_[LIQ]*cloud.composition().Hs(idL, YLiquid_, p, T) - + this->Y_[SLD]*cloud.composition().Hs(idS, YSolid_, p, T); + this->Y_[GAS]*cloud.composition().hs(idG, YGas_, p, T) + + this->Y_[LIQ]*cloud.composition().hs(idL, YLiquid_, p, T) + + this->Y_[SLD]*cloud.composition().hs(idS, YSolid_, p, T); } @@ -378,7 +378,7 @@ void Foam::ReactingMultiphaseParcel::calc cloud.UTransRef()[this->cell()] += dm*U0; cloud.hsTransRef()[this->cell()] += - dm*HsEff(cloud, td, pc, T0, idG, idL, idS); + dm*hsEff(cloud, td, pc, T0, idG, idL, idS); cloud.phaseChange().addToPhaseChangeMass(np0*mass1); } diff --git a/src/lagrangian/parcel/parcels/Templates/ReactingMultiphaseParcel/ReactingMultiphaseParcel.H b/src/lagrangian/parcel/parcels/Templates/ReactingMultiphaseParcel/ReactingMultiphaseParcel.H index dd1c105f66..8cab2948ee 100644 --- a/src/lagrangian/parcel/parcels/Templates/ReactingMultiphaseParcel/ReactingMultiphaseParcel.H +++ b/src/lagrangian/parcel/parcels/Templates/ReactingMultiphaseParcel/ReactingMultiphaseParcel.H @@ -158,7 +158,7 @@ private: //- Return the mixture effective sensible enthalpy template - scalar HsEff + scalar hsEff ( TrackCloudType& cloud, trackingData& td, diff --git a/src/lagrangian/parcel/parcels/Templates/SprayParcel/SprayParcel.C b/src/lagrangian/parcel/parcels/Templates/SprayParcel/SprayParcel.C index e543be3242..13e9667029 100644 --- a/src/lagrangian/parcel/parcels/Templates/SprayParcel/SprayParcel.C +++ b/src/lagrangian/parcel/parcels/Templates/SprayParcel/SprayParcel.C @@ -350,8 +350,8 @@ Foam::scalar Foam::SprayParcel::chi scalar TBoil = liq.pvInvert(p0); scalar hl = liq.hl(pAmb, TBoil); - scalar iTp = liq.Ha(pAmb, T0) - pAmb/liq.rho(pAmb, T0); - scalar iTb = liq.Ha(pAmb, TBoil) - pAmb/liq.rho(pAmb, TBoil); + scalar iTp = liq.ha(pAmb, T0) - pAmb/liq.rho(pAmb, T0); + scalar iTb = liq.ha(pAmb, TBoil) - pAmb/liq.rho(pAmb, TBoil); chi += X[i]*(iTp - iTb)/hl; } diff --git a/src/lagrangian/parcel/submodels/Reacting/CompositionModel/CompositionModel/CompositionModel.C b/src/lagrangian/parcel/submodels/Reacting/CompositionModel/CompositionModel/CompositionModel.C index 86fd65658e..01178588d5 100644 --- a/src/lagrangian/parcel/submodels/Reacting/CompositionModel/CompositionModel/CompositionModel.C +++ b/src/lagrangian/parcel/submodels/Reacting/CompositionModel/CompositionModel/CompositionModel.C @@ -308,7 +308,7 @@ Foam::scalarField Foam::CompositionModel::X template -Foam::scalar Foam::CompositionModel::H +Foam::scalar Foam::CompositionModel::ha ( const label phasei, const scalarField& Y, @@ -333,7 +333,7 @@ Foam::scalar Foam::CompositionModel::H { forAll(Y, i) { - HMixture += Y[i]*thermo_.liquids().properties()[i].Ha(p, T); + HMixture += Y[i]*thermo_.liquids().properties()[i].ha(p, T); } break; } @@ -341,7 +341,7 @@ Foam::scalar Foam::CompositionModel::H { forAll(Y, i) { - HMixture += Y[i]*thermo_.solids().properties()[i].Ha(T); + HMixture += Y[i]*thermo_.solids().properties()[i].ha(T); } break; } @@ -357,7 +357,7 @@ Foam::scalar Foam::CompositionModel::H template -Foam::scalar Foam::CompositionModel::Hs +Foam::scalar Foam::CompositionModel::hs ( const label phasei, const scalarField& Y, @@ -366,7 +366,7 @@ Foam::scalar Foam::CompositionModel::Hs ) const { const phaseProperties& props = phaseProps_[phasei]; - scalar HsMixture = 0.0; + scalar hsMixture = 0.0; switch (props.phase()) { case phaseProperties::GAS: @@ -374,7 +374,7 @@ Foam::scalar Foam::CompositionModel::Hs forAll(Y, i) { label cid = props.carrierId(i); - HsMixture += Y[i]*carrierMcThermoPtr_->hsi(cid, p, T); + hsMixture += Y[i]*carrierMcThermoPtr_->hsi(cid, p, T); } break; } @@ -382,8 +382,8 @@ Foam::scalar Foam::CompositionModel::Hs { forAll(Y, i) { - HsMixture += - Y[i]*(thermo_.liquids().properties()[i].Hs(p, T)); + hsMixture += + Y[i]*(thermo_.liquids().properties()[i].hs(p, T)); } break; } @@ -391,7 +391,7 @@ Foam::scalar Foam::CompositionModel::Hs { forAll(Y, i) { - HsMixture += Y[i]*thermo_.solids().properties()[i].Hs(T); + hsMixture += Y[i]*thermo_.solids().properties()[i].hs(T); } break; } @@ -403,57 +403,7 @@ Foam::scalar Foam::CompositionModel::Hs } } - return HsMixture; -} - - -template -Foam::scalar Foam::CompositionModel::Hc -( - const label phasei, - const scalarField& Y, - const scalar p, - const scalar T -) const -{ - const phaseProperties& props = phaseProps_[phasei]; - scalar HcMixture = 0.0; - switch (props.phase()) - { - case phaseProperties::GAS: - { - forAll(Y, i) - { - label cid = props.carrierId(i); - HcMixture += Y[i]*carrierMcThermoPtr_->hfi(cid); - } - break; - } - case phaseProperties::LIQUID: - { - forAll(Y, i) - { - HcMixture += Y[i]*thermo_.liquids().properties()[i].Hf(); - } - break; - } - case phaseProperties::SOLID: - { - forAll(Y, i) - { - HcMixture += Y[i]*thermo_.solids().properties()[i].Hf(); - } - break; - } - default: - { - FatalErrorInFunction - << "Unknown phase enumeration" - << abort(FatalError); - } - } - - return HcMixture; + return hsMixture; } diff --git a/src/lagrangian/parcel/submodels/Reacting/CompositionModel/CompositionModel/CompositionModel.H b/src/lagrangian/parcel/submodels/Reacting/CompositionModel/CompositionModel/CompositionModel.H index 20babc9085..73afc67ee4 100644 --- a/src/lagrangian/parcel/submodels/Reacting/CompositionModel/CompositionModel/CompositionModel.H +++ b/src/lagrangian/parcel/submodels/Reacting/CompositionModel/CompositionModel/CompositionModel.H @@ -215,7 +215,7 @@ public: // Evaluation //- Return total enthalpy for the phase phaseI - virtual scalar H + virtual scalar ha ( const label phaseI, const scalarField& Y, @@ -224,16 +224,7 @@ public: ) const; //- Return sensible enthalpy for the phase phaseI - virtual scalar Hs - ( - const label phaseI, - const scalarField& Y, - const scalar p, - const scalar T - ) const; - - //- Return chemical enthalpy for the phase phaseI - virtual scalar Hc + virtual scalar hs ( const label phaseI, const scalarField& Y, diff --git a/src/lagrangian/parcel/submodels/Reacting/PhaseChangeModel/LiquidEvaporation/LiquidEvaporation.C b/src/lagrangian/parcel/submodels/Reacting/PhaseChangeModel/LiquidEvaporation/LiquidEvaporation.C index fbf49e6cff..dfb8bb963d 100644 --- a/src/lagrangian/parcel/submodels/Reacting/PhaseChangeModel/LiquidEvaporation/LiquidEvaporation.C +++ b/src/lagrangian/parcel/submodels/Reacting/PhaseChangeModel/LiquidEvaporation/LiquidEvaporation.C @@ -244,7 +244,7 @@ Foam::scalar Foam::LiquidEvaporation::dh case (parent::etEnthalpyDifference): { scalar hc = this->owner().composition().carrier().hai(idc, p, T); - scalar hp = liquids_.properties()[idl].Ha(p, T); + scalar hp = liquids_.properties()[idl].ha(p, T); dh = hc - hp; break; diff --git a/src/lagrangian/parcel/submodels/Reacting/PhaseChangeModel/LiquidEvaporationBoil/LiquidEvaporationBoil.C b/src/lagrangian/parcel/submodels/Reacting/PhaseChangeModel/LiquidEvaporationBoil/LiquidEvaporationBoil.C index fa7fe75397..672e2c2aaf 100644 --- a/src/lagrangian/parcel/submodels/Reacting/PhaseChangeModel/LiquidEvaporationBoil/LiquidEvaporationBoil.C +++ b/src/lagrangian/parcel/submodels/Reacting/PhaseChangeModel/LiquidEvaporationBoil/LiquidEvaporationBoil.C @@ -175,15 +175,15 @@ void Foam::LiquidEvaporationBoil::calculate const scalarField XcMix(calcXc(p.cell())); // carrier thermo properties - scalar Hsc = 0.0; - scalar Hc = 0.0; + scalar hsc = 0.0; + scalar hc = 0.0; scalar Cpc = 0.0; scalar kappac = 0.0; forAll(this->owner().composition().carrier().Y(), i) { scalar Yc = this->owner().composition().carrier().Y()[i][p.cell()]; - Hc += Yc*this->owner().composition().carrier().hai(i, pc, Tc); - Hsc += Yc*this->owner().composition().carrier().hai(i, ps, Ts); + hc += Yc*this->owner().composition().carrier().hai(i, pc, Tc); + hsc += Yc*this->owner().composition().carrier().hai(i, ps, Ts); Cpc += Yc*this->owner().composition().carrier().Cpi(i, ps, Ts); kappac += Yc*this->owner().composition().carrier().kappai(i, ps, Ts); } @@ -252,7 +252,7 @@ void Foam::LiquidEvaporationBoil::calculate // model constants // NOTE: using Sherwood number instead of Nusselt number - const scalar A = (Hc - Hsc)/hv; + const scalar A = (hc - hsc)/hv; const scalar B = pi*kappac/Cpc*d*Sh; scalar G = 0.0; @@ -328,7 +328,7 @@ Foam::scalar Foam::LiquidEvaporationBoil::dh { scalar hc = this->owner().composition().carrier().hai(idc, p, TDash); - scalar hp = liquids_.properties()[idl].Ha(p, TDash); + scalar hp = liquids_.properties()[idl].ha(p, TDash); dh = hc - hp; break; diff --git a/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationDiffusionLimitedRate/COxidationDiffusionLimitedRate.C b/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationDiffusionLimitedRate/COxidationDiffusionLimitedRate.C index 74591d242e..188c7bf67c 100644 --- a/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationDiffusionLimitedRate/COxidationDiffusionLimitedRate.C +++ b/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationDiffusionLimitedRate/COxidationDiffusionLimitedRate.C @@ -157,12 +157,12 @@ Foam::scalar Foam::COxidationDiffusionLimitedRate::calculate dMassSRCarrier[O2GlobalId_] -= dmO2; dMassSRCarrier[CO2GlobalId_] += dmCO2; - const scalar HsC = thermo.solids().properties()[CsLocalId_].Hs(T); + const scalar hsC = thermo.solids().properties()[CsLocalId_].hs(T); // carrier sensible enthalpy exchange handled via change in mass // Heat of reaction [J] - return dmC*HsC - dmCO2*HcCO2_; + return dmC*hsC - dmCO2*HcCO2_; } diff --git a/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationHurtMitchell/COxidationHurtMitchell.C b/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationHurtMitchell/COxidationHurtMitchell.C index 2e16997cb9..c21a381bfc 100644 --- a/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationHurtMitchell/COxidationHurtMitchell.C +++ b/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationHurtMitchell/COxidationHurtMitchell.C @@ -195,8 +195,8 @@ Foam::scalar Foam::COxidationHurtMitchell::calculate // note: carrier sensible enthalpy exchange handled via change in mass if (heatOfReaction_ < 0) { - const scalar HsC = thermo.solids().properties()[CsLocalId_].Hs(T); - return dOmega*(WC_*HsC - (WC_ + Sb_*WO2_)*HcCO2_); + const scalar hsC = thermo.solids().properties()[CsLocalId_].hs(T); + return dOmega*(WC_*hsC - (WC_ + Sb_*WO2_)*HcCO2_); } else { diff --git a/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationIntrinsicRate/COxidationIntrinsicRate.C b/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationIntrinsicRate/COxidationIntrinsicRate.C index a03a944e2e..b15778cc1b 100644 --- a/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationIntrinsicRate/COxidationIntrinsicRate.C +++ b/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationIntrinsicRate/COxidationIntrinsicRate.C @@ -212,12 +212,12 @@ Foam::scalar Foam::COxidationIntrinsicRate::calculate dMassSRCarrier[O2GlobalId_] -= dmO2; dMassSRCarrier[CO2GlobalId_] += dmCO2; - const scalar HsC = thermo.solids().properties()[CsLocalId_].Hs(T); + const scalar hsC = thermo.solids().properties()[CsLocalId_].hs(T); // carrier sensible enthalpy exchange handled via change in mass // Heat of reaction [J] - return dmC*HsC - dmCO2*HcCO2_; + return dmC*hsC - dmCO2*HcCO2_; } diff --git a/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationKineticDiffusionLimitedRate/COxidationKineticDiffusionLimitedRate.C b/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationKineticDiffusionLimitedRate/COxidationKineticDiffusionLimitedRate.C index a3029068b6..296575b893 100644 --- a/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationKineticDiffusionLimitedRate/COxidationKineticDiffusionLimitedRate.C +++ b/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationKineticDiffusionLimitedRate/COxidationKineticDiffusionLimitedRate.C @@ -166,12 +166,12 @@ Foam::scalar Foam::COxidationKineticDiffusionLimitedRate::calculate dMassSRCarrier[O2GlobalId_] -= dmO2; dMassSRCarrier[CO2GlobalId_] += dmCO2; - const scalar HsC = thermo.solids().properties()[CsLocalId_].Hs(T); + const scalar hsC = thermo.solids().properties()[CsLocalId_].hs(T); // carrier sensible enthalpy exchange handled via change in mass // Heat of reaction [J] - return dmC*HsC - dmCO2*HcCO2_; + return dmC*hsC - dmCO2*HcCO2_; } diff --git a/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationMurphyShaddix/COxidationMurphyShaddix.C b/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationMurphyShaddix/COxidationMurphyShaddix.C index dbcbdde5fd..d11a07692f 100644 --- a/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationMurphyShaddix/COxidationMurphyShaddix.C +++ b/src/lagrangian/parcel/submodels/ReactingMultiphase/SurfaceReactionModel/COxidationMurphyShaddix/COxidationMurphyShaddix.C @@ -224,12 +224,12 @@ Foam::scalar Foam::COxidationMurphyShaddix::calculate // Add to particle mass transfer dMassSolid[CsLocalId_] += dOmega*WC_; - const scalar HsC = thermo.solids().properties()[CsLocalId_].Hs(T); + const scalar hsC = thermo.solids().properties()[CsLocalId_].hs(T); // carrier sensible enthalpy exchange handled via change in mass // Heat of reaction [J] - return dOmega*(WC_*HsC - (WC_ + WO2_)*HcCO2_); + return dOmega*(WC_*hsC - (WC_ + WO2_)*HcCO2_); } diff --git a/src/thermophysicalModels/basic/basicThermo/BasicThermo.C b/src/thermophysicalModels/basic/basicThermo/BasicThermo.C index 58716b30ec..583e403d85 100644 --- a/src/thermophysicalModels/basic/basicThermo/BasicThermo.C +++ b/src/thermophysicalModels/basic/basicThermo/BasicThermo.C @@ -255,7 +255,7 @@ Foam::BasicThermo::BasicThermo "he", dimEnergy/dimMass, &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::HE, + &MixtureType::thermoMixtureType::he, this->p_, this->T_ ), @@ -359,7 +359,7 @@ Foam::BasicThermo::he "he", dimEnergy/dimMass, &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::HE, + &MixtureType::thermoMixtureType::he, p, T ); @@ -377,7 +377,7 @@ Foam::BasicThermo::he return cellSetProperty ( &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::HE, + &MixtureType::thermoMixtureType::he, cells, cellSetScalarList(this->p_, cells), T @@ -396,7 +396,7 @@ Foam::BasicThermo::he return patchFieldProperty ( &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::HE, + &MixtureType::thermoMixtureType::he, patchi, this->p_.boundaryField()[patchi], T @@ -415,7 +415,7 @@ Foam::BasicThermo::he return fieldSourceProperty ( &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::HE, + &MixtureType::thermoMixtureType::he, source, cellSetScalarList(this->p_, source.cells()), T @@ -432,7 +432,7 @@ Foam::BasicThermo::hs() const "hs", dimEnergy/dimMass, &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::Hs, + &MixtureType::thermoMixtureType::hs, this->p_, this->T_ ); @@ -452,7 +452,7 @@ Foam::BasicThermo::hs "hs", dimEnergy/dimMass, &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::Hs, + &MixtureType::thermoMixtureType::hs, p, T ); @@ -470,7 +470,7 @@ Foam::BasicThermo::hs return cellSetProperty ( &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::Hs, + &MixtureType::thermoMixtureType::hs, cells, cellSetScalarList(this->p_, cells), T @@ -489,7 +489,7 @@ Foam::BasicThermo::hs return patchFieldProperty ( &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::Hs, + &MixtureType::thermoMixtureType::hs, patchi, this->p_.boundaryField()[patchi], T @@ -506,7 +506,7 @@ Foam::BasicThermo::ha() const "ha", dimEnergy/dimMass, &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::Ha, + &MixtureType::thermoMixtureType::ha, this->p_, this->T_ ); @@ -526,7 +526,7 @@ Foam::BasicThermo::ha "ha", dimEnergy/dimMass, &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::Ha, + &MixtureType::thermoMixtureType::ha, p, T ); @@ -544,7 +544,7 @@ Foam::BasicThermo::ha return cellSetProperty ( &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::Ha, + &MixtureType::thermoMixtureType::ha, cells, cellSetScalarList(this->p_, cells), T @@ -563,7 +563,7 @@ Foam::BasicThermo::ha return patchFieldProperty ( &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::Ha, + &MixtureType::thermoMixtureType::ha, patchi, this->p_.boundaryField()[patchi], T @@ -571,20 +571,6 @@ Foam::BasicThermo::ha } -template -Foam::tmp -Foam::BasicThermo::hc() const -{ - return volScalarFieldProperty - ( - "hc", - dimEnergy/dimMass, - &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::Hf - ); -} - - template Foam::tmp Foam::BasicThermo::Cp @@ -644,7 +630,7 @@ Foam::BasicThermo::Cpv template Foam::tmp -Foam::BasicThermo::THE +Foam::BasicThermo::The ( const volScalarField& h, const volScalarField& p, @@ -656,7 +642,7 @@ Foam::BasicThermo::THE "T", dimTemperature, &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::THE, + &MixtureType::thermoMixtureType::The, h, p, T0 @@ -666,7 +652,7 @@ Foam::BasicThermo::THE template Foam::tmp -Foam::BasicThermo::THE +Foam::BasicThermo::The ( const scalarField& h, const scalarField& T0, @@ -676,7 +662,7 @@ Foam::BasicThermo::THE return cellSetProperty ( &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::THE, + &MixtureType::thermoMixtureType::The, cells, h, cellSetScalarList(this->p_, cells), @@ -687,7 +673,7 @@ Foam::BasicThermo::THE template Foam::tmp -Foam::BasicThermo::THE +Foam::BasicThermo::The ( const scalarField& h, const scalarField& T0, @@ -697,7 +683,7 @@ Foam::BasicThermo::THE return patchFieldProperty ( &MixtureType::thermoMixture, - &MixtureType::thermoMixtureType::THE, + &MixtureType::thermoMixtureType::The, patchi, h, this->p_.boundaryField()[patchi], diff --git a/src/thermophysicalModels/basic/basicThermo/BasicThermo.H b/src/thermophysicalModels/basic/basicThermo/BasicThermo.H index 6cd04a586b..fdb300904c 100644 --- a/src/thermophysicalModels/basic/basicThermo/BasicThermo.H +++ b/src/thermophysicalModels/basic/basicThermo/BasicThermo.H @@ -330,9 +330,6 @@ public: const labelList& cells ) const; - //- Enthalpy of formation [J/kg] - virtual tmp hc() const; - //- Heat capacity at constant pressure for patch [J/kg/K] virtual tmp Cp ( @@ -358,7 +355,7 @@ public: // Temperature-energy inversion functions //- Temperature from enthalpy/internal energy - virtual tmp THE + virtual tmp The ( const volScalarField& h, const volScalarField& p, @@ -366,7 +363,7 @@ public: ) const; //- Temperature from enthalpy/internal energy for cell-set - virtual tmp THE + virtual tmp The ( const scalarField& he, const scalarField& T0, // starting temperature @@ -374,7 +371,7 @@ public: ) const; //- Temperature from enthalpy/internal energy for patch - virtual tmp THE + virtual tmp The ( const scalarField& he, const scalarField& T0, // starting temperature diff --git a/src/thermophysicalModels/basic/basicThermo/basicThermo.H b/src/thermophysicalModels/basic/basicThermo/basicThermo.H index f300de296c..7ca1c225cd 100644 --- a/src/thermophysicalModels/basic/basicThermo/basicThermo.H +++ b/src/thermophysicalModels/basic/basicThermo/basicThermo.H @@ -374,9 +374,6 @@ public: const label patchi ) const = 0; - //- Enthalpy of formation [J/kg] - virtual tmp hc() const = 0; - //- Heat capacity at constant pressure for patch [J/kg/K] virtual tmp Cp ( @@ -412,7 +409,7 @@ public: // Temperature-energy inversion functions //- Temperature from enthalpy/internal energy - virtual tmp THE + virtual tmp The ( const volScalarField& h, const volScalarField& p, @@ -420,7 +417,7 @@ public: ) const = 0; //- Temperature from enthalpy/internal energy for cell-set - virtual tmp THE + virtual tmp The ( const scalarField& h, const scalarField& T0, // starting temperature @@ -428,7 +425,7 @@ public: ) const = 0; //- Temperature from enthalpy/internal energy for patch - virtual tmp THE + virtual tmp The ( const scalarField& h, const scalarField& T0, // starting temperature diff --git a/src/thermophysicalModels/basic/psiThermo/PsiThermo.C b/src/thermophysicalModels/basic/psiThermo/PsiThermo.C index 394c89e53a..3f7e207353 100644 --- a/src/thermophysicalModels/basic/psiThermo/PsiThermo.C +++ b/src/thermophysicalModels/basic/psiThermo/PsiThermo.C @@ -53,7 +53,7 @@ void Foam::PsiThermo::calculate() transportMixture = this->transportMixture(composition, thermoMixture); - TCells[celli] = thermoMixture.THE + TCells[celli] = thermoMixture.The ( hCells[celli], pCells[celli], @@ -118,7 +118,7 @@ void Foam::PsiThermo::calculate() transportMixture = this->transportMixture(composition, thermoMixture); - phe[facei] = thermoMixture.HE(pp[facei], pT[facei]); + phe[facei] = thermoMixture.he(pp[facei], pT[facei]); pCp[facei] = thermoMixture.Cp(pp[facei], pT[facei]); pCv[facei] = thermoMixture.Cv(pp[facei], pT[facei]); @@ -142,7 +142,7 @@ void Foam::PsiThermo::calculate() transportMixture = this->transportMixture(composition, thermoMixture); - pT[facei] = thermoMixture.THE(phe[facei], pp[facei], pT[facei]); + pT[facei] = thermoMixture.The(phe[facei], pp[facei], pT[facei]); pCp[facei] = thermoMixture.Cp(pp[facei], pT[facei]); pCv[facei] = thermoMixture.Cv(pp[facei], pT[facei]); diff --git a/src/thermophysicalModels/basic/rhoFluidThermo/RhoFluidThermo.C b/src/thermophysicalModels/basic/rhoFluidThermo/RhoFluidThermo.C index 935cf243ce..fec017b057 100644 --- a/src/thermophysicalModels/basic/rhoFluidThermo/RhoFluidThermo.C +++ b/src/thermophysicalModels/basic/rhoFluidThermo/RhoFluidThermo.C @@ -54,7 +54,7 @@ void Foam::RhoFluidThermo::calculate() transportMixture = this->transportMixture(composition, thermoMixture); - TCells[celli] = thermoMixture.THE + TCells[celli] = thermoMixture.The ( hCells[celli], pCells[celli], @@ -124,7 +124,7 @@ void Foam::RhoFluidThermo::calculate() transportMixture = this->transportMixture(composition, thermoMixture); - phe[facei] = thermoMixture.HE(pp[facei], pT[facei]); + phe[facei] = thermoMixture.he(pp[facei], pT[facei]); pCp[facei] = thermoMixture.Cp(pp[facei], pT[facei]); pCv[facei] = thermoMixture.Cv(pp[facei], pT[facei]); @@ -149,7 +149,7 @@ void Foam::RhoFluidThermo::calculate() transportMixture = this->transportMixture(composition, thermoMixture); - pT[facei] = thermoMixture.THE(phe[facei], pp[facei], pT[facei]); + pT[facei] = thermoMixture.The(phe[facei], pp[facei], pT[facei]); pCp[facei] = thermoMixture.Cp(pp[facei], pT[facei]); pCv[facei] = thermoMixture.Cv(pp[facei], pT[facei]); diff --git a/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel.C b/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel.C index 3349584de7..b048c106ed 100644 --- a/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel.C +++ b/src/thermophysicalModels/chemistryModel/chemistryModel/chemistryModel.C @@ -214,7 +214,7 @@ void Foam::chemistryModel::derivatives scalar& dTdt = dYTpdt[nSpecie_]; for (label i=0; i::jacobian } // dT/dt - scalarField& Ha = YTpWork_[4]; + scalarField& ha = YTpWork_[4]; scalar& dTdt = dYTpdt[nSpecie_]; for (label i=0; i::jacobian for (label j=0; j::jacobian { const scalar dYidt = dYTpdt[i]; const scalar ddYidtdT = J(i, nSpecie_); - ddTdtdT -= dYidt*Cp[sToc(i)] + ddYidtdT*Ha[sToc(i)]; + ddTdtdT -= dYidt*Cp[sToc(i)] + ddYidtdT*ha[sToc(i)]; } ddTdtdT -= dTdt*dCpMdT; ddTdtdT /= CpM; @@ -931,7 +931,7 @@ Foam::chemistryModel::Qdot() const { forAll(Qdot, celli) { - const scalar hi = specieThermos_[i].Hf(); + const scalar hi = specieThermos_[i].hf(); Qdot[celli] -= hi*RR_[i][celli]; } } diff --git a/src/thermophysicalModels/multicomponentThermo/mixtures/valueMulticomponentMixture/valueMulticomponentMixture.C b/src/thermophysicalModels/multicomponentThermo/mixtures/valueMulticomponentMixture/valueMulticomponentMixture.C index f8cc22aa68..a5450aede0 100644 --- a/src/thermophysicalModels/multicomponentThermo/mixtures/valueMulticomponentMixture/valueMulticomponentMixture.C +++ b/src/thermophysicalModels/multicomponentThermo/mixtures/valueMulticomponentMixture/valueMulticomponentMixture.C @@ -167,9 +167,9 @@ Foam::valueMulticomponentMixture::thermoMixtureType::psi template Foam::scalar -Foam::valueMulticomponentMixture::thermoMixtureType::Hf() const +Foam::valueMulticomponentMixture::thermoMixtureType::hf() const { - return massWeighted(&ThermoType::Hf); + return massWeighted(&ThermoType::hf); } @@ -188,16 +188,16 @@ Foam::valueMulticomponentMixture::thermoMixtureType::Hf() const thermoMixtureFunction(Cp) thermoMixtureFunction(Cv) -thermoMixtureFunction(Hs) -thermoMixtureFunction(Ha) +thermoMixtureFunction(hs) +thermoMixtureFunction(ha) thermoMixtureFunction(Cpv) thermoMixtureFunction(gamma) -thermoMixtureFunction(HE) +thermoMixtureFunction(he) template Foam::scalar -Foam::valueMulticomponentMixture::thermoMixtureType::THE +Foam::valueMulticomponentMixture::thermoMixtureType::The ( const scalar he, scalar p, @@ -210,7 +210,7 @@ Foam::valueMulticomponentMixture::thermoMixtureType::THE he, p, T0, - &thermoMixtureType::HE, + &thermoMixtureType::he, &thermoMixtureType::Cpv, &thermoMixtureType::limit ); diff --git a/src/thermophysicalModels/multicomponentThermo/mixtures/valueMulticomponentMixture/valueMulticomponentMixture.H b/src/thermophysicalModels/multicomponentThermo/mixtures/valueMulticomponentMixture/valueMulticomponentMixture.H index 085d25dd00..139b940843 100644 --- a/src/thermophysicalModels/multicomponentThermo/mixtures/valueMulticomponentMixture/valueMulticomponentMixture.H +++ b/src/thermophysicalModels/multicomponentThermo/mixtures/valueMulticomponentMixture/valueMulticomponentMixture.H @@ -122,13 +122,13 @@ public: scalar Cv(const scalar p, const scalar T) const; // Sensible enthalpy [J/kg] - scalar Hs(const scalar p, const scalar T) const; + scalar hs(const scalar p, const scalar T) const; // Absolute enthalpy [J/kg] - scalar Ha(const scalar p, const scalar T) const; + scalar ha(const scalar p, const scalar T) const; // Enthalpy of formation [J/kg] - scalar Hf() const; + scalar hf() const; // Mass specific derived properties @@ -140,14 +140,14 @@ public: scalar gamma(const scalar p, const scalar T) const; //- Enthalpy/Internal energy [J/kg] - scalar HE(const scalar p, const scalar T) const; + scalar he(const scalar p, const scalar T) const; // Energy->temperature inversion functions //- Temperature from enthalpy or internal energy // given an initial temperature T0 - scalar THE + scalar The ( const scalar he, const scalar p, diff --git a/src/thermophysicalModels/multicomponentThermo/multicomponentThermo/MulticomponentThermo.C b/src/thermophysicalModels/multicomponentThermo/multicomponentThermo/MulticomponentThermo.C index a668a2fa67..f3b4a1ea86 100644 --- a/src/thermophysicalModels/multicomponentThermo/multicomponentThermo/MulticomponentThermo.C +++ b/src/thermophysicalModels/multicomponentThermo/multicomponentThermo/MulticomponentThermo.C @@ -211,7 +211,7 @@ Foam::scalar Foam::MulticomponentThermo::hei const scalar T ) const { - return this->specieThermo(speciei).HE(p, T); + return this->specieThermo(speciei).he(p, T); } @@ -225,7 +225,7 @@ Foam::tmp Foam::MulticomponentThermo::hei { return scalarFieldPropertyi ( - &BaseThermo::mixtureType::thermoType::HE, + &BaseThermo::mixtureType::thermoType::he, speciei, p, T @@ -246,7 +246,7 @@ Foam::MulticomponentThermo::hei ( "he", dimEnergy/dimMass, - &BaseThermo::mixtureType::thermoType::HE, + &BaseThermo::mixtureType::thermoType::he, speciei, p, T @@ -262,7 +262,7 @@ Foam::scalar Foam::MulticomponentThermo::hsi const scalar T ) const { - return this->specieThermo(speciei).Hs(p, T); + return this->specieThermo(speciei).hs(p, T); } @@ -276,7 +276,7 @@ Foam::tmp Foam::MulticomponentThermo::hsi { return scalarFieldPropertyi ( - &BaseThermo::mixtureType::thermoType::Hs, + &BaseThermo::mixtureType::thermoType::hs, speciei, p, T @@ -297,7 +297,7 @@ Foam::MulticomponentThermo::hsi ( "hs", dimEnergy/dimMass, - &BaseThermo::mixtureType::thermoType::Hs, + &BaseThermo::mixtureType::thermoType::hs, speciei, p, T @@ -313,7 +313,7 @@ Foam::scalar Foam::MulticomponentThermo::hai const scalar T ) const { - return this->specieThermo(speciei).Ha(p, T); + return this->specieThermo(speciei).ha(p, T); } @@ -327,7 +327,7 @@ Foam::tmp Foam::MulticomponentThermo::hai { return scalarFieldPropertyi ( - &BaseThermo::mixtureType::thermoType::Ha, + &BaseThermo::mixtureType::thermoType::ha, speciei, p, T @@ -348,7 +348,7 @@ Foam::MulticomponentThermo::hai ( "ha", dimEnergy/dimMass, - &BaseThermo::mixtureType::thermoType::Ha, + &BaseThermo::mixtureType::thermoType::ha, speciei, p, T @@ -362,7 +362,7 @@ Foam::scalar Foam::MulticomponentThermo::hfi const label speciei ) const { - return this->specieThermo(speciei).Hf(); + return this->specieThermo(speciei).hf(); } diff --git a/src/thermophysicalModels/multicomponentThermo/psiuMulticomponentThermo/PsiuMulticomponentThermo.C b/src/thermophysicalModels/multicomponentThermo/psiuMulticomponentThermo/PsiuMulticomponentThermo.C index f965e991f0..275fe59c6d 100644 --- a/src/thermophysicalModels/multicomponentThermo/psiuMulticomponentThermo/PsiuMulticomponentThermo.C +++ b/src/thermophysicalModels/multicomponentThermo/psiuMulticomponentThermo/PsiuMulticomponentThermo.C @@ -57,7 +57,7 @@ void Foam::PsiuMulticomponentThermo::calculate() transportMixture = this->transportMixture(composition, thermoMixture); - TCells[celli] = thermoMixture.THE + TCells[celli] = thermoMixture.The ( hCells[celli], pCells[celli], @@ -72,7 +72,7 @@ void Foam::PsiuMulticomponentThermo::calculate() kappaCells[celli] = transportMixture.kappa(pCells[celli], TCells[celli]); - TuCells[celli] = this->reactants(composition).THE + TuCells[celli] = this->reactants(composition).The ( heuCells[celli], pCells[celli], @@ -137,7 +137,7 @@ void Foam::PsiuMulticomponentThermo::calculate() transportMixture = this->transportMixture(composition, thermoMixture); - phe[facei] = thermoMixture.HE(pp[facei], pT[facei]); + phe[facei] = thermoMixture.he(pp[facei], pT[facei]); pCp[facei] = thermoMixture.Cp(pp[facei], pT[facei]); pCv[facei] = thermoMixture.Cv(pp[facei], pT[facei]); @@ -160,7 +160,7 @@ void Foam::PsiuMulticomponentThermo::calculate() transportMixture = this->transportMixture(composition, thermoMixture); - pT[facei] = thermoMixture.THE(phe[facei], pp[facei], pT[facei]); + pT[facei] = thermoMixture.The(phe[facei], pp[facei], pT[facei]); pCp[facei] = thermoMixture.Cp(pp[facei], pT[facei]); pCv[facei] = thermoMixture.Cv(pp[facei], pT[facei]); @@ -170,7 +170,7 @@ void Foam::PsiuMulticomponentThermo::calculate() pTu[facei] = this->reactants(composition) - .THE(pheu[facei], pp[facei], pTu[facei]); + .The(pheu[facei], pp[facei], pTu[facei]); } } } @@ -214,7 +214,7 @@ Foam::PsiuMulticomponentThermo::PsiuMulticomponentThermo BaseThermo::mixtureType::thermoType::heName() + 'u', dimEnergy/dimMass, &BaseThermo::mixtureType::reactants, - &BaseThermo::mixtureType::thermoMixtureType::HE, + &BaseThermo::mixtureType::thermoMixtureType::he, this->p_, this->Tu_ ), @@ -269,7 +269,7 @@ Foam::PsiuMulticomponentThermo::heu return this->cellSetProperty ( &BaseThermo::mixtureType::reactants, - &BaseThermo::mixtureType::thermoMixtureType::HE, + &BaseThermo::mixtureType::thermoMixtureType::he, cells, UIndirectList(this->p_, cells), Tu @@ -288,7 +288,7 @@ Foam::PsiuMulticomponentThermo::heu return this->patchFieldProperty ( &BaseThermo::mixtureType::reactants, - &BaseThermo::mixtureType::thermoMixtureType::HE, + &BaseThermo::mixtureType::thermoMixtureType::he, patchi, this->p_.boundaryField()[patchi], Tu @@ -305,7 +305,7 @@ Foam::PsiuMulticomponentThermo::Tb() const "Tb", dimTemperature, &BaseThermo::mixtureType::products, - &BaseThermo::mixtureType::thermoMixtureType::THE, + &BaseThermo::mixtureType::thermoMixtureType::The, this->he_, this->p_, this->T_ diff --git a/src/thermophysicalModels/solidThermo/constSolidThermo/constSolidThermo.C b/src/thermophysicalModels/solidThermo/constSolidThermo/constSolidThermo.C index 91fdc4a79e..b6ccefb522 100644 --- a/src/thermophysicalModels/solidThermo/constSolidThermo/constSolidThermo.C +++ b/src/thermophysicalModels/solidThermo/constSolidThermo/constSolidThermo.C @@ -257,13 +257,6 @@ Foam::tmp Foam::constSolidThermo::ha } -Foam::tmp Foam::constSolidThermo::hc() const -{ - NotImplemented; - return tmp(nullptr); -} - - Foam::tmp Foam::constSolidThermo::Cp ( const scalarField& T, @@ -294,7 +287,7 @@ Foam::tmp Foam::constSolidThermo::Cpv } -Foam::tmp Foam::constSolidThermo::THE +Foam::tmp Foam::constSolidThermo::The ( const volScalarField& h, const volScalarField& p, @@ -306,7 +299,7 @@ Foam::tmp Foam::constSolidThermo::THE } -Foam::tmp Foam::constSolidThermo::THE +Foam::tmp Foam::constSolidThermo::The ( const scalarField& he, const scalarField& T0, @@ -318,7 +311,7 @@ Foam::tmp Foam::constSolidThermo::THE } -Foam::tmp Foam::constSolidThermo::THE +Foam::tmp Foam::constSolidThermo::The ( const scalarField& he, const scalarField& T0, diff --git a/src/thermophysicalModels/solidThermo/constSolidThermo/constSolidThermo.H b/src/thermophysicalModels/solidThermo/constSolidThermo/constSolidThermo.H index 785d97ceac..70a35b1613 100644 --- a/src/thermophysicalModels/solidThermo/constSolidThermo/constSolidThermo.H +++ b/src/thermophysicalModels/solidThermo/constSolidThermo/constSolidThermo.H @@ -315,9 +315,6 @@ public: const labelList& cells ) const; - //- Enthalpy of formation [J/kg] - virtual tmp hc() const; - //- Heat capacity at constant pressure for patch [J/kg/K] virtual tmp Cp ( @@ -343,7 +340,7 @@ public: // Temperature-energy inversion functions //- Temperature from enthalpy/internal energy - virtual tmp THE + virtual tmp The ( const volScalarField& h, const volScalarField& p, @@ -351,7 +348,7 @@ public: ) const; //- Temperature from enthalpy/internal energy for cell-set - virtual tmp THE + virtual tmp The ( const scalarField& he, const scalarField& T0, // starting temperature @@ -359,7 +356,7 @@ public: ) const; //- Temperature from enthalpy/internal energy for patch - virtual tmp THE + virtual tmp The ( const scalarField& he, const scalarField& T0, // starting temperature diff --git a/src/thermophysicalModels/solidThermo/solidThermo/SolidThermo.C b/src/thermophysicalModels/solidThermo/solidThermo/SolidThermo.C index 59627098fb..b7a6fb8317 100644 --- a/src/thermophysicalModels/solidThermo/solidThermo/SolidThermo.C +++ b/src/thermophysicalModels/solidThermo/solidThermo/SolidThermo.C @@ -55,7 +55,7 @@ void Foam::SolidThermo::calculate() transportMixture = this->transportMixture(composition, thermoMixture); - TCells[celli] = thermoMixture.THE + TCells[celli] = thermoMixture.The ( hCells[celli], pCells[celli], @@ -127,7 +127,7 @@ void Foam::SolidThermo::calculate() transportMixture = this->transportMixture(composition, thermoMixture); - phe[facei] = thermoMixture.HE(pp[facei], pT[facei]); + phe[facei] = thermoMixture.he(pp[facei], pT[facei]); prho[facei] = thermoMixture.rho(pp[facei], pT[facei]); pCp[facei] = thermoMixture.Cp(pp[facei], pT[facei]); @@ -159,7 +159,7 @@ void Foam::SolidThermo::calculate() transportMixture = this->transportMixture(composition, thermoMixture); - pT[facei] = thermoMixture.THE(phe[facei], pp[facei] ,pT[facei]); + pT[facei] = thermoMixture.The(phe[facei], pp[facei] ,pT[facei]); prho[facei] = thermoMixture.rho(pp[facei], pT[facei]); pCp[facei] = thermoMixture.Cp(pp[facei], pT[facei]); diff --git a/src/thermophysicalModels/specie/equationOfState/Boussinesq/Boussinesq.H b/src/thermophysicalModels/specie/equationOfState/Boussinesq/Boussinesq.H index aa01390adb..c1e3bf8c41 100644 --- a/src/thermophysicalModels/specie/equationOfState/Boussinesq/Boussinesq.H +++ b/src/thermophysicalModels/specie/equationOfState/Boussinesq/Boussinesq.H @@ -173,22 +173,22 @@ public: inline scalar rho(scalar p, scalar T) const; //- Return enthalpy contribution [J/kg] - inline scalar H(const scalar p, const scalar T) const; + inline scalar h(const scalar p, const scalar T) const; //- Return Cp contribution [J/(kg K] inline scalar Cp(scalar p, scalar T) const; //- Return internal energy contribution [J/kg] - inline scalar E(const scalar p, const scalar T) const; + inline scalar e(const scalar p, const scalar T) const; //- Return Cv contribution [J/(kg K] inline scalar Cv(scalar p, scalar T) const; //- Return entropy contribution to the integral of Cp/T [J/kg/K] - inline scalar Sp(const scalar p, const scalar T) const; + inline scalar sp(const scalar p, const scalar T) const; //- Return entropy contribution to the integral of Cv/T [J/kg/K] - inline scalar Sv(const scalar p, const scalar T) const; + inline scalar sv(const scalar p, const scalar T) const; //- Return compressibility [s^2/m^2] inline scalar psi(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/specie/equationOfState/Boussinesq/BoussinesqI.H b/src/thermophysicalModels/specie/equationOfState/Boussinesq/BoussinesqI.H index 5d0c61f8fe..389d5dd334 100644 --- a/src/thermophysicalModels/specie/equationOfState/Boussinesq/BoussinesqI.H +++ b/src/thermophysicalModels/specie/equationOfState/Boussinesq/BoussinesqI.H @@ -83,7 +83,7 @@ inline Foam::scalar Foam::Boussinesq::rho template -inline Foam::scalar Foam::Boussinesq::H(scalar p, scalar T) const +inline Foam::scalar Foam::Boussinesq::h(scalar p, scalar T) const { return p/this->rho(p, T); } @@ -97,7 +97,7 @@ inline Foam::scalar Foam::Boussinesq::Cp(scalar p, scalar T) const template -inline Foam::scalar Foam::Boussinesq::E(scalar p, scalar T) const +inline Foam::scalar Foam::Boussinesq::e(scalar p, scalar T) const { return 0; } @@ -111,7 +111,7 @@ inline Foam::scalar Foam::Boussinesq::Cv(scalar p, scalar T) const template -inline Foam::scalar Foam::Boussinesq::Sp +inline Foam::scalar Foam::Boussinesq::sp ( scalar p, scalar T @@ -122,7 +122,7 @@ inline Foam::scalar Foam::Boussinesq::Sp template -inline Foam::scalar Foam::Boussinesq::Sv +inline Foam::scalar Foam::Boussinesq::sv ( scalar p, scalar T diff --git a/src/thermophysicalModels/specie/equationOfState/PengRobinsonGas/PengRobinsonGas.H b/src/thermophysicalModels/specie/equationOfState/PengRobinsonGas/PengRobinsonGas.H index 8a5808362f..7139a0ca83 100644 --- a/src/thermophysicalModels/specie/equationOfState/PengRobinsonGas/PengRobinsonGas.H +++ b/src/thermophysicalModels/specie/equationOfState/PengRobinsonGas/PengRobinsonGas.H @@ -175,22 +175,22 @@ public: inline scalar rho(scalar p, scalar T) const; //- Return enthalpy contribution [J/kg] - inline scalar H(const scalar p, const scalar T) const; + inline scalar h(const scalar p, const scalar T) const; //- Return Cp contribution [J/(kg K] inline scalar Cp(scalar p, scalar T) const; //- Return internal energy contribution [J/kg] - inline scalar E(const scalar p, const scalar T) const; + inline scalar e(const scalar p, const scalar T) const; //- Return Cv contribution [J/(kg K] inline scalar Cv(scalar p, scalar T) const; //- Return entropy contribution to the integral of Cp/T [J/kg/K] - inline scalar Sp(const scalar p, const scalar T) const; + inline scalar sp(const scalar p, const scalar T) const; //- Return entropy contribution to the integral of Cv/T [J/kg/K] - inline scalar Sv(const scalar p, const scalar T) const; + inline scalar sv(const scalar p, const scalar T) const; //- Return compressibility [s^2/m^2] inline scalar psi(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/specie/equationOfState/PengRobinsonGas/PengRobinsonGasI.H b/src/thermophysicalModels/specie/equationOfState/PengRobinsonGas/PengRobinsonGasI.H index 6ed3a01767..68ee5a8dc6 100644 --- a/src/thermophysicalModels/specie/equationOfState/PengRobinsonGas/PengRobinsonGasI.H +++ b/src/thermophysicalModels/specie/equationOfState/PengRobinsonGas/PengRobinsonGasI.H @@ -90,7 +90,7 @@ inline Foam::scalar Foam::PengRobinsonGas::rho template -inline Foam::scalar Foam::PengRobinsonGas::H(scalar p, scalar T) const +inline Foam::scalar Foam::PengRobinsonGas::h(scalar p, scalar T) const { const scalar Pr = p/Pc_; const scalar Tr = T/Tc_; @@ -143,7 +143,7 @@ inline Foam::scalar Foam::PengRobinsonGas::Cp(scalar p, scalar T) const template -inline Foam::scalar Foam::PengRobinsonGas::E(scalar p, scalar T) const +inline Foam::scalar Foam::PengRobinsonGas::e(scalar p, scalar T) const { const scalar Pr = p/Pc_; const scalar Tr = T/Tc_; @@ -187,7 +187,7 @@ inline Foam::scalar Foam::PengRobinsonGas::Cv(scalar p, scalar T) const template -inline Foam::scalar Foam::PengRobinsonGas::Sp +inline Foam::scalar Foam::PengRobinsonGas::sp ( scalar p, scalar T @@ -214,7 +214,7 @@ inline Foam::scalar Foam::PengRobinsonGas::Sp template -inline Foam::scalar Foam::PengRobinsonGas::Sv +inline Foam::scalar Foam::PengRobinsonGas::sv ( scalar p, scalar T diff --git a/src/thermophysicalModels/specie/equationOfState/adiabaticPerfectFluid/adiabaticPerfectFluid.H b/src/thermophysicalModels/specie/equationOfState/adiabaticPerfectFluid/adiabaticPerfectFluid.H index df0b2298bc..7b752890d3 100644 --- a/src/thermophysicalModels/specie/equationOfState/adiabaticPerfectFluid/adiabaticPerfectFluid.H +++ b/src/thermophysicalModels/specie/equationOfState/adiabaticPerfectFluid/adiabaticPerfectFluid.H @@ -178,22 +178,22 @@ public: inline scalar rho(scalar p, scalar T) const; //- Return enthalpy contribution [J/kg] - inline scalar H(const scalar p, const scalar T) const; + inline scalar h(const scalar p, const scalar T) const; //- Return Cp contribution [J/(kg K] inline scalar Cp(scalar p, scalar T) const; //- Return internal energy contribution [J/kg] - inline scalar E(const scalar p, const scalar T) const; + inline scalar e(const scalar p, const scalar T) const; //- Return Cv contribution [J/(kg K] inline scalar Cv(scalar p, scalar T) const; //- Return entropy contribution to the integral of Cp/T [J/kg/K] - inline scalar Sp(const scalar p, const scalar T) const; + inline scalar sp(const scalar p, const scalar T) const; //- Return entropy contribution to the integral of Cv/T [J/kg/K] - inline scalar Sv(const scalar p, const scalar T) const; + inline scalar sv(const scalar p, const scalar T) const; //- Return compressibility [s^2/m^2] inline scalar psi(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/specie/equationOfState/adiabaticPerfectFluid/adiabaticPerfectFluidI.H b/src/thermophysicalModels/specie/equationOfState/adiabaticPerfectFluid/adiabaticPerfectFluidI.H index 95b60b37cd..36ae06ef56 100644 --- a/src/thermophysicalModels/specie/equationOfState/adiabaticPerfectFluid/adiabaticPerfectFluidI.H +++ b/src/thermophysicalModels/specie/equationOfState/adiabaticPerfectFluid/adiabaticPerfectFluidI.H @@ -85,7 +85,7 @@ inline Foam::scalar Foam::adiabaticPerfectFluid::rho template -inline Foam::scalar Foam::adiabaticPerfectFluid::H +inline Foam::scalar Foam::adiabaticPerfectFluid::h ( scalar p, scalar T @@ -108,7 +108,7 @@ inline Foam::scalar Foam::adiabaticPerfectFluid::Cp template -inline Foam::scalar Foam::adiabaticPerfectFluid::E +inline Foam::scalar Foam::adiabaticPerfectFluid::e ( scalar p, scalar T @@ -131,7 +131,7 @@ inline Foam::scalar Foam::adiabaticPerfectFluid::Cv template -inline Foam::scalar Foam::adiabaticPerfectFluid::Sp +inline Foam::scalar Foam::adiabaticPerfectFluid::sp ( scalar p, scalar T @@ -145,7 +145,7 @@ inline Foam::scalar Foam::adiabaticPerfectFluid::Sp template -inline Foam::scalar Foam::adiabaticPerfectFluid::Sv +inline Foam::scalar Foam::adiabaticPerfectFluid::sv ( scalar p, scalar T diff --git a/src/thermophysicalModels/specie/equationOfState/icoPolynomial/icoPolynomial.H b/src/thermophysicalModels/specie/equationOfState/icoPolynomial/icoPolynomial.H index d18179889b..725a6569ba 100644 --- a/src/thermophysicalModels/specie/equationOfState/icoPolynomial/icoPolynomial.H +++ b/src/thermophysicalModels/specie/equationOfState/icoPolynomial/icoPolynomial.H @@ -162,22 +162,22 @@ public: inline scalar rho(scalar p, scalar T) const; //- Return enthalpy contribution [J/kg] - inline scalar H(const scalar p, const scalar T) const; + inline scalar h(const scalar p, const scalar T) const; //- Return Cp contribution [J/(kg K] inline scalar Cp(scalar p, scalar T) const; //- Return internal energy contribution [J/kg] - inline scalar E(const scalar p, const scalar T) const; + inline scalar e(const scalar p, const scalar T) const; //- Return Cv contribution [J/(kg K] inline scalar Cv(scalar p, scalar T) const; //- Return entropy contribution to the integral of Cp/T [J/kg/K] - inline scalar Sp(const scalar p, const scalar T) const; + inline scalar sp(const scalar p, const scalar T) const; //- Return entropy contribution to the integral of Cv/T [J/kg/K] - inline scalar Sv(const scalar p, const scalar T) const; + inline scalar sv(const scalar p, const scalar T) const; //- Return compressibility [s^2/m^2] inline scalar psi(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/specie/equationOfState/icoPolynomial/icoPolynomialI.H b/src/thermophysicalModels/specie/equationOfState/icoPolynomial/icoPolynomialI.H index 919df2ff96..13ac986f52 100644 --- a/src/thermophysicalModels/specie/equationOfState/icoPolynomial/icoPolynomialI.H +++ b/src/thermophysicalModels/specie/equationOfState/icoPolynomial/icoPolynomialI.H @@ -76,7 +76,7 @@ inline Foam::scalar Foam::icoPolynomial::rho template -inline Foam::scalar Foam::icoPolynomial::H +inline Foam::scalar Foam::icoPolynomial::h ( scalar p, scalar T @@ -98,7 +98,7 @@ inline Foam::scalar Foam::icoPolynomial::Cp template -inline Foam::scalar Foam::icoPolynomial::E +inline Foam::scalar Foam::icoPolynomial::e ( scalar p, scalar T @@ -120,7 +120,7 @@ inline Foam::scalar Foam::icoPolynomial::Cv template -inline Foam::scalar Foam::icoPolynomial::Sp +inline Foam::scalar Foam::icoPolynomial::sp ( scalar p, scalar T @@ -131,7 +131,7 @@ inline Foam::scalar Foam::icoPolynomial::Sp template -inline Foam::scalar Foam::icoPolynomial::Sv +inline Foam::scalar Foam::icoPolynomial::sv ( scalar p, scalar T diff --git a/src/thermophysicalModels/specie/equationOfState/icoTabulated/icoTabulated.H b/src/thermophysicalModels/specie/equationOfState/icoTabulated/icoTabulated.H index 9405f1d90c..502adaab9e 100644 --- a/src/thermophysicalModels/specie/equationOfState/icoTabulated/icoTabulated.H +++ b/src/thermophysicalModels/specie/equationOfState/icoTabulated/icoTabulated.H @@ -145,22 +145,22 @@ public: inline scalar rho(scalar p, scalar T) const; //- Return enthalpy contribution [J/kg] - inline scalar H(const scalar p, const scalar T) const; + inline scalar h(const scalar p, const scalar T) const; //- Return Cp contribution [J/(kg K] inline scalar Cp(scalar p, scalar T) const; //- Return internal energy contribution [J/kg] - inline scalar E(const scalar p, const scalar T) const; + inline scalar e(const scalar p, const scalar T) const; //- Return Cv contribution [J/(kg K] inline scalar Cv(scalar p, scalar T) const; //- Return entropy contribution to the integral of Cp/T [J/kg/K] - inline scalar Sp(const scalar p, const scalar T) const; + inline scalar sp(const scalar p, const scalar T) const; //- Return entropy contribution to the integral of Cv/T [J/kg/K] - inline scalar Sv(const scalar p, const scalar T) const; + inline scalar sv(const scalar p, const scalar T) const; //- Return compressibility [s^2/m^2] inline scalar psi(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/specie/equationOfState/icoTabulated/icoTabulatedI.H b/src/thermophysicalModels/specie/equationOfState/icoTabulated/icoTabulatedI.H index df8b0e51b4..e24d85ca7b 100644 --- a/src/thermophysicalModels/specie/equationOfState/icoTabulated/icoTabulatedI.H +++ b/src/thermophysicalModels/specie/equationOfState/icoTabulated/icoTabulatedI.H @@ -76,7 +76,7 @@ inline Foam::scalar Foam::icoTabulated::rho template -inline Foam::scalar Foam::icoTabulated::H +inline Foam::scalar Foam::icoTabulated::h ( scalar p, scalar T @@ -98,7 +98,7 @@ inline Foam::scalar Foam::icoTabulated::Cp template -inline Foam::scalar Foam::icoTabulated::E +inline Foam::scalar Foam::icoTabulated::e ( scalar p, scalar T @@ -120,7 +120,7 @@ inline Foam::scalar Foam::icoTabulated::Cv template -inline Foam::scalar Foam::icoTabulated::Sp +inline Foam::scalar Foam::icoTabulated::sp ( scalar p, scalar T @@ -131,7 +131,7 @@ inline Foam::scalar Foam::icoTabulated::Sp template -inline Foam::scalar Foam::icoTabulated::Sv +inline Foam::scalar Foam::icoTabulated::sv ( scalar p, scalar T diff --git a/src/thermophysicalModels/specie/equationOfState/incompressiblePerfectGas/incompressiblePerfectGas.H b/src/thermophysicalModels/specie/equationOfState/incompressiblePerfectGas/incompressiblePerfectGas.H index a92397da45..5c269ea684 100644 --- a/src/thermophysicalModels/specie/equationOfState/incompressiblePerfectGas/incompressiblePerfectGas.H +++ b/src/thermophysicalModels/specie/equationOfState/incompressiblePerfectGas/incompressiblePerfectGas.H @@ -155,22 +155,22 @@ public: inline scalar rho(scalar p, scalar T) const; //- Return enthalpy contribution [J/kg] - inline scalar H(const scalar p, const scalar T) const; + inline scalar h(const scalar p, const scalar T) const; //- Return Cp contribution [J/(kg K] inline scalar Cp(scalar p, scalar T) const; //- Return internal energy contribution [J/kg] - inline scalar E(const scalar p, const scalar T) const; + inline scalar e(const scalar p, const scalar T) const; //- Return Cv contribution [J/(kg K] inline scalar Cv(scalar p, scalar T) const; //- Return entropy contribution to the integral of Cp/T [J/kg/K] - inline scalar Sp(const scalar p, const scalar T) const; + inline scalar sp(const scalar p, const scalar T) const; //- Return entropy contribution to the integral of Cv/T [J/kg/K] - inline scalar Sv(const scalar p, const scalar T) const; + inline scalar sv(const scalar p, const scalar T) const; //- Return compressibility [s^2/m^2] inline scalar psi(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/specie/equationOfState/incompressiblePerfectGas/incompressiblePerfectGasI.H b/src/thermophysicalModels/specie/equationOfState/incompressiblePerfectGas/incompressiblePerfectGasI.H index ecad482827..394751182b 100644 --- a/src/thermophysicalModels/specie/equationOfState/incompressiblePerfectGas/incompressiblePerfectGasI.H +++ b/src/thermophysicalModels/specie/equationOfState/incompressiblePerfectGas/incompressiblePerfectGasI.H @@ -77,7 +77,7 @@ inline Foam::scalar Foam::incompressiblePerfectGas::rho template -inline Foam::scalar Foam::incompressiblePerfectGas::H +inline Foam::scalar Foam::incompressiblePerfectGas::h ( scalar p, scalar T @@ -99,7 +99,7 @@ inline Foam::scalar Foam::incompressiblePerfectGas::Cp template -inline Foam::scalar Foam::incompressiblePerfectGas::E +inline Foam::scalar Foam::incompressiblePerfectGas::e ( scalar p, scalar T @@ -121,7 +121,7 @@ inline Foam::scalar Foam::incompressiblePerfectGas::Cv template -inline Foam::scalar Foam::incompressiblePerfectGas::Sp +inline Foam::scalar Foam::incompressiblePerfectGas::sp ( scalar p, scalar T @@ -132,7 +132,7 @@ inline Foam::scalar Foam::incompressiblePerfectGas::Sp template -inline Foam::scalar Foam::incompressiblePerfectGas::Sv +inline Foam::scalar Foam::incompressiblePerfectGas::sv ( scalar p, scalar T diff --git a/src/thermophysicalModels/specie/equationOfState/linear/linear.H b/src/thermophysicalModels/specie/equationOfState/linear/linear.H index 97d6df3ba0..3c6aa57ef3 100644 --- a/src/thermophysicalModels/specie/equationOfState/linear/linear.H +++ b/src/thermophysicalModels/specie/equationOfState/linear/linear.H @@ -160,22 +160,22 @@ public: inline scalar rho(scalar p, scalar T) const; //- Return enthalpy contribution [J/kg] - inline scalar H(const scalar p, const scalar T) const; + inline scalar h(const scalar p, const scalar T) const; //- Return Cp contribution [J/(kg K] inline scalar Cp(scalar p, scalar T) const; //- Return internal energy contribution [J/kg] - inline scalar E(const scalar p, const scalar T) const; + inline scalar e(const scalar p, const scalar T) const; //- Return Cv contribution [J/(kg K] inline scalar Cv(scalar p, scalar T) const; //- Return entropy contribution to the integral of Cp/T [J/kg/K] - inline scalar Sp(const scalar p, const scalar T) const; + inline scalar sp(const scalar p, const scalar T) const; //- Return entropy contribution to the integral of Cv/T [J/kg/K] - inline scalar Sv(const scalar p, const scalar T) const; + inline scalar sv(const scalar p, const scalar T) const; //- Return compressibility [s^2/m^2] inline scalar psi(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/specie/equationOfState/linear/linearI.H b/src/thermophysicalModels/specie/equationOfState/linear/linearI.H index f8d69da15e..3add70ba42 100644 --- a/src/thermophysicalModels/specie/equationOfState/linear/linearI.H +++ b/src/thermophysicalModels/specie/equationOfState/linear/linearI.H @@ -72,7 +72,7 @@ inline Foam::scalar Foam::linear::rho(scalar p, scalar T) const template -inline Foam::scalar Foam::linear::H(scalar p, scalar T) const +inline Foam::scalar Foam::linear::h(scalar p, scalar T) const { return log(rho(p, T))/psi_; } @@ -86,7 +86,7 @@ inline Foam::scalar Foam::linear::Cp(scalar p, scalar T) const template -inline Foam::scalar Foam::linear::E(scalar p, scalar T) const +inline Foam::scalar Foam::linear::e(scalar p, scalar T) const { const scalar rho = this->rho(p, T); @@ -102,14 +102,14 @@ inline Foam::scalar Foam::linear::Cv(scalar p, scalar T) const template -inline Foam::scalar Foam::linear::Sp(scalar p, scalar T) const +inline Foam::scalar Foam::linear::sp(scalar p, scalar T) const { return -log((rho0_ + psi_*p)/(rho0_ + psi_*Pstd))/(T*psi_); } template -inline Foam::scalar Foam::linear::Sv(scalar p, scalar T) const +inline Foam::scalar Foam::linear::sv(scalar p, scalar T) const { NotImplemented; return 0; diff --git a/src/thermophysicalModels/specie/equationOfState/perfectFluid/perfectFluid.H b/src/thermophysicalModels/specie/equationOfState/perfectFluid/perfectFluid.H index 7b738b2183..ac479cdbd7 100644 --- a/src/thermophysicalModels/specie/equationOfState/perfectFluid/perfectFluid.H +++ b/src/thermophysicalModels/specie/equationOfState/perfectFluid/perfectFluid.H @@ -167,22 +167,22 @@ public: inline scalar rho(scalar p, scalar T) const; //- Return enthalpy contribution [J/kg] - inline scalar H(const scalar p, const scalar T) const; + inline scalar h(const scalar p, const scalar T) const; //- Return Cp contribution [J/(kg K] inline scalar Cp(scalar p, scalar T) const; //- Return internal energy contribution [J/kg] - inline scalar E(const scalar p, const scalar T) const; + inline scalar e(const scalar p, const scalar T) const; //- Return Cv contribution [J/(kg K] inline scalar Cv(scalar p, scalar T) const; //- Return entropy contribution to the integral of Cp/T [J/kg/K] - inline scalar Sp(const scalar p, const scalar T) const; + inline scalar sp(const scalar p, const scalar T) const; //- Return entropy contribution to the integral of Cv/T [J/kg/K] - inline scalar Sv(const scalar p, const scalar T) const; + inline scalar sv(const scalar p, const scalar T) const; //- Return compressibility [s^2/m^2] inline scalar psi(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/specie/equationOfState/perfectFluid/perfectFluidI.H b/src/thermophysicalModels/specie/equationOfState/perfectFluid/perfectFluidI.H index 643b461cfe..ddda3d64a6 100644 --- a/src/thermophysicalModels/specie/equationOfState/perfectFluid/perfectFluidI.H +++ b/src/thermophysicalModels/specie/equationOfState/perfectFluid/perfectFluidI.H @@ -79,7 +79,7 @@ inline Foam::scalar Foam::perfectFluid::rho(scalar p, scalar T) const template -inline Foam::scalar Foam::perfectFluid::H(scalar p, scalar T) const +inline Foam::scalar Foam::perfectFluid::h(scalar p, scalar T) const { return p/rho(p, T) - Pstd/rho(Pstd, T); } @@ -95,7 +95,7 @@ inline Foam::scalar Foam::perfectFluid::Cp(scalar p, scalar T) const template -inline Foam::scalar Foam::perfectFluid::E(scalar p, scalar T) const +inline Foam::scalar Foam::perfectFluid::e(scalar p, scalar T) const { return 0; } @@ -109,14 +109,14 @@ inline Foam::scalar Foam::perfectFluid::Cv(scalar p, scalar T) const template -inline Foam::scalar Foam::perfectFluid::Sp(scalar p, scalar T) const +inline Foam::scalar Foam::perfectFluid::sp(scalar p, scalar T) const { return -this->R()*log(p/Pstd); } template -inline Foam::scalar Foam::perfectFluid::Sv(scalar p, scalar T) const +inline Foam::scalar Foam::perfectFluid::sv(scalar p, scalar T) const { NotImplemented; return 0; diff --git a/src/thermophysicalModels/specie/equationOfState/perfectGas/perfectGas.H b/src/thermophysicalModels/specie/equationOfState/perfectGas/perfectGas.H index 46fcb16d2e..1e3540101e 100644 --- a/src/thermophysicalModels/specie/equationOfState/perfectGas/perfectGas.H +++ b/src/thermophysicalModels/specie/equationOfState/perfectGas/perfectGas.H @@ -134,22 +134,22 @@ public: inline scalar rho(scalar p, scalar T) const; //- Return enthalpy contribution [J/kg] - inline scalar H(const scalar p, const scalar T) const; + inline scalar h(const scalar p, const scalar T) const; //- Return Cp contribution [J/(kg K] inline scalar Cp(scalar p, scalar T) const; //- Return internal energy contribution [J/kg] - inline scalar E(const scalar p, const scalar T) const; + inline scalar e(const scalar p, const scalar T) const; //- Return Cv contribution [J/(kg K] inline scalar Cv(scalar p, scalar T) const; //- Return entropy contribution to the integral of Cp/T [J/kg/K] - inline scalar Sp(const scalar p, const scalar T) const; + inline scalar sp(const scalar p, const scalar T) const; //- Return entropy contribution to the integral of Cv/T [J/kg/K] - inline scalar Sv(const scalar p, const scalar T) const; + inline scalar sv(const scalar p, const scalar T) const; //- Return compressibility [s^2/m^2] inline scalar psi(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/specie/equationOfState/perfectGas/perfectGasI.H b/src/thermophysicalModels/specie/equationOfState/perfectGas/perfectGasI.H index 6e2416a53e..bc3b1d94ef 100644 --- a/src/thermophysicalModels/specie/equationOfState/perfectGas/perfectGasI.H +++ b/src/thermophysicalModels/specie/equationOfState/perfectGas/perfectGasI.H @@ -63,7 +63,7 @@ inline Foam::scalar Foam::perfectGas::rho(scalar p, scalar T) const template -inline Foam::scalar Foam::perfectGas::H(scalar p, scalar T) const +inline Foam::scalar Foam::perfectGas::h(scalar p, scalar T) const { return 0; } @@ -77,7 +77,7 @@ inline Foam::scalar Foam::perfectGas::Cp(scalar p, scalar T) const template -inline Foam::scalar Foam::perfectGas::E(scalar p, scalar T) const +inline Foam::scalar Foam::perfectGas::e(scalar p, scalar T) const { return 0; } @@ -91,14 +91,14 @@ inline Foam::scalar Foam::perfectGas::Cv(scalar p, scalar T) const template -inline Foam::scalar Foam::perfectGas::Sp(scalar p, scalar T) const +inline Foam::scalar Foam::perfectGas::sp(scalar p, scalar T) const { return -this->R()*log(p/Pstd); } template -inline Foam::scalar Foam::perfectGas::Sv(scalar p, scalar T) const +inline Foam::scalar Foam::perfectGas::sv(scalar p, scalar T) const { NotImplemented; return 0; diff --git a/src/thermophysicalModels/specie/equationOfState/rPolynomial/rPolynomial.H b/src/thermophysicalModels/specie/equationOfState/rPolynomial/rPolynomial.H index 8ed1fb32b1..94090828d6 100644 --- a/src/thermophysicalModels/specie/equationOfState/rPolynomial/rPolynomial.H +++ b/src/thermophysicalModels/specie/equationOfState/rPolynomial/rPolynomial.H @@ -178,22 +178,22 @@ public: inline scalar rho(scalar p, scalar T) const; //- Return enthalpy contribution [J/kg] - inline scalar H(const scalar p, const scalar T) const; + inline scalar h(const scalar p, const scalar T) const; //- Return Cp contribution [J/(kg K] inline scalar Cp(scalar p, scalar T) const; //- Return internal energy contribution [J/kg] - inline scalar E(const scalar p, const scalar T) const; + inline scalar e(const scalar p, const scalar T) const; //- Return Cv contribution [J/(kg K] inline scalar Cv(scalar p, scalar T) const; //- Return entropy contribution to the integral of Cp/T [J/kg/K] - inline scalar Sp(const scalar p, const scalar T) const; + inline scalar sp(const scalar p, const scalar T) const; //- Return entropy contribution to the integral of Cv/T [J/kg/K] - inline scalar Sv(const scalar p, const scalar T) const; + inline scalar sv(const scalar p, const scalar T) const; //- Return compressibility [s^2/m^2] inline scalar psi(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/specie/equationOfState/rPolynomial/rPolynomialI.H b/src/thermophysicalModels/specie/equationOfState/rPolynomial/rPolynomialI.H index e888cfc897..72c85a25d3 100644 --- a/src/thermophysicalModels/specie/equationOfState/rPolynomial/rPolynomialI.H +++ b/src/thermophysicalModels/specie/equationOfState/rPolynomial/rPolynomialI.H @@ -69,7 +69,7 @@ inline Foam::scalar Foam::rPolynomial::rho(scalar p, scalar T) const template -inline Foam::scalar Foam::rPolynomial::H(scalar p, scalar T) const +inline Foam::scalar Foam::rPolynomial::h(scalar p, scalar T) const { return 0; } @@ -83,7 +83,7 @@ inline Foam::scalar Foam::rPolynomial::Cp(scalar p, scalar T) const template -inline Foam::scalar Foam::rPolynomial::E(scalar p, scalar T) const +inline Foam::scalar Foam::rPolynomial::e(scalar p, scalar T) const { return 0; } @@ -97,14 +97,14 @@ inline Foam::scalar Foam::rPolynomial::Cv(scalar p, scalar T) const template -inline Foam::scalar Foam::rPolynomial::Sp(scalar p, scalar T) const +inline Foam::scalar Foam::rPolynomial::sp(scalar p, scalar T) const { return 0; } template -inline Foam::scalar Foam::rPolynomial::Sv(scalar p, scalar T) const +inline Foam::scalar Foam::rPolynomial::sv(scalar p, scalar T) const { NotImplemented return 0; diff --git a/src/thermophysicalModels/specie/equationOfState/rhoConst/rhoConst.H b/src/thermophysicalModels/specie/equationOfState/rhoConst/rhoConst.H index bfaa8d08b7..af86df41e0 100644 --- a/src/thermophysicalModels/specie/equationOfState/rhoConst/rhoConst.H +++ b/src/thermophysicalModels/specie/equationOfState/rhoConst/rhoConst.H @@ -144,22 +144,22 @@ public: inline scalar rho(scalar p, scalar T) const; //- Return enthalpy contribution [J/kg] - inline scalar H(const scalar p, const scalar T) const; + inline scalar h(const scalar p, const scalar T) const; //- Return Cp contribution [J/(kg K] inline scalar Cp(scalar p, scalar T) const; //- Return internal energy contribution [J/kg] - inline scalar E(const scalar p, const scalar T) const; + inline scalar e(const scalar p, const scalar T) const; //- Return Cv contribution [J/(kg K] inline scalar Cv(scalar p, scalar T) const; //- Return entropy contribution to the integral of Cp/T [J/kg/K] - inline scalar Sp(const scalar p, const scalar T) const; + inline scalar sp(const scalar p, const scalar T) const; //- Return entropy contribution to the integral of Cv/T [J/kg/K] - inline scalar Sv(const scalar p, const scalar T) const; + inline scalar sv(const scalar p, const scalar T) const; //- Return compressibility [s^2/m^2] inline scalar psi(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/specie/equationOfState/rhoConst/rhoConstI.H b/src/thermophysicalModels/specie/equationOfState/rhoConst/rhoConstI.H index 35ed75f986..167c960599 100644 --- a/src/thermophysicalModels/specie/equationOfState/rhoConst/rhoConstI.H +++ b/src/thermophysicalModels/specie/equationOfState/rhoConst/rhoConstI.H @@ -69,7 +69,7 @@ inline Foam::scalar Foam::rhoConst::rho(scalar p, scalar T) const template -inline Foam::scalar Foam::rhoConst::H(scalar p, scalar T) const +inline Foam::scalar Foam::rhoConst::h(scalar p, scalar T) const { return p/rho_; } @@ -83,7 +83,7 @@ inline Foam::scalar Foam::rhoConst::Cp(scalar p, scalar T) const template -inline Foam::scalar Foam::rhoConst::E(scalar p, scalar T) const +inline Foam::scalar Foam::rhoConst::e(scalar p, scalar T) const { return 0; } @@ -97,14 +97,14 @@ inline Foam::scalar Foam::rhoConst::Cv(scalar p, scalar T) const template -inline Foam::scalar Foam::rhoConst::Sp(scalar p, scalar T) const +inline Foam::scalar Foam::rhoConst::sp(scalar p, scalar T) const { return 0; } template -inline Foam::scalar Foam::rhoConst::Sv(scalar p, scalar T) const +inline Foam::scalar Foam::rhoConst::sv(scalar p, scalar T) const { return 0; } diff --git a/src/thermophysicalModels/specie/equationOfState/rhoTabulated/rhoTabulated.H b/src/thermophysicalModels/specie/equationOfState/rhoTabulated/rhoTabulated.H index 549170d0da..b63de7989d 100644 --- a/src/thermophysicalModels/specie/equationOfState/rhoTabulated/rhoTabulated.H +++ b/src/thermophysicalModels/specie/equationOfState/rhoTabulated/rhoTabulated.H @@ -29,7 +29,7 @@ Description density vs pressure and temperature. Thermodynamic contributions derived from tabulated density data are not - sufficiently accurate and hence the H, Cp, E, Cv, Sp, Sv and CpMCv are not + sufficiently accurate and hence the h, Cp, e, Cv, sp, sv and CpMCv are not implemented. Thus this equation of state should be used in conjunction with hTabulated or eTabulated thermodynamics in which both the energy and heat capacity are tabulated w.r.t. pressure and temperature avoiding the need @@ -183,7 +183,7 @@ public: //- Return enthalpy contribution [J/kg] // Not implemented - inline scalar H(const scalar p, const scalar T) const; + inline scalar h(const scalar p, const scalar T) const; //- Return Cp contribution [J/(kg K] // Not implemented @@ -191,7 +191,7 @@ public: //- Return internal energy contribution [J/kg] // Not implemented - inline scalar E(const scalar p, const scalar T) const; + inline scalar e(const scalar p, const scalar T) const; //- Return Cv contribution [J/(kg K] // Not implemented @@ -199,11 +199,11 @@ public: //- Return entropy contribution to the integral of Cp/T [J/kg/K] // Not implemented - inline scalar Sp(const scalar p, const scalar T) const; + inline scalar sp(const scalar p, const scalar T) const; //- Return entropy contribution to the integral of Cv/T [J/kg/K] // Not implemented - inline scalar Sv(const scalar p, const scalar T) const; + inline scalar sv(const scalar p, const scalar T) const; //- Return compressibility [s^2/m^2] inline scalar psi(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/specie/equationOfState/rhoTabulated/rhoTabulatedI.H b/src/thermophysicalModels/specie/equationOfState/rhoTabulated/rhoTabulatedI.H index cb5a1e9896..447507ee4b 100644 --- a/src/thermophysicalModels/specie/equationOfState/rhoTabulated/rhoTabulatedI.H +++ b/src/thermophysicalModels/specie/equationOfState/rhoTabulated/rhoTabulatedI.H @@ -76,7 +76,7 @@ inline Foam::scalar Foam::rhoTabulated::rho template -inline Foam::scalar Foam::rhoTabulated::H +inline Foam::scalar Foam::rhoTabulated::h ( scalar p, scalar T @@ -100,7 +100,7 @@ inline Foam::scalar Foam::rhoTabulated::Cp template -inline Foam::scalar Foam::rhoTabulated::E +inline Foam::scalar Foam::rhoTabulated::e ( scalar p, scalar T @@ -124,7 +124,7 @@ inline Foam::scalar Foam::rhoTabulated::Cv template -inline Foam::scalar Foam::rhoTabulated::Sp +inline Foam::scalar Foam::rhoTabulated::sp ( scalar p, scalar T @@ -136,7 +136,7 @@ inline Foam::scalar Foam::rhoTabulated::Sp template -inline Foam::scalar Foam::rhoTabulated::Sv +inline Foam::scalar Foam::rhoTabulated::sv ( scalar p, scalar T diff --git a/src/thermophysicalModels/specie/thermo/absoluteEnthalpy/absoluteEnthalpy.H b/src/thermophysicalModels/specie/thermo/absoluteEnthalpy/absoluteEnthalpy.H index 630bc8fe46..0b378b3b01 100644 --- a/src/thermophysicalModels/specie/thermo/absoluteEnthalpy/absoluteEnthalpy.H +++ b/src/thermophysicalModels/specie/thermo/absoluteEnthalpy/absoluteEnthalpy.H @@ -87,19 +87,19 @@ public: } // Absolute enthalpy [J/kg] - scalar HE + scalar he ( const Thermo& thermo, const scalar p, const scalar T ) const { - return thermo.Ha(p, T); + return thermo.ha(p, T); } //- Temperature from absolute enthalpy // given an initial temperature T0 - scalar THE + scalar The ( const Thermo& thermo, const scalar h, @@ -107,7 +107,7 @@ public: const scalar T0 ) const { - return thermo.THa(h, p, T0); + return thermo.Tha(h, p, T0); } }; diff --git a/src/thermophysicalModels/specie/thermo/absoluteInternalEnergy/absoluteInternalEnergy.H b/src/thermophysicalModels/specie/thermo/absoluteInternalEnergy/absoluteInternalEnergy.H index 48ad0c83d0..e53c7f02db 100644 --- a/src/thermophysicalModels/specie/thermo/absoluteInternalEnergy/absoluteInternalEnergy.H +++ b/src/thermophysicalModels/specie/thermo/absoluteInternalEnergy/absoluteInternalEnergy.H @@ -88,19 +88,19 @@ public: } // Absolute internal energy [J/kg] - scalar HE + scalar he ( const Thermo& thermo, const scalar p, const scalar T ) const { - return thermo.Ea(p, T); + return thermo.ea(p, T); } //- Temperature from absolute internal energy // given an initial temperature T0 - scalar THE + scalar The ( const Thermo& thermo, const scalar e, @@ -108,7 +108,7 @@ public: const scalar T0 ) const { - return thermo.TEa(e, p, T0); + return thermo.Tea(e, p, T0); } }; diff --git a/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.C b/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.C index aa16d9cbb8..c4ced14864 100644 --- a/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.C +++ b/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.C @@ -37,9 +37,19 @@ Foam::eConstThermo::eConstThermo : EquationOfState(name, dict), Cv_(dict.subDict("thermodynamics").lookup("Cv")), - Hf_(dict.subDict("thermodynamics").lookup("Hf")), + hf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"hf", "Hf"}) + ), Tref_(dict.subDict("thermodynamics").lookupOrDefault("Tref", Tstd)), - Esref_(dict.subDict("thermodynamics").lookupOrDefault("Esref", 0)) + esRef_ + ( + dict + .subDict("thermodynamics") + .lookupOrDefaultBackwardsCompatible({"esRef", "Esref"}, 0) + ) {} @@ -52,14 +62,14 @@ void Foam::eConstThermo::write(Ostream& os) const dictionary dict("thermodynamics"); dict.add("Cv", Cv_); - dict.add("Hf", Hf_); + dict.add("hf", hf_); if (Tref_ != Tstd) { dict.add("Tref", Tref_); } - if (Esref_ != 0) + if (esRef_ != 0) { - dict.add("Esref", Esref_); + dict.add("esRef", esRef_); } os << indent << dict.dictName() << dict; } diff --git a/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.H b/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.H index 9990e8e41b..12cf3d4c85 100644 --- a/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.H +++ b/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.H @@ -29,7 +29,7 @@ Description at constant volume: \verbatim - e = Cv*(T - Tref) + Esref + e = Cv*(T - Tref) + esRef \endverbatim Usage @@ -37,8 +37,8 @@ Usage Property | Description Cv | Constant Heat capacity at constant volume [J/kg/K] Tref | Reference temperature [K] (defaults to Tstd) - Esref | Reference sensible internal energy [J/kg] (defaults to 0) - Hf | Heat of formation [J/kg] + esRef | Reference sensible internal energy [J/kg] (defaults to 0) + hf | Heat of formation [J/kg] \endtable Example specification of eConstThermo for air: @@ -46,7 +46,7 @@ Usage thermodynamics { Cv 724; - Hf 0; + hf 0; } \endverbatim @@ -112,13 +112,13 @@ class eConstThermo scalar Cv_; //- Heat of formation [J/kg] - scalar Hf_; + scalar hf_; //- Reference temperature around which to linearise [K] scalar Tref_; //- Reference sensible enthalpy around which to linearise [J/kg] - scalar Esref_; + scalar esRef_; public: @@ -130,9 +130,9 @@ public: ( const EquationOfState& st, const scalar Cv, - const scalar Hf, + const scalar hf, const scalar Tref, - const scalar Esref + const scalar esRef ); //- Construct from name and dictionary @@ -163,19 +163,19 @@ public: inline scalar Cv(const scalar p, const scalar T) const; //- Sensible internal energy [J/kg] - inline scalar Es(const scalar p, const scalar T) const; + inline scalar es(const scalar p, const scalar T) const; //- Absolute internal energy [J/kg] - inline scalar Ea(const scalar p, const scalar T) const; + inline scalar ea(const scalar p, const scalar T) const; //- Enthalpy of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Entropy [J/kg/K] - inline scalar S(const scalar p, const scalar T) const; + inline scalar s(const scalar p, const scalar T) const; //- Gibbs free energy of the mixture in the standard state [J/kg] - inline scalar Gstd(const scalar T) const; + inline scalar gStd(const scalar T) const; #include "EtoHthermo.H" diff --git a/src/thermophysicalModels/specie/thermo/eConst/eConstThermoI.H b/src/thermophysicalModels/specie/thermo/eConst/eConstThermoI.H index 54d7eacfc0..1a5048dc59 100644 --- a/src/thermophysicalModels/specie/thermo/eConst/eConstThermoI.H +++ b/src/thermophysicalModels/specie/thermo/eConst/eConstThermoI.H @@ -30,16 +30,16 @@ inline Foam::eConstThermo::eConstThermo ( const EquationOfState& st, const scalar Cv, - const scalar Hf, + const scalar hf, const scalar Tref, - const scalar Esref + const scalar esRef ) : EquationOfState(st), Cv_(Cv), - Hf_(Hf), + hf_(hf), Tref_(Tref), - Esref_(Esref) + esRef_(esRef) {} @@ -52,9 +52,9 @@ inline Foam::eConstThermo::eConstThermo : EquationOfState(name, ct), Cv_(ct.Cv_), - Hf_(ct.Hf_), + hf_(ct.hf_), Tref_(ct.Tref_), - Esref_(ct.Esref_) + esRef_(ct.esRef_) {} @@ -93,54 +93,54 @@ inline Foam::scalar Foam::eConstThermo::Cv template -inline Foam::scalar Foam::eConstThermo::Es +inline Foam::scalar Foam::eConstThermo::es ( const scalar p, const scalar T ) const { - return Cv_*(T - Tref_) + Esref_ + EquationOfState::E(p, T); + return Cv_*(T - Tref_) + esRef_ + EquationOfState::e(p, T); } template -inline Foam::scalar Foam::eConstThermo::Ea +inline Foam::scalar Foam::eConstThermo::ea ( const scalar p, const scalar T ) const { - return Es(p, T) + Hf(); + return es(p, T) + hf(); } template -inline Foam::scalar Foam::eConstThermo::Hf() const +inline Foam::scalar Foam::eConstThermo::hf() const { - return Hf_; + return hf_; } template -inline Foam::scalar Foam::eConstThermo::S +inline Foam::scalar Foam::eConstThermo::s ( const scalar p, const scalar T ) const { - return Cp(p, T)*log(T/Tstd) + EquationOfState::Sv(p, T); + return Cp(p, T)*log(T/Tstd) + EquationOfState::sv(p, T); } template -inline Foam::scalar Foam::eConstThermo::Gstd +inline Foam::scalar Foam::eConstThermo::gStd ( const scalar T ) const { return - Cv_*(T - Tref_) + Esref_ + Hf() + Pstd/EquationOfState::rho(Pstd, T) - - S(Pstd, T)*T; + Cv_*(T - Tref_) + esRef_ + hf() + Pstd/EquationOfState::rho(Pstd, T) + - s(Pstd, T)*T; } @@ -188,8 +188,8 @@ inline void Foam::eConstThermo::operator+= const scalar Y2 = ct.Y()/this->Y(); Cv_ = Y1*Cv_ + Y2*ct.Cv_; - Hf_ = Y1*Hf_ + Y2*ct.Hf_; - Esref_ = Y1*Esref_ + Y2*ct.Esref_; + hf_ = Y1*hf_ + Y2*ct.hf_; + esRef_ = Y1*esRef_ + Y2*ct.esRef_; } } @@ -215,9 +215,9 @@ inline Foam::eConstThermo Foam::operator+ ( eofs, ct1.Cv_, - ct1.Hf_, + ct1.hf_, ct1.Tref_, - ct1.Esref_ + ct1.esRef_ ); } else @@ -241,11 +241,11 @@ inline Foam::eConstThermo Foam::operator+ eofs, ct1.Y()/eofs.Y()*ct1.Cv_ + ct2.Y()/eofs.Y()*ct2.Cv_, - ct1.Y()/eofs.Y()*ct1.Hf_ - + ct2.Y()/eofs.Y()*ct2.Hf_, + ct1.Y()/eofs.Y()*ct1.hf_ + + ct2.Y()/eofs.Y()*ct2.hf_, ct1.Tref_, - ct1.Y()/eofs.Y()*ct1.Esref_ - + ct2.Y()/eofs.Y()*ct2.Esref_ + ct1.Y()/eofs.Y()*ct1.esRef_ + + ct2.Y()/eofs.Y()*ct2.esRef_ ); } } @@ -262,9 +262,9 @@ inline Foam::eConstThermo Foam::operator* ( s*static_cast(ct), ct.Cv_, - ct.Hf_, + ct.hf_, ct.Tref_, - ct.Esref_ + ct.esRef_ ); } @@ -301,11 +301,11 @@ inline Foam::eConstThermo Foam::operator== eofs, ct2.Y()/eofs.Y()*ct2.Cv_ - ct1.Y()/eofs.Y()*ct1.Cv_, - ct2.Y()/eofs.Y()*ct2.Hf_ - - ct1.Y()/eofs.Y()*ct1.Hf_, + ct2.Y()/eofs.Y()*ct2.hf_ + - ct1.Y()/eofs.Y()*ct1.hf_, ct1.Tref_, - ct2.Y()/eofs.Y()*ct2.Esref_ - - ct1.Y()/eofs.Y()*ct1.Esref_ + ct2.Y()/eofs.Y()*ct2.esRef_ + - ct1.Y()/eofs.Y()*ct1.esRef_ ); } diff --git a/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermo.C b/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermo.C index 41768068f1..5433816f7a 100644 --- a/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermo.C +++ b/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermo.C @@ -36,8 +36,18 @@ Foam::eIcoTabulatedThermo::eIcoTabulatedThermo ) : EquationOfState(name, dict), - Hf_(dict.subDict("thermodynamics").lookup("Hf")), - Sf_(dict.subDict("thermodynamics").lookup("Sf")), + hf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"hf", "Hf"}) + ), + sf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"sf", "Sf"}) + ), Cv_("Cv", dict.subDict("thermodynamics").subDict("Cv")) {} @@ -53,8 +63,8 @@ void Foam::eIcoTabulatedThermo::write EquationOfState::write(os); dictionary dict("thermodynamics"); - dict.add("Hf", Hf_); - dict.add("Sf", Sf_); + dict.add("hf", hf_); + dict.add("sf", sf_); dict.add("Cv", Cv_.values()); os << indent << dict.dictName() << dict; } diff --git a/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermo.H b/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermo.H index 762c05bccb..58c1e1b476 100644 --- a/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermo.H +++ b/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermo.H @@ -31,8 +31,8 @@ Description Usage \table Property | Description - Hf | Heat of formation - Sf | Standard entropy + hf | Heat of formation + sf | Standard entropy Cv | Specific heat at constant volume vs temperature table \endtable @@ -40,8 +40,8 @@ Usage \verbatim thermodynamics { - Hf 0; - Sf 0; + hf 0; + sf 0; Cv { values @@ -104,10 +104,10 @@ class eIcoTabulatedThermo // Private Data //- Heat of formation - scalar Hf_; + scalar hf_; //- Standard entropy - scalar Sf_; + scalar sf_; //- Specific heat at constant volume table [J/kg/K] integratedNonUniformTable Cv_; @@ -142,19 +142,19 @@ public: inline scalar Cv(const scalar p, const scalar T) const; //- Sensible internal energy [J/kg] - inline scalar Es(const scalar p, const scalar T) const; + inline scalar es(const scalar p, const scalar T) const; //- Absolute internal energy [J/kg] - inline scalar Ea(const scalar p, const scalar T) const; + inline scalar ea(const scalar p, const scalar T) const; //- Enthalpy of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Entropy [J/kg/K] - inline scalar S(const scalar p, const scalar T) const; + inline scalar s(const scalar p, const scalar T) const; //- Gibbs free energy of the mixture in the standard state [J/kg] - inline scalar Gstd(const scalar T) const; + inline scalar gStd(const scalar T) const; #include "EtoHthermo.H" diff --git a/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermoI.H b/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermoI.H index 9ac89199bf..0c41e08582 100644 --- a/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermoI.H +++ b/src/thermophysicalModels/specie/thermo/eIcoTabulated/eIcoTabulatedThermoI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2020 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2020-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -35,8 +35,8 @@ inline Foam::eIcoTabulatedThermo::eIcoTabulatedThermo ) : EquationOfState(name, pt), - Hf_(pt.Hf_), - Sf_(pt.Sf_), + hf_(pt.hf_), + sf_(pt.sf_), Cv_(pt.Cv_) {} @@ -65,37 +65,37 @@ inline Foam::scalar Foam::eIcoTabulatedThermo::Cv template -inline Foam::scalar Foam::eIcoTabulatedThermo::Es +inline Foam::scalar Foam::eIcoTabulatedThermo::es ( const scalar p, const scalar T ) const { - return Cv_.intfdT(T) + EquationOfState::E(p, T); + return Cv_.intfdT(T) + EquationOfState::e(p, T); } template -inline Foam::scalar Foam::eIcoTabulatedThermo::Ea +inline Foam::scalar Foam::eIcoTabulatedThermo::ea ( const scalar p, const scalar T ) const { - return Es(p, T) + Hf_; + return es(p, T) + hf_; } template -inline Foam::scalar Foam::eIcoTabulatedThermo::Hf() +inline Foam::scalar Foam::eIcoTabulatedThermo::hf() const { - return Hf_; + return hf_; } template -inline Foam::scalar Foam::eIcoTabulatedThermo::S +inline Foam::scalar Foam::eIcoTabulatedThermo::s ( const scalar p, const scalar T @@ -107,7 +107,7 @@ inline Foam::scalar Foam::eIcoTabulatedThermo::S template -inline Foam::scalar Foam::eIcoTabulatedThermo::Gstd +inline Foam::scalar Foam::eIcoTabulatedThermo::gStd ( const scalar T ) const diff --git a/src/thermophysicalModels/specie/thermo/ePolynomial/ePolynomialThermo.C b/src/thermophysicalModels/specie/thermo/ePolynomial/ePolynomialThermo.C index 359faca30b..d97b66e1f7 100644 --- a/src/thermophysicalModels/specie/thermo/ePolynomial/ePolynomialThermo.C +++ b/src/thermophysicalModels/specie/thermo/ePolynomial/ePolynomialThermo.C @@ -36,8 +36,18 @@ Foam::ePolynomialThermo::ePolynomialThermo ) : EquationOfState(name, dict), - Hf_(dict.subDict("thermodynamics").lookup("Hf")), - Sf_(dict.subDict("thermodynamics").lookup("Sf")), + hf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"hf", "Hf"}) + ), + sf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"sf", "Sf"}) + ), CvCoeffs_ ( dict.subDict("thermodynamics").lookup @@ -70,8 +80,8 @@ void Foam::ePolynomialThermo::write EquationOfState::write(os); dictionary dict("thermodynamics"); - dict.add("Hf", Hf_); - dict.add("Sf", Sf_); + dict.add("hf", hf_); + dict.add("sf", sf_); dict.add ( word("CvCoeffs<" + Foam::name(PolySize) + '>'), diff --git a/src/thermophysicalModels/specie/thermo/ePolynomial/ePolynomialThermo.H b/src/thermophysicalModels/specie/thermo/ePolynomial/ePolynomialThermo.H index da18d3b9e1..2acde8273f 100644 --- a/src/thermophysicalModels/specie/thermo/ePolynomial/ePolynomialThermo.H +++ b/src/thermophysicalModels/specie/thermo/ePolynomial/ePolynomialThermo.H @@ -41,8 +41,8 @@ Description Usage \table Property | Description - Hf | Heat of formation - Sf | Standard entropy + hf | Heat of formation + sf | Standard entropy CvCoeffs<8> | Specific heat at constant volume polynomial coeffs \endtable @@ -50,8 +50,8 @@ Usage \verbatim thermodynamics { - Hf 0; - Sf 0; + hf 0; + sf 0; CvCoeffs<8> (1000 -0.05 0.003 0 0 0 0 0); } \endverbatim @@ -126,10 +126,10 @@ class ePolynomialThermo // Private Data //- Heat of formation - scalar Hf_; + scalar hf_; //- Standard entropy - scalar Sf_; + scalar sf_; //- Specific heat at constant volume polynomial coeffs [J/kg/K/K^i] Polynomial CvCoeffs_; @@ -149,8 +149,8 @@ class ePolynomialThermo inline ePolynomialThermo ( const EquationOfState& pt, - const scalar Hf, - const scalar Sf, + const scalar hf, + const scalar sf, const Polynomial& CvCoeffs, const typename Polynomial::intPolyType& eCoeffs, const Polynomial& sCoeffs @@ -186,19 +186,19 @@ public: inline scalar Cv(const scalar p, const scalar T) const; //- Sensible internal energy [J/kg] - inline scalar Es(const scalar p, const scalar T) const; + inline scalar es(const scalar p, const scalar T) const; //- Absolute internal energy [J/kg] - inline scalar Ea(const scalar p, const scalar T) const; + inline scalar ea(const scalar p, const scalar T) const; //- Enthalpy of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Entropy [J/kg/K] - inline scalar S(const scalar p, const scalar T) const; + inline scalar s(const scalar p, const scalar T) const; //- Gibbs free energy of the mixture in the standard state [J/kg] - inline scalar Gstd(const scalar T) const; + inline scalar gStd(const scalar T) const; #include "EtoHthermo.H" diff --git a/src/thermophysicalModels/specie/thermo/ePolynomial/ePolynomialThermoI.H b/src/thermophysicalModels/specie/thermo/ePolynomial/ePolynomialThermoI.H index f2259641fb..b9844d1f39 100644 --- a/src/thermophysicalModels/specie/thermo/ePolynomial/ePolynomialThermoI.H +++ b/src/thermophysicalModels/specie/thermo/ePolynomial/ePolynomialThermoI.H @@ -31,16 +31,16 @@ template inline Foam::ePolynomialThermo::ePolynomialThermo ( const EquationOfState& pt, - const scalar Hf, - const scalar Sf, + const scalar hf, + const scalar sf, const Polynomial& CvCoeffs, const typename Polynomial::intPolyType& eCoeffs, const Polynomial& sCoeffs ) : EquationOfState(pt), - Hf_(Hf), - Sf_(Sf), + hf_(hf), + sf_(sf), CvCoeffs_(CvCoeffs), eCoeffs_(eCoeffs), sCoeffs_(sCoeffs) @@ -55,8 +55,8 @@ inline Foam::ePolynomialThermo::ePolynomialThermo ) : EquationOfState(name, pt), - Hf_(pt.Hf_), - Sf_(pt.Sf_), + hf_(pt.hf_), + sf_(pt.sf_), CvCoeffs_(pt.CvCoeffs_), eCoeffs_(pt.eCoeffs_), sCoeffs_(pt.sCoeffs_) @@ -87,55 +87,55 @@ inline Foam::scalar Foam::ePolynomialThermo::Cv template -inline Foam::scalar Foam::ePolynomialThermo::Es +inline Foam::scalar Foam::ePolynomialThermo::es ( const scalar p, const scalar T ) const { - return eCoeffs_.value(T) + EquationOfState::E(p, T); + return eCoeffs_.value(T) + EquationOfState::e(p, T); } template -inline Foam::scalar Foam::ePolynomialThermo::Ea +inline Foam::scalar Foam::ePolynomialThermo::ea ( const scalar p, const scalar T ) const { - return Es(p, T) + Hf(); + return es(p, T) + hf(); } template -inline Foam::scalar Foam::ePolynomialThermo::Hf() +inline Foam::scalar Foam::ePolynomialThermo::hf() const { - return Hf_; + return hf_; } template -inline Foam::scalar Foam::ePolynomialThermo::S +inline Foam::scalar Foam::ePolynomialThermo::s ( const scalar p, const scalar T ) const { - return sCoeffs_.value(T) + EquationOfState::Sv(p, T); + return sCoeffs_.value(T) + EquationOfState::sv(p, T); } template -inline Foam::scalar Foam::ePolynomialThermo::Gstd +inline Foam::scalar Foam::ePolynomialThermo::gStd ( const scalar T ) const { return - eCoeffs_.value(T) + Hf() + Pstd/EquationOfState::rho(Pstd, T) - - S(Pstd, T)*T; + eCoeffs_.value(T) + hf() + Pstd/EquationOfState::rho(Pstd, T) + - s(Pstd, T)*T; } @@ -168,8 +168,8 @@ inline void Foam::ePolynomialThermo::operator+= Y1 /= this->Y(); const scalar Y2 = pt.Y()/this->Y(); - Hf_ = Y1*Hf_ + Y2*pt.Hf_; - Sf_ = Y1*Sf_ + Y2*pt.Sf_; + hf_ = Y1*hf_ + Y2*pt.hf_; + sf_ = Y1*sf_ + Y2*pt.sf_; CvCoeffs_ = Y1*CvCoeffs_ + Y2*pt.CvCoeffs_; eCoeffs_ = Y1*eCoeffs_ + Y2*pt.eCoeffs_; sCoeffs_ = Y1*sCoeffs_ + Y2*pt.sCoeffs_; @@ -204,8 +204,8 @@ inline Foam::ePolynomialThermo Foam::operator+ return ePolynomialThermo ( eofs, - pt1.Hf_, - pt1.Sf_, + pt1.hf_, + pt1.sf_, pt1.CvCoeffs_, pt1.eCoeffs_, pt1.sCoeffs_ @@ -218,8 +218,8 @@ inline Foam::ePolynomialThermo Foam::operator+ return ePolynomialThermo ( eofs, - Y1*pt1.Hf_ + Y2*pt2.Hf_, - Y1*pt1.Sf_ + Y2*pt2.Sf_, + Y1*pt1.hf_ + Y2*pt2.hf_, + Y1*pt1.sf_ + Y2*pt2.sf_, Y1*pt1.CvCoeffs_ + Y2*pt2.CvCoeffs_, Y1*pt1.eCoeffs_ + Y2*pt2.eCoeffs_, Y1*pt1.sCoeffs_ + Y2*pt2.sCoeffs_ @@ -238,8 +238,8 @@ inline Foam::ePolynomialThermo Foam::operator* return ePolynomialThermo ( s*static_cast(pt), - pt.Hf_, - pt.Sf_, + pt.hf_, + pt.sf_, pt.CvCoeffs_, pt.eCoeffs_, pt.sCoeffs_ @@ -266,8 +266,8 @@ inline Foam::ePolynomialThermo Foam::operator== return ePolynomialThermo ( eofs, - Y2*pt2.Hf_ - Y1*pt1.Hf_, - Y2*pt2.Sf_ - Y1*pt1.Sf_, + Y2*pt2.hf_ - Y1*pt1.hf_, + Y2*pt2.sf_ - Y1*pt1.sf_, Y2*pt2.CvCoeffs_ - Y1*pt1.CvCoeffs_, Y2*pt2.eCoeffs_ - Y1*pt1.eCoeffs_, Y2*pt2.sCoeffs_ - Y1*pt1.sCoeffs_ diff --git a/src/thermophysicalModels/specie/thermo/ePower/ePowerThermo.C b/src/thermophysicalModels/specie/thermo/ePower/ePowerThermo.C index 75be11439e..018b222486 100644 --- a/src/thermophysicalModels/specie/thermo/ePower/ePowerThermo.C +++ b/src/thermophysicalModels/specie/thermo/ePower/ePowerThermo.C @@ -39,7 +39,12 @@ Foam::ePowerThermo::ePowerThermo c0_(dict.subDict("thermodynamics").lookup("C0")), n0_(dict.subDict("thermodynamics").lookup("n0")), Tref_(dict.subDict("thermodynamics").lookup("Tref")), - Hf_(dict.subDict("thermodynamics").lookup("Hf")) + hf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"hf", "Hf"}) + ) {} diff --git a/src/thermophysicalModels/specie/thermo/ePower/ePowerThermo.H b/src/thermophysicalModels/specie/thermo/ePower/ePowerThermo.H index f9c72d0c98..95819cd87e 100644 --- a/src/thermophysicalModels/specie/thermo/ePower/ePowerThermo.H +++ b/src/thermophysicalModels/specie/thermo/ePower/ePowerThermo.H @@ -39,7 +39,7 @@ Usage c0 | Reference heat capacity at constant volume [J/kg/K] n0 | Exponent of the power function Tref | Reference temperature [K] - Hf | Heat of formation [J/kg] + hf | Heat of formation [J/kg] \endtable Example specification of ePowerThermo: @@ -49,7 +49,7 @@ Usage c0 230; Tref 470; n0 3; - Hf 0; + hf 0; } \endverbatim @@ -118,7 +118,7 @@ class ePowerThermo scalar c0_; scalar n0_; scalar Tref_; - scalar Hf_; + scalar hf_; // Private Member Functions @@ -138,7 +138,7 @@ public: const scalar c0, const scalar n0, const scalar Tref, - const scalar Hf + const scalar hf ); //- Construct from name and dictionary @@ -173,19 +173,19 @@ public: inline scalar Cv(const scalar p, const scalar T) const; //- Sensible internal energy [J/kg] - inline scalar Es(const scalar p, const scalar T) const; + inline scalar es(const scalar p, const scalar T) const; //- Absolute internal energy [J/kg] - inline scalar Ea(const scalar p, const scalar T) const; + inline scalar ea(const scalar p, const scalar T) const; //- Enthalpy of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Entropy [J/kg/K] - inline scalar S(const scalar p, const scalar T) const; + inline scalar s(const scalar p, const scalar T) const; //- Gibbs free energy of the mixture in the standard state [J/kg] - inline scalar Gstd(const scalar T) const; + inline scalar gStd(const scalar T) const; #include "EtoHthermo.H" diff --git a/src/thermophysicalModels/specie/thermo/ePower/ePowerThermoI.H b/src/thermophysicalModels/specie/thermo/ePower/ePowerThermoI.H index 1b56a2eb1a..1aba1a2d2a 100644 --- a/src/thermophysicalModels/specie/thermo/ePower/ePowerThermoI.H +++ b/src/thermophysicalModels/specie/thermo/ePower/ePowerThermoI.H @@ -53,14 +53,14 @@ inline Foam::ePowerThermo::ePowerThermo const scalar c0, const scalar n0, const scalar Tref, - const scalar Hf + const scalar hf ) : EquationOfState(st), c0_(c0), n0_(n0), Tref_(Tref), - Hf_(Hf) + hf_(hf) {} @@ -75,7 +75,7 @@ inline Foam::ePowerThermo::ePowerThermo c0_(jt.c0_), n0_(jt.n0_), Tref_(jt.Tref_), - Hf_(jt.Hf_) + hf_(jt.hf_) {} @@ -114,7 +114,7 @@ inline Foam::scalar Foam::ePowerThermo::Cv template -inline Foam::scalar Foam::ePowerThermo::Es +inline Foam::scalar Foam::ePowerThermo::es ( const scalar p, const scalar T @@ -122,30 +122,30 @@ inline Foam::scalar Foam::ePowerThermo::Es { return c0_*(pow(T, n0_ + 1) - pow(Tstd, n0_ + 1))/(pow(Tref_, n0_)*(n0_ + 1)) - + EquationOfState::E(p, T); + + EquationOfState::e(p, T); } template -inline Foam::scalar Foam::ePowerThermo::Ea +inline Foam::scalar Foam::ePowerThermo::ea ( const scalar p, const scalar T ) const { - return Es(p, T) + Hf(); + return es(p, T) + hf(); } template -inline Foam::scalar Foam::ePowerThermo::Hf() const +inline Foam::scalar Foam::ePowerThermo::hf() const { - return Hf_; + return hf_; } template -inline Foam::scalar Foam::ePowerThermo::S +inline Foam::scalar Foam::ePowerThermo::s ( const scalar p, const scalar T @@ -153,20 +153,20 @@ inline Foam::scalar Foam::ePowerThermo::S { return c0_*(pow(T, n0_) - pow(Tstd, n0_))/(pow(Tref_, n0_)*n0_) - + EquationOfState::Sv(p, T); + + EquationOfState::sv(p, T); } template -inline Foam::scalar Foam::ePowerThermo::Gstd +inline Foam::scalar Foam::ePowerThermo::gStd ( const scalar T ) const { return c0_*(pow(T, n0_ + 1) - pow(Tstd, n0_ + 1))/(pow(Tref_, n0_)*(n0_ + 1)) - + Hf() + Pstd/EquationOfState::rho(Pstd, T) - - S(Pstd, T)*T; + + hf() + Pstd/EquationOfState::rho(Pstd, T) + - s(Pstd, T)*T; } @@ -199,7 +199,7 @@ inline void Foam::ePowerThermo::operator+= Y1 /= this->Y(); const scalar Y2 = ct.Y()/this->Y(); - Hf_ = Y1*Hf_ + Y2*ct.Hf_; + hf_ = Y1*hf_ + Y2*ct.hf_; c0_ = Y1*c0_ + Y2*ct.c0_; n0_ = Y1*n0_ + Y2*ct.n0_; Tref_ = Y1*Tref_ + Y2*ct.Tref_; @@ -230,7 +230,7 @@ inline Foam::ePowerThermo Foam::operator+ ct1.c0_, ct1.n0_, ct1.Tref_, - ct1.Hf_ + ct1.hf_ ); } else @@ -244,8 +244,8 @@ inline Foam::ePowerThermo Foam::operator+ + ct2.Y()/eofs.Y()*ct2.n0_, ct1.Y()/eofs.Y()*ct1.Tref_ + ct2.Y()/eofs.Y()*ct2.Tref_, - ct1.Y()/eofs.Y()*ct1.Hf_ - + ct2.Y()/eofs.Y()*ct2.Hf_ + ct1.Y()/eofs.Y()*ct1.hf_ + + ct2.Y()/eofs.Y()*ct2.hf_ ); } } @@ -264,7 +264,7 @@ inline Foam::ePowerThermo Foam::operator* ct.c0_, ct.n0_, ct.Tref_, - ct.Hf_ + ct.hf_ ); } @@ -291,8 +291,8 @@ inline Foam::ePowerThermo Foam::operator== - ct1.Y()/eofs.Y()*ct1.n0_, ct2.Y()/eofs.Y()*ct2.Tref_ - ct1.Y()/eofs.Y()*ct1.Tref_, - ct2.Y()/eofs.Y()*ct2.Hf_ - - ct1.Y()/eofs.Y()*ct1.Hf_ + ct2.Y()/eofs.Y()*ct2.hf_ + - ct1.Y()/eofs.Y()*ct1.hf_ ); } diff --git a/src/thermophysicalModels/specie/thermo/eTabulated/eTabulatedThermo.C b/src/thermophysicalModels/specie/thermo/eTabulated/eTabulatedThermo.C index cb9f232e6b..0ab2cbccf2 100644 --- a/src/thermophysicalModels/specie/thermo/eTabulated/eTabulatedThermo.C +++ b/src/thermophysicalModels/specie/thermo/eTabulated/eTabulatedThermo.C @@ -36,9 +36,25 @@ Foam::eTabulatedThermo::eTabulatedThermo ) : EquationOfState(name, dict), - Hf_(dict.subDict("thermodynamics").lookup("Hf")), - Sf_(dict.subDict("thermodynamics").lookup("Sf")), - Es_("Es", dict.subDict("thermodynamics").subDict("Es")), + hf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"hf", "Hf"}) + ), + sf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"sf", "Sf"}) + ), + es_ + ( + "es", + dict + .subDict("thermodynamics") + .subDictBackwardsCompatible({"es", "Es"}) + ), Cp_("Cp", dict.subDict("thermodynamics").subDict("Cp")), Cv_("Cv", dict.subDict("thermodynamics").subDict("Cv")) {} @@ -55,12 +71,12 @@ void Foam::eTabulatedThermo::write EquationOfState::write(os); dictionary dict("thermodynamics"); - dict.add("Hf", Hf_); - dict.add("Sf", Sf_); + dict.add("hf", hf_); + dict.add("sf", sf_); - dictionary EsDict("Es"); - EsDict.add("values", Es_.values()); - dict.add("Es", EsDict); + dictionary esDict("es"); + esDict.add("values", es_.values()); + dict.add("es", esDict); dictionary CpDict("Cp"); CpDict.add("values", Cp_.values()); diff --git a/src/thermophysicalModels/specie/thermo/eTabulated/eTabulatedThermo.H b/src/thermophysicalModels/specie/thermo/eTabulated/eTabulatedThermo.H index cc0f0c41f0..fcc6d4b608 100644 --- a/src/thermophysicalModels/specie/thermo/eTabulated/eTabulatedThermo.H +++ b/src/thermophysicalModels/specie/thermo/eTabulated/eTabulatedThermo.H @@ -32,9 +32,9 @@ Usage \table Property | Description - Hf | Heat of formation - Sf | Standard entropy - Es | Sensible internal energy vs pressure and temperature table + hf | Heat of formation + sf | Standard entropy + es | Sensible internal energy vs pressure and temperature table Cv | Specific heat capacity vs pressure and temperature table \endtable @@ -42,10 +42,10 @@ Usage \verbatim thermodynamics { - Hf 0; - Sf 0; + hf 0; + sf 0; - Es + es { pLow 1e4; pHigh 5e5; @@ -135,13 +135,13 @@ class eTabulatedThermo // Private Data //- Heat of formation - scalar Hf_; + scalar hf_; //- Standard entropy - scalar Sf_; + scalar sf_; //- Sensible internal energy table [J/kg] - table2D Es_; + table2D es_; //- Specific heat at constant pressure table [J/kg/K] table2D Cp_; @@ -182,25 +182,25 @@ public: inline scalar Cv(const scalar p, const scalar T) const; //- Sensible internal energy [J/kg] - inline scalar Es(const scalar p, const scalar T) const; + inline scalar es(const scalar p, const scalar T) const; //- Absolute internal energy [J/kg] - inline scalar Ea(const scalar p, const scalar T) const; + inline scalar ea(const scalar p, const scalar T) const; //- Sensible enthalpy [J/kg] - inline scalar Hs(const scalar p, const scalar T) const; + inline scalar hs(const scalar p, const scalar T) const; //- Absolute enthalpy [J/kg] - inline scalar Ha(const scalar p, const scalar T) const; + inline scalar ha(const scalar p, const scalar T) const; //- Enthalpy of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Entropy [J/kg/K] - inline scalar S(const scalar p, const scalar T) const; + inline scalar s(const scalar p, const scalar T) const; //- Gibbs free energy of the mixture in the standard state [J/kg] - inline scalar Gstd(const scalar T) const; + inline scalar gStd(const scalar T) const; // Derivative term used for Jacobian diff --git a/src/thermophysicalModels/specie/thermo/eTabulated/eTabulatedThermoI.H b/src/thermophysicalModels/specie/thermo/eTabulated/eTabulatedThermoI.H index e5808ec7bb..2b4f6958d9 100644 --- a/src/thermophysicalModels/specie/thermo/eTabulated/eTabulatedThermoI.H +++ b/src/thermophysicalModels/specie/thermo/eTabulated/eTabulatedThermoI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2020 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2020-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -35,9 +35,9 @@ inline Foam::eTabulatedThermo::eTabulatedThermo ) : EquationOfState(name, pt), - Hf_(pt.Hf_), - Sf_(pt.Sf_), - Es_(pt.Es_), + hf_(pt.hf_), + sf_(pt.sf_), + es_(pt.es_), Cp_(pt.Cp_), Cv_(pt.Cv_) {} @@ -78,59 +78,59 @@ inline Foam::scalar Foam::eTabulatedThermo::Cv template -inline Foam::scalar Foam::eTabulatedThermo::Es +inline Foam::scalar Foam::eTabulatedThermo::es ( const scalar p, const scalar T ) const { - return Es_.value(p, T); + return es_.value(p, T); } template -inline Foam::scalar Foam::eTabulatedThermo::Ea +inline Foam::scalar Foam::eTabulatedThermo::ea ( const scalar p, const scalar T ) const { - return Es(p, T) + Hf_; + return es(p, T) + hf_; } template -inline Foam::scalar Foam::eTabulatedThermo::Hs +inline Foam::scalar Foam::eTabulatedThermo::hs ( const scalar p, const scalar T ) const { - return Es(p, T) + p/EquationOfState::rho(p, T); + return es(p, T) + p/EquationOfState::rho(p, T); } template -inline Foam::scalar Foam::eTabulatedThermo::Ha +inline Foam::scalar Foam::eTabulatedThermo::ha ( const scalar p, const scalar T ) const { - return Ea(p, T) + p/EquationOfState::rho(p, T); + return ea(p, T) + p/EquationOfState::rho(p, T); } template -inline Foam::scalar Foam::eTabulatedThermo::Hf() +inline Foam::scalar Foam::eTabulatedThermo::hf() const { - return Hf_; + return hf_; } template -inline Foam::scalar Foam::eTabulatedThermo::S +inline Foam::scalar Foam::eTabulatedThermo::s ( const scalar p, const scalar T @@ -142,7 +142,7 @@ inline Foam::scalar Foam::eTabulatedThermo::S template -inline Foam::scalar Foam::eTabulatedThermo::Gstd +inline Foam::scalar Foam::eTabulatedThermo::gStd ( const scalar T ) const diff --git a/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.C b/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.C index 7d0caa5fee..d3abbca58d 100644 --- a/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.C +++ b/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.C @@ -37,9 +37,19 @@ Foam::hConstThermo::hConstThermo : EquationOfState(name, dict), Cp_(dict.subDict("thermodynamics").lookup("Cp")), - Hf_(dict.subDict("thermodynamics").lookup("Hf")), + hf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"hf", "Hf"}) + ), Tref_(dict.subDict("thermodynamics").lookupOrDefault("Tref", Tstd)), - Hsref_(dict.subDict("thermodynamics").lookupOrDefault("Hsref", 0)) + hsRef_ + ( + dict + .subDict("thermodynamics") + .lookupOrDefaultBackwardsCompatible({"hsRef", "Hsref"}, 0) + ) {} @@ -52,14 +62,14 @@ void Foam::hConstThermo::write(Ostream& os) const dictionary dict("thermodynamics"); dict.add("Cp", Cp_); - dict.add("Hf", Hf_); + dict.add("hf", hf_); if (Tref_ != Tstd) { dict.add("Tref", Tref_); } - if (Hsref_ != 0) + if (hsRef_ != 0) { - dict.add("Hsref", Hsref_); + dict.add("hsRef", hsRef_); } os << indent << dict.dictName() << dict; } diff --git a/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.H b/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.H index 8c5e4eef66..e5f64ac57e 100644 --- a/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.H +++ b/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.H @@ -29,7 +29,7 @@ Description at constant pressure: \verbatim - h = Cp*(T - Tref) + Hsref + h = Cp*(T - Tref) + hsRef \endverbatim Usage @@ -37,8 +37,8 @@ Usage Property | Description Cp | Constant Heat capacity at constant pressure [J/kg/K] Tref | Reference temperature [K] (defaults to Tstd) - Hsref | Reference sensible enthalpy [J/kg] (defaults to 0) - Hf | Heat of formation [J/kg] + hsRef | Reference sensible enthalpy [J/kg] (defaults to 0) + hf | Heat of formation [J/kg] \endtable Example specification of hConstThermo for air: @@ -46,7 +46,7 @@ Usage thermodynamics { Cp 1007; - Hf 0; + hf 0; } \endverbatim @@ -112,13 +112,13 @@ class hConstThermo scalar Cp_; //- Heat of formation [J/kg] - scalar Hf_; + scalar hf_; //- Reference temperature around which to linearise [K] scalar Tref_; //- Reference sensible enthalpy around which to linearise [J/kg] - scalar Hsref_; + scalar hsRef_; public: @@ -130,9 +130,9 @@ public: ( const EquationOfState& st, const scalar Cp, - const scalar Hf, + const scalar hf, const scalar Tref, - const scalar Hsref + const scalar hsRef ); //- Construct from name and dictionary @@ -163,19 +163,19 @@ public: inline scalar Cp(const scalar p, const scalar T) const; //- Absolute enthalpy [J/kg] - inline scalar Ha(const scalar p, const scalar T) const; + inline scalar ha(const scalar p, const scalar T) const; //- Sensible enthalpy [J/kg] - inline scalar Hs(const scalar p, const scalar T) const; + inline scalar hs(const scalar p, const scalar T) const; //- Enthalpy of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Entropy [J/kg/K] - inline scalar S(const scalar p, const scalar T) const; + inline scalar s(const scalar p, const scalar T) const; //- Gibbs free energy of the mixture in the standard state [J/kg] - inline scalar Gstd(const scalar T) const; + inline scalar gStd(const scalar T) const; #include "HtoEthermo.H" diff --git a/src/thermophysicalModels/specie/thermo/hConst/hConstThermoI.H b/src/thermophysicalModels/specie/thermo/hConst/hConstThermoI.H index 1a8dde2c52..a635b5f109 100644 --- a/src/thermophysicalModels/specie/thermo/hConst/hConstThermoI.H +++ b/src/thermophysicalModels/specie/thermo/hConst/hConstThermoI.H @@ -30,16 +30,16 @@ inline Foam::hConstThermo::hConstThermo ( const EquationOfState& st, const scalar Cp, - const scalar Hf, + const scalar hf, const scalar Tref, const scalar Href ) : EquationOfState(st), Cp_(Cp), - Hf_(Hf), + hf_(hf), Tref_(Tref), - Hsref_(Href) + hsRef_(Href) {} @@ -52,9 +52,9 @@ inline Foam::hConstThermo::hConstThermo : EquationOfState(name, ct), Cp_(ct.Cp_), - Hf_(ct.Hf_), + hf_(ct.hf_), Tref_(ct.Tref_), - Hsref_(ct.Hsref_) + hsRef_(ct.hsRef_) {} @@ -93,52 +93,52 @@ inline Foam::scalar Foam::hConstThermo::Cp template -inline Foam::scalar Foam::hConstThermo::Hs +inline Foam::scalar Foam::hConstThermo::hs ( const scalar p, const scalar T ) const { - return Cp_*(T - Tref_) + Hsref_ + EquationOfState::H(p, T); + return Cp_*(T - Tref_) + hsRef_ + EquationOfState::h(p, T); } template -inline Foam::scalar Foam::hConstThermo::Ha +inline Foam::scalar Foam::hConstThermo::ha ( const scalar p, const scalar T ) const { - return Hs(p, T) + Hf(); + return hs(p, T) + hf(); } template -inline Foam::scalar Foam::hConstThermo::Hf() const +inline Foam::scalar Foam::hConstThermo::hf() const { - return Hf_; + return hf_; } template -inline Foam::scalar Foam::hConstThermo::S +inline Foam::scalar Foam::hConstThermo::s ( const scalar p, const scalar T ) const { - return Cp_*log(T/Tstd) + EquationOfState::Sp(p, T); + return Cp_*log(T/Tstd) + EquationOfState::sp(p, T); } template -inline Foam::scalar Foam::hConstThermo::Gstd +inline Foam::scalar Foam::hConstThermo::gStd ( const scalar T ) const { - return Cp_*(T - Tref_) + Hsref_ + Hf() - Cp_*T*log(T/Tstd); + return Cp_*(T - Tref_) + hsRef_ + hf() - Cp_*T*log(T/Tstd); } @@ -185,8 +185,8 @@ inline void Foam::hConstThermo::operator+= const scalar Y2 = ct.Y()/this->Y(); Cp_ = Y1*Cp_ + Y2*ct.Cp_; - Hf_ = Y1*Hf_ + Y2*ct.Hf_; - Hsref_ = Y1*Hsref_ + Y2*ct.Hsref_; + hf_ = Y1*hf_ + Y2*ct.hf_; + hsRef_ = Y1*hsRef_ + Y2*ct.hsRef_; } } @@ -212,9 +212,9 @@ inline Foam::hConstThermo Foam::operator+ ( eofs, ct1.Cp_, - ct1.Hf_, + ct1.hf_, ct1.Tref_, - ct1.Hsref_ + ct1.hsRef_ ); } else @@ -238,11 +238,11 @@ inline Foam::hConstThermo Foam::operator+ eofs, ct1.Y()/eofs.Y()*ct1.Cp_ + ct2.Y()/eofs.Y()*ct2.Cp_, - ct1.Y()/eofs.Y()*ct1.Hf_ - + ct2.Y()/eofs.Y()*ct2.Hf_, + ct1.Y()/eofs.Y()*ct1.hf_ + + ct2.Y()/eofs.Y()*ct2.hf_, ct1.Tref_, - ct1.Y()/eofs.Y()*ct1.Hsref_ - + ct2.Y()/eofs.Y()*ct2.Hsref_ + ct1.Y()/eofs.Y()*ct1.hsRef_ + + ct2.Y()/eofs.Y()*ct2.hsRef_ ); } } @@ -259,9 +259,9 @@ inline Foam::hConstThermo Foam::operator* ( s*static_cast(ct), ct.Cp_, - ct.Hf_, + ct.hf_, ct.Tref_, - ct.Hsref_ + ct.hsRef_ ); } @@ -298,11 +298,11 @@ inline Foam::hConstThermo Foam::operator== eofs, ct2.Y()/eofs.Y()*ct2.Cp_ - ct1.Y()/eofs.Y()*ct1.Cp_, - ct2.Y()/eofs.Y()*ct2.Hf_ - - ct1.Y()/eofs.Y()*ct1.Hf_, + ct2.Y()/eofs.Y()*ct2.hf_ + - ct1.Y()/eofs.Y()*ct1.hf_, ct1.Tref_, - ct2.Y()/eofs.Y()*ct2.Hsref_ - - ct1.Y()/eofs.Y()*ct1.Hsref_ + ct2.Y()/eofs.Y()*ct2.hsRef_ + - ct1.Y()/eofs.Y()*ct1.hsRef_ ); } diff --git a/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermo.C b/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermo.C index e0a748c336..6563c518b4 100644 --- a/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermo.C +++ b/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermo.C @@ -36,8 +36,18 @@ Foam::hIcoTabulatedThermo::hIcoTabulatedThermo ) : EquationOfState(name, dict), - Hf_(dict.subDict("thermodynamics").lookup("Hf")), - Sf_(dict.subDict("thermodynamics").lookup("Sf")), + hf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"hf", "Hf"}) + ), + sf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"sf", "Sf"}) + ), Cp_("Cp", dict.subDict("thermodynamics").subDict("Cp")) {} @@ -53,8 +63,8 @@ void Foam::hIcoTabulatedThermo::write EquationOfState::write(os); dictionary dict("thermodynamics"); - dict.add("Hf", Hf_); - dict.add("Sf", Sf_); + dict.add("hf", hf_); + dict.add("sf", sf_); dict.add("Cp", Cp_.values()); os << indent << dict.dictName() << dict; } diff --git a/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermo.H b/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermo.H index 52a4abedca..a82e03a603 100644 --- a/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermo.H +++ b/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermo.H @@ -32,8 +32,8 @@ Usage \table Property | Description - Hf | Heat of formation - Sf | Standard entropy + hf | Heat of formation + sf | Standard entropy Cp | Specific heat at constant pressure vs temperature table \endtable @@ -41,8 +41,8 @@ Usage \verbatim thermodynamics { - Hf 0; - Sf 0; + hf 0; + sf 0; Cp { values @@ -105,10 +105,10 @@ class hIcoTabulatedThermo // Private Data //- Heat of formation - scalar Hf_; + scalar hf_; //- Standard entropy - scalar Sf_; + scalar sf_; //- Specific heat at constant pressure table [J/kg/K] integratedNonUniformTable Cp_; @@ -143,19 +143,19 @@ public: inline scalar Cp(const scalar p, const scalar T) const; //- Absolute enthalpy [J/kg] - inline scalar Ha(const scalar p, const scalar T) const; + inline scalar ha(const scalar p, const scalar T) const; //- Sensible enthalpy [J/kg] - inline scalar Hs(const scalar p, const scalar T) const; + inline scalar hs(const scalar p, const scalar T) const; //- Enthalpy of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Entropy [J/kg/K] - inline scalar S(const scalar p, const scalar T) const; + inline scalar s(const scalar p, const scalar T) const; //- Gibbs free energy of the mixture in the standard state [J/kg] - inline scalar Gstd(const scalar T) const; + inline scalar gStd(const scalar T) const; #include "HtoEthermo.H" diff --git a/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermoI.H b/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermoI.H index 27c3eba832..c1d239aed1 100644 --- a/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermoI.H +++ b/src/thermophysicalModels/specie/thermo/hIcoTabulated/hIcoTabulatedThermoI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2020 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2020-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -35,8 +35,8 @@ inline Foam::hIcoTabulatedThermo::hIcoTabulatedThermo ) : EquationOfState(name, pt), - Hf_(pt.Hf_), - Sf_(pt.Sf_), + hf_(pt.hf_), + sf_(pt.sf_), Cp_(pt.Cp_) {} @@ -65,53 +65,53 @@ inline Foam::scalar Foam::hIcoTabulatedThermo::Cp template -inline Foam::scalar Foam::hIcoTabulatedThermo::Hs +inline Foam::scalar Foam::hIcoTabulatedThermo::hs ( const scalar p, const scalar T ) const { - return Cp_.intfdT(T) + EquationOfState::H(p, T); + return Cp_.intfdT(T) + EquationOfState::h(p, T); } template -inline Foam::scalar Foam::hIcoTabulatedThermo::Ha +inline Foam::scalar Foam::hIcoTabulatedThermo::ha ( const scalar p, const scalar T ) const { - return Hs(p, T) + Hf_; + return hs(p, T) + hf_; } template -inline Foam::scalar Foam::hIcoTabulatedThermo::Hf() +inline Foam::scalar Foam::hIcoTabulatedThermo::hf() const { - return Hf_; + return hf_; } template -inline Foam::scalar Foam::hIcoTabulatedThermo::S +inline Foam::scalar Foam::hIcoTabulatedThermo::s ( const scalar p, const scalar T ) const { - return Cp_.intfByTdT(T) + EquationOfState::Sp(p, T) + Sf_; + return Cp_.intfByTdT(T) + EquationOfState::sp(p, T) + sf_; } template -inline Foam::scalar Foam::hIcoTabulatedThermo::Gstd +inline Foam::scalar Foam::hIcoTabulatedThermo::gStd ( const scalar T ) const { - return Cp_.intfdT(T) + Hf_ - (Cp_.intfByTdT(T) + Sf_)*T; + return Cp_.intfdT(T) + hf_ - (Cp_.intfByTdT(T) + sf_)*T; } diff --git a/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.C b/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.C index e91eca9e65..9e17f99b74 100644 --- a/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.C +++ b/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.C @@ -36,8 +36,18 @@ Foam::hPolynomialThermo::hPolynomialThermo ) : EquationOfState(name, dict), - Hf_(dict.subDict("thermodynamics").lookup("Hf")), - Sf_(dict.subDict("thermodynamics").lookup("Sf")), + hf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"hf", "Hf"}) + ), + sf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"sf", "Sf"}) + ), CpCoeffs_ ( dict.subDict("thermodynamics").lookup @@ -52,10 +62,10 @@ Foam::hPolynomialThermo::hPolynomialThermo sCoeffs_ = CpCoeffs_.integralMinus1(); // Offset h poly so that it is relative to the enthalpy at Tstd - hCoeffs_[0] += Hf_ - hCoeffs_.value(Tstd); + hCoeffs_[0] += hf_ - hCoeffs_.value(Tstd); // Offset s poly so that it is relative to the entropy at Tstd - sCoeffs_[0] += Sf_ - sCoeffs_.value(Tstd); + sCoeffs_[0] += sf_ - sCoeffs_.value(Tstd); } @@ -70,8 +80,8 @@ void Foam::hPolynomialThermo::write EquationOfState::write(os); dictionary dict("thermodynamics"); - dict.add("Hf", Hf_); - dict.add("Sf", Sf_); + dict.add("hf", hf_); + dict.add("sf", sf_); dict.add ( word("CpCoeffs<" + Foam::name(PolySize) + '>'), diff --git a/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.H b/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.H index 98e731265b..09c9daa450 100644 --- a/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.H +++ b/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.H @@ -39,8 +39,8 @@ Description Usage \table Property | Description - Hf | Heat of formation - Sf | Standard entropy + hf | Heat of formation + sf | Standard entropy CpCoeffs<8> | Specific heat at constant pressure polynomial coeffs \endtable @@ -48,8 +48,8 @@ Usage \verbatim thermodynamics { - Hf 0; - Sf 0; + hf 0; + sf 0; CpCoeffs<8> (1000 -0.05 0.003 0 0 0 0 0); } \endverbatim @@ -124,10 +124,10 @@ class hPolynomialThermo // Private Data //- Heat of formation - scalar Hf_; + scalar hf_; //- Standard entropy - scalar Sf_; + scalar sf_; //- Specific heat at constant pressure polynomial coeffs [J/kg/K/K^i] Polynomial CpCoeffs_; @@ -149,8 +149,8 @@ public: inline hPolynomialThermo ( const EquationOfState& pt, - const scalar Hf, - const scalar Sf, + const scalar hf, + const scalar sf, const Polynomial& CpCoeffs, const typename Polynomial::intPolyType& hCoeffs, const Polynomial& sCoeffs @@ -181,19 +181,19 @@ public: inline scalar Cp(const scalar p, const scalar T) const; //- Absolute enthalpy [J/kg] - inline scalar Ha(const scalar p, const scalar T) const; + inline scalar ha(const scalar p, const scalar T) const; //- Sensible enthalpy [J/kg] - inline scalar Hs(const scalar p, const scalar T) const; + inline scalar hs(const scalar p, const scalar T) const; //- Enthalpy of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Entropy [J/kg/K] - inline scalar S(const scalar p, const scalar T) const; + inline scalar s(const scalar p, const scalar T) const; //- Gibbs free energy of the mixture in the standard state [J/kg] - inline scalar Gstd(const scalar T) const; + inline scalar gStd(const scalar T) const; #include "HtoEthermo.H" diff --git a/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermoI.H b/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermoI.H index 72a22b4a7b..d0b991e016 100644 --- a/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermoI.H +++ b/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermoI.H @@ -31,16 +31,16 @@ template inline Foam::hPolynomialThermo::hPolynomialThermo ( const EquationOfState& pt, - const scalar Hf, - const scalar Sf, + const scalar hf, + const scalar sf, const Polynomial& CpCoeffs, const typename Polynomial::intPolyType& hCoeffs, const Polynomial& sCoeffs ) : EquationOfState(pt), - Hf_(Hf), - Sf_(Sf), + hf_(hf), + sf_(sf), CpCoeffs_(CpCoeffs), hCoeffs_(hCoeffs), sCoeffs_(sCoeffs) @@ -55,8 +55,8 @@ inline Foam::hPolynomialThermo::hPolynomialThermo ) : EquationOfState(name, pt), - Hf_(pt.Hf_), - Sf_(pt.Sf_), + hf_(pt.hf_), + sf_(pt.sf_), CpCoeffs_(pt.CpCoeffs_), hCoeffs_(pt.hCoeffs_), sCoeffs_(pt.sCoeffs_) @@ -87,48 +87,48 @@ inline Foam::scalar Foam::hPolynomialThermo::Cp template -inline Foam::scalar Foam::hPolynomialThermo::Hs +inline Foam::scalar Foam::hPolynomialThermo::hs ( const scalar p, const scalar T ) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } template -inline Foam::scalar Foam::hPolynomialThermo::Ha +inline Foam::scalar Foam::hPolynomialThermo::ha ( const scalar p, const scalar T ) const { - return hCoeffs_.value(T) + EquationOfState::H(p, T); + return hCoeffs_.value(T) + EquationOfState::h(p, T); } template -inline Foam::scalar Foam::hPolynomialThermo::Hf() +inline Foam::scalar Foam::hPolynomialThermo::hf() const { - return Hf_; + return hf_; } template -inline Foam::scalar Foam::hPolynomialThermo::S +inline Foam::scalar Foam::hPolynomialThermo::s ( const scalar p, const scalar T ) const { - return sCoeffs_.value(T) + EquationOfState::Sp(p, T); + return sCoeffs_.value(T) + EquationOfState::sp(p, T); } template -inline Foam::scalar Foam::hPolynomialThermo::Gstd +inline Foam::scalar Foam::hPolynomialThermo::gStd ( const scalar T ) const @@ -168,8 +168,8 @@ inline void Foam::hPolynomialThermo::operator+= Y1 /= this->Y(); const scalar Y2 = pt.Y()/this->Y(); - Hf_ = Y1*Hf_ + Y2*pt.Hf_; - Sf_ = Y1*Sf_ + Y2*pt.Sf_; + hf_ = Y1*hf_ + Y2*pt.hf_; + sf_ = Y1*sf_ + Y2*pt.sf_; CpCoeffs_ = Y1*CpCoeffs_ + Y2*pt.CpCoeffs_; hCoeffs_ = Y1*hCoeffs_ + Y2*pt.hCoeffs_; sCoeffs_ = Y1*sCoeffs_ + Y2*pt.sCoeffs_; @@ -204,8 +204,8 @@ inline Foam::hPolynomialThermo Foam::operator+ return hPolynomialThermo ( eofs, - pt1.Hf_, - pt1.Sf_, + pt1.hf_, + pt1.sf_, pt1.CpCoeffs_, pt1.hCoeffs_, pt1.sCoeffs_ @@ -218,8 +218,8 @@ inline Foam::hPolynomialThermo Foam::operator+ return hPolynomialThermo ( eofs, - Y1*pt1.Hf_ + Y2*pt2.Hf_, - Y1*pt1.Sf_ + Y2*pt2.Sf_, + Y1*pt1.hf_ + Y2*pt2.hf_, + Y1*pt1.sf_ + Y2*pt2.sf_, Y1*pt1.CpCoeffs_ + Y2*pt2.CpCoeffs_, Y1*pt1.hCoeffs_ + Y2*pt2.hCoeffs_, Y1*pt1.sCoeffs_ + Y2*pt2.sCoeffs_ @@ -238,8 +238,8 @@ inline Foam::hPolynomialThermo Foam::operator* return hPolynomialThermo ( s*static_cast(pt), - pt.Hf_, - pt.Sf_, + pt.hf_, + pt.sf_, pt.CpCoeffs_, pt.hCoeffs_, pt.sCoeffs_ @@ -266,8 +266,8 @@ inline Foam::hPolynomialThermo Foam::operator== return hPolynomialThermo ( eofs, - Y2*pt2.Hf_ - Y1*pt1.Hf_, - Y2*pt2.Sf_ - Y1*pt1.Sf_, + Y2*pt2.hf_ - Y1*pt1.hf_, + Y2*pt2.sf_ - Y1*pt1.sf_, Y2*pt2.CpCoeffs_ - Y1*pt1.CpCoeffs_, Y2*pt2.hCoeffs_ - Y1*pt1.hCoeffs_, Y2*pt2.sCoeffs_ - Y1*pt1.sCoeffs_ diff --git a/src/thermophysicalModels/specie/thermo/hPower/hPowerThermo.C b/src/thermophysicalModels/specie/thermo/hPower/hPowerThermo.C index 996308b1fd..66ed4a0299 100644 --- a/src/thermophysicalModels/specie/thermo/hPower/hPowerThermo.C +++ b/src/thermophysicalModels/specie/thermo/hPower/hPowerThermo.C @@ -39,7 +39,12 @@ Foam::hPowerThermo::hPowerThermo c0_(dict.subDict("thermodynamics").lookup("C0")), n0_(dict.subDict("thermodynamics").lookup("n0")), Tref_(dict.subDict("thermodynamics").lookup("Tref")), - Hf_(dict.subDict("thermodynamics").lookup("Hf")) + hf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"hf", "Hf"}) + ) {} diff --git a/src/thermophysicalModels/specie/thermo/hPower/hPowerThermo.H b/src/thermophysicalModels/specie/thermo/hPower/hPowerThermo.H index e066b64a5e..7908e70ab8 100644 --- a/src/thermophysicalModels/specie/thermo/hPower/hPowerThermo.H +++ b/src/thermophysicalModels/specie/thermo/hPower/hPowerThermo.H @@ -36,7 +36,7 @@ Usage c0 | Reference heat capacity at constant pressure [J/kg/K] n0 | Exponent of the power function Tref | Reference temperature [K] - Hf | Heat of formation [J/kg] + hf | Heat of formation [J/kg] \endtable Example specification of hPowerThermo: @@ -46,7 +46,7 @@ Usage c0 230; Tref 470; n0 3; - Hf 0; + hf 0; } \endverbatim @@ -115,7 +115,7 @@ class hPowerThermo scalar c0_; scalar n0_; scalar Tref_; - scalar Hf_; + scalar hf_; // Private Member Functions @@ -135,7 +135,7 @@ public: const scalar c0, const scalar n0, const scalar Tref, - const scalar Hf + const scalar hf ); //- Construct from name and dictionary @@ -170,19 +170,19 @@ public: inline scalar Cp(const scalar p, const scalar T) const; //- Absolute enthalpy [J/kg] - inline scalar Ha(const scalar p, const scalar T) const; + inline scalar ha(const scalar p, const scalar T) const; //- Sensible enthalpy [J/kg] - inline scalar Hs(const scalar p, const scalar T) const; + inline scalar hs(const scalar p, const scalar T) const; //- Enthalpy of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Entropy [J/kg/K] - inline scalar S(const scalar p, const scalar T) const; + inline scalar s(const scalar p, const scalar T) const; //- Gibbs free energy of the mixture in the standard state [J/kg] - inline scalar Gstd(const scalar T) const; + inline scalar gStd(const scalar T) const; #include "HtoEthermo.H" diff --git a/src/thermophysicalModels/specie/thermo/hPower/hPowerThermoI.H b/src/thermophysicalModels/specie/thermo/hPower/hPowerThermoI.H index 6e676d4355..65c7910981 100644 --- a/src/thermophysicalModels/specie/thermo/hPower/hPowerThermoI.H +++ b/src/thermophysicalModels/specie/thermo/hPower/hPowerThermoI.H @@ -53,14 +53,14 @@ inline Foam::hPowerThermo::hPowerThermo const scalar c0, const scalar n0, const scalar Tref, - const scalar Hf + const scalar hf ) : EquationOfState(st), c0_(c0), n0_(n0), Tref_(Tref), - Hf_(Hf) + hf_(hf) {} @@ -75,7 +75,7 @@ inline Foam::hPowerThermo::hPowerThermo c0_(jt.c0_), n0_(jt.n0_), Tref_(jt.Tref_), - Hf_(jt.Hf_) + hf_(jt.hf_) {} @@ -114,7 +114,7 @@ inline Foam::scalar Foam::hPowerThermo::Cp template -inline Foam::scalar Foam::hPowerThermo::Hs +inline Foam::scalar Foam::hPowerThermo::hs ( const scalar p, const scalar T @@ -122,30 +122,30 @@ inline Foam::scalar Foam::hPowerThermo::Hs { return c0_*(pow(T, n0_ + 1) - pow(Tstd, n0_ + 1))/(pow(Tref_, n0_)*(n0_ + 1)) - + EquationOfState::H(p, T); + + EquationOfState::h(p, T); } template -inline Foam::scalar Foam::hPowerThermo::Ha +inline Foam::scalar Foam::hPowerThermo::ha ( const scalar p, const scalar T ) const { - return Hs(p, T) + Hf(); + return hs(p, T) + hf(); } template -inline Foam::scalar Foam::hPowerThermo::Hf() const +inline Foam::scalar Foam::hPowerThermo::hf() const { - return Hf_; + return hf_; } template -inline Foam::scalar Foam::hPowerThermo::S +inline Foam::scalar Foam::hPowerThermo::s ( const scalar p, const scalar T @@ -153,19 +153,19 @@ inline Foam::scalar Foam::hPowerThermo::S { return c0_*(pow(T, n0_) - pow(Tstd, n0_))/(pow(Tref_, n0_)*n0_) - + EquationOfState::Sp(p, T); + + EquationOfState::sp(p, T); } template -inline Foam::scalar Foam::hPowerThermo::Gstd +inline Foam::scalar Foam::hPowerThermo::gStd ( const scalar T ) const { return c0_*(pow(T, n0_ + 1) - pow(Tstd, n0_ + 1))/(pow(Tref_, n0_)*(n0_ + 1)) - + Hf() + + hf() - c0_*(pow(T, n0_) - pow(Tstd, n0_))*T/(pow(Tref_, n0_)*n0_); } @@ -200,7 +200,7 @@ inline void Foam::hPowerThermo::operator+= Y1 /= this->Y(); const scalar Y2 = ct.Y()/this->Y(); - Hf_ = Y1*Hf_ + Y2*ct.Hf_; + hf_ = Y1*hf_ + Y2*ct.hf_; c0_ = Y1*c0_ + Y2*ct.c0_; n0_ = Y1*n0_ + Y2*ct.n0_; Tref_ = Y1*Tref_ + Y2*ct.Tref_; @@ -231,7 +231,7 @@ inline Foam::hPowerThermo Foam::operator+ ct1.c0_, ct1.n0_, ct1.Tref_, - ct1.Hf_ + ct1.hf_ ); } else @@ -245,8 +245,8 @@ inline Foam::hPowerThermo Foam::operator+ + ct2.Y()/eofs.Y()*ct2.n0_, ct1.Y()/eofs.Y()*ct1.Tref_ + ct2.Y()/eofs.Y()*ct2.Tref_, - ct1.Y()/eofs.Y()*ct1.Hf_ - + ct2.Y()/eofs.Y()*ct2.Hf_ + ct1.Y()/eofs.Y()*ct1.hf_ + + ct2.Y()/eofs.Y()*ct2.hf_ ); } } @@ -265,7 +265,7 @@ inline Foam::hPowerThermo Foam::operator* ct.c0_, ct.n0_, ct.Tref_, - ct.Hf_ + ct.hf_ ); } @@ -292,8 +292,8 @@ inline Foam::hPowerThermo Foam::operator== - ct1.Y()/eofs.Y()*ct1.n0_, ct2.Y()/eofs.Y()*ct2.Tref_ - ct1.Y()/eofs.Y()*ct1.Tref_, - ct2.Y()/eofs.Y()*ct2.Hf_ - - ct1.Y()/eofs.Y()*ct1.Hf_ + ct2.Y()/eofs.Y()*ct2.hf_ + - ct1.Y()/eofs.Y()*ct1.hf_ ); } diff --git a/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermo.C b/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermo.C index 690bad05d4..de60fec7b0 100644 --- a/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermo.C +++ b/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermo.C @@ -36,9 +36,25 @@ Foam::hTabulatedThermo::hTabulatedThermo ) : EquationOfState(name, dict), - Hf_(dict.subDict("thermodynamics").lookup("Hf")), - Sf_(dict.subDict("thermodynamics").lookup("Sf")), - Hs_("Hs", dict.subDict("thermodynamics").subDict("Hs")), + hf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"hf", "Hf"}) + ), + sf_ + ( + dict + .subDict("thermodynamics") + .lookupBackwardsCompatible({"sf", "Sf"}) + ), + hs_ + ( + "hs", + dict + .subDict("thermodynamics") + .subDictBackwardsCompatible({"hs", "Hs"}) + ), Cp_("Cp", dict.subDict("thermodynamics").subDict("Cp")), Cv_("Cv", dict.subDict("thermodynamics").subDict("Cv")) {} @@ -55,12 +71,12 @@ void Foam::hTabulatedThermo::write EquationOfState::write(os); dictionary dict("thermodynamics"); - dict.add("Hf", Hf_); - dict.add("Sf", Sf_); + dict.add("hf", hf_); + dict.add("sf", sf_); - dictionary HsDict("Hs"); - HsDict.add("values", Hs_.values()); - dict.add("Hs", HsDict); + dictionary hsDict("hs"); + hsDict.add("values", hs_.values()); + dict.add("hs", hsDict); dictionary CpDict("Cp"); CpDict.add("values", Cp_.values()); diff --git a/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermo.H b/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermo.H index 5fe60d3205..25fbdc406a 100644 --- a/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermo.H +++ b/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermo.H @@ -32,9 +32,9 @@ Usage \table Property | Description - Hf | Heat of formation - Sf | Standard entropy - Hs | Sensible enthalpy vs pressure and temperature table + hf | Heat of formation + sf | Standard entropy + hs | Sensible enthalpy vs pressure and temperature table Cp | Specific heat capacity vs pressure and temperature table \endtable @@ -42,10 +42,10 @@ Usage \verbatim thermodynamics { - Hf 0; - Sf 0; + hf 0; + sf 0; - Hs + hs { pLow 1e4; pHigh 5e5; @@ -135,13 +135,13 @@ class hTabulatedThermo // Private Data //- Heat of formation - scalar Hf_; + scalar hf_; //- Standard entropy - scalar Sf_; + scalar sf_; //- Sensible enthalpy table [J/kg] - table2D Hs_; + table2D hs_; //- Specific heat at constant pressure table [J/kg/K] table2D Cp_; @@ -182,25 +182,25 @@ public: inline scalar Cv(const scalar p, const scalar T) const; //- Sensible enthalpy [J/kg] - inline scalar Hs(const scalar p, const scalar T) const; + inline scalar hs(const scalar p, const scalar T) const; //- Absolute enthalpy [J/kg] - inline scalar Ha(const scalar p, const scalar T) const; + inline scalar ha(const scalar p, const scalar T) const; //- Sensible internal energy [J/kg] - inline scalar Es(const scalar p, const scalar T) const; + inline scalar es(const scalar p, const scalar T) const; //- Absolute internal energy [J/kg] - inline scalar Ea(const scalar p, const scalar T) const; + inline scalar ea(const scalar p, const scalar T) const; //- Enthalpy of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Entropy [J/kg/K] - inline scalar S(const scalar p, const scalar T) const; + inline scalar s(const scalar p, const scalar T) const; //- Gibbs free energy of the mixture in the standard state [J/kg] - inline scalar Gstd(const scalar T) const; + inline scalar gStd(const scalar T) const; // Derivative term used for Jacobian diff --git a/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermoI.H b/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermoI.H index d26e7f3bac..c0cfe6127f 100644 --- a/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermoI.H +++ b/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermoI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2020 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2020-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -35,9 +35,9 @@ inline Foam::hTabulatedThermo::hTabulatedThermo ) : EquationOfState(name, pt), - Hf_(pt.Hf_), - Sf_(pt.Sf_), - Hs_(pt.Hs_), + hf_(pt.hf_), + sf_(pt.sf_), + hs_(pt.hs_), Cp_(pt.Cp_), Cv_(pt.Cv_) {} @@ -78,59 +78,59 @@ inline Foam::scalar Foam::hTabulatedThermo::Cv template -inline Foam::scalar Foam::hTabulatedThermo::Hs +inline Foam::scalar Foam::hTabulatedThermo::hs ( const scalar p, const scalar T ) const { - return Hs_.value(p, T); + return hs_.value(p, T); } template -inline Foam::scalar Foam::hTabulatedThermo::Ha +inline Foam::scalar Foam::hTabulatedThermo::ha ( const scalar p, const scalar T ) const { - return Hs(p, T) + Hf_; + return hs(p, T) + hf_; } template -inline Foam::scalar Foam::hTabulatedThermo::Hf() +inline Foam::scalar Foam::hTabulatedThermo::hf() const { - return Hf_; + return hf_; } template -inline Foam::scalar Foam::hTabulatedThermo::Es +inline Foam::scalar Foam::hTabulatedThermo::es ( const scalar p, const scalar T ) const { - return Hs(p, T) - p/EquationOfState::rho(p, T); + return hs(p, T) - p/EquationOfState::rho(p, T); } template -inline Foam::scalar Foam::hTabulatedThermo::Ea +inline Foam::scalar Foam::hTabulatedThermo::ea ( const scalar p, const scalar T ) const { - return Ha(p, T) - p/EquationOfState::rho(p, T); + return ha(p, T) - p/EquationOfState::rho(p, T); } template -inline Foam::scalar Foam::hTabulatedThermo::S +inline Foam::scalar Foam::hTabulatedThermo::s ( const scalar p, const scalar T @@ -142,7 +142,7 @@ inline Foam::scalar Foam::hTabulatedThermo::S template -inline Foam::scalar Foam::hTabulatedThermo::Gstd +inline Foam::scalar Foam::hTabulatedThermo::gStd ( const scalar T ) const diff --git a/src/thermophysicalModels/specie/thermo/janaf/janafThermo.H b/src/thermophysicalModels/specie/thermo/janaf/janafThermo.H index 22dd3809c8..6b512810d3 100644 --- a/src/thermophysicalModels/specie/thermo/janaf/janafThermo.H +++ b/src/thermophysicalModels/specie/thermo/janaf/janafThermo.H @@ -230,19 +230,19 @@ public: inline scalar Cp(const scalar p, const scalar T) const; //- Absolute enthalpy [J/kg] - inline scalar Ha(const scalar p, const scalar T) const; + inline scalar ha(const scalar p, const scalar T) const; //- Sensible enthalpy [J/kg] - inline scalar Hs(const scalar p, const scalar T) const; + inline scalar hs(const scalar p, const scalar T) const; //- Enthalpy of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Entropy [J/kg/K] - inline scalar S(const scalar p, const scalar T) const; + inline scalar s(const scalar p, const scalar T) const; //- Gibbs free energy of the mixture in the standard state [J/kg] - inline scalar Gstd(const scalar T) const; + inline scalar gStd(const scalar T) const; #include "HtoEthermo.H" diff --git a/src/thermophysicalModels/specie/thermo/janaf/janafThermoI.H b/src/thermophysicalModels/specie/thermo/janaf/janafThermoI.H index 6b45696660..9514a512a9 100644 --- a/src/thermophysicalModels/specie/thermo/janaf/janafThermoI.H +++ b/src/thermophysicalModels/specie/thermo/janaf/janafThermoI.H @@ -181,18 +181,18 @@ inline Foam::scalar Foam::janafThermo::Cp template -inline Foam::scalar Foam::janafThermo::Hs +inline Foam::scalar Foam::janafThermo::hs ( const scalar p, const scalar T ) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } template -inline Foam::scalar Foam::janafThermo::Ha +inline Foam::scalar Foam::janafThermo::ha ( const scalar p, const scalar T @@ -203,12 +203,12 @@ inline Foam::scalar Foam::janafThermo::Ha ( ((((a[4]/5.0*T + a[3]/4.0)*T + a[2]/3.0)*T + a[1]/2.0)*T + a[0])*T + a[5] - ) + EquationOfState::H(p, T); + ) + EquationOfState::h(p, T); } template -inline Foam::scalar Foam::janafThermo::Hf() const +inline Foam::scalar Foam::janafThermo::hf() const { const coeffArray& a = lowCpCoeffs_; return @@ -222,7 +222,7 @@ inline Foam::scalar Foam::janafThermo::Hf() const template -inline Foam::scalar Foam::janafThermo::S +inline Foam::scalar Foam::janafThermo::s ( const scalar p, const scalar T @@ -233,12 +233,12 @@ inline Foam::scalar Foam::janafThermo::S ( (((a[4]/4.0*T + a[3]/3.0)*T + a[2]/2.0)*T + a[1])*T + a[0]*log(T) + a[6] - ) + EquationOfState::Sp(p, T); + ) + EquationOfState::sp(p, T); } template -inline Foam::scalar Foam::janafThermo::Gstd +inline Foam::scalar Foam::janafThermo::gStd ( const scalar T ) const diff --git a/src/thermophysicalModels/specie/thermo/sensibleEnthalpy/sensibleEnthalpy.H b/src/thermophysicalModels/specie/thermo/sensibleEnthalpy/sensibleEnthalpy.H index 987cb6c627..88660ebaec 100644 --- a/src/thermophysicalModels/specie/thermo/sensibleEnthalpy/sensibleEnthalpy.H +++ b/src/thermophysicalModels/specie/thermo/sensibleEnthalpy/sensibleEnthalpy.H @@ -87,19 +87,19 @@ public: } // Sensible enthalpy [J/kg] - scalar HE + scalar he ( const Thermo& thermo, const scalar p, const scalar T ) const { - return thermo.Hs(p, T); + return thermo.hs(p, T); } //- Temperature from sensible enthalpy // given an initial temperature T0 - scalar THE + scalar The ( const Thermo& thermo, const scalar h, diff --git a/src/thermophysicalModels/specie/thermo/sensibleInternalEnergy/sensibleInternalEnergy.H b/src/thermophysicalModels/specie/thermo/sensibleInternalEnergy/sensibleInternalEnergy.H index 2d8184e347..3ad660a044 100644 --- a/src/thermophysicalModels/specie/thermo/sensibleInternalEnergy/sensibleInternalEnergy.H +++ b/src/thermophysicalModels/specie/thermo/sensibleInternalEnergy/sensibleInternalEnergy.H @@ -88,19 +88,19 @@ public: } //- Sensible internal energy [J/kg] - scalar HE + scalar he ( const Thermo& thermo, const scalar p, const scalar T ) const { - return thermo.Es(p, T); + return thermo.es(p, T); } //- Temperature from sensible internal energy // given an initial temperature T0 - scalar THE + scalar The ( const Thermo& thermo, const scalar e, @@ -108,7 +108,7 @@ public: const scalar T0 ) const { - return thermo.TEs(e, p, T0); + return thermo.Tes(e, p, T0); } }; diff --git a/src/thermophysicalModels/specie/thermo/thermo/EtoHthermo.H b/src/thermophysicalModels/specie/thermo/thermo/EtoHthermo.H index 89d0a6d7d9..5ff48810e6 100644 --- a/src/thermophysicalModels/specie/thermo/thermo/EtoHthermo.H +++ b/src/thermophysicalModels/specie/thermo/thermo/EtoHthermo.H @@ -7,20 +7,20 @@ inline scalar Cp return Cv(p, T) + EquationOfState::CpMCv(p, T); } -inline scalar Hs +inline scalar hs ( const scalar p, const scalar T ) const { - return Es(p, T) + p/EquationOfState::rho(p, T); + return es(p, T) + p/EquationOfState::rho(p, T); } -inline scalar Ha +inline scalar ha ( const scalar p, const scalar T ) const { - return Ea(p, T) + p/EquationOfState::rho(p, T); + return ea(p, T) + p/EquationOfState::rho(p, T); } diff --git a/src/thermophysicalModels/specie/thermo/thermo/HtoEthermo.H b/src/thermophysicalModels/specie/thermo/thermo/HtoEthermo.H index 67561713fe..b447f684e1 100644 --- a/src/thermophysicalModels/specie/thermo/thermo/HtoEthermo.H +++ b/src/thermophysicalModels/specie/thermo/thermo/HtoEthermo.H @@ -7,20 +7,20 @@ inline scalar Cv return Cp(p, T) - EquationOfState::CpMCv(p, T); } -inline scalar Es +inline scalar es ( const scalar p, const scalar T ) const { - return Hs(p, T) - p/EquationOfState::rho(p, T); + return hs(p, T) - p/EquationOfState::rho(p, T); } -inline scalar Ea +inline scalar ea ( const scalar p, const scalar T ) const { - return Ha(p, T) - p/EquationOfState::rho(p, T); + return ha(p, T) - p/EquationOfState::rho(p, T); } diff --git a/src/thermophysicalModels/specie/thermo/thermo/thermo.H b/src/thermophysicalModels/specie/thermo/thermo/thermo.H index 1c9aad7c91..0571b7a9b0 100644 --- a/src/thermophysicalModels/specie/thermo/thermo/thermo.H +++ b/src/thermophysicalModels/specie/thermo/thermo/thermo.H @@ -144,28 +144,28 @@ public: // inline scalar Cp(const scalar p, const scalar T) const; // Sensible enthalpy [J/kg] - // inline scalar Hs(const scalar p, const scalar T) const; + // inline scalar hs(const scalar p, const scalar T) const; // Enthalpy of formation [J/kg] - // inline scalar Hf() const; + // inline scalar hf() const; // Absolute enthalpy [J/kg] - // inline scalar Ha(const scalar p, const scalar T) const; + // inline scalar ha(const scalar p, const scalar T) const; // Heat capacity at constant volume [J/kg/K] // inline scalar Cv(const scalar p, const scalar T) const; // Sensible internal energy [J/kg] - // inline scalar Es(const scalar p, const scalar T) const; + // inline scalar es(const scalar p, const scalar T) const; // Absolute internal energy [J/kg] - // inline scalar Ea(const scalar p, const scalar T) const; + // inline scalar ea(const scalar p, const scalar T) const; // Entropy [J/kg/K] - // inline scalar S(const scalar p, const scalar T) const; + // inline scalar s(const scalar p, const scalar T) const; - // Mass specific derived properties + // Derived properties //- Heat capacity at constant pressure/volume [J/kg/K] inline scalar Cpv(const scalar p, const scalar T) const; @@ -174,48 +174,12 @@ public: inline scalar gamma(const scalar p, const scalar T) const; //- Enthalpy/Internal energy [J/kg] - inline scalar HE(const scalar p, const scalar T) const; - - //- Gibbs free energy [J/kg] - inline scalar G(const scalar p, const scalar T) const; - - //- Helmholtz free energy [J/kg] - inline scalar A(const scalar p, const scalar T) const; - - - // Mole specific derived properties - - //- Heat capacity at constant pressure [J/kmol/K] - inline scalar cp(const scalar p, const scalar T) const; - - //- Absolute enthalpy [J/kmol] - inline scalar ha(const scalar p, const scalar T) const; - - //- Sensible enthalpy [J/kmol] - inline scalar hs(const scalar p, const scalar T) const; - - //- Enthalpy of formation [J/kmol] - inline scalar hc() const; - - //- Entropy [J/kmol/K] - inline scalar s(const scalar p, const scalar T) const; - - //- Enthalpy/Internal energy [J/kmol] inline scalar he(const scalar p, const scalar T) const; - //- Heat capacity at constant volume [J/kmol/K] - inline scalar cv(const scalar p, const scalar T) const; - - //- Sensible internal energy [J/kmol] - inline scalar es(const scalar p, const scalar T) const; - - //- Absolute internal energy [J/kmol] - inline scalar ea(const scalar p, const scalar T) const; - - //- Gibbs free energy [J/kmol] + //- Gibbs free energy [J/kg] inline scalar g(const scalar p, const scalar T) const; - //- Helmholtz free energy [J/kmol] + //- Helmholtz free energy [J/kg] inline scalar a(const scalar p, const scalar T) const; @@ -231,23 +195,19 @@ public: inline scalar Kp(const scalar p, const scalar T) const; //- Equilibrium constant i.t.o. molar concentration - // = PIi(ci/cstd)^nui + // = PIi(ci/cStd)^nui // For low pressures (where the gas mixture is near perfect) - // Kc = Kp(pstd/(RR*T))^nu + // Kc = Kp(Pstd/(RR*T))^nu inline scalar Kc(const scalar p, const scalar T) const; //- Equilibrium constant [] i.t.o. mole-fractions // For low pressures (where the gas mixture is near perfect) - // Kx = Kp(pstd/p)^nui - inline scalar Kx - ( - const scalar p, - const scalar T - ) const; + // Kx = Kp(Pstd/p)^nui + inline scalar Kx(const scalar p, const scalar T) const; //- Equilibrium constant [] i.t.o. number of moles // For low pressures (where the gas mixture is near perfect) - // Kn = Kp(n*pstd/p)^nui where n = number of moles in mixture + // Kn = Kp(n*Pstd/p)^nui where n = number of moles in mixture inline scalar Kn ( const scalar p, @@ -256,7 +216,7 @@ public: ) const; - // Energy->temperature inversion functions + // Energy->temperature inversion functions //- Return the temperature corresponding to the value of the // thermodynamic property f, given the function f = F(p, T) @@ -282,7 +242,7 @@ public: //- Temperature from enthalpy or internal energy // given an initial temperature T0 - inline scalar THE + inline scalar The ( const scalar H, const scalar p, @@ -292,14 +252,14 @@ public: //- Temperature from sensible enthalpy given an initial T0 inline scalar THs ( - const scalar Hs, + const scalar hs, const scalar p, const scalar T0 ) const; //- Temperature from absolute enthalpy // given an initial temperature T0 - inline scalar THa + inline scalar Tha ( const scalar H, const scalar p, @@ -308,7 +268,7 @@ public: //- Temperature from sensible internal energy // given an initial temperature T0 - inline scalar TEs + inline scalar Tes ( const scalar E, const scalar p, @@ -317,7 +277,7 @@ public: //- Temperature from absolute internal energy // given an initial temperature T0 - inline scalar TEa + inline scalar Tea ( const scalar E, const scalar p, @@ -331,9 +291,6 @@ public: // w.r.t. temperature inline scalar dKcdTbyKc(const scalar p, const scalar T) const; - //- Derivative of cp w.r.t. temperature - inline scalar dcpdT(const scalar p, const scalar T) const; - // I-O diff --git a/src/thermophysicalModels/specie/thermo/thermo/thermoI.H b/src/thermophysicalModels/specie/thermo/thermo/thermoI.H index 9298be12a3..b590dae2ee 100644 --- a/src/thermophysicalModels/specie/thermo/thermo/thermoI.H +++ b/src/thermophysicalModels/specie/thermo/thermo/thermoI.H @@ -85,99 +85,11 @@ Foam::species::thermo::gamma(const scalar p, const scalar T) const } -template class Type> -inline Foam::scalar -Foam::species::thermo::HE(const scalar p, const scalar T) const -{ - return Type>::HE(*this, p, T); -} - - -template class Type> -inline Foam::scalar -Foam::species::thermo::G(const scalar p, const scalar T) const -{ - return this->Ha(p, T) - T*this->S(p, T); -} - - -template class Type> -inline Foam::scalar -Foam::species::thermo::A(const scalar p, const scalar T) const -{ - return this->Ea(p, T) - T*this->S(p, T); -} - - -template class Type> -inline Foam::scalar -Foam::species::thermo::cp(const scalar p, const scalar T) const -{ - return this->Cp(p, T)*this->W(); -} - - -template class Type> -inline Foam::scalar -Foam::species::thermo::ha(const scalar p, const scalar T) const -{ - return this->Ha(p, T)*this->W(); -} - - -template class Type> -inline Foam::scalar -Foam::species::thermo::hs(const scalar p, const scalar T) const -{ - return this->Hs(p, T)*this->W(); -} - - -template class Type> -inline Foam::scalar -Foam::species::thermo::hc() const -{ - return this->Hf()*this->W(); -} - - -template class Type> -inline Foam::scalar -Foam::species::thermo::s(const scalar p, const scalar T) const -{ - return this->S(p, T)*this->W(); -} - - template class Type> inline Foam::scalar Foam::species::thermo::he(const scalar p, const scalar T) const { - return this->HE(p, T)*this->W(); -} - - -template class Type> -inline Foam::scalar -Foam::species::thermo::cv(const scalar p, const scalar T) const -{ - return this->Cv(p, T)*this->W(); -} - - -template class Type> -inline Foam::scalar -Foam::species::thermo::es(const scalar p, const scalar T) const -{ - return this->Es(p, T)*this->W(); -} - - -template class Type> -inline Foam::scalar -Foam::species::thermo::ea(const scalar p, const scalar T) const -{ - return this->Ea(p, T)*this->W(); + return Type>::he(*this, p, T); } @@ -185,7 +97,7 @@ template class Type> inline Foam::scalar Foam::species::thermo::g(const scalar p, const scalar T) const { - return this->G(p, T)*this->W(); + return this->ha(p, T) - T*this->s(p, T); } @@ -193,7 +105,7 @@ template class Type> inline Foam::scalar Foam::species::thermo::a(const scalar p, const scalar T) const { - return this->A(p, T)*this->W(); + return this->ea(p, T) - T*this->s(p, T); } @@ -201,7 +113,7 @@ template class Type> inline Foam::scalar Foam::species::thermo::K(const scalar p, const scalar T) const { - scalar arg = -this->Y()*this->Gstd(T)/(RR*T); + scalar arg = -this->Y()*this->gStd(T)/(RR*T); if (arg < 600) { @@ -358,14 +270,14 @@ inline Foam::scalar Foam::species::thermo::T template class Type> -inline Foam::scalar Foam::species::thermo::THE +inline Foam::scalar Foam::species::thermo::The ( const scalar he, const scalar p, const scalar T0 ) const { - return Type>::THE(*this, he, p, T0); + return Type>::The(*this, he, p, T0); } @@ -383,7 +295,7 @@ inline Foam::scalar Foam::species::thermo::THs hs, p, T0, - &thermo::Hs, + &thermo::hs, &thermo::Cp, &thermo::limit ); @@ -391,7 +303,7 @@ inline Foam::scalar Foam::species::thermo::THs template class Type> -inline Foam::scalar Foam::species::thermo::THa +inline Foam::scalar Foam::species::thermo::Tha ( const scalar ha, const scalar p, @@ -404,7 +316,7 @@ inline Foam::scalar Foam::species::thermo::THa ha, p, T0, - &thermo::Ha, + &thermo::ha, &thermo::Cp, &thermo::limit ); @@ -412,7 +324,7 @@ inline Foam::scalar Foam::species::thermo::THa template class Type> -inline Foam::scalar Foam::species::thermo::TEs +inline Foam::scalar Foam::species::thermo::Tes ( const scalar es, const scalar p, @@ -425,7 +337,7 @@ inline Foam::scalar Foam::species::thermo::TEs es, p, T0, - &thermo::Es, + &thermo::es, &thermo::Cv, &thermo::limit ); @@ -433,7 +345,7 @@ inline Foam::scalar Foam::species::thermo::TEs template class Type> -inline Foam::scalar Foam::species::thermo::TEa +inline Foam::scalar Foam::species::thermo::Tea ( const scalar ea, const scalar p, @@ -446,7 +358,7 @@ inline Foam::scalar Foam::species::thermo::TEa ea, p, T0, - &thermo::Ea, + &thermo::ea, &thermo::Cv, &thermo::limit ); @@ -462,7 +374,7 @@ Foam::species::thermo::dKcdTbyKc ) const { const scalar dKcdTbyKc = - (this->S(Pstd, T) + this->Gstd(T)/T)*this->Y()/(RR*T); + (this->s(Pstd, T) + this->gStd(T)/T)*this->Y()/(RR*T); const scalar nm = this->Y()/this->W(); if (equal(nm, small)) @@ -476,14 +388,6 @@ Foam::species::thermo::dKcdTbyKc } -template class Type> -inline Foam::scalar -Foam::species::thermo::dcpdT(const scalar p, const scalar T) const -{ - return this->dCpdT(p, T)*this->W();; -} - - // * * * * * * * * * * * * * * * Member Operators * * * * * * * * * * * * * // template class Type> diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/Ar/Ar.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/Ar/Ar.C index ca09a341a2..630adc11b8 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/Ar/Ar.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/Ar/Ar.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -96,7 +96,7 @@ Foam::Ar::Ar() kappag_("kappag", 0.0001236, 0.8262, -132.8, 16000), sigma_("sigma", 150.86, 0.03823, 1.2927, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 39.948, 28), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -132,7 +132,7 @@ Foam::Ar::Ar kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/Ar/Ar.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/Ar/Ar.H index bd0ba33498..a5c6d12896 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/Ar/Ar.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/Ar/Ar.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class Ar Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/Ar/ArI.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/Ar/ArI.H index 810d23b524..01faaf6461 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/Ar/ArI.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/Ar/ArI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::Ar::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::Ar::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::Ar::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::Ar::Hf() const +inline Foam::scalar Foam::Ar::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::Ar::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::Ar::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C10H22/C10H22.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C10H22/C10H22.C index c40dd325c6..1b3841c920 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C10H22/C10H22.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C10H22/C10H22.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::C10H22::C10H22() kappag_("kappag", -668.4, 0.9323, -4071000000.0, 0.0), sigma_("sigma", 617.70, 0.055435, 1.3095, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 142.285, 28.0), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::C10H22::C10H22 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C10H22/C10H22.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C10H22/C10H22.H index e9b4724ea1..8e82441ab7 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C10H22/C10H22.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C10H22/C10H22.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C10H22 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C10H22/C10H22I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C10H22/C10H22I.H index bac7fa7cce..e9aee80160 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C10H22/C10H22I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C10H22/C10H22I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C10H22::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C10H22::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C10H22::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C10H22::Hf() const +inline Foam::scalar Foam::C10H22::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C10H22::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C10H22::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C12H26/C12H26.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C12H26/C12H26.C index fdd2443d48..6a46f4739c 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C12H26/C12H26.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C12H26/C12H26.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::C12H26::C12H26() kappag_("kappag", 5.719e-06, 1.4699, 579.4, 0.0), sigma_("sigma", 658.0, 0.055493, 1.3262, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 170.338, 28.0), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::C12H26::C12H26 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C12H26/C12H26.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C12H26/C12H26.H index 45a3fa81ec..98fcfcac34 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C12H26/C12H26.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C12H26/C12H26.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C12H26 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C12H26/C12H26I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C12H26/C12H26I.H index 67e67f62d8..5845aab232 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C12H26/C12H26I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C12H26/C12H26I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C12H26::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C12H26::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C12H26::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C12H26::Hf() const +inline Foam::scalar Foam::C12H26::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C12H26::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C12H26::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C13H28/C13H28.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C13H28/C13H28.C index 8ed6c54d5f..77998f5e53 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C13H28/C13H28.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C13H28/C13H28.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::C13H28::C13H28() kappag_("kappag", 5.3701e-06, 1.4751, 599.09, 0.0), sigma_("sigma", 675.80, 0.05561, 1.3361, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 184.365, 28.0), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::C13H28::C13H28 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C13H28/C13H28.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C13H28/C13H28.H index 9090bc2b42..6a4cc54eae 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C13H28/C13H28.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C13H28/C13H28.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C13H28 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C13H28/C13H28I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C13H28/C13H28I.H index 2e264c9740..6260784704 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C13H28/C13H28I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C13H28/C13H28I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C13H28::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C13H28::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C13H28::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C13H28::Hf() const +inline Foam::scalar Foam::C13H28::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C13H28::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C13H28::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C14H30/C14H30.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C14H30/C14H30.C index 6af9f35beb..d0abededc2 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C14H30/C14H30.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C14H30/C14H30.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::C14H30::C14H30() kappag_("kappag", -0.000628, 0.944, -5490, 0.0), sigma_("sigma", 692.40, 0.056436, 1.3658, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 198.392, 28.0), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::C14H30::C14H30 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C14H30/C14H30.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C14H30/C14H30.H index c4f389ee0f..6fe0151771 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C14H30/C14H30.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C14H30/C14H30.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C14H30 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C14H30/C14H30I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C14H30/C14H30I.H index 8b4c1997f1..89a28d278c 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C14H30/C14H30I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C14H30/C14H30I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C14H30::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C14H30::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C14H30::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C14H30::Hf() const +inline Foam::scalar Foam::C14H30::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C14H30::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C14H30::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C16H34/C16H34.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C16H34/C16H34.C index c32aedc123..9d4187a7dd 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C16H34/C16H34.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C16H34/C16H34.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::C16H34::C16H34() kappag_("kappag", 3.075e-06, 1.552, 678.0, 0.0), sigma_("sigma", 720.60, 0.05699, 1.3929, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 226.446, 28.0), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::C16H34::C16H34 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C16H34/C16H34.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C16H34/C16H34.H index 1d4a471381..76da88a498 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C16H34/C16H34.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C16H34/C16H34.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C16H34 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C16H34/C16H34I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C16H34/C16H34I.H index 6db00905bb..13c44d8a26 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C16H34/C16H34I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C16H34/C16H34I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C16H34::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C16H34::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C16H34::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C16H34::Hf() const +inline Foam::scalar Foam::C16H34::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C16H34::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C16H34::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H5OH/C2H5OH.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H5OH/C2H5OH.C index a2a08106f7..4726cfe03a 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H5OH/C2H5OH.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H5OH/C2H5OH.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::C2H5OH::C2H5OH() kappag_("kappag", -3.12, 0.7152, -3550000.0, 0.0), sigma_("sigma", 3.7640e-02, -2.1570e-05, -1.025e-07, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 46.069, 28), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::C2H5OH::C2H5OH kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H5OH/C2H5OH.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H5OH/C2H5OH.H index 4927538229..1d33645175 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H5OH/C2H5OH.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H5OH/C2H5OH.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C2H5OH Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H5OH/C2H5OHI.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H5OH/C2H5OHI.H index 69e5411781..e1c7476218 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H5OH/C2H5OHI.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H5OH/C2H5OHI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C2H5OH::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C2H5OH::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C2H5OH::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C2H5OH::Hf() const +inline Foam::scalar Foam::C2H5OH::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C2H5OH::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C2H5OH::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6/C2H6.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6/C2H6.C index 7c19b60fc8..d401300172 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6/C2H6.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6/C2H6.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -94,7 +94,7 @@ Foam::C2H6::C2H6() kappag_("kappag", 7.3869e-05, 1.1689, 500.73, 0.0), sigma_("sigma", 305.32, 0.048643, 1.1981, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 30.070, 28), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -130,7 +130,7 @@ Foam::C2H6::C2H6 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6/C2H6.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6/C2H6.H index bfb21ece6f..649939a8e5 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6/C2H6.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6/C2H6.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C2H6 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6/C2H6I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6/C2H6I.H index ae7be47da6..5cbee2d247 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6/C2H6I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6/C2H6I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C2H6::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C2H6::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C2H6::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C2H6::Hf() const +inline Foam::scalar Foam::C2H6::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C2H6::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C2H6::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6O/C2H6O.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6O/C2H6O.C index ef20fab52e..47793a3621 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6O/C2H6O.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6O/C2H6O.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -96,7 +96,7 @@ Foam::C2H6O::C2H6O() kappag_("kappag", 0.2247, 0.1026, 997.06, 1762900), sigma_("sigma", 400.10, 0.06096, 1.2286, 0, 0, 0), D_("D", 147.18, 20.1, 46.069, 28), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -132,7 +132,7 @@ Foam::C2H6O::C2H6O kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6O/C2H6O.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6O/C2H6O.H index 61af643409..554fcc7fd2 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6O/C2H6O.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6O/C2H6O.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C2H6O Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6O/C2H6OI.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6O/C2H6OI.H index 5138eecca7..7fd5fcc2d7 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6O/C2H6OI.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C2H6O/C2H6OI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C2H6O::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C2H6O::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C2H6O::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C2H6O::Hf() const +inline Foam::scalar Foam::C2H6O::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C2H6O::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C2H6O::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H6O/C3H6O.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H6O/C3H6O.C index 6f018a511a..0d1546e31a 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H6O/C3H6O.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H6O/C3H6O.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::C3H6O::C3H6O() kappag_("kappag", -26.8, 0.9098, -126500000, 0.0), sigma_("sigma", 508.20, 0.0622, 1.124, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 58.08, 28), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::C3H6O::C3H6O kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H6O/C3H6O.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H6O/C3H6O.H index 128517bfe2..70795b16b5 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H6O/C3H6O.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H6O/C3H6O.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C3H6O Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H6O/C3H6OI.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H6O/C3H6OI.H index 29fcca436d..b50e91f8c8 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H6O/C3H6OI.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H6O/C3H6OI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C3H6O::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C3H6O::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C3H6O::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C3H6O::Hf() const +inline Foam::scalar Foam::C3H6O::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C3H6O::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C3H6O::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H8/C3H8.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H8/C3H8.C index e595d40d13..d2dce5c36d 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H8/C3H8.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H8/C3H8.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -93,7 +93,7 @@ Foam::C3H8::C3H8() kappag_("kappag", -1.12, 0.10972, -9834.6, -7535800), sigma_("sigma", 369.83, 0.05092, 1.2197, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 44.096, 28), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -129,7 +129,7 @@ Foam::C3H8::C3H8 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H8/C3H8.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H8/C3H8.H index 859ec2c213..3bd93227fd 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H8/C3H8.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H8/C3H8.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C3H8 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H8/C3H8I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H8/C3H8I.H index 74e6b836dd..09e5777188 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H8/C3H8I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C3H8/C3H8I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C3H8::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C3H8::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C3H8::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C3H8::Hf() const +inline Foam::scalar Foam::C3H8::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C3H8::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C3H8::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C4H10O/C4H10O.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C4H10O/C4H10O.C index 8623c73c00..9b6a7d27ec 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C4H10O/C4H10O.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C4H10O/C4H10O.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::C4H10O::C4H10O() kappag_("kappag", -0.0044894, 0.6155, -3266.3, 0.0), sigma_("sigma", 466.70, 0.057356, 1.288, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 74.123, 28), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::C4H10O::C4H10O kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C4H10O/C4H10O.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C4H10O/C4H10O.H index 2a76f03330..87db6e06c2 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C4H10O/C4H10O.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C4H10O/C4H10O.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C4H10O Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C4H10O/C4H10OI.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C4H10O/C4H10OI.H index 631b1c4b26..c3a30f37d0 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C4H10O/C4H10OI.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C4H10O/C4H10OI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C4H10O::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C4H10O::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C4H10O::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C4H10O::Hf() const +inline Foam::scalar Foam::C4H10O::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C4H10O::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C4H10O::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H14/C6H14.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H14/C6H14.C index 3ec769c08f..8048399d6d 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H14/C6H14.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H14/C6H14.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::C6H14::C6H14() kappag_("kappag", -650.5, 0.8053, -1412100000, 0.0), sigma_("sigma", 507.60, 0.055003, 1.2674, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 86.177, 28), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::C6H14::C6H14 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H14/C6H14.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H14/C6H14.H index a133a9e694..1aa580c913 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H14/C6H14.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H14/C6H14.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C6H14 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H14/C6H14I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H14/C6H14I.H index 246e7c8374..e4bb7e2b80 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H14/C6H14I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H14/C6H14I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C6H14::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C6H14::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C6H14::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C6H14::Hf() const +inline Foam::scalar Foam::C6H14::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C6H14::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C6H14::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H6/C6H6.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H6/C6H6.C index 2c326f0868..c123987273 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H6/C6H6.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H6/C6H6.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::C6H6::C6H6() kappag_("kappag", 1.652e-05, 1.3117, 491, 0.0), sigma_("sigma", 562.16, 0.07195, 1.2389, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 78.114, 28), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::C6H6::C6H6 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H6/C6H6.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H6/C6H6.H index 84354b1891..7c8c5aa90f 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H6/C6H6.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H6/C6H6.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C6H6 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H6/C6H6I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H6/C6H6I.H index e491a92069..b3f57312e6 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H6/C6H6I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C6H6/C6H6I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C6H6::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C6H6::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C6H6::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C6H6::Hf() const +inline Foam::scalar Foam::C6H6::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C6H6::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C6H6::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H16/C7H16.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H16/C7H16.C index 8b1e4c2f56..380653a958 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H16/C7H16.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H16/C7H16.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -103,7 +103,7 @@ Foam::C7H16::C7H16() kappag_("kappag", -0.070028, 0.38068, -7049.9, -2400500.0), sigma_("sigma", 540.20, 0.054143, 1.2512, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 100.204, 28.0), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -139,7 +139,7 @@ Foam::C7H16::C7H16 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H16/C7H16.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H16/C7H16.H index 4f572fb7d9..fdad4d5b98 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H16/C7H16.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H16/C7H16.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C7H16 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H16/C7H16I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H16/C7H16I.H index 91b61466dd..a4bc666c44 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H16/C7H16I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H16/C7H16I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C7H16::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C7H16::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C7H16::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C7H16::Hf() const +inline Foam::scalar Foam::C7H16::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C7H16::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C7H16::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H8/C7H8.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H8/C7H8.C index ac8f1ae055..f36762cad0 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H8/C7H8.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H8/C7H8.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::C7H8::C7H8() kappag_("kappag", 2.392e-05, 1.2694, 537, 0.0), sigma_("sigma", 591.79, 0.06685, 1.2456, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 92.141, 28), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::C7H8::C7H8 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H8/C7H8.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H8/C7H8.H index 0c616d12eb..8db2b66bb6 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H8/C7H8.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H8/C7H8.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C7H8 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H8/C7H8I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H8/C7H8I.H index 04d1da3f8f..38892ea22a 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H8/C7H8I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C7H8/C7H8I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C7H8::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C7H8::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C7H8::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C7H8::Hf() const +inline Foam::scalar Foam::C7H8::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C7H8::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C7H8::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H10/C8H10.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H10/C8H10.C index d196dcc28f..bf7c728a8f 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H10/C8H10.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H10/C8H10.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::C8H10::C8H10() kappag_("kappag", 1.708e-05, 1.319, 565.6, 0.0), sigma_("sigma", 617.17, 0.066, 1.268, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 106.167, 28.0), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::C8H10::C8H10 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H10/C8H10.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H10/C8H10.H index b16f907f84..230e63f111 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H10/C8H10.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H10/C8H10.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -76,7 +76,7 @@ class C8H10 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -136,13 +136,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H10/C8H10I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H10/C8H10I.H index 7dc8706417..f19e418291 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H10/C8H10I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H10/C8H10I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C8H10::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C8H10::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C8H10::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C8H10::Hf() const +inline Foam::scalar Foam::C8H10::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C8H10::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C8H10::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H18/C8H18.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H18/C8H18.C index f2ad86e4bf..ceeb8e3b8f 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H18/C8H18.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H18/C8H18.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::C8H18::C8H18() kappag_("kappag", -8758, 0.8448, -27121000000.0, 0.0), sigma_("sigma", 568.70, 0.052789, 1.2323, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 114.231, 28.0), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::C8H18::C8H18 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H18/C8H18.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H18/C8H18.H index f4f88e82a6..c2e1a22bc5 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H18/C8H18.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H18/C8H18.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C8H18 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H18/C8H18I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H18/C8H18I.H index 251d6f2950..7211818e82 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H18/C8H18I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C8H18/C8H18I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C8H18::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C8H18::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C8H18::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C8H18::Hf() const +inline Foam::scalar Foam::C8H18::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C8H18::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C8H18::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C9H20/C9H20.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C9H20/C9H20.C index b287dcc5f9..1a839b84fe 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C9H20/C9H20.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C9H20/C9H20.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::C9H20::C9H20() kappag_("kappag", -0.065771, 0.27198, -3482.3, -1580300.0), sigma_("sigma", 594.60, 0.054975, 1.2897, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 128.258, 28.0), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::C9H20::C9H20 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C9H20/C9H20.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C9H20/C9H20.H index 828f8ff74d..439d3398ed 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C9H20/C9H20.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C9H20/C9H20.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class C9H20 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C9H20/C9H20I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C9H20/C9H20I.H index 770967d064..a4731e71de 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C9H20/C9H20I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/C9H20/C9H20I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::C9H20::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::C9H20::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::C9H20::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::C9H20::Hf() const +inline Foam::scalar Foam::C9H20::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::C9H20::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::C9H20::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH3OH/CH3OH.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH3OH/CH3OH.C index 867a484ea7..175716f303 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH3OH/CH3OH.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH3OH/CH3OH.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::CH3OH::CH3OH() kappag_("kappag", -7.763, 1.0279, -74360000.0, 6770000000.0), sigma_("sigma", 512.58, 0.056, -0.00014583, 1.08e-07, 0.0, 0.0), D_("D", 147.18, 20.1, 32.042, 28.0), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::CH3OH::CH3OH kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH3OH/CH3OH.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH3OH/CH3OH.H index 1a6f829ec1..de3cf7a9a1 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH3OH/CH3OH.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH3OH/CH3OH.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class CH3OH Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH3OH/CH3OHI.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH3OH/CH3OHI.H index ccf48fd86e..2b1078a23b 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH3OH/CH3OHI.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH3OH/CH3OHI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::CH3OH::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::CH3OH::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::CH3OH::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::CH3OH::Hf() const +inline Foam::scalar Foam::CH3OH::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::CH3OH::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::CH3OH::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH4N2O/CH4N2O.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH4N2O/CH4N2O.C index 24169952b0..3c197f0ba8 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH4N2O/CH4N2O.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH4N2O/CH4N2O.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -94,7 +94,7 @@ Foam::CH4N2O::CH4N2O() kappag_("kappag", 6.977e-05, 1.1243, 844.9, -148850.0), sigma_("sigma", 705.0, 1.0, 0.0, 0.0, 0.0, 0.0), // note: set to constant D_("D", 147.18, 20.1, 60.056, 28.0), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -130,7 +130,7 @@ Foam::CH4N2O::CH4N2O kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH4N2O/CH4N2O.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH4N2O/CH4N2O.H index 932521588c..99e42ade1f 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH4N2O/CH4N2O.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH4N2O/CH4N2O.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -78,7 +78,7 @@ class CH4N2O Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -138,13 +138,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH4N2O/CH4N2OI.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH4N2O/CH4N2OI.H index 8e746ff603..797e8475cc 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH4N2O/CH4N2OI.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/CH4N2O/CH4N2OI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::CH4N2O::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::CH4N2O::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::CH4N2O::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::CH4N2O::Hf() const +inline Foam::scalar Foam::CH4N2O::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::CH4N2O::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::CH4N2O::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/H2O/H2O.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/H2O/H2O.C index 4ab482252e..6d47a21cd8 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/H2O/H2O.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/H2O/H2O.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::H2O::H2O() kappag_("kappag", 6.977e-05, 1.1243, 844.9, -148850), sigma_("sigma", 647.13, 0.18548, 2.717, -3.554, 2.047, 0), D_("D", 15.0, 15.0, 18.015, 28), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::H2O::H2O kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/H2O/H2O.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/H2O/H2O.H index debe740a22..0ab43ce526 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/H2O/H2O.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/H2O/H2O.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -76,7 +76,7 @@ class H2O Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -136,13 +136,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/H2O/H2OI.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/H2O/H2OI.H index 7df3e5f308..24abb3d819 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/H2O/H2OI.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/H2O/H2OI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::H2O::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::H2O::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::H2O::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::H2O::Hf() const +inline Foam::scalar Foam::H2O::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::H2O::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::H2O::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IC8H18/IC8H18.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IC8H18/IC8H18.C index 0e2a782b70..d5c7f2cafb 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IC8H18/IC8H18.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IC8H18/IC8H18.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::IC8H18::IC8H18() kappag_("kappag", 1.758e-05, 1.3114, 392.9, 0.0), sigma_("sigma", 543.96, 0.047434, 1.1975, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 114.231, 28.0), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::IC8H18::IC8H18 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IC8H18/IC8H18.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IC8H18/IC8H18.H index a04ccdb4a2..412e10aca0 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IC8H18/IC8H18.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IC8H18/IC8H18.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class IC8H18 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IC8H18/IC8H18I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IC8H18/IC8H18I.H index a3210ccdc0..b44cd856fd 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IC8H18/IC8H18I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IC8H18/IC8H18I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::IC8H18::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::IC8H18::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::IC8H18::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::IC8H18::Hf() const +inline Foam::scalar Foam::IC8H18::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::IC8H18::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::IC8H18::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IDEA/IDEA.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IDEA/IDEA.C index 815ce3e700..543a38dd56 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IDEA/IDEA.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IDEA/IDEA.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -119,7 +119,7 @@ Foam::IDEA::IDEA() 8.6488806234 ), D_("D", 147.18, 20.1, 142.2, 28.0), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -155,7 +155,7 @@ Foam::IDEA::IDEA kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IDEA/IDEA.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IDEA/IDEA.H index 3fa2e19399..0861eaf61d 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IDEA/IDEA.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IDEA/IDEA.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -99,7 +99,7 @@ class IDEA Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -159,13 +159,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IDEA/IDEAI.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IDEA/IDEAI.H index 7417081fea..1e6a0e6f2e 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IDEA/IDEAI.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/IDEA/IDEAI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::IDEA::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::IDEA::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::IDEA::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::IDEA::Hf() const +inline Foam::scalar Foam::IDEA::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::IDEA::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::IDEA::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/MB/MB.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/MB/MB.C index 08ad2f8b6a..ed558634e8 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/MB/MB.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/MB/MB.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -95,7 +95,7 @@ Foam::MB::MB() kappag_("kappag", 1333.1, 0.9962, 12317000000.0, 0.0), sigma_("sigma", 554.5, 0.064084, 1.2418, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 102.133, 28.0), // note: Same as nHeptane, - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -131,7 +131,7 @@ Foam::MB::MB kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/MB/MB.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/MB/MB.H index 4486a585e2..a4e64c2c9e 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/MB/MB.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/MB/MB.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class MB Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/MB/MBI.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/MB/MBI.H index b0faf672b4..435cea9a85 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/MB/MBI.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/MB/MBI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::MB::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::MB::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::MB::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::MB::Hf() const +inline Foam::scalar Foam::MB::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::MB::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::MB::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/N2/N2.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/N2/N2.C index a87cc4eac9..63dc6a4dde 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/N2/N2.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/N2/N2.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::N2::N2() kappag_("kappag", 0.000351, 0.7652, 25.767, 0.0), sigma_("sigma", 126.10, 0.02898, 1.2457, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 28.014, 28.0), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::N2::N2 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/N2/N2.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/N2/N2.H index 0f6bcc3da1..af128a3ba9 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/N2/N2.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/N2/N2.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class N2 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/N2/N2I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/N2/N2I.H index b8b5191cb6..cfecf0a375 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/N2/N2I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/N2/N2I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::N2::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::N2::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::N2::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::N2::Hf() const +inline Foam::scalar Foam::N2::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::N2::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::N2::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/NH3/NH3.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/NH3/NH3.C index 1b28f9ef74..daf69bf45d 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/NH3/NH3.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/NH3/NH3.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2021-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -79,7 +79,7 @@ Foam::NH3::NH3() kappag_("kappag", -4.5900e-02, 1.6520e-01, -1.7078e+03, 0), sigma_("sigma", 9.1200e-02, 1.1028e+00, 0, 0, 0, 0), D_("D", 14.9, 20.1, W(), 28), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -115,7 +115,7 @@ Foam::NH3::NH3 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/NH3/NH3.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/NH3/NH3.H index 704f08a7be..4455895d41 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/NH3/NH3.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/NH3/NH3.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2021-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -76,7 +76,7 @@ class NH3 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -136,13 +136,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/NH3/NH3I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/NH3/NH3I.H index d0bd0f1acc..cee847381e 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/NH3/NH3I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/NH3/NH3I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2021-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::NH3::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::NH3::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::NH3::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::NH3::Hf() const +inline Foam::scalar Foam::NH3::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::NH3::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::NH3::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/aC10H7CH3/aC10H7CH3.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/aC10H7CH3/aC10H7CH3.C index 3bb163a822..8dd7689983 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/aC10H7CH3/aC10H7CH3.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/aC10H7CH3/aC10H7CH3.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -95,7 +95,7 @@ Foam::aC10H7CH3::aC10H7CH3() kappag_("kappag", 0.3911, -0.1051, -213.52, 2318300), sigma_("sigma", 772.04, 0.076, 1.33, 0, 0, 0), D_("D", 147.18, 20.1, 142.2, 28), // note: Same as nHeptane - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -131,7 +131,7 @@ Foam::aC10H7CH3::aC10H7CH3 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/aC10H7CH3/aC10H7CH3.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/aC10H7CH3/aC10H7CH3.H index 96928a6ee6..6f969dd2e3 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/aC10H7CH3/aC10H7CH3.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/aC10H7CH3/aC10H7CH3.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class aC10H7CH3 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/aC10H7CH3/aC10H7CH3I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/aC10H7CH3/aC10H7CH3I.H index 7e279ac5a4..6c4d117cda 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/aC10H7CH3/aC10H7CH3I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/aC10H7CH3/aC10H7CH3I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::aC10H7CH3::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::aC10H7CH3::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::aC10H7CH3::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::aC10H7CH3::Hf() const +inline Foam::scalar Foam::aC10H7CH3::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::aC10H7CH3::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::aC10H7CH3::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/bC10H7CH3/bC10H7CH3.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/bC10H7CH3/bC10H7CH3.C index 6436f6f29b..9389c7a8ea 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/bC10H7CH3/bC10H7CH3.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/bC10H7CH3/bC10H7CH3.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::bC10H7CH3::bC10H7CH3() kappag_("kappag", 0.4477, -0.1282, -345.89, 2340100), sigma_("sigma", 761.0, 0.066442, 1.2634, 0.0, 0.0, 0.0), D_("D", 147.18, 20.1, 142.2, 28), // note: Same as nHeptane, - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::bC10H7CH3::bC10H7CH3 kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/bC10H7CH3/bC10H7CH3.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/bC10H7CH3/bC10H7CH3.H index e2457deb7f..5a7662d84e 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/bC10H7CH3/bC10H7CH3.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/bC10H7CH3/bC10H7CH3.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -77,7 +77,7 @@ class bC10H7CH3 Function2s::APIdiffCoef D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -137,13 +137,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/bC10H7CH3/bC10H7CH3I.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/bC10H7CH3/bC10H7CH3I.H index f977c4b286..bd9372a3f8 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/bC10H7CH3/bC10H7CH3I.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/bC10H7CH3/bC10H7CH3I.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::bC10H7CH3::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::bC10H7CH3::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::bC10H7CH3::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::bC10H7CH3::Hf() const +inline Foam::scalar Foam::bC10H7CH3::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::bC10H7CH3::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::bC10H7CH3::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/iC3H8O/iC3H8O.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/iC3H8O/iC3H8O.C index 2563377655..d83a01ece1 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/iC3H8O/iC3H8O.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/iC3H8O/iC3H8O.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::iC3H8O::iC3H8O() kappag_("kappag", -80.642, -1.4549, -604.42, 0.0), sigma_("sigma", 0.03818, -3.818e-05, -6.51e-08, 0.0, 0.0, 0.0), D_("D", 4.75e-10, 1.75, 0.0, 0.0, 0.0), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::iC3H8O::iC3H8O kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/iC3H8O/iC3H8O.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/iC3H8O/iC3H8O.H index 4f782d7246..cc7ba06742 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/iC3H8O/iC3H8O.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/iC3H8O/iC3H8O.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -76,7 +76,7 @@ class iC3H8O Function1s::NSRDS1 D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -136,13 +136,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/iC3H8O/iC3H8OI.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/iC3H8O/iC3H8OI.H index d0d9e077ec..04b2bf8254 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/iC3H8O/iC3H8OI.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/iC3H8O/iC3H8OI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::iC3H8O::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::iC3H8O::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::iC3H8O::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::iC3H8O::Hf() const +inline Foam::scalar Foam::iC3H8O::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::iC3H8O::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::iC3H8O::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquid/liquid.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquid/liquid.C index 7e00cf5472..decea7b571 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquid/liquid.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquid/liquid.C @@ -79,7 +79,7 @@ Foam::liquid::liquid(const dictionary& dict) kappag_(New("kappag", dict)), sigma_(New("sigma", dict)), D_(New("D", dict)), - Hf_(h_->value(Tstd)) + hf_(h_->value(Tstd)) {} @@ -99,7 +99,7 @@ Foam::liquid::liquid(const liquid& lm) kappag_(lm.kappag_, false), sigma_(lm.sigma_, false), D_(lm.D_, false), - Hf_(lm.Hf_) + hf_(lm.hf_) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquid/liquid.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquid/liquid.H index 5c57673a6d..2f4eaf70e8 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquid/liquid.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquid/liquid.H @@ -69,7 +69,7 @@ class liquid autoPtr> D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; // Private Member Functions @@ -119,13 +119,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquid/liquidI.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquid/liquidI.H index 356481d3fc..d020fe284b 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquid/liquidI.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquid/liquidI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2019-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2019-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::liquid::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::liquid::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::liquid::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::liquid::Hf() const +inline Foam::scalar Foam::liquid::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::liquid::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::liquid::ha(scalar p, scalar T) const { return h_->value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquidProperties/liquidProperties.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquidProperties/liquidProperties.C index 12505b411a..fcdfa7aad0 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquidProperties/liquidProperties.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquidProperties/liquidProperties.C @@ -92,7 +92,7 @@ const Foam::word& Foam::liquidProperties::name() const } -Foam::scalar Foam::liquidProperties::S(scalar p, scalar T) const +Foam::scalar Foam::liquidProperties::s(scalar p, scalar T) const { NotImplemented; return 0; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquidProperties/liquidProperties.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquidProperties/liquidProperties.H index 72f9cb07e1..d7144dc824 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquidProperties/liquidProperties.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquidProperties/liquidProperties.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -227,26 +227,26 @@ public: // Fundamental thermodynamic properties //- Liquid heat of formation [J/kg] - virtual scalar Hf() const = 0; + virtual scalar hf() const = 0; //- Liquid sensible enthalpy [J/kg] // currently pressure effects are neglected - virtual scalar Hs(scalar p, scalar T) const = 0; + virtual scalar hs(scalar p, scalar T) const = 0; //- Liquid absolute enthalpy [J/kg] // currently pressure effects are neglected - virtual scalar Ha(scalar p, scalar T) const = 0; + virtual scalar ha(scalar p, scalar T) const = 0; //- Sensible internal energy [J/kg] // currently pressure effects are neglected - inline scalar Es(scalar p, const scalar T) const; + inline scalar es(scalar p, const scalar T) const; //- Absolute internal energy [J/kg] // currently pressure effects are neglected - inline scalar Ea(scalar p, scalar T) const; + inline scalar ea(scalar p, scalar T) const; //- Liquid entropy [J/kg/K] - scalar S(const scalar p, const scalar T) const; + scalar s(const scalar p, const scalar T) const; // Physical properties diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquidProperties/liquidPropertiesI.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquidProperties/liquidPropertiesI.H index f5a16171c2..3965224d09 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquidProperties/liquidPropertiesI.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/liquidProperties/liquidPropertiesI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -109,15 +109,15 @@ inline Foam::scalar Foam::liquidProperties::CpMCv(scalar p, scalar T) const } -inline Foam::scalar Foam::liquidProperties::Es(scalar p, const scalar T) const +inline Foam::scalar Foam::liquidProperties::es(scalar p, const scalar T) const { - return Hs(p, T); + return hs(p, T); } -inline Foam::scalar Foam::liquidProperties::Ea(scalar p, const scalar T) const +inline Foam::scalar Foam::liquidProperties::ea(scalar p, const scalar T) const { - return Ha(p, T); + return ha(p, T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/nC3H8O/nC3H8O.C b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/nC3H8O/nC3H8O.C index 485fe35d3c..d8949ff167 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/nC3H8O/nC3H8O.C +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/nC3H8O/nC3H8O.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -104,7 +104,7 @@ Foam::nC3H8O::nC3H8O() kappag_("kappag", -613.84, 0.7927, -1157400000.0, 0.0), sigma_("sigma", 0.04533, -6.88e-05, -1.6e-08, 0.0, 0.0, 0.0), D_("D", 4.75e-10, 1.75, 0.0, 0.0, 0.0), // note: same as iC3H8O, - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} @@ -140,7 +140,7 @@ Foam::nC3H8O::nC3H8O kappag_(vapourThermalConductivity), sigma_(surfaceTension), D_(vapourDiffusivity), - Hf_(h_.value(Tstd)) + hf_(h_.value(Tstd)) {} diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/nC3H8O/nC3H8O.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/nC3H8O/nC3H8O.H index 292171e6c2..034e43a24a 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/nC3H8O/nC3H8O.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/nC3H8O/nC3H8O.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -76,7 +76,7 @@ class nC3H8O Function1s::NSRDS1 D_; //- Liquid heat of formation [J/kg] - scalar Hf_; + scalar hf_; public: @@ -136,13 +136,13 @@ public: inline scalar Cp(scalar p, scalar T) const; //- Liquid sensible enthalpy [J/kg] - inline scalar Hs(scalar p, scalar T) const; + inline scalar hs(scalar p, scalar T) const; //- Liquid heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Liquid absolute enthalpy [J/kg] - inline scalar Ha(scalar p, scalar T) const; + inline scalar ha(scalar p, scalar T) const; //- Ideal gas heat capacity [J/kg/K] inline scalar Cpg(scalar p, scalar T) const; diff --git a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/nC3H8O/nC3H8OI.H b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/nC3H8O/nC3H8OI.H index dd22b7a37b..478eec8db5 100644 --- a/src/thermophysicalModels/thermophysicalProperties/liquidProperties/nC3H8O/nC3H8OI.H +++ b/src/thermophysicalModels/thermophysicalProperties/liquidProperties/nC3H8O/nC3H8OI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -47,19 +47,19 @@ inline Foam::scalar Foam::nC3H8O::Cp(scalar p, scalar T) const } -inline Foam::scalar Foam::nC3H8O::Hs(scalar p, scalar T) const +inline Foam::scalar Foam::nC3H8O::hs(scalar p, scalar T) const { - return Ha(p, T) - Hf(); + return ha(p, T) - hf(); } -inline Foam::scalar Foam::nC3H8O::Hf() const +inline Foam::scalar Foam::nC3H8O::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::nC3H8O::Ha(scalar p, scalar T) const +inline Foam::scalar Foam::nC3H8O::ha(scalar p, scalar T) const { return h_.value(T); } diff --git a/src/thermophysicalModels/thermophysicalProperties/solidProperties/solidProperties/solidProperties.C b/src/thermophysicalModels/thermophysicalProperties/solidProperties/solidProperties/solidProperties.C index 415a753eca..2a733bbed7 100644 --- a/src/thermophysicalModels/thermophysicalProperties/solidProperties/solidProperties/solidProperties.C +++ b/src/thermophysicalModels/thermophysicalProperties/solidProperties/solidProperties/solidProperties.C @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -41,14 +41,14 @@ Foam::solidProperties::solidProperties scalar rho, scalar Cp, scalar kappa, - scalar Hf, + scalar hf, scalar emissivity ) : rho_(rho), Cp_(Cp), kappa_(kappa), - Hf_(Hf), + hf_(hf), emissivity_(emissivity) {} @@ -58,7 +58,7 @@ Foam::solidProperties::solidProperties(const dictionary& dict) rho_(dict.lookup("rho")), Cp_(dict.lookup("Cp")), kappa_(dict.lookupBackwardsCompatible({"kappa", "K"})), - Hf_(dict.lookup("Hf")), + hf_(dict.lookupBackwardsCompatible({"hf", "Hf"})), emissivity_(dict.lookup("emissivity")) {} @@ -71,7 +71,7 @@ void Foam::solidProperties::readIfPresent(const dictionary& dict) dict.readIfPresent("Cp", Cp_); dict.readIfPresent("K", kappa_); dict.readIfPresent("kappa", kappa_); - dict.readIfPresent("Hf", Hf_); + dict.readIfPresent("hf", hf_); dict.readIfPresent("emissivity", emissivity_); } @@ -81,7 +81,7 @@ void Foam::solidProperties::write(Ostream& os) const os << rho_ << token::SPACE << Cp_ << token::SPACE << kappa_ << token::SPACE - << Hf_ << token::SPACE + << hf_ << token::SPACE << emissivity_; } diff --git a/src/thermophysicalModels/thermophysicalProperties/solidProperties/solidProperties/solidProperties.H b/src/thermophysicalModels/thermophysicalProperties/solidProperties/solidProperties/solidProperties.H index 8a1f437384..92f8505338 100644 --- a/src/thermophysicalModels/thermophysicalProperties/solidProperties/solidProperties/solidProperties.H +++ b/src/thermophysicalModels/thermophysicalProperties/solidProperties/solidProperties/solidProperties.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -67,7 +67,7 @@ class solidProperties scalar kappa_; //- Heat of formation [J/kg] - scalar Hf_; + scalar hf_; //- Emissivity scalar emissivity_; @@ -108,7 +108,7 @@ public: scalar rho, scalar Cp, scalar kappa, - scalar Hf, + scalar hf, scalar emissivity ); @@ -147,19 +147,19 @@ public: inline scalar Cp() const; //- Heat of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Sensible enthalpy [J/kg] - inline scalar Hs(const scalar T) const; + inline scalar hs(const scalar T) const; //- Absolute enthalpy [J/kg] - inline scalar Ha(scalar T) const; + inline scalar ha(scalar T) const; //- Sensible internal energy [J/kg] - inline scalar Es(const scalar T) const; + inline scalar es(const scalar T) const; //- Absolute internal energy [J/kg] - inline scalar Ea(scalar T) const; + inline scalar ea(scalar T) const; //- Thermal conductivity [W/m/K] inline scalar kappa() const; diff --git a/src/thermophysicalModels/thermophysicalProperties/solidProperties/solidProperties/solidPropertiesI.H b/src/thermophysicalModels/thermophysicalProperties/solidProperties/solidProperties/solidPropertiesI.H index ff40f5cafd..8d797254b8 100644 --- a/src/thermophysicalModels/thermophysicalProperties/solidProperties/solidProperties/solidPropertiesI.H +++ b/src/thermophysicalModels/thermophysicalProperties/solidProperties/solidProperties/solidPropertiesI.H @@ -2,7 +2,7 @@ ========= | \\ / F ield | OpenFOAM: The Open Source CFD Toolbox \\ / O peration | Website: https://openfoam.org - \\ / A nd | Copyright (C) 2011-2021 OpenFOAM Foundation + \\ / A nd | Copyright (C) 2011-2023 OpenFOAM Foundation \\/ M anipulation | ------------------------------------------------------------------------------- License @@ -39,33 +39,33 @@ inline Foam::scalar Foam::solidProperties::Cp() const } -inline Foam::scalar Foam::solidProperties::Hf() const +inline Foam::scalar Foam::solidProperties::hf() const { - return Hf_; + return hf_; } -inline Foam::scalar Foam::solidProperties::Hs(const scalar T) const +inline Foam::scalar Foam::solidProperties::hs(const scalar T) const { return Cp_*(T - Tstd); } -inline Foam::scalar Foam::solidProperties::Ha(const scalar T) const +inline Foam::scalar Foam::solidProperties::ha(const scalar T) const { - return Hs(T) + Hf(); + return hs(T) + hf(); } -inline Foam::scalar Foam::solidProperties::Es(const scalar T) const +inline Foam::scalar Foam::solidProperties::es(const scalar T) const { - return Hs(T); + return hs(T); } -inline Foam::scalar Foam::solidProperties::Ea(const scalar T) const +inline Foam::scalar Foam::solidProperties::ea(const scalar T) const { - return Es(T) + Hf(); + return es(T) + hf(); } diff --git a/src/thermophysicalModels/thermophysicalProperties/thermophysicalProperties/thermophysicalProperties.H b/src/thermophysicalModels/thermophysicalProperties/thermophysicalProperties/thermophysicalProperties.H index b91fe0cb0b..00381d8966 100644 --- a/src/thermophysicalModels/thermophysicalProperties/thermophysicalProperties/thermophysicalProperties.H +++ b/src/thermophysicalModels/thermophysicalProperties/thermophysicalProperties/thermophysicalProperties.H @@ -145,16 +145,16 @@ public: virtual scalar Cp(const scalar p, const scalar T) const = 0; //- Sensible enthalpy [J/kg] - virtual scalar Hs(const scalar p, const scalar T) const = 0; + virtual scalar hs(const scalar p, const scalar T) const = 0; //- Enthalpy of formation [J/kg] - virtual scalar Hf() const = 0; + virtual scalar hf() const = 0; //- Absolute enthalpy [J/kg] - virtual scalar Ha(const scalar p, const scalar T) const = 0; + virtual scalar ha(const scalar p, const scalar T) const = 0; // Entropy [J/kg/K] - virtual scalar S(const scalar p, const scalar T) const = 0; + virtual scalar s(const scalar p, const scalar T) const = 0; // Physical properties diff --git a/src/thermophysicalModels/thermophysicalProperties/thermophysicalProperties/thermophysicalPropertiesSelector.H b/src/thermophysicalModels/thermophysicalProperties/thermophysicalProperties/thermophysicalPropertiesSelector.H index 43e05a99fa..1632fb8c62 100644 --- a/src/thermophysicalModels/thermophysicalProperties/thermophysicalProperties/thermophysicalPropertiesSelector.H +++ b/src/thermophysicalModels/thermophysicalProperties/thermophysicalProperties/thermophysicalPropertiesSelector.H @@ -138,25 +138,25 @@ public: inline scalar Cp(const scalar p, const scalar T) const; //- Sensible enthalpy [J/kg] - inline scalar Hs(const scalar p, const scalar T) const; + inline scalar hs(const scalar p, const scalar T) const; //- Enthalpy of formation [J/kg] - inline scalar Hf() const; + inline scalar hf() const; //- Absolute enthalpy [J/kg] - inline scalar Ha(const scalar p, const scalar T) const; + inline scalar ha(const scalar p, const scalar T) const; //- Heat capacity at constant volume [J/kg/K] inline scalar Cv(const scalar p, const scalar T) const; //- Sensible internal energy [J/kg] - inline scalar Es(const scalar p, const scalar T) const; + inline scalar es(const scalar p, const scalar T) const; //- Absolute internal energy [J/kg] - inline scalar Ea(const scalar p, const scalar T) const; + inline scalar ea(const scalar p, const scalar T) const; // Entropy [J/kg/K] - inline scalar S(const scalar p, const scalar T) const; + inline scalar s(const scalar p, const scalar T) const; // Physical properties diff --git a/src/thermophysicalModels/thermophysicalProperties/thermophysicalProperties/thermophysicalPropertiesSelectorI.H b/src/thermophysicalModels/thermophysicalProperties/thermophysicalProperties/thermophysicalPropertiesSelectorI.H index 0bba51fb4e..5f8aa70544 100644 --- a/src/thermophysicalModels/thermophysicalProperties/thermophysicalProperties/thermophysicalPropertiesSelectorI.H +++ b/src/thermophysicalModels/thermophysicalProperties/thermophysicalProperties/thermophysicalPropertiesSelectorI.H @@ -113,33 +113,33 @@ Foam::thermophysicalPropertiesSelector::Cp template inline Foam::scalar -Foam::thermophysicalPropertiesSelector::Hs +Foam::thermophysicalPropertiesSelector::hs ( scalar p, scalar T ) const { - return propertiesPtr_->Hs(p, T); + return propertiesPtr_->hs(p, T); } template inline Foam::scalar -Foam::thermophysicalPropertiesSelector::Hf() const +Foam::thermophysicalPropertiesSelector::hf() const { - return propertiesPtr_->Hf(); + return propertiesPtr_->hf(); } template inline Foam::scalar -Foam::thermophysicalPropertiesSelector::Ha +Foam::thermophysicalPropertiesSelector::ha ( scalar p, scalar T ) const { - return propertiesPtr_->Ha(p, T); + return propertiesPtr_->ha(p, T); } @@ -157,37 +157,37 @@ Foam::thermophysicalPropertiesSelector::Cv template inline Foam::scalar -Foam::thermophysicalPropertiesSelector::Es +Foam::thermophysicalPropertiesSelector::es ( scalar p, scalar T ) const { - return propertiesPtr_->Es(p, T); + return propertiesPtr_->es(p, T); } template inline Foam::scalar -Foam::thermophysicalPropertiesSelector::Ea +Foam::thermophysicalPropertiesSelector::ea ( scalar p, scalar T ) const { - return propertiesPtr_->Ea(p, T); + return propertiesPtr_->ea(p, T); } template inline Foam::scalar -Foam::thermophysicalPropertiesSelector::S +Foam::thermophysicalPropertiesSelector::s ( scalar p, scalar T ) const { - return propertiesPtr_->S(p, T); + return propertiesPtr_->s(p, T); } diff --git a/test/multiphaseEuler/interfaceComposition/waterAndIsopropanolEvaporation/system/continuity b/test/multiphaseEuler/interfaceComposition/waterAndIsopropanolEvaporation/system/continuity index 89f647fd2d..c869b2374f 100644 --- a/test/multiphaseEuler/interfaceComposition/waterAndIsopropanolEvaporation/system/continuity +++ b/test/multiphaseEuler/interfaceComposition/waterAndIsopropanolEvaporation/system/continuity @@ -29,14 +29,7 @@ codeInclude { tmp ea(const rhoFluidThermo& thermo) { - tmp tEa = thermo.he() + thermo.hc(); - - if (thermo.he().name() == thermo.phasePropertyName("h")) - { - tEa.ref() -= thermo.p()/thermo.rho(); - } - - return tEa; + return thermo.ha() - thermo.p()/thermo.rho(); } } #}; diff --git a/test/multiphaseEuler/interfaceComposition/waterEvaporation/system/continuity b/test/multiphaseEuler/interfaceComposition/waterEvaporation/system/continuity index 89f647fd2d..c869b2374f 100644 --- a/test/multiphaseEuler/interfaceComposition/waterEvaporation/system/continuity +++ b/test/multiphaseEuler/interfaceComposition/waterEvaporation/system/continuity @@ -29,14 +29,7 @@ codeInclude { tmp ea(const rhoFluidThermo& thermo) { - tmp tEa = thermo.he() + thermo.hc(); - - if (thermo.he().name() == thermo.phasePropertyName("h")) - { - tEa.ref() -= thermo.p()/thermo.rho(); - } - - return tEa; + return thermo.ha() - thermo.p()/thermo.rho(); } } #}; diff --git a/test/multiphaseEuler/thermal/waterEvaporation/system/continuity b/test/multiphaseEuler/thermal/waterEvaporation/system/continuity index 7c2dd583e9..707668b4b9 100644 --- a/test/multiphaseEuler/thermal/waterEvaporation/system/continuity +++ b/test/multiphaseEuler/thermal/waterEvaporation/system/continuity @@ -29,14 +29,7 @@ codeInclude { tmp ea(const rhoFluidThermo& thermo) { - tmp tEa = thermo.he() + thermo.hc(); - - if (thermo.he().name() == thermo.phasePropertyName("h")) - { - tEa.ref() -= thermo.p()/thermo.rho(); - } - - return tEa; + return thermo.ha() - thermo.p()/thermo.rho(); } } #};