https://mooseframework.inl.gov
Namespaces | Enumerations | Functions | Variables
NS Namespace Reference

Namespaces

 FV
 
 phase
 
 settings
 
 splitting
 

Enumerations

enum  WallTreatmentEnum { WallTreatmentEnum::EQ_NEWTON = 0, WallTreatmentEnum::EQ_INCREMENTAL = 1, WallTreatmentEnum::EQ_LINEARIZED = 2, WallTreatmentEnum::NEQ = 3 }
 Wall treatment options. More...
 
enum  ViscousForm : int { ViscousForm::Traction, ViscousForm::Laplace }
 

Functions

int delta (unsigned int i, unsigned int j)
 Delta function, which returns zero if $i j$ and unity if $i=j$. More...
 
int computeSign (const Real &a)
 Sign function, returns $+1$ if $a$ is positive and $-1$ if $a$ is negative. More...
 
unsigned int getIndex (const Real &p, const std::vector< Real > &bounds)
 Determines the index $i$ in a sorted array such that the input point is within the $i$-th and $i+1$-th entries in the array. More...
 
Real reynoldsPropertyDerivative (const Real &Re, const Real &rho, const Real &mu, const Real &drho, const Real &dmu)
 Computes the derivative of the Reynolds number, $Re { Vd}{}$, with respect to an arbitrary variable $$, where it is assumed that only the material properties of density $$ and dynamic viscosity $$ have nonzero derivatives with respect to $$. More...
 
Real prandtlPropertyDerivative (const Real &mu, const Real &cp, const Real &k, const Real &dmu, const Real &dcp, const Real &dk)
 Computes the derivative of the Prandtl number, $Pr{ C_p}{k}$, with respect to an arbitrary variale $$. More...
 
template<typename T >
findUStar (const T &mu, const T &rho, const T &u, Real dist)
 Finds the friction velocity using standard velocity wall functions formulation. More...
 
template<typename T >
findyPlus (const T &mu, const T &rho, const T &u, Real dist)
 Finds the non-dimensional wall distance normalized with the friction velocity Implements a fixed-point iteration in the wall function to get this velocity. More...
 
template<typename T >
computeSpeed (const libMesh::VectorValue< T > &velocity)
 Compute the speed (velocity norm) given the supplied velocity. More...
 
template<typename T >
computeShearStrainRateNormSquared (const Moose::Functor< T > &u, const Moose::Functor< T > *v, const Moose::Functor< T > *w, const Moose::ElemArg &elem_arg, const Moose::StateArg &state)
 Utility function to compute the shear strain rate. More...
 
void getWallBoundedElements (const std::vector< BoundaryName > &wall_boundary_name, const FEProblemBase &fe_problem, const SubProblem &subproblem, const std::set< SubdomainID > &block_ids, std::unordered_set< const Elem *> &wall_bounded)
 Map marking wall bounded elements The map passed in wall_bounded_map gets cleared and re-populated. More...
 
void getWallDistance (const std::vector< BoundaryName > &wall_boundary_name, const FEProblemBase &fe_problem, const SubProblem &subproblem, const std::set< SubdomainID > &block_ids, std::map< const Elem *, std::vector< Real >> &dist_map)
 Map storing wall ditance for near-wall marked elements The map passed in dist_map gets cleared and re-populated. More...
 
void getElementFaceArgs (const std::vector< BoundaryName > &wall_boundary_name, const FEProblemBase &fe_problem, const SubProblem &subproblem, const std::set< SubdomainID > &block_ids, std::map< const Elem *, std::vector< const FaceInfo *>> &face_info_map)
 Map storing face arguments to wall bounded faces The map passed in face_info_map gets cleared and re-populated. More...
 
template<typename T , typename VectorType , typename PointType >
divergence (const TensorValue< T > &gradient, const VectorType &value, const PointType &point, const Moose::CoordinateSystemType &coord_sys, const unsigned int rz_radial_coord)
 Compute the divergence of a vector given its matrix of derivatives. More...
 
template<typename T1 , typename T2 , typename T3 >
auto wallHeatTransferCoefficient (const T1 &Nu, const T2 &k, const T3 &D_h)
 Compute wall heat transfer coefficient. More...
 
template Real findUStar< Real > (const Real &mu, const Real &rho, const Real &u, const Real dist)
 
template ADReal findUStar< ADReal > (const ADReal &mu, const ADReal &rho, const ADReal &u, const Real dist)
 
template Real findyPlus< Real > (const Real &mu, const Real &rho, const Real &u, Real dist)
 
template ADReal findyPlus< ADReal > (const ADReal &mu, const ADReal &rho, const ADReal &u, Real dist)
 
template Real computeSpeed< Real > (const libMesh::VectorValue< Real > &velocity)
 
template ADReal computeSpeed< ADReal > (const libMesh::VectorValue< ADReal > &velocity)
 
template Real computeShearStrainRateNormSquared< Real > (const Moose::Functor< Real > &u, const Moose::Functor< Real > *v, const Moose::Functor< Real > *w, const Moose::ElemArg &elem_arg, const Moose::StateArg &state)
 
template ADReal computeShearStrainRateNormSquared< ADReal > (const Moose::Functor< ADReal > &u, const Moose::Functor< ADReal > *v, const Moose::Functor< ADReal > *w, const Moose::ElemArg &elem_arg, const Moose::StateArg &state)
 
std::string grad (const std::string &var)
 
std::string time_deriv (const std::string &var)
 
template<class T >
std::tuple< bool, T, T > isPorosityJumpFace (const Moose::FunctorBase< T > &porosity, const FaceInfo &fi, const Moose::StateArg &time)
 Checks to see whether the porosity value jumps from one side to the other of the provided face. More...
 
template std::tuple< bool, Real, RealisPorosityJumpFace< Real > (const Moose::FunctorBase< Real > &porosity, const FaceInfo &fi, const Moose::StateArg &time)
 
template std::tuple< bool, ADReal, ADRealisPorosityJumpFace< ADReal > (const Moose::FunctorBase< ADReal > &porosity, const FaceInfo &fi, const Moose::StateArg &time)
 

Variables

static const std::string directions [3] = {"x", "y", "z"}
 
static const std::string pebble_diameter = "pebble_diameter"
 
static const std::string infinite_porosity = "infinite_porosity"
 
static const std::string axis = "axis"
 
static const std::string center = "center"
 
static const std::string wall_porosity = "wall_porosity"
 
static const std::string wall_distance = "wall_distance"
 
static const std::string density = "rho"
 
static const std::string superficial_density = "superficial_rho"
 
static const std::string momentum_x = "rhou"
 
static const std::string momentum_y = "rhov"
 
static const std::string momentum_z = "rhow"
 
static const std::string momentum_vector [3] = {momentum_x, momentum_y, momentum_z}
 
static const std::string superficial_momentum_x = "superficial_rhou"
 
static const std::string superficial_momentum_y = "superficial_rhov"
 
static const std::string superficial_momentum_z = "superficial_rhow"
 
static const std::string superficial_momentum_vector [3]
 
static const std::string velocity = "velocity"
 
static const std::string velocity_x = "vel_x"
 
static const std::string velocity_y = "vel_y"
 
static const std::string velocity_z = "vel_z"
 
const std::string velocity_vector [3] = {velocity_x, velocity_y, velocity_z}
 
static const std::string superficial_velocity_x = "superficial_vel_x"
 
static const std::string superficial_velocity_y = "superficial_vel_y"
 
static const std::string superficial_velocity_z = "superficial_vel_z"
 
static const std::string superficial_velocity = "superficial_velocity"
 
static const std::string superficial_velocity_vector [3]
 
static const std::string pressure = "pressure"
 
static const std::string total_pressure = "pressure_total"
 
static const std::string temperature = "temperature"
 
static const std::string internal_energy = "internal_energy"
 
static const std::string specific_internal_energy = "e"
 
static const std::string specific_total_energy = "et"
 
static const std::string internal_energy_density = "rho_e"
 
static const std::string total_energy_density = "rho_et"
 
static const std::string superficial_total_energy_density = "superficial_rho_et"
 
static const std::string specific_enthalpy = "h"
 
static const std::string specific_total_enthalpy = "ht"
 
static const std::string enthalpy_density = "rho_h"
 
static const std::string total_enthalpy_density = "rho_ht"
 
static const std::string superficial_total_enthalpy_density = "superficial_rho_ht"
 
static const std::string mixing_length = "mixing_length"
 
static const std::string wall_shear_stress = "wall_shear_stress"
 
static const std::string wall_yplus = "wall_yplus"
 
static const std::string eddy_viscosity = "eddy_viscosity"
 
static const std::string total_viscosity = "total_viscosity"
 
static const std::string mach_number = "Mach"
 
static const std::string specific_volume = "specific_volume"
 
static const std::string momentum = "momentum"
 
static const std::string v = "v"
 
static const std::string acceleration = "acceleration"
 
static const std::string fluid = "fp"
 
static const std::string porosity = "porosity"
 
static const std::string smoothed_porosity = "smoothed_porosity"
 
static const std::string T_fluid = "T_fluid"
 
static const std::string T_solid = "T_solid"
 
static const std::string heat_source = "heat_source"
 
static const std::string cL = "Darcy_coefficient"
 
static const std::string cQ = "Forchheimer_coefficient"
 
static const std::string alpha_boussinesq = "alpha_b"
 
static const std::string drhos_dTs = "drhos_dTs"
 
static const std::string dks_dTs = "dks_dTs"
 
static const std::string kappa = "kappa"
 
static const std::string kappa_s = "kappa_s"
 
static const std::string rho_s = "rho_s"
 
static const std::string cp_s = "cp_s"
 
static const std::string k_s = "k_s"
 
static const std::string cp = "cp"
 
static const std::string cv = "cv"
 
static const std::string mu = "mu"
 
static const std::string mu_t = "mu_t"
 
static const std::string mu_t_passive_scalar = "mu_t_passive_scalar"
 
static const std::string mu_eff = "mu_eff"
 
static const std::string k = "k"
 
static const std::string k_t = "k_t"
 
static const std::string thermal_diffusivity = "thermal_diffusivity"
 
static const std::string alpha = "alpha"
 
static const std::string alpha_wall = "alpha_wall"
 
static const std::string solid = "solid"
 
static const std::string Prandtl = "Pr"
 
static const std::string turbulent_Prandtl = "Pr_t"
 
static const std::string Reynolds = "Re"
 
static const std::string Reynolds_hydraulic = "Re_h"
 
static const std::string Reynolds_interstitial = "Re_i"
 
static const std::string c = "c"
 
static const std::string speed = "speed"
 
static const std::string sound_speed = "sound_speed"
 
static const std::string latent_heat = "latent_heat"
 
static const std::string T_liquidus = "T_liquidus"
 
static const std::string T_solidus = "T_solidus"
 
static const std::string alpha_exchange = "alpha_exchange"
 
static const std::string component = "component"
 
static const std::string source_scaling = "source_scaling"
 
static const std::string matrix_tau = "matrix_tau"
 
static const std::string vector_tau = "vector_tau"
 
static const std::string scalar_tau = "scalar_tau"
 
static const std::string diagonal_tau = "diagonal_tau"
 
static const std::string A = "A"
 
static const std::string R = "R"
 
static const std::string S = "S"
 
static const std::string dS_dTs = "dS_dTs"
 
static const std::string F = "F"
 
static const std::string G = "G"
 
static const std::string dUdt = "dUdt"
 
static const std::string C = "C"
 
static const std::string Z = "Z"
 
static const std::string K = "K"
 
static const std::string mass_flux = "mass_flux"
 
static const std::string TKE = "tke"
 
static const std::string TKED = "epsilon"
 
static constexpr Real von_karman_constant = 0.4187
 
static constexpr Real E_turb_constant = 9.793
 
static constexpr Real mu_t_low_limit = 1.0e-8
 
static constexpr Real epsilon_low_limit = 1.0e-8
 
static constexpr Real min_y_plus = 1e-10
 

Enumeration Type Documentation

◆ ViscousForm

enum NS::ViscousForm : int
strong
Enumerator
Traction 
Laplace 

Definition at line 20 of file NSEnums.h.

20  : int
21 {
22  Traction,
23  Laplace
24 };
auto Laplace(const T1 &surf_tension, const T2 &delta_rho, const Real &gravity_magnitude)
Compute Laplace number (or coefficient)
Definition: Numerics.h:200

◆ WallTreatmentEnum

enum NS::WallTreatmentEnum
strong

Wall treatment options.

Enumerator
EQ_NEWTON 
EQ_INCREMENTAL 
EQ_LINEARIZED 
NEQ 

Definition at line 182 of file NS.h.

Function Documentation

◆ computeShearStrainRateNormSquared()

template<typename T >
T NS::computeShearStrainRateNormSquared ( const Moose::Functor< T > &  u,
const Moose::Functor< T > *  v,
const Moose::Functor< T > *  w,
const Moose::ElemArg elem_arg,
const Moose::StateArg state 
)

Utility function to compute the shear strain rate.

Definition at line 168 of file NavierStokesMethods.C.

173 {
174  const auto & grad_u = u.gradient(elem_arg, state);
175  const T Sij_xx = 2.0 * grad_u(0);
176  T Sij_xy = 0.0;
177  T Sij_xz = 0.0;
178  T Sij_yy = 0.0;
179  T Sij_yz = 0.0;
180  T Sij_zz = 0.0;
181 
182  const T grad_xx = grad_u(0);
183  T grad_xy = 0.0;
184  T grad_xz = 0.0;
185  T grad_yx = 0.0;
186  T grad_yy = 0.0;
187  T grad_yz = 0.0;
188  T grad_zx = 0.0;
189  T grad_zy = 0.0;
190  T grad_zz = 0.0;
191 
192  T trace = Sij_xx / 3.0;
193 
194  if (v) // dim >= 2
195  {
196  const auto & grad_v = (*v).gradient(elem_arg, state);
197  Sij_xy = grad_u(1) + grad_v(0);
198  Sij_yy = 2.0 * grad_v(1);
199 
200  grad_xy = grad_u(1);
201  grad_yx = grad_v(0);
202  grad_yy = grad_v(1);
203 
204  trace += Sij_yy / 3.0;
205 
206  if (w) // dim >= 3
207  {
208  const auto & grad_w = (*w).gradient(elem_arg, state);
209 
210  Sij_xz = grad_u(2) + grad_w(0);
211  Sij_yz = grad_v(2) + grad_w(1);
212  Sij_zz = 2.0 * grad_w(2);
213 
214  grad_xz = grad_u(2);
215  grad_yz = grad_v(2);
216  grad_zx = grad_w(0);
217  grad_zy = grad_w(1);
218  grad_zz = grad_w(2);
219 
220  trace += Sij_zz / 3.0;
221  }
222  }
223 
224  return (Sij_xx - trace) * grad_xx + Sij_xy * grad_xy + Sij_xz * grad_xz + Sij_xy * grad_yx +
225  (Sij_yy - trace) * grad_yy + Sij_yz * grad_yz + Sij_xz * grad_zx + Sij_yz * grad_zy +
226  (Sij_zz - trace) * grad_zz;
227 }
static const std::string v
Definition: NS.h:84
GradientType gradient(const ElemArg &elem, const StateArg &state) const

◆ computeShearStrainRateNormSquared< ADReal >()

template ADReal NS::computeShearStrainRateNormSquared< ADReal > ( const Moose::Functor< ADReal > &  u,
const Moose::Functor< ADReal > *  v,
const Moose::Functor< ADReal > *  w,
const Moose::ElemArg elem_arg,
const Moose::StateArg state 
)

◆ computeShearStrainRateNormSquared< Real >()

template Real NS::computeShearStrainRateNormSquared< Real > ( const Moose::Functor< Real > &  u,
const Moose::Functor< Real > *  v,
const Moose::Functor< Real > *  w,
const Moose::ElemArg elem_arg,
const Moose::StateArg state 
)

◆ computeSign()

int NS::computeSign ( const Real a)

Sign function, returns $+1$ if $a$ is positive and $-1$ if $a$ is negative.

Parameters
[in]anumber
Returns
the sign of the input

Definition at line 27 of file NavierStokesMethods.C.

28 {
29  return a > 0 ? 1 : (a < 0 ? -1 : 0);
30 }

◆ computeSpeed()

template<typename T >
T NS::computeSpeed ( const libMesh::VectorValue< T > &  velocity)

Compute the speed (velocity norm) given the supplied velocity.

Definition at line 155 of file NavierStokesMethods.C.

156 {
157  // if the velocity is zero, then the norm function call fails because AD tries to calculate the
158  // derivatives which causes a divide by zero - because d/dx(sqrt(f(x))) = 1/2/sqrt(f(x))*df/dx.
159  // So add a bit of noise (based on hitchhiker's guide to the galaxy's meaning of life number) to
160  // avoid this failure mode.
161  return isZero(velocity) ? 1e-42 : velocity.norm();
162 }
bool isZero(const T &value, const Real tolerance=TOLERANCE *TOLERANCE *TOLERANCE)
static const std::string velocity
Definition: NS.h:45

◆ computeSpeed< ADReal >()

template ADReal NS::computeSpeed< ADReal > ( const libMesh::VectorValue< ADReal > &  velocity)

◆ computeSpeed< Real >()

template Real NS::computeSpeed< Real > ( const libMesh::VectorValue< Real > &  velocity)

◆ delta()

int NS::delta ( unsigned int  i,
unsigned int  j 
)

Delta function, which returns zero if $i j$ and unity if $i=j$.

Parameters
[in]iinteger number
[in]jinteger number
Returns
delta function

Definition at line 18 of file NavierStokesMethods.C.

Referenced by MethaneFluidProperties::alpha(), HydrogenFluidProperties::alpha(), NitrogenFluidProperties::alpha(), CO2FluidProperties::alpha(), GrainTracker::boundingRegionDistance(), HelmholtzFluidProperties::c_from_p_T(), Water97FluidProperties::c_from_p_T_template(), QuadSubChannel1PhaseProblem::computeBeta(), TriSubChannel1PhaseProblem::computeBeta(), BiLinearMixedModeTraction::computeCriticalDisplacementJump(), BiLinearMixedModeTraction::computeEffectiveDisplacementJump(), BiLinearMixedModeTraction::computeFinalDisplacementJump(), BiLinearMixedModeTraction::computeModeMixity(), NodalRankTwoPD::computeRankTwoTensors(), BiLinearMixedModeTraction::computeTraction(), BiLinearMixedModeTraction::computeTractionDerivatives(), WallDistanceMixingLengthAux::computeValue(), RotationAngle::computeValue(), HelmholtzFluidProperties::cp_from_p_T(), Water97FluidProperties::cp_from_p_T_template(), HelmholtzFluidProperties::cv_from_p_T(), Water97FluidProperties::cv_from_p_T_template(), MethaneFluidProperties::d2alpha_ddelta2(), NitrogenFluidProperties::d2alpha_ddelta2(), HydrogenFluidProperties::d2alpha_ddelta2(), CO2FluidProperties::d2alpha_ddelta2(), MethaneFluidProperties::d2alpha_ddeltatau(), NitrogenFluidProperties::d2alpha_ddeltatau(), HydrogenFluidProperties::d2alpha_ddeltatau(), CO2FluidProperties::d2alpha_ddeltatau(), MethaneFluidProperties::d2alpha_dtau2(), NitrogenFluidProperties::d2alpha_dtau2(), HydrogenFluidProperties::d2alpha_dtau2(), CO2FluidProperties::d2alpha_dtau2(), Water97FluidProperties::d2phi3_ddelta2(), Water97FluidProperties::d2phi3_ddeltatau(), Water97FluidProperties::d2phi3_dtau2(), MethaneFluidProperties::dalpha_ddelta(), HydrogenFluidProperties::dalpha_ddelta(), NitrogenFluidProperties::dalpha_ddelta(), CO2FluidProperties::dalpha_ddelta(), MethaneFluidProperties::dalpha_dtau(), NitrogenFluidProperties::dalpha_dtau(), HydrogenFluidProperties::dalpha_dtau(), CO2FluidProperties::dalpha_dtau(), Water97FluidProperties::dphi3_ddelta(), Water97FluidProperties::dphi3_dtau(), HelmholtzFluidProperties::e_from_p_T(), Water97FluidProperties::e_from_p_T_template(), LevelSetOlssonTerminator::execute(), HelmholtzFluidProperties::h_from_p_T(), Water97FluidProperties::h_from_p_T_template(), NitrogenFluidProperties::k_from_rho_T(), NitrogenFluidProperties::mu_from_rho_T(), HelmholtzFluidProperties::p_from_rho_T(), PatchSidesetGenerator::partition(), Water97FluidProperties::phi3(), HelmholtzFluidProperties::rho_from_p_T(), and HelmholtzFluidProperties::s_from_p_T().

19 {
20  if (i == j)
21  return 1;
22  else
23  return 0;
24 }
static const std::complex< double > j(0, 1)
Complex number "j" (also known as "i")

◆ divergence()

template<typename T , typename VectorType , typename PointType >
T NS::divergence ( const TensorValue< T > &  gradient,
const VectorType &  value,
const PointType &  point,
const Moose::CoordinateSystemType coord_sys,
const unsigned int  rz_radial_coord 
)

Compute the divergence of a vector given its matrix of derivatives.

Definition at line 170 of file NavierStokesMethods.h.

Referenced by INSADMaterial::computeQpProperties(), and INSADMomentumGradDiv::computeQpResidual().

175 {
176  mooseAssert((coord_sys == Moose::COORD_XYZ) || (coord_sys == Moose::COORD_RZ),
177  "This function only supports calculations of divergence in Cartesian and "
178  "axisymmetric coordinate systems");
179  auto div = gradient.tr();
180  if (coord_sys == Moose::COORD_RZ)
181  // u_r / r
182  div += value(rz_radial_coord) / point(rz_radial_coord);
183  return div;
184 }
Real value(unsigned n, unsigned alpha, unsigned beta, Real x)

◆ findUStar()

template<typename T >
T NS::findUStar ( const T &  mu,
const T &  rho,
const T &  u,
Real  dist 
)

Finds the friction velocity using standard velocity wall functions formulation.

It is used in WallFunctionWallShearStressAux, WallFunctionYPlusAux and INSFVWallFunctionBC.

Parameters
muthe dynamic viscosity
rhothe density
uthe centroid velocity
distthe element centroid distance to the wall
Returns
the velocity at the wall

This is important to reduce the number of nonlinear iterations

This is important to reduce the number of nonlinear iterations

Definition at line 65 of file NavierStokesMethods.C.

66 {
67  // usually takes about 3-4 iterations
68  constexpr int MAX_ITERS{50};
69  constexpr Real REL_TOLERANCE{1e-6};
70 
71  // Check inputs
72  mooseAssert(mu > 0, "Need a strictly positive viscosity");
73  mooseAssert(rho > 0, "Need a strictly positive density");
74  mooseAssert(u > 0, "Need a strictly positive velocity");
75  mooseAssert(dist > 0, "Need a strictly positive wall distance");
76 
77  const T nu = mu / rho;
78 
79  // Wall-function linearized guess
80  const Real a_c = 1 / NS::von_karman_constant;
81  const T b_c = 1.0 / NS::von_karman_constant * (std::log(NS::E_turb_constant * dist / mu) + 1.0);
82  const T & c_c = u;
83 
85  T u_star = std::max(1e-20, (-b_c + std::sqrt(std::pow(b_c, 2) + 4.0 * a_c * c_c)) / (2.0 * a_c));
86 
87  // Newton-Raphson method to solve for u_star (friction velocity).
88  for (int i = 0; i < MAX_ITERS; ++i)
89  {
90  T residual =
91  u_star / NS::von_karman_constant * std::log(NS::E_turb_constant * u_star * dist / nu) - u;
92  T deriv = (1.0 + std::log(NS::E_turb_constant * u_star * dist / nu)) / NS::von_karman_constant;
93  T new_u_star = std::max(1e-20, u_star - residual / deriv);
94 
95  Real rel_err =
96  std::abs(MetaPhysicL::raw_value(new_u_star - u_star) / MetaPhysicL::raw_value(new_u_star));
97 
98  u_star = new_u_star;
99  if (rel_err < REL_TOLERANCE)
100  return u_star;
101  }
102 
103  mooseException("Could not find the wall friction velocity (mu: ",
104  mu,
105  " rho: ",
106  rho,
107  " velocity: ",
108  u,
109  " wall distance: ",
110  dist,
111  ")");
112 }
static constexpr Real von_karman_constant
Definition: NS.h:191
auto raw_value(const Eigen::Map< T > &in)
Real deriv(unsigned n, unsigned alpha, unsigned beta, Real x)
static const std::string mu
Definition: NS.h:123
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
static constexpr Real E_turb_constant
Definition: NS.h:192
MooseUnits pow(const MooseUnits &, int)

◆ findUStar< ADReal >()

template ADReal NS::findUStar< ADReal > ( const ADReal mu,
const ADReal rho,
const ADReal u,
const Real  dist 
)

◆ findUStar< Real >()

template Real NS::findUStar< Real > ( const Real mu,
const Real rho,
const Real u,
const Real  dist 
)

◆ findyPlus()

template<typename T >
T NS::findyPlus ( const T &  mu,
const T &  rho,
const T &  u,
Real  dist 
)

Finds the non-dimensional wall distance normalized with the friction velocity Implements a fixed-point iteration in the wall function to get this velocity.

Parameters
muthe dynamic viscosity
rhothe density
uthe centroid velocity
distthe element centroid distance to the wall
Returns
the non-dimensional wall distance

Definition at line 119 of file NavierStokesMethods.C.

120 {
121  // Fixed point iteration method to find y_plus
122  // It should take 3 or 4 iterations
123  constexpr int MAX_ITERS{10};
124  constexpr Real REL_TOLERANCE{1e-2};
125 
126  // Check inputs
127  mooseAssert(mu > 0, "Need a strictly positive viscosity");
128  mooseAssert(u > 0, "Need a strictly positive velocity");
129  mooseAssert(rho > 0, "Need a strictly positive density");
130  mooseAssert(dist > 0, "Need a strictly positive wall distance");
131 
132  Real yPlusLast = 0.0;
133  T yPlus = dist * u * rho / mu; // Assign initial value to laminar
134  const Real rev_yPlusLam = 1.0 / MetaPhysicL::raw_value(yPlus);
135  const T kappa_time_Re = NS::von_karman_constant * u * dist / (mu / rho);
136  unsigned int iters = 0;
137 
138  do
139  {
140  yPlusLast = MetaPhysicL::raw_value(yPlus);
141  // Negative y plus does not make sense
142  yPlus = std::max(NS::min_y_plus, yPlus);
143  yPlus = (kappa_time_Re + yPlus) / (1.0 + std::log(NS::E_turb_constant * yPlus));
144  } while (std::abs(rev_yPlusLam * (MetaPhysicL::raw_value(yPlus) - yPlusLast)) > REL_TOLERANCE &&
145  ++iters < MAX_ITERS);
146 
147  return std::max(NS::min_y_plus, yPlus);
148 }
static constexpr Real von_karman_constant
Definition: NS.h:191
static constexpr Real min_y_plus
Definition: NS.h:198
auto raw_value(const Eigen::Map< T > &in)
static const std::string mu
Definition: NS.h:123
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
static constexpr Real E_turb_constant
Definition: NS.h:192

◆ findyPlus< ADReal >()

template ADReal NS::findyPlus< ADReal > ( const ADReal mu,
const ADReal rho,
const ADReal u,
Real  dist 
)

◆ findyPlus< Real >()

template Real NS::findyPlus< Real > ( const Real mu,
const Real rho,
const Real u,
Real  dist 
)

◆ getElementFaceArgs()

void NS::getElementFaceArgs ( const std::vector< BoundaryName > &  wall_boundary_name,
const FEProblemBase fe_problem,
const SubProblem subproblem,
const std::set< SubdomainID > &  block_ids,
std::map< const Elem *, std::vector< const FaceInfo *>> &  face_info_map 
)

Map storing face arguments to wall bounded faces The map passed in face_info_map gets cleared and re-populated.

Face arguments to wall-bounded faces for wall treatment.

Definition at line 308 of file NavierStokesMethods.C.

Referenced by RANSYPlusAux::initialSetup(), INSFVTKESourceSink::initialSetup(), kEpsilonViscosityAux::initialSetup(), INSFVTKEDSourceSink::initialSetup(), LinearFVTKESourceSink::initialSetup(), and LinearFVTKEDSourceSink::initialSetup().

313 {
314  face_info_map.clear();
315 
316  for (const auto & elem : fe_problem.mesh().getMesh().active_element_ptr_range())
317  if (block_ids.find(elem->subdomain_id()) != block_ids.end())
318  for (const auto i_side : elem->side_index_range())
319  {
320  const auto & side_bnds = subproblem.mesh().getBoundaryIDs(elem, i_side);
321  for (const auto & name : wall_boundary_name)
322  {
323  const auto wall_id = subproblem.mesh().getBoundaryID(name);
324  for (const auto side_id : side_bnds)
325  if (side_id == wall_id)
326  {
327  // The list below stores the face infos with respect to their owning elements,
328  // depending on the block restriction we might encounter situations where the
329  // element outside of the block owns the face info.
330  const auto & neighbor = elem->neighbor_ptr(i_side);
331  const auto elem_has_fi = Moose::FV::elemHasFaceInfo(*elem, neighbor);
332  const auto & elem_for_fi = elem_has_fi ? elem : neighbor;
333  const auto side = elem_has_fi ? i_side : neighbor->which_neighbor_am_i(elem);
334 
335  const FaceInfo * const fi = subproblem.mesh().faceInfo(elem_for_fi, side);
336  face_info_map[elem].push_back(fi);
337  }
338  }
339  }
340 }
virtual MooseMesh & mesh()=0
bool elemHasFaceInfo(const Elem &elem, const Elem *const neighbor)
const std::vector< const FaceInfo *> & faceInfo() const
MeshBase & getMesh()
const std::string name
Definition: Setup.h:20
virtual MooseMesh & mesh() override
std::vector< BoundaryID > getBoundaryIDs(const Elem *const elem, const unsigned short int side) const
BoundaryID getBoundaryID(const BoundaryName &boundary_name) const

◆ getIndex()

unsigned int NS::getIndex ( const Real p,
const std::vector< Real > &  bounds 
)

Determines the index $i$ in a sorted array such that the input point is within the $i$-th and $i+1$-th entries in the array.

Parameters
[in]pinput point
[in]boundssorted array
Returns
index of point

Definition at line 33 of file NavierStokesMethods.C.

34 {
35  if (p < bounds.front() || p > bounds.back())
36  mooseError("Point exceeds bounds of domain!");
37 
38  for (unsigned int i = 1; i < bounds.size(); ++i)
39  if (p <= bounds[i])
40  return i - 1;
41 
42  return bounds.size() - 2;
43 }
void mooseError(Args &&... args)

◆ getWallBoundedElements()

void NS::getWallBoundedElements ( const std::vector< BoundaryName > &  wall_boundary_name,
const FEProblemBase fe_problem,
const SubProblem subproblem,
const std::set< SubdomainID > &  block_ids,
std::unordered_set< const Elem *> &  wall_bounded 
)

Map marking wall bounded elements The map passed in wall_bounded_map gets cleared and re-populated.

Bounded element maps for wall treatment.

Definition at line 241 of file NavierStokesMethods.C.

Referenced by INSFVTurbulentAdvection::initialSetup(), RANSYPlusAux::initialSetup(), INSFVTKESourceSink::initialSetup(), kEpsilonViscosityAux::initialSetup(), INSFVTKEDSourceSink::initialSetup(), INSFVTurbulentDiffusion::initialSetup(), LinearFVTurbulentDiffusion::initialSetup(), LinearFVTurbulentAdvection::initialSetup(), LinearFVTKESourceSink::initialSetup(), and LinearFVTKEDSourceSink::initialSetup().

246 {
247 
248  wall_bounded.clear();
249  const auto wall_boundary_ids = subproblem.mesh().getBoundaryIDs(wall_boundary_names);
250 
251  for (const auto & elem : fe_problem.mesh().getMesh().active_element_ptr_range())
252  {
253  if (block_ids.find(elem->subdomain_id()) != block_ids.end())
254  for (const auto i_side : elem->side_index_range())
255  {
256  const auto & side_bnds = subproblem.mesh().getBoundaryIDs(elem, i_side);
257  for (const auto & wall_id : wall_boundary_ids)
258  {
259  for (const auto side_id : side_bnds)
260  if (side_id == wall_id)
261  wall_bounded.insert(elem);
262  }
263  }
264  }
265 }
virtual MooseMesh & mesh()=0
MeshBase & getMesh()
virtual MooseMesh & mesh() override
std::vector< BoundaryID > getBoundaryIDs(const Elem *const elem, const unsigned short int side) const

◆ getWallDistance()

void NS::getWallDistance ( const std::vector< BoundaryName > &  wall_boundary_name,
const FEProblemBase fe_problem,
const SubProblem subproblem,
const std::set< SubdomainID > &  block_ids,
std::map< const Elem *, std::vector< Real >> &  dist_map 
)

Map storing wall ditance for near-wall marked elements The map passed in dist_map gets cleared and re-populated.

Bounded element face distances for wall treatment.

Definition at line 269 of file NavierStokesMethods.C.

Referenced by RANSYPlusAux::initialSetup(), INSFVTKESourceSink::initialSetup(), kEpsilonViscosityAux::initialSetup(), INSFVTKEDSourceSink::initialSetup(), LinearFVTKESourceSink::initialSetup(), and LinearFVTKEDSourceSink::initialSetup().

274 {
275  dist_map.clear();
276 
277  for (const auto & elem : fe_problem.mesh().getMesh().active_element_ptr_range())
278  if (block_ids.find(elem->subdomain_id()) != block_ids.end())
279  for (const auto i_side : elem->side_index_range())
280  {
281  const auto & side_bnds = subproblem.mesh().getBoundaryIDs(elem, i_side);
282  for (const auto & name : wall_boundary_name)
283  {
284  const auto wall_id = subproblem.mesh().getBoundaryID(name);
285  for (const auto side_id : side_bnds)
286  if (side_id == wall_id)
287  {
288  // The list below stores the face infos with respect to their owning elements,
289  // depending on the block restriction we might encounter situations where the
290  // element outside of the block owns the face info.
291  const auto & neighbor = elem->neighbor_ptr(i_side);
292  const auto elem_has_fi = Moose::FV::elemHasFaceInfo(*elem, neighbor);
293  const auto & elem_for_fi = elem_has_fi ? elem : neighbor;
294  const auto side = elem_has_fi ? i_side : neighbor->which_neighbor_am_i(elem);
295 
296  const FaceInfo * const fi = subproblem.mesh().faceInfo(elem_for_fi, side);
297  const auto & elem_centroid =
298  elem_has_fi ? fi->elemCentroid() : fi->neighborCentroid();
299  const Real dist = std::abs((elem_centroid - fi->faceCentroid()) * fi->normal());
300  dist_map[elem].push_back(dist);
301  }
302  }
303  }
304 }
virtual MooseMesh & mesh()=0
bool elemHasFaceInfo(const Elem &elem, const Elem *const neighbor)
const Point & faceCentroid() const
const Point & neighborCentroid() const
const std::vector< const FaceInfo *> & faceInfo() const
const Point & elemCentroid() const
MeshBase & getMesh()
const std::string name
Definition: Setup.h:20
const Point & normal() const
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
virtual MooseMesh & mesh() override
std::vector< BoundaryID > getBoundaryIDs(const Elem *const elem, const unsigned short int side) const
BoundaryID getBoundaryID(const BoundaryName &boundary_name) const

◆ grad()

std::string NS::grad ( const std::string &  var)
inline

◆ isPorosityJumpFace()

template<class T >
std::tuple< bool, T, T > NS::isPorosityJumpFace ( const Moose::FunctorBase< T > &  porosity,
const FaceInfo fi,
const Moose::StateArg time 
)

Checks to see whether the porosity value jumps from one side to the other of the provided face.

Parameters
porositythe porosity
fithe face to inspect for porosity jumps
timeA temporal argument indicating at what time state to evaluate the porosity
Returns
a tuple where the zeroth member indicates whether there is a jump, the first member is the porosity value on the "element" side of the face, and the second member is the porosity value on the "neighbor" side of the face

Definition at line 59 of file NSFVUtils.C.

Referenced by WCNSFV2PMomentumAdvectionSlip::computeResidualsAndAData(), INSFVMomentumAdvection::computeResidualsAndAData(), HasPorosityJumpFace::computeValue(), BernoulliPressureVariable::getDirichletBoundaryFaceValue(), INSFVRhieChowInterpolator::getVelocity(), BernoulliPressureVariable::isDirichletBoundaryFace(), and BernoulliPressureVariable::isExtrapolatedBoundaryFace().

62 {
63  if (!fi.neighborPtr() || (fi.elem().subdomain_id() == fi.neighbor().subdomain_id()))
64  // We've agreed to only support porosity jump treatment at subdomain boundaries
65  return {false, 0, 0};
66 
67  mooseAssert(porosity.hasBlocks(fi.elem().subdomain_id()) &&
68  porosity.hasBlocks(fi.neighbor().subdomain_id()),
69  "Porosity should have blocks on both elem and neighbor");
70 
71  const Moose::FaceArg face_elem{
72  &fi, Moose::FV::LimiterType::CentralDifference, true, false, fi.elemPtr(), nullptr};
73  const Moose::FaceArg face_neighbor{
74  &fi, Moose::FV::LimiterType::CentralDifference, true, false, fi.neighborPtr(), nullptr};
75  const auto eps_elem = porosity(face_elem, time), eps_neighbor = porosity(face_neighbor, time);
76  return {!MooseUtils::relativeFuzzyEqual(eps_elem, eps_neighbor), eps_elem, eps_neighbor};
77 }
const Elem & elem() const
static const std::string porosity
Definition: NS.h:104
const Elem * neighborPtr() const
const Elem & neighbor() const
const Elem * elemPtr() const
bool relativeFuzzyEqual(const T &var1, const T2 &var2, const T3 &tol=libMesh::TOLERANCE *libMesh::TOLERANCE)

◆ isPorosityJumpFace< ADReal >()

template std::tuple< bool, ADReal, ADReal > NS::isPorosityJumpFace< ADReal > ( const Moose::FunctorBase< ADReal > &  porosity,
const FaceInfo fi,
const Moose::StateArg time 
)

◆ isPorosityJumpFace< Real >()

template std::tuple< bool, Real, Real > NS::isPorosityJumpFace< Real > ( const Moose::FunctorBase< Real > &  porosity,
const FaceInfo fi,
const Moose::StateArg time 
)

◆ prandtlPropertyDerivative()

Real NS::prandtlPropertyDerivative ( const Real mu,
const Real cp,
const Real k,
const Real dmu,
const Real dcp,
const Real dk 
)

Computes the derivative of the Prandtl number, $Pr{ C_p}{k}$, with respect to an arbitrary variale $$.

This derivative is

${ Pr}{ }={k({ C_p}{}+C_p{ mu}{})- C_p{ k}{}}{k^2}$

Parameters
[in]mudynamic viscosity
[in]cpisobaric specific heat
[in]kthermal conductivity
[in]dmuderivative of dynamic viscosity with respect to $$
[in]dcpderivative of isobaric specific heat with respect to $$
[in]dkderivative of thermal conductivity with respect to $$
Returns
derivative of Prandtl number with respect to $$

Definition at line 53 of file NavierStokesMethods.C.

Referenced by GeneralFluidProps::computeQpProperties(), and GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl().

59 {
60  return (k * (mu * dcp + cp * dmu) - mu * cp * dk) / std::max(k * k, 1e-8);
61 }
static const std::string cp
Definition: NS.h:121
static const std::string mu
Definition: NS.h:123
static const std::string k
Definition: NS.h:130

◆ reynoldsPropertyDerivative()

Real NS::reynoldsPropertyDerivative ( const Real Re,
const Real rho,
const Real mu,
const Real drho,
const Real dmu 
)

Computes the derivative of the Reynolds number, $Re { Vd}{}$, with respect to an arbitrary variable $$, where it is assumed that only the material properties of density $$ and dynamic viscosity $$ have nonzero derivatives with respect to $$.

To eliminate the need to pass in the velocity $V$ and characteristic length $d$, the derivative is rewritten in terms of the Reynolds number such that the partial derivative of $Re$ with respect to an aritrary parameter $$ is

${ Re}{}=Re({1}{}{}{ x}-{1}{}{}{ x}$

Parameters
[in]ReReynolds number
[in]rhodensity
[in]mudynamic viscosity
[in]drhopartial derivative of density with respect to arbitrary variable $$
[in]dmupartial derivative of dynamic viscosity with respect to arbitrary variable $$
Returns
derivative of Reynolds number with respect to $$

Definition at line 46 of file NavierStokesMethods.C.

Referenced by GeneralFluidProps::computeQpProperties(), and GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl().

48 {
49  return Re * (drho / std::max(rho, 1e-6) - dmu / std::max(mu, 1e-8));
50 }
static const std::string mu
Definition: NS.h:123

◆ time_deriv()

std::string NS::time_deriv ( const std::string &  var)
inline

◆ wallHeatTransferCoefficient()

template<typename T1 , typename T2 , typename T3 >
auto NS::wallHeatTransferCoefficient ( const T1 &  Nu,
const T2 &  k,
const T3 &  D_h 
)

Variable Documentation

◆ A

const std::string NS::A = "A"
static

Definition at line 161 of file NS.h.

◆ acceleration

const std::string NS::acceleration = "acceleration"
static

◆ alpha

const std::string NS::alpha = "alpha"
static

Definition at line 134 of file NS.h.

Referenced by SolidMechanicsPlasticWeakPlaneShear::activeConstraints(), SolidMechanicsPlasticWeakPlaneTensile::activeConstraints(), PorousFlowActionBase::addCapillaryPressureVG(), ElbowPipe1Phase::buildMeshNodes(), MultiPlasticityLinearSystem::calculateJacobian(), PorousFlowVanGenuchten::capillaryPressure(), PorousFlowVanGenuchten::capillaryPressureHys(), Beta::cdf(), Gamma::cdf(), NSFVBase::commonMomentumEquationParams(), StochasticTools::BiasCorrectedAccelerated< std::vector< InType >, std::vector< OutType > >::compute(), StochasticTools::BiasCorrectedAccelerated< InType, OutType >::compute(), PCNSFVKT::computeAlphaAndOmega(), ExponentialSoftening::computeCrackingRelease(), ADExponentialSoftening::computeCrackingRelease(), InterWrapper1PhaseProblem::computeDP(), SubChannel1PhaseProblem::computeDP(), PCNSFVKT::computeFaceFlux(), ADShaftConnectedPump1PhaseUserObject::computeFluxesAndResiduals(), ADShaftConnectedTurbine1PhaseUserObject::computeFluxesAndResiduals(), ADShaftConnectedCompressor1PhaseUserObject::computeFluxesAndResiduals(), QuadSubChannel1PhaseProblem::computeh(), TriSubChannel1PhaseProblem::computeh(), InterWrapper1PhaseProblem::computeh(), InterWrapper1PhaseProblem::computeInterpolatedValue(), SubChannel1PhaseProblem::computeInterpolatedValue(), InterWrapper1PhaseProblem::computeP(), SubChannel1PhaseProblem::computeP(), TotalLagrangianStressDivergenceBase< G >::computeQpJacobianDisplacement(), TotalLagrangianStressDivergenceBaseS< G >::computeQpJacobianDisplacement(), UpdatedLagrangianStressDivergenceBase< G >::computeQpJacobianDisplacement(), HomogenizedTotalLagrangianStressDivergenceR::computeQpJacobianDisplacement(), HomogenizedTotalLagrangianStressDivergenceA::computeQpJacobianDisplacement(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), PCNSFVKT::computeQpResidual(), HomogenizedTotalLagrangianStressDivergenceR::computeScalarQpOffDiagJacobian(), DensityUpdateTwoConstraints::computeUpdatedDensity(), InterWrapper1PhaseProblem::computeWij(), SubChannel1PhaseProblem::computeWijResidual(), XFEMCutElem::computeXFEMWeights(), NormalSampler::computeZ(), SolidMechanicsPlasticMeanCapTC::consistentTangentOperator(), RichardsSUPGstandard::cosh_relation(), RichardsSUPGstandard::cosh_relation_prime(), TemperaturePressureFunctionFluidProperties::cp_from_p_T(), PertinentGeochemicalSystem::createModel(), LeadFluidProperties::cv_from_p_T(), LeadBismuthFluidProperties::cv_from_p_T(), LeadLithiumFluidProperties::cv_from_p_T(), TemperaturePressureFunctionFluidProperties::cv_from_p_T(), PorousFlowVanGenuchten::d2CapillaryPressure(), PorousFlowVanGenuchten::d2capillaryPressureHys(), PorousFlowVanGenuchten::d2EffectiveSaturation(), PorousFlowVanGenuchten::d2saturationHys(), PorousFlowVanGenuchten::dCapillaryPressure(), PorousFlowVanGenuchten::dcapillaryPressureHys(), PorousFlowVanGenuchten::dEffectiveSaturation(), PorousFlowVanGenuchten::dsaturationHys(), RichardsSUPGstandard::dtauSUPG_dgradp(), RichardsSUPGstandard::dtauSUPG_dp(), PorousFlowVanGenuchten::effectiveSaturation(), DetailedPinMeshGeneratorBase::generatePin(), StochasticTools::GaussianProcess::getGradient(), SingleVariableReturnMappingSolutionTempl< is_ad >::internalSolve(), ComputeMultiPlasticityStress::lineSearch(), Beta::pdf(), Gamma::pdf(), Beta::quantile(), Gamma::quantile(), SolidMechanicsPlasticMohrCoulombMulti::returnPlane(), THM::rho_from_arhoA_alpha_A(), PorousFlowVanGenuchten::saturationHys(), INSBase::tauNodal(), RichardsSUPGstandard::tauSUPG(), TEST(), TEST_F(), THM::v_from_arhoA_alpha_A(), NSFVMixturePhaseInterface::validParams(), NSFVEnergyAmbientConvection::validParams(), MarvelTriWettedPerimIC::value(), and MarvelTriFlowAreaIC::value().

◆ alpha_boussinesq

const std::string NS::alpha_boussinesq = "alpha_b"
static

◆ alpha_exchange

const std::string NS::alpha_exchange = "alpha_exchange"
static

◆ alpha_wall

const std::string NS::alpha_wall = "alpha_wall"
static

Definition at line 135 of file NS.h.

◆ axis

const std::string NS::axis = "axis"
static

◆ c

const std::string NS::c = "c"
static

Definition at line 142 of file NS.h.

◆ C

const std::string NS::C = "C"
static

◆ center

const std::string NS::center = "center"
static

◆ cL

const std::string NS::cL = "Darcy_coefficient"
static

◆ component

const std::string NS::component = "component"
static

Definition at line 153 of file NS.h.

Referenced by CNSAction::act(), QuasiStaticSolidMechanicsPhysics::actOutputMatProp(), MultiSpeciesDiffusionPhysicsBase::addComponent(), GradientOperatorCoordinates::Cartesian::addGradOp(), GradientOperatorCoordinates::AxisymmetricCylindrical::addGradOp(), INSAction::addINSMomentum(), INSAction::addINSNoBCBC(), INSAction::addINSTimeKernels(), INSAction::addINSVelocityAux(), INSAction::addINSVelocityBC(), CNSAction::addNoPenetrationBC(), CNSAction::addNSMomentumInviscidFlux(), CNSAction::addNSMomentumInviscidSpecifiedPressureBC(), CNSAction::addNSMomentumWeakStagnationBC(), CNSAction::addNSSUPGMomentum(), CNSAction::addNSVelocityAux(), INSFVRhieChowInterpolator::addToA(), HSBoundaryInterface::check(), ShaftConnectable::checkShaftConnection(), TorqueTempl< is_ad >::componentJacobian(), StressDivergenceRZTensors::computeAverageGradientPhi(), StressDivergenceTensors::computeAverageGradientPhi(), ADComputeIncrementalShellStrain::computeBMatrix(), ADComputeFiniteShellStrain::computeBNLMatrix(), MechanicsFiniteStrainBaseNOSPD::computeDinvFTDU(), GeneralizedPlaneStrainOffDiagOSPD::computeDispFullOffDiagJacobianScalar(), GeneralizedPlaneStrainOffDiagNOSPD::computeDispFullOffDiagJacobianScalar(), GeneralizedPlaneStrainOffDiag::computeDispOffDiagJacobianScalar(), GeneralizedPlaneStrainOffDiagNOSPD::computeDispPartialOffDiagJacobianScalar(), GeneralizedPlaneStrainOffDiagOSPD::computeDispPartialOffDiagJacobianScalar(), MechanicsFiniteStrainBaseNOSPD::computeDJDU(), MechanicsFiniteStrainBaseNOSPD::computeDSDU(), MechanicsBaseNOSPD::computeDSDU(), StressDivergenceBeam::computeGlobalResidual(), ADComputeIncrementalShellStrain::computeGMatrix(), ConvectedMesh::computePGVelocityJacobian(), DashpotBC::computeQpOffDiagJacobian(), AbaqusUMATStress::computeQpStress(), ComputeLagrangianStrainBase< G >::computeQpUnstabilizedDeformationGradient(), ConvectedMeshPSPG::dStrongResidualDDisp(), ConvectedMeshPSPG::dStrongResidualDVel(), PenaltyFrictionUserObject::getAccumulatedSlip(), BrineFluidProperties::getComponent(), MechanicalContactConstraint::getConnectedDofIndices(), MechanicalContactConstraint::getCoupledVarComponent(), PenaltyFrictionUserObject::getDeltaTangentialLagrangeMultiplier(), PenaltyFrictionUserObject::getFrictionalContactPressure(), HSBoundaryInterface::getHSBoundaryName(), HSBoundaryInterface::getHSExternalBoundaryType(), PenaltyFrictionUserObject::getTangentialVelocity(), GradientOperator< C >::gradOp(), TotalLagrangianStressDivergenceBaseS< G >::gradTest(), TotalLagrangianStressDivergenceBase< G >::gradTest(), UpdatedLagrangianStressDivergenceBase< G >::gradTest(), TotalLagrangianStressDivergenceBase< G >::gradTrial(), TotalLagrangianStressDivergenceBaseS< G >::gradTrial(), UpdatedLagrangianStressDivergenceBase< G >::gradTrial(), TotalLagrangianStressDivergenceBase< G >::gradTrialStabilized(), TotalLagrangianStressDivergenceBaseS< G >::gradTrialStabilized(), UpdatedLagrangianStressDivergenceBase< G >::gradTrialStabilized(), TotalLagrangianStressDivergenceBase< G >::gradTrialUnstabilized(), TotalLagrangianStressDivergenceBaseS< G >::gradTrialUnstabilized(), UpdatedLagrangianStressDivergenceBase< G >::gradTrialUnstabilized(), HSBoundaryInterface::HSBoundaryInterface(), HSBoundaryInterface::HSBoundaryIsValid(), Simulation::identifyLoops(), PetscProjectSolutionOntoBounds::lineSearch(), TotalLagrangianStressDivergenceBase< G >::precalculateJacobianDisplacement(), TotalLagrangianStressDivergenceBaseS< G >::precalculateJacobianDisplacement(), UpdatedLagrangianStressDivergenceBase< G >::precalculateJacobianDisplacement(), RhieChowMassFlux::selectPressureGradient(), ADComputeFiniteShellStrain::updatedxyz(), ADComputeFiniteShellStrain::updateGVectors(), MortarGenericTraction::validParams(), TangentialMortarMechanicalContact::validParams(), NormalMortarMechanicalContact::validParams(), MMSTestFunc::validParams(), JinSlabCoeffFunc::validParams(), VectorTransientAbsorbingBC::validParams(), VectorCurrentSource::validParams(), ADMatWaveReaction::validParams(), ADConductionCurrent::validParams(), PorousFlowElementNormal::validParams(), CartesianMortarMechanicalContact::validParams(), DiffusionFluxFVAux::validParams(), EMRobinBC::validParams(), VectorEMRobinBC::validParams(), GrainAdvectionAux::validParams(), TorqueTempl< is_ad >::validParams(), PorousFlowDarcyVelocityComponentTempl< is_ad >::validParams(), RANFSTieNode::validParams(), RANFSNormalMechanicalContact::validParams(), DarcyFluxComponent::validParams(), AEFVKernel::validParams(), and AEFVBC::validParams().

◆ cp

const std::string NS::cp = "cp"
static

Definition at line 121 of file NS.h.

Referenced by WCNSFVTurbulencePhysics::addAuxiliaryKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), WCNSFVTurbulencePhysics::addFluidEnergyTurbulenceKernels(), PNSFVSolidHeatTransferPhysics::addMaterials(), WCNSFVFluidHeatTransferPhysicsBase::addMaterials(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyTimeKernels(), AriaLaserWeld304LStainlessSteelFunctorMaterial::AriaLaserWeld304LStainlessSteelFunctorMaterial(), WCNSFVInletTemperatureBC::boundaryValue(), ThermalFunctionSolidPropertiesTest::buildObjects(), NSFVBase::commonFluidEnergyEquationParams(), QuadSubChannel1PhaseProblem::computeBeta(), TriSubChannel1PhaseProblem::computeBeta(), ADSimpleTurbine1PhaseUserObject::computeFluxesAndResiduals(), TriSubChannel1PhaseProblem::computeh(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), PrandtlNumberAux::computeValue(), FluidPropertiesInterrogator::computeVaporMixture(), ConjugateHTNumbersFunctorMaterialTempl< is_ad >::ConjugateHTNumbersFunctorMaterialTempl(), PBSodiumFluidProperties::cp_from_p_T(), HelmholtzFluidProperties::cp_from_p_T(), SodiumSaturationFluidProperties::cp_from_p_T(), SimpleFluidProperties::cp_from_p_T(), NaKFluidProperties::cp_from_p_T(), NaClFluidProperties::cp_from_p_T(), StiffenedGasFluidProperties::cp_from_p_T(), SalineMoltenSaltFluidProperties::cp_from_p_T(), TabulatedFluidProperties::cp_from_p_T(), LeadLithiumFluidProperties::cp_from_p_T(), LeadBismuthFluidProperties::cp_from_p_T(), CaloricallyImperfectGas::cp_from_p_T(), LeadFluidProperties::cp_from_p_T(), TemperaturePressureFunctionFluidProperties::cp_from_p_T(), FlibeFluidProperties::cp_from_p_T(), HeliumFluidProperties::cp_from_p_T(), FlinakFluidProperties::cp_from_p_T(), ThermalUCProperties::cp_from_T(), ThermalCompositeSiCProperties::cp_from_T(), ThermalGraphiteProperties::cp_from_T(), ThermalMonolithicSiCProperties::cp_from_T(), ThermalSS316Properties::cp_from_T(), ThermalFunctionSolidProperties::cp_from_T(), CaloricallyImperfectGas::cp_from_T(), StiffenedGasFluidProperties::cp_from_v_e(), LinearFluidProperties::cp_from_v_e(), CaloricallyImperfectGas::cp_from_v_e(), TestSinglePhaseFluidProperties::cp_from_v_e(), LeadLithiumFluidProperties::cp_from_v_e(), LeadBismuthFluidProperties::cp_from_v_e(), LeadFluidProperties::cp_from_v_e(), SimpleFluidProperties::cp_from_v_e(), TemperaturePressureFunctionFluidProperties::cp_from_v_e(), FlibeFluidProperties::cp_from_v_e(), FlinakFluidProperties::cp_from_v_e(), HeliumFluidProperties::cp_from_v_e(), TabulatedFluidProperties::cp_from_v_e(), LeadFluidProperties::cv_from_p_T(), LeadLithiumFluidProperties::cv_from_p_T(), LeadBismuthFluidProperties::cv_from_p_T(), FlibeFluidProperties::cv_from_v_e(), FlinakFluidProperties::cv_from_v_e(), SodiumSaturationFluidProperties::e_from_p_T(), FlibeFluidProperties::e_from_p_T(), FlinakFluidProperties::e_from_p_T(), CaloricallyImperfectGas::e_from_v_h(), SubChannel1PhaseProblem::externalSolve(), InterWrapper1PhaseProblem::externalSolve(), CaloricallyImperfectGas::gamma_from_p_T(), CaloricallyImperfectGas::gamma_from_v_e(), GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), LeadFluidProperties::h_from_p_T(), FlibeFluidProperties::h_from_p_T(), FlinakFluidProperties::h_from_p_T(), LeadBismuthFluidProperties::h_from_v_e(), LeadLithiumFluidProperties::h_from_v_e(), LeadFluidProperties::h_from_v_e(), FlibeFluidProperties::p_from_v_e(), FlinakFluidProperties::p_from_v_e(), THM::Peclet(), fp::prandtl(), HeatTransferUtils::prandtl(), THM::Prandtl(), prandtlPropertyDerivative(), FlibeFluidProperties::T_from_v_e(), FlinakFluidProperties::T_from_v_e(), TEST(), TEST_F(), fp::thermalDiffusivity(), HeatTransferUtils::thermalDiffusivity(), PINSFVEnergyTimeDerivative::validParams(), INSFVTurbulentTemperatureWallFunction::validParams(), WCNSFVEnergyFluxBC::validParams(), INSElementIntegralEnergyAdvectionTempl< is_ad >::validParams(), PNSFVSolidHeatTransferPhysics::validParams(), WCNSFVInletTemperatureBC::validParams(), NSFVOutflowTemperatureBC::validParams(), ThermalDiffusivityFunctorMaterial::validParams(), INSFVEnthalpyFunctorMaterial::validParams(), TurbulentConductivityAux::validParams(), WCNSFVMixingLengthEnergyDiffusion::validParams(), and GeneralFunctorFluidPropsTempl< is_ad >::validParams().

◆ cp_s

const std::string NS::cp_s = "cp_s"
static

Definition at line 119 of file NS.h.

Referenced by LaserWeld316LStainlessSteel::computeQpProperties().

◆ cQ

const std::string NS::cQ = "Forchheimer_coefficient"
static

◆ cv

const std::string NS::cv = "cv"
static

Definition at line 122 of file NS.h.

Referenced by ADSimpleTurbine1PhaseUserObject::computeFluxesAndResiduals(), FluidPropertiesInterrogator::computeVaporMixture(), SodiumSaturationFluidProperties::cv_from_p_T(), LeadFluidProperties::cv_from_p_T(), SimpleFluidProperties::cv_from_p_T(), StiffenedGasFluidProperties::cv_from_p_T(), LeadBismuthFluidProperties::cv_from_p_T(), LeadLithiumFluidProperties::cv_from_p_T(), CaloricallyImperfectGas::cv_from_p_T(), TabulatedFluidProperties::cv_from_p_T(), TemperaturePressureFunctionFluidProperties::cv_from_p_T(), FlibeFluidProperties::cv_from_p_T(), FlinakFluidProperties::cv_from_p_T(), HeliumFluidProperties::cv_from_p_T(), CaloricallyImperfectGas::cv_from_T(), LinearFluidProperties::cv_from_v_e(), StiffenedGasFluidProperties::cv_from_v_e(), TestSinglePhaseFluidProperties::cv_from_v_e(), CaloricallyImperfectGas::cv_from_v_e(), LeadBismuthFluidProperties::cv_from_v_e(), LeadLithiumFluidProperties::cv_from_v_e(), LeadFluidProperties::cv_from_v_e(), SimpleFluidProperties::cv_from_v_e(), TemperaturePressureFunctionFluidProperties::cv_from_v_e(), FlibeFluidProperties::cv_from_v_e(), FlinakFluidProperties::cv_from_v_e(), TabulatedFluidProperties::cv_from_v_e(), HeliumFluidProperties::cv_from_v_e(), CaloricallyImperfectGas::e_from_v_h(), CaloricallyImperfectGas::gamma_from_p_T(), CaloricallyImperfectGas::gamma_from_v_e(), GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), NSTemperatureDerivs< NSEnergyViscousBC >::get_hess(), CaloricallyImperfectGas::setupLookupTables(), FlibeFluidProperties::T_from_v_e(), FlinakFluidProperties::T_from_v_e(), and TEST_F().

◆ density

const std::string NS::density = "rho"
static

Definition at line 33 of file NS.h.

Referenced by CNSAction::act(), WCNSFVTwoPhaseMixturePhysics::addAdvectionSlipTerm(), WCNSFVTurbulencePhysics::addAuxiliaryKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSFVFluidHeatTransferPhysics::addEnergyTimeKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), WCNSFVTurbulencePhysics::addFlowTurbulenceKernels(), WCNSFVTurbulencePhysics::addFluidEnergyTurbulenceKernels(), WCNSFVTurbulencePhysics::addFVBCs(), WCNSFVFlowPhysics::addInletBC(), WCNSFVTurbulencePhysics::addKEpsilonAdvection(), WCNSFVTurbulencePhysics::addKEpsilonSink(), WCNSFVFlowPhysics::addMassKernels(), WCNSFVFlowPhysics::addMassTimeKernels(), PNSFVSolidHeatTransferPhysics::addMaterials(), WCNSLinearFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTurbulencePhysics::addMaterials(), WCNSFVFluidHeatTransferPhysicsBase::addMaterials(), WCNSFVFlowPhysics::addMomentumAdvectionKernels(), WCNSLinearFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumGravityKernels(), WCNSFVFlowPhysics::addMomentumTimeKernels(), CNSAction::addNSInternalEnergyAux(), CNSAction::addNSMassInviscidFlux(), CNSAction::addNSMassUnspecifiedNormalFlowBC(), CNSAction::addNSMassWeakStagnationBC(), CNSAction::addNSSUPGMass(), CNSAction::addNSTimeKernels(), CNSAction::addNSVelocityAux(), WCNSFVFlowPhysics::addOutletBC(), WCNSFVTwoPhaseMixturePhysics::addPhaseChangeEnergySource(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyTimeKernels(), WCNSLinearFVFlowPhysics::addRhieChowUserObjects(), WCNSFVScalarTransportPhysics::addScalarInletBC(), WCNSFVFlowPhysics::addSolverVariables(), CNSAction::addSpecificTotalEnthalpyAux(), CNSAction::addSpecificVolumeComputation(), WCNSFVFlowPhysics::addWallsBC(), AriaLaserWeld304LStainlessSteelFunctorMaterial::AriaLaserWeld304LStainlessSteelFunctorMaterial(), HelmholtzFluidProperties::c_from_p_T(), NSFVBase::commonMomentumEquationParams(), RichardsMaterial::computeDerivedQuantities(), Q2PNodalMass::computeQpJacobian(), RichardsLumpedMassChange::computeQpJacobian(), Q2PNodalMass::computeQpOffDiagJacobian(), RichardsLumpedMassChange::computeQpOffDiagJacobian(), DensityTempl< is_ad >::computeQpProperties(), PorousFlowFluidStateBaseMaterialTempl< is_ad >::computeQpProperties(), Q2PNodalMass::computeQpResidual(), RichardsLumpedMassChange::computeQpResidual(), HelmholtzFluidProperties::cp_from_p_T(), HelmholtzFluidProperties::cv_from_p_T(), NaKFluidProperties::e_from_p_rho(), HelmholtzFluidProperties::e_from_p_T(), BrineFluidProperties::e_from_p_T_X(), NodalDensity::execute(), GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), HelmholtzFluidProperties::h_from_p_T(), SimpleFluidProperties::h_from_p_T(), BernoulliPressureVariable::initialSetup(), PorousFlowFluidStateBaseMaterialTempl< is_ad >::initQpStatefulProperties(), INSFVMomentumBoussinesq::INSFVMomentumBoussinesq(), NitrogenFluidProperties::k_from_p_T(), HydrogenFluidProperties::k_from_p_T(), CO2FluidProperties::k_from_p_T(), NitrogenFluidProperties::k_from_rho_T(), HydrogenFluidProperties::k_from_rho_T(), CO2FluidProperties::k_from_rho_T(), Water97FluidProperties::k_from_rho_T(), Water97FluidProperties::k_from_rho_T_template(), LinearFVMomentumBoussinesq::LinearFVMomentumBoussinesq(), NitrogenFluidProperties::mu_from_p_T(), HydrogenFluidProperties::mu_from_p_T(), NitrogenFluidProperties::mu_from_rho_T(), HydrogenFluidProperties::mu_from_rho_T(), CO2FluidProperties::mu_from_rho_T(), Water97FluidProperties::mu_from_rho_T(), Water97FluidProperties::mu_from_rho_T_template(), HelmholtzFluidProperties::p_from_rho_T(), CO2FluidProperties::p_from_rho_T(), PINSFVEnergyTimeDerivative::PINSFVEnergyTimeDerivative(), RichardsFullyUpwindFlux::prepareNodalValues(), Q2PSaturationFlux::prepareNodalValues(), Q2PPorepressureFlux::prepareNodalValues(), Q2PBorehole::prepareNodalValues(), RichardsBorehole::prepareNodalValues(), HelmholtzFluidProperties::rho_from_p_T(), CO2FluidProperties::rho_from_p_T(), Water97FluidProperties::rho_from_p_T_template(), HelmholtzFluidProperties::s_from_p_T(), CNSAction::setBCCommonParams(), CNSAction::setKernelCommonParams(), NaKFluidProperties::T_from_p_rho(), TEST_F(), PressureEqualsDensityMaterial::validParams(), INSFVEnergyTimeDerivative::validParams(), PINSFVEnergyTimeDerivative::validParams(), INSFVMomentumTimeDerivative::validParams(), PCNSFVDensityTimeDerivative::validParams(), PINSFVMomentumFrictionCorrection::validParams(), PINSFVMomentumFriction::validParams(), NSFVDispersePhaseDragFunctorMaterial::validParams(), INSFVTurbulentTemperatureWallFunction::validParams(), NSFVPumpFunctorMaterial::validParams(), INSFVMassAdvection::validParams(), ReynoldsNumberFunctorAux::validParams(), NSThermalBC::validParams(), INSFVkEpsilonViscosityFunctorMaterial::validParams(), LinearFVMomentumBoussinesq::validParams(), INSElementIntegralEnergyAdvectionTempl< is_ad >::validParams(), NSFVPhaseChangeSource::validParams(), INSFVMixingLengthReynoldsStress::validParams(), INSFVTurbulentAdvection::validParams(), INSFVMeshAdvection::validParams(), WCNSFV2PInterfaceAreaSourceSink::validParams(), WCNSFV2PMomentumAdvectionSlip::validParams(), WCNSFVEnergyTimeDerivative::validParams(), PNSFVSolidHeatTransferPhysics::validParams(), WCNSFVMomentumTimeDerivative::validParams(), WCNSFVMassTimeDerivative::validParams(), INSFVMomentumGravity::validParams(), NSFVOutflowTemperatureBC::validParams(), WCNSFV2PSlipVelocityFunctorMaterial::validParams(), WCNSFVInletTemperatureBC::validParams(), LinearFVTKESourceSink::validParams(), WCNSFVInletVelocityBC::validParams(), INSFVTKESourceSink::validParams(), NSInternalEnergyAux::validParams(), INSFVMomentumBoussinesq::validParams(), WCNSFVFluxBCBase::validParams(), RANSYPlusAux::validParams(), NSImposedVelocityBC::validParams(), INSFVWallFunctionBC::validParams(), ThermalDiffusivityFunctorMaterial::validParams(), INSFVMomentumAdvection::validParams(), PINSFVFunctorBC::validParams(), INSFVEnthalpyFunctorMaterial::validParams(), LinearFVTKEDSourceSink::validParams(), RhoFromPTFunctorMaterial::validParams(), NavierStokesLHDGAssemblyHelper::validParams(), INSFVTurbulentViscosityWallFunction::validParams(), WCNSFVMixingLengthEnergyDiffusion::validParams(), INSFVTKEDSourceSink::validParams(), kEpsilonViscosityAux::validParams(), ConservedVarValuesMaterial::validParams(), PorousConservedVarMaterial::validParams(), INSFVTKEDWallFunctionBC::validParams(), INSFVMomentumAdvectionOutflowBC::validParams(), NSTemperatureL2::validParams(), INSFVMassAdvectionOutflowBC::validParams(), ReynoldsNumberFunctorMaterial::validParams(), NSVelocityAux::validParams(), GeneralFunctorFluidPropsTempl< is_ad >::validParams(), BernoulliPressureVariable::validParams(), LinearFVTurbulentViscosityWallFunctionBC::validParams(), NSKernel::validParams(), NSIntegratedBC::validParams(), NSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), NSSpecificTotalEnthalpyAux::validParams(), PNSInitialCondition::validParams(), FunctorPebbleBedDragCoefficients< FunctorErgunDragCoefficients >::validParams(), NavierStokesMaterial::validParams(), RhieChowMassFlux::validParams(), NSImposedVelocityDirectionBC::validParams(), NSInitialCondition::value(), PNSInitialCondition::value(), NSFunctionInitialCondition::value(), and RichardsSUPGstandard::velSUPG().

◆ diagonal_tau

const std::string NS::diagonal_tau = "diagonal_tau"
static

Definition at line 160 of file NS.h.

◆ directions

const std::string NS::directions[3] = {"x", "y", "z"}
static

◆ dks_dTs

const std::string NS::dks_dTs = "dks_dTs"
static

Definition at line 115 of file NS.h.

◆ drhos_dTs

const std::string NS::drhos_dTs = "drhos_dTs"
static

Definition at line 114 of file NS.h.

◆ dS_dTs

const std::string NS::dS_dTs = "dS_dTs"
static

Definition at line 164 of file NS.h.

◆ dUdt

const std::string NS::dUdt = "dUdt"
static

Definition at line 167 of file NS.h.

◆ E_turb_constant

constexpr Real NS::E_turb_constant = 9.793
static

◆ eddy_viscosity

const std::string NS::eddy_viscosity = "eddy_viscosity"
static

Definition at line 77 of file NS.h.

◆ enthalpy_density

const std::string NS::enthalpy_density = "rho_h"
static

◆ epsilon_low_limit

constexpr Real NS::epsilon_low_limit = 1.0e-8
static

◆ F

const std::string NS::F = "F"
static

◆ fluid

const std::string NS::fluid = "fp"
static

◆ G

const std::string NS::G = "G"
static

◆ heat_source

const std::string NS::heat_source = "heat_source"
static

Definition at line 108 of file NS.h.

◆ infinite_porosity

const std::string NS::infinite_porosity = "infinite_porosity"
static

Definition at line 26 of file NS.h.

◆ internal_energy

const std::string NS::internal_energy = "internal_energy"
static

◆ internal_energy_density

const std::string NS::internal_energy_density = "rho_e"
static

Definition at line 64 of file NS.h.

◆ k

const std::string NS::k = "k"
static

Definition at line 130 of file NS.h.

Referenced by AddGeochemistrySolverAction::act(), DisplacementGradientsAction::act(), SolidMechanicsPlasticMeanCapTC::activeConstraints(), CoupledHeatTransferAction::addBCs(), AddCoupledEqSpeciesAction::AddCoupledEqSpeciesAction(), AddCoupledSolidKinSpeciesAction::AddCoupledSolidKinSpeciesAction(), WCNSFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyHeatConductionKernels(), RadiationTransferAction::addRadiationObject(), CoupledHeatTransferAction::addTransfers(), AriaLaserWeld304LStainlessSteelFunctorMaterial::AriaLaserWeld304LStainlessSteelFunctorMaterial(), PolygonMeshGeneratorBase::backgroundNodes(), Component2D::build2DMesh(), Component2D::build2DMesh2ndOrder(), Component2D::buildMesh(), FileMeshComponent::buildMesh(), Component1D::buildMesh(), ThermalFunctionSolidPropertiesTest::buildObjects(), FiniteStrainCrystalPlasticity::calc_schmid_tensor(), FiniteStrainCPSlipRateRes::calcDtauDsliprate(), CrystalPlasticitySlipRateGSS::calcFlowDirection(), FiniteStrainUObasedCP::calcJacobian(), FiniteStrainCrystalPlasticity::calcJacobian(), ComputeMultipleCrystalPlasticityStress::calculateJacobian(), MultiPlasticityLinearSystem::calculateJacobian(), CrystalPlasticityStressUpdateBase::calculateSchmidTensor(), CFLTimeStepSizeTempl< is_ad >::CFLTimeStepSizeTempl(), GeochemicalSystem::checkAndInitialize(), SingularShapeTensorEliminatorUserObjectPD::checkShapeTensorSingularity(), PolynomialQuadrature::clenshaw_curtis(), EFAFace::combineTwoEdges(), NSFVBase::commonFluidEnergyEquationParams(), RichardsMaterial::compute2ndDerivedQuantities(), neml2::LAROMANCE6DInterpolation::compute_interpolation(), InteractionIntegralTempl< is_ad >::computeAuxFields(), QuadSubChannel1PhaseProblem::computeBeta(), TriSubChannel1PhaseProblem::computeBeta(), ADComputeIncrementalShellStrain::computeBMatrix(), ADComputeFiniteShellStrain::computeBNLMatrix(), ComputeStrainBaseNOSPD::computeBondHorizonQpDeformationGradient(), HexagonalLatticeUtils::computeChannelPinIndices(), LatticeSmoothCircleIC::computeCircleCenters(), ComputeStrainBaseNOSPD::computeConventionalQpDeformationGradient(), DerivativeMultiPhaseMaterial::computeD3F(), DerivativeTwoPhaseMaterial::computeD3F(), MechanicsFiniteStrainBaseNOSPD::computeDinvFTDU(), GeneralizedPlaneStrainOffDiagOSPD::computeDispFullOffDiagJacobianScalar(), FiniteStrainHyperElasticViscoPlastic::computeDpk2Dfpinv(), CohesiveZoneModelTools::computedRdF(), MechanicsFiniteStrainBaseNOSPD::computeDSDFhat(), PODReducedBasisTrainer::computeEigenDecomposition(), MorrisReporterContext< DataType >::computeElementaryEffects(), ADComputeIncrementalShellStrain::computeGMatrix(), FiniteStrainHyperElasticViscoPlastic::computeIntVarDerivatives(), ShaftConnectableUserObjectInterface::computeMomentOfInertiaScalarJacobianWRTFlowDofs(), ADComputeFiniteShellStrain::computeNodeNormal(), ADComputeIncrementalShellStrain::computeNodeNormal(), MechanicsOSPD::computeNonlocalJacobian(), HorizonStabilizedFormIFiniteStrainMechanicsNOSPD::computeNonlocalJacobian(), HorizonStabilizedFormIIFiniteStrainMechanicsNOSPD::computeNonlocalJacobian(), HyperElasticPhaseFieldIsoDamage::computeNumStiffness(), HorizonStabilizedFormIFiniteStrainMechanicsNOSPD::computePDNonlocalOffDiagJacobian(), HorizonStabilizedFormIIFiniteStrainMechanicsNOSPD::computePDNonlocalOffDiagJacobian(), HyperElasticPhaseFieldIsoDamage::computePK2StressAndDerivative(), FiniteStrainHyperElasticViscoPlastic::computePK2StressAndDerivative(), ADComputeFiniteShellStrain::computeProperties(), RichardsPiecewiseLinearSinkFlux::computeQpIntegral(), Q2PPiecewiseLinearSinkFlux::computeQpIntegral(), NSMomentumViscousFlux::computeQpJacobian(), NSMomentumViscousBC::computeQpJacobian(), FiniteStrainHyperElasticViscoPlastic::computeQpJacobian(), NSEnergyViscousFlux::computeQpOffDiagJacobian(), NSMomentumViscousFlux::computeQpOffDiagJacobian(), INSChorinPredictor::computeQpOffDiagJacobian(), SLKKSMultiACBulkC::computeQpOffDiagJacobian(), SwitchingFunctionConstraintEta::computeQpOffDiagJacobian(), InertialTorque::computeQpOffDiagJacobian(), PhaseFieldFractureMechanicsOffDiag::computeQpOffDiagJacobian(), INSSplitMomentum::computeQpOffDiagJacobian(), StressDivergenceRZTensors::computeQpOffDiagJacobian(), NSMomentumViscousBC::computeQpOffDiagJacobian(), NSEnergyViscousBC::computeQpOffDiagJacobian(), ComputeLagrangianStressCustomPK2::computeQpPK1Stress(), ComputeSimoHughesJ2PlasticityStress::computeQpPK1Stress(), StrainGradDispDerivatives::computeQpProperties(), ComputeCosseratSmallStrain::computeQpProperties(), ComputeCosseratIncrementalSmallStrain::computeQpProperties(), ElectrochemicalSinteringMaterial::computeQpProperties(), ADComputeIsotropicElasticityTensorShell::computeQpProperties(), ForceDensityMaterial::computeQpProperties(), ThirdPhaseSuppressionMaterial::computeQpProperties(), INSChorinPredictor::computeQpResidual(), InertialTorque::computeQpResidual(), MomentBalancing::computeQpResidual(), INSSplitMomentum::computeQpResidual(), PorousFlowSink::computeQpResidual(), Q2PPiecewiseLinearSink::computeQpResidual(), RichardsPiecewiseLinearSink::computeQpResidual(), ComputeHypoelasticStVenantKirchhoffStress::computeQpSmallStress(), AbaqusUMATStress::computeQpStress(), NodalRankTwoPD::computeRankTwoTensors(), ADInertialForceShell::computeShellInertialForces(), ComputeLinearElasticPFFractureStress::computeStrainVolDev(), NavierStokesMaterial::computeStrongResiduals(), RichardsMaterial::computeSUPG(), HEVPFlowRatePowerLawJ2::computeTensorDerivative(), ShaftConnectableUserObjectInterface::computeTorqueScalarJacobianWRTFlowDofs(), PrandtlNumberAux::computeValue(), FluidPropertiesInterrogator::computeVaporMixture(), ComputeVolumetricEigenstrain::ComputeVolumetricEigenstrain(), ConjugateHTNumbersFunctorMaterialTempl< is_ad >::ConjugateHTNumbersFunctorMaterialTempl(), EFAElement2D::connectNeighbors(), EFAElement3D::connectNeighbors(), EFAFragment3D::connectSubfaces(), SolidMechanicsPlasticMeanCapTC::consistentTangentOperator(), SolidMechanicsPlasticTensileMulti::consistentTangentOperator(), CappedDruckerPragerCosseratStressUpdate::consistentTangentOperator(), CappedDruckerPragerStressUpdate::consistentTangentOperator(), TwoParameterPlasticityStressUpdate::consistentTangentOperator(), ComputeMultiPlasticityStress::consistentTangentOperator(), CappedMohrCoulombCosseratStressUpdate::consistentTangentOperatorV(), TensileStressUpdate::consistentTangentOperatorV(), CappedMohrCoulombStressUpdate::consistentTangentOperatorV(), EFAElement2D::createChild(), EFAElement3D::createFaces(), PeridynamicsMesh::createNeighborHorizonBasedData(), PeridynamicsMesh::createNodeHorizBasedData(), PeridynamicsMesh::createPeridynamicsMeshData(), SurrogateTrainer::crossValidate(), HeatTransferModels::cylindricalThermalConductance(), CappedWeakPlaneStressUpdate::d2qdstress2(), DerivativeMultiPhaseBase::DerivativeMultiPhaseBase(), DerivativeTwoPhaseMaterial::DerivativeTwoPhaseMaterial(), SolidMechanicsPlasticTensile::dflowPotential_dstress(), SolidMechanicsPlasticMohrCoulomb::dflowPotential_dstress(), SolidMechanicsPlasticWeakPlaneShear::dflowPotential_dstress(), SolidMechanicsPlasticJ2::dflowPotential_dstress(), DiscreteLineSegmentInterface::DiscreteLineSegmentInterface(), MultiParameterPlasticityStressUpdate::dnRHSdVar(), NSViscStressTensorDerivs< NSEnergyViscousBC >::dtau(), PolygonMeshGeneratorBase::ductNodes(), MultiParameterPlasticityStressUpdate::dVardTrial(), EFAFace::EFAFace(), ElasticityTensorTools::elasticJacobian(), ElasticityTensorTools::elasticJacobianWC(), ComputeMultipleCrystalPlasticityStress::elastoPlasticTangentModuli(), FiniteStrainUObasedCP::elastoPlasticTangentModuli(), FiniteStrainCrystalPlasticity::elastoPlasticTangentModuli(), ElectrochemicalSinteringMaterial::ElectrochemicalSinteringMaterial(), euler2RGB(), Legendre::evaluateOrthonormal(), CompositeSeriesBasisInterface::evaluateSeries(), Legendre::evaluateStandard(), CFLTimeStepSizeTempl< is_ad >::execute(), ComputeGrainForceAndTorque::executeJacobian(), ComputeExternalGrainForceAndTorque::executeJacobian(), SubChannel1PhaseProblem::externalSolve(), InterWrapper1PhaseProblem::externalSolve(), MultiPlasticityDebugger::fddflowPotential_dstress(), MultiPlasticityDebugger::fdJacobian(), AdvectiveFluxCalculatorBase::finalize(), MorrisReporterContext< DataType >::finalize(), CrackMeshCut3DUserObject::findBoundaryEdges(), FinEfficiencyFunctorMaterialTempl< is_ad >::FinEfficiencyFunctorMaterialTempl(), CompositeSeriesBasisInterface::formatCoefficients(), EFAElement2D::fragmentSanityCheck(), GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), RevolveGenerator::generate(), MeshGeneratorPD::generate(), DetailedPinMeshGeneratorBase::generatePin(), GeochemistryTimeDependentReactor::GeochemistryTimeDependentReactor(), GeochemicalSystem::getAlgebraicVariableDenseValues(), GeochemicalSystem::getAlgebraicVariableValues(), EFAElement3D::getCommonEdgeID(), DiscreteLineSegmentInterface::getElementBoundaryCoordinates(), GeochemicalSystem::getKineticMoles(), ShaftConnectableUserObjectInterface::getMomentOfInertiaJacobianData(), EFAElement2D::getPhantomNodeOnEdge(), EFAElement3D::getPhantomNodeOnFace(), XFEMCutElem2D::getPhysicalQuadraturePoints(), ShaftConnectableUserObjectInterface::getTorqueJacobianData(), LAROMANCEStressUpdateBaseTempl< is_ad >::getTransformedLimits(), XFEM::getXFEMqRuleOnSurface(), CrackMeshCut3DUserObject::growFront(), GrainForceAndTorqueSum::initialize(), MaskedGrainForceAndTorque::initialize(), StochasticTools::inplaceSort(), EFAFragment3D::isEdgeConnected(), Q2PPiecewiseLinearSink::jac(), PorousFlowSink::jac(), RichardsPiecewiseLinearSink::jac(), MethaneFluidProperties::k_from_p_T(), SodiumSaturationFluidProperties::k_from_p_T(), NaKFluidProperties::k_from_p_T(), NitrogenFluidProperties::k_from_p_T(), SimpleFluidProperties::k_from_p_T(), HydrogenFluidProperties::k_from_p_T(), NaClFluidProperties::k_from_p_T(), StiffenedGasFluidProperties::k_from_p_T(), LeadLithiumFluidProperties::k_from_p_T(), LeadBismuthFluidProperties::k_from_p_T(), LeadFluidProperties::k_from_p_T(), CaloricallyImperfectGas::k_from_p_T(), TabulatedFluidProperties::k_from_p_T(), IdealGasFluidProperties::k_from_p_T(), SalineMoltenSaltFluidProperties::k_from_p_T(), CO2FluidProperties::k_from_p_T(), TemperaturePressureFunctionFluidProperties::k_from_p_T(), FlibeFluidProperties::k_from_p_T(), HeliumFluidProperties::k_from_p_T(), FlinakFluidProperties::k_from_p_T(), ThermalUCProperties::k_from_T(), ThermalMonolithicSiCProperties::k_from_T(), ThermalGraphiteProperties::k_from_T(), ThermalCompositeSiCProperties::k_from_T(), ThermalSS316Properties::k_from_T(), ThermalFunctionSolidProperties::k_from_T(), StiffenedGasFluidProperties::k_from_v_e(), CaloricallyImperfectGas::k_from_v_e(), TestSinglePhaseFluidProperties::k_from_v_e(), LeadLithiumFluidProperties::k_from_v_e(), LeadBismuthFluidProperties::k_from_v_e(), IdealGasFluidProperties::k_from_v_e(), LeadFluidProperties::k_from_v_e(), SimpleFluidProperties::k_from_v_e(), TabulatedFluidProperties::k_from_v_e(), PolynomialQuadrature::legendre(), ElasticityTensorTools::momentJacobian(), ElasticityTensorTools::momentJacobianWC(), GeochemistryTimeDependentReactor::newTemperature(), IndependentMHDecision::nextSamples(), PMCMCDecision::nextSamples(), IndependentMHDecision::nextSeeds(), ComputeLagrangianObjectiveStress::objectiveUpdateGreenNaghdi(), ComputeLagrangianObjectiveStress::objectiveUpdateJaumann(), GatherRCDataFaceThread< RangeType >::onFace(), GeochemistryConsoleOutput::output(), THM::Peclet(), ComputeLagrangianObjectiveStress::polarDecomposition(), GeochemistryTimeDependentReactor::postSolveFlowThrough(), fp::prandtl(), HeatTransferUtils::prandtl(), THM::Prandtl(), prandtlPropertyDerivative(), PolycrystalHex::precomputeGrainStructure(), SLKKSMultiACBulkC::precomputeQpJacobian(), SLKKSMultiPhaseConcentration::precomputeQpResidual(), SLKKSMultiACBulkC::precomputeQpResidual(), GeochemistryTimeDependentReactor::preSolveFlush(), EFAElement2D::printElement(), EFAElement3D::printElement(), PolygonMeshGeneratorBase::quadElemDef(), CrackMeshCut3DUserObject::refineBoundary(), CrackMeshCut3DUserObject::refineFront(), GeochemistryTimeDependentReactor::removeCurrentSpecies(), EFAElement3D::removePhantomEmbeddedNode(), StochasticTools::reshapeVector(), SolidMechanicsPlasticMeanCapTC::returnMap(), PolygonMeshGeneratorBase::ringNodes(), TriInterWrapperMesh::rodPositions(), TriSubChannelMesh::rodPositions(), SCMDetailedTriSubChannelMeshGenerator::SCMDetailedTriSubChannelMeshGenerator(), SCMTriInterWrapperMeshGenerator::SCMTriInterWrapperMeshGenerator(), SCMTriSubChannelMeshGenerator::SCMTriSubChannelMeshGenerator(), GeochemicalSystem::setAlgebraicVariables(), AttribINSFVBCs::setFrom(), AttribINSFVMomentumResidualObject::setFrom(), GeochemicalSystem::setKineticMoles(), GeochemicalSystem::setMineralRelatedFreeMoles(), Xfem::shapeFunc2D(), SLKKSMultiPhaseBase::SLKKSMultiPhaseBase(), SolidMechanicsPlasticIsotropicSD::SolidMechanicsPlasticIsotropicSD(), XFEMCutElem2D::solveMomentFitting(), CrystalPlasticityStressUpdateBase::sortCrossSlipFamilies(), ADVolumeJunctionBaseUserObject::storeConnectionData(), ComputeLagrangianObjectiveStress::stressAdvectionDerivative(), EFAElement2D::switchNode(), EFAElement3D::switchNode(), TEST(), TEST_F(), fp::thermalDiffusivity(), HeatTransferUtils::thermalDiffusivity(), ElasticityTensorTools::toMooseVoigtNotationIndexConversion(), ElasticityTensorTools::toVoigtNotationIndexConversion(), CrystalPlasticityStressUpdateBase::transformHexagonalMillerBravaisSlipSystems(), CrackMeshCut3DUserObject::triangulation(), ADComputeFiniteShellStrain::updatedxyz(), GeochemicalSystem::updateOldWithCurrent(), ComputeLagrangianObjectiveStress::updateTensor(), ThermalDiffusivityFunctorMaterial::validParams(), PINSFVEnergyDiffusion::validParams(), GeneralFunctorFluidPropsTempl< is_ad >::validParams(), NSFVFunctorHeatFluxBC::validParams(), MMSTestFunc::value(), wallHeatTransferCoefficient(), and Simulation::~Simulation().

◆ K

const std::string NS::K = "K"
static

◆ k_s

const std::string NS::k_s = "k_s"
static

◆ k_t

const std::string NS::k_t = "k_t"
static

◆ kappa

const std::string NS::kappa = "kappa"
static

◆ kappa_s

const std::string NS::kappa_s = "kappa_s"
static

Definition at line 117 of file NS.h.

Referenced by NSFVFunctorHeatFluxBC::validParams().

◆ latent_heat

const std::string NS::latent_heat = "latent_heat"
static

Definition at line 147 of file NS.h.

Referenced by WCNSFVTwoPhaseMixturePhysics::addPhaseChangeEnergySource().

◆ mach_number

const std::string NS::mach_number = "Mach"
static

◆ mass_flux

const std::string NS::mass_flux = "mass_flux"
static

Definition at line 171 of file NS.h.

◆ matrix_tau

const std::string NS::matrix_tau = "matrix_tau"
static

Definition at line 157 of file NS.h.

◆ min_y_plus

constexpr Real NS::min_y_plus = 1e-10
static

Definition at line 198 of file NS.h.

Referenced by findyPlus().

◆ mixing_length

const std::string NS::mixing_length = "mixing_length"
static

◆ momentum

const std::string NS::momentum = "momentum"
static

Definition at line 83 of file NS.h.

◆ momentum_vector

const std::string NS::momentum_vector[3] = {momentum_x, momentum_y, momentum_z}
static

Definition at line 38 of file NS.h.

◆ momentum_x

const std::string NS::momentum_x = "rhou"
static

◆ momentum_y

const std::string NS::momentum_y = "rhov"
static

◆ momentum_z

const std::string NS::momentum_z = "rhow"
static

◆ mu

const std::string NS::mu = "mu"
static

Definition at line 123 of file NS.h.

Referenced by WCNSFVTurbulencePhysics::addAuxiliaryKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), WCNSFVTurbulencePhysics::addFVBCs(), WCNSFVTurbulencePhysics::addKEpsilonSink(), WCNSLinearFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTurbulencePhysics::addMaterials(), WCNSLinearFVFlowPhysics::addMomentumFluxKernels(), WCNSLinearFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumViscousDissipationKernels(), WCNSFVFlowPhysics::addWallsBC(), AriaLaserWeld304LStainlessSteelFunctorMaterial::AriaLaserWeld304LStainlessSteelFunctorMaterial(), INSFVTurbulentViscosityWallFunction::boundaryValue(), INSFVTKEDWallFunctionBC::boundaryValue(), NSFVBase::commonMomentumEquationParams(), HyperElasticPhaseFieldIsoDamage::computeDamageStress(), IntegralDirectedSurfaceForce::computeFaceInfoIntegral(), PINSFVMomentumFriction::computeFrictionWCoefficient(), LinearFVTKESourceSink::computeMatrixContribution(), PorousFlowBrine::computeQpProperties(), PorousFlowMultiComponentFluidTempl< is_ad >::computeQpProperties(), PorousFlowSingleComponentFluidTempl< is_ad >::computeQpProperties(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), INSFVTKESourceSink::computeQpResidual(), INSFVTKEDSourceSink::computeQpResidual(), LinearFVTKEDSourceSink::computeRightHandSideContribution(), ComputeLinearElasticPFFractureStress::computeStrainSpectral(), ComputeLinearElasticPFFractureStress::computeStrainVolDev(), LinearFVTurbulentViscosityWallFunctionBC::computeTurbulentViscosity(), PrandtlNumberAux::computeValue(), WallFunctionWallShearStressAux::computeValue(), WallFunctionYPlusAux::computeValue(), RANSYPlusAux::computeValue(), kEpsilonViscosityAux::computeValue(), FluidPropertiesInterrogator::computeVaporMixture(), ConjugateHTNumbersFunctorMaterialTempl< is_ad >::ConjugateHTNumbersFunctorMaterialTempl(), SolidMechanicsPlasticJ2::consistentTangentOperator(), SolidMechanicsPlasticDruckerPragerHyperbolic::consistentTangentOperator(), SolidMechanicsPlasticTensileMulti::consistentTangentOperator(), NSViscStressTensorDerivs< NSEnergyViscousBC >::dtau(), SubChannel1PhaseProblem::externalSolve(), InterWrapper1PhaseProblem::externalSolve(), MorrisReporterContext< DataType >::finalize(), findUStar(), findyPlus(), PolynomialQuadrature::gauss_hermite(), GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), fp::grashof(), HeatTransferUtils::grashof(), PolynomialQuadrature::hermite(), KernelDensity1D::KernelDensity1D(), fp::laplace(), HeatTransferUtils::laplace(), MorrisReporterContext< DataType >::MorrisReporterContext(), MethaneFluidProperties::mu_from_p_T(), CO2FluidProperties::mu_from_p_T(), NitrogenFluidProperties::mu_from_p_T(), HydrogenFluidProperties::mu_from_p_T(), NaKFluidProperties::mu_from_p_T(), SodiumSaturationFluidProperties::mu_from_p_T(), StiffenedGasFluidProperties::mu_from_p_T(), TabulatedFluidProperties::mu_from_p_T(), CaloricallyImperfectGas::mu_from_p_T(), LeadBismuthFluidProperties::mu_from_p_T(), LeadLithiumFluidProperties::mu_from_p_T(), LeadFluidProperties::mu_from_p_T(), SalineMoltenSaltFluidProperties::mu_from_p_T(), IdealGasFluidProperties::mu_from_p_T(), Water97FluidProperties::mu_from_p_T(), SimpleFluidProperties::mu_from_p_T(), TemperaturePressureFunctionFluidProperties::mu_from_p_T(), FlibeFluidProperties::mu_from_p_T(), HeliumFluidProperties::mu_from_p_T(), FlinakFluidProperties::mu_from_p_T(), BrineFluidProperties::mu_from_p_T_X(), NitrogenFluidProperties::mu_from_rho_T(), HydrogenFluidProperties::mu_from_rho_T(), CO2FluidProperties::mu_from_rho_T(), Water97FluidProperties::mu_from_rho_T(), StiffenedGasFluidProperties::mu_from_v_e(), LinearTestFluidProperties::mu_from_v_e(), TestSinglePhaseFluidProperties::mu_from_v_e(), CaloricallyImperfectGas::mu_from_v_e(), LeadLithiumFluidProperties::mu_from_v_e(), LeadBismuthFluidProperties::mu_from_v_e(), LeadFluidProperties::mu_from_v_e(), IdealGasFluidProperties::mu_from_v_e(), TabulatedFluidProperties::mu_from_v_e(), SimpleFluidProperties::mu_from_v_e(), PINSFVMomentumFriction::PINSFVMomentumFriction(), PolynomialChaosTrainer::postTrain(), PolynomialRegressionTrainer::postTrain(), fp::prandtl(), HeatTransferUtils::prandtl(), THM::Prandtl(), prandtlPropertyDerivative(), SolidMechanicsPlasticJ2::returnMap(), SolidMechanicsPlasticDruckerPragerHyperbolic::returnMap(), HeatTransferUtils::reynolds(), fp::reynolds(), THM::Reynolds(), reynoldsPropertyDerivative(), NitrogenFluidProperties::rho_mu_from_p_T(), HydrogenFluidProperties::rho_mu_from_p_T(), CO2FluidProperties::rho_mu_from_p_T(), Water97FluidProperties::rho_mu_from_p_T(), SinglePhaseFluidProperties::rho_mu_from_p_T(), MultiComponentFluidProperties::rho_mu_from_p_T_X(), TEST(), TEST_F(), PINSFVMomentumFrictionCorrection::validParams(), NSFVDispersePhaseDragFunctorMaterial::validParams(), PINSFVMomentumFriction::validParams(), LinearFVMomentumFriction::validParams(), ReynoldsNumberFunctorAux::validParams(), INSFVTurbulentTemperatureWallFunction::validParams(), INSFVMushyPorousFrictionFunctorMaterial::validParams(), WCNSFV2PSlipVelocityFunctorMaterial::validParams(), LinearFVTKESourceSink::validParams(), INSFVTKESourceSink::validParams(), RANSYPlusAux::validParams(), LinearFVTKEDSourceSink::validParams(), INSFVTKEDSourceSink::validParams(), kEpsilonViscosityAux::validParams(), NavierStokesLHDGAssemblyHelper::validParams(), INSFVTurbulentViscosityWallFunction::validParams(), INSFVMomentumDiffusion::validParams(), INSFVTKEDWallFunctionBC::validParams(), LinearWCNSFVMomentumFlux::validParams(), ReynoldsNumberFunctorMaterial::validParams(), IntegralDirectedSurfaceForce::validParams(), GeneralFunctorFluidPropsTempl< is_ad >::validParams(), and LinearFVTurbulentViscosityWallFunctionBC::validParams().

◆ mu_eff

const std::string NS::mu_eff = "mu_eff"
static

Definition at line 129 of file NS.h.

Referenced by WCNSFVTurbulencePhysics::addMaterials().

◆ mu_t

const std::string NS::mu_t = "mu_t"
static

◆ mu_t_low_limit

constexpr Real NS::mu_t_low_limit = 1.0e-8
static

◆ mu_t_passive_scalar

const std::string NS::mu_t_passive_scalar = "mu_t_passive_scalar"
static

◆ pebble_diameter

const std::string NS::pebble_diameter = "pebble_diameter"
static

◆ porosity

const std::string NS::porosity = "porosity"
static

Definition at line 104 of file NS.h.

Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyTimeKernels(), WCNSFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addMassTimeKernels(), WCNSFVFlowPhysics::addMomentumAdvectionKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumGravityKernels(), WCNSFVFlowPhysics::addMomentumPressureKernels(), WCNSFVFlowPhysics::addMomentumViscousDissipationKernels(), WCNSFVFlowPhysics::addOutletBC(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyHeatConductionKernels(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyTimeKernels(), WCNSFVFlowPhysicsBase::addPorousMediumSpeedMaterial(), WCNSFVFlowPhysics::addRhieChowUserObjects(), WCNSFVScalarTransportPhysics::addScalarAdvectionKernels(), WCNSFVFlowPhysics::addSolverVariables(), INSFEFluidMassKernel::computeQpJacobian(), INSFEFluidMomentumKernel::computeQpJacobian(), INSFEFluidWallMomentumBC::computeQpJacobian(), INSFEFluidEnergyKernel::computeQpJacobian(), INSFEFluidMomentumBC::computeQpJacobian(), INSFEFluidWallMomentumBC::computeQpOffDiagJacobian(), INSFEFluidMomentumKernel::computeQpOffDiagJacobian(), INSFEFluidMomentumBC::computeQpOffDiagJacobian(), PorousFlowPorosityLinear::computeQpProperties(), INSFEFluidMassKernel::computeQpResidual(), INSFEFluidMomentumKernel::computeQpResidual(), INSFEFluidWallMomentumBC::computeQpResidual(), INSFEFluidEnergyKernel::computeQpResidual(), INSFEFluidMomentumBC::computeQpResidual(), BernoulliPressureVariable::initialSetup(), isPorosityJumpFace(), PINSFVRhieChowInterpolator::PINSFVRhieChowInterpolator(), PINSFVRhieChowInterpolatorSegregated::PINSFVRhieChowInterpolatorSegregated(), PCNSFVDensityTimeDerivative::validParams(), PINSFVEnergyTimeDerivative::validParams(), PINSFVMomentumPressurePorosityGradient::validParams(), PCNSFVMomentumFriction::validParams(), HasPorosityJumpFace::validParams(), PINSFVMomentumAdvection::validParams(), NSFVBase::validParams(), PINSFVMomentumDiffusion::validParams(), PINSFVMomentumFriction::validParams(), PINSFVMomentumPressure::validParams(), PWCNSFVMomentumFluxBC::validParams(), PWCNSFVMassTimeDerivative::validParams(), PINSFVRhieChowInterpolatorSegregated::validParams(), FVPorosityTimeDerivative::validParams(), PINSFVSpeedFunctorMaterial::validParams(), PINSFVMomentumBoussinesq::validParams(), PINSFVScalarFieldAdvection::validParams(), PINSFVMomentumGravity::validParams(), PINSFVMomentumPressureFlux::validParams(), PINSFVMomentumAdvectionOutflowBC::validParams(), PINSFVEnergyAnisotropicDiffusion::validParams(), LinearFrictionFactorFunctorMaterial::validParams(), GeneralFluidProps::validParams(), PINSFVFunctorBC::validParams(), HLLCUserObject::validParams(), PorousMixedVarMaterial::validParams(), PorousPrimitiveVarMaterial::validParams(), PorousConservedVarMaterial::validParams(), PINSFVRhieChowInterpolator::validParams(), PINSFVEnergyDiffusion::validParams(), PNSFVMomentumPressureFluxRZ::validParams(), GeneralFunctorFluidPropsTempl< is_ad >::validParams(), BernoulliPressureVariable::validParams(), FunctorPebbleBedDragCoefficients< FunctorErgunDragCoefficients >::validParams(), NSFVHeatFluxBC::validParams(), and NSFVFunctorHeatFluxBC::validParams().

◆ Prandtl

const std::string NS::Prandtl = "Pr"
static

◆ pressure

const std::string NS::pressure = "pressure"
static

Definition at line 56 of file NS.h.

Referenced by INSAction::act(), CNSAction::act(), PorousFlowBrineCO2::activityCoefficient(), INSAction::addINSMomentum(), INSAction::addINSNoBCBC(), INSAction::addINSPressureBC(), WCNSFVFluidHeatTransferPhysicsBase::addMaterials(), CNSAction::addNoPenetrationBC(), CNSAction::addNSMomentumInviscidFlux(), CNSAction::addSpecificTotalEnthalpyAux(), Water97FluidProperties::b23T(), Water97FluidProperties::b2bc(), Water97FluidProperties::b3ab(), SimpleFluidProperties::beta_from_p_T(), HeliumFluidProperties::beta_from_p_T(), TemperaturePressureFunctionFluidProperties::beta_from_p_T(), FlinakFluidProperties::beta_from_p_T(), StiffenedGasFluidProperties::c2_from_p_rho(), HelmholtzFluidProperties::c_from_p_T(), SimpleFluidProperties::c_from_p_T(), TabulatedFluidProperties::c_from_p_T(), Water97FluidProperties::c_from_p_T_template(), TabulatedFluidProperties::checkInputVariables(), PorousFlowBrineCO2::checkVariables(), IntegralDirectedSurfaceForce::computeFaceInfoIntegral(), PorousFlowFluidStateBaseMaterialTempl< is_ad >::computeQpProperties(), PBSodiumFluidProperties::cp_from_p_T(), HelmholtzFluidProperties::cp_from_p_T(), SodiumSaturationFluidProperties::cp_from_p_T(), SimpleFluidProperties::cp_from_p_T(), NaClFluidProperties::cp_from_p_T(), SalineMoltenSaltFluidProperties::cp_from_p_T(), StiffenedGasFluidProperties::cp_from_p_T(), TabulatedFluidProperties::cp_from_p_T(), Water97FluidProperties::cp_from_p_T(), TemperaturePressureFunctionFluidProperties::cp_from_p_T(), FlibeFluidProperties::cp_from_p_T(), HeliumFluidProperties::cp_from_p_T(), FlinakFluidProperties::cp_from_p_T(), Water97FluidProperties::cp_from_p_T_template(), BrineFluidProperties::cp_from_p_T_X(), PBSodiumFluidProperties::cv_from_p_T(), HelmholtzFluidProperties::cv_from_p_T(), SodiumSaturationFluidProperties::cv_from_p_T(), NaKFluidProperties::cv_from_p_T(), SimpleFluidProperties::cv_from_p_T(), NaClFluidProperties::cv_from_p_T(), StiffenedGasFluidProperties::cv_from_p_T(), TabulatedFluidProperties::cv_from_p_T(), Water97FluidProperties::cv_from_p_T(), TemperaturePressureFunctionFluidProperties::cv_from_p_T(), FlibeFluidProperties::cv_from_p_T(), FlinakFluidProperties::cv_from_p_T(), HeliumFluidProperties::cv_from_p_T(), Water97FluidProperties::cv_from_p_T_template(), PorousFlowBroadbridgeWhite::d2EffectiveSaturation(), PorousFlowBroadbridgeWhite::dEffectiveSaturation(), Water97FluidProperties::densityRegion3(), StiffenedGasTwoPhaseFluidProperties::dT_sat_dp(), NaKFluidProperties::e_from_p_rho(), TabulatedFluidProperties::e_from_p_rho(), HelmholtzFluidProperties::e_from_p_T(), NaKFluidProperties::e_from_p_T(), SodiumSaturationFluidProperties::e_from_p_T(), TabulatedFluidProperties::e_from_p_T(), NaClFluidProperties::e_from_p_T(), Water97FluidProperties::e_from_p_T(), SalineMoltenSaltFluidProperties::e_from_p_T(), TemperaturePressureFunctionFluidProperties::e_from_p_T(), FlibeFluidProperties::e_from_p_T(), HeliumFluidProperties::e_from_p_T(), FlinakFluidProperties::e_from_p_T(), Water97FluidProperties::e_from_p_T_template(), BrineFluidProperties::e_from_p_T_X(), PorousFlowBroadbridgeWhite::effectiveSaturation(), PorousFlowWaterNCG::equilibriumMassFractions(), PorousFlowBrineCO2::equilibriumMassFractions(), PorousFlowBrineCO2::equilibriumMoleFractions(), PorousFlowBrineCO2::equilibriumMoleFractionsLowTemp(), CavityPressureUserObject::execute(), PorousFlowBrineCO2::fugacityCoefficientCO2HighTemp(), PorousFlowBrineCO2::fugacityCoefficientH2OHighTemp(), PorousFlowBrineCO2::fugacityCoefficientsHighTemp(), PorousFlowBrineCO2::fugacityCoefficientsLowTemp(), PorousFlowBrineCO2::funcABHighTemp(), PorousFlowBrineCO2::funcABLowTemp(), PorousFlowWaterNCG::gasDensity(), PorousFlowWaterNCG::gasProperties(), PorousFlowBrineCO2::gasProperties(), GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), WCNSFVFlowPhysicsBase::getFlowVariableName(), LinearFVMomentumPressure::getPressureVariable(), SodiumSaturationFluidProperties::h_from_p_T(), HelmholtzFluidProperties::h_from_p_T(), NaKFluidProperties::h_from_p_T(), TabulatedFluidProperties::h_from_p_T(), NaClFluidProperties::h_from_p_T(), SimpleFluidProperties::h_from_p_T(), TemperaturePressureFunctionFluidProperties::h_from_p_T(), Water97FluidProperties::h_from_p_T(), FlibeFluidProperties::h_from_p_T(), FlinakFluidProperties::h_from_p_T(), HeliumFluidProperties::h_from_p_T(), Water97FluidProperties::h_from_p_T_template(), BrineFluidProperties::h_from_p_T_X(), PorousFlowFluidStateBaseMaterialTempl< is_ad >::initQpStatefulProperties(), Water97FluidProperties::inRegion(), Water97FluidProperties::inRegionPH(), NitrogenFluidProperties::k_from_p_T(), HydrogenFluidProperties::k_from_p_T(), TabulatedFluidProperties::k_from_p_T(), SalineMoltenSaltFluidProperties::k_from_p_T(), CO2FluidProperties::k_from_p_T(), Water97FluidProperties::k_from_p_T(), TemperaturePressureFunctionFluidProperties::k_from_p_T(), HeliumFluidProperties::k_from_p_T(), BrineFluidProperties::k_from_p_T_X(), TemperaturePressureFunctionFluidProperties::k_from_v_e(), PorousFlowWaterNCG::liquidDensity(), PorousFlowWaterNCG::liquidProperties(), PorousFlowBrineCO2::liquidProperties(), PorousFlowWaterNCG::massFractions(), PorousFlowBrineCO2::massFractions(), NitrogenFluidProperties::mu_from_p_T(), CO2FluidProperties::mu_from_p_T(), HydrogenFluidProperties::mu_from_p_T(), TabulatedFluidProperties::mu_from_p_T(), SalineMoltenSaltFluidProperties::mu_from_p_T(), Water97FluidProperties::mu_from_p_T(), TemperaturePressureFunctionFluidProperties::mu_from_p_T(), HeliumFluidProperties::mu_from_p_T(), BrineFluidProperties::mu_from_p_T_X(), TemperaturePressureFunctionFluidProperties::mu_from_v_e(), PrintMatricesNSProblem::onTimestepEnd(), CO2FluidProperties::p_from_rho_T(), SinglePhaseFluidProperties::p_T_from_h_s(), SinglePhaseFluidProperties::p_T_from_v_e(), SinglePhaseFluidProperties::p_T_from_v_h(), Water97FluidProperties::p_T_from_v_h(), PINSFVRhieChowInterpolator::pinsfvSetup(), NSMomentumInviscidBC::pressureQpResidualHelper(), NSEnergyInviscidBC::qpJacobianTermA(), NSEnergyInviscidBC::qpResidualHelper(), RhieChowInterpolatorBase::RhieChowInterpolatorBase(), RhieChowMassFlux::RhieChowMassFlux(), SodiumSaturationFluidProperties::rho_from_p_T(), PBSodiumFluidProperties::rho_from_p_T(), HelmholtzFluidProperties::rho_from_p_T(), TabulatedFluidProperties::rho_from_p_T(), CO2FluidProperties::rho_from_p_T(), SalineMoltenSaltFluidProperties::rho_from_p_T(), Water97FluidProperties::rho_from_p_T(), NaClFluidProperties::rho_from_p_T(), SimpleFluidProperties::rho_from_p_T(), TemperaturePressureFunctionFluidProperties::rho_from_p_T(), FlibeFluidProperties::rho_from_p_T(), FlinakFluidProperties::rho_from_p_T(), HeliumFluidProperties::rho_from_p_T(), Water97FluidProperties::rho_from_p_T_template(), BrineFluidProperties::rho_from_p_T_X(), NitrogenFluidProperties::rho_mu_from_p_T(), HydrogenFluidProperties::rho_mu_from_p_T(), CO2FluidProperties::rho_mu_from_p_T(), MultiComponentFluidProperties::rho_mu_from_p_T_X(), TabulatedFluidProperties::s_from_h_p(), Water97FluidProperties::s_from_h_p(), HelmholtzFluidProperties::s_from_p_T(), TabulatedFluidProperties::s_from_p_T(), PorousFlowWaterNCG::saturation(), PorousFlowBrineCO2::saturation(), ThermochimicaDataBase< is_nodal >::server(), INSAction::setKernelCommonParams(), INSAction::setNoBCCommonParams(), PorousFlowBrineCO2::solveEquilibriumMoleFractionHighTemp(), CO2FluidProperties::sublimationPressure(), Water97FluidProperties::subregion2ph(), Water97FluidProperties::subregion3(), Water97FluidProperties::subregion3ph(), HelmholtzFluidProperties::T_from_p_h(), TabulatedFluidProperties::T_from_p_h(), Water97FluidProperties::T_from_p_h(), Water97FluidProperties::T_from_p_h_ad(), NaKFluidProperties::T_from_p_rho(), TabulatedFluidProperties::T_from_p_rho(), TabulatedFluidProperties::T_from_p_s(), StiffenedGasTwoPhaseFluidProperties::T_sat(), Water97FluidProperties::temperature_from_ph1(), Water97FluidProperties::temperature_from_ph2a(), Water97FluidProperties::temperature_from_ph2b(), Water97FluidProperties::temperature_from_ph2c(), Water97FluidProperties::temperature_from_ph3a(), Water97FluidProperties::temperature_from_ph3b(), Water97FluidProperties::tempXY(), TEST_F(), PorousFlowWaterVapor::thermophysicalProperties(), PorousFlowWaterNCG::thermophysicalProperties(), PorousFlowBrineCO2::thermophysicalProperties(), PorousFlowWaterNCG::totalMassFraction(), PorousFlowBrineCO2::totalMassFraction(), PorousFlowWaterNCG::twoPhaseProperties(), PorousFlowBrineCO2::twoPhaseProperties(), SodiumSaturationFluidProperties::v_from_p_T(), TabulatedFluidProperties::v_from_p_T(), Water97FluidProperties::v_from_p_T(), TemperaturePressureFunctionFluidProperties::v_from_p_T(), FlibeFluidProperties::v_from_p_T(), FlinakFluidProperties::v_from_p_T(), Water97FluidProperties::v_from_p_T_template(), PINSFVMomentumPressurePorosityGradient::validParams(), INSFVMomentumPressure::validParams(), INSADMaterial::validParams(), MomentumFreeBC::validParams(), NSMomentumInviscidFluxWithGradP::validParams(), PressureGradient::validParams(), PCNSFVStrongBC::validParams(), NSEntropyError::validParams(), LinearFVMomentumPressure::validParams(), WCNSFV2PInterfaceAreaSourceSink::validParams(), INSBase::validParams(), InternalEnergyAux::validParams(), INSFVMomentumPressureFlux::validParams(), NSEnergyInviscidUnspecifiedBC::validParams(), INSADMomentumPressure::validParams(), NSEnergyInviscidSpecifiedNormalFlowBC::validParams(), INSStressComponentAux::validParams(), NSMomentumInviscidFlux::validParams(), NSEnergyInviscidSpecifiedDensityAndVelocityBC::validParams(), NSMomentumInviscidSpecifiedNormalFlowBC::validParams(), INSFVEnthalpyFunctorMaterial::validParams(), INSChorinCorrector::validParams(), PINSFVFunctorBC::validParams(), PorousMixedVarMaterial::validParams(), CNSFVHLLCSpecifiedPressureBC::validParams(), LinearFVEnthalpyFunctorMaterial::validParams(), RhoFromPTFunctorMaterial::validParams(), PCNSFVHLLCSpecifiedPressureBC::validParams(), PorousPrimitiveVarMaterial::validParams(), INSADMomentumNoBCBC::validParams(), NavierStokesLHDGAssemblyHelper::validParams(), EnthalpyAux::validParams(), PrintMatricesNSProblem::validParams(), PNSFVMomentumPressureFluxRZ::validParams(), INSProjection::validParams(), NSStagnationPressureBC::validParams(), GeneralFunctorFluidPropsTempl< is_ad >::validParams(), IntegralDirectedSurfaceForce::validParams(), NSPressurePin::validParams(), INSMomentumNoBCBCBase::validParams(), NSInitialCondition::validParams(), PNSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), NSSpecificTotalEnthalpyAux::validParams(), NSPressureNeumannBC::validParams(), RhieChowInterpolatorBase::validParams(), RhieChowMassFlux::validParams(), NSInitialCondition::value(), PNSInitialCondition::value(), NSFunctionInitialCondition::value(), TabulatedFluidProperties::vaporTemperature(), Water97FluidProperties::vaporTemperature(), SinglePhaseFluidProperties::vaporTemperature(), Water97FluidProperties::vaporTemperature_ad(), and TabulatedFluidProperties::writeTabulatedData().

◆ R

const std::string NS::R = "R"
static

◆ Reynolds

const std::string NS::Reynolds = "Re"
static

◆ Reynolds_hydraulic

const std::string NS::Reynolds_hydraulic = "Re_h"
static

◆ Reynolds_interstitial

const std::string NS::Reynolds_interstitial = "Re_i"
static

◆ rho_s

const std::string NS::rho_s = "rho_s"
static

◆ S

const std::string NS::S = "S"
static

◆ scalar_tau

const std::string NS::scalar_tau = "scalar_tau"
static

Definition at line 159 of file NS.h.

◆ smoothed_porosity

const std::string NS::smoothed_porosity = "smoothed_porosity"
static

◆ solid

const std::string NS::solid = "solid"
static

Definition at line 136 of file NS.h.

◆ sound_speed

const std::string NS::sound_speed = "sound_speed"
static

Definition at line 144 of file NS.h.

◆ source_scaling

const std::string NS::source_scaling = "source_scaling"
static

Definition at line 154 of file NS.h.

◆ specific_enthalpy

const std::string NS::specific_enthalpy = "h"
static

◆ specific_internal_energy

const std::string NS::specific_internal_energy = "e"
static

◆ specific_total_energy

const std::string NS::specific_total_energy = "et"
static

Definition at line 63 of file NS.h.

◆ specific_total_enthalpy

const std::string NS::specific_total_enthalpy = "ht"
static

◆ specific_volume

const std::string NS::specific_volume = "specific_volume"
static

◆ speed

const std::string NS::speed = "speed"
static

◆ superficial_density

const std::string NS::superficial_density = "superficial_rho"
static

Definition at line 34 of file NS.h.

Referenced by PNSInitialCondition::validParams(), and PNSInitialCondition::value().

◆ superficial_momentum_vector

const std::string NS::superficial_momentum_vector[3]
static
Initial value:
= {
static const std::string superficial_momentum_y
Definition: NS.h:40
static const std::string superficial_momentum_x
Definition: NS.h:39
static const std::string superficial_momentum_z
Definition: NS.h:41

Definition at line 42 of file NS.h.

◆ superficial_momentum_x

const std::string NS::superficial_momentum_x = "superficial_rhou"
static

◆ superficial_momentum_y

const std::string NS::superficial_momentum_y = "superficial_rhov"
static

◆ superficial_momentum_z

const std::string NS::superficial_momentum_z = "superficial_rhow"
static

◆ superficial_total_energy_density

const std::string NS::superficial_total_energy_density = "superficial_rho_et"
static

Definition at line 66 of file NS.h.

Referenced by PNSInitialCondition::validParams(), and PNSInitialCondition::value().

◆ superficial_total_enthalpy_density

const std::string NS::superficial_total_enthalpy_density = "superficial_rho_ht"
static

Definition at line 72 of file NS.h.

Referenced by PNSInitialCondition::validParams(), and PNSInitialCondition::value().

◆ superficial_velocity

const std::string NS::superficial_velocity = "superficial_velocity"
static

◆ superficial_velocity_vector

const std::string NS::superficial_velocity_vector[3]
static
Initial value:
= {
static const std::string superficial_velocity_y
Definition: NS.h:51
static const std::string superficial_velocity_z
Definition: NS.h:52
static const std::string superficial_velocity_x
Definition: NS.h:50

Definition at line 54 of file NS.h.

Referenced by WCNSFVFlowPhysicsBase::addPorousMediumSpeedMaterial().

◆ superficial_velocity_x

const std::string NS::superficial_velocity_x = "superficial_vel_x"
static

◆ superficial_velocity_y

const std::string NS::superficial_velocity_y = "superficial_vel_y"
static

◆ superficial_velocity_z

const std::string NS::superficial_velocity_z = "superficial_vel_z"
static

◆ T_fluid

const std::string NS::T_fluid = "T_fluid"
static

Definition at line 106 of file NS.h.

Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyAmbientConvection(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyAmbientConvection(), WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyWallBC(), WCNSFVFluidHeatTransferPhysicsBase::addMaterials(), WCNSLinearFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyAmbientConvection(), ADConvectionHeatTransfer3DBC::computeQpResidual(), ConjugateHTNumbersFunctorMaterialTempl< is_ad >::ConjugateHTNumbersFunctorMaterialTempl(), ConvectionHeatFluxFunctorMaterialTempl< is_ad >::ConvectionHeatFluxFunctorMaterialTempl(), GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), LinearFVMomentumBoussinesq::getTemperatureVariable(), FVConvectionCorrelationInterface::validParams(), PCNSFVStrongBC::validParams(), PINSFVEnergyAmbientConvection::validParams(), WCNSFVEnergyFluxBC::validParams(), PNSFVSolidHeatTransferPhysics::validParams(), LinearFVMomentumBoussinesq::validParams(), DittusBoelterFunctorMaterialTempl< is_ad >::validParams(), INSFVMomentumBoussinesq::validParams(), PorousPrimitiveVarMaterial::validParams(), LinearFVConvectiveHeatTransferBC::validParams(), LinearFVEnthalpyFunctorMaterial::validParams(), PorousMixedVarMaterial::validParams(), LinearFVVolumetricHeatTransfer::validParams(), GeneralFunctorFluidPropsTempl< is_ad >::validParams(), and WCNSFVFluidHeatTransferPhysicsBase::validParams().

◆ T_liquidus

const std::string NS::T_liquidus = "T_liquidus"
static

Definition at line 148 of file NS.h.

Referenced by WCNSFVTwoPhaseMixturePhysics::addPhaseChangeEnergySource().

◆ T_solid

const std::string NS::T_solid = "T_solid"
static

◆ T_solidus

const std::string NS::T_solidus = "T_solidus"
static

Definition at line 149 of file NS.h.

Referenced by WCNSFVTwoPhaseMixturePhysics::addPhaseChangeEnergySource().

◆ temperature

const std::string NS::temperature = "temperature"
static

Definition at line 59 of file NS.h.

Referenced by CNSAction::act(), PorousFlowBrineCO2::activityCoefficient(), PorousFlowBrineCO2::activityCoefficientCO2(), PorousFlowBrineCO2::activityCoefficientH2O(), PorousFlowBrineCO2::activityCoefficientHighTemp(), MortarGapHeatTransferAction::addMortarVariable(), CNSAction::addNSEnergyInviscidSpecifiedPressureBC(), CNSAction::addNSSUPGEnergy(), CNSAction::addNSSUPGMass(), CNSAction::addNSSUPGMomentum(), CNSAction::addPressureOrTemperatureAux(), Water97FluidProperties::b23p(), PBSodiumFluidProperties::beta_from_p_T(), SimpleFluidProperties::beta_from_p_T(), StiffenedGasFluidProperties::beta_from_p_T(), HeliumFluidProperties::beta_from_p_T(), TemperaturePressureFunctionFluidProperties::beta_from_p_T(), FlinakFluidProperties::beta_from_p_T(), GeochemicalSystem::buildTemperatureDependentQuantities(), HelmholtzFluidProperties::c_from_p_T(), SimpleFluidProperties::c_from_p_T(), TabulatedFluidProperties::c_from_p_T(), Water97FluidProperties::c_from_p_T_template(), TabulatedFluidProperties::checkInputVariables(), PorousFlowWaterNCG::checkVariables(), PorousFlowBrineCO2::checkVariables(), ComputeDilatationThermalExpansionFunctionEigenstrainTempl< is_ad >::computeDilatation(), PorousFlowFluidStateSingleComponentTempl< is_ad >::computeQpProperties(), PBSodiumFluidProperties::cp_from_p_T(), HelmholtzFluidProperties::cp_from_p_T(), SodiumSaturationFluidProperties::cp_from_p_T(), SimpleFluidProperties::cp_from_p_T(), NaKFluidProperties::cp_from_p_T(), NaClFluidProperties::cp_from_p_T(), SalineMoltenSaltFluidProperties::cp_from_p_T(), StiffenedGasFluidProperties::cp_from_p_T(), TabulatedFluidProperties::cp_from_p_T(), CaloricallyImperfectGas::cp_from_p_T(), Water97FluidProperties::cp_from_p_T(), TemperaturePressureFunctionFluidProperties::cp_from_p_T(), FlibeFluidProperties::cp_from_p_T(), HeliumFluidProperties::cp_from_p_T(), FlinakFluidProperties::cp_from_p_T(), Water97FluidProperties::cp_from_p_T_template(), BrineFluidProperties::cp_from_p_T_X(), PBSodiumFluidProperties::cv_from_p_T(), HelmholtzFluidProperties::cv_from_p_T(), SodiumSaturationFluidProperties::cv_from_p_T(), NaKFluidProperties::cv_from_p_T(), SimpleFluidProperties::cv_from_p_T(), NaClFluidProperties::cv_from_p_T(), StiffenedGasFluidProperties::cv_from_p_T(), CaloricallyImperfectGas::cv_from_p_T(), TabulatedFluidProperties::cv_from_p_T(), Water97FluidProperties::cv_from_p_T(), TemperaturePressureFunctionFluidProperties::cv_from_p_T(), FlibeFluidProperties::cv_from_p_T(), FlinakFluidProperties::cv_from_p_T(), HeliumFluidProperties::cv_from_p_T(), Water97FluidProperties::cv_from_p_T_template(), Water97FluidProperties::densityRegion3(), NaKFluidProperties::e_from_p_rho(), TemperaturePressureFunctionFluidProperties::e_from_p_rho(), Water97FluidProperties::e_from_p_rho_template(), HelmholtzFluidProperties::e_from_p_T(), SodiumSaturationFluidProperties::e_from_p_T(), NaKFluidProperties::e_from_p_T(), TabulatedFluidProperties::e_from_p_T(), NaClFluidProperties::e_from_p_T(), Water97FluidProperties::e_from_p_T(), SimpleFluidProperties::e_from_p_T(), SalineMoltenSaltFluidProperties::e_from_p_T(), TemperaturePressureFunctionFluidProperties::e_from_p_T(), HeliumFluidProperties::e_from_p_T(), FlibeFluidProperties::e_from_p_T(), FlinakFluidProperties::e_from_p_T(), Water97FluidProperties::e_from_p_T_template(), BrineFluidProperties::e_from_p_T_X(), PorousFlowWaterNCG::enthalpyOfDissolution(), PorousFlowBrineCO2::enthalpyOfDissolution(), PorousFlowBrineCO2::enthalpyOfDissolutionGas(), PorousFlowBrineCO2::equilibriumConstantCO2(), EquilibriumConstantFit::EquilibriumConstantFit(), PorousFlowBrineCO2::equilibriumConstantH2O(), EquilibriumConstantInterpolator::EquilibriumConstantInterpolator(), PorousFlowWaterNCG::equilibriumMassFractions(), PorousFlowBrineCO2::equilibriumMassFractions(), PorousFlowBrineCO2::equilibriumMoleFractions(), PorousFlowBrineCO2::equilibriumMoleFractionsLowTemp(), GeochemistrySpatialReactor::execute(), PBSodiumFluidProperties::F_enthalpy(), PorousFlowBrineCO2::fugacityCoefficientCO2HighTemp(), PorousFlowBrineCO2::fugacityCoefficientH2OHighTemp(), PorousFlowBrineCO2::fugacityCoefficientsHighTemp(), PorousFlowBrineCO2::fugacityCoefficientsLowTemp(), PorousFlowBrineCO2::funcABHighTemp(), PorousFlowBrineCO2::funcABLowTemp(), PorousFlowWaterNCG::gasDensity(), PorousFlowWaterNCG::gasProperties(), PorousFlowBrineCO2::gasProperties(), WCNSFVFlowPhysicsBase::getFlowVariableName(), PBSodiumFluidProperties::h_from_p_T(), SodiumSaturationFluidProperties::h_from_p_T(), HelmholtzFluidProperties::h_from_p_T(), NaKFluidProperties::h_from_p_T(), TabulatedFluidProperties::h_from_p_T(), NaClFluidProperties::h_from_p_T(), SalineMoltenSaltFluidProperties::h_from_p_T(), SimpleFluidProperties::h_from_p_T(), TemperaturePressureFunctionFluidProperties::h_from_p_T(), Water97FluidProperties::h_from_p_T(), FlibeFluidProperties::h_from_p_T(), FlinakFluidProperties::h_from_p_T(), HeliumFluidProperties::h_from_p_T(), Water97FluidProperties::h_from_p_T_template(), BrineFluidProperties::h_from_p_T_X(), BrineFluidProperties::haliteSolubility(), BrineFluidProperties::henryConstant(), PorousFlowBrineCO2::henryConstant(), Water97FluidProperties::henryConstant(), PorousFlowFluidStateSingleComponentTempl< is_ad >::initQpStatefulProperties(), Water97FluidProperties::inRegion(), PBSodiumFluidProperties::k_from_p_T(), MethaneFluidProperties::k_from_p_T(), SodiumSaturationFluidProperties::k_from_p_T(), NaKFluidProperties::k_from_p_T(), NitrogenFluidProperties::k_from_p_T(), HydrogenFluidProperties::k_from_p_T(), NaClFluidProperties::k_from_p_T(), StiffenedGasFluidProperties::k_from_p_T(), CaloricallyImperfectGas::k_from_p_T(), TabulatedFluidProperties::k_from_p_T(), SalineMoltenSaltFluidProperties::k_from_p_T(), CO2FluidProperties::k_from_p_T(), Water97FluidProperties::k_from_p_T(), TemperaturePressureFunctionFluidProperties::k_from_p_T(), FlibeFluidProperties::k_from_p_T(), HeliumFluidProperties::k_from_p_T(), FlinakFluidProperties::k_from_p_T(), Water97FluidProperties::k_from_p_T_template(), BrineFluidProperties::k_from_p_T_X(), NitrogenFluidProperties::k_from_rho_T(), HydrogenFluidProperties::k_from_rho_T(), CO2FluidProperties::k_from_rho_T(), Water97FluidProperties::k_from_rho_T(), Water97FluidProperties::k_from_rho_T_template(), TemperaturePressureFunctionFluidProperties::k_from_v_e(), FlibeFluidProperties::k_from_v_e(), FlinakFluidProperties::k_from_v_e(), Water97FluidProperties::k_from_v_e_template(), PorousFlowWaterNCG::liquidDensity(), PorousFlowWaterNCG::liquidProperties(), PorousFlowBrineCO2::liquidProperties(), PorousFlowWaterNCG::massFractions(), PorousFlowBrineCO2::massFractions(), ComputeMeanThermalExpansionFunctionEigenstrainTempl< is_ad >::meanThermalExpansionCoefficient(), CO2FluidProperties::meltingPressure(), PBSodiumFluidProperties::mu_from_p_T(), MethaneFluidProperties::mu_from_p_T(), NitrogenFluidProperties::mu_from_p_T(), CO2FluidProperties::mu_from_p_T(), HydrogenFluidProperties::mu_from_p_T(), NaKFluidProperties::mu_from_p_T(), SodiumSaturationFluidProperties::mu_from_p_T(), StiffenedGasFluidProperties::mu_from_p_T(), TabulatedFluidProperties::mu_from_p_T(), CaloricallyImperfectGas::mu_from_p_T(), SalineMoltenSaltFluidProperties::mu_from_p_T(), Water97FluidProperties::mu_from_p_T(), SimpleFluidProperties::mu_from_p_T(), TemperaturePressureFunctionFluidProperties::mu_from_p_T(), FlibeFluidProperties::mu_from_p_T(), HeliumFluidProperties::mu_from_p_T(), FlinakFluidProperties::mu_from_p_T(), Water97FluidProperties::mu_from_p_T_template(), BrineFluidProperties::mu_from_p_T_X(), PBSodiumFluidProperties::mu_from_rho_T(), NitrogenFluidProperties::mu_from_rho_T(), HydrogenFluidProperties::mu_from_rho_T(), CO2FluidProperties::mu_from_rho_T(), Water97FluidProperties::mu_from_rho_T(), Water97FluidProperties::mu_from_rho_T_template(), TemperaturePressureFunctionFluidProperties::mu_from_v_e(), FlibeFluidProperties::mu_from_v_e(), FlinakFluidProperties::mu_from_v_e(), HelmholtzFluidProperties::p_from_rho_T(), CO2FluidProperties::p_from_rho_T(), FlinakFluidProperties::p_from_v_e(), FlibeFluidProperties::p_from_v_e(), SodiumSaturationFluidProperties::p_from_v_e(), SimpleFluidProperties::p_from_v_e(), StiffenedGasTwoPhaseFluidProperties::p_sat(), SinglePhaseFluidProperties::p_T_from_h_s(), SinglePhaseFluidProperties::p_T_from_v_e(), SinglePhaseFluidProperties::p_T_from_v_h(), Water97FluidProperties::p_T_from_v_h(), CO2FluidProperties::partialDensity(), PorousFlowBrineCO2::partialDensityCO2(), SodiumSaturationFluidProperties::rho_from_p_T(), PBSodiumFluidProperties::rho_from_p_T(), HelmholtzFluidProperties::rho_from_p_T(), TabulatedFluidProperties::rho_from_p_T(), NaKFluidProperties::rho_from_p_T(), CO2FluidProperties::rho_from_p_T(), SalineMoltenSaltFluidProperties::rho_from_p_T(), NaClFluidProperties::rho_from_p_T(), Water97FluidProperties::rho_from_p_T(), SimpleFluidProperties::rho_from_p_T(), TemperaturePressureFunctionFluidProperties::rho_from_p_T(), FlibeFluidProperties::rho_from_p_T(), FlinakFluidProperties::rho_from_p_T(), HeliumFluidProperties::rho_from_p_T(), Water97FluidProperties::rho_from_p_T_template(), BrineFluidProperties::rho_from_p_T_X(), NitrogenFluidProperties::rho_mu_from_p_T(), HydrogenFluidProperties::rho_mu_from_p_T(), CO2FluidProperties::rho_mu_from_p_T(), Water97FluidProperties::rho_mu_from_p_T(), MultiComponentFluidProperties::rho_mu_from_p_T_X(), Water97FluidProperties::s_from_h_p(), HelmholtzFluidProperties::s_from_p_T(), TabulatedFluidProperties::s_from_p_T(), MethaneFluidProperties::saturatedLiquidDensity(), NitrogenFluidProperties::saturatedLiquidDensity(), CO2FluidProperties::saturatedLiquidDensity(), MethaneFluidProperties::saturatedVaporDensity(), NitrogenFluidProperties::saturatedVaporDensity(), CO2FluidProperties::saturatedVaporDensity(), PorousFlowWaterNCG::saturation(), PorousFlowBrineCO2::saturation(), ThermochimicaDataBase< is_nodal >::server(), GeochemistryActivityCoefficientsDebyeHuckel::setInternalParameters(), GeochemicalSystem::setTemperature(), CaloricallyImperfectGas::setupLookupTables(), PorousFlowBrineCO2::smoothCubicInterpolation(), PorousFlowBrineCO2::solveEquilibriumMoleFractionHighTemp(), CO2FluidProperties::sublimationPressure(), Water97FluidProperties::subregion3(), Water97FluidProperties::T_drhodT_from_p_rho(), PBSodiumFluidProperties::T_from_p_h(), Water97FluidProperties::T_from_p_h(), Water97FluidProperties::T_from_p_h_ad(), FlibeFluidProperties::T_from_p_rho(), FlinakFluidProperties::T_from_p_rho(), PBSodiumFluidProperties::temperature_correction(), TEST_F(), PorousFlowWaterNCG::thermophysicalProperties(), PorousFlowBrineCO2::thermophysicalProperties(), PorousFlowWaterNCG::totalMassFraction(), PorousFlowBrineCO2::totalMassFraction(), PorousFlowWaterNCG::twoPhaseProperties(), PorousFlowBrineCO2::twoPhaseProperties(), umat_(), SodiumSaturationFluidProperties::v_from_p_T(), TabulatedFluidProperties::v_from_p_T(), Water97FluidProperties::v_from_p_T(), TemperaturePressureFunctionFluidProperties::v_from_p_T(), FlibeFluidProperties::v_from_p_T(), FlinakFluidProperties::v_from_p_T(), Water97FluidProperties::v_from_p_T_template(), NSLiquidFractionAux::validParams(), INSElementIntegralEnergyAdvectionTempl< is_ad >::validParams(), RhoFromPTFunctorMaterial::validParams(), NSSUPGBase::validParams(), NSStagnationTemperatureBC::validParams(), NSEnergyThermalFlux::validParams(), PCNSFVHLLCSpecifiedMassFluxAndTemperatureBC::validParams(), CNSFVHLLCSpecifiedMassFluxAndTemperatureBC::validParams(), AriaLaserWeld304LStainlessSteelFunctorMaterial::validParams(), INSAction::validParams(), NSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), PNSInitialCondition::validParams(), NSEnergyViscousBC::validParams(), NSEnergyInviscidBC::validParams(), NavierStokesMaterial::validParams(), NSInitialCondition::value(), PNSInitialCondition::value(), NSFunctionInitialCondition::value(), MethaneFluidProperties::vaporPressure(), NitrogenFluidProperties::vaporPressure(), HydrogenFluidProperties::vaporPressure(), CO2FluidProperties::vaporPressure(), TabulatedFluidProperties::vaporPressure(), BrineFluidProperties::vaporPressure(), Water97FluidProperties::vaporPressure(), SinglePhaseFluidProperties::vaporPressure(), Water97FluidProperties::vaporPressureTemplate(), and TabulatedFluidProperties::writeTabulatedData().

◆ thermal_diffusivity

const std::string NS::thermal_diffusivity = "thermal_diffusivity"
static

◆ TKE

const std::string NS::TKE = "tke"
static

◆ TKED

const std::string NS::TKED = "epsilon"
static

◆ total_energy_density

const std::string NS::total_energy_density = "rho_et"
static

◆ total_enthalpy_density

const std::string NS::total_enthalpy_density = "rho_ht"
static

Definition at line 71 of file NS.h.

◆ total_pressure

const std::string NS::total_pressure = "pressure_total"
static

◆ total_viscosity

const std::string NS::total_viscosity = "total_viscosity"
static

◆ turbulent_Prandtl

const std::string NS::turbulent_Prandtl = "Pr_t"
static

◆ v

const std::string NS::v = "v"
static

Definition at line 84 of file NS.h.

Referenced by RigidBodyMultiKernelAction::act(), GrainGrowthAction::act(), GrainGrowthLinearizedInterfaceAction::act(), CommonSolidMechanicsAction::act(), PolycrystalKernelAction::act(), PolycrystalStoredEnergyAction::act(), GrainGrowthAction::addBnds(), GradientOperatorCoordinates::AxisymmetricCylindrical::addGradOp(), GradientOperatorCoordinates::CentrosymmetricSpherical::addGradOp(), ElemExtrema::atVertex(), TraceRayTools::atVertex(), ClaimRays::buildPointNeighbors(), InterfaceMeshCut2DUserObject::calculateSignedDistance(), DisplacementAboutAxis::calculateTransformationMatrices(), StudentT::cdf(), StochasticTools::BiasCorrectedAccelerated< InType, OutType >::compute(), FluidPropertiesInterrogator::compute1Phase(), RZSymmetry::computeCircumference(), PODReducedBasisTrainer::computeEigenDecomposition(), HillElastoPlasticityStressUpdateTempl< is_ad >::computeElasticityTensorEigenDecomposition(), RDG3EqnMaterial::computeElementPrimitiveVariables(), ADNumericalFlux3EqnCentered::computeFlux(), HillPlasticityStressUpdateTempl< is_ad >::computeHillTensorEigenDecomposition(), StochasticTools::POD::computePOD(), FlowModelGasMixUtils::computePrimitiveSolution(), FlowModel1PhaseUtils::computePrimitiveSolutionVector(), CosseratStressDivergenceTensors::computeQpOffDiagJacobian(), ACInterfaceKobayashi1::computeQpOffDiagJacobian(), InertialTorque::computeQpOffDiagJacobian(), MomentBalancing::computeQpOffDiagJacobian(), PorousFlowDarcyVelocityMaterial::computeQpProperties(), PorousMixedVarMaterial::computeQpProperties(), PorousPrimitiveVarMaterial::computeQpProperties(), PorousFlowAqueousPreDisChemistry::computeQpProperties(), PorousFlowMassFractionAqueousEquilibriumChemistry::computeQpProperties(), PorousFlowEffectiveFluidPressureTempl< is_ad >::computeQpProperties(), PorousFlowThermalConductivityIdealTempl< is_ad >::computeQpProperties(), PorousFlowMatrixInternalEnergyTempl< is_ad >::computeQpProperties(), PorousFlowPorosityHMBiotModulus::computeQpProperties(), PorousFlowPermeabilityKozenyCarmanBaseTempl< is_ad >::computeQpProperties(), PorousFlowThermalConductivityFromPorosityTempl< is_ad >::computeQpProperties(), PorousFlowTotalGravitationalDensityFullySaturatedFromPorosity::computeQpProperties(), PorousFlowPermeabilityExponentialTempl< is_ad >::computeQpProperties(), PorousFlowPorosityExponentialBase::computeQpProperties(), PorousFlowJoinerTempl< is_ad >::computeQpProperties(), INSFVMassAdvection::computeQpResidual(), NSFVOutflowTemperatureBC::computeQpResidual(), INSFVEnergyAdvection::computeQpResidual(), INSFVScalarFieldAdvection::computeQpResidual(), INSFVTurbulentAdvection::computeQpResidual(), INSFVMassAdvectionOutflowBC::computeQpResidual(), DiscreteLineSegmentInterface::computeRadialCoordinate(), computeShearStrainRateNormSquared(), THMSpecificVolumeAux::computeValue(), OptimizationFunctionAuxTest::computeValue(), PorousFlowElementNormal::computeValue(), StagnationTemperatureAux::computeValue(), StagnationPressureAux::computeValue(), SurrogateModelAuxKernelTempl< ComputeValueType >::computeValue(), FluidPropertiesInterrogator::computeVaporMixture(), InterWrapper1PhaseProblem::createPetscVector(), SubChannel1PhaseProblem::createPetscVector(), dataLoad(), dataStore(), MultiParameterPlasticityStressUpdate::dVardTrial(), StabilizationUtils::elementAverage(), INSFVMomentumAdvectionOutflowBC::gatherRCData(), SCMDetailedQuadInterWrapperMeshGenerator::generate(), NSPressureDerivs< NSPressureNeumannBC >::get_grad(), NSPressureDerivs< NSPressureNeumannBC >::get_hess(), LAROMANCEStressUpdateBaseTempl< is_ad >::getMakeFrameHelper(), SumPostprocessor::getValue(), INSFVRhieChowInterpolator::getVelocity(), GradientOperator< C >::gradOp(), ConstantViewFactorSurfaceRadiation::initialize(), SurrogateModelScalarAux::initialSetup(), TraceRayTools::intersectTriangle(), ViewFactorBase::maxDevReciprocity(), ViewFactorBase::maxDevRowSum(), RayTracingAngularQuadrature::orthonormalVector(), StudentT::pdf(), Xfem::polyhedron_volume_3d(), ACInterfaceKobayashi1::precomputeQpJacobian(), ADACInterfaceKobayashi1::precomputeQpResidual(), ACInterfaceKobayashi1::precomputeQpResidual(), StudentT::quantile(), Xfem::r8vec_norm(), EBSDReader::readFile(), SolidMechanicsPlasticMohrCoulombMulti::returnTip(), NormalSampler::sample(), Simulation::setupInitialConditionsFromFile(), StochasticTools::stochasticAllGather(), StochasticTools::stochasticGather(), TEST(), TEST_F(), THMParsedFunctionWrapper::THMParsedFunctionWrapper(), THM::v_from_arhoA_alpha_A(), THM::v_from_rho(), THM::v_from_rhoA_A(), FourierNoise::value(), FlowModelGasMixIC::value(), PorousFlowFluidStateFlash::vaporMassFraction(), WCNSFVFluxBCBase::varVelocity(), ViewFactorBase::ViewFactorBase(), and WCNSFV2PSlipVelocityFunctorMaterial::WCNSFV2PSlipVelocityFunctorMaterial().

◆ vector_tau

const std::string NS::vector_tau = "vector_tau"
static

Definition at line 158 of file NS.h.

◆ velocity

const std::string NS::velocity = "velocity"
static

Definition at line 45 of file NS.h.

Referenced by INSAction::act(), INSAction::addINSMomentum(), INSAction::addINSNoBCBC(), INSAction::addINSTemperature(), INSAction::addINSTimeKernels(), INSAction::addINSVelocityAux(), INSAction::addINSVelocityBC(), INSFVInletIntensityTKEBC::boundaryValue(), INSFVTurbulentViscosityWallFunction::boundaryValue(), INSFVTKEDWallFunctionBC::boundaryValue(), LinearFVTKESourceSink::computeMatrixContribution(), PorousFlowDispersiveFlux::computeQpJac(), DashpotBC::computeQpJacobian(), DashpotBC::computeQpOffDiagJacobian(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), WCNSFV2PInterfaceAreaSourceSink::computeQpResidual(), PorousFlowDispersiveFlux::computeQpResidual(), NSEnergyViscousFlux::computeQpResidual(), INSFVTKESourceSink::computeQpResidual(), FVPorousFlowDispersiveFlux::computeQpResidual(), INSFVTKEDSourceSink::computeQpResidual(), DashpotBC::computeQpResidual(), LinearFVTKEDSourceSink::computeRightHandSideContribution(), computeSpeed(), INSFVWallFunctionBC::computeStrongResidual(), LinearFVTurbulentViscosityWallFunctionBC::computeTurbulentViscosity(), WallFunctionWallShearStressAux::computeValue(), WallFunctionYPlusAux::computeValue(), RANSYPlusAux::computeValue(), kEpsilonViscosityAux::computeValue(), INSFVRhieChowInterpolator::getVelocity(), InterfaceMeshCutUserObjectBase::initialize(), INSFVRhieChowInterpolator::INSFVRhieChowInterpolator(), INSFVRhieChowInterpolatorSegregated::INSFVRhieChowInterpolatorSegregated(), NSFVDispersePhaseDragFunctorMaterial::NSFVDispersePhaseDragFunctorMaterial(), PINSFVSpeedFunctorMaterial::PINSFVSpeedFunctorMaterial(), INSElementIntegralEnergyAdvectionTempl< is_ad >::validParams(), and PINSFVSpeedFunctorMaterial::validParams().

◆ velocity_vector

const std::string NS::velocity_vector[3] = {velocity_x, velocity_y, velocity_z}

◆ velocity_x

const std::string NS::velocity_x = "vel_x"
static

◆ velocity_y

const std::string NS::velocity_y = "vel_y"
static

◆ velocity_z

const std::string NS::velocity_z = "vel_z"
static

◆ von_karman_constant

constexpr Real NS::von_karman_constant = 0.4187
static

◆ wall_distance

const std::string NS::wall_distance = "wall_distance"
static

Definition at line 30 of file NS.h.

◆ wall_porosity

const std::string NS::wall_porosity = "wall_porosity"
static

Definition at line 29 of file NS.h.

◆ wall_shear_stress

const std::string NS::wall_shear_stress = "wall_shear_stress"
static

Definition at line 75 of file NS.h.

◆ wall_yplus

const std::string NS::wall_yplus = "wall_yplus"
static

Definition at line 76 of file NS.h.

◆ Z

const std::string NS::Z = "Z"
static