Class for fluid properties read from a file. More...
#include <TabulatedFluidProperties.h>
Public Member Functions | |
TabulatedFluidProperties (const InputParameters ¶meters) | |
virtual | ~TabulatedFluidProperties () |
virtual void | initialSetup () override |
virtual std::string | fluidName () const override |
virtual Real | molarMass () const override |
Fluid name. More... | |
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 | 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 | 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 | cp_from_p_T (Real pressure, Real temperature) 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 std::vector< Real > | henryCoefficients () const override |
Henry's law coefficients for dissolution in water. More... | |
virtual Real | vaporPressure (Real temperature) const override |
Vapor pressure. More... | |
virtual void | vaporPressure (Real temperature, Real &psat, Real &dpsat_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... | |
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 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 Member Functions | |
void | writeTabulatedData (std::string file_name) |
Writes tabulated data to a file. More... | |
virtual void | checkInputVariables (Real &pressure, Real &temperature) const |
Checks that the inputs are within the range of the tabulated data, and throws an error if they are not. More... | |
virtual void | generateTabulatedData () |
Generates a table of fluid properties by looping over pressure and temperature and calculating properties using the FluidProperties UserObject _fp. More... | |
void | reshapeData2D (unsigned int nrow, unsigned int ncol, const std::vector< Real > &vec, std::vector< std::vector< Real >> &mat) |
Forms a 2D matrix from a single std::vector. More... | |
Protected Attributes | |
FileName | _file_name |
File name of tabulated data file. More... | |
std::vector< Real > | _pressure |
Pressure vector. More... | |
std::vector< Real > | _temperature |
Temperature vector. More... | |
std::vector< std::vector< Real > > | _properties |
Tabulated fluid properties. More... | |
std::vector< std::unique_ptr< BicubicInterpolation > > | _property_ipol |
Interpolated fluid property. More... | |
Real | _temperature_min |
Minimum temperature in tabulated data. More... | |
Real | _temperature_max |
Maximum temperature in tabulated data. More... | |
Real | _pressure_min |
Minimum pressure in tabulated data. More... | |
Real | _pressure_max |
Maximum pressure in tabulated data. More... | |
unsigned int | _num_T |
Number of temperature points in the tabulated data. More... | |
unsigned int | _num_p |
Number of pressure points in the tabulated data. More... | |
const bool | _save_file |
Whether to save a generated fluid properties file to disk. More... | |
const SinglePhaseFluidProperties & | _fp |
SinglePhaseFluidPropertiesPT UserObject. More... | |
const std::vector< std::string > | _required_columns {"pressure", "temperature"} |
List of required column names to be read. More... | |
const std::vector< std::string > | _property_columns |
List of possible property column names to be read. More... | |
MultiMooseEnum | _interpolated_properties_enum |
Properties to be interpolated entered in the input file. More... | |
std::vector< std::string > | _interpolated_properties |
List of properties to be interpolated. More... | |
bool | _interpolate_density |
Set of flags to note whether a property is to be interpolated. More... | |
bool | _interpolate_enthalpy |
bool | _interpolate_internal_energy |
bool | _interpolate_viscosity |
bool | _interpolate_k |
bool | _interpolate_cp |
bool | _interpolate_cv |
bool | _interpolate_entropy |
unsigned int | _density_idx |
Index of each property. More... | |
unsigned int | _enthalpy_idx |
unsigned int | _internal_energy_idx |
unsigned int | _viscosity_idx |
unsigned int | _k_idx |
unsigned int | _cp_idx |
unsigned int | _cv_idx |
unsigned int | _entropy_idx |
MooseUtils::DelimitedFileReader | _csv_reader |
The MOOSE delimited file reader. 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) |
Class for fluid properties read from a file.
Property values are read from a CSV file containing property data. Monotonically increasing values of pressure and temperature must be included in the data file, specifying the phase space where tabulated fluid properties will be defined. An error is thrown if either temperature or pressure data is not included or not monotonic, and an error is also thrown if this UserObject is requested to provide a fluid property outside this phase space.
This class is intended to be used when complicated formulations for fluid properties (for example, density or enthalpy) are required, which can be computationally expensive. This is particularly the case where the fluid equation of state is based on a Helmholtz free energy that is a function of density and temperature, like that used in CO2FluidProperties. In this case, density must be solved iteratively using pressure and temperature, which increases the computational burden.
Using interpolation to calculate these fluid properties can significantly reduce the computational time for these cases.
The expected file format for the tabulated fluid properties is now described. The first line must be the header containing the required column names "pressure" and "temperature", and the names of the fluid properties to be read. Available fluid property names are: "density", "enthalpy", "internal_energy", "viscosity", "k" (thermal conductivity), "cp" (isobaric specific heat capacity), "cv" (isochoric specific heat capacity), and "entropy". Note: the order is not important, although having pressure and temperature first makes the data easier for a human to read).
The data in the pressure and temperature columns must be monotonically increasing. This file format does require duplication of the pressure and temperature data - each pressure value must be included num_T times, while each temperature value is repeated num_p times, where num_T and num_p are the number of temperature and pressure points, respectively. This class will check that the required number of data points have been entered (num_T * num_p).
An example of a valid fluid properties file is provided below:
pressure, temperature, density, enthalpy, internal_energy 200000, 275, 3.90056, -21487, -72761.7 200000, 277, 3.86573, -19495.4, -71232.0 200000, 280, 3.83155, -17499.1, -69697.3 300000, 275, 6.07273, -22728.3, -73626.5 300000, 277, 6.01721, -20711.5, -72079.3 300000, 280, 5.96277, -18691.0, -70527.7
and so on.
If no tabulated fluid property data file exists, then data for the fluid supplied by the required FluidProperties UserObject will be generated using the pressure and temperature ranges specified in the input file at the beginning of the simulation. The properties to be tabulated are provided in the "interpolated_properties" input parameter (the properties that can be tabulated are listed above).
This tabulated data will be written to file in the correct format, enabling suitable data files to be created for future use. There is an upfront computational expense required for this initial data generation, depending on the required number of pressure and temperature points. However, provided that the number of data points required to generate the tabulated data is smaller than the number of times the property members in the FluidProperties UserObject are used, the initial time to generate the data and the subsequent interpolation time can be much less than using the original FluidProperties UserObject.
Properties specified in the data file or listed in the input file (and their derivatives wrt pressure and temperature) will be calculated using bicubic interpolation, while all remaining fluid properties are calculated using the supplied FluidProperties UserObject.
Definition at line 92 of file TabulatedFluidProperties.h.
TabulatedFluidProperties::TabulatedFluidProperties | ( | const InputParameters & | parameters | ) |
Definition at line 60 of file TabulatedFluidProperties.C.
|
virtual |
Definition at line 101 of file TabulatedFluidProperties.C.
|
overridevirtual |
Definition at line 420 of file TabulatedFluidProperties.C.
|
protectedvirtual |
Checks that the inputs are within the range of the tabulated data, and throws an error if they are not.
pressure | input pressure (Pa) |
temperature | input temperature (K) |
Definition at line 635 of file TabulatedFluidProperties.C.
Referenced by cp_from_p_T(), cv_from_p_T(), e_from_p_T(), h_from_p_T(), k_from_p_T(), mu_from_p_T(), rho_from_p_T(), and s_from_p_T().
|
overridevirtual |
Definition at line 426 of file TabulatedFluidProperties.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 438 of file TabulatedFluidProperties.C.
|
overridevirtual |
Definition at line 342 of file TabulatedFluidProperties.C.
|
overridevirtual |
Definition at line 354 of file TabulatedFluidProperties.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 304 of file TabulatedFluidProperties.C.
|
inlineprivateinherited |
Definition at line 326 of file SinglePhaseFluidProperties.h.
Referenced by SinglePhaseFluidProperties::vaporPressure(), and SinglePhaseFluidProperties::vaporTemperature().
|
protectedvirtual |
Generates a table of fluid properties by looping over pressure and temperature and calculating properties using the FluidProperties UserObject _fp.
Definition at line 544 of file TabulatedFluidProperties.C.
Referenced by initialSetup().
|
overridevirtual |
Definition at line 368 of file TabulatedFluidProperties.C.
|
overridevirtual |
Definition at line 380 of file TabulatedFluidProperties.C.
|
overridevirtual |
Henry's law coefficients for dissolution in water.
Reimplemented from SinglePhaseFluidProperties.
Definition at line 494 of file TabulatedFluidProperties.C.
|
inlinefinalvirtualinherited |
Definition at line 35 of file FluidProperties.h.
|
overridevirtual |
Definition at line 104 of file TabulatedFluidProperties.C.
|
overridevirtual |
Definition at line 450 of file TabulatedFluidProperties.C.
|
overridevirtual |
Definition at line 462 of file TabulatedFluidProperties.C.
|
overridevirtual |
Fluid name.
Reimplemented from SinglePhaseFluidProperties.
Definition at line 310 of file TabulatedFluidProperties.C.
|
overridevirtual |
Definition at line 394 of file TabulatedFluidProperties.C.
|
overridevirtual |
Definition at line 406 of file TabulatedFluidProperties.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 |
|
protected |
Forms a 2D matrix from a single std::vector.
nrow | number of rows in the matrix | |
ncol | number of columns in the matrix | |
vec | 1D vector to reshape into a 2D matrix | |
[out] | 2D | matrix formed by reshaping vec |
Definition at line 617 of file TabulatedFluidProperties.C.
Referenced by initialSetup().
|
virtualinherited |
|
overridevirtual |
Definition at line 316 of file TabulatedFluidProperties.C.
|
overridevirtual |
Definition at line 328 of file TabulatedFluidProperties.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 488 of file TabulatedFluidProperties.C.
|
overridevirtual |
Definition at line 476 of file TabulatedFluidProperties.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.
|
overridevirtual |
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 from SinglePhaseFluidProperties.
Definition at line 500 of file TabulatedFluidProperties.C.
|
overridevirtual |
Reimplemented from SinglePhaseFluidProperties.
Definition at line 506 of file TabulatedFluidProperties.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.
|
protected |
Writes tabulated data to a file.
file_name | name of the file to be written |
Definition at line 512 of file TabulatedFluidProperties.C.
Referenced by initialSetup().
|
protectedinherited |
Flag to set unimplemented Jacobian entries to zero.
Definition at line 48 of file FluidProperties.h.
Referenced by SinglePhaseFluidProperties::fluidPropError().
|
protected |
Definition at line 235 of file TabulatedFluidProperties.h.
Referenced by cp_from_p_T(), and initialSetup().
|
protected |
The MOOSE delimited file reader.
Definition at line 240 of file TabulatedFluidProperties.h.
Referenced by initialSetup(), and TabulatedFluidProperties().
|
protected |
Definition at line 236 of file TabulatedFluidProperties.h.
Referenced by cv_from_p_T(), and initialSetup().
|
protected |
Index of each property.
Definition at line 230 of file TabulatedFluidProperties.h.
Referenced by initialSetup(), and rho_from_p_T().
|
protected |
Definition at line 231 of file TabulatedFluidProperties.h.
Referenced by h_from_p_T(), and initialSetup().
|
protected |
Definition at line 237 of file TabulatedFluidProperties.h.
Referenced by initialSetup(), and s_from_p_T().
|
protected |
File name of tabulated data file.
Definition at line 181 of file TabulatedFluidProperties.h.
Referenced by initialSetup().
|
protected |
SinglePhaseFluidPropertiesPT UserObject.
Definition at line 208 of file TabulatedFluidProperties.h.
Referenced by c_from_p_T(), cp_from_p_T(), cv_from_p_T(), e_from_p_T(), fluidName(), generateTabulatedData(), h_from_p_T(), henryCoefficients(), k_from_p_T(), molarMass(), mu_from_p_T(), rho_from_p_T(), s_from_p_T(), vaporPressure(), and writeTabulatedData().
|
protected |
Definition at line 232 of file TabulatedFluidProperties.h.
Referenced by e_from_p_T(), and initialSetup().
|
protected |
Definition at line 225 of file TabulatedFluidProperties.h.
Referenced by cp_from_p_T(), and initialSetup().
|
protected |
Definition at line 226 of file TabulatedFluidProperties.h.
Referenced by cv_from_p_T(), and initialSetup().
|
protected |
Set of flags to note whether a property is to be interpolated.
Definition at line 220 of file TabulatedFluidProperties.h.
Referenced by initialSetup(), and rho_from_p_T().
|
protected |
Definition at line 221 of file TabulatedFluidProperties.h.
Referenced by h_from_p_T(), and initialSetup().
|
protected |
Definition at line 227 of file TabulatedFluidProperties.h.
Referenced by initialSetup(), and s_from_p_T().
|
protected |
Definition at line 222 of file TabulatedFluidProperties.h.
Referenced by e_from_p_T(), and initialSetup().
|
protected |
Definition at line 224 of file TabulatedFluidProperties.h.
Referenced by initialSetup(), and k_from_p_T().
|
protected |
Definition at line 223 of file TabulatedFluidProperties.h.
Referenced by initialSetup(), and mu_from_p_T().
|
protected |
List of properties to be interpolated.
Definition at line 218 of file TabulatedFluidProperties.h.
Referenced by generateTabulatedData(), initialSetup(), and writeTabulatedData().
|
protected |
Properties to be interpolated entered in the input file.
Definition at line 216 of file TabulatedFluidProperties.h.
Referenced by generateTabulatedData().
|
protected |
Definition at line 234 of file TabulatedFluidProperties.h.
Referenced by initialSetup(), and k_from_p_T().
|
protected |
Number of pressure points in the tabulated data.
Definition at line 203 of file TabulatedFluidProperties.h.
Referenced by generateTabulatedData(), initialSetup(), and writeTabulatedData().
|
protected |
Number of temperature points in the tabulated data.
Definition at line 201 of file TabulatedFluidProperties.h.
Referenced by generateTabulatedData(), initialSetup(), and writeTabulatedData().
|
protected |
Pressure vector.
Definition at line 183 of file TabulatedFluidProperties.h.
Referenced by generateTabulatedData(), initialSetup(), and writeTabulatedData().
|
protected |
Maximum pressure in tabulated data.
Definition at line 199 of file TabulatedFluidProperties.h.
Referenced by checkInputVariables(), generateTabulatedData(), initialSetup(), and TabulatedFluidProperties().
|
protected |
Minimum pressure in tabulated data.
Definition at line 197 of file TabulatedFluidProperties.h.
Referenced by checkInputVariables(), generateTabulatedData(), initialSetup(), and TabulatedFluidProperties().
|
protected |
Tabulated fluid properties.
Definition at line 187 of file TabulatedFluidProperties.h.
Referenced by generateTabulatedData(), initialSetup(), and writeTabulatedData().
|
protected |
List of possible property column names to be read.
Definition at line 213 of file TabulatedFluidProperties.h.
Referenced by initialSetup().
|
protected |
Interpolated fluid property.
Definition at line 190 of file TabulatedFluidProperties.h.
Referenced by cp_from_p_T(), cv_from_p_T(), e_from_p_T(), h_from_p_T(), initialSetup(), k_from_p_T(), mu_from_p_T(), rho_from_p_T(), and s_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 |
List of required column names to be read.
Definition at line 211 of file TabulatedFluidProperties.h.
Referenced by initialSetup().
|
protected |
Whether to save a generated fluid properties file to disk.
Definition at line 205 of file TabulatedFluidProperties.h.
Referenced by initialSetup().
|
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 |
Temperature vector.
Definition at line 185 of file TabulatedFluidProperties.h.
Referenced by generateTabulatedData(), initialSetup(), and writeTabulatedData().
|
protected |
Maximum temperature in tabulated data.
Definition at line 195 of file TabulatedFluidProperties.h.
Referenced by checkInputVariables(), generateTabulatedData(), initialSetup(), and TabulatedFluidProperties().
|
protected |
Minimum temperature in tabulated data.
Definition at line 193 of file TabulatedFluidProperties.h.
Referenced by checkInputVariables(), generateTabulatedData(), initialSetup(), and TabulatedFluidProperties().
|
protected |
Definition at line 233 of file TabulatedFluidProperties.h.
Referenced by initialSetup(), and mu_from_p_T().
|
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(), SimpleFluidProperties::h_from_p_T(), Water97FluidProperties::h_from_p_T(), 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(), 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(), SimpleFluidProperties::s_from_p_T(), Water97FluidProperties::s_from_p_T(), 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 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(), SimpleFluidProperties::rho_from_p_T(), rho_from_p_T(), FlibeFluidProperties::rho_from_p_T(), FlinakFluidProperties::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(), SimpleFluidProperties::s_from_p_T(), Water97FluidProperties::s_from_p_T(), 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(), FlinakFluidProperties::T_from_v_e(), FlibeFluidProperties::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(), FlinakFluidProperties::e_from_p_T(), FlibeFluidProperties::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(), StiffenedGasFluidProperties::p_from_v_e(), IdealGasFluidProperties::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(), FlinakFluidProperties::v_from_p_T(), and FlibeFluidProperties::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.