Fluid properties of a simple, idealised fluid density=density0 * exp(P / bulk_modulus - thermal_expansion * T) internal_energy = cv * T enthalpy = cv * T + P / density The following parameters are constant: thermal expansion cv cp bulk modulus thermal conductivity specific entropy viscosity. More...
#include <SimpleFluidProperties.h>
Public Member Functions | |
SimpleFluidProperties (const InputParameters ¶meters) | |
virtual | ~SimpleFluidProperties () |
virtual std::string | fluidName () const override |
virtual Real | molarMass () const override |
Fluid name. More... | |
virtual Real | beta_from_p_T (Real pressure, Real temperature) const override |
virtual void | beta_from_p_T (Real pressure, Real temperature, Real &beta, Real &dbeta_dp, Real &dbeta_dT) const override |
virtual Real | cp_from_p_T (Real pressure, Real temperature) const override |
virtual void | cp_from_p_T (Real pressure, Real temperature, Real &cp, Real &dcp_dp, Real &dcp_dT) const override |
virtual Real | cv_from_p_T (Real pressure, Real temperature) const override |
virtual Real | c_from_p_T (Real pressure, Real temperature) const override |
virtual Real | k_from_p_T (Real pressure, Real temperature) const override |
virtual void | k_from_p_T (Real pressure, Real temperature, Real &k, Real &dk_dp, Real &dk_dT) const override |
virtual Real | s_from_p_T (Real pressure, Real temperature) const override |
virtual void | s_from_p_T (Real p, Real T, Real &s, Real &ds_dp, Real &ds_dT) const override |
virtual Real | rho_from_p_T (Real pressure, Real temperature) const override |
virtual void | rho_from_p_T (Real pressure, Real temperature, Real &rho, Real &drho_dp, Real &drho_dT) const override |
virtual Real | e_from_p_T (Real pressure, Real temperature) const override |
virtual void | e_from_p_T (Real pressure, Real temperature, Real &e, Real &de_dp, Real &de_dT) const override |
virtual Real | mu_from_p_T (Real pressure, Real temperature) const override |
virtual void | mu_from_p_T (Real pressure, Real temperature, Real &mu, Real &dmu_dp, Real &dmu_dT) const override |
virtual Real | h_from_p_T (Real p, Real T) const override |
virtual void | h_from_p_T (Real pressure, Real temperature, Real &h, Real &dh_dp, Real &dh_dT) const override |
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 | _molar_mass |
molar mass More... | |
const Real | _thermal_expansion |
thermal expansion coefficient More... | |
const Real | _cv |
specific heat at constant volume More... | |
const Real | _cp |
specific heat at constant pressure More... | |
const Real | _bulk_modulus |
bulk modulus More... | |
const Real | _thermal_conductivity |
thermal conductivity More... | |
const Real | _specific_entropy |
specific entropy More... | |
const Real | _viscosity |
viscosity More... | |
const Real | _density0 |
density at zero pressure and temperature More... | |
const Real | _pp_coeff |
Porepressure coefficient: enthalpy = internal_energy + porepressure / density * _pp_coeff. 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... | |
e | 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 v s | propfunc (g, v, e) propfuncWithDefault(T |
v | |
e | 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 v s | p |
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 T e | propfuncWithDefault (gamma, p, T) |
Fluid properties of a simple, idealised fluid density=density0 * exp(P / bulk_modulus - thermal_expansion * T) internal_energy = cv * T enthalpy = cv * T + P / density The following parameters are constant: thermal expansion cv cp bulk modulus thermal conductivity specific entropy viscosity.
Definition at line 36 of file SimpleFluidProperties.h.
SimpleFluidProperties::SimpleFluidProperties | ( | const InputParameters & | parameters | ) |
Definition at line 41 of file SimpleFluidProperties.C.
|
virtual |
Definition at line 56 of file SimpleFluidProperties.C.
|
overridevirtual |
Definition at line 70 of file SimpleFluidProperties.C.
Referenced by beta_from_p_T().
|
overridevirtual |
Definition at line 76 of file SimpleFluidProperties.C.
|
overridevirtual |
Definition at line 104 of file SimpleFluidProperties.C.
|
overridevirtual |
Definition at line 84 of file SimpleFluidProperties.C.
Referenced by cp_from_p_T().
|
overridevirtual |
Definition at line 90 of file SimpleFluidProperties.C.
|
virtualinherited |
Critical density.
Reimplemented in IdealGasFluidProperties, CO2FluidProperties, HydrogenFluidProperties, NitrogenFluidProperties, StiffenedGasFluidProperties, MethaneFluidProperties, NaClFluidProperties, and Water97FluidProperties.
Definition at line 120 of file SinglePhaseFluidProperties.C.
Referenced by HelmholtzFluidProperties::c_from_p_T(), HelmholtzFluidProperties::cp_from_p_T(), HelmholtzFluidProperties::cv_from_p_T(), HelmholtzFluidProperties::e_from_p_T(), HelmholtzFluidProperties::h_from_p_T(), HelmholtzFluidProperties::p_from_rho_T(), IdealRealGasMixtureFluidProperties::p_T_from_v_e(), HelmholtzFluidProperties::rho_from_p_T(), HelmholtzFluidProperties::s_from_p_T(), IdealRealGasMixtureFluidProperties::T_from_p_v(), and IdealRealGasMixtureFluidProperties::v_from_p_T().
|
virtualinherited |
Critical specific internal energy.
Reimplemented in IdealGasFluidProperties, and StiffenedGasFluidProperties.
Definition at line 126 of file SinglePhaseFluidProperties.C.
Referenced by IdealRealGasMixtureFluidProperties::p_T_from_v_e(), and IdealRealGasMixtureFluidProperties::T_from_p_v().
|
virtualinherited |
Critical pressure.
Reimplemented in CO2FluidProperties, HydrogenFluidProperties, NitrogenFluidProperties, MethaneFluidProperties, NaClFluidProperties, and Water97FluidProperties.
Definition at line 108 of file SinglePhaseFluidProperties.C.
|
virtualinherited |
Critical temperature.
Reimplemented in IdealGasFluidProperties, CO2FluidProperties, HydrogenFluidProperties, NitrogenFluidProperties, StiffenedGasFluidProperties, MethaneFluidProperties, NaClFluidProperties, and Water97FluidProperties.
Definition at line 114 of file SinglePhaseFluidProperties.C.
Referenced by HelmholtzFluidProperties::c_from_p_T(), HelmholtzFluidProperties::cp_from_p_T(), HelmholtzFluidProperties::cv_from_p_T(), HelmholtzFluidProperties::e_from_p_T(), HelmholtzFluidProperties::h_from_p_T(), HelmholtzFluidProperties::p_from_rho_T(), HelmholtzFluidProperties::rho_from_p_T(), HelmholtzFluidProperties::s_from_p_T(), IdealRealGasMixtureFluidProperties::v_from_p_T(), and IdealRealGasMixtureFluidProperties::xs_prim_from_p_T().
|
overridevirtual |
Definition at line 98 of file SimpleFluidProperties.C.
|
overridevirtual |
Definition at line 150 of file SimpleFluidProperties.C.
Referenced by e_from_p_T(), and h_from_p_T().
|
overridevirtual |
Definition at line 156 of file SimpleFluidProperties.C.
|
virtualinherited |
Specific internal energy from temperature and specific volume.
[in] | T | temperature |
[in] | v | specific volume |
Reimplemented in IdealGasFluidProperties, and StiffenedGasFluidProperties.
Definition at line 286 of file SinglePhaseFluidProperties.C.
Referenced by IdealRealGasMixtureFluidProperties::p_T_from_v_e(), and IdealRealGasMixtureFluidProperties::T_from_p_v().
|
inlinefinalvirtualinherited |
Definition at line 34 of file FluidProperties.h.
|
inlinefinalvirtualinherited |
Definition at line 36 of file FluidProperties.h.
|
overridevirtual |
Definition at line 59 of file SimpleFluidProperties.C.
|
inlineprivateinherited |
Definition at line 326 of file SinglePhaseFluidProperties.h.
Referenced by SinglePhaseFluidProperties::vaporPressure(), and SinglePhaseFluidProperties::vaporTemperature().
|
overridevirtual |
|
overridevirtual |
Definition at line 186 of file SimpleFluidProperties.C.
|
virtualinherited |
Henry's law coefficients for dissolution in water.
Reimplemented in CO2FluidProperties, TabulatedFluidProperties, HydrogenFluidProperties, NitrogenFluidProperties, and MethaneFluidProperties.
Definition at line 183 of file SinglePhaseFluidProperties.C.
Referenced by TabulatedFluidProperties::henryCoefficients().
|
inlinefinalvirtualinherited |
Definition at line 35 of file FluidProperties.h.
|
overridevirtual |
Definition at line 109 of file SimpleFluidProperties.C.
|
overridevirtual |
Definition at line 115 of file SimpleFluidProperties.C.
|
overridevirtual |
Fluid name.
Reimplemented from SinglePhaseFluidProperties.
Definition at line 65 of file SimpleFluidProperties.C.
|
overridevirtual |
Definition at line 164 of file SimpleFluidProperties.C.
Referenced by mu_from_p_T().
|
overridevirtual |
Definition at line 170 of file SimpleFluidProperties.C.
|
inherited |
|
inherited |
|
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
|
inherited |
|
inherited |
|
virtualinherited |
|
overridevirtual |
Definition at line 135 of file SimpleFluidProperties.C.
Referenced by c_from_p_T(), h_from_p_T(), and rho_from_p_T().
|
overridevirtual |
Definition at line 141 of file SimpleFluidProperties.C.
|
virtualinherited |
|
virtualinherited |
Reimplemented in Water97FluidProperties, CO2FluidProperties, HydrogenFluidProperties, and NitrogenFluidProperties.
Definition at line 263 of file SinglePhaseFluidProperties.C.
|
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.
Referenced by PorousFlowSingleComponentFluid::computeQpProperties(), PorousFlowWaterNCG::gasProperties(), PorousFlowBrineCO2::gasProperties(), and PorousFlowWaterNCG::liquidProperties().
|
overridevirtual |
Definition at line 129 of file SimpleFluidProperties.C.
|
overridevirtual |
Definition at line 123 of file SimpleFluidProperties.C.
|
inlinefinalvirtualinherited |
Definition at line 39 of file FluidProperties.h.
|
inlinefinalvirtualinherited |
Definition at line 38 of file FluidProperties.h.
|
virtualinherited |
Triple point pressure.
Reimplemented in CO2FluidProperties, HydrogenFluidProperties, NitrogenFluidProperties, MethaneFluidProperties, NaClFluidProperties, and Water97FluidProperties.
Definition at line 132 of file SinglePhaseFluidProperties.C.
|
virtualinherited |
Triple point temperature.
Reimplemented in CO2FluidProperties, HydrogenFluidProperties, NitrogenFluidProperties, MethaneFluidProperties, NaClFluidProperties, and Water97FluidProperties.
Definition at line 138 of file SinglePhaseFluidProperties.C.
|
virtualinherited |
Specific internal energy from temperature and specific volume.
[in] | T | temperature |
[in] | v | specific volume |
Reimplemented in IdealGasFluidProperties, and StiffenedGasFluidProperties.
Definition at line 292 of file SinglePhaseFluidProperties.C.
Referenced by IdealRealGasMixtureFluidProperties::v_from_p_T().
|
inherited |
Definition at line 198 of file SinglePhaseFluidProperties.C.
|
virtualinherited |
Vapor pressure.
Used to delineate liquid and gas phases. Valid for temperatures between the triple point temperature and the critical temperature
T | fluid temperature (K) | |
[out] | saturation | pressure (Pa) |
[out] | derivative | of saturation pressure wrt temperature (Pa/K) |
Reimplemented in TabulatedFluidProperties, CO2FluidProperties, Water97FluidProperties, HydrogenFluidProperties, NitrogenFluidProperties, and MethaneFluidProperties.
Definition at line 177 of file SinglePhaseFluidProperties.C.
Referenced by PorousFlowWaterNCG::equilibriumMassFractions(), PorousFlowWaterNCG::gasDensity(), PorousFlowWaterNCG::gasProperties(), BrineFluidProperties::vaporPressure(), TabulatedFluidProperties::vaporPressure(), and SinglePhaseFluidProperties::vaporPressure().
|
virtualinherited |
Reimplemented in TabulatedFluidProperties, CO2FluidProperties, Water97FluidProperties, HydrogenFluidProperties, NitrogenFluidProperties, and MethaneFluidProperties.
Definition at line 189 of file SinglePhaseFluidProperties.C.
|
inherited |
Definition at line 227 of file SinglePhaseFluidProperties.C.
|
virtualinherited |
Vapor temperature.
Used to delineate liquid and gas phases. Valid for pressures between the triple point pressure and the critical pressure
p | fluid pressure (Pa) | |
[out] | saturation | temperature (K) |
[out] | derivative | of saturation temperature wrt pressure |
Reimplemented in Water97FluidProperties.
Definition at line 212 of file SinglePhaseFluidProperties.C.
Referenced by PorousFlowWaterVapor::thermophysicalProperties(), and SinglePhaseFluidProperties::vaporTemperature().
|
virtualinherited |
Reimplemented in Water97FluidProperties.
Definition at line 218 of file SinglePhaseFluidProperties.C.
|
protectedinherited |
Flag to set unimplemented Jacobian entries to zero.
Definition at line 48 of file FluidProperties.h.
Referenced by SinglePhaseFluidProperties::fluidPropError().
|
protected |
bulk modulus
Definition at line 105 of file SimpleFluidProperties.h.
Referenced by c_from_p_T(), and rho_from_p_T().
|
protected |
specific heat at constant pressure
Definition at line 102 of file SimpleFluidProperties.h.
Referenced by cp_from_p_T().
|
protected |
specific heat at constant volume
Definition at line 99 of file SimpleFluidProperties.h.
Referenced by cv_from_p_T(), e_from_p_T(), and h_from_p_T().
|
protected |
density at zero pressure and temperature
Definition at line 117 of file SimpleFluidProperties.h.
Referenced by rho_from_p_T().
|
protected |
|
protected |
Porepressure coefficient: enthalpy = internal_energy + porepressure / density * _pp_coeff.
Definition at line 120 of file SimpleFluidProperties.h.
Referenced by h_from_p_T().
|
staticinherited |
Universal gas constant (J/mol/K)
Definition at line 42 of file FluidProperties.h.
Referenced by HelmholtzFluidProperties::c_from_p_T(), IdealGasFluidProperties::c_from_p_T(), HelmholtzFluidProperties::cp_from_p_T(), HelmholtzFluidProperties::cv_from_p_T(), HelmholtzFluidProperties::e_from_p_T(), HelmholtzFluidProperties::h_from_p_T(), HelmholtzFluidProperties::p_from_rho_T(), HelmholtzFluidProperties::rho_from_p_T(), IdealGasFluidProperties::rho_from_p_T(), and HelmholtzFluidProperties::s_from_p_T().
|
protected |
specific entropy
Definition at line 111 of file SimpleFluidProperties.h.
Referenced by s_from_p_T().
|
protectedinherited |
Conversion of temperature from Celsius to Kelvin.
Definition at line 46 of file FluidProperties.h.
Referenced by NaClFluidProperties::cp_from_p_T(), BrineFluidProperties::cp_from_p_T_X(), NaClFluidProperties::h_from_p_T(), BrineFluidProperties::h_from_p_T_X(), BrineFluidProperties::haliteSolubility(), NaClFluidProperties::k_from_p_T(), BrineFluidProperties::k_from_p_T_X(), BrineFluidProperties::mu_from_p_T_X(), CO2FluidProperties::partialDensity(), NaClFluidProperties::rho_from_p_T(), and BrineFluidProperties::rho_from_p_T_X().
|
protected |
thermal conductivity
Definition at line 108 of file SimpleFluidProperties.h.
Referenced by k_from_p_T().
|
protected |
thermal expansion coefficient
Definition at line 96 of file SimpleFluidProperties.h.
Referenced by beta_from_p_T(), and rho_from_p_T().
|
protected |
|
inherited |
Definition at line 163 of file SinglePhaseFluidProperties.h.
Referenced by NaClFluidProperties::e_from_p_T(), IdealGasFluidProperties::e_from_v_h(), StiffenedGasFluidProperties::e_from_v_h(), HelmholtzFluidProperties::h_from_p_T(), StiffenedGasFluidProperties::h_from_p_T(), NaClFluidProperties::h_from_p_T(), IdealGasFluidProperties::h_from_p_T(), h_from_p_T(), Water97FluidProperties::h_from_p_T(), TabulatedFluidProperties::h_from_p_T(), FlibeFluidProperties::h_from_p_T(), FlinakFluidProperties::h_from_p_T(), HeliumFluidProperties::h_from_p_T(), StiffenedGasFluidProperties::h_from_T_v(), IdealGasFluidProperties::h_from_T_v(), StiffenedGasFluidProperties::p_from_h_s(), IdealGasFluidProperties::p_from_h_s(), StiffenedGasFluidProperties::s_from_h_p(), IdealGasFluidProperties::s_from_h_p(), IdealGasFluidProperties::T_from_p_h(), and Water97FluidProperties::T_from_p_h().
Definition at line 183 of file SinglePhaseFluidProperties.h.
|
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(), 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(), 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().
Definition at line 171 of file SinglePhaseFluidProperties.h.
Definition at line 173 of file SinglePhaseFluidProperties.h.
Definition at line 175 of file SinglePhaseFluidProperties.h.
Definition at line 185 of file SinglePhaseFluidProperties.h.
Definition at line 187 of file SinglePhaseFluidProperties.h.
|
inherited |
Definition at line 190 of file SinglePhaseFluidProperties.h.
Definition at line 169 of file SinglePhaseFluidProperties.h.
Referenced by HeliumFluidProperties::beta_from_p_T(), FlinakFluidProperties::beta_from_p_T(), StiffenedGasFluidProperties::c2_from_p_rho(), HeliumFluidProperties::c_from_v_e(), StiffenedGasFluidProperties::e_from_p_rho(), IdealGasFluidProperties::e_from_p_rho(), NaClFluidProperties::e_from_p_T(), Water97FluidProperties::k_from_p_T(), CO2FluidProperties::mu_from_p_T(), NitrogenFluidProperties::mu_from_p_T(), HydrogenFluidProperties::mu_from_p_T(), Water97FluidProperties::mu_from_p_T(), SinglePhaseFluidProperties::rho_e_from_p_T(), StiffenedGasFluidProperties::rho_from_p_s(), IdealGasFluidProperties::rho_from_p_s(), HelmholtzFluidProperties::rho_from_p_T(), StiffenedGasFluidProperties::rho_from_p_T(), CO2FluidProperties::rho_from_p_T(), Water97FluidProperties::rho_from_p_T(), NaClFluidProperties::rho_from_p_T(), IdealGasFluidProperties::rho_from_p_T(), rho_from_p_T(), TabulatedFluidProperties::rho_from_p_T(), FlinakFluidProperties::rho_from_p_T(), FlibeFluidProperties::rho_from_p_T(), HeliumFluidProperties::rho_from_p_T(), NitrogenFluidProperties::rho_mu_from_p_T(), HydrogenFluidProperties::rho_mu_from_p_T(), CO2FluidProperties::rho_mu_from_p_T(), Water97FluidProperties::rho_mu_from_p_T(), and SinglePhaseFluidProperties::rho_mu_from_p_T().
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(), 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(), 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(), HeliumFluidProperties::T_from_v_e(), SinglePhaseFluidProperties::vaporPressure(), Water97FluidProperties::vaporTemperature(), and SinglePhaseFluidProperties::vaporTemperature().
Definition at line 179 of file SinglePhaseFluidProperties.h.
Definition at line 181 of file SinglePhaseFluidProperties.h.
|
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(), FlibeFluidProperties::cp_from_v_e(), FlinakFluidProperties::cp_from_v_e(), HeliumFluidProperties::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(), HeliumFluidProperties::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(), HeliumFluidProperties::k_from_v_e(), FlibeFluidProperties::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(), 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(), HeliumFluidProperties::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().
|
inherited |
Definition at line 157 of file SinglePhaseFluidProperties.h.
|
inherited |
Definition at line 159 of file SinglePhaseFluidProperties.h.
|
inherited |
Definition at line 161 of file SinglePhaseFluidProperties.h.
|
inherited |
Definition at line 165 of file SinglePhaseFluidProperties.h.
Definition at line 189 of file SinglePhaseFluidProperties.h.