www.mooseframework.org
Public Member Functions | Static Public Attributes | Protected Attributes | Private Member Functions | List of all members
HeliumFluidProperties Class Reference

Fluid properties for helium [petersen] [harlow]. More...

#include <HeliumFluidProperties.h>

Inheritance diagram for HeliumFluidProperties:
[legend]

Public Member Functions

 HeliumFluidProperties (const InputParameters &parameters)
 
virtual std::string fluidName () const override
 Fluid name. More...
 
virtual Real p_from_v_e (Real v, Real e) const override
 Pressure from specific volume and specific internal energy. More...
 
virtual void p_from_v_e (Real v, Real e, Real &p, Real &dp_dv, Real &dp_de) const override
 Pressure and its derivatives from specific volume and specific internal energy. More...
 
void p_from_v_e (const DualReal &v, const DualReal &e, DualReal &p, DualReal &dp_dv, DualReal &dp_de) const override
 
virtual Real T_from_v_e (Real v, Real e) const override
 Temperature from specific volume and specific internal energy. More...
 
virtual void T_from_v_e (Real v, Real e, Real &T, Real &dT_dv, Real &dT_de) const override
 Temperature and its derivatives from specific volume and specific internal energy. More...
 
void T_from_v_e (const DualReal &v, const DualReal &e, DualReal &T, DualReal &dT_dv, DualReal &dT_de) const override
 
virtual Real c_from_v_e (Real v, Real e) const override
 Speed of sound from specific volume and specific internal energy. More...
 
virtual void c_from_v_e (Real v, Real e, Real &c, Real &dc_dv, Real &dc_de) const override
 
virtual Real cp_from_v_e (Real v, Real e) const override
 Isobaric specific heat from specific volume and specific internal energy. More...
 
void cp_from_v_e (Real v, Real e, Real &cp, Real &dcp_dv, Real &dcp_de) const override
 Isobaric specific heat from specific volume and specific internal energy. More...
 
virtual Real cv_from_v_e (Real v, Real e) const override
 Isochoric specific heat from specific volume and specific internal energy. More...
 
void cv_from_v_e (Real v, Real e, Real &cv, Real &dcv_dv, Real &dcv_de) const override
 Isochoric specific heat from specific volume and specific internal energy. More...
 
virtual Real mu_from_v_e (Real v, Real e) const override
 Dynamic viscosity from specific volume and specific internal energy. More...
 
virtual Real k_from_v_e (Real v, Real e) const override
 Thermal conductivity from specific volume and specific internal energy. More...
 
virtual Real beta_from_p_T (Real p, Real T) const override
 Thermal expansion coefficient from pressure and temperature. More...
 
virtual Real rho_from_p_T (Real p, Real T) const override
 Density from pressure and temperature. More...
 
virtual void rho_from_p_T (Real p, Real T, Real &rho, Real &drho_dp, Real &drho_dT) const override
 Density and its derivatives from pressure and temperature. More...
 
virtual void rho_from_p_T (const DualReal &p, const DualReal &T, DualReal &rho, DualReal &drho_dp, DualReal &drho_dT) const override
 
virtual Real e_from_p_T (Real p, Real T) const override
 Specific internal energy from pressure and temperature. More...
 
virtual void e_from_p_T (Real p, Real T, Real &e, Real &de_dp, Real &de_dT) const override
 Specific internal energy and its derivatives from pressure and temperature. More...
 
virtual Real h_from_p_T (Real p, Real T) const override
 Specific enthalpy from pressure and temperature. More...
 
virtual void h_from_p_T (Real p, Real T, Real &h, Real &dh_dp, Real &dh_dT) const override
 Specific enthalpy and its derivatives from pressure and temperature. More...
 
virtual Real molarMass () const override
 Molar mass. More...
 
virtual Real cp_from_p_T (Real p, Real T) const override
 Isobaric specific heat capacity from pressure and temperature. More...
 
virtual void cp_from_p_T (Real p, Real T, Real &cp, Real &dcp_dp, Real &dcp_dT) const override
 Isobaric specific heat capacity and its derivatives from pressure and temperature. More...
 
virtual Real cv_from_p_T (Real p, Real T) const override
 Isochoric specific heat capacity from pressure and temperature. More...
 
virtual void cv_from_p_T (Real p, Real T, Real &cv, Real &dcv_dp, Real &dcv_dT) const override
 Isochoric specific heat capacity and its derivatives from pressure and temperature. More...
 
virtual Real k_from_p_T (Real p, Real T) const override
 Thermal conductivity from pressure and temperature. More...
 
virtual void k_from_p_T (Real p, Real T, Real &k, Real &dk_dp, Real &dk_dT) const override
 Thermal conductivity and its derivatives wrt pressure and temperature. More...
 
virtual Real mu_from_p_T (Real p, Real T) const override
 Dynamic viscosity from pressure and temperature. More...
 
virtual void mu_from_p_T (Real p, Real T, Real &mu, Real &dmu_drho, Real &dmu_dT) const override
 Dynamic viscosity and its derivatives wrt pressure and temperature. More...
 
virtual Real criticalPressure () const
 Critical pressure. More...
 
virtual Real criticalTemperature () const
 Critical temperature. More...
 
virtual Real criticalDensity () const
 Critical density. More...
 
virtual Real criticalInternalEnergy () const
 Critical specific internal energy. More...
 
virtual Real triplePointPressure () const
 Triple point pressure. More...
 
virtual Real triplePointTemperature () const
 Triple point temperature. More...
 
virtual Real e_spndl_from_v (Real v) const
 Specific internal energy from temperature and specific volume. More...
 
virtual void v_e_spndl_from_T (Real T, Real &v, Real &e) const
 Specific internal energy from temperature and specific volume. More...
 
virtual Real vaporPressure (Real T) const
 Vapor pressure. More...
 
virtual void vaporPressure (Real T, Real &psat, Real &dpsat_dT) const
 
DualReal vaporPressure (const DualReal &T) const
 
virtual Real vaporTemperature (Real p) const
 Vapor temperature. More...
 
virtual void vaporTemperature (Real p, Real &Tsat, Real &dTsat_dp) const
 
DualReal vaporTemperature (const DualReal &p) const
 
virtual std::vector< Real > henryCoefficients () const
 Henry's law coefficients for dissolution in water. More...
 
virtual void rho_mu_from_p_T (Real p, Real T, Real &rho, Real &mu) const
 Combined methods. More...
 
virtual void rho_mu_from_p_T (Real p, Real T, Real &rho, Real &drho_dp, Real &drho_dT, Real &mu, Real &dmu_dp, Real &dmu_dT) const
 
virtual void rho_mu_from_p_T (const DualReal &p, const DualReal &T, DualReal &rho, DualReal &mu) const
 
virtual void rho_e_from_p_T (Real p, Real T, Real &rho, Real &drho_dp, Real &drho_dT, Real &e, Real &de_dp, Real &de_dT) const
 
virtual void execute () final
 
virtual void initialize () final
 
virtual void finalize () final
 
virtual void threadJoin (const UserObject &) final
 
virtual void subdomainSetup () final
 

Static Public Attributes

static const Real _R = 8.3144598
 Universal gas constant (J/mol/K) More...
 

Protected Attributes

const Real _cv
 specific heat at constant volume More...
 
const Real _cp
 specific heat at constant pressure More...
 
const Real _T_c2k
 Conversion of temperature from Celsius to Kelvin. More...
 
const bool _allow_imperfect_jacobians
 Flag to set unimplemented Jacobian entries to zero. More...
 

Private Member Functions

template<typename... Args>
void fluidPropError (Args... args) const
 
e e e e p h T T T T T v v v s h propfuncWithDefault (beta, p, T) propfuncWithDefault(v
 
e e e e p h T T T T T v v v s h T propfuncWithDefault (e, p, T) propfuncWithDefault(gamma
 
 propfunc (p, v, e) propfunc(T
 Compute a fluid property given for the state defined by two given properties. More...
 
propfunc (c, v, e) propfunc(cp
 
e e propfunc (cv, v, e) propfunc(mu
 
e e e propfunc (k, v, e) propfunc(s
 
e e e e propfunc (s, h, p) propfunc(T
 
e e e e p propfunc (rho, p, s) propfunc(e
 
e e e e p h propfunc (s, p, T) propfunc(pp_sat
 
e e e e p h T propfunc (mu, rho, T) propfunc(k
 
e e e e p h T T propfunc (c, p, T) propfunc(cp
 
e e e e p h T T T propfunc (cv, p, T) propfunc(mu
 
e e e e p h T T T T propfunc (k, p, T) propfunc(rho
 
e e e e p h T T T T T propfunc (e, p, rho) propfunc(e
 
e e e e p h T T T T T v propfunc (p, T, v) propfunc(h
 
e e e e p h T T T T T v v propfunc (s, T, v) propfunc(cv
 
e e e e p h T T T T T v v v propfunc (h, p, T) propfunc(p
 
e e e e p h T T T T T v v vpropfunc (g, v, e) propfuncWithDefault(T
 
 v
 
v
 
e e v
 
e e e v
 
e e e e p v
 
e e e e p h T T T T T v v v s h T v
 
e e e e h
 
e e e e p h T T T T T v v v h
 
e e e e p h p
 
e e e e p h T T p
 
e e e e p h T T T p
 
e e e e p h T T T T p
 
e e e e p h T T T T T v v vp
 
e e e e p h T T T T T v v v s h p
 
e e e e p h T rho
 
e e e e p h T T T T T T
 
e e e e p h T T T T T v T
 
e e e e p h T T T T T v v T
 
e e e e p h T T T T T v v v s h TpropfuncWithDefault (gamma, p, T)
 

Detailed Description

Fluid properties for helium [petersen] [harlow].

Definition at line 22 of file HeliumFluidProperties.h.

Constructor & Destructor Documentation

◆ HeliumFluidProperties()

HeliumFluidProperties::HeliumFluidProperties ( const InputParameters &  parameters)

Definition at line 23 of file HeliumFluidProperties.C.

24  : SinglePhaseFluidProperties(parameters), _cv(3117.0), _cp(5195.0)
25 {
26 }

Member Function Documentation

◆ beta_from_p_T()

Real HeliumFluidProperties::beta_from_p_T ( Real  p,
Real  T 
) const
overridevirtual

Thermal expansion coefficient from pressure and temperature.

Parameters
[in]ppressure (Pa)
[in]Ttemperature (K)
Returns
thermal expansion coefficient (1/K)

Definition at line 165 of file HeliumFluidProperties.C.

166 {
167  Real rho;
168  Real drho_dT;
169  Real drho_dp;
170  rho_from_p_T(pressure, temperature, rho, drho_dp, drho_dT);
171 
172  return -drho_dT / rho;
173 }

◆ c_from_v_e() [1/2]

Real HeliumFluidProperties::c_from_v_e ( Real  v,
Real  e 
) const
overridevirtual

Speed of sound from specific volume and specific internal energy.

Parameters
[in]vspecific volume (m$^3$/kg)
[in]especific internal energy (J/kg)
Returns
speed of sound (m/s)

Definition at line 96 of file HeliumFluidProperties.C.

97 {
98  Real p = p_from_v_e(v, e);
99  Real T = T_from_v_e(v, e);
100 
101  Real rho, drho_dp, drho_dT;
102  rho_from_p_T(p, T, rho, drho_dp, drho_dT);
103 
104  Real c2 = -(p / rho / rho - _cv / drho_dT) / (_cv * drho_dp / drho_dT);
105  return std::sqrt(c2);
106 }

◆ c_from_v_e() [2/2]

void HeliumFluidProperties::c_from_v_e ( Real  v,
Real  e,
Real &  c,
Real &  dc_dv,
Real &  dc_de 
) const
overridevirtual

Definition at line 109 of file HeliumFluidProperties.C.

110 {
111  DualReal myv = v;
112  Moose::derivInsert(myv.derivatives(), 0, 1);
113  Moose::derivInsert(myv.derivatives(), 1, 0);
114  DualReal mye = e;
115  Moose::derivInsert(mye.derivatives(), 0, 0);
116  Moose::derivInsert(mye.derivatives(), 1, 1);
117 
118  auto p = SinglePhaseFluidProperties::p_from_v_e(myv, mye);
119  auto T = SinglePhaseFluidProperties::T_from_v_e(myv, mye);
120 
121  DualReal rho, drho_dp, drho_dT;
122  rho_from_p_T(p, T, rho, drho_dp, drho_dT);
123 
124  auto cc = std::sqrt(-(p / rho / rho - _cv / drho_dT) / (_cv * drho_dp / drho_dT));
125  c = cc.value();
126  dc_dv = cc.derivatives()[0];
127  dc_de = cc.derivatives()[1];
128 }

◆ cp_from_p_T() [1/2]

Real HeliumFluidProperties::cp_from_p_T ( Real  p,
Real  T 
) const
overridevirtual

Isobaric specific heat capacity from pressure and temperature.

Parameters
ppressure (Pa)
Ttemperature (K)
Returns
isobaric specific heat (J/kg/.K)

Definition at line 243 of file HeliumFluidProperties.C.

244 {
245  return _cp;
246 }

Referenced by cp_from_p_T().

◆ cp_from_p_T() [2/2]

void HeliumFluidProperties::cp_from_p_T ( Real  p,
Real  T,
Real &  cp,
Real &  dcp_dp,
Real &  dcp_dT 
) const
overridevirtual

Isobaric specific heat capacity and its derivatives from pressure and temperature.

Parameters
[in]ppressure (Pa)
[in]Ttemperature (K)
[out]cpisobaric specific heat (J/kg/K)
[out]dcp_dpderivative of isobaric specific heat w.r.t. pressure (J/kg/K/Pa)
[out]dcp_dTderivative of isobaric specific heat w.r.t. temperature (J/kg/K/K)

Definition at line 249 of file HeliumFluidProperties.C.

251 {
253  dcp_dp = 0.0;
254  dcp_dT = 0.0;
255 }

◆ cp_from_v_e() [1/2]

Real HeliumFluidProperties::cp_from_v_e ( Real  v,
Real  e 
) const
overridevirtual

Isobaric specific heat from specific volume and specific internal energy.

Parameters
[in]vspecific volume (m$^3$/kg)
[in]especific internal energy (J/kg)
Returns
isobaric specific heat (J/kg.K)

Definition at line 130 of file HeliumFluidProperties.C.

130 { return _cp; }

Referenced by cp_from_v_e().

◆ cp_from_v_e() [2/2]

void HeliumFluidProperties::cp_from_v_e ( Real  v,
Real  e,
Real &  cp,
Real &  dcp_dv,
Real &  dcp_de 
) const
override

Isobaric specific heat from specific volume and specific internal energy.

Parameters
[in]vspecific volume (m$^3$/kg)
[in]especific internal energy (J/kg)
[out]cpisobaric specific heat (J/kg.K)
[out]dcp_dvderivative of isobaric specific heat w.r.t. specific volume
[out]dcp_dederivative of isobaric specific heat w.r.t. specific internal energy

Definition at line 133 of file HeliumFluidProperties.C.

134 {
135  cp = cp_from_v_e(v, e);
136  dcp_dv = 0.0;
137  dcp_de = 0.0;
138 }

◆ criticalDensity()

Real SinglePhaseFluidProperties::criticalDensity ( ) const
virtualinherited

◆ criticalInternalEnergy()

Real SinglePhaseFluidProperties::criticalInternalEnergy ( ) const
virtualinherited

Critical specific internal energy.

Returns
specific internal energy (J/kg)

Reimplemented in IdealGasFluidProperties, and StiffenedGasFluidProperties.

Definition at line 126 of file SinglePhaseFluidProperties.C.

127 {
128  mooseError(name(), ": ", __PRETTY_FUNCTION__, " not implemented.");
129 }

Referenced by IdealRealGasMixtureFluidProperties::p_T_from_v_e(), and IdealRealGasMixtureFluidProperties::T_from_p_v().

◆ criticalPressure()

Real SinglePhaseFluidProperties::criticalPressure ( ) const
virtualinherited

Critical pressure.

Returns
critical pressure (Pa)

Reimplemented in CO2FluidProperties, HydrogenFluidProperties, NitrogenFluidProperties, MethaneFluidProperties, NaClFluidProperties, and Water97FluidProperties.

Definition at line 108 of file SinglePhaseFluidProperties.C.

109 {
110  mooseError(name(), ": ", __PRETTY_FUNCTION__, " not implemented.");
111 }

◆ criticalTemperature()

Real SinglePhaseFluidProperties::criticalTemperature ( ) const
virtualinherited

◆ cv_from_p_T() [1/2]

Real HeliumFluidProperties::cv_from_p_T ( Real  p,
Real  T 
) const
overridevirtual

Isochoric specific heat capacity from pressure and temperature.

Parameters
ppressure (Pa)
Ttemperature (K)
Returns
isochoric specific heat (J/kg.K)

Definition at line 257 of file HeliumFluidProperties.C.

258 {
259  return _cv;
260 }

Referenced by cv_from_p_T().

◆ cv_from_p_T() [2/2]

void HeliumFluidProperties::cv_from_p_T ( Real  p,
Real  T,
Real &  cv,
Real &  dcv_dp,
Real &  dcv_dT 
) const
overridevirtual

Isochoric specific heat capacity and its derivatives from pressure and temperature.

Parameters
[in]ppressure (Pa)
[in]Ttemperature (K)
[out]cvisochoric specific heat (J/kg/K)
[out]dcv_dpderivative of isochoric specific heat w.r.t. pressure (J/kg/K/Pa)
[out]dcv_dTderivative of isochoric specific heat w.r.t. temperature (J/kg/K/K)

Definition at line 263 of file HeliumFluidProperties.C.

265 {
267  dcv_dp = 0.0;
268  dcv_dT = 0.0;
269 }

◆ cv_from_v_e() [1/2]

Real HeliumFluidProperties::cv_from_v_e ( Real  v,
Real  e 
) const
overridevirtual

Isochoric specific heat from specific volume and specific internal energy.

Parameters
[in]vspecific volume (m$^3$/kg)
[in]especific internal energy (J/kg)
Returns
isochoric specific heat (J/kg.K)

Definition at line 140 of file HeliumFluidProperties.C.

140 { return _cv; }

Referenced by cv_from_v_e().

◆ cv_from_v_e() [2/2]

void HeliumFluidProperties::cv_from_v_e ( Real  v,
Real  e,
Real &  cv,
Real &  dcv_dv,
Real &  dcv_de 
) const
override

Isochoric specific heat from specific volume and specific internal energy.

Parameters
[in]vspecific volume (m$^3$/kg)
[in]especific internal energy (J/kg)
[out]cvisochoric specific heat (J/kg.K)
[out]dcv_dvderivative of isochoric specific heat w.r.t. specific volume
[out]dcv_dederivative of isochoric specific heat w.r.t. specific internal energy

Definition at line 143 of file HeliumFluidProperties.C.

144 {
145  cv = cv_from_v_e(v, e);
146  dcv_dv = 0.0;
147  dcv_de = 0.0;
148 }

◆ e_from_p_T() [1/2]

Real HeliumFluidProperties::e_from_p_T ( Real  p,
Real  T 
) const
overridevirtual

Specific internal energy from pressure and temperature.

Parameters
[in]ppressure (Pa)
[in]Ttemperature (K)
Returns
specific internal energy (J/kg)

Definition at line 208 of file HeliumFluidProperties.C.

209 {
210  return _cv * temperature;
211 }

◆ e_from_p_T() [2/2]

void HeliumFluidProperties::e_from_p_T ( Real  p,
Real  T,
Real &  e,
Real &  de_dp,
Real &  de_dT 
) const
overridevirtual

Specific internal energy and its derivatives from pressure and temperature.

Parameters
[in]ppressure (Pa)
[in]Ttemperature (K)
[out]especific internal energy (J/kg)
[out]de_dpderivative of specific internal energy w.r.t. pressure
[out]de_dTderivative of specific internal energy w.r.t. temperature

Definition at line 214 of file HeliumFluidProperties.C.

216 {
218  de_dp = 0.0;
219  de_dT = _cv;
220 }

Referenced by e_from_p_T().

◆ e_spndl_from_v()

Real SinglePhaseFluidProperties::e_spndl_from_v ( Real  v) const
virtualinherited

Specific internal energy from temperature and specific volume.

Parameters
[in]Ttemperature
[in]vspecific volume

Reimplemented in IdealGasFluidProperties, and StiffenedGasFluidProperties.

Definition at line 286 of file SinglePhaseFluidProperties.C.

287 {
288  mooseError(name(), ": ", __PRETTY_FUNCTION__, " not implemented.");
289 }

Referenced by IdealRealGasMixtureFluidProperties::p_T_from_v_e(), and IdealRealGasMixtureFluidProperties::T_from_p_v().

◆ execute()

virtual void FluidProperties::execute ( )
inlinefinalvirtualinherited

Definition at line 34 of file FluidProperties.h.

34 {}

◆ finalize()

virtual void FluidProperties::finalize ( )
inlinefinalvirtualinherited

Definition at line 36 of file FluidProperties.h.

36 {}

◆ fluidName()

std::string HeliumFluidProperties::fluidName ( ) const
overridevirtual

Fluid name.

Returns
"helium"

Definition at line 29 of file HeliumFluidProperties.C.

30 {
31  return "helium";
32 }

◆ fluidPropError()

template<typename... Args>
void SinglePhaseFluidProperties::fluidPropError ( Args...  args) const
inlineprivateinherited

Definition at line 326 of file SinglePhaseFluidProperties.h.

327  {
329  mooseDoOnce(mooseWarning(std::forward<Args>(args)...));
330  else
331  mooseError(std::forward<Args>(args)...);
332  }

Referenced by SinglePhaseFluidProperties::vaporPressure(), and SinglePhaseFluidProperties::vaporTemperature().

◆ h_from_p_T() [1/2]

Real HeliumFluidProperties::h_from_p_T ( Real  p,
Real  T 
) const
overridevirtual

Specific enthalpy from pressure and temperature.

Parameters
[in]ppressure (Pa)
[in]Ttemperature (K)
Returns
specific enthalpy (J/kg)

Definition at line 223 of file HeliumFluidProperties.C.

224 {
225  return _cp * temperature;
226 }

Referenced by h_from_p_T().

◆ h_from_p_T() [2/2]

void HeliumFluidProperties::h_from_p_T ( Real  p,
Real  T,
Real &  h,
Real &  dh_dp,
Real &  dh_dT 
) const
overridevirtual

Specific enthalpy and its derivatives from pressure and temperature.

Parameters
[in]ppressure (Pa)
[in]Ttemperature (K)
[out]hspecific enthalpy (J/kg)
[out]dh_dpderivative of specific enthalpy w.r.t. pressure
[out]dh_dTderivative of specific enthalpy w.r.t. temperature

Definition at line 229 of file HeliumFluidProperties.C.

231 {
233  dh_dp = 0.0;
234  dh_dT = _cp;
235 }

◆ henryCoefficients()

std::vector< Real > SinglePhaseFluidProperties::henryCoefficients ( ) const
virtualinherited

Henry's law coefficients for dissolution in water.

Returns
Henry's constant coefficients

Reimplemented in CO2FluidProperties, TabulatedFluidProperties, HydrogenFluidProperties, NitrogenFluidProperties, and MethaneFluidProperties.

Definition at line 183 of file SinglePhaseFluidProperties.C.

184 {
185  mooseError(name(), ": ", __PRETTY_FUNCTION__, " not implemented.");
186 }

Referenced by TabulatedFluidProperties::henryCoefficients().

◆ initialize()

virtual void FluidProperties::initialize ( )
inlinefinalvirtualinherited

Definition at line 35 of file FluidProperties.h.

35 {}

◆ k_from_p_T() [1/2]

Real HeliumFluidProperties::k_from_p_T ( Real  p,
Real  T 
) const
overridevirtual

Thermal conductivity from pressure and temperature.

Parameters
ppressure (Pa)
Ttemperature (K)
Returns
thermal conductivity (W/m.K)

Definition at line 287 of file HeliumFluidProperties.C.

288 {
289  return 2.682e-3 * (1.0 + 1.123e-8 * pressure) *
290  std::pow(temperature, 0.71 * (1.0 - 2.0e-9 * pressure));
291 }

Referenced by k_from_p_T().

◆ k_from_p_T() [2/2]

void HeliumFluidProperties::k_from_p_T ( Real  p,
Real  T,
Real &  k,
Real &  dk_dp,
Real &  dk_dT 
) const
overridevirtual

Thermal conductivity and its derivatives wrt pressure and temperature.

Parameters
ppressure (Pa)
Ttemperature (K)
[out]kthermal conductivity (W/m.K)
[out]dk_dpderivative of thermal conductivity wrt pressure
[out]dk_dTderivative of thermal conductivity wrt temperature

Definition at line 294 of file HeliumFluidProperties.C.

296 {
298 
299  Real term = 1.0 + 1.123e-8 * pressure;
300  Real exp = 0.71 * (1.0 - 2.0e-9 * pressure);
301 
302  dk_dp = 2.682e-3 * (term * 0.71 * (-2.0e-9) * std::log(temperature) * std::pow(temperature, exp) +
303  std::pow(temperature, exp) * 1.123e-8);
304 
305  dk_dT = 2.682e-3 * term * exp * std::pow(temperature, exp - 1.0);
306 }

◆ k_from_v_e()

Real HeliumFluidProperties::k_from_v_e ( Real  v,
Real  e 
) const
overridevirtual

Thermal conductivity from specific volume and specific internal energy.

Parameters
[in]vspecific volume (m$^3$/kg)
[in]especific internal energy (J/kg)
Returns
thermal conductivity (W/m.K)

Definition at line 157 of file HeliumFluidProperties.C.

158 {
159  Real p_in_bar = p_from_v_e(v, e) * 1.0e-5;
160  Real T = T_from_v_e(v, e);
161  return 2.682e-3 * (1.0 + 1.123e-3 * p_in_bar) * std::pow(T, 0.71 * (1.0 - 2.0e-4 * p_in_bar));
162 }

◆ molarMass()

Real HeliumFluidProperties::molarMass ( ) const
overridevirtual

Molar mass.

Returns
molar mass (kg/mol)

Reimplemented from SinglePhaseFluidProperties.

Definition at line 238 of file HeliumFluidProperties.C.

239 {
240  return 4.002602e-3;
241 }

◆ mu_from_p_T() [1/2]

Real HeliumFluidProperties::mu_from_p_T ( Real  p,
Real  T 
) const
overridevirtual

Dynamic viscosity from pressure and temperature.

Parameters
ppressure (Pa)
Ttemperature (K)
Returns
dynamic viscosity (Pa.s)

Definition at line 272 of file HeliumFluidProperties.C.

273 {
274  return 3.674e-7 * std::pow(temperature, 0.7);
275 }

Referenced by mu_from_p_T().

◆ mu_from_p_T() [2/2]

void HeliumFluidProperties::mu_from_p_T ( Real  p,
Real  T,
Real &  mu,
Real &  dmu_drho,
Real &  dmu_dT 
) const
overridevirtual

Dynamic viscosity and its derivatives wrt pressure and temperature.

Parameters
ppressure (Pa)
Ttemperature (K)
[out]muviscosity (Pa.s)
[out]dmu_dpderivative of viscosity wrt pressure
[out]dmu_dTderivative of viscosity wrt temperature

Definition at line 278 of file HeliumFluidProperties.C.

280 {
282  dmu_dp = 0.0;
283  dmu_dT = 3.674e-7 * 0.7 * std::pow(temperature, -0.3);
284 }

◆ mu_from_v_e()

Real HeliumFluidProperties::mu_from_v_e ( Real  v,
Real  e 
) const
overridevirtual

Dynamic viscosity from specific volume and specific internal energy.

Parameters
[in]vspecific volume (m$^3$/kg)
[in]especific internal energy (J/kg)
Returns
dynamic viscosity (Pa.s)

Definition at line 151 of file HeliumFluidProperties.C.

152 {
153  return 3.674e-7 * std::pow(T_from_v_e(v, e), 0.7);
154 }

◆ p_from_v_e() [1/3]

void HeliumFluidProperties::p_from_v_e ( const DualReal &  v,
const DualReal &  e,
DualReal &  p,
DualReal &  dp_dv,
DualReal &  dp_de 
) const
override

Definition at line 57 of file HeliumFluidProperties.C.

59 {
60  p = SinglePhaseFluidProperties::p_from_v_e(v, e);
61 
62  DualReal T, dT_dv, dT_de;
63  T_from_v_e(v, e, T, dT_dv, dT_de);
64 
65  auto val = 48.14 * v - 0.4446 / std::pow(T, 0.2);
66  auto dp_dT = 1.0e5 / val - 0.4446 * 0.2e5 * std::pow(T, -0.2) / (val * val);
67 
68  dp_dv = -48.14e5 * T / (val * val); // taking advantage of dT_dv = 0.0;
69  dp_de = dp_dT * dT_de;
70 }

◆ p_from_v_e() [2/3]

Real HeliumFluidProperties::p_from_v_e ( Real  v,
Real  e 
) const
overridevirtual

Pressure from specific volume and specific internal energy.

Parameters
[in]vspecific volume (m$^3$/kg)
[in]especific internal energy (J/kg)
Returns
pressure (Pa)

Definition at line 35 of file HeliumFluidProperties.C.

36 {
37  Real T = T_from_v_e(v, e);
38  return T / (48.14 * v - 0.4446 / std::pow(T, 0.2)) * 1.0e5;
39 }

Referenced by c_from_v_e(), k_from_v_e(), and p_from_v_e().

◆ p_from_v_e() [3/3]

void HeliumFluidProperties::p_from_v_e ( Real  v,
Real  e,
Real &  p,
Real &  dp_dv,
Real &  dp_de 
) const
overridevirtual

Pressure and its derivatives from specific volume and specific internal energy.

Parameters
[in]vspecific volume (m$^3$/kg)
[in]especific internal energy (J/kg)
[out]ppressure (Pa)
[out]dp_dvderivative of pressure w.r.t. specific volume
[out]dp_dederivative of pressure w.r.t. specific internal energy

Definition at line 42 of file HeliumFluidProperties.C.

43 {
44  p = p_from_v_e(v, e);
45 
46  Real T, dT_dv, dT_de;
47  T_from_v_e(v, e, T, dT_dv, dT_de);
48 
49  Real val = 48.14 * v - 0.4446 / std::pow(T, 0.2);
50  Real dp_dT = 1.0e5 / val - 0.4446 * 0.2e5 * std::pow(T, -0.2) / (val * val);
51 
52  dp_dv = -48.14e5 * T / (val * val); // taking advantage of dT_dv = 0.0;
53  dp_de = dp_dT * dT_de;
54 }

◆ propfunc() [1/16]

e e e e p h T T SinglePhaseFluidProperties::propfunc ( ,
p  ,
T   
)
inherited

◆ propfunc() [2/16]

e SinglePhaseFluidProperties::propfunc ( ,
v  ,
 
)
inherited

◆ propfunc() [3/16]

e e e e p h T T T SinglePhaseFluidProperties::propfunc ( cv  ,
p  ,
T   
)
inherited

◆ propfunc() [4/16]

e e SinglePhaseFluidProperties::propfunc ( cv  ,
v  ,
 
)
inherited

◆ propfunc() [5/16]

e e e e p h T T T T T SinglePhaseFluidProperties::propfunc ( ,
p  ,
rho   
)
inherited

◆ propfunc() [6/16]

e e e e p h T T T T T v v v s SinglePhaseFluidProperties::propfunc ( ,
v  ,
 
)
inherited

◆ propfunc() [7/16]

e e e e p h T T T T T v v v SinglePhaseFluidProperties::propfunc ( h  ,
p  ,
T   
)
inherited

◆ propfunc() [8/16]

e e e e p h T T T T SinglePhaseFluidProperties::propfunc ( ,
p  ,
T   
)
inherited

◆ propfunc() [9/16]

e e e SinglePhaseFluidProperties::propfunc ( ,
v  ,
 
)
inherited

◆ propfunc() [10/16]

e e e e p h T SinglePhaseFluidProperties::propfunc ( mu  ,
rho  ,
T   
)
inherited

◆ propfunc() [11/16]

e e e e p h T T T T T v SinglePhaseFluidProperties::propfunc ( p  ,
T  ,
v   
)
inherited

◆ propfunc() [12/16]

SinglePhaseFluidProperties::propfunc ( p  ,
v  ,
 
)
inherited

Compute a fluid property given for the state defined by two given properties.

For all functions, the first two arguments are the given properties that define the fluid state. For the two-argument variants, the desired property is the return value. The five-argument variants also provide partial derivatives dx/da and dx/db where x is the desired property being computed, a is the first given property, and b is the second given property. The desired property, dx/da, and dx/db are stored into the 3rd, 4th, and 5th arguments respectively.

Properties/parameters used in these function are listed below with their units:

@begincode p pressure [Pa] T temperature [K] e specific internal energy [J/kg] v specific volume [m^3/kg] rho density [kg/m^3] h specific enthalpy [J/kg] s specific entropy [J/(kg*K)] mu viscosity [Pa*s] k thermal conductivity [W/(m*K)] c speed of sound [m/s] cp constant-pressure specific heat [J/K] cv constant-volume specific heat [J/K] beta volumetric thermal expansion coefficient [1/K] g Gibbs free energy [J] pp_sat partial pressure at saturation [Pa] gamma Adiabatic ratio (cp/cv) [-]

As an example:

@begincode // calculate pressure given specific vol and energy: auto pressure = your_fluid_properties_object.p_from_v_e(specific_vol, specific_energy);

// or use the derivative variant: Real dp_dv = 0; // derivative will be stored into here Real dp_de = 0; // derivative will be stored into here your_fluid_properties_object.p_from_v_e(specific_vol, specific_energy, pressure, dp_dv, dp_de);

Automatic differentiation (AD) support is provided through x_from_a_b(DualReal a, DualReal b) and x_from_a_b(DualReal a, DualReal b, DualReal x, DualReal dx_da, DualReal dx_db) versions of the functions where a and b must be ADReal/DualNumber's calculated using all AD-supporting values:

@begincode auto v = 1/rho; // rho must be an AD non-linear variable. auto e = rhoE/rho - vel_energy; // rhoE and vel_energy must be AD variables/numbers also. auto pressure = your_fluid_properties_object.p_from_v_e(v, e); // pressure now contains partial derivatives w.r.t. all degrees of freedom

◆ propfunc() [13/16]

e e e e p SinglePhaseFluidProperties::propfunc ( rho  ,
p  ,
 
)
inherited

◆ propfunc() [14/16]

e e e e SinglePhaseFluidProperties::propfunc ( ,
h  ,
p   
)
inherited

◆ propfunc() [15/16]

e e e e p h SinglePhaseFluidProperties::propfunc ( ,
p  ,
T   
)
inherited

◆ propfunc() [16/16]

e e e e p h T T T T T v v SinglePhaseFluidProperties::propfunc ( ,
T  ,
v   
)
inherited

◆ propfuncWithDefault() [1/2]

e e e e p h T T T T T v v v s h SinglePhaseFluidProperties::propfuncWithDefault ( beta  ,
p  ,
T   
)
inherited

◆ propfuncWithDefault() [2/2]

e e e e p h T T T T T v v v s h T SinglePhaseFluidProperties::propfuncWithDefault ( ,
p  ,
T   
)
inherited

◆ rho_e_from_p_T()

void SinglePhaseFluidProperties::rho_e_from_p_T ( Real  p,
Real  T,
Real &  rho,
Real &  drho_dp,
Real &  drho_dT,
Real &  e,
Real &  de_dp,
Real &  de_dT 
) const
virtualinherited

Definition at line 242 of file SinglePhaseFluidProperties.C.

250 {
251  rho_from_p_T(p, T, rho, drho_dp, drho_dT);
252  e_from_p_T(p, T, e, de_dp, de_dT);
253 }

◆ rho_from_p_T() [1/3]

void HeliumFluidProperties::rho_from_p_T ( const DualReal &  p,
const DualReal &  T,
DualReal &  rho,
DualReal &  drho_dp,
DualReal &  drho_dT 
) const
overridevirtual

Definition at line 194 of file HeliumFluidProperties.C.

199 {
200  rho = SinglePhaseFluidProperties::rho_from_p_T(pressure, temperature);
201  auto val = 1.0 / (temperature + 0.4446e-5 * pressure / std::pow(temperature, 0.2));
202  drho_dp = 48.14e-5 * (val - 0.4446e-5 * pressure * val * val / std::pow(temperature, 0.2));
203  drho_dT =
204  -48.14e-5 * pressure * val * val * (1.0 - 0.08892e-5 * pressure / std::pow(temperature, 1.2));
205 }

◆ rho_from_p_T() [2/3]

Real HeliumFluidProperties::rho_from_p_T ( Real  p,
Real  T 
) const
overridevirtual

Density from pressure and temperature.

Parameters
[in]ppressure (Pa)
[in]Ttemperature (K)
Returns
density (kg/m$^3$)

Definition at line 176 of file HeliumFluidProperties.C.

177 {
178  Real p_in_bar = pressure * 1.0e-5;
179  return 48.14 * p_in_bar / (temperature + 0.4446 * p_in_bar / std::pow(temperature, 0.2));
180 }

Referenced by beta_from_p_T(), c_from_v_e(), and rho_from_p_T().

◆ rho_from_p_T() [3/3]

void HeliumFluidProperties::rho_from_p_T ( Real  p,
Real  T,
Real &  rho,
Real &  drho_dp,
Real &  drho_dT 
) const
overridevirtual

Density and its derivatives from pressure and temperature.

Parameters
[in]ppressure (Pa)
[in]Ttemperature (K)
[out]rhodensity (kg/m$^3$)
[out]drho_dpderivative of density w.r.t. pressure
[out]drho_dTderivative of density w.r.t. temperature

Definition at line 183 of file HeliumFluidProperties.C.

185 {
187  Real val = 1.0 / (temperature + 0.4446e-5 * pressure / std::pow(temperature, 0.2));
188  drho_dp = 48.14e-5 * (val - 0.4446e-5 * pressure * val * val / std::pow(temperature, 0.2));
189  drho_dT =
190  -48.14e-5 * pressure * val * val * (1.0 - 0.08892e-5 * pressure / std::pow(temperature, 1.2));
191 }

◆ rho_mu_from_p_T() [1/3]

void SinglePhaseFluidProperties::rho_mu_from_p_T ( const DualReal &  p,
const DualReal &  T,
DualReal &  rho,
DualReal &  mu 
) const
virtualinherited

Definition at line 277 of file SinglePhaseFluidProperties.C.

281 {
282  rho = rho_from_p_T(p, T);
283  mu = mu_from_p_T(p, T);
284 }

◆ rho_mu_from_p_T() [2/3]

void SinglePhaseFluidProperties::rho_mu_from_p_T ( Real  p,
Real  T,
Real &  rho,
Real &  drho_dp,
Real &  drho_dT,
Real &  mu,
Real &  dmu_dp,
Real &  dmu_dT 
) const
virtualinherited

Reimplemented in Water97FluidProperties, CO2FluidProperties, HydrogenFluidProperties, and NitrogenFluidProperties.

Definition at line 263 of file SinglePhaseFluidProperties.C.

271 {
272  rho_from_p_T(p, T, rho, drho_dp, drho_dT);
273  mu_from_p_T(p, T, mu, dmu_dp, dmu_dT);
274 }

◆ rho_mu_from_p_T() [3/3]

void SinglePhaseFluidProperties::rho_mu_from_p_T ( Real  p,
Real  T,
Real &  rho,
Real &  mu 
) const
virtualinherited

Combined methods.

These methods are particularly useful for the PorousFlow module, where density and viscosity are typically both computed everywhere. The combined methods allow the most efficient means of calculating both properties, especially where rho(p, T) and mu(rho, T). In this case, an extra density calculation would be required to calculate mu(p, T). All propery names are described above.

Reimplemented in Water97FluidProperties, CO2FluidProperties, HydrogenFluidProperties, and NitrogenFluidProperties.

Definition at line 256 of file SinglePhaseFluidProperties.C.

257 {
258  rho = rho_from_p_T(p, T);
259  mu = mu_from_p_T(p, T);
260 }

Referenced by PorousFlowSingleComponentFluid::computeQpProperties(), PorousFlowWaterNCG::gasProperties(), PorousFlowBrineCO2::gasProperties(), and PorousFlowWaterNCG::liquidProperties().

◆ subdomainSetup()

virtual void FluidProperties::subdomainSetup ( )
inlinefinalvirtualinherited

Definition at line 39 of file FluidProperties.h.

39 {}

◆ T_from_v_e() [1/3]

void HeliumFluidProperties::T_from_v_e ( const DualReal &  v,
const DualReal &  e,
DualReal &  T,
DualReal &  dT_dv,
DualReal &  dT_de 
) const
override

Definition at line 87 of file HeliumFluidProperties.C.

89 {
90  T = SinglePhaseFluidProperties::T_from_v_e(v, e);
91  dT_dv = 0.0;
92  dT_de = 1.0 / _cv;
93 }

◆ T_from_v_e() [2/3]

Real HeliumFluidProperties::T_from_v_e ( Real  v,
Real  e 
) const
overridevirtual

Temperature from specific volume and specific internal energy.

Parameters
[in]vspecific volume (m$^3$/kg)
[in]especific internal energy (J/kg)
Returns
temperature (K)

Definition at line 73 of file HeliumFluidProperties.C.

74 {
75  return e / _cv;
76 }

Referenced by c_from_v_e(), k_from_v_e(), mu_from_v_e(), p_from_v_e(), and T_from_v_e().

◆ T_from_v_e() [3/3]

void HeliumFluidProperties::T_from_v_e ( Real  v,
Real  e,
Real &  T,
Real &  dT_dv,
Real &  dT_de 
) const
overridevirtual

Temperature and its derivatives from specific volume and specific internal energy.

Parameters
[in]vspecific volume (m$^3$/kg)
[in]especific internal energy (J/kg)
[out]Ttemperature (K)
[out]dT_dvderivative of temperature w.r.t. specific volume
[out]dT_dederivative of temperature w.r.t. specific internal energy

Definition at line 79 of file HeliumFluidProperties.C.

80 {
81  T = T_from_v_e(v, e);
82  dT_dv = 0.0;
83  dT_de = 1.0 / _cv;
84 }

◆ threadJoin()

virtual void FluidProperties::threadJoin ( const UserObject &  )
inlinefinalvirtualinherited

Definition at line 38 of file FluidProperties.h.

38 {}

◆ triplePointPressure()

Real SinglePhaseFluidProperties::triplePointPressure ( ) const
virtualinherited

Triple point pressure.

Returns
triple point pressure (Pa)

Reimplemented in CO2FluidProperties, HydrogenFluidProperties, NitrogenFluidProperties, MethaneFluidProperties, NaClFluidProperties, and Water97FluidProperties.

Definition at line 132 of file SinglePhaseFluidProperties.C.

133 {
134  mooseError(name(), ": ", __PRETTY_FUNCTION__, " not implemented.");
135 }

◆ triplePointTemperature()

Real SinglePhaseFluidProperties::triplePointTemperature ( ) const
virtualinherited

Triple point temperature.

Returns
triple point temperature (K)

Reimplemented in CO2FluidProperties, HydrogenFluidProperties, NitrogenFluidProperties, MethaneFluidProperties, NaClFluidProperties, and Water97FluidProperties.

Definition at line 138 of file SinglePhaseFluidProperties.C.

139 {
140  mooseError(name(), ": ", __PRETTY_FUNCTION__, " not implemented.");
141 }

◆ v_e_spndl_from_T()

void SinglePhaseFluidProperties::v_e_spndl_from_T ( Real  T,
Real &  v,
Real &  e 
) const
virtualinherited

Specific internal energy from temperature and specific volume.

Parameters
[in]Ttemperature
[in]vspecific volume

Reimplemented in IdealGasFluidProperties, and StiffenedGasFluidProperties.

Definition at line 292 of file SinglePhaseFluidProperties.C.

293 {
294  mooseError(name(), ": ", __PRETTY_FUNCTION__, " not implemented.");
295 }

Referenced by IdealRealGasMixtureFluidProperties::v_from_p_T().

◆ vaporPressure() [1/3]

DualReal SinglePhaseFluidProperties::vaporPressure ( const DualReal &  T) const
inherited

Definition at line 198 of file SinglePhaseFluidProperties.C.

199 {
200  Real p = 0.0;
201  Real temperature = T.value();
202  Real dpdT = 0.0;
203 
204  vaporPressure(temperature, p, dpdT);
205 
206  DualReal result = p;
207  result.derivatives() = T.derivatives() * dpdT;
208 
209  return result;
210 }

◆ vaporPressure() [2/3]

Real SinglePhaseFluidProperties::vaporPressure ( Real  T) const
virtualinherited

Vapor pressure.

Used to delineate liquid and gas phases. Valid for temperatures between the triple point temperature and the critical temperature

Parameters
Tfluid temperature (K)
[out]saturationpressure (Pa)
[out]derivativeof saturation pressure wrt temperature (Pa/K)

Reimplemented in TabulatedFluidProperties, CO2FluidProperties, Water97FluidProperties, HydrogenFluidProperties, NitrogenFluidProperties, and MethaneFluidProperties.

Definition at line 177 of file SinglePhaseFluidProperties.C.

178 {
179  mooseError(name(), ": ", __PRETTY_FUNCTION__, " not implemented.");
180 }

Referenced by PorousFlowWaterNCG::equilibriumMassFractions(), PorousFlowWaterNCG::gasDensity(), PorousFlowWaterNCG::gasProperties(), BrineFluidProperties::vaporPressure(), TabulatedFluidProperties::vaporPressure(), and SinglePhaseFluidProperties::vaporPressure().

◆ vaporPressure() [3/3]

void SinglePhaseFluidProperties::vaporPressure ( Real  T,
Real &  psat,
Real &  dpsat_dT 
) const
virtualinherited

Reimplemented in TabulatedFluidProperties, CO2FluidProperties, Water97FluidProperties, HydrogenFluidProperties, NitrogenFluidProperties, and MethaneFluidProperties.

Definition at line 189 of file SinglePhaseFluidProperties.C.

190 {
191  fluidPropError(name(), ": ", __PRETTY_FUNCTION__, " derivatives not implemented.");
192 
193  dp_dT = 0.0;
194  p = vaporPressure(T);
195 }

◆ vaporTemperature() [1/3]

DualReal SinglePhaseFluidProperties::vaporTemperature ( const DualReal &  p) const
inherited

Definition at line 227 of file SinglePhaseFluidProperties.C.

228 {
229  Real T = 0.0;
230  Real pressure = p.value();
231  Real dTdp = 0.0;
232 
233  vaporTemperature(pressure, T, dTdp);
234 
235  DualReal result = T;
236  result.derivatives() = p.derivatives() * dTdp;
237 
238  return result;
239 }

◆ vaporTemperature() [2/3]

Real SinglePhaseFluidProperties::vaporTemperature ( Real  p) const
virtualinherited

Vapor temperature.

Used to delineate liquid and gas phases. Valid for pressures between the triple point pressure and the critical pressure

Parameters
pfluid pressure (Pa)
[out]saturationtemperature (K)
[out]derivativeof saturation temperature wrt pressure

Reimplemented in Water97FluidProperties.

Definition at line 212 of file SinglePhaseFluidProperties.C.

213 {
214  mooseError(name(), ": ", __PRETTY_FUNCTION__, " not implemented.");
215 }

Referenced by PorousFlowWaterVapor::thermophysicalProperties(), and SinglePhaseFluidProperties::vaporTemperature().

◆ vaporTemperature() [3/3]

void SinglePhaseFluidProperties::vaporTemperature ( Real  p,
Real &  Tsat,
Real &  dTsat_dp 
) const
virtualinherited

Reimplemented in Water97FluidProperties.

Definition at line 218 of file SinglePhaseFluidProperties.C.

219 {
220  fluidPropError(name(), ": ", __PRETTY_FUNCTION__, " derivatives not implemented.");
221 
222  dT_dp = 0.0;
223  T = vaporTemperature(p);
224 }

Member Data Documentation

◆ _allow_imperfect_jacobians

const bool FluidProperties::_allow_imperfect_jacobians
protectedinherited

Flag to set unimplemented Jacobian entries to zero.

Definition at line 48 of file FluidProperties.h.

Referenced by SinglePhaseFluidProperties::fluidPropError().

◆ _cp

const Real HeliumFluidProperties::_cp
protected

specific heat at constant pressure

Definition at line 332 of file HeliumFluidProperties.h.

Referenced by cp_from_p_T(), cp_from_v_e(), and h_from_p_T().

◆ _cv

const Real HeliumFluidProperties::_cv
protected

specific heat at constant volume

Definition at line 329 of file HeliumFluidProperties.h.

Referenced by c_from_v_e(), cv_from_p_T(), cv_from_v_e(), e_from_p_T(), and T_from_v_e().

◆ _R

const Real FluidProperties::_R = 8.3144598
staticinherited

◆ _T_c2k

const Real FluidProperties::_T_c2k
protectedinherited

◆ h [1/2]

e e e e SinglePhaseFluidProperties::h
inherited

◆ h [2/2]

e e e e p h T T T T T v v v SinglePhaseFluidProperties::h
inherited

Definition at line 183 of file SinglePhaseFluidProperties.h.

◆ p [1/6]

e e e e p h SinglePhaseFluidProperties::p
inherited

Definition at line 167 of file SinglePhaseFluidProperties.h.

Referenced by StiffenedGasFluidProperties::c_from_v_e(), c_from_v_e(), IdealGasFluidProperties::cp_from_p_T(), IdealGasFluidProperties::cv_from_p_T(), StiffenedGasFluidProperties::e_from_p_rho(), IdealGasFluidProperties::e_from_p_rho(), StiffenedGasFluidProperties::e_from_p_T(), IdealGasFluidProperties::e_from_p_T(), StiffenedGasFluidProperties::g_from_v_e(), IdealGasFluidProperties::g_from_v_e(), TabulatedFluidProperties::generateTabulatedData(), StiffenedGasFluidProperties::h_from_p_T(), IdealGasFluidProperties::h_from_p_T(), Water97FluidProperties::henryConstant(), IdealGasFluidProperties::k_from_p_T(), StiffenedGasFluidProperties::p_from_h_s(), IdealGasFluidProperties::p_from_h_s(), StiffenedGasFluidProperties::p_from_T_v(), IdealGasFluidProperties::p_from_T_v(), IdealGasFluidProperties::p_from_v_e(), StiffenedGasFluidProperties::p_from_v_e(), p_from_v_e(), FlinakFluidProperties::p_from_v_e(), FlibeFluidProperties::p_from_v_e(), SinglePhaseFluidProperties::rho_e_from_p_T(), StiffenedGasFluidProperties::rho_from_p_s(), IdealGasFluidProperties::rho_from_p_s(), StiffenedGasFluidProperties::rho_from_p_T(), IdealGasFluidProperties::rho_from_p_T(), SinglePhaseFluidProperties::rho_mu_from_p_T(), StiffenedGasFluidProperties::s_from_h_p(), IdealGasFluidProperties::s_from_h_p(), StiffenedGasFluidProperties::s_from_p_T(), IdealGasFluidProperties::s_from_p_T(), SimpleFluidProperties::s_from_p_T(), Water97FluidProperties::s_from_p_T(), TabulatedFluidProperties::s_from_p_T(), IdealGasFluidProperties::s_from_T_v(), StiffenedGasFluidProperties::s_from_v_e(), IdealGasFluidProperties::s_from_v_e(), Water97FluidProperties::T_from_p_h(), FlinakFluidProperties::T_from_v_e(), FlibeFluidProperties::T_from_v_e(), Water97FluidProperties::vaporPressure(), SinglePhaseFluidProperties::vaporPressure(), Water97FluidProperties::vaporTemperature(), SinglePhaseFluidProperties::vaporTemperature(), and TabulatedFluidProperties::writeTabulatedData().

◆ p [2/6]

e e e e p h T T SinglePhaseFluidProperties::p
inherited

Definition at line 171 of file SinglePhaseFluidProperties.h.

◆ p [3/6]

e e e e p h T T T SinglePhaseFluidProperties::p
inherited

Definition at line 173 of file SinglePhaseFluidProperties.h.

◆ p [4/6]

e e e e p h T T T T SinglePhaseFluidProperties::p
inherited

Definition at line 175 of file SinglePhaseFluidProperties.h.

◆ p [5/6]

e e e e p h T T T T T v v v s SinglePhaseFluidProperties::p
inherited

Definition at line 185 of file SinglePhaseFluidProperties.h.

◆ p [6/6]

e e e e p h T T T T T v v v s h SinglePhaseFluidProperties::p
inherited

Definition at line 187 of file SinglePhaseFluidProperties.h.

◆ propfuncWithDefault

e e e e p h T T T T T v v v s h T e SinglePhaseFluidProperties::propfuncWithDefault(gamma, p, T)
inherited

Definition at line 190 of file SinglePhaseFluidProperties.h.

◆ rho

e e e e p h T SinglePhaseFluidProperties::rho
inherited

◆ T [1/3]

e e e e p h T T T T T SinglePhaseFluidProperties::T
inherited

Definition at line 177 of file SinglePhaseFluidProperties.h.

Referenced by IdealGasFluidProperties::c_from_p_T(), IdealGasFluidProperties::c_from_v_e(), c_from_v_e(), IdealGasFluidProperties::cp_from_p_T(), IdealGasFluidProperties::cv_from_p_T(), StiffenedGasFluidProperties::e_from_p_T(), IdealGasFluidProperties::e_from_p_T(), StiffenedGasFluidProperties::e_from_T_v(), IdealGasFluidProperties::e_from_T_v(), StiffenedGasFluidProperties::g_from_v_e(), IdealGasFluidProperties::g_from_v_e(), StiffenedGasFluidProperties::h_from_p_T(), IdealGasFluidProperties::h_from_p_T(), StiffenedGasFluidProperties::h_from_T_v(), IdealGasFluidProperties::h_from_T_v(), Water97FluidProperties::henryConstant(), IdealGasFluidProperties::k_from_p_T(), k_from_v_e(), IdealGasFluidProperties::mu_from_p_T(), StiffenedGasFluidProperties::p_from_T_v(), IdealGasFluidProperties::p_from_T_v(), p_from_v_e(), FlibeFluidProperties::p_from_v_e(), FlinakFluidProperties::p_from_v_e(), SinglePhaseFluidProperties::rho_e_from_p_T(), StiffenedGasFluidProperties::rho_from_p_s(), IdealGasFluidProperties::rho_from_p_s(), StiffenedGasFluidProperties::rho_from_p_T(), IdealGasFluidProperties::rho_from_p_T(), SinglePhaseFluidProperties::rho_mu_from_p_T(), StiffenedGasFluidProperties::s_from_p_T(), IdealGasFluidProperties::s_from_p_T(), SimpleFluidProperties::s_from_p_T(), Water97FluidProperties::s_from_p_T(), TabulatedFluidProperties::s_from_p_T(), StiffenedGasFluidProperties::s_from_T_v(), IdealGasFluidProperties::s_from_T_v(), StiffenedGasFluidProperties::s_from_v_e(), IdealGasFluidProperties::s_from_v_e(), IdealGasFluidProperties::T_from_p_h(), Water97FluidProperties::T_from_p_h(), StiffenedGasFluidProperties::T_from_v_e(), IdealGasFluidProperties::T_from_v_e(), FlibeFluidProperties::T_from_v_e(), FlinakFluidProperties::T_from_v_e(), T_from_v_e(), SinglePhaseFluidProperties::vaporPressure(), Water97FluidProperties::vaporTemperature(), and SinglePhaseFluidProperties::vaporTemperature().

◆ T [2/3]

e e e e p h T T T T T v SinglePhaseFluidProperties::T
inherited

Definition at line 179 of file SinglePhaseFluidProperties.h.

◆ T [3/3]

e e e e p h T T T T T v v SinglePhaseFluidProperties::T
inherited

Definition at line 181 of file SinglePhaseFluidProperties.h.

◆ v [1/6]

SinglePhaseFluidProperties::v
inherited

Definition at line 155 of file SinglePhaseFluidProperties.h.

Referenced by StiffenedGasFluidProperties::c_from_v_e(), IdealGasFluidProperties::c_from_v_e(), c_from_v_e(), StiffenedGasFluidProperties::cp_from_v_e(), IdealGasFluidProperties::cp_from_v_e(), FlibeFluidProperties::cp_from_v_e(), FlinakFluidProperties::cp_from_v_e(), cp_from_v_e(), FlibeFluidProperties::cv_from_p_T(), FlinakFluidProperties::cv_from_p_T(), IdealGasFluidProperties::cv_from_v_e(), FlibeFluidProperties::cv_from_v_e(), FlinakFluidProperties::cv_from_v_e(), cv_from_v_e(), FlibeFluidProperties::e_from_p_T(), FlinakFluidProperties::e_from_p_T(), StiffenedGasFluidProperties::e_from_T_v(), IdealGasFluidProperties::e_from_v_h(), StiffenedGasFluidProperties::e_from_v_h(), StiffenedGasFluidProperties::g_from_v_e(), IdealGasFluidProperties::g_from_v_e(), FlibeFluidProperties::k_from_v_e(), FlinakFluidProperties::k_from_v_e(), k_from_v_e(), FlibeFluidProperties::mu_from_v_e(), FlinakFluidProperties::mu_from_v_e(), mu_from_v_e(), StiffenedGasFluidProperties::p_from_T_v(), IdealGasFluidProperties::p_from_T_v(), IdealGasFluidProperties::p_from_v_e(), StiffenedGasFluidProperties::p_from_v_e(), p_from_v_e(), FlibeFluidProperties::p_from_v_e(), FlinakFluidProperties::p_from_v_e(), StiffenedGasFluidProperties::s_from_T_v(), IdealGasFluidProperties::s_from_T_v(), StiffenedGasFluidProperties::s_from_v_e(), IdealGasFluidProperties::s_from_v_e(), StiffenedGasFluidProperties::T_from_v_e(), IdealGasFluidProperties::T_from_v_e(), FlinakFluidProperties::T_from_v_e(), FlibeFluidProperties::T_from_v_e(), T_from_v_e(), StiffenedGasFluidProperties::v_e_spndl_from_T(), IdealGasFluidProperties::v_e_spndl_from_T(), FlibeFluidProperties::v_from_p_T(), and FlinakFluidProperties::v_from_p_T().

◆ v [2/6]

e SinglePhaseFluidProperties::v
inherited

Definition at line 157 of file SinglePhaseFluidProperties.h.

◆ v [3/6]

e e SinglePhaseFluidProperties::v
inherited

Definition at line 159 of file SinglePhaseFluidProperties.h.

◆ v [4/6]

e e e SinglePhaseFluidProperties::v
inherited

Definition at line 161 of file SinglePhaseFluidProperties.h.

◆ v [5/6]

e e e e p SinglePhaseFluidProperties::v
inherited

Definition at line 165 of file SinglePhaseFluidProperties.h.

◆ v [6/6]

e e e e p h T T T T T v v v s h T SinglePhaseFluidProperties::v
inherited

Definition at line 189 of file SinglePhaseFluidProperties.h.


The documentation for this class was generated from the following files:
HeliumFluidProperties::rho_from_p_T
virtual Real rho_from_p_T(Real p, Real T) const override
Density from pressure and temperature.
Definition: HeliumFluidProperties.C:176
HeliumFluidProperties::h_from_p_T
virtual Real h_from_p_T(Real p, Real T) const override
Specific enthalpy from pressure and temperature.
Definition: HeliumFluidProperties.C:223
HeliumFluidProperties::k_from_p_T
virtual Real k_from_p_T(Real p, Real T) const override
Thermal conductivity from pressure and temperature.
Definition: HeliumFluidProperties.C:287
pow
ExpressionBuilder::EBTerm pow(const ExpressionBuilder::EBTerm &left, T exponent)
Definition: ExpressionBuilder.h:673
SinglePhaseFluidProperties::v
v
Definition: SinglePhaseFluidProperties.h:155
HeliumFluidProperties::cp_from_v_e
virtual Real cp_from_v_e(Real v, Real e) const override
Isobaric specific heat from specific volume and specific internal energy.
Definition: HeliumFluidProperties.C:130
HeliumFluidProperties::cv_from_p_T
virtual Real cv_from_p_T(Real p, Real T) const override
Isochoric specific heat capacity from pressure and temperature.
Definition: HeliumFluidProperties.C:257
HeliumFluidProperties::mu_from_p_T
virtual Real mu_from_p_T(Real p, Real T) const override
Dynamic viscosity from pressure and temperature.
Definition: HeliumFluidProperties.C:272
HeliumFluidProperties::T_from_v_e
virtual Real T_from_v_e(Real v, Real e) const override
Temperature from specific volume and specific internal energy.
Definition: HeliumFluidProperties.C:73
SinglePhaseFluidProperties::SinglePhaseFluidProperties
SinglePhaseFluidProperties(const InputParameters &parameters)
Definition: SinglePhaseFluidProperties.C:22
SinglePhaseFluidProperties::T
e e e e p h T T T T T T
Definition: SinglePhaseFluidProperties.h:177
HeliumFluidProperties::cv_from_v_e
virtual Real cv_from_v_e(Real v, Real e) const override
Isochoric specific heat from specific volume and specific internal energy.
Definition: HeliumFluidProperties.C:140
SinglePhaseFluidProperties::rho
e e e e p h T rho
Definition: SinglePhaseFluidProperties.h:169
SinglePhaseFluidProperties::vaporPressure
virtual Real vaporPressure(Real T) const
Vapor pressure.
Definition: SinglePhaseFluidProperties.C:177
SinglePhaseFluidProperties::vaporTemperature
virtual Real vaporTemperature(Real p) const
Vapor temperature.
Definition: SinglePhaseFluidProperties.C:212
name
const std::string name
Definition: Setup.h:21
HeliumFluidProperties::p_from_v_e
virtual Real p_from_v_e(Real v, Real e) const override
Pressure from specific volume and specific internal energy.
Definition: HeliumFluidProperties.C:35
HeliumFluidProperties::_cp
const Real _cp
specific heat at constant pressure
Definition: HeliumFluidProperties.h:332
HeliumFluidProperties::_cv
const Real _cv
specific heat at constant volume
Definition: HeliumFluidProperties.h:329
SinglePhaseFluidProperties::fluidPropError
void fluidPropError(Args... args) const
Definition: SinglePhaseFluidProperties.h:326
NS::temperature
const std::string temperature
Definition: NS.h:26
HeliumFluidProperties::cp_from_p_T
virtual Real cp_from_p_T(Real p, Real T) const override
Isobaric specific heat capacity from pressure and temperature.
Definition: HeliumFluidProperties.C:243
FluidProperties::_allow_imperfect_jacobians
const bool _allow_imperfect_jacobians
Flag to set unimplemented Jacobian entries to zero.
Definition: FluidProperties.h:48
SinglePhaseFluidProperties::p
e e e e p h p
Definition: SinglePhaseFluidProperties.h:167
HeliumFluidProperties::e_from_p_T
virtual Real e_from_p_T(Real p, Real T) const override
Specific internal energy from pressure and temperature.
Definition: HeliumFluidProperties.C:208
NS::pressure
const std::string pressure
Definition: NS.h:25
SinglePhaseFluidProperties::h
e e e e h
Definition: SinglePhaseFluidProperties.h:163