Loading [MathJax]/extensions/tex2jax.js
https://mooseframework.inl.gov
All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends
Public Types | Public Member Functions | Static Public Member Functions | Protected Types | Protected Member Functions | Protected Attributes | Private Member Functions | List of all members
PorousFlowHystereticInfo Class Reference

Material designed to calculate the capillary pressure as a function of saturation, or the saturation as a function of capillary pressure, or derivative information, etc. More...

#include <PorousFlowHystereticInfo.h>

Inheritance diagram for PorousFlowHystereticInfo:
[legend]

Public Types

typedef DerivativeMaterialPropertyNameInterface::SymbolName SymbolName
 

Public Member Functions

 PorousFlowHystereticInfo (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 Types

enum  InfoTypeEnum {
  InfoTypeEnum::PC, InfoTypeEnum::SAT, InfoTypeEnum::SAT_GIVEN_PC, InfoTypeEnum::DS_DPC_ERR,
  InfoTypeEnum::DPC_DS_ERR, InfoTypeEnum::D2S_DPC2_ERR, InfoTypeEnum::D2PC_DS2_ERR
}
 Type of info required. More...
 

Protected Member Functions

virtual void initQpStatefulProperties () override
 
virtual void computeQpProperties () override
 
void computeQpInfo ()
 Fill _info with the required information. More...
 
Real landSat (Real slDel) const
 
void computeTurningPointInfo (unsigned tp_num, Real tp_sat, Real tp_pc)
 Compute all relevant quantities at the given turning point. More...
 
Real capillaryPressureQp (Real sat) const
 
Real dcapillaryPressureQp (Real sat) const
 
Real d2capillaryPressureQp (Real sat) const
 
Real liquidSaturationQp (Real pc) const
 
Real dliquidSaturationQp (Real pc) const
 
Real d2liquidSaturationQp (Real pc) const
 

Protected Attributes

MaterialProperty< Real > & _pc
 Computed nodal or quadpoint value of capillary pressure (needed for hysteretic order computation) More...
 
MaterialProperty< Real > & _info
 Computed nodal or quadpoint value: the meaning of this depends on info_enum. More...
 
const VariableValue_pc_val
 Nodal or quadpoint value of capillary pressure. More...
 
const VariableValue_sat_val
 Nodal or quadpoint value of liquid saturation. More...
 
const Real _fd_eps
 small parameter to use in the finite-difference approximations to the derivative More...
 
enum PorousFlowHystereticInfo::InfoTypeEnum _info_enum
 
const Real _alpha_d
 van Genuchten alpha parameter for the primary drying curve More...
 
const Real _alpha_w
 van Genuchten alpha parameter for the primary wetting curve More...
 
const Real _n_d
 van Genuchten n parameter for the primary drying curve More...
 
const Real _n_w
 van Genuchten n parameter for the primary wetting curve More...
 
const Real _s_l_min
 Minimum liquid saturation for which the van Genuchten expression is valid (Pc(_s_l_min) = infinity) More...
 
const Real _s_lr
 Liquid saturation below which the liquid relative permeability is zero. More...
 
const Real _s_gr_max
 Residual gas saturation: 1 - _s_gr_max is the maximum saturation for which the van Genuchten expression is valid for the wetting curve. More...
 
const Real _pc_max
 Maximum capillary pressure: for Pc above this value, a "lower" extension will be used. More...
 
const Real _high_ratio
 The high-saturation extension to the wetting will commence at _high_ratio * (1 - _s_gr_del) More...
 
const PorousFlowVanGenuchten::LowCapillaryPressureExtension::ExtensionStrategy _low_ext_type
 Type of low-saturation extension. More...
 
const Real _s_low_d
 Saturation on the primary drying curve where low-saturation extension commences. More...
 
const Real _dpc_low_d
 d(Pc)/dS on the primary drying curve at S = _s_low_d More...
 
const PorousFlowVanGenuchten::LowCapillaryPressureExtension _low_ext_d
 Parameters involved in the low-saturation extension of the primary drying curve. More...
 
const Real _s_low_w
 Saturation on the primary wetting curve where low-saturation extension commences. More...
 
const Real _dpc_low_w
 d(Pc)/dS on the primary wetting curve at S = _s_low_w More...
 
const PorousFlowVanGenuchten::LowCapillaryPressureExtension _low_ext_w
 Parameters involved in the low-saturation extension of the primary wetting curve. More...
 
const PorousFlowVanGenuchten::HighCapillaryPressureExtension::ExtensionStrategy _high_ext_type
 Type of high-saturation extension of the wetting curves. More...
 
const Real _s_high
 Saturation at the point of high-saturation extension. More...
 
const Real _pc_high
 Pc at the point of high-saturation extension. More...
 
const Real _dpc_high
 d(Pc)/d(S) at the point of high-saturation extension More...
 
const PorousFlowVanGenuchten::HighCapillaryPressureExtension _high_ext
 Parameters involved in the high-saturation extension of the primary wetting curve. More...
 
const MaterialProperty< unsigned > & _hys_order
 Hysteresis order, as computed by PorousFlowHysteresisOrder. More...
 
const MaterialProperty< unsigned > & _hys_order_old
 Old value of hysteresis order, as computed by PorousFlowHysteresisOrder. More...
 
const MaterialProperty< std::array< Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _hys_sat_tps
 Saturation values at the turning points, as computed by PorousFlowHysteresisOrder. More...
 
const MaterialProperty< Real > & _pc_older
 Older value of capillary pressure. More...
 
MaterialProperty< std::array< Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _pc_tps
 Nodal or quadpoint values of Pc at the turning points. More...
 
MaterialProperty< std::array< Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _s_d_tps
 Computed nodal or quadpoint values of saturation on the drying curve at _pc_tps. More...
 
MaterialProperty< std::array< Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _s_gr_tps
 Computed nodal or quadpoint values of S_gr_Del, ie, the Land expression, at the turning points. More...
 
MaterialProperty< std::array< PorousFlowVanGenuchten::LowCapillaryPressureExtension, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _w_low_ext_tps
 Nodal or quadpoint values of the low extension of the wetting curve defined by _s_gr_tps. More...
 
MaterialProperty< std::array< PorousFlowVanGenuchten::HighCapillaryPressureExtension, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _w_high_ext_tps
 Nodal or quadpoint values of the high extension of the wetting curve defined by _s_gr_tps. More...
 
MaterialProperty< std::array< Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _s_w_tps
 Computed nodal or quadpoint values of liquid saturation on the wetting curve defined by _s_gr_del, at pc = _pc_d_tps. More...
 
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...
 

Private Member Functions

Real relativeError (Real finite_difference, Real hand_coded)
 Computes the relative error between a finite-difference approximation to the derivative and a hand-coded version. More...
 

Detailed Description

Material designed to calculate the capillary pressure as a function of saturation, or the saturation as a function of capillary pressure, or derivative information, etc.

Definition at line 18 of file PorousFlowHystereticInfo.h.

Member Enumeration Documentation

◆ InfoTypeEnum

Type of info required.

Enumerator
PC 
SAT 
SAT_GIVEN_PC 
DS_DPC_ERR 
DPC_DS_ERR 
D2S_DPC2_ERR 
D2PC_DS2_ERR 

Definition at line 48 of file PorousFlowHystereticInfo.h.

48  {
49  PC,
50  SAT,
51  SAT_GIVEN_PC,
52  DS_DPC_ERR,
53  DPC_DS_ERR,
54  D2S_DPC2_ERR,
55  D2PC_DS2_ERR
56  } _info_enum;
enum PorousFlowHystereticInfo::InfoTypeEnum _info_enum

Constructor & Destructor Documentation

◆ PorousFlowHystereticInfo()

PorousFlowHystereticInfo::PorousFlowHystereticInfo ( const InputParameters parameters)

Definition at line 60 of file PorousFlowHystereticInfo.C.

62  _pc(_nodal_material ? declareProperty<Real>("PorousFlow_hysteretic_capillary_pressure_nodal")
63  : declareProperty<Real>("PorousFlow_hysteretic_capillary_pressure_qp")),
64  _info(_nodal_material ? declareProperty<Real>("PorousFlow_hysteretic_info_nodal")
65  : declareProperty<Real>("PorousFlow_hysteretic_info_qp")),
66  _pc_val(_nodal_material ? coupledDofValues("pc_var") : coupledValue("pc_var")),
67  _sat_val(_nodal_material ? coupledDofValues("sat_var") : coupledValue("sat_var")),
68  _fd_eps(getParam<Real>("fd_eps")),
69  _info_enum(getParam<MooseEnum>("info_required").getEnum<InfoTypeEnum>())
70 {
71  // note that _num_phases must be positive, otherwise get a problem with using
72  // PorousFlowHysteresisOrder, so _num_phases > 0 needn't be checked here
73 }
const Real _fd_eps
small parameter to use in the finite-difference approximations to the derivative
const VariableValue & _sat_val
Nodal or quadpoint value of liquid saturation.
MaterialProperty< Real > & _pc
Computed nodal or quadpoint value of capillary pressure (needed for hysteretic order computation) ...
MaterialProperty< Real > & _info
Computed nodal or quadpoint value: the meaning of this depends on info_enum.
PorousFlowHystereticCapillaryPressure(const InputParameters &parameters)
enum PorousFlowHystereticInfo::InfoTypeEnum _info_enum
const VariableValue & _pc_val
Nodal or quadpoint value of capillary pressure.

Member Function Documentation

◆ capillaryPressureQp()

Real PorousFlowHystereticCapillaryPressure::capillaryPressureQp ( Real  sat) const
protectedinherited
Returns
the value of capillary pressure, given the liquid saturation. This uses _hys_order[_qp]
Parameters
satliquid saturation

Definition at line 300 of file PorousFlowHystereticCapillaryPressure.C.

Referenced by PorousFlow2PhaseHysPS::buildQpPPSS(), computeQpInfo(), computeQpProperties(), and initQpStatefulProperties().

301 {
302  Real pc = 0.0;
303  if (_hys_order[_qp] == 0) // on primary drying curve
305  sat, _s_l_min, 0.0, _alpha_d, _n_d, _low_ext_d);
306  else if (_hys_order[_qp] == 1) // first-order wetting
307  pc = firstOrderWettingPc(sat);
308  else if (_hys_order[_qp] == 2) // second-order drying
309  pc = secondOrderDryingPc(sat);
310  else // third order drying and wetting
311  {
312  const Real tp1 = _hys_sat_tps[_qp].at(1);
313  const Real tp2 = _hys_sat_tps[_qp].at(2);
314  const Real pc1 = firstOrderWettingPc(sat);
315  const Real pc2 = secondOrderDryingPc(sat);
316  // handle cases that occur just at the transition from 3rd to 2nd order, or 3rd to 1st order
317  if (sat < tp2)
318  pc = pc2;
319  else if (sat > tp1)
320  pc = pc1;
321  else if (pc1 >= pc2)
322  pc = pc1;
323  else if (pc1 <= 0.0 || pc2 <= 0.0)
324  pc = 0.0;
325  else
326  pc = std::exp(std::log(pc1) + (sat - tp1) * (std::log(pc2) - std::log(pc1)) / (tp2 - tp1));
327  }
328  return pc;
329 }
const MaterialProperty< unsigned > & _hys_order
Hysteresis order, as computed by PorousFlowHysteresisOrder.
const Real _alpha_d
van Genuchten alpha parameter for the primary drying curve
const Real _n_d
van Genuchten n parameter for the primary drying curve
Real capillaryPressureHys(Real sl, Real slmin, Real sgrdel, Real alpha, Real n, const LowCapillaryPressureExtension &low_ext=LowCapillaryPressureExtension(), const HighCapillaryPressureExtension &high_ext=HighCapillaryPressureExtension())
Hysteretic capillary pressure function (Eqn(1) of Doughty2007) with extensions (page5 and Fig1 of Dou...
const MaterialProperty< std::array< Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _hys_sat_tps
Saturation values at the turning points, as computed by PorousFlowHysteresisOrder.
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
const PorousFlowVanGenuchten::LowCapillaryPressureExtension _low_ext_d
Parameters involved in the low-saturation extension of the primary drying curve.
const Real _s_l_min
Minimum liquid saturation for which the van Genuchten expression is valid (Pc(_s_l_min) = infinity) ...

◆ computeQpInfo()

void PorousFlowHystereticInfo::computeQpInfo ( )
protected

Fill _info with the required information.

Definition at line 94 of file PorousFlowHystereticInfo.C.

Referenced by computeQpProperties(), and initQpStatefulProperties().

95 {
96  switch (_info_enum)
97  {
98  case InfoTypeEnum::PC:
99  _info[_qp] = capillaryPressureQp(_sat_val[_qp]);
100  break;
101  case InfoTypeEnum::SAT:
102  {
103  const Real pc = capillaryPressureQp(_sat_val[_qp]);
104  _info[_qp] = liquidSaturationQp(pc);
105  break;
106  }
108  _info[_qp] = liquidSaturationQp(_pc_val[_qp]);
109  break;
111  {
112  const Real pc = capillaryPressureQp(_sat_val[_qp]);
113  const Real fd =
115  _info[_qp] = relativeError(fd, dliquidSaturationQp(pc));
116  break;
117  }
119  {
120  const Real fd = 0.5 *
123  _fd_eps;
125  break;
126  }
128  {
129  const Real pc = capillaryPressureQp(_sat_val[_qp]);
130  const Real fd =
132  _info[_qp] = relativeError(fd, d2liquidSaturationQp(pc));
133  break;
134  }
136  {
137  const Real fd = 0.5 *
140  _fd_eps;
142  break;
143  }
144  }
145 }
const Real _fd_eps
small parameter to use in the finite-difference approximations to the derivative
const VariableValue & _sat_val
Nodal or quadpoint value of liquid saturation.
MaterialProperty< Real > & _info
Computed nodal or quadpoint value: the meaning of this depends on info_enum.
Real relativeError(Real finite_difference, Real hand_coded)
Computes the relative error between a finite-difference approximation to the derivative and a hand-co...
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
enum PorousFlowHystereticInfo::InfoTypeEnum _info_enum
const VariableValue & _pc_val
Nodal or quadpoint value of capillary pressure.

◆ computeQpProperties()

void PorousFlowHystereticInfo::computeQpProperties ( )
overrideprotectedvirtual

Reimplemented from PorousFlowHystereticCapillaryPressure.

Definition at line 85 of file PorousFlowHystereticInfo.C.

86 {
88  _saturation[_qp][0] = _sat_val[_qp];
89  _pc[_qp] = capillaryPressureQp(_sat_val[_qp]);
90  computeQpInfo();
91 }
const VariableValue & _sat_val
Nodal or quadpoint value of liquid saturation.
MaterialProperty< Real > & _pc
Computed nodal or quadpoint value of capillary pressure (needed for hysteretic order computation) ...
void computeQpInfo()
Fill _info with the required information.
GenericMaterialProperty< std::vector< Real >, is_ad > & _saturation
Computed nodal or qp saturation of the phases.

◆ computeTurningPointInfo()

void PorousFlowHystereticCapillaryPressure::computeTurningPointInfo ( unsigned  tp_num,
Real  tp_sat,
Real  tp_pc 
)
protectedinherited

Compute all relevant quantities at the given turning point.

Parameters
tp_numThe turning point number. Eg, tp_num=0 upon transition from zeroth-order drying to first-order wetting
tp_satLiquid saturation at the turning point
tp_pcCapillary pressure at the turning point

Definition at line 240 of file PorousFlowHystereticCapillaryPressure.C.

Referenced by PorousFlowHystereticCapillaryPressure::computeQpProperties(), and PorousFlowHystereticCapillaryPressure::initQpStatefulProperties().

243 {
244  _pc_tps[_qp].at(tp_num) = tp_pc;
245 
246  // Quantities on the drying curve:
247  // pc on the drying curve at the turning point saturation
249  tp_sat, _s_l_min, 0.0, _alpha_d, _n_d, _low_ext_d);
250  // saturation on the drying curve, at tp_pc
251  _s_d_tps[_qp].at(tp_num) =
253 
254  // Quantities relevant to the wetting curve defined by the Land expression.
255  // s_gr_tps is the Land expression as a function of the turning point saturation
256  _s_gr_tps[_qp].at(tp_num) = landSat(tp_sat);
257  // the low extension of the wetting curve defined by _s_gr_tps
258  const Real s_w_low_ext = PorousFlowVanGenuchten::saturationHys(
259  _pc_max, _s_l_min, _s_gr_tps[_qp].at(tp_num), _alpha_w, _n_w);
261  s_w_low_ext, _s_l_min, _s_gr_tps[_qp].at(tp_num), _alpha_w, _n_w);
263  _low_ext_type, s_w_low_ext, _pc_max, dpc_w_low_ext);
264  // the high extension of the wetting curve defined by _s_gr_tps
265  const Real s_w_high_ext =
267  ? 1.0 - _s_gr_tps[_qp].at(tp_num)
268  : _high_ratio *
269  (1.0 -
270  _s_gr_tps[_qp].at(
271  tp_num)); // if NONE then use the vanGenuchten all the way to 1 - _s_gr_tps
272  const Real pc_w_high_ext =
274  _s_l_min,
275  _s_gr_tps[_qp].at(tp_num),
276  _alpha_w,
277  _n_w,
278  _w_low_ext_tps[_qp].at(tp_num));
279  const Real dpc_w_high_ext =
281  _s_l_min,
282  _s_gr_tps[_qp].at(tp_num),
283  _alpha_w,
284  _n_w,
285  _w_low_ext_tps[_qp].at(tp_num));
287  _high_ext_type, s_w_high_ext, pc_w_high_ext, dpc_w_high_ext);
288 
289  // saturation on the wetting curve defined by _s_gr_tps, at pc = pc_d_tps
290  _s_w_tps[_qp].at(tp_num) = PorousFlowVanGenuchten::saturationHys(pc_d_tps,
291  _s_l_min,
292  _s_gr_tps[_qp].at(tp_num),
293  _alpha_w,
294  _n_w,
295  _w_low_ext_tps[_qp].at(tp_num),
296  _w_high_ext_tps[_qp].at(tp_num));
297 }
Real dcapillaryPressureHys(Real sl, Real slmin, Real sgrdel, Real alpha, Real n, const LowCapillaryPressureExtension &low_ext=LowCapillaryPressureExtension(), const HighCapillaryPressureExtension &high_ext=HighCapillaryPressureExtension())
Derivative of capillaryPressureHys with respect to sl.
MaterialProperty< std::array< PorousFlowVanGenuchten::LowCapillaryPressureExtension, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _w_low_ext_tps
Nodal or quadpoint values of the low extension of the wetting curve defined by _s_gr_tps.
MaterialProperty< std::array< PorousFlowVanGenuchten::HighCapillaryPressureExtension, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _w_high_ext_tps
Nodal or quadpoint values of the high extension of the wetting curve defined by _s_gr_tps.
const PorousFlowVanGenuchten::LowCapillaryPressureExtension::ExtensionStrategy _low_ext_type
Type of low-saturation extension.
const Real _high_ratio
The high-saturation extension to the wetting will commence at _high_ratio * (1 - _s_gr_del) ...
const Real _pc_max
Maximum capillary pressure: for Pc above this value, a "lower" extension will be used.
Parameters associated with the extension of the hysteretic wetting capillary pressure function to hig...
const PorousFlowVanGenuchten::HighCapillaryPressureExtension::ExtensionStrategy _high_ext_type
Type of high-saturation extension of the wetting curves.
const Real _alpha_d
van Genuchten alpha parameter for the primary drying curve
const Real _n_d
van Genuchten n parameter for the primary drying curve
Real capillaryPressureHys(Real sl, Real slmin, Real sgrdel, Real alpha, Real n, const LowCapillaryPressureExtension &low_ext=LowCapillaryPressureExtension(), const HighCapillaryPressureExtension &high_ext=HighCapillaryPressureExtension())
Hysteretic capillary pressure function (Eqn(1) of Doughty2007) with extensions (page5 and Fig1 of Dou...
Parameters associated with the extension of the hysteretic capillary pressure function to low saturat...
const Real _alpha_w
van Genuchten alpha parameter for the primary wetting curve
MaterialProperty< std::array< Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _pc_tps
Nodal or quadpoint values of Pc at the turning points.
const Real _n_w
van Genuchten n parameter for the primary wetting curve
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
const PorousFlowVanGenuchten::LowCapillaryPressureExtension _low_ext_d
Parameters involved in the low-saturation extension of the primary drying curve.
MaterialProperty< std::array< Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _s_gr_tps
Computed nodal or quadpoint values of S_gr_Del, ie, the Land expression, at the turning points...
MaterialProperty< std::array< Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _s_w_tps
Computed nodal or quadpoint values of liquid saturation on the wetting curve defined by _s_gr_del...
const Real _s_l_min
Minimum liquid saturation for which the van Genuchten expression is valid (Pc(_s_l_min) = infinity) ...
MaterialProperty< std::array< Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _s_d_tps
Computed nodal or quadpoint values of saturation on the drying curve at _pc_tps.
Real saturationHys(Real pc, Real slmin, Real sgrdel, Real alpha, Real n, const LowCapillaryPressureExtension &low_ext=LowCapillaryPressureExtension(), const HighCapillaryPressureExtension &high_ext=HighCapillaryPressureExtension())
Hysteretic saturation function (Eqn(1) of Doughty2007) with extensions (page5 and Fig1 of Doughty2008...

◆ d2capillaryPressureQp()

Real PorousFlowHystereticCapillaryPressure::d2capillaryPressureQp ( Real  sat) const
protectedinherited
Returns
d^2(capillary pressure)/d(sat)^2. This uses _hys_order[_qp]
Parameters
satliquid saturation

Definition at line 371 of file PorousFlowHystereticCapillaryPressure.C.

Referenced by computeQpInfo(), and PorousFlow2PhaseHysPS::computeQpProperties().

372 {
373  Real d2pc = 0.0;
374  if (_hys_order[_qp] == 0) // on primary drying curve
376  sat, _s_l_min, 0.0, _alpha_d, _n_d, _low_ext_d);
377  else if (_hys_order[_qp] == 1) // first-order wetting
378  d2pc = d2firstOrderWettingPc(sat);
379  else if (_hys_order[_qp] == 2) // second-order drying
380  d2pc = d2secondOrderDryingPc(sat);
381  else // third order drying and wetting
382  {
383  const Real tp1 = _hys_sat_tps[_qp].at(1);
384  const Real tp2 = _hys_sat_tps[_qp].at(2);
385  const Real pc1 = firstOrderWettingPc(sat);
386  const Real pc2 = secondOrderDryingPc(sat);
387  // handle cases that occur just at the transition from 3rd to 2nd order, or 3rd to 1st order
388  if (sat < tp2)
389  d2pc = d2secondOrderDryingPc(sat);
390  else if (sat > tp1)
391  d2pc = d2firstOrderWettingPc(sat);
392  else if (pc1 >= pc2)
393  d2pc = d2firstOrderWettingPc(sat);
394  else if (pc1 <= 0.0 || pc2 <= 0.0)
395  d2pc = 0.0;
396  else
397  {
398  const Real pc =
399  std::exp(std::log(pc1) + (sat - tp1) * (std::log(pc2) - std::log(pc1)) / (tp2 - tp1));
400  const Real dpc1 = dfirstOrderWettingPc(sat);
401  const Real dpc2 = dsecondOrderDryingPc(sat);
402  const Real dpc = pc * (dpc1 / pc1 + (std::log(pc2) - std::log(pc1)) / (tp2 - tp1) +
403  (sat - tp1) * (dpc2 / pc2 - dpc1 / pc1) / (tp2 - tp1));
404  const Real d2pc1 = d2firstOrderWettingPc(sat);
405  const Real d2pc2 = d2secondOrderDryingPc(sat);
406  d2pc =
407  dpc * (dpc1 / pc1 + (std::log(pc2) - std::log(pc1)) / (tp2 - tp1) +
408  (sat - tp1) * (dpc2 / pc2 - dpc1 / pc1) / (tp2 - tp1)) +
409  pc *
410  (d2pc1 / pc1 - dpc1 * dpc1 / pc1 / pc1 + (dpc2 / pc2 - dpc1 / pc1) / (tp2 - tp1) +
411  (dpc2 / pc2 - dpc1 / pc1) / (tp2 - tp1) +
412  (sat - tp1) *
413  (d2pc2 / pc2 - dpc2 * dpc2 / pc2 / pc2 - d2pc1 / pc1 + dpc1 * dpc1 / pc1 / pc1) /
414  (tp2 - tp1));
415  }
416  }
417  return d2pc;
418 }
Real d2capillaryPressureHys(Real sl, Real slmin, Real sgrdel, Real alpha, Real n, const LowCapillaryPressureExtension &low_ext=LowCapillaryPressureExtension(), const HighCapillaryPressureExtension &high_ext=HighCapillaryPressureExtension())
Second derivative of capillaryPressureHys with respect to sl.
const MaterialProperty< unsigned > & _hys_order
Hysteresis order, as computed by PorousFlowHysteresisOrder.
const Real _alpha_d
van Genuchten alpha parameter for the primary drying curve
const Real _n_d
van Genuchten n parameter for the primary drying curve
const MaterialProperty< std::array< Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _hys_sat_tps
Saturation values at the turning points, as computed by PorousFlowHysteresisOrder.
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
const PorousFlowVanGenuchten::LowCapillaryPressureExtension _low_ext_d
Parameters involved in the low-saturation extension of the primary drying curve.
const Real _s_l_min
Minimum liquid saturation for which the van Genuchten expression is valid (Pc(_s_l_min) = infinity) ...

◆ d2liquidSaturationQp()

Real PorousFlowHystereticCapillaryPressure::d2liquidSaturationQp ( Real  pc) const
protectedinherited
Returns
d^2(liquid saturation)/d(pc)^2. This uses _hys_order[_qp]
Parameters
pccapillary pressure

Definition at line 698 of file PorousFlowHystereticCapillaryPressure.C.

Referenced by computeQpInfo(), PorousFlow1PhaseHysP::computeQpProperties(), and PorousFlow2PhaseHysPP::computeQpProperties().

699 {
700  Real d2sat = 0.0;
701  if (_hys_order[_qp] == 0) // on primary drying curve
703  else if (_hys_order[_qp] == 1) // first-order wetting
704  d2sat = d2firstOrderWettingSat(pc);
705  else if (_hys_order[_qp] == 2) // second-order drying
706  d2sat = d2secondOrderDryingSat(pc);
707  else // third order drying and wetting
708  {
709  const Real pc_tp1 = _pc_tps[_qp].at(1); // pc on first-order wetting at TP_1
710  const Real pc_tp2 = _pc_tps[_qp].at(2); // pc on second-order drying at TP_2
711  const Real sat1 = firstOrderWettingSat(pc);
712  const Real sat2 = secondOrderDryingSat(pc);
713  const Real dsat1 = dfirstOrderWettingSat(pc);
714  const Real dsat2 = dsecondOrderDryingSat(pc);
715  const Real d2sat1 = d2firstOrderWettingSat(pc);
716  const Real d2sat2 = d2secondOrderDryingSat(pc);
717  if (pc_tp1 <= 0.0 || pc <= 0.0 || pc_tp2 <= 0.0)
718  d2sat = d2sat2;
719  else if (pc > pc_tp2)
720  d2sat = d2sat2;
721  else if (pc < pc_tp1)
722  d2sat = d2sat1;
723  else
724  d2sat = d2sat1 - 1.0 / pc / pc * (sat2 - sat1) / std::log(pc_tp2 / pc_tp1) +
725  2.0 / pc * (dsat2 - dsat1) / std::log(pc_tp2 / pc_tp1) +
726  (std::log(pc) - std::log(pc_tp1)) * (d2sat2 - d2sat1) / std::log(pc_tp2 / pc_tp1);
727  }
728  return d2sat;
729 }
const MaterialProperty< unsigned > & _hys_order
Hysteresis order, as computed by PorousFlowHysteresisOrder.
const Real _alpha_d
van Genuchten alpha parameter for the primary drying curve
const Real _n_d
van Genuchten n parameter for the primary drying curve
MaterialProperty< std::array< Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _pc_tps
Nodal or quadpoint values of Pc at the turning points.
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
const PorousFlowVanGenuchten::LowCapillaryPressureExtension _low_ext_d
Parameters involved in the low-saturation extension of the primary drying curve.
Real d2saturationHys(Real pc, Real slmin, Real sgrdel, Real alpha, Real n, const LowCapillaryPressureExtension &low_ext=LowCapillaryPressureExtension(), const HighCapillaryPressureExtension &high_ext=HighCapillaryPressureExtension())
Second derivative of Hysteretic saturation function with respect to pc.
const Real _s_l_min
Minimum liquid saturation for which the van Genuchten expression is valid (Pc(_s_l_min) = infinity) ...

◆ dcapillaryPressureQp()

Real PorousFlowHystereticCapillaryPressure::dcapillaryPressureQp ( Real  sat) const
protectedinherited
Returns
d(capillary pressure)/d(sat). This uses _hys_order[_qp]
Parameters
satliquid saturation

Definition at line 332 of file PorousFlowHystereticCapillaryPressure.C.

Referenced by computeQpInfo(), and PorousFlow2PhaseHysPS::computeQpProperties().

333 {
334  Real dpc = 0.0;
335  if (_hys_order[_qp] == 0) // on primary drying curve
337  sat, _s_l_min, 0.0, _alpha_d, _n_d, _low_ext_d);
338  else if (_hys_order[_qp] == 1) // first-order wetting
339  dpc = dfirstOrderWettingPc(sat);
340  else if (_hys_order[_qp] == 2) // second-order drying
341  dpc = dsecondOrderDryingPc(sat);
342  else // third order drying and wetting
343  {
344  const Real tp1 = _hys_sat_tps[_qp].at(1);
345  const Real tp2 = _hys_sat_tps[_qp].at(2);
346  const Real pc1 = firstOrderWettingPc(sat);
347  const Real pc2 = secondOrderDryingPc(sat);
348  // handle cases that occur just at the transition from 3rd to 2nd order, or 3rd to 1st order
349  if (sat < tp2)
350  dpc = dsecondOrderDryingPc(sat);
351  else if (sat > tp1)
352  dpc = dfirstOrderWettingPc(sat);
353  else if (pc1 >= pc2)
354  dpc = dfirstOrderWettingPc(sat);
355  else if (pc1 <= 0.0 || pc2 <= 0.0)
356  dpc = 0.0;
357  else
358  {
359  const Real pc =
360  std::exp(std::log(pc1) + (sat - tp1) * (std::log(pc2) - std::log(pc1)) / (tp2 - tp1));
361  const Real dpc1 = dfirstOrderWettingPc(sat);
362  const Real dpc2 = dsecondOrderDryingPc(sat);
363  dpc = pc * (dpc1 / pc1 + (std::log(pc2) - std::log(pc1)) / (tp2 - tp1) +
364  (sat - tp1) * (dpc2 / pc2 - dpc1 / pc1) / (tp2 - tp1));
365  }
366  }
367  return dpc;
368 }
Real dcapillaryPressureHys(Real sl, Real slmin, Real sgrdel, Real alpha, Real n, const LowCapillaryPressureExtension &low_ext=LowCapillaryPressureExtension(), const HighCapillaryPressureExtension &high_ext=HighCapillaryPressureExtension())
Derivative of capillaryPressureHys with respect to sl.
const MaterialProperty< unsigned > & _hys_order
Hysteresis order, as computed by PorousFlowHysteresisOrder.
const Real _alpha_d
van Genuchten alpha parameter for the primary drying curve
const Real _n_d
van Genuchten n parameter for the primary drying curve
const MaterialProperty< std::array< Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _hys_sat_tps
Saturation values at the turning points, as computed by PorousFlowHysteresisOrder.
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
const PorousFlowVanGenuchten::LowCapillaryPressureExtension _low_ext_d
Parameters involved in the low-saturation extension of the primary drying curve.
const Real _s_l_min
Minimum liquid saturation for which the van Genuchten expression is valid (Pc(_s_l_min) = infinity) ...

◆ dliquidSaturationQp()

Real PorousFlowHystereticCapillaryPressure::dliquidSaturationQp ( Real  pc) const
protectedinherited
Returns
d(liquid saturation)/d(pc). This uses _hys_order[_qp]
Parameters
pccapillary pressure

Definition at line 667 of file PorousFlowHystereticCapillaryPressure.C.

Referenced by computeQpInfo(), PorousFlow1PhaseHysP::computeQpProperties(), and PorousFlow2PhaseHysPP::computeQpProperties().

668 {
669  Real dsat = 0.0;
670  if (_hys_order[_qp] == 0) // on primary drying curve
672  else if (_hys_order[_qp] == 1) // first-order wetting
673  dsat = dfirstOrderWettingSat(pc);
674  else if (_hys_order[_qp] == 2) // second-order drying
675  dsat = dsecondOrderDryingSat(pc);
676  else // third order drying and wetting
677  {
678  const Real pc_tp1 = _pc_tps[_qp].at(1); // pc on first-order wetting at TP_1
679  const Real pc_tp2 = _pc_tps[_qp].at(2); // pc on second-order drying at TP_2
680  const Real sat1 = firstOrderWettingSat(pc);
681  const Real sat2 = secondOrderDryingSat(pc);
682  const Real dsat1 = dfirstOrderWettingSat(pc);
683  const Real dsat2 = dsecondOrderDryingSat(pc);
684  if (pc_tp1 <= 0.0 || pc <= 0.0 || pc_tp2 <= 0.0)
685  dsat = dsat2;
686  else if (pc > pc_tp2)
687  dsat = dsat2;
688  else if (pc < pc_tp1)
689  dsat = dsat1;
690  else
691  dsat = dsat1 + 1.0 / pc * (sat2 - sat1) / std::log(pc_tp2 / pc_tp1) +
692  (std::log(pc) - std::log(pc_tp1)) * (dsat2 - dsat1) / std::log(pc_tp2 / pc_tp1);
693  }
694  return dsat;
695 }
const MaterialProperty< unsigned > & _hys_order
Hysteresis order, as computed by PorousFlowHysteresisOrder.
const Real _alpha_d
van Genuchten alpha parameter for the primary drying curve
const Real _n_d
van Genuchten n parameter for the primary drying curve
MaterialProperty< std::array< Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _pc_tps
Nodal or quadpoint values of Pc at the turning points.
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
const PorousFlowVanGenuchten::LowCapillaryPressureExtension _low_ext_d
Parameters involved in the low-saturation extension of the primary drying curve.
Real dsaturationHys(Real pc, Real slmin, Real sgrdel, Real alpha, Real n, const LowCapillaryPressureExtension &low_ext=LowCapillaryPressureExtension(), const HighCapillaryPressureExtension &high_ext=HighCapillaryPressureExtension())
Derivative of Hysteretic saturation function with respect to pc.
const Real _s_l_min
Minimum liquid saturation for which the van Genuchten expression is valid (Pc(_s_l_min) = infinity) ...

◆ initQpStatefulProperties()

void PorousFlowHystereticInfo::initQpStatefulProperties ( )
overrideprotectedvirtual

Reimplemented from PorousFlowHystereticCapillaryPressure.

Definition at line 76 of file PorousFlowHystereticInfo.C.

77 {
79  _saturation[_qp][0] = _sat_val[_qp];
80  _pc[_qp] = capillaryPressureQp(_sat_val[_qp]);
81  computeQpInfo();
82 }
const VariableValue & _sat_val
Nodal or quadpoint value of liquid saturation.
MaterialProperty< Real > & _pc
Computed nodal or quadpoint value of capillary pressure (needed for hysteretic order computation) ...
void computeQpInfo()
Fill _info with the required information.
GenericMaterialProperty< std::vector< Real >, is_ad > & _saturation
Computed nodal or qp saturation of the phases.

◆ landSat()

Real PorousFlowHystereticCapillaryPressure::landSat ( Real  slDel) const
protectedinherited
Returns
the value of gas saturation (called S_gr^Delta in the markdown documentation) using the Land expression. (This is a function of the liquid saturation at the turning point)
Parameters
slDelthe value of the liquid saturation at the turning point

Definition at line 233 of file PorousFlowHystereticCapillaryPressure.C.

Referenced by PorousFlowHystereticCapillaryPressure::computeTurningPointInfo().

234 {
235  const Real a = 1.0 / _s_gr_max - 1.0 / (1.0 - _s_lr);
236  return (1.0 - slDel) / (1.0 + a * (1.0 - slDel));
237 }
const Real _s_gr_max
Residual gas saturation: 1 - _s_gr_max is the maximum saturation for which the van Genuchten expressi...
const Real _s_lr
Liquid saturation below which the liquid relative permeability is zero.
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real

◆ liquidSaturationQp()

Real PorousFlowHystereticCapillaryPressure::liquidSaturationQp ( Real  pc) const
protectedinherited
Returns
the value of liquid saturation, given the capillary pressure. This uses _hys_order[_qp]
Parameters
pccapillary pressure

Definition at line 630 of file PorousFlowHystereticCapillaryPressure.C.

Referenced by PorousFlow1PhaseHysP::buildQpPPSS(), PorousFlow2PhaseHysPP::buildQpPPSS(), and computeQpInfo().

631 {
632  Real sat = 0.0;
633  if (_hys_order[_qp] == 0) // on primary drying curve
635  else if (_hys_order[_qp] == 1) // first-order wetting
636  sat = firstOrderWettingSat(pc);
637  else if (_hys_order[_qp] == 2) // second-order drying
638  sat = secondOrderDryingSat(pc);
639  else // third order drying and wetting
640  {
641  // NOTE: this is not the exact inverse of the third-order capillary-pressure formula, but only
642  // the approximate inverse. In any simulation, only liquidSaturationQp or capillaryPressureQp
643  // are used (not both) so having a slightly different formulation for these two functions is OK
644  // Rationale: when pc is close to pc_tp1 then use the first-order wetting curve; when pc is
645  // close to pc_tp2 then use the second-order drying curve
646  const Real pc_tp1 = _pc_tps[_qp].at(1); // pc on first-order wetting at TP_1
647  const Real pc_tp2 = _pc_tps[_qp].at(2); // pc on second-order drying at TP_2
648  const Real sat1 = firstOrderWettingSat(pc);
649  const Real sat2 = secondOrderDryingSat(pc);
650  // handle cases that occur just at the transition from 3rd to 2nd order, or 3rd to 1st order
651  if (pc_tp1 <= 0.0 || pc <= 0.0 ||
652  pc_tp2 <= 0.0) // only the first condition is strictly necessary as cannot get pc==0 or
653  // pc_tp2=0 without pc_tp1=0 in reality. The other conditions are added in
654  // case of numerical strangenesses
655  sat = sat2;
656  else if (pc > pc_tp2)
657  sat = sat2;
658  else if (pc < pc_tp1)
659  sat = sat1;
660  else
661  sat = sat1 + (std::log(pc) - std::log(pc_tp1)) * (sat2 - sat1) / std::log(pc_tp2 / pc_tp1);
662  }
663  return sat;
664 }
const MaterialProperty< unsigned > & _hys_order
Hysteresis order, as computed by PorousFlowHysteresisOrder.
const Real _alpha_d
van Genuchten alpha parameter for the primary drying curve
const Real _n_d
van Genuchten n parameter for the primary drying curve
MaterialProperty< std::array< Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER > > & _pc_tps
Nodal or quadpoint values of Pc at the turning points.
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
const PorousFlowVanGenuchten::LowCapillaryPressureExtension _low_ext_d
Parameters involved in the low-saturation extension of the primary drying curve.
const Real _s_l_min
Minimum liquid saturation for which the van Genuchten expression is valid (Pc(_s_l_min) = infinity) ...
Real saturationHys(Real pc, Real slmin, Real sgrdel, Real alpha, Real n, const LowCapillaryPressureExtension &low_ext=LowCapillaryPressureExtension(), const HighCapillaryPressureExtension &high_ext=HighCapillaryPressureExtension())
Hysteretic saturation function (Eqn(1) of Doughty2007) with extensions (page5 and Fig1 of Doughty2008...

◆ relativeError()

Real PorousFlowHystereticInfo::relativeError ( Real  finite_difference,
Real  hand_coded 
)
private

Computes the relative error between a finite-difference approximation to the derivative and a hand-coded version.

Returns
finite_difference / hand_coded - 1, with appropriate guards against division by zero
Parameters
finite_differencethe finite-difference approximation to the derivative
hand_codedthe hand-coded derivative

Definition at line 148 of file PorousFlowHystereticInfo.C.

Referenced by computeQpInfo().

149 {
150  if (finite_difference == 0.0 && hand_coded == 0.0)
151  return 0.0;
152  else if (finite_difference > 0.0 && hand_coded == 0.0)
153  return std::numeric_limits<Real>::max();
154  else if (finite_difference < 0.0 && hand_coded == 0.0)
155  return std::numeric_limits<Real>::min();
156  return finite_difference / hand_coded - 1.0;
157 }

◆ validParams()

InputParameters PorousFlowHystereticInfo::validParams ( )
static

Definition at line 15 of file PorousFlowHystereticInfo.C.

16 {
18  params.addCoupledVar("pc_var",
19  0,
20  "Variable that represents capillary pressure. Depending on info_required, "
21  "this may not be used to compute the info");
22  params.addRequiredCoupledVar(
23  "sat_var",
24  "Variable that represent liquid saturation. This is always needed to "
25  "ensure the hysteretic order is computed correctly");
26  MooseEnum property_enum("pc sat sat_given_pc dS_dPc_err dPc_dS_err d2S_dPc2_err d2Pc_dS2_err",
27  "pc");
28  params.addParam<MooseEnum>(
29  "info_required",
30  property_enum,
31  "The type of information required. pc: capillary pressure given the saturation (pc_var is "
32  "not used in this case). sat: given the liquid saturation, compute the capillary pressure, "
33  "then invert the relationship to yield liquid saturation again (pc_var is not used in this "
34  "case). This is useful to understand the non-invertibility of the hysteretic relationships. "
35  " sat_given_pc: given the capillary pressure, compute the saturation. dS_dPc_err: relative "
36  "error in d(sat)/d(pc) calculation, ie (S(Pc + fd_eps) - S(Pc - fd_eps))/(2 * eps * S'(Pc)) "
37  "- 1, where S' is the coded derivative (Pc is computed from sat in this case: pc_var is not "
38  "used). This is useful for checking derivatives. dPc_dS_err: relative error in "
39  "d(pc)/d(sat) calculation, ie (Pc(S + fd_eps) - Pc(S - fd_eps)) / (2 * eps * Pc'(S)) - 1, "
40  "where Pc' is the coded derative (pc_var is not used in this case). d2S_dPc2_err: relative "
41  "error in d^2(sat)/d(pc)^2 (Pc is computed from sat in this case: pc_var is not used). "
42  "d2Pc_dS2_err: relative error in d^2(pc)/d(sat)^2.");
43  params.addParam<Real>(
44  "fd_eps",
45  1E-8,
46  "Small quantity used in computing the finite-difference approximations to derivatives");
47  params.addClassDescription(
48  "This Material computes capillary pressure or saturation, etc. It is primarily "
49  "of use when users desire to compute hysteretic quantities such as capillary pressure for "
50  "visualisation purposes. The "
51  "result is written into PorousFlow_hysteretic_info_nodal or "
52  "PorousFlow_hysteretic_info_qp (depending on the at_nodes flag). It "
53  "does not "
54  "compute porepressure and should not be used in simulations that employ "
55  "PorousFlow*PhaseHys* "
56  "Materials.");
57  return params;
58 }
void addParam(const std::string &name, const std::initializer_list< typename T::value_type > &value, const std::string &doc_string)
void addCoupledVar(const std::string &name, const std::string &doc_string)
void addRequiredCoupledVar(const std::string &name, const std::string &doc_string)
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
void addClassDescription(const std::string &doc_string)

Member Data Documentation

◆ _alpha_d

const Real PorousFlowHystereticCapillaryPressure::_alpha_d
protectedinherited

◆ _alpha_w

const Real PorousFlowHystereticCapillaryPressure::_alpha_w
protectedinherited

◆ _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.

◆ _dpc_high

const Real PorousFlowHystereticCapillaryPressure::_dpc_high
protectedinherited

d(Pc)/d(S) at the point of high-saturation extension

Definition at line 124 of file PorousFlowHystereticCapillaryPressure.h.

◆ _dpc_low_d

const Real PorousFlowHystereticCapillaryPressure::_dpc_low_d
protectedinherited

d(Pc)/dS on the primary drying curve at S = _s_low_d

Definition at line 108 of file PorousFlowHystereticCapillaryPressure.h.

◆ _dpc_low_w

const Real PorousFlowHystereticCapillaryPressure::_dpc_low_w
protectedinherited

d(Pc)/dS on the primary wetting curve at S = _s_low_w

Definition at line 114 of file PorousFlowHystereticCapillaryPressure.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.

◆ _fd_eps

const Real PorousFlowHystereticInfo::_fd_eps
protected

small parameter to use in the finite-difference approximations to the derivative

Definition at line 45 of file PorousFlowHystereticInfo.h.

Referenced by computeQpInfo().

◆ _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.

◆ _high_ext

const PorousFlowVanGenuchten::HighCapillaryPressureExtension PorousFlowHystereticCapillaryPressure::_high_ext
protectedinherited

Parameters involved in the high-saturation extension of the primary wetting curve.

Definition at line 126 of file PorousFlowHystereticCapillaryPressure.h.

◆ _high_ext_type

const PorousFlowVanGenuchten::HighCapillaryPressureExtension::ExtensionStrategy PorousFlowHystereticCapillaryPressure::_high_ext_type
protectedinherited

Type of high-saturation extension of the wetting curves.

Definition at line 118 of file PorousFlowHystereticCapillaryPressure.h.

Referenced by PorousFlowHystereticCapillaryPressure::computeTurningPointInfo().

◆ _high_ratio

const Real PorousFlowHystereticCapillaryPressure::_high_ratio
protectedinherited

The high-saturation extension to the wetting will commence at _high_ratio * (1 - _s_gr_del)

Definition at line 102 of file PorousFlowHystereticCapillaryPressure.h.

Referenced by PorousFlowHystereticCapillaryPressure::computeTurningPointInfo().

◆ _hys_order

const MaterialProperty<unsigned>& PorousFlowHystereticCapillaryPressure::_hys_order
protectedinherited

◆ _hys_order_old

const MaterialProperty<unsigned>& PorousFlowHystereticCapillaryPressure::_hys_order_old
protectedinherited

Old value of hysteresis order, as computed by PorousFlowHysteresisOrder.

Definition at line 132 of file PorousFlowHystereticCapillaryPressure.h.

Referenced by PorousFlowHystereticCapillaryPressure::computeQpProperties().

◆ _hys_sat_tps

const MaterialProperty<std::array<Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER> >& PorousFlowHystereticCapillaryPressure::_hys_sat_tps
protectedinherited

◆ _info

MaterialProperty<Real>& PorousFlowHystereticInfo::_info
protected

Computed nodal or quadpoint value: the meaning of this depends on info_enum.

Definition at line 36 of file PorousFlowHystereticInfo.h.

Referenced by computeQpInfo().

◆ _info_enum

enum PorousFlowHystereticInfo::InfoTypeEnum PorousFlowHystereticInfo::_info_enum
protected

Referenced by computeQpInfo().

◆ _low_ext_d

const PorousFlowVanGenuchten::LowCapillaryPressureExtension PorousFlowHystereticCapillaryPressure::_low_ext_d
protectedinherited

◆ _low_ext_type

const PorousFlowVanGenuchten::LowCapillaryPressureExtension::ExtensionStrategy PorousFlowHystereticCapillaryPressure::_low_ext_type
protectedinherited

Type of low-saturation extension.

Definition at line 104 of file PorousFlowHystereticCapillaryPressure.h.

Referenced by PorousFlowHystereticCapillaryPressure::computeTurningPointInfo().

◆ _low_ext_w

const PorousFlowVanGenuchten::LowCapillaryPressureExtension PorousFlowHystereticCapillaryPressure::_low_ext_w
protectedinherited

Parameters involved in the low-saturation extension of the primary wetting curve.

Definition at line 116 of file PorousFlowHystereticCapillaryPressure.h.

◆ _n_d

const Real PorousFlowHystereticCapillaryPressure::_n_d
protectedinherited

◆ _n_w

const Real PorousFlowHystereticCapillaryPressure::_n_w
protectedinherited

◆ _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

MaterialProperty<Real>& PorousFlowHystereticInfo::_pc
protected

Computed nodal or quadpoint value of capillary pressure (needed for hysteretic order computation)

Definition at line 33 of file PorousFlowHystereticInfo.h.

Referenced by computeQpProperties(), and initQpStatefulProperties().

◆ _pc_high

const Real PorousFlowHystereticCapillaryPressure::_pc_high
protectedinherited

Pc at the point of high-saturation extension.

Definition at line 122 of file PorousFlowHystereticCapillaryPressure.h.

◆ _pc_max

const Real PorousFlowHystereticCapillaryPressure::_pc_max
protectedinherited

Maximum capillary pressure: for Pc above this value, a "lower" extension will be used.

Definition at line 100 of file PorousFlowHystereticCapillaryPressure.h.

Referenced by PorousFlowHystereticCapillaryPressure::computeTurningPointInfo().

◆ _pc_older

const MaterialProperty<Real>& PorousFlowHystereticCapillaryPressure::_pc_older
protectedinherited

Older value of capillary pressure.

Definition at line 139 of file PorousFlowHystereticCapillaryPressure.h.

Referenced by PorousFlowHystereticCapillaryPressure::computeQpProperties().

◆ _pc_tps

MaterialProperty<std::array<Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER> >& PorousFlowHystereticCapillaryPressure::_pc_tps
protectedinherited

◆ _pc_val

const VariableValue& PorousFlowHystereticInfo::_pc_val
protected

Nodal or quadpoint value of capillary pressure.

Definition at line 39 of file PorousFlowHystereticInfo.h.

Referenced by computeQpInfo().

◆ _porepressure

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

◆ _s_d_tps

MaterialProperty<std::array<Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER> >& PorousFlowHystereticCapillaryPressure::_s_d_tps
protectedinherited

◆ _s_gr_max

const Real PorousFlowHystereticCapillaryPressure::_s_gr_max
protectedinherited

Residual gas saturation: 1 - _s_gr_max is the maximum saturation for which the van Genuchten expression is valid for the wetting curve.

Definition at line 98 of file PorousFlowHystereticCapillaryPressure.h.

Referenced by PorousFlowHystereticCapillaryPressure::landSat(), and PorousFlowHystereticCapillaryPressure::PorousFlowHystereticCapillaryPressure().

◆ _s_gr_tps

MaterialProperty<std::array<Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER> >& PorousFlowHystereticCapillaryPressure::_s_gr_tps
protectedinherited

◆ _s_high

const Real PorousFlowHystereticCapillaryPressure::_s_high
protectedinherited

Saturation at the point of high-saturation extension.

Definition at line 120 of file PorousFlowHystereticCapillaryPressure.h.

Referenced by PorousFlowHystereticCapillaryPressure::PorousFlowHystereticCapillaryPressure().

◆ _s_l_min

const Real PorousFlowHystereticCapillaryPressure::_s_l_min
protectedinherited

Minimum liquid saturation for which the van Genuchten expression is valid (Pc(_s_l_min) = infinity)

Definition at line 94 of file PorousFlowHystereticCapillaryPressure.h.

Referenced by PorousFlowHystereticCapillaryPressure::capillaryPressureQp(), PorousFlowHystereticCapillaryPressure::computeTurningPointInfo(), PorousFlowHystereticCapillaryPressure::d2capillaryPressureQp(), PorousFlowHystereticCapillaryPressure::d2firstOrderWettingPc(), PorousFlowHystereticCapillaryPressure::d2firstOrderWettingSat(), PorousFlowHystereticCapillaryPressure::d2liquidSaturationQp(), PorousFlowHystereticCapillaryPressure::d2secondOrderDryingPc(), PorousFlowHystereticCapillaryPressure::d2secondOrderDryingSat(), PorousFlowHystereticCapillaryPressure::dcapillaryPressureQp(), PorousFlowHystereticCapillaryPressure::dfirstOrderWettingPc(), PorousFlowHystereticCapillaryPressure::dfirstOrderWettingSat(), PorousFlowHystereticCapillaryPressure::dliquidSaturationQp(), PorousFlowHystereticCapillaryPressure::dsecondOrderDryingPc(), PorousFlowHystereticCapillaryPressure::dsecondOrderDryingSat(), PorousFlowHystereticCapillaryPressure::firstOrderWettingPc(), PorousFlowHystereticCapillaryPressure::firstOrderWettingSat(), PorousFlowHystereticCapillaryPressure::initQpStatefulProperties(), PorousFlowHystereticCapillaryPressure::liquidSaturationQp(), PorousFlowHystereticCapillaryPressure::PorousFlowHystereticCapillaryPressure(), PorousFlowHystereticCapillaryPressure::secondOrderDryingPc(), and PorousFlowHystereticCapillaryPressure::secondOrderDryingSat().

◆ _s_low_d

const Real PorousFlowHystereticCapillaryPressure::_s_low_d
protectedinherited

Saturation on the primary drying curve where low-saturation extension commences.

Definition at line 106 of file PorousFlowHystereticCapillaryPressure.h.

◆ _s_low_w

const Real PorousFlowHystereticCapillaryPressure::_s_low_w
protectedinherited

Saturation on the primary wetting curve where low-saturation extension commences.

Definition at line 112 of file PorousFlowHystereticCapillaryPressure.h.

Referenced by PorousFlowHystereticCapillaryPressure::PorousFlowHystereticCapillaryPressure().

◆ _s_lr

const Real PorousFlowHystereticCapillaryPressure::_s_lr
protectedinherited

Liquid saturation below which the liquid relative permeability is zero.

Definition at line 96 of file PorousFlowHystereticCapillaryPressure.h.

Referenced by PorousFlowHystereticCapillaryPressure::landSat(), and PorousFlowHystereticCapillaryPressure::PorousFlowHystereticCapillaryPressure().

◆ _s_w_tps

MaterialProperty<std::array<Real, PorousFlowConstants::MAX_HYSTERESIS_ORDER> >& PorousFlowHystereticCapillaryPressure::_s_w_tps
protectedinherited

◆ _sat_val

const VariableValue& PorousFlowHystereticInfo::_sat_val
protected

Nodal or quadpoint value of liquid saturation.

Definition at line 42 of file PorousFlowHystereticInfo.h.

Referenced by computeQpInfo(), computeQpProperties(), and initQpStatefulProperties().

◆ _saturation

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

◆ _w_high_ext_tps

MaterialProperty<std::array<PorousFlowVanGenuchten::HighCapillaryPressureExtension, PorousFlowConstants::MAX_HYSTERESIS_ORDER> >& PorousFlowHystereticCapillaryPressure::_w_high_ext_tps
protectedinherited

◆ _w_low_ext_tps

MaterialProperty<std::array<PorousFlowVanGenuchten::LowCapillaryPressureExtension, PorousFlowConstants::MAX_HYSTERESIS_ORDER> >& PorousFlowHystereticCapillaryPressure::_w_low_ext_tps
protectedinherited

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