diff --git a/src/phaseSystemModels/multiphaseInter/compressibleMultiPhaseTurbulenceModels/compressibleMultiPhaseTurbulenceModels.C b/src/phaseSystemModels/multiphaseInter/compressibleMultiPhaseTurbulenceModels/compressibleMultiPhaseTurbulenceModels.C
index 5df5277cf1..a53f543289 100644
--- a/src/phaseSystemModels/multiphaseInter/compressibleMultiPhaseTurbulenceModels/compressibleMultiPhaseTurbulenceModels.C
+++ b/src/phaseSystemModels/multiphaseInter/compressibleMultiPhaseTurbulenceModels/compressibleMultiPhaseTurbulenceModels.C
@@ -79,6 +79,8 @@ makeBaseTurbulenceModel
#include "Stokes.H"
makeLaminarModel(Stokes);
+#include "generalizedNewtonian.H"
+makeLaminarModel(generalizedNewtonian);
// -------------------------------------------------------------------------- //
// RAS models
diff --git a/src/phaseSystemModels/reactingEuler/multiphaseSystem/Make/files b/src/phaseSystemModels/reactingEuler/multiphaseSystem/Make/files
index 063053cac4..e660904900 100644
--- a/src/phaseSystemModels/reactingEuler/multiphaseSystem/Make/files
+++ b/src/phaseSystemModels/reactingEuler/multiphaseSystem/Make/files
@@ -11,8 +11,6 @@ multiphaseSystem/multiphaseSystem.C
multiphaseSystem/multiphaseSystemNew.C
multiphaseSystem/multiphaseSystems.C
-reactionThermo/hRefConstThermos.C
-
diameter = diameterModels
$(diameter)/diameterModel/diameterModel.C
$(diameter)/constantDiameter/constantDiameter.C
diff --git a/src/phaseSystemModels/reactingEuler/multiphaseSystem/reactionThermo/hRefConstThermos.C b/src/phaseSystemModels/reactingEuler/multiphaseSystem/reactionThermo/hRefConstThermos.C
deleted file mode 100644
index 8cd582eb71..0000000000
--- a/src/phaseSystemModels/reactingEuler/multiphaseSystem/reactionThermo/hRefConstThermos.C
+++ /dev/null
@@ -1,351 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | www.openfoam.com
- \\/ M anipulation |
--------------------------------------------------------------------------------
- Copyright (C) 2015-2018 OpenFOAM Foundation
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 3 of the License, or
- (at your option) any later version.
-
- OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
- ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
- FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
- for more details.
-
- You should have received a copy of the GNU General Public License
- along with OpenFOAM. If not, see .
-
-\*---------------------------------------------------------------------------*/
-
-#include "makeReactionThermo.H"
-#include "makeThermo.H"
-
-#include "rhoReactionThermo.H"
-#include "heRhoThermo.H"
-
-#include "specie.H"
-#include "perfectGas.H"
-#include "rPolynomial.H"
-#include "perfectFluid.H"
-#include "rhoConst.H"
-
-#include "sensibleEnthalpy.H"
-
-#include "hRefConstThermo.H"
-#include "eRefConstThermo.H"
-
-#include "constTransport.H"
-
-#include "pureMixture.H"
-#include "multiComponentMixture.H"
-
-#include "thermoPhysicsTypes.H"
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-// Thermo type typedefs:
-
-typedef
-constTransport
-<
- species::thermo
- <
- hRefConstThermo
- <
- perfectGas
- >,
- sensibleEnthalpy
- >
-> constRefGasHThermoPhysics;
-
-typedef
-constTransport
-<
- species::thermo
- <
- hRefConstThermo
- <
- perfectFluid
- >,
- sensibleEnthalpy
- >
-> constRefFluidHThermoPhysics;
-
-typedef
-constTransport
-<
- species::thermo
- <
- hRefConstThermo
- <
- rPolynomial
- >,
- sensibleEnthalpy
- >
-> constRefrPolFluidHThermoPhysics;
-
-typedef
-constTransport
-<
- species::thermo
- <
- eRefConstThermo
- <
- perfectGas
- >,
- sensibleInternalEnergy
- >
-> constRefGasEThermoPhysics;
-
-typedef
-constTransport
-<
- species::thermo
- <
- eRefConstThermo
- <
- perfectFluid
- >,
- sensibleInternalEnergy
- >
-> constRefFluidEThermoPhysics;
-
-typedef
-constTransport
-<
- species::thermo
- <
- eRefConstThermo
- <
- rPolynomial
- >,
- sensibleInternalEnergy
- >
-> constRefrPolFluidEThermoPhysics;
-
-typedef
-constTransport
-<
- species::thermo
- <
- eRefConstThermo
- <
- rhoConst
- >,
- sensibleInternalEnergy
- >
-> constRefRhoConstEThermoPhysics;
-
-typedef
-constTransport
-<
- species::thermo
- <
- hRefConstThermo
- <
- rhoConst
- >,
- sensibleEnthalpy
- >
-> constRefRhoConstHThermoPhysics;
-
-
-// pureMixture, sensibleEnthalpy:
-
-makeThermos
-(
- rhoThermo,
- heRhoThermo,
- pureMixture,
- constTransport,
- sensibleEnthalpy,
- hRefConstThermo,
- perfectGas,
- specie
-);
-
-makeThermos
-(
- rhoThermo,
- heRhoThermo,
- pureMixture,
- constTransport,
- sensibleEnthalpy,
- hRefConstThermo,
- rPolynomial,
- specie
-);
-
-makeThermos
-(
- rhoThermo,
- heRhoThermo,
- pureMixture,
- constTransport,
- sensibleEnthalpy,
- hRefConstThermo,
- perfectFluid,
- specie
-);
-
-makeThermos
-(
- rhoThermo,
- heRhoThermo,
- pureMixture,
- constTransport,
- sensibleEnthalpy,
- hRefConstThermo,
- rhoConst,
- specie
-);
-
-
-// pureMixture, sensibleInternalEnergy:
-
-makeThermos
-(
- rhoThermo,
- heRhoThermo,
- pureMixture,
- constTransport,
- sensibleInternalEnergy,
- eRefConstThermo,
- perfectGas,
- specie
-);
-
-makeThermos
-(
- rhoThermo,
- heRhoThermo,
- pureMixture,
- constTransport,
- sensibleInternalEnergy,
- eRefConstThermo,
- rPolynomial,
- specie
-);
-
-makeThermos
-(
- rhoThermo,
- heRhoThermo,
- pureMixture,
- constTransport,
- sensibleInternalEnergy,
- eRefConstThermo,
- perfectFluid,
- specie
-);
-
-makeThermos
-(
- rhoThermo,
- heRhoThermo,
- pureMixture,
- constTransport,
- sensibleInternalEnergy,
- eRefConstThermo,
- rhoConst,
- specie
-);
-
-
-// multiComponentMixture, sensibleInternalEnergy:
-
-makeThermoPhysicsReactionThermos
-(
- rhoThermo,
- rhoReactionThermo,
- heRhoThermo,
- multiComponentMixture,
- constRefGasEThermoPhysics
-);
-
-makeThermoPhysicsReactionThermos
-(
- rhoThermo,
- rhoReactionThermo,
- heRhoThermo,
- multiComponentMixture,
- constRefFluidEThermoPhysics
-);
-
-makeThermoPhysicsReactionThermos
-(
- rhoThermo,
- rhoReactionThermo,
- heRhoThermo,
- multiComponentMixture,
- constRefrPolFluidEThermoPhysics
-);
-
-makeThermoPhysicsReactionThermos
-(
- rhoThermo,
- rhoReactionThermo,
- heRhoThermo,
- multiComponentMixture,
- constRefRhoConstEThermoPhysics
-);
-
-
-// multiComponentMixture, sensibleEnthalpy:
-
-makeThermoPhysicsReactionThermos
-(
- rhoThermo,
- rhoReactionThermo,
- heRhoThermo,
- multiComponentMixture,
- constRefRhoConstHThermoPhysics
-);
-
-makeThermoPhysicsReactionThermos
-(
- rhoThermo,
- rhoReactionThermo,
- heRhoThermo,
- multiComponentMixture,
- constRefFluidHThermoPhysics
-);
-
-makeThermoPhysicsReactionThermos
-(
- rhoThermo,
- rhoReactionThermo,
- heRhoThermo,
- multiComponentMixture,
- constRefrPolFluidHThermoPhysics
-);
-
-makeThermoPhysicsReactionThermos
-(
- rhoThermo,
- rhoReactionThermo,
- heRhoThermo,
- multiComponentMixture,
- constRefGasHThermoPhysics
-);
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// ************************************************************************* //
diff --git a/src/thermophysicalModels/basic/rhoThermo/rhoThermos.C b/src/thermophysicalModels/basic/rhoThermo/rhoThermos.C
index 1b964ba69c..915511a899 100644
--- a/src/thermophysicalModels/basic/rhoThermo/rhoThermos.C
+++ b/src/thermophysicalModels/basic/rhoThermo/rhoThermos.C
@@ -501,6 +501,18 @@ makeThermos
specie
);
+makeThermos
+(
+ rhoThermo,
+ heRhoThermo,
+ pureMixture,
+ constTransport,
+ sensibleInternalEnergy,
+ eConstThermo,
+ perfectGas,
+ specie
+);
+
makeThermos
(
rhoThermo,
diff --git a/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.C b/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.C
index e04253f520..cf823ca6ce 100644
--- a/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.C
+++ b/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.C
@@ -6,6 +6,7 @@
\\/ M anipulation |
-------------------------------------------------------------------------------
Copyright (C) 2011-2017 OpenFOAM Foundation
+ Copyright (C) 2020 OpenCFD Ltd.
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
@@ -35,7 +36,9 @@ Foam::eConstThermo::eConstThermo(const dictionary& dict)
:
EquationOfState(dict),
Cv_(dict.subDict("thermodynamics").get("Cv")),
- Hf_(dict.subDict("thermodynamics").get("Hf"))
+ Hf_(dict.subDict("thermodynamics").get("Hf")),
+ Tref_(dict.subDict("thermodynamics").getOrDefault("Tref", Tstd)),
+ Esref_(dict.subDict("thermodynamics").getOrDefault("Eref", 0))
{}
@@ -51,6 +54,8 @@ void Foam::eConstThermo::write(Ostream& os) const
os.beginBlock("thermodynamics");
os.writeEntry("Cv", Cv_);
os.writeEntry("Hf", Hf_);
+ os.writeEntryIfDifferent("Tref", Tstd, Tref_);
+ os.writeEntryIfDifferent("Eref", 0, Esref_);
os.endBlock();
}
}
diff --git a/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.H b/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.H
index 074b8d1c89..c06421a15b 100644
--- a/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.H
+++ b/src/thermophysicalModels/specie/thermo/eConst/eConstThermo.H
@@ -6,6 +6,7 @@
\\/ M anipulation |
-------------------------------------------------------------------------------
Copyright (C) 2011-2017 OpenFOAM Foundation
+ Copyright (C) 2020 OpenCFD Ltd.
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
@@ -101,6 +102,12 @@ class eConstThermo
// Note: input in [J/kg], but internally uses [J/kmol]
scalar Hf_;
+ //- Reference temperature around which to linearise [K]
+ scalar Tref_;
+
+ //- Reference sensible enthalpy around which to linearise [J/kg]
+ scalar Esref_;
+
// Private Member Functions
@@ -109,7 +116,9 @@ class eConstThermo
(
const EquationOfState& st,
const scalar cv,
- const scalar hf
+ const scalar hf,
+ const scalar Tref,
+ const scalar Esref
);
@@ -159,13 +168,14 @@ public:
//- Entropy [J/(kg K)]
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;
+
#include "EtoHthermo.H"
// Derivative term used for Jacobian
- //- Derivative of Gibbs free energy w.r.t. temperature
- inline scalar dGdT(const scalar p, const scalar T) const;
//- Temperature derivative of heat capacity at constant pressure
inline scalar dCpdT(const scalar p, const scalar T) const;
diff --git a/src/thermophysicalModels/specie/thermo/eConst/eConstThermoI.H b/src/thermophysicalModels/specie/thermo/eConst/eConstThermoI.H
index 9b74f81f05..518a326c2c 100644
--- a/src/thermophysicalModels/specie/thermo/eConst/eConstThermoI.H
+++ b/src/thermophysicalModels/specie/thermo/eConst/eConstThermoI.H
@@ -32,12 +32,16 @@ inline Foam::eConstThermo::eConstThermo
(
const EquationOfState& st,
const scalar cv,
- const scalar hf
+ const scalar hf,
+ const scalar Tref,
+ const scalar Esref
)
:
EquationOfState(st),
Cv_(cv),
- Hf_(hf)
+ Hf_(hf),
+ Tref_(Tref),
+ Esref_(Esref)
{}
@@ -52,7 +56,9 @@ inline Foam::eConstThermo::eConstThermo
:
EquationOfState(name, ct),
Cv_(ct.Cv_),
- Hf_(ct.Hf_)
+ Hf_(ct.Hf_),
+ Tref_(ct.Tref_),
+ Esref_(ct.Esref_)
{}
@@ -102,7 +108,7 @@ inline Foam::scalar Foam::eConstThermo::Es
const scalar T
) const
{
- return Cv_*T + EquationOfState::E(p, T);
+ return Cv_*(T - Tref_) + Esref_ + EquationOfState::E(p, T);
}
@@ -136,13 +142,14 @@ inline Foam::scalar Foam::eConstThermo::S
template
-inline Foam::scalar Foam::eConstThermo::dGdT
+inline Foam::scalar Foam::eConstThermo::Gstd
(
- const scalar p,
const scalar T
) const
{
- return 0;
+ return
+ Cv_*(T - Tref_) + Esref_ + Hc() + Pstd/EquationOfState::rho(Pstd, T)
+ - S(Pstd, T)*T;
}
@@ -153,6 +160,7 @@ inline Foam::scalar Foam::eConstThermo::dCpdT
const scalar T
) const
{
+ NotImplemented;
return 0;
}
@@ -175,6 +183,7 @@ inline void Foam::eConstThermo::operator+=
Cv_ = Y1*Cv_ + Y2*ct.Cv_;
Hf_ = Y1*Hf_ + Y2*ct.Hf_;
+ Esref_ = Y1*Esref_ + Y2*ct.Esref_;
}
}
@@ -200,7 +209,9 @@ inline Foam::eConstThermo Foam::operator+
(
eofs,
ct1.Cv_,
- ct1.Hf_
+ ct1.Hf_,
+ ct1.Tref_,
+ ct1.Esref_
);
}
else
@@ -211,7 +222,10 @@ inline Foam::eConstThermo Foam::operator+
ct1.Y()/eofs.Y()*ct1.Cv_
+ ct2.Y()/eofs.Y()*ct2.Cv_,
ct1.Y()/eofs.Y()*ct1.Hf_
- + ct2.Y()/eofs.Y()*ct2.Hf_
+ + ct2.Y()/eofs.Y()*ct2.Hf_,
+ ct1.Tref_,
+ ct1.Y()/eofs.Y()*ct1.Esref_
+ + ct2.Y()/eofs.Y()*ct2.Esref_
);
}
}
@@ -228,7 +242,9 @@ inline Foam::eConstThermo Foam::operator*
(
s*static_cast(ct),
ct.Cv_,
- ct.Hf_
+ ct.Hf_,
+ ct.Tref_,
+ ct.Esref_
);
}
@@ -252,7 +268,10 @@ inline Foam::eConstThermo Foam::operator==
ct2.Y()/eofs.Y()*ct2.Cv_
- ct1.Y()/eofs.Y()*ct1.Cv_,
ct2.Y()/eofs.Y()*ct2.Hf_
- - ct1.Y()/eofs.Y()*ct1.Hf_
+ - ct1.Y()/eofs.Y()*ct1.Hf_,
+ ct1.Tref_,
+ ct2.Y()/eofs.Y()*ct2.Esref_
+ - ct1.Y()/eofs.Y()*ct1.Esref_
);
}
diff --git a/src/thermophysicalModels/specie/thermo/eRefConst/eRefConstThermo.C b/src/thermophysicalModels/specie/thermo/eRefConst/eRefConstThermo.C
deleted file mode 100644
index be17e17351..0000000000
--- a/src/thermophysicalModels/specie/thermo/eRefConst/eRefConstThermo.C
+++ /dev/null
@@ -1,77 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | www.openfoam.com
- \\/ M anipulation |
--------------------------------------------------------------------------------
- Copyright (C) 2018 OpenFOAM Foundation
- Copyright (C) 2020 OpenCFD Ltd.
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 3 of the License, or
- (at your option) any later version.
-
- OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
- ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
- FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
- for more details.
-
- You should have received a copy of the GNU General Public License
- along with OpenFOAM. If not, see .
-
-\*---------------------------------------------------------------------------*/
-
-#include "eRefConstThermo.H"
-#include "IOstreams.H"
-
-// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
-
-template
-Foam::eRefConstThermo::eRefConstThermo(const dictionary& dict)
-:
- EquationOfState(dict),
- Cv_(readCoeff("Cv", dict)),
- Hf_(readCoeff("Hf", dict)),
- Tref_(readCoeff("Tref", dict)),
- Eref_(readCoeff("Eref", dict))
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
-
-template
-void Foam::eRefConstThermo::write(Ostream& os) const
-{
- EquationOfState::write(os);
-
- {
- os.beginBlock("thermodynamics");
- os.writeEntry("Cv", Cv_);
- os.writeEntry("Hf", Hf_);
- os.writeEntry("Tref", Tref_);
- os.writeEntry("Eref", Eref_);
- os.endBlock();
- }
-}
-
-
-// * * * * * * * * * * * * * * * Ostream Operator * * * * * * * * * * * * * //
-
-template
-Foam::Ostream& Foam::operator<<
-(
- Ostream& os,
- const eRefConstThermo& ct
-)
-{
- ct.write(os);
- return os;
-}
-
-
-// ************************************************************************* //
diff --git a/src/thermophysicalModels/specie/thermo/eRefConst/eRefConstThermo.H b/src/thermophysicalModels/specie/thermo/eRefConst/eRefConstThermo.H
deleted file mode 100644
index c009ccc3dc..0000000000
--- a/src/thermophysicalModels/specie/thermo/eRefConst/eRefConstThermo.H
+++ /dev/null
@@ -1,234 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | www.openfoam.com
- \\/ M anipulation |
--------------------------------------------------------------------------------
- Copyright (C) 2018 OpenFOAM Foundation
- Copyright (C) 2020 OpenCFD Ltd.
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 3 of the License, or
- (at your option) any later version.
-
- OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
- ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
- FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
- for more details.
-
- You should have received a copy of the GNU General Public License
- along with OpenFOAM. If not, see .
-
-Class
- Foam::eRefConstThermo
-
-Description
- Constant properties thermodynamics package
- templated into the EquationOfState.
-
-SourceFiles
- eRefConstThermoI.H
- eRefConstThermo.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef eRefConstThermo_H
-#define eRefConstThermo_H
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-// Forward Declarations
-
-template class eRefConstThermo;
-
-template
-inline eRefConstThermo operator+
-(
- const eRefConstThermo&,
- const eRefConstThermo&
-);
-
-template
-inline eRefConstThermo operator*
-(
- const scalar,
- const eRefConstThermo&
-);
-
-template
-inline eRefConstThermo operator==
-(
- const eRefConstThermo&,
- const eRefConstThermo&
-);
-
-template
-Ostream& operator<<
-(
- Ostream&,
- const eRefConstThermo&
-);
-
-
-/*---------------------------------------------------------------------------*\
- Class eRefConstThermo Declaration
-\*---------------------------------------------------------------------------*/
-
-template
-class eRefConstThermo
-:
- public EquationOfState
-{
- // Private Data
-
- scalar Cv_;
- scalar Hf_;
- scalar Tref_;
- scalar Eref_;
-
-
- // Private Member Functions
-
- //- Read coefficient from "thermodynamics" sub-dictionary
- inline scalar readCoeff(const word& key, const dictionary& dict)
- {
- return dict.subDict("thermodynamics").get(key);
- }
-
-
- //- Construct from components
- inline eRefConstThermo
- (
- const EquationOfState& st,
- const scalar cv,
- const scalar hf,
- const scalar tref,
- const scalar eref
- );
-
-
-public:
-
- // Constructors
-
- //- Construct from dictionary
- eRefConstThermo(const dictionary& dict);
-
- //- Construct as named copy
- inline eRefConstThermo(const word&, const eRefConstThermo&);
-
- //- Construct and return a clone
- inline autoPtr clone() const;
-
- //- Selector from dictionary
- inline static autoPtr New(const dictionary& dict);
-
-
- // Member Functions
-
- //- Return the instantiated type name
- static word typeName()
- {
- return "eRefConst<" + EquationOfState::typeName() + '>';
- }
-
- //- Limit temperature to be within the range
- inline scalar limit(const scalar T) const;
-
-
- // Fundamental properties
-
- //- 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;
-
- //- Absolute internal energy [J/kg]
- inline scalar Ea(const scalar p, const scalar T) const;
-
- //- Chemical enthalpy [J/kg]
- inline scalar Hc() const;
-
- //- Entropy [J/(kg K)]
- inline scalar S(const scalar p, const scalar T) const;
-
- #include "EtoHthermo.H"
-
-
- // Derivative term used for Jacobian
-
- //- Derivative of Gibbs free energy w.r.t. temperature
- inline scalar dGdT(const scalar p, const scalar T) const;
-
- //- Temperature derivative of heat capacity at constant pressure
- inline scalar dCpdT(const scalar p, const scalar T) const;
-
-
- // I-O
-
- //- Write to Ostream
- void write(Ostream& os) const;
-
-
- // Member operators
-
- inline void operator+=(const eRefConstThermo&);
-
-
- // Friend operators
-
- friend eRefConstThermo operator+
- (
- const eRefConstThermo&,
- const eRefConstThermo&
- );
-
- friend eRefConstThermo operator*
- (
- const scalar,
- const eRefConstThermo&
- );
-
- friend eRefConstThermo operator==
- (
- const eRefConstThermo&,
- const eRefConstThermo&
- );
-
-
- // IOstream Operators
-
- friend Ostream& operator<<
- (
- Ostream&,
- const eRefConstThermo&
- );
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#include "eRefConstThermoI.H"
-
-#ifdef NoRepository
- #include "eRefConstThermo.C"
-#endif
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/src/thermophysicalModels/specie/thermo/eRefConst/eRefConstThermoI.H b/src/thermophysicalModels/specie/thermo/eRefConst/eRefConstThermoI.H
deleted file mode 100644
index 1d9e0e7d43..0000000000
--- a/src/thermophysicalModels/specie/thermo/eRefConst/eRefConstThermoI.H
+++ /dev/null
@@ -1,276 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | www.openfoam.com
- \\/ M anipulation |
--------------------------------------------------------------------------------
- Copyright (C) 2018 OpenFOAM Foundation
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 3 of the License, or
- (at your option) any later version.
-
- OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
- ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
- FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
- for more details.
-
- You should have received a copy of the GNU General Public License
- along with OpenFOAM. If not, see .
-
-\*---------------------------------------------------------------------------*/
-
-// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * //
-
-template
-inline Foam::eRefConstThermo::eRefConstThermo
-(
- const EquationOfState& st,
- const scalar cv,
- const scalar hf,
- const scalar tref,
- const scalar eref
-)
-:
- EquationOfState(st),
- Cv_(cv),
- Hf_(hf),
- Tref_(tref),
- Eref_(eref)
-{}
-
-
-// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
-
-template
-inline Foam::eRefConstThermo::eRefConstThermo
-(
- const word& name,
- const eRefConstThermo& ct
-)
-:
- EquationOfState(name, ct),
- Cv_(ct.Cv_),
- Hf_(ct.Hf_),
- Tref_(ct.Tref_),
- Eref_(ct.Eref_)
-{}
-
-
-template
-inline Foam::autoPtr>
-Foam::eRefConstThermo::clone() const
-{
- return autoPtr>
- (
- new eRefConstThermo(*this)
- );
-}
-
-
-template
-inline Foam::autoPtr>
-Foam::eRefConstThermo::New(const dictionary& dict)
-{
- return autoPtr>
- (
- new eRefConstThermo(dict)
- );
-}
-
-
-// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
-
-template
-inline Foam::scalar Foam::eRefConstThermo::limit
-(
- const scalar T
-) const
-{
- return T;
-}
-
-
-template
-inline Foam::scalar Foam::eRefConstThermo::Cv
-(
- const scalar p,
- const scalar T
-) const
-{
- return Cv_ + EquationOfState::Cv(p, T);
-}
-
-
-template
-inline Foam::scalar Foam::eRefConstThermo::Es
-(
- const scalar p, const scalar T
-) const
-{
- return Cv_*(T - Tref_) + Eref_ + EquationOfState::E(p, T);
-}
-
-
-template
-inline Foam::scalar Foam::eRefConstThermo::Hc() const
-{
- return Hf_;
-}
-
-
-template
-inline Foam::scalar Foam::eRefConstThermo::Ea
-(
- const scalar p, const scalar T
-) const
-{
- return Es(p, T) + Hc();
-}
-
-
-template
-inline Foam::scalar Foam::eRefConstThermo::S
-(
- const scalar p, const scalar T
-) const
-{
- return Cp(p, T)*log(T/Tstd) + EquationOfState::S(p, T);
-}
-
-
-template
-inline Foam::scalar Foam::eRefConstThermo::dGdT
-(
- const scalar p, const scalar T
-) const
-{
- return 0;
-}
-
-
-template
-inline Foam::scalar Foam::eRefConstThermo::dCpdT
-(
- const scalar p, const scalar T
-) const
-{
- return 0;
-}
-
-
-// * * * * * * * * * * * * * * * Member Operators * * * * * * * * * * * * * //
-
-template
-inline void Foam::eRefConstThermo::operator+=
-(
- const eRefConstThermo& ct
-)
-{
- scalar Y1 = this->Y();
-
- EquationOfState::operator+=(ct);
-
- if (mag(this->Y()) > SMALL)
- {
- Y1 /= this->Y();
- const scalar Y2 = ct.Y()/this->Y();
-
- Cv_ = Y1*Cv_ + Y2*ct.Cv_;
- Hf_ = Y1*Hf_ + Y2*ct.Hf_;
- }
-}
-
-
-// * * * * * * * * * * * * * * * Friend Operators * * * * * * * * * * * * * //
-
-template
-inline Foam::eRefConstThermo Foam::operator+
-(
- const eRefConstThermo& ct1,
- const eRefConstThermo& ct2
-)
-{
- EquationOfState eofs
- (
- static_cast(ct1)
- + static_cast(ct2)
- );
-
- if (mag(eofs.Y()) < SMALL)
- {
- return eRefConstThermo
- (
- eofs,
- ct1.Cv_,
- ct1.Hf_,
- ct1.Tref_,
- ct1.Eref_
- );
- }
- else
- {
- return eRefConstThermo
- (
- 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.Tref_
- + ct2.Y()/eofs.Y()*ct2.Tref_,
- ct1.Y()/eofs.Y()*ct1.Eref_
- + ct2.Y()/eofs.Y()*ct2.Eref_
- );
- }
-}
-
-
-template
-inline Foam::eRefConstThermo Foam::operator*
-(
- const scalar s,
- const eRefConstThermo& ct
-)
-{
- return eRefConstThermo
- (
- s*static_cast(ct),
- ct.Cv_,
- ct.Hf_,
- ct.Tref_,
- ct.Eref_
- );
-}
-
-
-template
-inline Foam::eRefConstThermo Foam::operator==
-(
- const eRefConstThermo& ct1,
- const eRefConstThermo& ct2
-)
-{
- EquationOfState eofs
- (
- static_cast(ct1)
- == static_cast(ct2)
- );
-
- return eRefConstThermo
- (
- 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_
- );
-}
-
-
-// ************************************************************************* //
diff --git a/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.C b/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.C
index 5ad1e9a7e0..93bdc53549 100644
--- a/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.C
+++ b/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.C
@@ -6,6 +6,7 @@
\\/ M anipulation |
-------------------------------------------------------------------------------
Copyright (C) 2011-2017 OpenFOAM Foundation
+ Copyright (C) 2020 OpenCFD Ltd.
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
@@ -35,7 +36,9 @@ Foam::hConstThermo::hConstThermo(const dictionary& dict)
:
EquationOfState(dict),
Cp_(dict.subDict("thermodynamics").get("Cp")),
- Hf_(dict.subDict("thermodynamics").get("Hf"))
+ Hf_(dict.subDict("thermodynamics").get("Hf")),
+ Tref_(dict.subDict("thermodynamics").getOrDefault("Tref", Tstd)),
+ Hsref_(dict.subDict("thermodynamics").getOrDefault("Href", 0))
{}
@@ -51,6 +54,8 @@ void Foam::hConstThermo::write(Ostream& os) const
os.beginBlock("thermodynamics");
os.writeEntry("Cp", Cp_);
os.writeEntry("Hf", Hf_);
+ os.writeEntryIfDifferent("Tref", Tstd, Tref_);
+ os.writeEntryIfDifferent("Href", 0, Hsref_);
os.endBlock();
}
}
diff --git a/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.H b/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.H
index 508efec076..81045c8033 100644
--- a/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.H
+++ b/src/thermophysicalModels/specie/thermo/hConst/hConstThermo.H
@@ -6,6 +6,7 @@
\\/ M anipulation |
-------------------------------------------------------------------------------
Copyright (C) 2011-2017 OpenFOAM Foundation
+ Copyright (C) 2020 OpenCFD Ltd.
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
@@ -94,6 +95,12 @@ class hConstThermo
scalar Cp_;
scalar Hf_;
+ //- Reference temperature
+ scalar Tref_;
+
+ //- Reference sensible enthalpy
+ scalar Hsref_;
+
// Private Member Functions
@@ -102,7 +109,9 @@ class hConstThermo
(
const EquationOfState& st,
const scalar cp,
- const scalar hf
+ const scalar hf,
+ const scalar Tref,
+ const scalar Href
);
@@ -152,13 +161,14 @@ public:
//- Entropy [J/(kg K)]
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;
+
#include "HtoEthermo.H"
// Derivative term used for Jacobian
- //- Derivative of Gibbs free energy w.r.t. temperature
- inline scalar dGdT(const scalar p, const scalar T) const;
//- Temperature derivative of heat capacity at constant pressure
inline scalar dCpdT(const scalar p, const scalar T) const;
diff --git a/src/thermophysicalModels/specie/thermo/hConst/hConstThermoI.H b/src/thermophysicalModels/specie/thermo/hConst/hConstThermoI.H
index 2103d66fd8..7210c36afe 100644
--- a/src/thermophysicalModels/specie/thermo/hConst/hConstThermoI.H
+++ b/src/thermophysicalModels/specie/thermo/hConst/hConstThermoI.H
@@ -32,12 +32,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)
{}
@@ -52,7 +56,9 @@ inline Foam::hConstThermo::hConstThermo
:
EquationOfState(name, ct),
Cp_(ct.Cp_),
- Hf_(ct.Hf_)
+ Hf_(ct.Hf_),
+ Tref_(ct.Tref_),
+ Hsref_(ct.Hsref_)
{}
@@ -111,7 +117,7 @@ inline Foam::scalar Foam::hConstThermo::Hs
const scalar p, const scalar T
) const
{
- return Cp_*T + EquationOfState::H(p, T);
+ return Cp_*(T - Tref_) + Hsref_ + EquationOfState::H(p, T);
}
@@ -133,12 +139,12 @@ inline Foam::scalar Foam::hConstThermo::S
template
-inline Foam::scalar Foam::hConstThermo::dGdT
+inline Foam::scalar Foam::hConstThermo::Gstd
(
- const scalar p, const scalar T
+ const scalar T
) const
{
- return 0;
+ return Cp_*(T - Tref_) + Hsref_ + Hc() - Cp_*T*log(T/Tstd);
}
@@ -170,6 +176,7 @@ inline void Foam::hConstThermo::operator+=
Cp_ = Y1*Cp_ + Y2*ct.Cp_;
Hf_ = Y1*Hf_ + Y2*ct.Hf_;
+ Hsref_ = Y1*Hsref_ + Y2*ct.Hsref_;
}
}
@@ -195,7 +202,9 @@ inline Foam::hConstThermo Foam::operator+
(
eofs,
ct1.Cp_,
- ct1.Hf_
+ ct1.Hf_,
+ ct1.Tref_,
+ ct1.Hsref_
);
}
else
@@ -206,7 +215,10 @@ inline Foam::hConstThermo Foam::operator+
ct1.Y()/eofs.Y()*ct1.Cp_
+ ct2.Y()/eofs.Y()*ct2.Cp_,
ct1.Y()/eofs.Y()*ct1.Hf_
- + ct2.Y()/eofs.Y()*ct2.Hf_
+ + ct2.Y()/eofs.Y()*ct2.Hf_,
+ ct1.Tref_,
+ ct1.Y()/eofs.Y()*ct1.Hsref_
+ + ct2.Y()/eofs.Y()*ct2.Hsref_
);
}
}
@@ -223,7 +235,9 @@ inline Foam::hConstThermo Foam::operator*
(
s*static_cast(ct),
ct.Cp_,
- ct.Hf_
+ ct.Hf_,
+ ct.Tref_,
+ ct.Hsref_
);
}
@@ -247,7 +261,10 @@ inline Foam::hConstThermo Foam::operator==
ct2.Y()/eofs.Y()*ct2.Cp_
- ct1.Y()/eofs.Y()*ct1.Cp_,
ct2.Y()/eofs.Y()*ct2.Hf_
- - ct1.Y()/eofs.Y()*ct1.Hf_
+ - ct1.Y()/eofs.Y()*ct1.Hf_,
+ ct1.Tref_,
+ ct2.Y()/eofs.Y()*ct2.Hsref_
+ - ct1.Y()/eofs.Y()*ct1.Hsref_
);
}
diff --git a/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.C b/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.C
index 95c13b1de0..dc83092428 100644
--- a/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.C
+++ b/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.C
@@ -6,6 +6,7 @@
\\/ M anipulation |
-------------------------------------------------------------------------------
Copyright (C) 2011-2017 OpenFOAM Foundation
+ Copyright (C) 2020 OpenCFD Ltd.
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
diff --git a/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.H b/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.H
index 7ab292c1b2..6bbd98159c 100644
--- a/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.H
+++ b/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermo.H
@@ -212,14 +212,15 @@ public:
//- Entropy [J/(kg K)]
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;
+
#include "HtoEthermo.H"
// Derivative term used for Jacobian
- //- Derivative of Gibbs free energy w.r.t. temperature
- inline scalar dGdT(const scalar p, const scalar T) const;
//- Temperature derivative of heat capacity at constant pressure
inline scalar dCpdT(const scalar p, const scalar T) const;
diff --git a/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermoI.H b/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermoI.H
index 3fb36c86d7..8f41531e36 100644
--- a/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermoI.H
+++ b/src/thermophysicalModels/specie/thermo/hPolynomial/hPolynomialThermoI.H
@@ -6,6 +6,7 @@
\\/ M anipulation |
-------------------------------------------------------------------------------
Copyright (C) 2011-2017 OpenFOAM Foundation
+ Copyright (C) 2020 OpenCFD Ltd.
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
@@ -129,18 +130,12 @@ inline Foam::scalar Foam::hPolynomialThermo::S
template
-inline Foam::scalar Foam::hPolynomialThermo::dGdT
+inline Foam::scalar Foam::hPolynomialThermo::Gstd
(
- const scalar p,
const scalar T
) const
{
- return
- (
- hCoeffs_.derivative(T)
- - T*sCoeffs_.derivative(T)
- - sCoeffs_.value(T)
- );
+ return hCoeffs_.value(T) - sCoeffs_.value(T)*T;
}
diff --git a/src/thermophysicalModels/specie/thermo/hPower/hPowerThermo.H b/src/thermophysicalModels/specie/thermo/hPower/hPowerThermo.H
index e2479283b6..57e857ff8e 100644
--- a/src/thermophysicalModels/specie/thermo/hPower/hPowerThermo.H
+++ b/src/thermophysicalModels/specie/thermo/hPower/hPowerThermo.H
@@ -6,6 +6,7 @@
\\/ M anipulation |
-------------------------------------------------------------------------------
Copyright (C) 2012-2017 OpenFOAM Foundation
+ Copyright (C) 2020 OpenCFD Ltd.
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
@@ -173,14 +174,15 @@ public:
//- Entropy [J/(kg K)]
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;
+
#include "HtoEthermo.H"
// Derivative term used for Jacobian
- //- Derivative of Gibbs free energy w.r.t. temperature
- inline scalar dGdT(const scalar p, const scalar T) const;
//- Temperature derivative of heat capacity at constant pressure
inline scalar dCpdT(const scalar p, const scalar T) const;
diff --git a/src/thermophysicalModels/specie/thermo/hPower/hPowerThermoI.H b/src/thermophysicalModels/specie/thermo/hPower/hPowerThermoI.H
index f97ae97671..fec051ca85 100644
--- a/src/thermophysicalModels/specie/thermo/hPower/hPowerThermoI.H
+++ b/src/thermophysicalModels/specie/thermo/hPower/hPowerThermoI.H
@@ -6,6 +6,7 @@
\\/ M anipulation |
-------------------------------------------------------------------------------
Copyright (C) 2012-2017 OpenFOAM Foundation
+ Copyright (C) 2020 OpenCFD Ltd.
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
@@ -161,14 +162,15 @@ inline Foam::scalar Foam::hPowerThermo::S
template
-inline Foam::scalar Foam::hPowerThermo::dGdT
+inline Foam::scalar Foam::hPowerThermo::Gstd
(
- const scalar p, const scalar T
+ const scalar T
) const
{
- // To be implemented
- NotImplemented;
- return 0;
+ return
+ c0_*(pow(T, n0_ + 1) - pow(Tstd, n0_ + 1))/(pow(Tref_, n0_)*(n0_ + 1))
+ + Hc()
+ - c0_*(pow(T, n0_) - pow(Tstd, n0_))*T/(pow(Tref_, n0_)*n0_);
}
diff --git a/src/thermophysicalModels/specie/thermo/hRefConst/hRefConstThermo.C b/src/thermophysicalModels/specie/thermo/hRefConst/hRefConstThermo.C
deleted file mode 100644
index 9ed932eb47..0000000000
--- a/src/thermophysicalModels/specie/thermo/hRefConst/hRefConstThermo.C
+++ /dev/null
@@ -1,77 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | www.openfoam.com
- \\/ M anipulation |
--------------------------------------------------------------------------------
- Copyright (C) 2015-2017 OpenFOAM Foundation
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 3 of the License, or
- (at your option) any later version.
-
- OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
- ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
- FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
- for more details.
-
- You should have received a copy of the GNU General Public License
- along with OpenFOAM. If not, see .
-
-\*---------------------------------------------------------------------------*/
-
-#include "hRefConstThermo.H"
-#include "IOstreams.H"
-
-// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
-
-template
-Foam::hRefConstThermo::hRefConstThermo(const dictionary& dict)
-:
- EquationOfState(dict),
- Cp_(dict.subDict("thermodynamics").get("Cp")),
- Hf_(dict.subDict("thermodynamics").get("Hf")),
- Tref_(dict.subDict("thermodynamics").get("Tref")),
- Href_(dict.subDict("thermodynamics").get("Href"))
-{}
-
-
-// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
-
-template
-void Foam::hRefConstThermo::write(Ostream& os) const
-{
- EquationOfState::write(os);
-
- // Entries in dictionary format
- {
- os.beginBlock("thermodynamics");
- os.writeEntry("Cp", Cp_);
- os.writeEntry("Hf", Hf_);
- os.writeEntry("Tref", Tref_);
- os.writeEntry("Href", Href_);
- os.endBlock();
- }
-}
-
-
-// * * * * * * * * * * * * * * * Ostream Operator * * * * * * * * * * * * * //
-
-template
-Foam::Ostream& Foam::operator<<
-(
- Ostream& os,
- const hRefConstThermo& ct
-)
-{
- ct.write(os);
- return os;
-}
-
-
-// ************************************************************************* //
diff --git a/src/thermophysicalModels/specie/thermo/hRefConst/hRefConstThermo.H b/src/thermophysicalModels/specie/thermo/hRefConst/hRefConstThermo.H
deleted file mode 100644
index 16351f452c..0000000000
--- a/src/thermophysicalModels/specie/thermo/hRefConst/hRefConstThermo.H
+++ /dev/null
@@ -1,229 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | www.openfoam.com
- \\/ M anipulation |
--------------------------------------------------------------------------------
- Copyright (C) 2015-2017 OpenFOAM Foundation
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 3 of the License, or
- (at your option) any later version.
-
- OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
- ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
- FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
- for more details.
-
- You should have received a copy of the GNU General Public License
- along with OpenFOAM. If not, see .
-
-Class
- Foam::hRefConstThermo
-
-Group
- grpSpecieThermo
-
-Description
- Constant properties thermodynamics package
- templated into the EquationOfState.
-
-SourceFiles
- hRefConstThermoI.H
- hRefConstThermo.C
-
-\*---------------------------------------------------------------------------*/
-
-#ifndef hRefConstThermo_H
-#define hRefConstThermo_H
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-namespace Foam
-{
-
-// Forward declaration of friend functions and operators
-
-template class hRefConstThermo;
-
-template
-inline hRefConstThermo operator+
-(
- const hRefConstThermo&,
- const hRefConstThermo&
-);
-
-template
-inline hRefConstThermo operator*
-(
- const scalar,
- const hRefConstThermo&
-);
-
-template
-inline hRefConstThermo operator==
-(
- const hRefConstThermo&,
- const hRefConstThermo&
-);
-
-template
-Ostream& operator<<
-(
- Ostream&,
- const hRefConstThermo&
-);
-
-
-/*---------------------------------------------------------------------------*\
- Class hRefConstThermo Declaration
-\*---------------------------------------------------------------------------*/
-
-template
-class hRefConstThermo
-:
- public EquationOfState
-{
- // Private Data
-
- scalar Cp_;
- scalar Hf_;
- scalar Tref_;
- scalar Href_;
-
-
- // Private Member Functions
-
- //- Construct from components
- inline hRefConstThermo
- (
- const EquationOfState& st,
- const scalar cp,
- const scalar hf,
- const scalar tref,
- const scalar href
- );
-
-
-public:
-
- // Constructors
-
- //- Construct from dictionary
- hRefConstThermo(const dictionary& dict);
-
- //- Construct as named copy
- inline hRefConstThermo(const word&, const hRefConstThermo&);
-
- //- Construct and return a clone
- inline autoPtr clone() const;
-
- //- Selector from dictionary
- inline static autoPtr New(const dictionary& dict);
-
-
- // Member Functions
-
- //- Return the instantiated type name
- static word typeName()
- {
- return "hRefConst<" + EquationOfState::typeName() + '>';
- }
-
- //- Limit temperature to be within the range
- inline scalar limit(const scalar T) const;
-
-
- // Fundamental properties
-
- //- Heat capacity at constant pressure [J/(kg K)]
- inline scalar Cp(const scalar p, const scalar T) const;
-
- //- Absolute Enthalpy [J/kg]
- inline scalar Ha(const scalar p, const scalar T) const;
-
- //- Sensible enthalpy [J/kg]
- inline scalar Hs(const scalar p, const scalar T) const;
-
- //- Chemical enthalpy [J/kg]
- inline scalar Hc() const;
-
- //- Entropy [J/(kg K)]
- inline scalar S(const scalar p, const scalar T) const;
-
- #include "HtoEthermo.H"
-
-
- // Derivative term used for Jacobian
-
- //- Derivative of Gibbs free energy w.r.t. temperature
- inline scalar dGdT(const scalar p, const scalar T) const;
-
- //- Temperature derivative of heat capacity at constant pressure
- inline scalar dCpdT(const scalar p, const scalar T) const;
-
-
- // I-O
-
- //- Write to Ostream
- void write(Ostream& os) const;
-
-
- // Member operators
-
- inline void operator+=(const hRefConstThermo&);
-
-
- // Friend operators
-
- friend hRefConstThermo operator+
- (
- const hRefConstThermo&,
- const hRefConstThermo&
- );
-
- friend hRefConstThermo operator*
- (
- const scalar,
- const hRefConstThermo&
- );
-
- friend hRefConstThermo operator==
- (
- const hRefConstThermo&,
- const hRefConstThermo&
- );
-
-
- // IOstream Operators
-
- friend Ostream& operator<<
- (
- Ostream&,
- const hRefConstThermo&
- );
-};
-
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-} // End namespace Foam
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#include "hRefConstThermoI.H"
-
-#ifdef NoRepository
- #include "hRefConstThermo.C"
-#endif
-
-// * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * * //
-
-#endif
-
-// ************************************************************************* //
diff --git a/src/thermophysicalModels/specie/thermo/hRefConst/hRefConstThermoI.H b/src/thermophysicalModels/specie/thermo/hRefConst/hRefConstThermoI.H
deleted file mode 100644
index d2592d629c..0000000000
--- a/src/thermophysicalModels/specie/thermo/hRefConst/hRefConstThermoI.H
+++ /dev/null
@@ -1,270 +0,0 @@
-/*---------------------------------------------------------------------------*\
- ========= |
- \\ / F ield | OpenFOAM: The Open Source CFD Toolbox
- \\ / O peration |
- \\ / A nd | www.openfoam.com
- \\/ M anipulation |
--------------------------------------------------------------------------------
- Copyright (C) 2015-2017 OpenFOAM Foundation
--------------------------------------------------------------------------------
-License
- This file is part of OpenFOAM.
-
- OpenFOAM is free software: you can redistribute it and/or modify it
- under the terms of the GNU General Public License as published by
- the Free Software Foundation, either version 3 of the License, or
- (at your option) any later version.
-
- OpenFOAM is distributed in the hope that it will be useful, but WITHOUT
- ANY WARRANTY; without even the implied warranty of MERCHANTABILITY or
- FITNESS FOR A PARTICULAR PURPOSE. See the GNU General Public License
- for more details.
-
- You should have received a copy of the GNU General Public License
- along with OpenFOAM. If not, see .
-
-\*---------------------------------------------------------------------------*/
-
-// * * * * * * * * * * * * * Private Member Functions * * * * * * * * * * * //
-
-template
-inline Foam::hRefConstThermo::hRefConstThermo
-(
- const EquationOfState& st,
- const scalar cp,
- const scalar hf,
- const scalar tref,
- const scalar href
-)
-:
- EquationOfState(st),
- Cp_(cp),
- Hf_(hf),
- Tref_(tref),
- Href_(href)
-{}
-
-
-// * * * * * * * * * * * * * * * * Constructors * * * * * * * * * * * * * * //
-
-template
-inline Foam::hRefConstThermo::hRefConstThermo
-(
- const word& name,
- const hRefConstThermo& ct
-)
-:
- EquationOfState(name, ct),
- Cp_(ct.Cp_),
- Hf_(ct.Hf_),
- Tref_(ct.Tref_),
- Href_(ct.Href_)
-{}
-
-
-template
-inline Foam::autoPtr>
-Foam::hRefConstThermo::clone() const
-{
- return autoPtr>::New(*this);
-}
-
-
-template
-inline Foam::autoPtr>
-Foam::hRefConstThermo::New(const dictionary& dict)
-{
- return autoPtr>::New(dict);
-}
-
-
-// * * * * * * * * * * * * * * * Member Functions * * * * * * * * * * * * * //
-
-template
-inline Foam::scalar Foam::hRefConstThermo::limit
-(
- const scalar T
-) const
-{
- return T;
-}
-
-
-template
-inline Foam::scalar Foam::hRefConstThermo::Cp
-(
- const scalar p,
- const scalar T
-) const
-{
- return Cp_ + EquationOfState::Cp(p, T);
-}
-
-
-template
-inline Foam::scalar Foam::hRefConstThermo::Ha
-(
- const scalar p, const scalar T
-) const
-{
- return Hs(p, T) + Hc();
-}
-
-
-template
-inline Foam::scalar Foam::hRefConstThermo::Hs
-(
- const scalar p, const scalar T
-) const
-{
- return Cp_*(T-Tref_) + Href_ + EquationOfState::H(p, T);
-}
-
-
-template
-inline Foam::scalar Foam::hRefConstThermo::Hc() const
-{
- return Hf_;
-}
-
-
-template
-inline Foam::scalar Foam::hRefConstThermo::S
-(
- const scalar p, const scalar T
-) const
-{
- return Cp_*log(T/Tstd) + EquationOfState::S(p, T);
-}
-
-
-template
-inline Foam::scalar Foam::hRefConstThermo::dGdT
-(
- const scalar p, const scalar T
-) const
-{
- return 0;
-}
-
-
-template
-inline Foam::scalar Foam::hRefConstThermo::dCpdT
-(
- const scalar p, const scalar T
-) const
-{
- return 0;
-}
-
-
-// * * * * * * * * * * * * * * * Member Operators * * * * * * * * * * * * * //
-
-template
-inline void Foam::hRefConstThermo::operator+=
-(
- const hRefConstThermo& ct
-)
-{
- scalar Y1 = this->Y();
-
- EquationOfState::operator+=(ct);
-
- if (mag(this->Y()) > SMALL)
- {
- Y1 /= this->Y();
- const scalar Y2 = ct.Y()/this->Y();
-
- Cp_ = Y1*Cp_ + Y2*ct.Cp_;
- Hf_ = Y1*Hf_ + Y2*ct.Hf_;
- }
-}
-
-
-// * * * * * * * * * * * * * * * Friend Operators * * * * * * * * * * * * * //
-
-template
-inline Foam::hRefConstThermo Foam::operator+
-(
- const hRefConstThermo& ct1,
- const hRefConstThermo& ct2
-)
-{
- EquationOfState eofs
- (
- static_cast(ct1)
- + static_cast(ct2)
- );
-
- if (mag(eofs.Y()) < SMALL)
- {
- return hRefConstThermo
- (
- eofs,
- ct1.Cp_,
- ct1.Hf_,
- ct1.Tref_,
- ct1.Href_
- );
- }
- else
- {
- return hRefConstThermo
- (
- 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.Tref_
- + ct2.Y()/eofs.Y()*ct2.Tref_,
- ct1.Y()/eofs.Y()*ct1.Href_
- + ct2.Y()/eofs.Y()*ct2.Href_
- );
- }
-}
-
-
-template
-inline Foam::hRefConstThermo Foam::operator*
-(
- const scalar s,
- const hRefConstThermo& ct
-)
-{
- return hRefConstThermo
- (
- s*static_cast(ct),
- ct.Cp_,
- ct.Hf_,
- ct.Tref_,
- ct.Href_
- );
-}
-
-
-template
-inline Foam::hRefConstThermo Foam::operator==
-(
- const hRefConstThermo& ct1,
- const hRefConstThermo& ct2
-)
-{
- EquationOfState eofs
- (
- static_cast(ct1)
- == static_cast(ct2)
- );
-
- return hRefConstThermo
- (
- 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_
- );
-}
-
-
-// ************************************************************************* //
diff --git a/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermo.H b/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermo.H
index 9aa40bd719..7013f18e57 100644
--- a/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermo.H
+++ b/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermo.H
@@ -112,9 +112,6 @@ class hTabulatedThermo
//- Specific heat at constant pressure table [J/kg/K]
integratedNonUniformTable Cp_;
- //- Enthalphy uniform table;
- //nonUniformTable hCoeffs_;
-
public:
@@ -157,15 +154,15 @@ public:
//- Entropy [J/kg/K]
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;
+
#include "HtoEthermo.H"
// Derivative term used for Jacobian
- //- Derivative of Gibbs free energy w.r.t. temperature
- inline scalar dGdT(const scalar p, const scalar T) const;
-
//- Temperature derivative of heat capacity at constant pressure
inline scalar dCpdT(const scalar p, const scalar T) const;
diff --git a/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermoI.H b/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermoI.H
index 4975a3e71e..4f06031ca5 100644
--- a/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermoI.H
+++ b/src/thermophysicalModels/specie/thermo/hTabulated/hTabulatedThermoI.H
@@ -108,26 +108,15 @@ inline Foam::scalar Foam::hTabulatedThermo::S
template
-inline Foam::scalar Foam::hTabulatedThermo::dGdT
+inline Foam::scalar Foam::hTabulatedThermo::Gstd
(
- const scalar p,
const scalar T
) const
{
- return 0;
+ return Cp_.intfdT(Pstd, T) + Hf_ - (Cp_.intfByTdT(Pstd, T) + Sf_)*T;
}
-// template
-// inline Foam::scalar Foam::hTabulatedThermo::Gstd
-// (
-// const scalar T
-// ) const
-// {
-// return Cp_.intfdT(Pstd, T) + Hf_ - (Cp_.intfByTdT(Pstd, T) + Sf_)*T;
-// }
-
-
template
inline Foam::scalar Foam::hTabulatedThermo::dCpdT
(
diff --git a/src/thermophysicalModels/specie/thermo/janaf/janafThermo.H b/src/thermophysicalModels/specie/thermo/janaf/janafThermo.H
index 72661d11bd..06309af536 100644
--- a/src/thermophysicalModels/specie/thermo/janaf/janafThermo.H
+++ b/src/thermophysicalModels/specie/thermo/janaf/janafThermo.H
@@ -6,6 +6,7 @@
\\/ M anipulation |
-------------------------------------------------------------------------------
Copyright (C) 2011-2017 OpenFOAM Foundation
+ Copyright (C) 2020 OpenCFD Ltd.
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
@@ -190,13 +191,14 @@ public:
//- Entropy [J/(kg K)]
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;
+
#include "HtoEthermo.H"
// Derivative term used for Jacobian
- //- Derivative of Gibbs free energy w.r.t. temperature
- inline scalar dGdT(const scalar p, const scalar T) const;
//- Temperature derivative of heat capacity at constant pressure
inline scalar dCpdT(const scalar p, const scalar T) const;
diff --git a/src/thermophysicalModels/specie/thermo/janaf/janafThermoI.H b/src/thermophysicalModels/specie/thermo/janaf/janafThermoI.H
index 1065ef60d0..218a227378 100644
--- a/src/thermophysicalModels/specie/thermo/janaf/janafThermoI.H
+++ b/src/thermophysicalModels/specie/thermo/janaf/janafThermoI.H
@@ -6,6 +6,7 @@
\\/ M anipulation |
-------------------------------------------------------------------------------
Copyright (C) 2011-2017 OpenFOAM Foundation
+ Copyright (C) 2020 OpenCFD Ltd.
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
@@ -240,14 +241,21 @@ inline Foam::scalar Foam::janafThermo::S
template
-inline Foam::scalar Foam::janafThermo::dGdT
+inline Foam::scalar Foam::janafThermo::Gstd
(
- const scalar p,
const scalar T
) const
{
const coeffArray& a = coeffs(T);
- return -((a[0] + a[5]/T)/T + a[1]/2 + T*(a[2]/3 + T*(a[3]/4 + T*a[4]/5)));
+ return
+ (
+ (
+ a[0]*(1 - log(T))
+ - (((a[4]/20.0*T + a[3]/12.0)*T + a[2]/6.0)*T + a[1]/2.0)*T
+ - a[6]
+ )*T
+ + a[5]
+ );
}
diff --git a/src/thermophysicalModels/specie/thermo/thermo/thermo.H b/src/thermophysicalModels/specie/thermo/thermo/thermo.H
index 17fd93bfb8..fb636d69e5 100644
--- a/src/thermophysicalModels/specie/thermo/thermo/thermo.H
+++ b/src/thermophysicalModels/specie/thermo/thermo/thermo.H
@@ -6,6 +6,7 @@
\\/ M anipulation |
-------------------------------------------------------------------------------
Copyright (C) 2011-2017 OpenFOAM Foundation
+ Copyright (C) 2020 OpenCFD Ltd.
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
diff --git a/src/thermophysicalModels/specie/thermo/thermo/thermoI.H b/src/thermophysicalModels/specie/thermo/thermo/thermoI.H
index 49e2e134a5..7665198e05 100644
--- a/src/thermophysicalModels/specie/thermo/thermo/thermoI.H
+++ b/src/thermophysicalModels/specie/thermo/thermo/thermoI.H
@@ -6,6 +6,7 @@
\\/ M anipulation |
-------------------------------------------------------------------------------
Copyright (C) 2011-2017 OpenFOAM Foundation
+ Copyright (C) 2020 OpenCFD Ltd.
-------------------------------------------------------------------------------
License
This file is part of OpenFOAM.
@@ -440,15 +441,17 @@ Foam::species::thermo::dKcdTbyKc
const scalar T
) const
{
- const scalar nm = this->Y()/this->W();
+ const scalar dKcdTbyKc =
+ (this->S(Pstd, T) + this->Gstd(T)/T)*this->Y()/(RR*T);
+ const scalar nm = this->Y()/this->W();
if (equal(nm, SMALL))
{
- return -this->dGdT(Pstd, T)*this->Y()/RR;
+ return dKcdTbyKc;
}
else
{
- return -(nm/T + this->dGdT(Pstd, T)*this->Y()/RR);
+ return dKcdTbyKc - nm/T;
}
}
diff --git a/tutorials/heatTransfer/chtMultiRegionTwoPhaseEulerFoam/solidQuenching2D/constant/water/thermophysicalProperties.gas b/tutorials/heatTransfer/chtMultiRegionTwoPhaseEulerFoam/solidQuenching2D/constant/water/thermophysicalProperties.gas
index 80aaa70994..e1eb2228bf 100644
--- a/tutorials/heatTransfer/chtMultiRegionTwoPhaseEulerFoam/solidQuenching2D/constant/water/thermophysicalProperties.gas
+++ b/tutorials/heatTransfer/chtMultiRegionTwoPhaseEulerFoam/solidQuenching2D/constant/water/thermophysicalProperties.gas
@@ -20,7 +20,7 @@ thermoType
type heRhoThermo;
mixture pureMixture;
transport const;
- thermo hRefConst;
+ thermo hConst;
equationOfState perfectGas;
specie specie;
energy sensibleEnthalpy;
diff --git a/tutorials/heatTransfer/chtMultiRegionTwoPhaseEulerFoam/solidQuenching2D/constant/water/thermophysicalProperties.liquid b/tutorials/heatTransfer/chtMultiRegionTwoPhaseEulerFoam/solidQuenching2D/constant/water/thermophysicalProperties.liquid
index c5706158b4..65204f1a49 100644
--- a/tutorials/heatTransfer/chtMultiRegionTwoPhaseEulerFoam/solidQuenching2D/constant/water/thermophysicalProperties.liquid
+++ b/tutorials/heatTransfer/chtMultiRegionTwoPhaseEulerFoam/solidQuenching2D/constant/water/thermophysicalProperties.liquid
@@ -20,7 +20,7 @@ thermoType
type heRhoThermo;
mixture pureMixture;
transport const;
- thermo hRefConst;
+ thermo hConst;
equationOfState rhoConst;
specie specie;
energy sensibleEnthalpy;
diff --git a/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_2phase/constant/thermophysicalProperties.gas b/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_2phase/constant/thermophysicalProperties.gas
index ea9d59a6c2..9387cb3816 100644
--- a/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_2phase/constant/thermophysicalProperties.gas
+++ b/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_2phase/constant/thermophysicalProperties.gas
@@ -20,7 +20,7 @@ thermoType
type heRhoThermo;
mixture pureMixture;
transport const;
- thermo eRefConst;
+ thermo eConst;
equationOfState rhoConst;
specie specie;
energy sensibleInternalEnergy;
diff --git a/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_2phase/constant/thermophysicalProperties.liquid b/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_2phase/constant/thermophysicalProperties.liquid
index 36cdf4ae4b..e6c18e8201 100644
--- a/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_2phase/constant/thermophysicalProperties.liquid
+++ b/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_2phase/constant/thermophysicalProperties.liquid
@@ -20,7 +20,7 @@ thermoType
type heRhoThermo;
mixture pureMixture;
transport const;
- thermo eRefConst;
+ thermo eConst;
equationOfState rhoConst;
specie specie;
energy sensibleInternalEnergy;
diff --git a/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_3phase/constant/thermophysicalProperties.gas b/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_3phase/constant/thermophysicalProperties.gas
index ea9d59a6c2..9387cb3816 100644
--- a/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_3phase/constant/thermophysicalProperties.gas
+++ b/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_3phase/constant/thermophysicalProperties.gas
@@ -20,7 +20,7 @@ thermoType
type heRhoThermo;
mixture pureMixture;
transport const;
- thermo eRefConst;
+ thermo eConst;
equationOfState rhoConst;
specie specie;
energy sensibleInternalEnergy;
diff --git a/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_3phase/constant/thermophysicalProperties.gas2 b/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_3phase/constant/thermophysicalProperties.gas2
index ea9d59a6c2..9387cb3816 100644
--- a/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_3phase/constant/thermophysicalProperties.gas2
+++ b/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_3phase/constant/thermophysicalProperties.gas2
@@ -20,7 +20,7 @@ thermoType
type heRhoThermo;
mixture pureMixture;
transport const;
- thermo eRefConst;
+ thermo eConst;
equationOfState rhoConst;
specie specie;
energy sensibleInternalEnergy;
diff --git a/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_3phase/constant/thermophysicalProperties.liquid b/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_3phase/constant/thermophysicalProperties.liquid
index 36cdf4ae4b..e6c18e8201 100644
--- a/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_3phase/constant/thermophysicalProperties.liquid
+++ b/tutorials/multiphase/reactingMultiphaseEulerFoam/RAS/wallBoiling1D_3phase/constant/thermophysicalProperties.liquid
@@ -20,7 +20,7 @@ thermoType
type heRhoThermo;
mixture pureMixture;
transport const;
- thermo eRefConst;
+ thermo eConst;
equationOfState rhoConst;
specie specie;
energy sensibleInternalEnergy;
diff --git a/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling/constant/thermophysicalProperties.gas b/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling/constant/thermophysicalProperties.gas
index eb50aaf17e..ef6932762e 100644
--- a/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling/constant/thermophysicalProperties.gas
+++ b/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling/constant/thermophysicalProperties.gas
@@ -20,7 +20,7 @@ thermoType
type heRhoThermo;
mixture pureMixture;
transport const;
- thermo eRefConst;
+ thermo eConst;
equationOfState perfectGas;
specie specie;
energy sensibleInternalEnergy;
diff --git a/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling/constant/thermophysicalProperties.liquid b/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling/constant/thermophysicalProperties.liquid
index bf5fdec6ab..0171facfe4 100644
--- a/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling/constant/thermophysicalProperties.liquid
+++ b/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling/constant/thermophysicalProperties.liquid
@@ -20,7 +20,7 @@ thermoType
type heRhoThermo;
mixture pureMixture;
transport const;
- thermo eRefConst;
+ thermo eConst;
equationOfState rhoConst;
specie specie;
energy sensibleInternalEnergy;
diff --git a/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling1D/constant/thermophysicalProperties.gas b/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling1D/constant/thermophysicalProperties.gas
index ea9d59a6c2..9387cb3816 100644
--- a/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling1D/constant/thermophysicalProperties.gas
+++ b/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling1D/constant/thermophysicalProperties.gas
@@ -20,7 +20,7 @@ thermoType
type heRhoThermo;
mixture pureMixture;
transport const;
- thermo eRefConst;
+ thermo eConst;
equationOfState rhoConst;
specie specie;
energy sensibleInternalEnergy;
diff --git a/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling1D/constant/thermophysicalProperties.liquid b/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling1D/constant/thermophysicalProperties.liquid
index 36cdf4ae4b..e6c18e8201 100644
--- a/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling1D/constant/thermophysicalProperties.liquid
+++ b/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoiling1D/constant/thermophysicalProperties.liquid
@@ -20,7 +20,7 @@ thermoType
type heRhoThermo;
mixture pureMixture;
transport const;
- thermo eRefConst;
+ thermo eConst;
equationOfState rhoConst;
specie specie;
energy sensibleInternalEnergy;
diff --git a/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoilingIATE/constant/thermophysicalProperties.gas b/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoilingIATE/constant/thermophysicalProperties.gas
index eb50aaf17e..ef6932762e 100644
--- a/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoilingIATE/constant/thermophysicalProperties.gas
+++ b/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoilingIATE/constant/thermophysicalProperties.gas
@@ -20,7 +20,7 @@ thermoType
type heRhoThermo;
mixture pureMixture;
transport const;
- thermo eRefConst;
+ thermo eConst;
equationOfState perfectGas;
specie specie;
energy sensibleInternalEnergy;
diff --git a/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoilingIATE/constant/thermophysicalProperties.liquid b/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoilingIATE/constant/thermophysicalProperties.liquid
index f1353d7288..6381ea22c1 100644
--- a/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoilingIATE/constant/thermophysicalProperties.liquid
+++ b/tutorials/multiphase/reactingTwoPhaseEulerFoam/RAS/wallBoilingIATE/constant/thermophysicalProperties.liquid
@@ -20,7 +20,7 @@ thermoType
type heRhoThermo;
mixture pureMixture;
transport const;
- thermo eRefConst;
+ thermo eConst;
equationOfState rhoConst;
specie specie;
energy sensibleInternalEnergy;
diff --git a/tutorials/multiphase/reactingTwoPhaseEulerFoam/laminar/steamInjection/constant/thermophysicalProperties.steam b/tutorials/multiphase/reactingTwoPhaseEulerFoam/laminar/steamInjection/constant/thermophysicalProperties.steam
index 025949a019..7583d50767 100644
--- a/tutorials/multiphase/reactingTwoPhaseEulerFoam/laminar/steamInjection/constant/thermophysicalProperties.steam
+++ b/tutorials/multiphase/reactingTwoPhaseEulerFoam/laminar/steamInjection/constant/thermophysicalProperties.steam
@@ -20,7 +20,7 @@ thermoType
type heRhoThermo;
mixture pureMixture;
transport const;
- thermo hRefConst;
+ thermo hConst;
equationOfState perfectGas;
specie specie;
energy sensibleEnthalpy;
diff --git a/tutorials/multiphase/reactingTwoPhaseEulerFoam/laminar/steamInjection/constant/thermophysicalProperties.water b/tutorials/multiphase/reactingTwoPhaseEulerFoam/laminar/steamInjection/constant/thermophysicalProperties.water
index 3ed2cfc8db..71077773b3 100644
--- a/tutorials/multiphase/reactingTwoPhaseEulerFoam/laminar/steamInjection/constant/thermophysicalProperties.water
+++ b/tutorials/multiphase/reactingTwoPhaseEulerFoam/laminar/steamInjection/constant/thermophysicalProperties.water
@@ -20,7 +20,7 @@ thermoType
type heRhoThermo;
mixture pureMixture;
transport const;
- thermo eRefConst;
+ thermo eConst;
equationOfState perfectFluid;
specie specie;
energy sensibleInternalEnergy;