www.mooseframework.org
Namespaces | Enumerations | Functions | Variables
NS Namespace Reference

Namespaces

 phase
 
 settings
 
 splitting
 

Enumerations

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...
 
ADReal findUStar (const ADReal &mu, const ADReal &rho, const ADReal &u, Real dist)
 Finds the friction velocity using standard velocity wall functions formulation. More...
 
ADReal findyPlus (const ADReal &mu, const ADReal &rho, const ADReal &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...
 
ADReal computeSpeed (const ADRealVectorValue &velocity)
 Compute the speed (velocity norm) given the supplied velocity. More...
 
void getWallBoundedElements (const std::vector< BoundaryName > &wall_boundary_name, const FEProblemBase &fe_problem, const SubProblem &subproblem, const std::set< SubdomainID > &block_ids, std::map< const Elem *, bool > &wall_bounded_map)
 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...
 
std::string grad (const std::string &var)
 
std::string time_deriv (const std::string &var)
 
std::tuple< bool, ADReal, ADRealisPorosityJumpFace (const Moose::Functor< ADReal > &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...
 

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 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 mu_eff = "mu_eff"
 
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 k = "k"
 
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 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 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 = "k"
 
static const std::string TKED = "epsilon"
 
static constexpr Real von_karman_constant = 0.4187
 
static constexpr Real E_turb_constant = 9.793
 

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:197

Function Documentation

◆ 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()

ADReal NS::computeSpeed ( const ADRealVectorValue velocity)

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

Definition at line 123 of file NavierStokesMethods.C.

Referenced by INSFVTurbulentViscosityWallFunction::boundaryValue(), PorousPrimitiveVarMaterial::computeQpProperties(), ConservedVarValuesMaterial::computeQpProperties(), PorousMixedVarMaterial::computeQpProperties(), PorousConservedVarMaterial::computeQpProperties(), INSADTauMaterialTempl< INSAD3Eqn >::computeQpProperties(), INSFVTKESourceSink::computeQpResidual(), INSFVTKEDSourceSink::computeQpResidual(), LinearFrictionFactorFunctorMaterial::LinearFrictionFactorFunctorMaterial(), NSFVDispersePhaseDragFunctorMaterial::NSFVDispersePhaseDragFunctorMaterial(), and PINSFVSpeedFunctorMaterial::PINSFVSpeedFunctorMaterial().

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

◆ 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(), 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 157 of file NavierStokesMethods.h.

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

162 {
163  mooseAssert((coord_sys == Moose::COORD_XYZ) || (coord_sys == Moose::COORD_RZ),
164  "This function only supports calculations of divergence in Cartesian and "
165  "axisymmetric coordinate systems");
166  auto div = gradient.tr();
167  if (coord_sys == Moose::COORD_RZ)
168  // u_r / r
169  div += value(rz_radial_coord) / point(rz_radial_coord);
170  return div;
171 }
Real value(unsigned n, unsigned alpha, unsigned beta, Real x)

◆ findUStar()

ADReal NS::findUStar ( const ADReal mu,
const ADReal rho,
const ADReal 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

Definition at line 64 of file NavierStokesMethods.C.

Referenced by INSFVTKEDWallFunctionBC::boundaryValue(), INSFVTurbulentViscosityWallFunction::boundaryValue(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), INSFVWallFunctionBC::computeStrongResidual(), WallFunctionYPlusAux::computeValue(), and WallFunctionWallShearStressAux::computeValue().

65 {
66  // usually takes about 3-4 iterations
67  constexpr int MAX_ITERS{50};
68  constexpr Real REL_TOLERANCE{1e-6};
69 
70  const ADReal nu = mu / rho;
71 
72  ADReal u_star = std::sqrt(nu * u / dist);
73 
74  // Newton-Raphson method to solve for u_star (friction velocity).
75  for (int i = 0; i < MAX_ITERS; ++i)
76  {
77  ADReal residual = u_star / NS::von_karman_constant * std::log(u_star * dist / (0.111 * nu)) - u;
78  ADReal deriv = (1 + std::log(u_star * dist / (0.111 * nu))) / NS::von_karman_constant;
79  ADReal new_u_star = std::max(1e-20, u_star - residual / deriv);
80 
81  Real rel_err = std::abs((new_u_star.value() - u_star.value()) / new_u_star.value());
82 
83  u_star = new_u_star;
84  if (rel_err < REL_TOLERANCE)
85  return u_star;
86  }
87 
88  mooseException("Could not find the wall friction velocity (mu: ",
89  mu,
90  " rho: ",
91  rho,
92  " velocity: ",
93  u,
94  " wall distance: ",
95  dist,
96  ")");
97 }
static constexpr Real von_karman_constant
Definition: NS.h:165
ADRealEigenVector< T, D, asd > sqrt(const ADRealEigenVector< T, D, asd > &)
ADRealEigenVector< T, D, asd > abs(const ADRealEigenVector< T, D, asd > &)
Real deriv(unsigned n, unsigned alpha, unsigned beta, Real x)
static const std::string mu
Definition: NS.h:122
DualReal ADReal
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real

◆ findyPlus()

ADReal NS::findyPlus ( const ADReal mu,
const ADReal rho,
const ADReal 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 100 of file NavierStokesMethods.C.

Referenced by INSFVTurbulentViscosityWallFunction::boundaryValue(), INSFVTKESourceSink::computeQpResidual(), and INSFVTKEDSourceSink::computeQpResidual().

101 {
102  // Fixed point iteration method to find y_plus
103  // It should take 3 or 4 iterations
104  constexpr int MAX_ITERS{10};
105  constexpr Real REL_TOLERANCE{1e-2};
106 
107  ADReal yPlusLast = 0.0;
108  ADReal yPlus = dist * u * rho / mu; // Assign intitial value to laminar
109  const ADReal rev_yPlusLam = 1.0 / yPlus;
110  const ADReal kappa_time_Re = NS::von_karman_constant * u * dist / (mu / rho);
111  unsigned int iters = 0;
112 
113  do
114  {
115  yPlusLast = yPlus;
116  yPlus = (kappa_time_Re + yPlus) / (1.0 + std::log(NS::E_turb_constant * yPlus));
117  } while (rev_yPlusLam * (yPlus - yPlusLast) > REL_TOLERANCE && ++iters < MAX_ITERS);
118 
119  return std::max(0.0, yPlus);
120 }
static constexpr Real von_karman_constant
Definition: NS.h:165
static const std::string mu
Definition: NS.h:122
DualReal ADReal
DIE A HORRIBLE DEATH HERE typedef LIBMESH_DEFAULT_SCALAR_TYPE Real
static constexpr Real E_turb_constant
Definition: NS.h:166

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

Definition at line 192 of file NavierStokesMethods.C.

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

197 {
198 
199  face_info_map.clear();
200 
201  for (const auto & elem : fe_problem.mesh().getMesh().active_element_ptr_range())
202  if (block_ids.find(elem->subdomain_id()) != block_ids.end())
203  for (const auto i_side : elem->side_index_range())
204  {
205  const auto & side_bnds = subproblem.mesh().getBoundaryIDs(elem, i_side);
206  for (const auto & name : wall_boundary_name)
207  {
208  const auto wall_id = subproblem.mesh().getBoundaryID(name);
209  for (const auto side_id : side_bnds)
210  if (side_id == wall_id)
211  {
212  const FaceInfo * fi = subproblem.mesh().faceInfo(elem, i_side);
213  face_info_map[elem].push_back(fi);
214  }
215  }
216  }
217 }
virtual MooseMesh & mesh()=0
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::map< const Elem *, bool > &  wall_bounded_map 
)

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

Bounded element maps for wall treatement.

Definition at line 134 of file NavierStokesMethods.C.

Referenced by INSFVTurbulentAdvection::initialSetup(), INSFVTKESourceSink::initialSetup(), INSFVTKEDSourceSink::initialSetup(), kEpsilonViscosityAux::initialSetup(), and INSFVTurbulentDiffusion::initialSetup().

139 {
140 
141  wall_bounded_map.clear();
142 
143  for (const auto & elem : fe_problem.mesh().getMesh().active_element_ptr_range())
144  {
145  if (block_ids.find(elem->subdomain_id()) != block_ids.end())
146  for (const auto i_side : elem->side_index_range())
147  {
148  const auto & side_bnds = subproblem.mesh().getBoundaryIDs(elem, i_side);
149  for (const auto & name : wall_boundary_name)
150  {
151  const auto wall_id = subproblem.mesh().getBoundaryID(name);
152  for (const auto side_id : side_bnds)
153  if (side_id == wall_id)
154  wall_bounded_map[elem] = true;
155  }
156  }
157  }
158 }
virtual MooseMesh & mesh()=0
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

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

Definition at line 162 of file NavierStokesMethods.C.

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

167 {
168 
169  dist_map.clear();
170 
171  for (const auto & elem : fe_problem.mesh().getMesh().active_element_ptr_range())
172  if (block_ids.find(elem->subdomain_id()) != block_ids.end())
173  for (const auto i_side : elem->side_index_range())
174  {
175  const auto & side_bnds = subproblem.mesh().getBoundaryIDs(elem, i_side);
176  for (const auto & name : wall_boundary_name)
177  {
178  const auto wall_id = subproblem.mesh().getBoundaryID(name);
179  for (const auto side_id : side_bnds)
180  if (side_id == wall_id)
181  {
182  const FaceInfo * const fi = subproblem.mesh().faceInfo(elem, i_side);
183  const Real dist = std::abs((fi->elemCentroid() - fi->faceCentroid()) * fi->normal());
184  dist_map[elem].push_back(dist);
185  }
186  }
187  }
188 }
virtual MooseMesh & mesh()=0
const Point & faceCentroid() const
ADRealEigenVector< T, D, asd > abs(const ADRealEigenVector< T, D, asd > &)
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()

std::tuple< bool, ADReal, ADReal > NS::isPorosityJumpFace ( const Moose::Functor< ADReal > &  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 58 of file NSFVUtils.C.

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

61 {
62  if (!fi.neighborPtr() || (fi.elem().subdomain_id() == fi.neighbor().subdomain_id()))
63  // We've agreed to only support porosity jump treatment at subdomain boundaries
64  return {false, 0, 0};
65 
66  mooseAssert(porosity.hasBlocks(fi.elem().subdomain_id()) &&
67  porosity.hasBlocks(fi.neighbor().subdomain_id()),
68  "Porosity should have blocks on both elem and neighbor");
69 
70  const Moose::FaceArg face_elem{
71  &fi, Moose::FV::LimiterType::CentralDifference, true, false, fi.elemPtr()};
72  const Moose::FaceArg face_neighbor{
74  const auto eps_elem = porosity(face_elem, time), eps_neighbor = porosity(face_neighbor, time);
75  return {!MooseUtils::relativeFuzzyEqual(eps_elem, eps_neighbor), eps_elem, eps_neighbor};
76 }
const Elem & elem() const
static const std::string porosity
Definition: NS.h:102
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)

◆ 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 GeneralFunctorFluidProps::GeneralFunctorFluidProps().

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:120
static const std::string mu
Definition: NS.h:122
static const std::string k
Definition: NS.h:124

◆ 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 GeneralFunctorFluidProps::GeneralFunctorFluidProps().

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:122

◆ time_deriv()

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

Variable Documentation

◆ A

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

Definition at line 146 of file NS.h.

◆ acceleration

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

◆ alpha

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

Definition at line 126 of file NS.h.

Referenced by SolidMechanicsPlasticWeakPlaneShear::activeConstraints(), SolidMechanicsPlasticWeakPlaneTensile::activeConstraints(), PorousFlowActionBase::addCapillaryPressureVG(), ElbowPipe1Phase::buildMeshNodes(), MultiPlasticityLinearSystem::calculateJacobian(), PorousFlowVanGenuchten::capillaryPressure(), PorousFlowVanGenuchten::capillaryPressureHys(), Beta::cdf(), Gamma::cdf(), StochasticTools::BiasCorrectedAccelerated< std::vector< InType >, std::vector< OutType > >::compute(), StochasticTools::BiasCorrectedAccelerated< InType, OutType >::compute(), PCNSFVKT::computeAlphaAndOmega(), ExponentialSoftening::computeCrackingRelease(), ADExponentialSoftening::computeCrackingRelease(), PCNSFVKT::computeFaceFlux(), ADShaftConnectedPump1PhaseUserObject::computeFluxesAndResiduals(), ADShaftConnectedTurbine1PhaseUserObject::computeFluxesAndResiduals(), ADShaftConnectedCompressor1PhaseUserObject::computeFluxesAndResiduals(), TotalLagrangianStressDivergenceBaseS< G >::computeQpJacobianDisplacement(), TotalLagrangianStressDivergenceBase< G >::computeQpJacobianDisplacement(), UpdatedLagrangianStressDivergenceBase< G >::computeQpJacobianDisplacement(), HomogenizedTotalLagrangianStressDivergenceR::computeQpJacobianDisplacement(), HomogenizedTotalLagrangianStressDivergenceA::computeQpJacobianDisplacement(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), PCNSFVKT::computeQpResidual(), HomogenizedTotalLagrangianStressDivergenceR::computeScalarQpOffDiagJacobian(), DensityUpdateTwoConstraints::computeUpdatedDensity(), XFEMCutElem::computeXFEMWeights(), NormalSampler::computeZ(), SolidMechanicsPlasticMeanCapTC::consistentTangentOperator(), RichardsSUPGstandard::cosh_relation(), RichardsSUPGstandard::cosh_relation_prime(), PertinentGeochemicalSystem::createModel(), LeadFluidProperties::cv_from_p_T(), LeadBismuthFluidProperties::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(), StochasticTools::GaussianProcessHandler::formFunctionGradient(), StochasticTools::GaussianProcessHandler::getGradientAdam(), 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(), THM::v_from_arhoA_alpha_A(), NSFVMixturePhaseInterface::validParams(), NSFVEnergyAmbientConvection::validParams(), and NSFVBase< Action >::validParams().

◆ alpha_boussinesq

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

Definition at line 111 of file NS.h.

Referenced by INSFVMomentumBoussinesq::validParams().

◆ alpha_wall

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

Definition at line 127 of file NS.h.

◆ axis

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

◆ c

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

Definition at line 133 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 138 of file NS.h.

Referenced by CNSAction::act(), QuasiStaticSolidMechanicsPhysics::actOutputMatProp(), 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(), GeneralizedPlaneStrainOffDiagNOSPD::computeDispFullOffDiagJacobianScalar(), GeneralizedPlaneStrainOffDiagOSPD::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(), PenaltyFrictionUserObject::getTangentialVelocity(), GradientOperator< C >::gradOp(), TotalLagrangianStressDivergenceBase< G >::gradTest(), TotalLagrangianStressDivergenceBaseS< G >::gradTest(), UpdatedLagrangianStressDivergenceBase< G >::gradTest(), TotalLagrangianStressDivergenceBaseS< G >::gradTrial(), TotalLagrangianStressDivergenceBase< G >::gradTrial(), UpdatedLagrangianStressDivergenceBase< G >::gradTrial(), TotalLagrangianStressDivergenceBaseS< G >::gradTrialStabilized(), TotalLagrangianStressDivergenceBase< G >::gradTrialStabilized(), UpdatedLagrangianStressDivergenceBase< G >::gradTrialStabilized(), TotalLagrangianStressDivergenceBase< G >::gradTrialUnstabilized(), TotalLagrangianStressDivergenceBaseS< G >::gradTrialUnstabilized(), UpdatedLagrangianStressDivergenceBase< G >::gradTrialUnstabilized(), HSBoundaryInterface::HSBoundaryInterface(), Simulation::identifyLoops(), PetscProjectSolutionOntoBounds::lineSearch(), TotalLagrangianStressDivergenceBaseS< G >::precalculateJacobianDisplacement(), TotalLagrangianStressDivergenceBase< G >::precalculateJacobianDisplacement(), UpdatedLagrangianStressDivergenceBase< G >::precalculateJacobianDisplacement(), ADComputeFiniteShellStrain::updatedxyz(), ADComputeFiniteShellStrain::updateGVectors(), NormalMortarMechanicalContact::validParams(), TangentialMortarMechanicalContact::validParams(), MortarGenericTraction::validParams(), JinSlabCoeffFunc::validParams(), MMSTestFunc::validParams(), PorousFlowElementNormal::validParams(), CartesianMortarMechanicalContact::validParams(), VectorTransientAbsorbingBC::validParams(), EMRobinBC::validParams(), VectorCurrentSource::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 120 of file NS.h.

Referenced by NSFVBase< Action >::addEnthalpyMaterial(), NSFVBase< Action >::addINSEnergyInletBC(), NSFVBase< Action >::addINSEnergyTimeKernels(), NSFVBase< Action >::addWCNSEnergyMixingLengthKernels(), NSFVBase< Action >::addWCNSEnergyTimeKernels(), AriaLaserWeld304LStainlessSteelFunctorMaterial::AriaLaserWeld304LStainlessSteelFunctorMaterial(), WCNSFVInletTemperatureBC::boundaryValue(), ThermalFunctionSolidPropertiesTest::buildObjects(), ADSimpleTurbine1PhaseUserObject::computeFluxesAndResiduals(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), PrandtlNumberAux::computeValue(), FluidPropertiesInterrogator::computeVaporMixture(), HelmholtzFluidProperties::cp_from_p_T(), SodiumSaturationFluidProperties::cp_from_p_T(), SimpleFluidProperties::cp_from_p_T(), NaKFluidProperties::cp_from_p_T(), StiffenedGasFluidProperties::cp_from_p_T(), TabulatedFluidProperties::cp_from_p_T(), SalineMoltenSaltFluidProperties::cp_from_p_T(), LeadBismuthFluidProperties::cp_from_p_T(), LeadFluidProperties::cp_from_p_T(), CaloricallyImperfectGas::cp_from_p_T(), IdealRealGasMixtureFluidProperties::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(), IdealRealGasMixtureFluidProperties::cp_from_T_v(), StiffenedGasFluidProperties::cp_from_v_e(), LinearFluidProperties::cp_from_v_e(), CaloricallyImperfectGas::cp_from_v_e(), TestSinglePhaseFluidProperties::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(), TabulatedFluidProperties::cp_from_v_e(), HeliumFluidProperties::cp_from_v_e(), LeadFluidProperties::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(), CaloricallyImperfectGas::gamma_from_p_T(), CaloricallyImperfectGas::gamma_from_v_e(), GeneralFunctorFluidProps::GeneralFunctorFluidProps(), LeadFluidProperties::h_from_p_T(), FlibeFluidProperties::h_from_p_T(), FlinakFluidProperties::h_from_p_T(), LeadBismuthFluidProperties::h_from_v_e(), LeadFluidProperties::h_from_v_e(), FlibeFluidProperties::p_from_v_e(), FlinakFluidProperties::p_from_v_e(), THM::Peclet(), fp::prandtl(), THM::Prandtl(), prandtlPropertyDerivative(), FlibeFluidProperties::T_from_v_e(), FlinakFluidProperties::T_from_v_e(), TEST(), TEST_F(), fp::thermalDiffusivity(), PINSFVEnergyTimeDerivative::validParams(), INSFVTurbulentTemperatureWallFunction::validParams(), WCNSFVEnergyFluxBC::validParams(), INSElementIntegralEnergyAdvectionTempl< is_ad >::validParams(), INSFVEnthalpyFunctorMaterial::validParams(), NSFVOutflowTemperatureBC::validParams(), WCNSFVInletTemperatureBC::validParams(), WCNSFVMixingLengthEnergyDiffusion::validParams(), ThermalDiffusivityFunctorMaterial::validParams(), TurbulentConductivityAux::validParams(), and NSFVBase< Action >::validParams().

◆ cp_s

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

Definition at line 118 of file NS.h.

◆ cQ

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

◆ cv

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

Definition at line 121 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(), CaloricallyImperfectGas::cv_from_p_T(), TabulatedFluidProperties::cv_from_p_T(), IdealRealGasMixtureFluidProperties::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(), IdealRealGasMixtureFluidProperties::cv_from_T_v(), StiffenedGasFluidProperties::cv_from_v_e(), TestSinglePhaseFluidProperties::cv_from_v_e(), CaloricallyImperfectGas::cv_from_v_e(), LeadBismuthFluidProperties::cv_from_v_e(), LeadFluidProperties::cv_from_v_e(), SimpleFluidProperties::cv_from_v_e(), TemperaturePressureFunctionFluidProperties::cv_from_v_e(), TabulatedFluidProperties::cv_from_v_e(), FlibeFluidProperties::cv_from_v_e(), FlinakFluidProperties::cv_from_v_e(), HeliumFluidProperties::cv_from_v_e(), CaloricallyImperfectGas::e_from_v_h(), CaloricallyImperfectGas::gamma_from_p_T(), CaloricallyImperfectGas::gamma_from_v_e(), GeneralFunctorFluidProps::GeneralFunctorFluidProps(), 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(), NSFVBase< Action >::addEnthalpyMaterial(), NSFVBase< Action >::addINSEnergyInletBC(), NSFVBase< Action >::addINSEnergyTimeKernels(), NSFVBase< Action >::addINSInletBC(), NSFVBase< Action >::addINSMassKernels(), NSFVBase< Action >::addINSMomentumAdvectionKernels(), NSFVBase< Action >::addINSMomentumBoussinesqKernels(), NSFVBase< Action >::addINSMomentumFrictionKernels(), NSFVBase< Action >::addINSMomentumGravityKernels(), NSFVBase< Action >::addINSMomentumMixingLengthKernels(), NSFVBase< Action >::addINSMomentumTimeKernels(), NSFVBase< Action >::addINSOutletBC(), NSFVBase< Action >::addINSVariables(), NSFVBase< Action >::addINSWallBC(), NSFVBase< Action >::addMixingLengthMaterial(), CNSAction::addNSInternalEnergyAux(), CNSAction::addNSMassInviscidFlux(), CNSAction::addNSMassUnspecifiedNormalFlowBC(), CNSAction::addNSMassWeakStagnationBC(), CNSAction::addNSSUPGMass(), CNSAction::addNSTimeKernels(), CNSAction::addNSVelocityAux(), NSFVBase< Action >::addScalarInletBC(), CNSAction::addSpecificTotalEnthalpyAux(), CNSAction::addSpecificVolumeComputation(), NSFVBase< Action >::addWCNSEnergyMixingLengthKernels(), NSFVBase< Action >::addWCNSEnergyTimeKernels(), NSFVBase< Action >::addWCNSMassTimeKernels(), NSFVBase< Action >::addWCNSMomentumTimeKernels(), AriaLaserWeld304LStainlessSteelFunctorMaterial::AriaLaserWeld304LStainlessSteelFunctorMaterial(), HelmholtzFluidProperties::c_from_p_T(), 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(), GeneralFunctorFluidProps::GeneralFunctorFluidProps(), 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(), 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(), Q2PPorepressureFlux::prepareNodalValues(), Q2PSaturationFlux::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(), PINSFVEnergyTimeDerivative::validParams(), INSFVEnergyTimeDerivative::validParams(), INSFVMomentumTimeDerivative::validParams(), PCNSFVDensityTimeDerivative::validParams(), PINSFVMomentumFrictionCorrection::validParams(), PressureEqualsDensityMaterial::validParams(), PINSFVMomentumFriction::validParams(), NSThermalBC::validParams(), INSFVkEpsilonViscosityFunctorMaterial::validParams(), NSFVPumpFunctorMaterial::validParams(), ReynoldsNumberFunctorAux::validParams(), INSFVTurbulentTemperatureWallFunction::validParams(), INSFVMassAdvection::validParams(), NSFVDispersePhaseDragFunctorMaterial::validParams(), INSElementIntegralEnergyAdvectionTempl< is_ad >::validParams(), INSFVMomentumGravity::validParams(), WCNSFVEnergyTimeDerivative::validParams(), WCNSFVMomentumTimeDerivative::validParams(), INSFVEnthalpyFunctorMaterial::validParams(), NSFVPhaseChangeSource::validParams(), INSFVMixingLengthReynoldsStress::validParams(), INSFVTKESourceSink::validParams(), WCNSFVMassTimeDerivative::validParams(), INSFVTurbulentAdvection::validParams(), INSFVMeshAdvection::validParams(), WCNSFVMixingLengthEnergyDiffusion::validParams(), NSImposedVelocityBC::validParams(), NSFVOutflowTemperatureBC::validParams(), WCNSFV2PSlipVelocityFunctorMaterial::validParams(), WCNSFVInletVelocityBC::validParams(), NSInternalEnergyAux::validParams(), WCNSFVFluxBCBase::validParams(), INSFVWallFunctionBC::validParams(), INSFVMomentumBoussinesq::validParams(), WCNSFVInletTemperatureBC::validParams(), PINSFVFunctorBC::validParams(), INSFVMomentumAdvection::validParams(), ThermalDiffusivityFunctorMaterial::validParams(), INSFVTKEDSourceSink::validParams(), kEpsilonViscosityAux::validParams(), RhoFromPTFunctorMaterial::validParams(), ConservedVarValuesMaterial::validParams(), INSFVMomentumAdvectionOutflowBC::validParams(), NSTemperatureL2::validParams(), PorousConservedVarMaterial::validParams(), GeneralFunctorFluidProps::validParams(), INSFVMassAdvectionOutflowBC::validParams(), INSFVTKEDWallFunctionBC::validParams(), INSFVTurbulentViscosityWallFunction::validParams(), NSVelocityAux::validParams(), ReynoldsNumberFunctorMaterial::validParams(), NSFVBase< Action >::validParams(), BernoulliPressureVariable::validParams(), NSKernel::validParams(), NSIntegratedBC::validParams(), NSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), NSSpecificTotalEnthalpyAux::validParams(), PNSInitialCondition::validParams(), FunctorPebbleBedDragCoefficients< FunctorErgunDragCoefficients >::validParams(), NavierStokesMaterial::validParams(), NSImposedVelocityDirectionBC::validParams(), NSInitialCondition::value(), NSFunctionInitialCondition::value(), PNSInitialCondition::value(), and RichardsSUPGstandard::velSUPG().

◆ diagonal_tau

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

Definition at line 145 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 113 of file NS.h.

◆ drhos_dTs

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

Definition at line 112 of file NS.h.

◆ dS_dTs

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

Definition at line 149 of file NS.h.

◆ dUdt

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

Definition at line 152 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 75 of file NS.h.

◆ enthalpy_density

const std::string NS::enthalpy_density = "rho_h"
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 106 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 62 of file NS.h.

◆ k

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

Definition at line 124 of file NS.h.

Referenced by AddGeochemistrySolverAction::act(), DisplacementGradientsAction::act(), SolidMechanicsPlasticMeanCapTC::activeConstraints(), CoupledHeatTransferAction::addBCs(), AddCoupledEqSpeciesAction::AddCoupledEqSpeciesAction(), AddCoupledSolidKinSpeciesAction::AddCoupledSolidKinSpeciesAction(), NSFVBase< Action >::addINSEnergyHeatConductionKernels(), 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(), NSFVBase< Action >::checkBoundaryParameterErrors(), SingularShapeTensorEliminatorUserObjectPD::checkShapeTensorSingularity(), PolynomialQuadrature::clenshaw_curtis(), EFAFace::combineTwoEdges(), RichardsMaterial::compute2ndDerivedQuantities(), InteractionIntegralTempl< is_ad >::computeAuxFields(), 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(), 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(), VolumeJunctionBaseUserObject::computeScalarJacobianWRTFlowDofs(), ADInertialForceShell::computeShellInertialForces(), ComputeLinearElasticPFFractureStress::computeStrainVolDev(), NavierStokesMaterial::computeStrongResiduals(), RichardsMaterial::computeSUPG(), HEVPFlowRatePowerLawJ2::computeTensorDerivative(), ShaftConnectableUserObjectInterface::computeTorqueScalarJacobianWRTFlowDofs(), PrandtlNumberAux::computeValue(), FluidPropertiesInterrogator::computeVaporMixture(), ComputeVolumetricEigenstrain::ComputeVolumetricEigenstrain(), 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(), MultiPlasticityDebugger::fddflowPotential_dstress(), MultiPlasticityDebugger::fdJacobian(), AdvectiveFluxCalculatorBase::finalize(), MorrisReporterContext< DataType >::finalize(), CrackMeshCut3DUserObject::findBoundaryEdges(), FinEfficiencyFunctorMaterialTempl< is_ad >::FinEfficiencyFunctorMaterialTempl(), CompositeSeriesBasisInterface::formatCoefficients(), EFAElement2D::fragmentSanityCheck(), GeneralFunctorFluidProps::GeneralFunctorFluidProps(), MeshGeneratorPD::generate(), GeochemistryTimeDependentReactor::GeochemistryTimeDependentReactor(), GeochemicalSystem::getAlgebraicVariableDenseValues(), GeochemicalSystem::getAlgebraicVariableValues(), EFAElement3D::getCommonEdgeID(), DiscreteLineSegmentInterface::getElementBoundaryCoordinates(), GeochemicalSystem::getKineticMoles(), ShaftConnectableUserObjectInterface::getMomentOfInertiaJacobianData(), EFAElement2D::getPhantomNodeOnEdge(), EFAElement3D::getPhantomNodeOnFace(), XFEMCutElem2D::getPhysicalQuadraturePoints(), ShaftConnectedTestComponentUserObject::getScalarEquationJacobianData(), ShaftConnectableUserObjectInterface::getTorqueJacobianData(), LAROMANCEStressUpdateBaseTempl< is_ad >::getTransformedLimits(), XFEM::getXFEMqRuleOnSurface(), CrackMeshCut3DUserObject::growFront(), MaskedGrainForceAndTorque::initialize(), GrainForceAndTorqueSum::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(), 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(), CO2FluidProperties::k_from_p_T(), IdealRealGasMixtureFluidProperties::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(), ThermalCompositeSiCProperties::k_from_T(), ThermalGraphiteProperties::k_from_T(), ThermalSS316Properties::k_from_T(), ThermalFunctionSolidProperties::k_from_T(), IdealRealGasMixtureFluidProperties::k_from_T_v(), StiffenedGasFluidProperties::k_from_v_e(), CaloricallyImperfectGas::k_from_v_e(), TestSinglePhaseFluidProperties::k_from_v_e(), IdealGasFluidProperties::k_from_v_e(), LeadBismuthFluidProperties::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(), 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(), GeochemicalSystem::setAlgebraicVariables(), AttribINSFVBCs::setFrom(), AttribINSFVMomentumResidualObject::setFrom(), GeochemicalSystem::setKineticMoles(), GeochemicalSystem::setMineralRelatedFreeMoles(), Xfem::shapeFunc2D(), SLKKSMultiPhaseBase::SLKKSMultiPhaseBase(), SolidMechanicsPlasticIsotropicSD::SolidMechanicsPlasticIsotropicSD(), XFEMCutElem2D::solveMomentFitting(), CrystalPlasticityStressUpdateBase::sortCrossSlipFamilies(), ADVolumeJunctionBaseUserObject::storeConnectionData(), VolumeJunctionBaseUserObject::storeConnectionData(), ComputeLagrangianObjectiveStress::stressAdvectionDerivative(), EFAElement2D::switchNode(), EFAElement3D::switchNode(), TEST(), TEST_F(), fp::thermalDiffusivity(), ElasticityTensorTools::toVoigtNotationIndexConversion(), CrystalPlasticityStressUpdateBase::transformHexagonalMillerBravaisSlipSystems(), CrackMeshCut3DUserObject::triangulation(), ADComputeFiniteShellStrain::updatedxyz(), GeochemicalSystem::updateOldWithCurrent(), ComputeLagrangianObjectiveStress::updateTensor(), ThermalDiffusivityFunctorMaterial::validParams(), PINSFVEnergyDiffusion::validParams(), NSFVBase< Action >::validParams(), NSFVFunctorHeatFluxBC::validParams(), MMSTestFunc::value(), THM::wallHeatTransferCoefficient(), and Simulation::~Simulation().

◆ K

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

◆ k_s

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

Definition at line 119 of file NS.h.

Referenced by NSFVFunctorHeatFluxBC::validParams().

◆ kappa

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

◆ kappa_s

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

Definition at line 115 of file NS.h.

Referenced by NSFVFunctorHeatFluxBC::validParams().

◆ mach_number

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

◆ mass_flux

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

Definition at line 156 of file NS.h.

◆ matrix_tau

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

Definition at line 142 of file NS.h.

◆ mixing_length

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

◆ momentum

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

Definition at line 81 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 122 of file NS.h.

Referenced by NSFVBase< Action >::addINSMomentumFrictionKernels(), NSFVBase< Action >::addINSMomentumViscousDissipationKernels(), NSFVBase< Action >::addINSWallBC(), NSFVBase< Action >::addMixingLengthMaterial(), AriaLaserWeld304LStainlessSteelFunctorMaterial::AriaLaserWeld304LStainlessSteelFunctorMaterial(), INSFVTurbulentViscosityWallFunction::boundaryValue(), INSFVTKEDWallFunctionBC::boundaryValue(), HyperElasticPhaseFieldIsoDamage::computeDamageStress(), IntegralDirectedSurfaceForce::computeFaceInfoIntegral(), PorousFlowBrine::computeQpProperties(), PorousFlowMultiComponentFluidTempl< is_ad >::computeQpProperties(), PorousFlowSingleComponentFluidTempl< is_ad >::computeQpProperties(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), INSFVTKEDSourceSink::computeQpResidual(), ComputeLinearElasticPFFractureStress::computeStrainSpectral(), ComputeLinearElasticPFFractureStress::computeStrainVolDev(), PrandtlNumberAux::computeValue(), WallFunctionWallShearStressAux::computeValue(), WallFunctionYPlusAux::computeValue(), FluidPropertiesInterrogator::computeVaporMixture(), SolidMechanicsPlasticJ2::consistentTangentOperator(), SolidMechanicsPlasticDruckerPragerHyperbolic::consistentTangentOperator(), SolidMechanicsPlasticTensileMulti::consistentTangentOperator(), NSViscStressTensorDerivs< NSEnergyViscousBC >::dtau(), MorrisReporterContext< DataType >::finalize(), findUStar(), kEpsilonViscosityAux::findUStarLocalMethod(), findyPlus(), PolynomialQuadrature::gauss_hermite(), GeneralFunctorFluidProps::GeneralFunctorFluidProps(), fp::grashof(), PolynomialQuadrature::hermite(), KernelDensity1D::KernelDensity1D(), fp::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(), LeadFluidProperties::mu_from_p_T(), IdealGasFluidProperties::mu_from_p_T(), Water97FluidProperties::mu_from_p_T(), SimpleFluidProperties::mu_from_p_T(), IdealRealGasMixtureFluidProperties::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(), IdealRealGasMixtureFluidProperties::mu_from_T_v(), StiffenedGasFluidProperties::mu_from_v_e(), LinearTestFluidProperties::mu_from_v_e(), TestSinglePhaseFluidProperties::mu_from_v_e(), CaloricallyImperfectGas::mu_from_v_e(), IdealGasFluidProperties::mu_from_v_e(), LeadBismuthFluidProperties::mu_from_v_e(), LeadFluidProperties::mu_from_v_e(), TabulatedFluidProperties::mu_from_v_e(), SimpleFluidProperties::mu_from_v_e(), PINSFVMomentumFriction::PINSFVMomentumFriction(), PolynomialChaosTrainer::postTrain(), PolynomialRegressionTrainer::postTrain(), fp::prandtl(), THM::Prandtl(), prandtlPropertyDerivative(), SolidMechanicsPlasticJ2::returnMap(), SolidMechanicsPlasticDruckerPragerHyperbolic::returnMap(), 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(), PINSFVMomentumFriction::validParams(), INSFVMomentumDiffusion::validParams(), INSFVTurbulentTemperatureWallFunction::validParams(), NSFVDispersePhaseDragFunctorMaterial::validParams(), ReynoldsNumberFunctorAux::validParams(), INSFVMushyPorousFrictionFunctorMaterial::validParams(), INSFVTKESourceSink::validParams(), WCNSFV2PSlipVelocityFunctorMaterial::validParams(), INSFVTKEDSourceSink::validParams(), kEpsilonViscosityAux::validParams(), INSFVTKEDWallFunctionBC::validParams(), INSFVTurbulentViscosityWallFunction::validParams(), ReynoldsNumberFunctorMaterial::validParams(), NSFVBase< Action >::validParams(), and IntegralDirectedSurfaceForce::validParams().

◆ mu_eff

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

Definition at line 116 of file NS.h.

◆ mu_t

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

◆ pebble_diameter

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

◆ porosity

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

Definition at line 102 of file NS.h.

Referenced by NSFVBase< Action >::addINSEnergyHeatConductionKernels(), NSFVBase< Action >::addINSEnergyTimeKernels(), NSFVBase< Action >::addINSInletBC(), NSFVBase< Action >::addINSMomentumAdvectionKernels(), NSFVBase< Action >::addINSMomentumBoussinesqKernels(), NSFVBase< Action >::addINSMomentumGravityKernels(), NSFVBase< Action >::addINSMomentumPressureKernels(), NSFVBase< Action >::addINSMomentumViscousDissipationKernels(), NSFVBase< Action >::addINSOutletBC(), NSFVBase< Action >::addINSVariables(), NSFVBase< Action >::addPorousMediumSpeedMaterial(), NSFVBase< Action >::addRhieChowUserObjects(), NSFVBase< Action >::addWCNSEnergyTimeKernels(), NSFVBase< Action >::addWCNSMassTimeKernels(), INSFEFluidMassKernel::computeQpJacobian(), INSFEFluidWallMomentumBC::computeQpJacobian(), INSFEFluidMomentumKernel::computeQpJacobian(), INSFEFluidEnergyKernel::computeQpJacobian(), INSFEFluidMomentumBC::computeQpJacobian(), INSFEFluidWallMomentumBC::computeQpOffDiagJacobian(), INSFEFluidMomentumKernel::computeQpOffDiagJacobian(), INSFEFluidMomentumBC::computeQpOffDiagJacobian(), PorousFlowPorosityLinear::computeQpProperties(), INSFEFluidMassKernel::computeQpResidual(), INSFEFluidWallMomentumBC::computeQpResidual(), INSFEFluidMomentumKernel::computeQpResidual(), INSFEFluidEnergyKernel::computeQpResidual(), INSFEFluidMomentumBC::computeQpResidual(), BernoulliPressureVariable::initialSetup(), isPorosityJumpFace(), PINSFVRhieChowInterpolator::PINSFVRhieChowInterpolator(), PINSFVRhieChowInterpolatorSegregated::PINSFVRhieChowInterpolatorSegregated(), PCNSFVDensityTimeDerivative::validParams(), PINSFVEnergyTimeDerivative::validParams(), PINSFVMomentumPressurePorosityGradient::validParams(), HasPorosityJumpFace::validParams(), PINSFVMomentumAdvection::validParams(), PINSFVMomentumDiffusion::validParams(), PINSFVMomentumPressure::validParams(), PCNSFVMomentumFriction::validParams(), PWCNSFVMomentumFluxBC::validParams(), PINSFVMomentumGravity::validParams(), PINSFVMomentumPressureFlux::validParams(), PWCNSFVMassTimeDerivative::validParams(), FVPorosityTimeDerivative::validParams(), PINSFVRhieChowInterpolatorSegregated::validParams(), PINSFVSpeedFunctorMaterial::validParams(), PINSFVMomentumBoussinesq::validParams(), PINSFVEnergyAnisotropicDiffusion::validParams(), LinearFrictionFactorFunctorMaterial::validParams(), PINSFVMomentumAdvectionOutflowBC::validParams(), PINSFVFunctorBC::validParams(), PINSFVEnergyDiffusion::validParams(), GeneralFluidProps::validParams(), HLLCUserObject::validParams(), PorousPrimitiveVarMaterial::validParams(), PorousMixedVarMaterial::validParams(), PorousConservedVarMaterial::validParams(), PINSFVRhieChowInterpolator::validParams(), GeneralFunctorFluidProps::validParams(), PNSFVMomentumPressureFluxRZ::validParams(), NSFVBase< Action >::validParams(), BernoulliPressureVariable::validParams(), FunctorPebbleBedDragCoefficients< FunctorErgunDragCoefficients >::validParams(), NSFVFunctorHeatFluxBC::validParams(), and NSFVHeatFluxBC::validParams().

◆ Prandtl

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

Definition at line 129 of file NS.h.

Referenced by GeneralFunctorFluidProps::GeneralFunctorFluidProps().

◆ 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(), 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(), 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(), 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(), 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(), GeneralFunctorFluidProps::GeneralFunctorFluidProps(), 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(), CO2FluidProperties::p_from_rho_T(), SinglePhaseFluidProperties::p_T_from_h_s(), SinglePhaseFluidProperties::p_T_from_v_e(), Water97FluidProperties::p_T_from_v_h(), SinglePhaseFluidProperties::p_T_from_v_h(), PINSFVRhieChowInterpolator::pinsfvSetup(), NSMomentumInviscidBC::pressureQpResidualHelper(), NSEnergyInviscidBC::qpJacobianTermA(), NSEnergyInviscidBC::qpResidualHelper(), RhieChowInterpolatorBase::RhieChowInterpolatorBase(), SodiumSaturationFluidProperties::rho_from_p_T(), HelmholtzFluidProperties::rho_from_p_T(), TabulatedFluidProperties::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(), MultiComponentFluidProperties::rho_mu_from_p_T_X(), TabulatedFluidProperties::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(), TabulatedFluidProperties::T_from_h_p(), 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(), MomentumFreeBC::validParams(), NSEntropyError::validParams(), NSMomentumInviscidFluxWithGradP::validParams(), PressureGradient::validParams(), PCNSFVStrongBC::validParams(), INSADMaterial::validParams(), INSBase::validParams(), INSADMomentumPressure::validParams(), INSStressComponentAux::validParams(), NSEnergyInviscidUnspecifiedBC::validParams(), INSFVMomentumPressureFlux::validParams(), InternalEnergyAux::validParams(), NSEnergyInviscidSpecifiedNormalFlowBC::validParams(), NSMomentumInviscidSpecifiedNormalFlowBC::validParams(), PINSFVFunctorBC::validParams(), INSChorinCorrector::validParams(), NSEnergyInviscidSpecifiedDensityAndVelocityBC::validParams(), NSMomentumInviscidFlux::validParams(), PorousPrimitiveVarMaterial::validParams(), RhoFromPTFunctorMaterial::validParams(), CNSFVHLLCSpecifiedPressureBC::validParams(), PCNSFVHLLCSpecifiedPressureBC::validParams(), PorousMixedVarMaterial::validParams(), INSADMomentumNoBCBC::validParams(), EnthalpyAux::validParams(), GeneralFunctorFluidProps::validParams(), INSProjection::validParams(), NSStagnationPressureBC::validParams(), PNSFVMomentumPressureFluxRZ::validParams(), IntegralDirectedSurfaceForce::validParams(), NSPressurePin::validParams(), INSMomentumNoBCBCBase::validParams(), NSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), NSSpecificTotalEnthalpyAux::validParams(), PNSInitialCondition::validParams(), NSPressureNeumannBC::validParams(), RhieChowInterpolatorBase::validParams(), NSInitialCondition::value(), PNSInitialCondition::value(), NSFunctionInitialCondition::value(), Water97FluidProperties::vaporTemperature(), SinglePhaseFluidProperties::vaporTemperature(), and Water97FluidProperties::vaporTemperature_ad().

◆ 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

Definition at line 131 of file NS.h.

Referenced by GeneralFunctorFluidProps::GeneralFunctorFluidProps().

◆ Reynolds_interstitial

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

Definition at line 132 of file NS.h.

Referenced by GeneralFunctorFluidProps::GeneralFunctorFluidProps().

◆ 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 144 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 128 of file NS.h.

◆ sound_speed

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

Definition at line 135 of file NS.h.

◆ source_scaling

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

Definition at line 139 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 61 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 64 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 70 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 NSFVBase< Action >::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

◆ T_solid

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

◆ temperature

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

Definition at line 57 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(), 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(), 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(), 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(), 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(), PorousFlowBrineCO2::fugacityCoefficientCO2HighTemp(), PorousFlowBrineCO2::fugacityCoefficientH2OHighTemp(), PorousFlowBrineCO2::fugacityCoefficientsHighTemp(), PorousFlowBrineCO2::fugacityCoefficientsLowTemp(), PorousFlowBrineCO2::funcABHighTemp(), PorousFlowBrineCO2::funcABLowTemp(), PorousFlowWaterNCG::gasDensity(), PorousFlowWaterNCG::gasProperties(), PorousFlowBrineCO2::gasProperties(), 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(), 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(), 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(), TabulatedFluidProperties::mu_from_p_T(), StiffenedGasFluidProperties::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(), 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(), Water97FluidProperties::p_T_from_v_h(), SinglePhaseFluidProperties::p_T_from_v_h(), CO2FluidProperties::partialDensity(), PorousFlowBrineCO2::partialDensityCO2(), SodiumSaturationFluidProperties::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(), 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(), Water97FluidProperties::rho_mu_from_p_T(), MultiComponentFluidProperties::rho_mu_from_p_T_X(), 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(), Water97FluidProperties::T_from_p_h(), Water97FluidProperties::T_from_p_h_ad(), FlibeFluidProperties::T_from_p_rho(), FlinakFluidProperties::T_from_p_rho(), 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(), NSStagnationTemperatureBC::validParams(), RhoFromPTFunctorMaterial::validParams(), NSSUPGBase::validParams(), CNSFVHLLCSpecifiedMassFluxAndTemperatureBC::validParams(), PCNSFVHLLCSpecifiedMassFluxAndTemperatureBC::validParams(), NSEnergyThermalFlux::validParams(), AriaLaserWeld304LStainlessSteelFunctorMaterial::validParams(), INSAction::validParams(), NSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), PNSInitialCondition::validParams(), NSEnergyViscousBC::validParams(), NavierStokesMaterial::validParams(), NSEnergyInviscidBC::validParams(), NSInitialCondition::value(), PNSInitialCondition::value(), NSFunctionInitialCondition::value(), MethaneFluidProperties::vaporPressure(), NitrogenFluidProperties::vaporPressure(), HydrogenFluidProperties::vaporPressure(), TabulatedFluidProperties::vaporPressure(), CO2FluidProperties::vaporPressure(), BrineFluidProperties::vaporPressure(), Water97FluidProperties::vaporPressure(), SinglePhaseFluidProperties::vaporPressure(), and Water97FluidProperties::vaporPressureTemplate().

◆ thermal_diffusivity

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

◆ TKE

const std::string NS::TKE = "k"
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 69 of file NS.h.

◆ total_viscosity

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

◆ v

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

Definition at line 82 of file NS.h.

Referenced by RigidBodyMultiKernelAction::act(), GrainGrowthAction::act(), GrainGrowthLinearizedInterfaceAction::act(), PolycrystalKernelAction::act(), PolycrystalStoredEnergyAction::act(), GrainGrowthAction::addBnds(), GradientOperatorCoordinates::AxisymmetricCylindrical::addGradOp(), GradientOperatorCoordinates::CentrosymmetricSpherical::addGradOp(), Simulation::addVariables(), 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(), 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(), PorousFlowThermalConductivityFromPorosityTempl< is_ad >::computeQpProperties(), PorousFlowTotalGravitationalDensityFullySaturatedFromPorosity::computeQpProperties(), PorousFlowPermeabilityExponentialTempl< is_ad >::computeQpProperties(), PorousFlowPermeabilityKozenyCarmanTempl< is_ad >::computeQpProperties(), PorousFlowPorosityExponentialBase::computeQpProperties(), PorousFlowJoinerTempl< is_ad >::computeQpProperties(), INSFVMassAdvection::computeQpResidual(), INSFVEnergyAdvection::computeQpResidual(), INSFVScalarFieldAdvection::computeQpResidual(), NSFVOutflowTemperatureBC::computeQpResidual(), INSFVTurbulentAdvection::computeQpResidual(), INSFVMassAdvectionOutflowBC::computeQpResidual(), DiscreteLineSegmentInterface::computeRadialCoordinate(), THMSpecificVolumeAux::computeValue(), OptimizationFunctionAuxTest::computeValue(), PorousFlowElementNormal::computeValue(), StagnationTemperatureAux::computeValue(), StagnationPressureAux::computeValue(), SurrogateModelAuxKernelTempl< ComputeValueType >::computeValue(), FluidPropertiesInterrogator::computeVaporMixture(), dataLoad(), dataStore(), MultiParameterPlasticityStressUpdate::dVardTrial(), StabilizationUtils::elementAverage(), INSFVMomentumAdvectionOutflowBC::gatherRCData(), NSPressureDerivs< NSPressureNeumannBC >::get_grad(), NSPressureDerivs< NSPressureNeumannBC >::get_hess(), LAROMANCEStressUpdateBaseTempl< is_ad >::getMakeFrameHelper(), SumPostprocessor::getValue(), INSFVRhieChowInterpolator::getVelocity(), GradientOperator< C >::gradOp(), ConstantViewFactorSurfaceRadiation::initialize(), SurrogateModelScalarAux::initialSetup(), ShaftConnectedTestComponentUserObject::initialSetup(), VolumeJunctionBaseUserObject::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(), NEML2Utils::set(), NEML2Utils::setBatched(), Simulation::setupInitialConditionsFromFile(), StochasticTools::stochasticAllGather(), StochasticTools::stochasticGather(), TEST(), TEST_F(), THMParsedFunctionWrapper::THMParsedFunctionWrapper(), NEML2Utils::toNEML2(), THM::v_from_arhoA_alpha_A(), THM::v_from_rho(), THM::v_from_rhoA_A(), FourierNoise::value(), PorousFlowFluidStateFlash::vaporMassFraction(), WCNSFVFluxBCBase::varVelocity(), and ViewFactorBase::ViewFactorBase().

◆ vector_tau

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

Definition at line 143 of file NS.h.

◆ velocity

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

◆ velocity_vector

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

Definition at line 49 of file NS.h.

Referenced by NSFVBase< Action >::checkGeneralControlErrors().

◆ 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 73 of file NS.h.

◆ wall_yplus

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

Definition at line 74 of file NS.h.

◆ Z

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