https://mooseframework.inl.gov
Public Types | Public Member Functions | Static Public Member Functions | Protected Member Functions | Protected Attributes | List of all members
PorousFlowFluidStateSingleComponentTempl< is_ad > Class Template Reference

Fluid state class using a persistent set of primary variables for the mutliphase, single component case. More...

#include <PorousFlowFluidStateSingleComponent.h>

Inheritance diagram for PorousFlowFluidStateSingleComponentTempl< is_ad >:
[legend]

Public Types

typedef DerivativeMaterialPropertyNameInterface::SymbolName SymbolName
 

Public Member Functions

 PorousFlowFluidStateSingleComponentTempl (const InputParameters &parameters)
 
const GenericMaterialProperty< U, is_ad > & getDefaultMaterialProperty (const std::string &name)
 
const GenericMaterialProperty< U, is_ad > & getDefaultMaterialPropertyByName (const std::string &name)
 
void validateDerivativeMaterialPropertyBase (const std::string &base)
 
const MaterialPropertyName derivativePropertyName (const MaterialPropertyName &base, const std::vector< SymbolName > &c) const
 
const MaterialPropertyName derivativePropertyNameFirst (const MaterialPropertyName &base, const SymbolName &c1) const
 
const MaterialPropertyName derivativePropertyNameSecond (const MaterialPropertyName &base, const SymbolName &c1, const SymbolName &c2) const
 
const MaterialPropertyName derivativePropertyNameThird (const MaterialPropertyName &base, const SymbolName &c1, const SymbolName &c2, const SymbolName &c3) const
 
GenericMaterialProperty< U, is_ad > & declarePropertyDerivative (const std::string &base, const std::vector< VariableName > &c)
 
GenericMaterialProperty< U, is_ad > & declarePropertyDerivative (const std::string &base, const std::vector< SymbolName > &c)
 
GenericMaterialProperty< U, is_ad > & declarePropertyDerivative (const std::string &base, const SymbolName &c1, const SymbolName &c2="", const SymbolName &c3="")
 
GenericMaterialProperty< U, is_ad > & declarePropertyDerivative (const std::string &base, const std::vector< VariableName > &c)
 
GenericMaterialProperty< U, is_ad > & declarePropertyDerivative (const std::string &base, const std::vector< SymbolName > &c)
 
GenericMaterialProperty< U, is_ad > & declarePropertyDerivative (const std::string &base, const SymbolName &c1, const SymbolName &c2="", const SymbolName &c3="")
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivative (const std::string &base, const std::vector< VariableName > &c)
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivative (const std::string &base, const std::vector< SymbolName > &c)
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivative (const std::string &base, const SymbolName &c1, const SymbolName &c2="", const SymbolName &c3="")
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivative (const std::string &base, const SymbolName &c1, unsigned int v2, unsigned int v3=libMesh::invalid_uint)
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivative (const std::string &base, unsigned int v1, unsigned int v2=libMesh::invalid_uint, unsigned int v3=libMesh::invalid_uint)
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivative (const std::string &base, const std::vector< VariableName > &c)
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivative (const std::string &base, const std::vector< SymbolName > &c)
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivative (const std::string &base, const SymbolName &c1, const SymbolName &c2="", const SymbolName &c3="")
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivative (const std::string &base, const SymbolName &c1, unsigned int v2, unsigned int v3=libMesh::invalid_uint)
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivative (const std::string &base, unsigned int v1, unsigned int v2=libMesh::invalid_uint, unsigned int v3=libMesh::invalid_uint)
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivativeByName (const MaterialPropertyName &base, const std::vector< VariableName > &c)
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivativeByName (const MaterialPropertyName &base, const std::vector< SymbolName > &c)
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivativeByName (const MaterialPropertyName &base, const SymbolName &c1, const SymbolName &c2="", const SymbolName &c3="")
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivativeByName (const MaterialPropertyName &base, const std::vector< VariableName > &c)
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivativeByName (const MaterialPropertyName &base, const std::vector< SymbolName > &c)
 
const GenericMaterialProperty< U, is_ad > & getMaterialPropertyDerivativeByName (const MaterialPropertyName &base, const SymbolName &c1, const SymbolName &c2="", const SymbolName &c3="")
 
void validateCoupling (const MaterialPropertyName &base, const std::vector< VariableName > &c, bool validate_aux=true)
 
void validateCoupling (const MaterialPropertyName &base, const VariableName &c1="", const VariableName &c2="", const VariableName &c3="")
 
void validateCoupling (const MaterialPropertyName &base, const std::vector< VariableName > &c, bool validate_aux=true)
 
void validateCoupling (const MaterialPropertyName &base, const VariableName &c1="", const VariableName &c2="", const VariableName &c3="")
 
void validateNonlinearCoupling (const MaterialPropertyName &base, const VariableName &c1="", const VariableName &c2="", const VariableName &c3="")
 
void validateNonlinearCoupling (const MaterialPropertyName &base, const VariableName &c1="", const VariableName &c2="", const VariableName &c3="")
 
const MaterialPropertyName propertyName (const MaterialPropertyName &base, const std::vector< SymbolName > &c) const
 
const MaterialPropertyName propertyName (const MaterialPropertyName &base, const std::vector< SymbolName > &c) const
 
const MaterialPropertyName propertyNameFirst (const MaterialPropertyName &base, const SymbolName &c1) const
 
const MaterialPropertyName propertyNameFirst (const MaterialPropertyName &base, const SymbolName &c1) const
 
const MaterialPropertyName propertyNameSecond (const MaterialPropertyName &base, const SymbolName &c1, const SymbolName &c2) const
 
const MaterialPropertyName propertyNameSecond (const MaterialPropertyName &base, const SymbolName &c1, const SymbolName &c2) const
 
const MaterialPropertyName propertyNameThird (const MaterialPropertyName &base, const SymbolName &c1, const SymbolName &c2, const SymbolName &c3) const
 
const MaterialPropertyName propertyNameThird (const MaterialPropertyName &base, const SymbolName &c1, const SymbolName &c2, const SymbolName &c3) const
 

Static Public Member Functions

static InputParameters validParams ()
 

Protected Member Functions

virtual void initQpStatefulProperties () override
 
virtual void computeQpProperties () override
 
virtual void thermophysicalProperties () override
 Calculates all required thermophysical properties and derivatives for each phase and fluid component. More...
 
virtual void setMaterialVectorSize () const override
 Size material property vectors and initialise with zeros. More...
 
GenericReal< is_ad > genericValue (const ADReal &value)
 Templated method that takes an ADReal value, and returns the raw value when is_ad = false, and the AD value when is_ad = true. More...
 
template<>
GenericReal< false > genericValue (const ADReal &value)
 
template<>
GenericReal< true > genericValue (const ADReal &value)
 

Protected Attributes

const GenericVariableValue< is_ad > & _liquid_porepressure
 Porepressure. More...
 
const GenericVariableGradient< is_ad > & _liquid_gradp_qp
 Gradient of porepressure (only defined at the qps) More...
 
const unsigned int _liquid_porepressure_varnum
 Moose variable number of the porepressure. More...
 
const unsigned int _pvar
 PorousFlow variable number of the porepressure. More...
 
const GenericVariableValue< is_ad > & _enthalpy
 Enthalpy. More...
 
const GenericVariableGradient< is_ad > & _gradh_qp
 Gradient of enthalpy (only defined at the qps) More...
 
const unsigned int _enthalpy_varnum
 Moose variable number of the enthalpy. More...
 
const unsigned int _hvar
 PorousFlow variable number of the enthalpy. More...
 
const PorousFlowFluidStateSingleComponentBase_fs
 FluidState UserObject. More...
 
const unsigned int _aqueous_phase_number
 Phase number of the aqueous phase. More...
 
const unsigned int _gas_phase_number
 Phase number of the gas phase. More...
 
GenericMaterialProperty< Real, is_ad > & _temperature
 Temperature. More...
 
GenericMaterialProperty< RealGradient, is_ad > *const _grad_temperature_qp
 Gradient of temperature (only defined at the qps) More...
 
MaterialProperty< std::vector< Real > > *const _dtemperature_dvar
 Derivative of temperature wrt PorousFlow variables. More...
 
MaterialProperty< std::vector< Real > > *const _dgrad_temperature_dgradv
 d(grad temperature)/d(grad PorousFlow variable) at the quadpoints More...
 
MaterialProperty< std::vector< RealGradient > > *const _dgrad_temperature_dv
 d(grad temperature)/d(PorousFlow variable) at the quadpoints More...
 
const unsigned int _pidx
 Index of derivative wrt pressure. More...
 
const unsigned int _hidx
 Index of derivative wrt enthalpy. More...
 
 usingPorousFlowFluidStateBaseMaterialMembers
 
 usingPorousFlowFluidStateBaseMaterialDerivativeMembers
 
const Real _T_c2k
 Conversion from degrees Celsius to degrees Kelvin. More...
 
bool _is_initqp
 Flag to indicate whether stateful properties should be computed. More...
 
std::vector< FluidStateProperties_fsp
 FluidStateProperties data for each fluid component in each fluid phase. More...
 
const PorousFlowCapillaryPressure_pc
 Capillary pressure UserObject. More...
 
const std::string _sfx
 Suffix to append to material property names (either qp or nodal as required) More...
 
GenericMaterialProperty< std::vector< std::vector< Real > >, is_ad > & _mass_frac
 Mass fraction matrix (indexing is fluid component in fluid phase) More...
 
GenericMaterialProperty< std::vector< std::vector< RealGradient > >, is_ad > *const _grad_mass_frac_qp
 Gradient of the mass fraction matrix (only defined at the qps) More...
 
MaterialProperty< std::vector< std::vector< std::vector< Real > > > > *const _dmass_frac_dvar
 Derivative of the mass fraction matrix with respect to the Porous Flow variables. More...
 
GenericMaterialProperty< std::vector< Real >, is_ad > & _fluid_density
 Fluid density of each phase. More...
 
MaterialProperty< std::vector< std::vector< Real > > > *const _dfluid_density_dvar
 Derivative of the fluid density for each phase wrt PorousFlow variables. More...
 
GenericMaterialProperty< std::vector< Real >, is_ad > & _fluid_viscosity
 Viscosity of each phase. More...
 
MaterialProperty< std::vector< std::vector< Real > > > *const _dfluid_viscosity_dvar
 Derivative of the fluid viscosity for each phase wrt PorousFlow variables. More...
 
GenericMaterialProperty< std::vector< Real >, is_ad > & _fluid_enthalpy
 Enthalpy of each phase. More...
 
MaterialProperty< std::vector< std::vector< Real > > > *const _dfluid_enthalpy_dvar
 Derivative of the fluid enthalpy for each phase wrt PorousFlow variables. More...
 
GenericMaterialProperty< std::vector< Real >, is_ad > & _fluid_internal_energy
 Internal energy of each phase. More...
 
MaterialProperty< std::vector< std::vector< Real > > > *const _dfluid_internal_energy_dvar
 Derivative of the fluid internal energy for each phase wrt PorousFlow variables. More...
 
 usingPorousFlowVariableBaseMembers
 
const unsigned int _num_phases
 Number of phases. More...
 
const unsigned int _num_components
 Number of components. More...
 
const unsigned int _num_pf_vars
 Number of PorousFlow variables. More...
 
GenericMaterialProperty< std::vector< Real >, is_ad > & _porepressure
 Computed nodal or quadpoint values of porepressure of the phases. More...
 
MaterialProperty< std::vector< std::vector< Real > > > *const _dporepressure_dvar
 d(porepressure)/d(PorousFlow variable) More...
 
GenericMaterialProperty< std::vector< RealGradient >, is_ad > *const _gradp_qp
 Grad(p) at the quadpoints. More...
 
MaterialProperty< std::vector< std::vector< Real > > > *const _dgradp_qp_dgradv
 d(grad porepressure)/d(grad PorousFlow variable) at the quadpoints More...
 
MaterialProperty< std::vector< std::vector< RealGradient > > > *const _dgradp_qp_dv
 d(grad porepressure)/d(PorousFlow variable) at the quadpoints More...
 
GenericMaterialProperty< std::vector< Real >, is_ad > & _saturation
 Computed nodal or qp saturation of the phases. More...
 
MaterialProperty< std::vector< std::vector< Real > > > *const _dsaturation_dvar
 d(saturation)/d(PorousFlow variable) More...
 
GenericMaterialProperty< std::vector< RealGradient >, is_ad > *const _grads_qp
 Grad(s) at the quadpoints. More...
 
MaterialProperty< std::vector< std::vector< Real > > > *const _dgrads_qp_dgradv
 d(grad saturation)/d(grad PorousFlow variable) at the quadpoints More...
 
MaterialProperty< std::vector< std::vector< RealGradient > > > *const _dgrads_qp_dv
 d(grad saturation)/d(PorousFlow variable) at the quadpoints More...
 

Detailed Description

template<bool is_ad>
class PorousFlowFluidStateSingleComponentTempl< is_ad >

Fluid state class using a persistent set of primary variables for the mutliphase, single component case.

Primary variables are: liquid pressure and enthalpy.

The PorousFlow kernels expect saturation and mass fractions (as well as pressure and temperature), so these must be calculated from the primary variables once the state of the system is determined.

Definition at line 28 of file PorousFlowFluidStateSingleComponent.h.

Constructor & Destructor Documentation

◆ PorousFlowFluidStateSingleComponentTempl()

Definition at line 31 of file PorousFlowFluidStateSingleComponent.C.

34  _liquid_porepressure(_nodal_material
35  ? this->template coupledGenericDofValue<is_ad>("porepressure")
36  : this->template coupledGenericValue<is_ad>("porepressure")),
37  _liquid_gradp_qp(this->template coupledGenericGradient<is_ad>("porepressure")),
38  _liquid_porepressure_varnum(coupled("porepressure")),
39  _pvar(_dictator.isPorousFlowVariable(_liquid_porepressure_varnum)
40  ? _dictator.porousFlowVariableNum(_liquid_porepressure_varnum)
41  : 0),
42  _enthalpy(_nodal_material ? this->template coupledGenericDofValue<is_ad>("enthalpy")
43  : this->template coupledGenericValue<is_ad>("enthalpy")),
44  _gradh_qp(this->template coupledGenericGradient<is_ad>("enthalpy")),
45  _enthalpy_varnum(coupled("enthalpy")),
46  _hvar(_dictator.isPorousFlowVariable(_enthalpy_varnum)
47  ? _dictator.porousFlowVariableNum(_enthalpy_varnum)
48  : 0),
49  _fs(this->template getUserObject<PorousFlowFluidStateSingleComponentBase>("fluid_state")),
50  _aqueous_phase_number(_fs.aqueousPhaseIndex()),
51  _gas_phase_number(_fs.gasPhaseIndex()),
53  this->template declareGenericProperty<Real, is_ad>("PorousFlow_temperature" + _sfx)),
54  _grad_temperature_qp(_nodal_material
55  ? nullptr
56  : &this->template declareGenericProperty<RealGradient, is_ad>(
57  "PorousFlow_grad_temperature_qp")),
58  _dtemperature_dvar(is_ad ? nullptr
59  : &this->template declareProperty<std::vector<Real>>(
60  "dPorousFlow_temperature" + _sfx + "_dvar")),
61  _dgrad_temperature_dgradv(is_ad || _nodal_material
62  ? nullptr
63  : &this->template declareProperty<std::vector<Real>>(
64  "dPorousFlow_grad_temperature_qp_dgradvar")),
65  _dgrad_temperature_dv(is_ad ? nullptr
66  : _nodal_material
67  ? nullptr
68  : &this->template declareProperty<std::vector<RealGradient>>(
69  "dPorousFlow_grad_temperature_qp_dvar")),
70  _pidx(_fs.getPressureIndex()),
71  _hidx(_fs.getEnthalpyIndex())
72 {
73  // Check that the number of phases in the fluidstate class is also provided in the Dictator
74  if (_fs.numPhases() != _num_phases)
75  mooseError(name(),
76  ": only ",
77  _fs.numPhases(),
78  " phases are allowed. Please check the number of phases entered in the dictator is "
79  "correct");
80 }
const GenericVariableGradient< is_ad > & _liquid_gradp_qp
Gradient of porepressure (only defined at the qps)
const PorousFlowFluidStateSingleComponentBase & _fs
FluidState UserObject.
const unsigned int _pidx
Index of derivative wrt pressure.
void mooseError(Args &&... args)
const unsigned int _gas_phase_number
Phase number of the gas phase.
const GenericVariableValue< is_ad > & _liquid_porepressure
Porepressure.
MaterialProperty< std::vector< Real > > *const _dgrad_temperature_dgradv
d(grad temperature)/d(grad PorousFlow variable) at the quadpoints
GenericMaterialProperty< Real, is_ad > & _temperature
Temperature.
MaterialProperty< std::vector< Real > > *const _dtemperature_dvar
Derivative of temperature wrt PorousFlow variables.
const unsigned int _enthalpy_varnum
Moose variable number of the enthalpy.
MaterialProperty< std::vector< RealGradient > > *const _dgrad_temperature_dv
d(grad temperature)/d(PorousFlow variable) at the quadpoints
const std::string _sfx
Suffix to append to material property names (either qp or nodal as required)
const unsigned int _hvar
PorousFlow variable number of the enthalpy.
GenericMaterialProperty< RealGradient, is_ad > *const _grad_temperature_qp
Gradient of temperature (only defined at the qps)
const std::string name
Definition: Setup.h:20
const GenericVariableValue< is_ad > & _enthalpy
Enthalpy.
const unsigned int _pvar
PorousFlow variable number of the porepressure.
Fluid state base class using a persistent set of primary variables for multiphase, single and multicomponent cases.
const unsigned int _num_phases
Number of phases.
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
unsigned int numPhases() const
The maximum number of phases in this model.
const unsigned int _liquid_porepressure_varnum
Moose variable number of the porepressure.
const GenericVariableGradient< is_ad > & _gradh_qp
Gradient of enthalpy (only defined at the qps)
const unsigned int _aqueous_phase_number
Phase number of the aqueous phase.
const unsigned int _hidx
Index of derivative wrt enthalpy.
Base class for miscible multiphase flow classes with a single fluid component using a pressure and en...

Member Function Documentation

◆ computeQpProperties()

template<bool is_ad>
void PorousFlowFluidStateSingleComponentTempl< is_ad >::computeQpProperties ( )
overrideprotectedvirtual

Reimplemented from PorousFlowFluidStateBaseMaterialTempl< is_ad >.

Definition at line 109 of file PorousFlowFluidStateSingleComponent.C.

110 {
111 
113 
114  // Temperature doesn't depend on fluid phase
116 
117  if (!is_ad)
118  {
119  (*_dtemperature_dvar)[_qp][_pvar] =
120  _fsp[_aqueous_phase_number].temperature.derivatives()[_pidx];
121  (*_dtemperature_dvar)[_qp][_hvar] =
122  _fsp[_aqueous_phase_number].temperature.derivatives()[_hidx];
123  }
124 
125  // Derivative of pressure, saturation and fluid properties wrt variables
126  if (!is_ad)
127  for (unsigned int ph = 0; ph < _num_phases; ++ph)
128  {
129  (*_dporepressure_dvar)[_qp][ph][_pvar] = _fsp[ph].pressure.derivatives()[_pidx];
130  (*_dporepressure_dvar)[_qp][ph][_hvar] = _fsp[ph].pressure.derivatives()[_hidx];
131 
132  (*_dsaturation_dvar)[_qp][ph][_pvar] = _fsp[ph].saturation.derivatives()[_pidx];
133  (*_dsaturation_dvar)[_qp][ph][_hvar] = _fsp[ph].saturation.derivatives()[_hidx];
134 
135  (*_dfluid_density_dvar)[_qp][ph][_pvar] = _fsp[ph].density.derivatives()[_pidx];
136  (*_dfluid_density_dvar)[_qp][ph][_hvar] = _fsp[ph].density.derivatives()[_hidx];
137 
138  (*_dfluid_viscosity_dvar)[_qp][ph][_pvar] = _fsp[ph].viscosity.derivatives()[_pidx];
139  (*_dfluid_viscosity_dvar)[_qp][ph][_hvar] = _fsp[ph].viscosity.derivatives()[_hidx];
140 
141  (*_dfluid_enthalpy_dvar)[_qp][ph][_pvar] = _fsp[ph].enthalpy.derivatives()[_pidx];
142  (*_dfluid_enthalpy_dvar)[_qp][ph][_hvar] = _fsp[ph].enthalpy.derivatives()[_hidx];
143 
144  (*_dfluid_internal_energy_dvar)[_qp][ph][_pvar] =
145  _fsp[ph].internal_energy.derivatives()[_pidx];
146  (*_dfluid_internal_energy_dvar)[_qp][ph][_hvar] =
147  _fsp[ph].internal_energy.derivatives()[_hidx];
148  }
149 
150  // If the material properties are being evaluated at the qps, calculate the
151  // gradients as well. Note: only nodal properties are evaluated in
152  // initQpStatefulProperties(), so no need to check _is_initqp flag for qp
153  // properties
154  if (!_nodal_material)
155  if constexpr (!is_ad)
156  {
157  // Need to compute second derivatives of properties wrt variables for some of
158  // the gradient derivatives. Use finite differences for now
159  const Real dp = 1.0e-5 * _liquid_porepressure[_qp];
160  const Real dh = 1.0e-5 * _enthalpy[_qp];
161 
162  std::vector<FluidStateProperties> fsp_dp(_num_phases, FluidStateProperties(_num_components));
163  _fs.thermophysicalProperties(_liquid_porepressure[_qp] + dp, _enthalpy[_qp], _qp, fsp_dp);
164 
165  std::vector<FluidStateProperties> fsp_dh(_num_phases, FluidStateProperties(_num_components));
166  _fs.thermophysicalProperties(_liquid_porepressure[_qp], _enthalpy[_qp] + dh, _qp, fsp_dh);
167 
168  // Gradient of temperature (non-zero in all phases)
169  (*_grad_temperature_qp)[_qp] = (*_dtemperature_dvar)[_qp][_pvar] * _liquid_gradp_qp[_qp] +
170  (*_dtemperature_dvar)[_qp][_hvar] * _gradh_qp[_qp];
171  (*_dgrad_temperature_dgradv)[_qp][_pvar] = (*_dtemperature_dvar)[_qp][_pvar];
172  (*_dgrad_temperature_dgradv)[_qp][_hvar] = (*_dtemperature_dvar)[_qp][_hvar];
173 
174  const auto d2T_dp2 = (fsp_dp[_aqueous_phase_number].temperature.derivatives()[_pidx] -
175  _fsp[_aqueous_phase_number].temperature.derivatives()[_pidx]) /
176  dp;
177 
178  const auto d2T_dh2 = (fsp_dh[_aqueous_phase_number].temperature.derivatives()[_hidx] -
179  _fsp[_aqueous_phase_number].temperature.derivatives()[_hidx]) /
180  dh;
181 
182  const auto d2T_dph = (fsp_dp[_aqueous_phase_number].temperature.derivatives()[_hidx] -
183  _fsp[_aqueous_phase_number].temperature.derivatives()[_hidx]) /
184  dp +
185  (fsp_dh[_aqueous_phase_number].temperature.derivatives()[_pidx] -
186  _fsp[_aqueous_phase_number].temperature.derivatives()[_pidx]) /
187  dh;
188 
189  (*_dgrad_temperature_dv)[_qp][_pvar] =
190  d2T_dp2 * _liquid_gradp_qp[_qp] + d2T_dph * _gradh_qp[_qp];
191  (*_dgrad_temperature_dv)[_qp][_hvar] =
192  d2T_dph * _liquid_gradp_qp[_qp] + d2T_dh2 * _gradh_qp[_qp];
193 
194  // Gradient of saturation and derivatives
195  (*_grads_qp)[_qp][_gas_phase_number] =
196  (*_dsaturation_dvar)[_qp][_gas_phase_number][_pvar] * _liquid_gradp_qp[_qp] +
197  (*_dsaturation_dvar)[_qp][_gas_phase_number][_hvar] * _gradh_qp[_qp];
198  (*_grads_qp)[_qp][_aqueous_phase_number] = -(*_grads_qp)[_qp][_gas_phase_number];
199 
200  (*_dgrads_qp_dgradv)[_qp][_gas_phase_number][_pvar] =
201  (*_dsaturation_dvar)[_qp][_gas_phase_number][_pvar];
202  (*_dgrads_qp_dgradv)[_qp][_aqueous_phase_number][_pvar] =
203  -(*_dgrads_qp_dgradv)[_qp][_gas_phase_number][_pvar];
204 
205  (*_dgrads_qp_dgradv)[_qp][_gas_phase_number][_hvar] =
206  (*_dsaturation_dvar)[_qp][_gas_phase_number][_hvar];
207  (*_dgrads_qp_dgradv)[_qp][_aqueous_phase_number][_hvar] =
208  -(*_dgrads_qp_dgradv)[_qp][_gas_phase_number][_hvar];
209 
210  const Real d2s_dp2 = (fsp_dp[_gas_phase_number].saturation.derivatives()[_pidx] -
211  _fsp[_gas_phase_number].saturation.derivatives()[_pidx]) /
212  dp;
213 
214  const Real d2s_dh2 = (fsp_dh[_gas_phase_number].saturation.derivatives()[_hidx] -
215  _fsp[_gas_phase_number].saturation.derivatives()[_hidx]) /
216  dh;
217 
218  const Real d2s_dph = (fsp_dp[_gas_phase_number].saturation.derivatives()[_hidx] -
219  _fsp[_gas_phase_number].saturation.derivatives()[_hidx]) /
220  dp +
221  (fsp_dh[_gas_phase_number].saturation.derivatives()[_pidx] -
222  _fsp[_gas_phase_number].saturation.derivatives()[_pidx]) /
223  dh;
224 
225  (*_dgrads_qp_dv)[_qp][_gas_phase_number][_pvar] =
226  d2s_dp2 * _liquid_gradp_qp[_qp] + d2s_dph * _gradh_qp[_qp];
227  (*_dgrads_qp_dv)[_qp][_aqueous_phase_number][_pvar] =
228  -(*_dgrads_qp_dv)[_qp][_gas_phase_number][_pvar];
229 
230  (*_dgrads_qp_dv)[_qp][_gas_phase_number][_hvar] =
231  d2s_dh2 * _gradh_qp[_qp] + d2s_dph * _liquid_gradp_qp[_qp];
232  (*_dgrads_qp_dv)[_qp][_aqueous_phase_number][_hvar] =
233  -(*_dgrads_qp_dv)[_qp][_gas_phase_number][_hvar];
234 
235  // Gradient of porepressure and derivatives
236  // Note: need first and second derivativea of capillary pressure
237  const Real dpc = _pc.dCapillaryPressure(_fsp[_aqueous_phase_number].saturation.value());
238  const Real d2pc = _pc.d2CapillaryPressure(_fsp[_aqueous_phase_number].saturation.value());
239 
240  (*_gradp_qp)[_qp][_aqueous_phase_number] = _liquid_gradp_qp[_qp];
241  (*_gradp_qp)[_qp][_gas_phase_number] =
242  _liquid_gradp_qp[_qp] + dpc * (*_grads_qp)[_qp][_aqueous_phase_number];
243 
244  for (unsigned int ph = 0; ph < _num_phases; ++ph)
245  (*_dgradp_qp_dgradv)[_qp][ph][_pvar] = 1.0;
246 
247  (*_dgradp_qp_dgradv)[_qp][_gas_phase_number][_pvar] +=
248  dpc * (*_dgrads_qp_dgradv)[_qp][_aqueous_phase_number][_pvar];
249  (*_dgradp_qp_dgradv)[_qp][_gas_phase_number][_hvar] =
250  dpc * (*_dgrads_qp_dgradv)[_qp][_aqueous_phase_number][_hvar];
251 
252  (*_dgradp_qp_dv)[_qp][_gas_phase_number][_pvar] =
253  d2pc * (*_grads_qp)[_qp][_aqueous_phase_number] *
254  (*_dsaturation_dvar)[_qp][_aqueous_phase_number][_pvar] +
255  dpc * (*_dgrads_qp_dv)[_qp][_aqueous_phase_number][_pvar];
256 
257  (*_dgradp_qp_dv)[_qp][_gas_phase_number][_hvar] =
258  d2pc * (*_grads_qp)[_qp][_aqueous_phase_number] *
259  (*_dsaturation_dvar)[_qp][_aqueous_phase_number][_hvar] +
260  dpc * (*_dgrads_qp_dv)[_qp][_aqueous_phase_number][_hvar];
261  }
262 }
const GenericVariableGradient< is_ad > & _liquid_gradp_qp
Gradient of porepressure (only defined at the qps)
const PorousFlowFluidStateSingleComponentBase & _fs
FluidState UserObject.
const PorousFlowCapillaryPressure & _pc
Capillary pressure UserObject.
const unsigned int _pidx
Index of derivative wrt pressure.
const unsigned int _gas_phase_number
Phase number of the gas phase.
MaterialProperty< std::vector< std::vector< Real > > > *const _dgradp_qp_dgradv
d(grad porepressure)/d(grad PorousFlow variable) at the quadpoints
const Real _T_c2k
Conversion from degrees Celsius to degrees Kelvin.
static const std::string temperature
Definition: NS.h:59
GenericReal< is_ad > genericValue(const ADReal &value)
Templated method that takes an ADReal value, and returns the raw value when is_ad = false...
const GenericVariableValue< is_ad > & _liquid_porepressure
Porepressure.
GenericMaterialProperty< Real, is_ad > & _temperature
Temperature.
const unsigned int _hvar
PorousFlow variable number of the enthalpy.
const GenericVariableValue< is_ad > & _enthalpy
Enthalpy.
AD data structure to pass calculated thermophysical properties.
const unsigned int _num_components
Number of components.
const unsigned int _pvar
PorousFlow variable number of the porepressure.
const unsigned int _num_phases
Number of phases.
virtual Real d2CapillaryPressure(Real saturation, unsigned qp=0) const
Second derivative of capillary pressure wrt true saturation.
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
virtual Real dCapillaryPressure(Real saturation, unsigned qp=0) const
Derivative of capillary pressure wrt true saturation.
std::vector< FluidStateProperties > _fsp
FluidStateProperties data for each fluid component in each fluid phase.
virtual void thermophysicalProperties(Real pressure, Real enthalpy, unsigned int qp, std::vector< FluidStateProperties > &fsp) const =0
Determines the complete thermophysical state of the system for a given set of primary variables...
const GenericVariableGradient< is_ad > & _gradh_qp
Gradient of enthalpy (only defined at the qps)
const unsigned int _aqueous_phase_number
Phase number of the aqueous phase.
const unsigned int _hidx
Index of derivative wrt enthalpy.

◆ genericValue() [1/3]

template<bool is_ad>
GenericReal<is_ad> PorousFlowFluidStateBaseMaterialTempl< is_ad >::genericValue ( const ADReal value)
protectedinherited

Templated method that takes an ADReal value, and returns the raw value when is_ad = false, and the AD value when is_ad = true.

Parameters
valueAD value
Returns
raw or AD value depending on is_ad

◆ genericValue() [2/3]

template<>
GenericReal< false > PorousFlowFluidStateBaseMaterialTempl< false >::genericValue ( const ADReal value)
protectedinherited

Definition at line 76 of file PorousFlowFluidStateBaseMaterial.C.

77 {
78  return MetaPhysicL::raw_value(value);
79 }
auto raw_value(const Eigen::Map< T > &in)

◆ genericValue() [3/3]

template<>
GenericReal< true > PorousFlowFluidStateBaseMaterialTempl< true >::genericValue ( const ADReal value)
protectedinherited

Definition at line 83 of file PorousFlowFluidStateBaseMaterial.C.

84 {
85  return value;
86 }
Real value(unsigned n, unsigned alpha, unsigned beta, Real x)

◆ initQpStatefulProperties()

template<bool is_ad>
void PorousFlowFluidStateSingleComponentTempl< is_ad >::initQpStatefulProperties ( )
overrideprotectedvirtual

Reimplemented from PorousFlowFluidStateBaseMaterialTempl< is_ad >.

Definition at line 92 of file PorousFlowFluidStateSingleComponent.C.

93 {
94  _is_initqp = true;
95  // Set the size of pressure and saturation vectors
97 
98  // Set the initial values of the temperature at the nodes.
99  // Note: not required for qp materials as no old values at the qps are requested
100  if (_nodal_material)
101  {
102  // Temperature doesn't depend on fluid phase
104  }
105 }
const Real _T_c2k
Conversion from degrees Celsius to degrees Kelvin.
static const std::string temperature
Definition: NS.h:59
GenericReal< is_ad > genericValue(const ADReal &value)
Templated method that takes an ADReal value, and returns the raw value when is_ad = false...
GenericMaterialProperty< Real, is_ad > & _temperature
Temperature.
bool _is_initqp
Flag to indicate whether stateful properties should be computed.
std::vector< FluidStateProperties > _fsp
FluidStateProperties data for each fluid component in each fluid phase.
const unsigned int _aqueous_phase_number
Phase number of the aqueous phase.

◆ setMaterialVectorSize()

template<bool is_ad>
void PorousFlowFluidStateSingleComponentTempl< is_ad >::setMaterialVectorSize ( ) const
overrideprotectedvirtual

Size material property vectors and initialise with zeros.

Reimplemented from PorousFlowFluidStateBaseMaterialTempl< is_ad >.

Definition at line 266 of file PorousFlowFluidStateSingleComponent.C.

267 {
269 
270  // Derivatives and gradients are not required in initQpStatefulProperties
271  if (!_is_initqp)
272  {
273  // Temperature doesn't depend of fluid phase
274  (*_dtemperature_dvar)[_qp].assign(_num_pf_vars, 0.0);
275 
276  // The gradient of the temperature is needed for qp materials and AD materials
277  if (!_nodal_material || is_ad)
278  (*_grad_temperature_qp)[_qp] = RealGradient();
279 
280  // No derivatives are required for AD materials
281  if (!is_ad)
282  if (!_nodal_material)
283  {
284  (*_dgrad_temperature_dgradv)[_qp].assign(_num_pf_vars, 0.0);
285  (*_dgrad_temperature_dv)[_qp].assign(_num_pf_vars, RealGradient());
286  }
287  }
288 }
virtual void setMaterialVectorSize() const
Size material property vectors and initialise with zeros.
const unsigned int _num_pf_vars
Number of PorousFlow variables.
bool _is_initqp
Flag to indicate whether stateful properties should be computed.

◆ thermophysicalProperties()

template<bool is_ad>
void PorousFlowFluidStateSingleComponentTempl< is_ad >::thermophysicalProperties ( )
overrideprotectedvirtual

Calculates all required thermophysical properties and derivatives for each phase and fluid component.

Implements PorousFlowFluidStateBaseMaterialTempl< is_ad >.

Definition at line 84 of file PorousFlowFluidStateSingleComponent.C.

85 {
88 }
const PorousFlowFluidStateSingleComponentBase & _fs
FluidState UserObject.
void clearFluidStateProperties(std::vector< FluidStateProperties > &fsp) const
Clears the contents of the FluidStateProperties data structure.
const GenericVariableValue< is_ad > & _liquid_porepressure
Porepressure.
const GenericVariableValue< is_ad > & _enthalpy
Enthalpy.
std::vector< FluidStateProperties > _fsp
FluidStateProperties data for each fluid component in each fluid phase.
virtual void thermophysicalProperties(Real pressure, Real enthalpy, unsigned int qp, std::vector< FluidStateProperties > &fsp) const =0
Determines the complete thermophysical state of the system for a given set of primary variables...

◆ validParams()

template<bool is_ad>
InputParameters PorousFlowFluidStateSingleComponentTempl< is_ad >::validParams ( )
static

Definition at line 18 of file PorousFlowFluidStateSingleComponent.C.

19 {
21  params.addRequiredCoupledVar("porepressure",
22  "Variable that is the porepressure of the liquid phase");
23  params.addRequiredCoupledVar("enthalpy", "Enthalpy of the fluid");
24  params.addRequiredParam<UserObjectName>("fluid_state", "Name of the FluidState UserObject");
25  params.addClassDescription(
26  "Class for single component multiphase fluid state calculations using pressure and enthalpy");
27  return params;
28 }
void addRequiredParam(const std::string &name, const std::string &doc_string)
void addRequiredCoupledVar(const std::string &name, const std::string &doc_string)
void addClassDescription(const std::string &doc_string)

Member Data Documentation

◆ _aqueous_phase_number

template<bool is_ad>
const unsigned int PorousFlowFluidStateSingleComponentTempl< is_ad >::_aqueous_phase_number
protected

Phase number of the aqueous phase.

Definition at line 60 of file PorousFlowFluidStateSingleComponent.h.

◆ _dfluid_density_dvar

template<bool is_ad>
MaterialProperty<std::vector<std::vector<Real> > >* const PorousFlowFluidStateBaseMaterialTempl< is_ad >::_dfluid_density_dvar
protectedinherited

Derivative of the fluid density for each phase wrt PorousFlow variables.

Definition at line 70 of file PorousFlowFluidStateBaseMaterial.h.

◆ _dfluid_enthalpy_dvar

template<bool is_ad>
MaterialProperty<std::vector<std::vector<Real> > >* const PorousFlowFluidStateBaseMaterialTempl< is_ad >::_dfluid_enthalpy_dvar
protectedinherited

Derivative of the fluid enthalpy for each phase wrt PorousFlow variables.

Definition at line 78 of file PorousFlowFluidStateBaseMaterial.h.

◆ _dfluid_internal_energy_dvar

template<bool is_ad>
MaterialProperty<std::vector<std::vector<Real> > >* const PorousFlowFluidStateBaseMaterialTempl< is_ad >::_dfluid_internal_energy_dvar
protectedinherited

Derivative of the fluid internal energy for each phase wrt PorousFlow variables.

Definition at line 82 of file PorousFlowFluidStateBaseMaterial.h.

◆ _dfluid_viscosity_dvar

template<bool is_ad>
MaterialProperty<std::vector<std::vector<Real> > >* const PorousFlowFluidStateBaseMaterialTempl< is_ad >::_dfluid_viscosity_dvar
protectedinherited

Derivative of the fluid viscosity for each phase wrt PorousFlow variables.

Definition at line 74 of file PorousFlowFluidStateBaseMaterial.h.

◆ _dgrad_temperature_dgradv

template<bool is_ad>
MaterialProperty<std::vector<Real> >* const PorousFlowFluidStateSingleComponentTempl< is_ad >::_dgrad_temperature_dgradv
protected

d(grad temperature)/d(grad PorousFlow variable) at the quadpoints

Definition at line 70 of file PorousFlowFluidStateSingleComponent.h.

◆ _dgrad_temperature_dv

template<bool is_ad>
MaterialProperty<std::vector<RealGradient> >* const PorousFlowFluidStateSingleComponentTempl< is_ad >::_dgrad_temperature_dv
protected

d(grad temperature)/d(PorousFlow variable) at the quadpoints

Definition at line 72 of file PorousFlowFluidStateSingleComponent.h.

◆ _dgradp_qp_dgradv

template<bool is_ad>
MaterialProperty<std::vector<std::vector<Real> > >* const PorousFlowVariableBaseTempl< is_ad >::_dgradp_qp_dgradv
protectedinherited

d(grad porepressure)/d(grad PorousFlow variable) at the quadpoints

Definition at line 51 of file PorousFlowVariableBase.h.

◆ _dgradp_qp_dv

template<bool is_ad>
MaterialProperty<std::vector<std::vector<RealGradient> > >* const PorousFlowVariableBaseTempl< is_ad >::_dgradp_qp_dv
protectedinherited

d(grad porepressure)/d(PorousFlow variable) at the quadpoints

Definition at line 54 of file PorousFlowVariableBase.h.

◆ _dgrads_qp_dgradv

template<bool is_ad>
MaterialProperty<std::vector<std::vector<Real> > >* const PorousFlowVariableBaseTempl< is_ad >::_dgrads_qp_dgradv
protectedinherited

d(grad saturation)/d(grad PorousFlow variable) at the quadpoints

Definition at line 66 of file PorousFlowVariableBase.h.

◆ _dgrads_qp_dv

template<bool is_ad>
MaterialProperty<std::vector<std::vector<RealGradient> > >* const PorousFlowVariableBaseTempl< is_ad >::_dgrads_qp_dv
protectedinherited

d(grad saturation)/d(PorousFlow variable) at the quadpoints

Definition at line 69 of file PorousFlowVariableBase.h.

◆ _dmass_frac_dvar

template<bool is_ad>
MaterialProperty<std::vector<std::vector<std::vector<Real> > > >* const PorousFlowFluidStateBaseMaterialTempl< is_ad >::_dmass_frac_dvar
protectedinherited

Derivative of the mass fraction matrix with respect to the Porous Flow variables.

Definition at line 66 of file PorousFlowFluidStateBaseMaterial.h.

◆ _dporepressure_dvar

template<bool is_ad>
MaterialProperty<std::vector<std::vector<Real> > >* const PorousFlowVariableBaseTempl< is_ad >::_dporepressure_dvar
protectedinherited

d(porepressure)/d(PorousFlow variable)

Definition at line 45 of file PorousFlowVariableBase.h.

◆ _dsaturation_dvar

template<bool is_ad>
MaterialProperty<std::vector<std::vector<Real> > >* const PorousFlowVariableBaseTempl< is_ad >::_dsaturation_dvar
protectedinherited

d(saturation)/d(PorousFlow variable)

Definition at line 60 of file PorousFlowVariableBase.h.

◆ _dtemperature_dvar

template<bool is_ad>
MaterialProperty<std::vector<Real> >* const PorousFlowFluidStateSingleComponentTempl< is_ad >::_dtemperature_dvar
protected

Derivative of temperature wrt PorousFlow variables.

Definition at line 68 of file PorousFlowFluidStateSingleComponent.h.

◆ _enthalpy

template<bool is_ad>
const GenericVariableValue<is_ad>& PorousFlowFluidStateSingleComponentTempl< is_ad >::_enthalpy
protected

Enthalpy.

Definition at line 50 of file PorousFlowFluidStateSingleComponent.h.

◆ _enthalpy_varnum

template<bool is_ad>
const unsigned int PorousFlowFluidStateSingleComponentTempl< is_ad >::_enthalpy_varnum
protected

Moose variable number of the enthalpy.

Definition at line 54 of file PorousFlowFluidStateSingleComponent.h.

◆ _fluid_density

template<bool is_ad>
GenericMaterialProperty<std::vector<Real>, is_ad>& PorousFlowFluidStateBaseMaterialTempl< is_ad >::_fluid_density
protectedinherited

Fluid density of each phase.

Definition at line 68 of file PorousFlowFluidStateBaseMaterial.h.

◆ _fluid_enthalpy

template<bool is_ad>
GenericMaterialProperty<std::vector<Real>, is_ad>& PorousFlowFluidStateBaseMaterialTempl< is_ad >::_fluid_enthalpy
protectedinherited

Enthalpy of each phase.

Definition at line 76 of file PorousFlowFluidStateBaseMaterial.h.

◆ _fluid_internal_energy

template<bool is_ad>
GenericMaterialProperty<std::vector<Real>, is_ad>& PorousFlowFluidStateBaseMaterialTempl< is_ad >::_fluid_internal_energy
protectedinherited

Internal energy of each phase.

Definition at line 80 of file PorousFlowFluidStateBaseMaterial.h.

◆ _fluid_viscosity

template<bool is_ad>
GenericMaterialProperty<std::vector<Real>, is_ad>& PorousFlowFluidStateBaseMaterialTempl< is_ad >::_fluid_viscosity
protectedinherited

Viscosity of each phase.

Definition at line 72 of file PorousFlowFluidStateBaseMaterial.h.

◆ _fs

template<bool is_ad>
const PorousFlowFluidStateSingleComponentBase& PorousFlowFluidStateSingleComponentTempl< is_ad >::_fs
protected

◆ _fsp

template<bool is_ad>
std::vector<FluidStateProperties> PorousFlowFluidStateBaseMaterialTempl< is_ad >::_fsp
protectedinherited

FluidStateProperties data for each fluid component in each fluid phase.

Definition at line 55 of file PorousFlowFluidStateBaseMaterial.h.

Referenced by PorousFlowFluidStateBaseMaterialTempl< is_ad >::PorousFlowFluidStateBaseMaterialTempl().

◆ _gas_phase_number

template<bool is_ad>
const unsigned int PorousFlowFluidStateSingleComponentTempl< is_ad >::_gas_phase_number
protected

Phase number of the gas phase.

Definition at line 62 of file PorousFlowFluidStateSingleComponent.h.

◆ _grad_mass_frac_qp

template<bool is_ad>
GenericMaterialProperty<std::vector<std::vector<RealGradient> >, is_ad>* const PorousFlowFluidStateBaseMaterialTempl< is_ad >::_grad_mass_frac_qp
protectedinherited

Gradient of the mass fraction matrix (only defined at the qps)

Definition at line 64 of file PorousFlowFluidStateBaseMaterial.h.

◆ _grad_temperature_qp

template<bool is_ad>
GenericMaterialProperty<RealGradient, is_ad>* const PorousFlowFluidStateSingleComponentTempl< is_ad >::_grad_temperature_qp
protected

Gradient of temperature (only defined at the qps)

Definition at line 66 of file PorousFlowFluidStateSingleComponent.h.

◆ _gradh_qp

template<bool is_ad>
const GenericVariableGradient<is_ad>& PorousFlowFluidStateSingleComponentTempl< is_ad >::_gradh_qp
protected

Gradient of enthalpy (only defined at the qps)

Definition at line 52 of file PorousFlowFluidStateSingleComponent.h.

◆ _gradp_qp

template<bool is_ad>
GenericMaterialProperty<std::vector<RealGradient>, is_ad>* const PorousFlowVariableBaseTempl< is_ad >::_gradp_qp
protectedinherited

Grad(p) at the quadpoints.

Definition at line 48 of file PorousFlowVariableBase.h.

◆ _grads_qp

template<bool is_ad>
GenericMaterialProperty<std::vector<RealGradient>, is_ad>* const PorousFlowVariableBaseTempl< is_ad >::_grads_qp
protectedinherited

Grad(s) at the quadpoints.

Definition at line 63 of file PorousFlowVariableBase.h.

◆ _hidx

template<bool is_ad>
const unsigned int PorousFlowFluidStateSingleComponentTempl< is_ad >::_hidx
protected

Index of derivative wrt enthalpy.

Definition at line 76 of file PorousFlowFluidStateSingleComponent.h.

◆ _hvar

template<bool is_ad>
const unsigned int PorousFlowFluidStateSingleComponentTempl< is_ad >::_hvar
protected

PorousFlow variable number of the enthalpy.

Definition at line 56 of file PorousFlowFluidStateSingleComponent.h.

◆ _is_initqp

template<bool is_ad>
bool PorousFlowFluidStateBaseMaterialTempl< is_ad >::_is_initqp
protectedinherited

Flag to indicate whether stateful properties should be computed.

Definition at line 53 of file PorousFlowFluidStateBaseMaterial.h.

◆ _liquid_gradp_qp

template<bool is_ad>
const GenericVariableGradient<is_ad>& PorousFlowFluidStateSingleComponentTempl< is_ad >::_liquid_gradp_qp
protected

Gradient of porepressure (only defined at the qps)

Definition at line 44 of file PorousFlowFluidStateSingleComponent.h.

◆ _liquid_porepressure

template<bool is_ad>
const GenericVariableValue<is_ad>& PorousFlowFluidStateSingleComponentTempl< is_ad >::_liquid_porepressure
protected

Porepressure.

Definition at line 42 of file PorousFlowFluidStateSingleComponent.h.

◆ _liquid_porepressure_varnum

template<bool is_ad>
const unsigned int PorousFlowFluidStateSingleComponentTempl< is_ad >::_liquid_porepressure_varnum
protected

Moose variable number of the porepressure.

Definition at line 46 of file PorousFlowFluidStateSingleComponent.h.

◆ _mass_frac

template<bool is_ad>
GenericMaterialProperty<std::vector<std::vector<Real> >, is_ad>& PorousFlowFluidStateBaseMaterialTempl< is_ad >::_mass_frac
protectedinherited

Mass fraction matrix (indexing is fluid component in fluid phase)

Definition at line 62 of file PorousFlowFluidStateBaseMaterial.h.

◆ _num_components

template<bool is_ad>
const unsigned int PorousFlowVariableBaseTempl< is_ad >::_num_components
protectedinherited

◆ _num_pf_vars

template<bool is_ad>
const unsigned int PorousFlowVariableBaseTempl< is_ad >::_num_pf_vars
protectedinherited

Number of PorousFlow variables.

Definition at line 39 of file PorousFlowVariableBase.h.

◆ _num_phases

template<bool is_ad>
const unsigned int PorousFlowVariableBaseTempl< is_ad >::_num_phases
protectedinherited

◆ _pc

template<bool is_ad>
const PorousFlowCapillaryPressure& PorousFlowFluidStateBaseMaterialTempl< is_ad >::_pc
protectedinherited

Capillary pressure UserObject.

Definition at line 57 of file PorousFlowFluidStateBaseMaterial.h.

◆ _pidx

template<bool is_ad>
const unsigned int PorousFlowFluidStateSingleComponentTempl< is_ad >::_pidx
protected

Index of derivative wrt pressure.

Definition at line 74 of file PorousFlowFluidStateSingleComponent.h.

◆ _porepressure

template<bool is_ad>
GenericMaterialProperty<std::vector<Real>, is_ad>& PorousFlowVariableBaseTempl< is_ad >::_porepressure
protectedinherited

◆ _pvar

template<bool is_ad>
const unsigned int PorousFlowFluidStateSingleComponentTempl< is_ad >::_pvar
protected

PorousFlow variable number of the porepressure.

Definition at line 48 of file PorousFlowFluidStateSingleComponent.h.

◆ _saturation

template<bool is_ad>
GenericMaterialProperty<std::vector<Real>, is_ad>& PorousFlowVariableBaseTempl< is_ad >::_saturation
protectedinherited

◆ _sfx

template<bool is_ad>
const std::string PorousFlowFluidStateBaseMaterialTempl< is_ad >::_sfx
protectedinherited

Suffix to append to material property names (either qp or nodal as required)

Definition at line 59 of file PorousFlowFluidStateBaseMaterial.h.

◆ _T_c2k

template<bool is_ad>
const Real PorousFlowFluidStateBaseMaterialTempl< is_ad >::_T_c2k
protectedinherited

Conversion from degrees Celsius to degrees Kelvin.

Definition at line 51 of file PorousFlowFluidStateBaseMaterial.h.

◆ _temperature

template<bool is_ad>
GenericMaterialProperty<Real, is_ad>& PorousFlowFluidStateSingleComponentTempl< is_ad >::_temperature
protected

Temperature.

Definition at line 64 of file PorousFlowFluidStateSingleComponent.h.

◆ usingPorousFlowFluidStateBaseMaterialDerivativeMembers

template<bool is_ad>
PorousFlowFluidStateSingleComponentTempl< is_ad >::usingPorousFlowFluidStateBaseMaterialDerivativeMembers
protected

Definition at line 81 of file PorousFlowFluidStateSingleComponent.h.

◆ usingPorousFlowFluidStateBaseMaterialMembers

template<bool is_ad>
PorousFlowFluidStateSingleComponentTempl< is_ad >::usingPorousFlowFluidStateBaseMaterialMembers
protected

Definition at line 79 of file PorousFlowFluidStateSingleComponent.h.

◆ usingPorousFlowVariableBaseMembers

template<bool is_ad>
PorousFlowFluidStateBaseMaterialTempl< is_ad >::usingPorousFlowVariableBaseMembers
protectedinherited

Definition at line 84 of file PorousFlowFluidStateBaseMaterial.h.


The documentation for this class was generated from the following files: