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

Fluid properties for 2LiF-BeF2 (flibe) [richard]. More...

#include <FlibeFluidProperties.h>

Inheritance diagram for FlibeFluidProperties:
[legend]

Public Member Functions

 FlibeFluidProperties (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...
 
virtual 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...
 
virtual void T_from_v_e (const DualReal &v, const DualReal &e, DualReal &T, DualReal &dT_dv, DualReal &dT_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...
 
virtual void cp_from_v_e (Real v, Real e, Real &cp, Real &dcp_dv, Real &dcp_de) const override
 Isobaric specific heat and its derivatives 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...
 
virtual void cv_from_v_e (Real v, Real e, Real &cv, Real &dcv_dv, Real &dcv_de) const override
 Isochoric specific heat and its derivatives from specific volume and specific internal energy. More...
 
virtual void cv_from_v_e (const DualReal &v, const DualReal &e, DualReal &cv, DualReal &dcv_dv, DualReal &dcv_de) const override
 
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 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 v_from_p_T (Real p, Real T) const override
 Specific volume from pressure and temperature. More...
 
virtual DualReal v_from_p_T (const DualReal &p, const DualReal &T) const override
 
virtual void v_from_p_T (Real p, Real T, Real &v, Real &dv_dp, Real &dv_dT) const override
 Specific volume 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 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 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
 
virtual Real molarMass () const override
 Molar mass. 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 & _drho_dp
 Derivative of density with respect to pressure at fixed temperature. More...
 
const Real _drho_dT
 Derivative of density with respect to temperature at fixed pressure. More...
 
const Real _p_atm
 Atmospheric pressure, Pa. More...
 
const Real _cp
 specific heat at constant pressure More...
 
const Real _c0
 additive constant to rho(P, T) correlation More...
 
const Real _dp_dT_at_constant_v
 derivative of pressure with respect to temperature at constant specific volume 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 2LiF-BeF2 (flibe) [richard].

Definition at line 22 of file FlibeFluidProperties.h.

Constructor & Destructor Documentation

◆ FlibeFluidProperties()

FlibeFluidProperties::FlibeFluidProperties ( const InputParameters &  parameters)

Definition at line 28 of file FlibeFluidProperties.C.

29  : SinglePhaseFluidProperties(parameters),
30  _drho_dp(getParam<Real>("drho_dp")),
31  _drho_dT(-0.4884),
32  _p_atm(101325.0),
33  _cp(2416.0),
34  _c0(2413.0),
36 {
37 }

Member Function Documentation

◆ cp_from_p_T() [1/2]

Real FlibeFluidProperties::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 291 of file FlibeFluidProperties.C.

292 {
293  return _cp;
294 }

Referenced by cp_from_p_T().

◆ cp_from_p_T() [2/2]

void FlibeFluidProperties::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)

Definition at line 297 of file FlibeFluidProperties.C.

299 {
301  dcp_dp = 0.0;
302  dcp_dT = 0.0;
303 }

◆ cp_from_v_e() [1/2]

Real FlibeFluidProperties::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 146 of file FlibeFluidProperties.C.

146 { return _cp; }

Referenced by cp_from_v_e(), cv_from_v_e(), e_from_p_T(), h_from_p_T(), p_from_v_e(), and T_from_v_e().

◆ cp_from_v_e() [2/2]

void FlibeFluidProperties::cp_from_v_e ( Real  v,
Real  e,
Real &  cp,
Real &  dcp_dv,
Real &  dcp_de 
) const
overridevirtual

Isobaric specific heat and its derivatives 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 149 of file FlibeFluidProperties.C.

150 {
151  cp = cp_from_v_e(v, e);
152  dcp_dv = 0.0;
153  dcp_de = 0.0;
154 }

◆ 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 FlibeFluidProperties::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 306 of file FlibeFluidProperties.C.

307 {
308  Real v = v_from_p_T(pressure, temperature);
309  Real e = e_from_p_T(pressure, temperature);
310  return cv_from_v_e(v, e);
311 }

Referenced by cv_from_p_T().

◆ cv_from_p_T() [2/2]

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

Definition at line 314 of file FlibeFluidProperties.C.

316 {
318  dcv_dp = 0.0;
319  dcv_dT = 0.0;
320 }

◆ cv_from_v_e() [1/3]

void FlibeFluidProperties::cv_from_v_e ( const DualReal &  v,
const DualReal &  e,
DualReal &  cv,
DualReal &  dcv_dv,
DualReal &  dcv_de 
) const
overridevirtual

Definition at line 173 of file FlibeFluidProperties.C.

178 {
179  cv = SinglePhaseFluidProperties::cv_from_v_e(v, e);
180  dcv_dv = -_dp_dT_at_constant_v;
181  dcv_de = 0.0;
182 }

◆ cv_from_v_e() [2/3]

Real FlibeFluidProperties::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 157 of file FlibeFluidProperties.C.

158 {
159  // definition of Cv by replacing e by h + p * v
160  Real cp = cp_from_v_e(v, e);
161  return cp - _dp_dT_at_constant_v * v;
162 }

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

◆ cv_from_v_e() [3/3]

void FlibeFluidProperties::cv_from_v_e ( Real  v,
Real  e,
Real &  cv,
Real &  dcv_dv,
Real &  dcv_de 
) const
overridevirtual

Isochoric specific heat and its derivatives 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 165 of file FlibeFluidProperties.C.

166 {
167  cv = cv_from_v_e(v, e);
168  dcv_dv = -_dp_dT_at_constant_v;
169  dcv_de = 0.0;
170 }

◆ e_from_p_T() [1/2]

Real FlibeFluidProperties::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 266 of file FlibeFluidProperties.C.

267 {
268  // definition of h = e + p * v
269  Real v = v_from_p_T(pressure, temperature);
270  Real cp = cp_from_v_e(v, 0.0 /* dummy */);
271  return cp * temperature - pressure * v;
272 }

Referenced by cv_from_p_T(), and e_from_p_T().

◆ e_from_p_T() [2/2]

void FlibeFluidProperties::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 275 of file FlibeFluidProperties.C.

277 {
279 
280  Real v, dv_dp, dv_dT;
281  v_from_p_T(pressure, temperature, v, dv_dp, dv_dT);
282 
283  // definition of e = h - p * v
284  de_dp = -pressure * dv_dp - v;
285 
286  // definition of e = h - p * v
287  Real cp = cp_from_v_e(v, e);
288  de_dT = cp - pressure * dv_dT;
289 }

◆ 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 FlibeFluidProperties::fluidName ( ) const
overridevirtual

Fluid name.

Returns
"flibe"

Definition at line 40 of file FlibeFluidProperties.C.

41 {
42  return "flibe";
43 }

◆ 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 FlibeFluidProperties::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 247 of file FlibeFluidProperties.C.

248 {
249  // definition of h for constant Cp
250  Real cp = cp_from_v_e(0.0 /* dummy */, 0.0 /* dummy */);
251  return cp * temperature;
252 }

Referenced by h_from_p_T().

◆ h_from_p_T() [2/2]

void FlibeFluidProperties::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 255 of file FlibeFluidProperties.C.

257 {
259  Real cp = cp_from_v_e(0.0 /* dummy */, 0.0 /* dummy */);
260 
261  dh_dp = 0.0;
262  dh_dT = cp;
263 }

◆ 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 FlibeFluidProperties::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 338 of file FlibeFluidProperties.C.

339 {
340  return 5.0e-4 * temperature + 0.63;
341 }

Referenced by k_from_p_T().

◆ k_from_p_T() [2/2]

void FlibeFluidProperties::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 344 of file FlibeFluidProperties.C.

346 {
347  k = this->k_from_p_T(pressure, temperature);
348  dk_dp = 0.0;
349  dk_dT = 5.0e-4;
350 }

◆ k_from_v_e()

Real FlibeFluidProperties::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 192 of file FlibeFluidProperties.C.

193 {
194  Real temperature = T_from_v_e(v, e);
195  return 5.0e-4 * temperature + 0.63;
196 }

◆ molarMass()

Real FlibeFluidProperties::molarMass ( ) const
overridevirtual

Molar mass.

Returns
molar mass (kg/mol)

Reimplemented from SinglePhaseFluidProperties.

Definition at line 46 of file FlibeFluidProperties.C.

47 {
48  return 99.037703E-3;
49 }

◆ mu_from_p_T() [1/2]

Real FlibeFluidProperties::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 323 of file FlibeFluidProperties.C.

324 {
325  return 1.16e-4 * std::exp(3755.0 / temperature);
326 }

Referenced by mu_from_p_T().

◆ mu_from_p_T() [2/2]

void FlibeFluidProperties::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 329 of file FlibeFluidProperties.C.

331 {
332  mu = this->mu_from_p_T(pressure, temperature);
333  dmu_dp = 0.0;
334  dmu_dT = -1.16e-4 * std::exp(3755.0 / temperature) * 3755.0 / (temperature * temperature);
335 }

◆ mu_from_v_e()

Real FlibeFluidProperties::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 185 of file FlibeFluidProperties.C.

186 {
187  Real temperature = T_from_v_e(v, e);
188  return 1.16e-4 * std::exp(3755.0 / temperature);
189 }

◆ p_from_v_e() [1/3]

void FlibeFluidProperties::p_from_v_e ( const DualReal &  v,
const DualReal &  e,
DualReal &  p,
DualReal &  dp_dv,
DualReal &  dp_de 
) const
overridevirtual

Definition at line 76 of file FlibeFluidProperties.C.

78 {
79  p = SinglePhaseFluidProperties::p_from_v_e(v, e);
80 
81  // chain rule, (dp_de)_v = (dp_dT)_v * (dT_de)_v
82  DualReal T, dT_dv, dT_de;
83  T_from_v_e(v, e, T, dT_dv, dT_de);
84  dp_de = _dp_dT_at_constant_v * dT_de;
85 
86  // cyclic relation, (dP_dv)_e = - (dp_de)_v * (de_dv)_p
87  auto cp = SinglePhaseFluidProperties::cp_from_v_e(v, e);
88  auto dT_dv_at_constant_p = -1.0 / (_drho_dT * v * v);
89  auto de_dv_at_constant_p = cp * dT_dv_at_constant_p - p;
90  dp_dv = -dp_de * de_dv_at_constant_p;
91 }

◆ p_from_v_e() [2/3]

Real FlibeFluidProperties::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 52 of file FlibeFluidProperties.C.

53 {
54  Real temperature = T_from_v_e(v, e);
55  return (1.0 / v - _drho_dT * temperature - _c0) / _drho_dp + _p_atm;
56 }

Referenced by p_from_v_e(), and T_from_v_e().

◆ p_from_v_e() [3/3]

void FlibeFluidProperties::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 59 of file FlibeFluidProperties.C.

60 {
61  p = p_from_v_e(v, e);
62 
63  // chain rule, (dp_de)_v = (dp_dT)_v * (dT_de)_v
64  Real T, dT_dv, dT_de;
65  T_from_v_e(v, e, T, dT_dv, dT_de);
66  dp_de = _dp_dT_at_constant_v * dT_de;
67 
68  // cyclic relation, (dP_dv)_e = - (dp_de)_v * (de_dv)_p
69  Real cp = cp_from_v_e(v, e);
70  Real dT_dv_at_constant_p = -1.0 / (_drho_dT * v * v);
71  Real de_dv_at_constant_p = cp * dT_dv_at_constant_p - p;
72  dp_dv = -dp_de * de_dv_at_constant_p;
73 }

◆ 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 FlibeFluidProperties::rho_from_p_T ( const DualReal &  p,
const DualReal &  T,
DualReal &  rho,
DualReal &  drho_dp,
DualReal &  drho_dT 
) const
overridevirtual

Definition at line 214 of file FlibeFluidProperties.C.

219 {
220  rho = SinglePhaseFluidProperties::rho_from_p_T(pressure, temperature);
221  drho_dp = _drho_dp;
222  drho_dT = _drho_dT;
223 }

◆ rho_from_p_T() [2/3]

Real FlibeFluidProperties::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 199 of file FlibeFluidProperties.C.

200 {
201  return _drho_dT * temperature + _drho_dp * (pressure - _p_atm) + _c0;
202 }

Referenced by rho_from_p_T().

◆ rho_from_p_T() [3/3]

void FlibeFluidProperties::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 205 of file FlibeFluidProperties.C.

207 {
209  drho_dp = _drho_dp;
210  drho_dT = _drho_dT;
211 }

◆ 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 FlibeFluidProperties::T_from_v_e ( const DualReal &  v,
const DualReal &  e,
DualReal &  T,
DualReal &  dT_dv,
DualReal &  dT_de 
) const
overridevirtual

Definition at line 130 of file FlibeFluidProperties.C.

132 {
133  T = SinglePhaseFluidProperties::T_from_v_e(v, e);
134 
135  // reciprocity relation based on the definition of cv
136  auto cv = SinglePhaseFluidProperties::cv_from_v_e(v, e);
137  dT_de = 1.0 / cv;
138 
139  // cyclic relation, (dT_dv)_e = -(dT_de)_v * (de_dv)_T
140  auto p = SinglePhaseFluidProperties::p_from_v_e(v, e);
141  auto dp_dv_at_constant_T = -1.0 / (_drho_dp * v * v);
142  auto de_dv_at_constant_T = -(p + v * dp_dv_at_constant_T);
143  dT_dv = -dT_de * de_dv_at_constant_T;
144 }

◆ T_from_v_e() [2/3]

Real FlibeFluidProperties::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 94 of file FlibeFluidProperties.C.

95 {
96  // We need to write these in a somewhat strange manner to ensure that pressure
97  // and temperature do not depend implicitly on each other, causing a circular
98  // logic problem. Substituting the definition for pressure based on the
99  // rho * (h - e) = P, where h = Cp * T into the density correlation for flibe,
100  // we can rearrange and get temperature in terms of only v and e
101 
102  // p = (Cp * T - e) / v
103  // T = (1 / v - drho_dp * [p - p_atm] + _c0) / drho_dT
104  // = (1 / v - drho_dp * [(Cp * T - e) / v - p_atm] + _c0) / drho_dT
105  // = (1 + drho_dp * e + p_atm * v * drho_dp - _c0 * v) / (drho_dT * v + drho_dp * Cp)
106 
107  Real cp = cp_from_v_e(v, e);
108  Real numerator = 1.0 + _drho_dp * (e + _p_atm * v) - _c0 * v;
109  Real denominator = _drho_dT * v + _drho_dp * cp;
110  return numerator / denominator;
111 }

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

◆ T_from_v_e() [3/3]

void FlibeFluidProperties::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 114 of file FlibeFluidProperties.C.

115 {
116  T = T_from_v_e(v, e);
117 
118  // reciprocity relation based on the definition of cv
119  Real cv = cv_from_v_e(v, e);
120  dT_de = 1.0 / cv;
121 
122  // cyclic relation, (dT_dv)_e = -(dT_de)_v * (de_dv)_T
123  Real p = p_from_v_e(v, e);
124  Real dp_dv_at_constant_T = -1.0 / (_drho_dp * v * v);
125  Real de_dv_at_constant_T = -(p + v * dp_dv_at_constant_T);
126  dT_dv = -dT_de * de_dv_at_constant_T;
127 }

◆ 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().

◆ v_from_p_T() [1/3]

DualReal FlibeFluidProperties::v_from_p_T ( const DualReal &  p,
const DualReal &  T 
) const
overridevirtual

Definition at line 226 of file FlibeFluidProperties.C.

227 {
228  return 1.0 / (_drho_dT * temperature + _drho_dp * (pressure - _p_atm) + _c0);
229 }

◆ v_from_p_T() [2/3]

Real FlibeFluidProperties::v_from_p_T ( Real  p,
Real  T 
) const
overridevirtual

Specific volume from pressure and temperature.

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

Definition at line 232 of file FlibeFluidProperties.C.

233 {
234  return 1.0 / (_drho_dT * temperature + _drho_dp * (pressure - _p_atm) + _c0);
235 }

Referenced by cv_from_p_T(), e_from_p_T(), and v_from_p_T().

◆ v_from_p_T() [3/3]

void FlibeFluidProperties::v_from_p_T ( Real  p,
Real  T,
Real &  v,
Real &  dv_dp,
Real &  dv_dT 
) const
overridevirtual

Specific volume and its derivatives from pressure and temperature.

Parameters
[in]ppressure (Pa)
[in]Ttemperature (K)
[out]vspecific volume (m$^3$/kg)
[out]dv_dpderivative of specific volume w.r.t. pressure
[out]dv_dTderivative of specific volume w.r.t. temperature

Definition at line 238 of file FlibeFluidProperties.C.

240 {
242  dv_dp = -v * v * _drho_dp;
243  dv_dT = -v * v * _drho_dT;
244 }

◆ 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().

◆ _c0

const Real FlibeFluidProperties::_c0
protected

additive constant to rho(P, T) correlation

Definition at line 334 of file FlibeFluidProperties.h.

Referenced by p_from_v_e(), rho_from_p_T(), T_from_v_e(), and v_from_p_T().

◆ _cp

const Real FlibeFluidProperties::_cp
protected

specific heat at constant pressure

Definition at line 331 of file FlibeFluidProperties.h.

Referenced by cp_from_p_T(), and cp_from_v_e().

◆ _dp_dT_at_constant_v

const Real FlibeFluidProperties::_dp_dT_at_constant_v
protected

derivative of pressure with respect to temperature at constant specific volume

Definition at line 337 of file FlibeFluidProperties.h.

Referenced by cv_from_v_e(), and p_from_v_e().

◆ _drho_dp

const Real& FlibeFluidProperties::_drho_dp
protected

Derivative of density with respect to pressure at fixed temperature.

Definition at line 322 of file FlibeFluidProperties.h.

Referenced by p_from_v_e(), rho_from_p_T(), T_from_v_e(), and v_from_p_T().

◆ _drho_dT

const Real FlibeFluidProperties::_drho_dT
protected

Derivative of density with respect to temperature at fixed pressure.

Definition at line 325 of file FlibeFluidProperties.h.

Referenced by p_from_v_e(), rho_from_p_T(), T_from_v_e(), and v_from_p_T().

◆ _p_atm

const Real FlibeFluidProperties::_p_atm
protected

Atmospheric pressure, Pa.

Definition at line 328 of file FlibeFluidProperties.h.

Referenced by p_from_v_e(), rho_from_p_T(), T_from_v_e(), and v_from_p_T().

◆ _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(), HeliumFluidProperties::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(), HeliumFluidProperties::p_from_v_e(), FlinakFluidProperties::p_from_v_e(), 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(), 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(), HeliumFluidProperties::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(), HeliumFluidProperties::k_from_v_e(), IdealGasFluidProperties::mu_from_p_T(), StiffenedGasFluidProperties::p_from_T_v(), IdealGasFluidProperties::p_from_T_v(), HeliumFluidProperties::p_from_v_e(), 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(), T_from_v_e(), FlinakFluidProperties::T_from_v_e(), HeliumFluidProperties::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(), HeliumFluidProperties::c_from_v_e(), StiffenedGasFluidProperties::cp_from_v_e(), IdealGasFluidProperties::cp_from_v_e(), cp_from_v_e(), FlinakFluidProperties::cp_from_v_e(), HeliumFluidProperties::cp_from_v_e(), cv_from_p_T(), FlinakFluidProperties::cv_from_p_T(), IdealGasFluidProperties::cv_from_v_e(), cv_from_v_e(), FlinakFluidProperties::cv_from_v_e(), HeliumFluidProperties::cv_from_v_e(), 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(), k_from_v_e(), FlinakFluidProperties::k_from_v_e(), HeliumFluidProperties::k_from_v_e(), mu_from_v_e(), FlinakFluidProperties::mu_from_v_e(), HeliumFluidProperties::mu_from_v_e(), StiffenedGasFluidProperties::p_from_T_v(), IdealGasFluidProperties::p_from_T_v(), IdealGasFluidProperties::p_from_v_e(), StiffenedGasFluidProperties::p_from_v_e(), HeliumFluidProperties::p_from_v_e(), 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(), T_from_v_e(), HeliumFluidProperties::T_from_v_e(), StiffenedGasFluidProperties::v_e_spndl_from_T(), IdealGasFluidProperties::v_e_spndl_from_T(), 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:
FlibeFluidProperties::e_from_p_T
virtual Real e_from_p_T(Real p, Real T) const override
Specific internal energy from pressure and temperature.
Definition: FlibeFluidProperties.C:266
FlibeFluidProperties::_c0
const Real _c0
additive constant to rho(P, T) correlation
Definition: FlibeFluidProperties.h:334
SinglePhaseFluidProperties::v
v
Definition: SinglePhaseFluidProperties.h:155
FlibeFluidProperties::_dp_dT_at_constant_v
const Real _dp_dT_at_constant_v
derivative of pressure with respect to temperature at constant specific volume
Definition: FlibeFluidProperties.h:337
FlibeFluidProperties::_p_atm
const Real _p_atm
Atmospheric pressure, Pa.
Definition: FlibeFluidProperties.h:328
FlibeFluidProperties::_drho_dT
const Real _drho_dT
Derivative of density with respect to temperature at fixed pressure.
Definition: FlibeFluidProperties.h:325
FlibeFluidProperties::_cp
const Real _cp
specific heat at constant pressure
Definition: FlibeFluidProperties.h:331
FlibeFluidProperties::mu_from_p_T
virtual Real mu_from_p_T(Real p, Real T) const override
Dynamic viscosity from pressure and temperature.
Definition: FlibeFluidProperties.C:323
SinglePhaseFluidProperties::SinglePhaseFluidProperties
SinglePhaseFluidProperties(const InputParameters &parameters)
Definition: SinglePhaseFluidProperties.C:22
FlibeFluidProperties::_drho_dp
const Real & _drho_dp
Derivative of density with respect to pressure at fixed temperature.
Definition: FlibeFluidProperties.h:322
FlibeFluidProperties::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: FlibeFluidProperties.C:146
FlibeFluidProperties::k_from_p_T
virtual Real k_from_p_T(Real p, Real T) const override
Thermal conductivity from pressure and temperature.
Definition: FlibeFluidProperties.C:338
SinglePhaseFluidProperties::T
e e e e p h T T T T T T
Definition: SinglePhaseFluidProperties.h:177
FlibeFluidProperties::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: FlibeFluidProperties.C:306
FlibeFluidProperties::rho_from_p_T
virtual Real rho_from_p_T(Real p, Real T) const override
Density from pressure and temperature.
Definition: FlibeFluidProperties.C:199
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
FlibeFluidProperties::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: FlibeFluidProperties.C:291
FlibeFluidProperties::v_from_p_T
virtual Real v_from_p_T(Real p, Real T) const override
Specific volume from pressure and temperature.
Definition: FlibeFluidProperties.C:232
SinglePhaseFluidProperties::fluidPropError
void fluidPropError(Args... args) const
Definition: SinglePhaseFluidProperties.h:326
FlibeFluidProperties::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: FlibeFluidProperties.C:94
NS::temperature
const std::string temperature
Definition: NS.h:26
FluidProperties::_allow_imperfect_jacobians
const bool _allow_imperfect_jacobians
Flag to set unimplemented Jacobian entries to zero.
Definition: FluidProperties.h:48
FlibeFluidProperties::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: FlibeFluidProperties.C:157
FlibeFluidProperties::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: FlibeFluidProperties.C:52
SinglePhaseFluidProperties::p
e e e e p h p
Definition: SinglePhaseFluidProperties.h:167
FlibeFluidProperties::h_from_p_T
virtual Real h_from_p_T(Real p, Real T) const override
Specific enthalpy from pressure and temperature.
Definition: FlibeFluidProperties.C:247
NS::pressure
const std::string pressure
Definition: NS.h:25
SinglePhaseFluidProperties::h
e e e e h
Definition: SinglePhaseFluidProperties.h:163