Namespaces | |
FV | |
phase | |
settings | |
splitting | |
Enumerations | |
enum | WallTreatmentEnum { WallTreatmentEnum::EQ_NEWTON = 0, WallTreatmentEnum::EQ_INCREMENTAL = 1, WallTreatmentEnum::EQ_LINEARIZED = 2, WallTreatmentEnum::NEQ = 3 } |
Wall treatment options. More... | |
enum | ViscousForm : int { ViscousForm::Traction, ViscousForm::Laplace } |
Functions | |
int | delta (unsigned int i, unsigned int j) |
Delta function, which returns zero if $i j$ and unity if $i=j$. More... | |
int | computeSign (const Real &a) |
Sign function, returns $+1$ if $a$ is positive and $-1$ if $a$ is negative. More... | |
unsigned int | getIndex (const Real &p, const std::vector< Real > &bounds) |
Determines the index $i$ in a sorted array such that the input point is within the $i$-th and $i+1$-th entries in the array. More... | |
Real | reynoldsPropertyDerivative (const Real &Re, const Real &rho, const Real &mu, const Real &drho, const Real &dmu) |
Computes the derivative of the Reynolds number, $Re { Vd}{}$, with respect to an arbitrary variable $$, where it is assumed that only the material properties of density $$ and dynamic viscosity $$ have nonzero derivatives with respect to $$. More... | |
Real | prandtlPropertyDerivative (const Real &mu, const Real &cp, const Real &k, const Real &dmu, const Real &dcp, const Real &dk) |
Computes the derivative of the Prandtl number, $Pr{ C_p}{k}$, with respect to an arbitrary variale $$. More... | |
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 > | |
T | divergence (const TensorValue< T > &gradient, const VectorType &value, const PointType &point, const Moose::CoordinateSystemType &coord_sys, const unsigned int rz_radial_coord) |
Compute the divergence of a vector given its matrix of derivatives. More... | |
template<typename T1 , typename T2 , typename T3 > | |
auto | wallHeatTransferCoefficient (const T1 &Nu, const T2 &k, const T3 &D_h) |
Compute wall heat transfer coefficient. More... | |
std::string | grad (const std::string &var) |
std::string | time_deriv (const std::string &var) |
std::tuple< bool, ADReal, ADReal > | 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. 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 | total_pressure = "pressure_total" |
static const std::string | temperature = "temperature" |
static const std::string | internal_energy = "internal_energy" |
static const std::string | specific_internal_energy = "e" |
static const std::string | specific_total_energy = "et" |
static const std::string | internal_energy_density = "rho_e" |
static const std::string | total_energy_density = "rho_et" |
static const std::string | superficial_total_energy_density = "superficial_rho_et" |
static const std::string | specific_enthalpy = "h" |
static const std::string | specific_total_enthalpy = "ht" |
static const std::string | enthalpy_density = "rho_h" |
static const std::string | total_enthalpy_density = "rho_ht" |
static const std::string | superficial_total_enthalpy_density = "superficial_rho_ht" |
static const std::string | mixing_length = "mixing_length" |
static const std::string | wall_shear_stress = "wall_shear_stress" |
static const std::string | wall_yplus = "wall_yplus" |
static const std::string | eddy_viscosity = "eddy_viscosity" |
static const std::string | total_viscosity = "total_viscosity" |
static const std::string | mach_number = "Mach" |
static const std::string | specific_volume = "specific_volume" |
static const std::string | momentum = "momentum" |
static const std::string | v = "v" |
static const std::string | acceleration = "acceleration" |
static const std::string | fluid = "fp" |
static const std::string | porosity = "porosity" |
static const std::string | smoothed_porosity = "smoothed_porosity" |
static const std::string | T_fluid = "T_fluid" |
static const std::string | T_solid = "T_solid" |
static const std::string | heat_source = "heat_source" |
static const std::string | cL = "Darcy_coefficient" |
static const std::string | cQ = "Forchheimer_coefficient" |
static const std::string | alpha_boussinesq = "alpha_b" |
static const std::string | drhos_dTs = "drhos_dTs" |
static const std::string | dks_dTs = "dks_dTs" |
static const std::string | kappa = "kappa" |
static const std::string | kappa_s = "kappa_s" |
static const std::string | rho_s = "rho_s" |
static const std::string | cp_s = "cp_s" |
static const std::string | k_s = "k_s" |
static const std::string | cp = "cp" |
static const std::string | cv = "cv" |
static const std::string | mu = "mu" |
static const std::string | mu_t = "mu_t" |
static const std::string | mu_t_passive_scalar = "mu_t_passive_scalar" |
static const std::string | mu_eff = "mu_eff" |
static const std::string | k = "k" |
static const std::string | k_t = "k_t" |
static const std::string | thermal_diffusivity = "thermal_diffusivity" |
static const std::string | alpha = "alpha" |
static const std::string | alpha_wall = "alpha_wall" |
static const std::string | solid = "solid" |
static const std::string | Prandtl = "Pr" |
static const std::string | turbulent_Prandtl = "Pr_t" |
static const std::string | Reynolds = "Re" |
static const std::string | Reynolds_hydraulic = "Re_h" |
static const std::string | Reynolds_interstitial = "Re_i" |
static const std::string | c = "c" |
static const std::string | speed = "speed" |
static const std::string | sound_speed = "sound_speed" |
static const std::string | latent_heat = "latent_heat" |
static const std::string | T_liquidus = "T_liquidus" |
static const std::string | T_solidus = "T_solidus" |
static const std::string | alpha_exchange = "alpha_exchange" |
static const std::string | component = "component" |
static const std::string | source_scaling = "source_scaling" |
static const std::string | matrix_tau = "matrix_tau" |
static const std::string | vector_tau = "vector_tau" |
static const std::string | scalar_tau = "scalar_tau" |
static const std::string | diagonal_tau = "diagonal_tau" |
static const std::string | A = "A" |
static const std::string | R = "R" |
static const std::string | S = "S" |
static const std::string | dS_dTs = "dS_dTs" |
static const std::string | F = "F" |
static const std::string | G = "G" |
static const std::string | dUdt = "dUdt" |
static const std::string | C = "C" |
static const std::string | Z = "Z" |
static const std::string | K = "K" |
static const std::string | mass_flux = "mass_flux" |
static const std::string | TKE = "tke" |
static const std::string | TKED = "epsilon" |
static constexpr Real | von_karman_constant = 0.4187 |
static constexpr Real | E_turb_constant = 9.793 |
static constexpr Real | mu_t_low_limit = 1.0e-8 |
static constexpr Real | epsilon_low_limit = 1.0e-8 |
static constexpr Real | min_y_plus = 1e-10 |
|
strong |
Enumerator | |
---|---|
Traction | |
Laplace |
Definition at line 20 of file NSEnums.h.
|
strong |
Sign function, returns $+1$ if $a$ is positive and $-1$ if $a$ is negative.
[in] | a | number |
Definition at line 27 of file NavierStokesMethods.C.
ADReal NS::computeSpeed | ( | const ADRealVectorValue & | velocity | ) |
Compute the speed (velocity norm) given the supplied velocity.
Definition at line 148 of file NavierStokesMethods.C.
Referenced by INSFVTurbulentViscosityWallFunction::boundaryValue(), INSFVTKEDWallFunctionBC::boundaryValue(), PINSFVMomentumFriction::computeFrictionWCoefficient(), PorousMixedVarMaterial::computeQpProperties(), PorousPrimitiveVarMaterial::computeQpProperties(), ConservedVarValuesMaterial::computeQpProperties(), PorousConservedVarMaterial::computeQpProperties(), INSADTauMaterialTempl< INSAD3Eqn >::computeQpProperties(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), WCNSFV2PInterfaceAreaSourceSink::computeQpResidual(), INSFVTKESourceSink::computeQpResidual(), INSFVTKEDSourceSink::computeQpResidual(), RANSYPlusAux::computeValue(), kEpsilonViscosityAux::computeValue(), LinearFrictionFactorFunctorMaterial::LinearFrictionFactorFunctorMaterial(), NSFVDispersePhaseDragFunctorMaterial::NSFVDispersePhaseDragFunctorMaterial(), and PINSFVSpeedFunctorMaterial::PINSFVSpeedFunctorMaterial().
Delta function, which returns zero if $i j$ and unity if $i=j$.
[in] | i | integer number |
[in] | j | integer number |
Definition at line 18 of file NavierStokesMethods.C.
Referenced by MethaneFluidProperties::alpha(), HydrogenFluidProperties::alpha(), NitrogenFluidProperties::alpha(), CO2FluidProperties::alpha(), GrainTracker::boundingRegionDistance(), HelmholtzFluidProperties::c_from_p_T(), Water97FluidProperties::c_from_p_T_template(), QuadSubChannel1PhaseProblem::computeBeta(), TriSubChannel1PhaseProblem::computeBeta(), BiLinearMixedModeTraction::computeCriticalDisplacementJump(), BiLinearMixedModeTraction::computeEffectiveDisplacementJump(), BiLinearMixedModeTraction::computeFinalDisplacementJump(), BiLinearMixedModeTraction::computeModeMixity(), NodalRankTwoPD::computeRankTwoTensors(), BiLinearMixedModeTraction::computeTraction(), BiLinearMixedModeTraction::computeTractionDerivatives(), WallDistanceMixingLengthAux::computeValue(), RotationAngle::computeValue(), HelmholtzFluidProperties::cp_from_p_T(), Water97FluidProperties::cp_from_p_T_template(), HelmholtzFluidProperties::cv_from_p_T(), Water97FluidProperties::cv_from_p_T_template(), MethaneFluidProperties::d2alpha_ddelta2(), NitrogenFluidProperties::d2alpha_ddelta2(), HydrogenFluidProperties::d2alpha_ddelta2(), CO2FluidProperties::d2alpha_ddelta2(), MethaneFluidProperties::d2alpha_ddeltatau(), NitrogenFluidProperties::d2alpha_ddeltatau(), HydrogenFluidProperties::d2alpha_ddeltatau(), CO2FluidProperties::d2alpha_ddeltatau(), MethaneFluidProperties::d2alpha_dtau2(), NitrogenFluidProperties::d2alpha_dtau2(), HydrogenFluidProperties::d2alpha_dtau2(), CO2FluidProperties::d2alpha_dtau2(), Water97FluidProperties::d2phi3_ddelta2(), Water97FluidProperties::d2phi3_ddeltatau(), Water97FluidProperties::d2phi3_dtau2(), MethaneFluidProperties::dalpha_ddelta(), HydrogenFluidProperties::dalpha_ddelta(), NitrogenFluidProperties::dalpha_ddelta(), CO2FluidProperties::dalpha_ddelta(), MethaneFluidProperties::dalpha_dtau(), NitrogenFluidProperties::dalpha_dtau(), HydrogenFluidProperties::dalpha_dtau(), CO2FluidProperties::dalpha_dtau(), Water97FluidProperties::dphi3_ddelta(), Water97FluidProperties::dphi3_dtau(), HelmholtzFluidProperties::e_from_p_T(), Water97FluidProperties::e_from_p_T_template(), LevelSetOlssonTerminator::execute(), HelmholtzFluidProperties::h_from_p_T(), Water97FluidProperties::h_from_p_T_template(), NitrogenFluidProperties::k_from_rho_T(), NitrogenFluidProperties::mu_from_rho_T(), HelmholtzFluidProperties::p_from_rho_T(), PatchSidesetGenerator::partition(), Water97FluidProperties::phi3(), HelmholtzFluidProperties::rho_from_p_T(), and HelmholtzFluidProperties::s_from_p_T().
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().
Finds the friction velocity using standard velocity wall functions formulation.
It is used in WallFunctionWallShearStressAux, WallFunctionYPlusAux and INSFVWallFunctionBC.
mu | the dynamic viscosity |
rho | the density |
u | the centroid velocity |
dist | the element centroid distance to the wall |
This is important to reduce the number of nonlinear iterations
This is important to reduce the number of nonlinear iterations
Definition at line 64 of file NavierStokesMethods.C.
Referenced by INSFVTurbulentViscosityWallFunction::boundaryValue(), INSFVTKEDWallFunctionBC::boundaryValue(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), INSFVWallFunctionBC::computeStrongResidual(), WallFunctionYPlusAux::computeValue(), WallFunctionWallShearStressAux::computeValue(), and kEpsilonViscosityAux::computeValue().
Finds the non-dimensional wall distance normalized with the friction velocity Implements a fixed-point iteration in the wall function to get this velocity.
mu | the dynamic viscosity |
rho | the density |
u | the centroid velocity |
dist | the element centroid distance to the wall |
Definition at line 116 of file NavierStokesMethods.C.
Referenced by INSFVTurbulentViscosityWallFunction::boundaryValue(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), INSFVTKESourceSink::computeQpResidual(), INSFVTKEDSourceSink::computeQpResidual(), RANSYPlusAux::computeValue(), and kEpsilonViscosityAux::computeValue().
void NS::getElementFaceArgs | ( | const std::vector< BoundaryName > & | wall_boundary_name, |
const FEProblemBase & | fe_problem, | ||
const SubProblem & | subproblem, | ||
const std::set< SubdomainID > & | block_ids, | ||
std::map< const Elem *, std::vector< const FaceInfo *>> & | face_info_map | ||
) |
Map storing face arguments to wall bounded faces The map passed in face_info_map
gets cleared and re-populated.
Face arguments to wall-bounded faces for wall treatment.
Definition at line 217 of file NavierStokesMethods.C.
Referenced by RANSYPlusAux::initialSetup(), INSFVTKESourceSink::initialSetup(), INSFVTKEDSourceSink::initialSetup(), and kEpsilonViscosityAux::initialSetup().
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.
[in] | p | input point |
[in] | bounds | sorted array |
Definition at line 33 of file NavierStokesMethods.C.
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 treatment.
Definition at line 159 of file NavierStokesMethods.C.
Referenced by INSFVTurbulentAdvection::initialSetup(), RANSYPlusAux::initialSetup(), INSFVTKESourceSink::initialSetup(), kEpsilonViscosityAux::initialSetup(), INSFVTKEDSourceSink::initialSetup(), and INSFVTurbulentDiffusion::initialSetup().
void NS::getWallDistance | ( | const std::vector< BoundaryName > & | wall_boundary_name, |
const FEProblemBase & | fe_problem, | ||
const SubProblem & | subproblem, | ||
const std::set< SubdomainID > & | block_ids, | ||
std::map< const Elem *, std::vector< Real >> & | dist_map | ||
) |
Map storing wall ditance for near-wall marked elements The map passed in dist_map
gets cleared and re-populated.
Bounded element face distances for wall treatment.
Definition at line 187 of file NavierStokesMethods.C.
Referenced by RANSYPlusAux::initialSetup(), INSFVTKESourceSink::initialSetup(), INSFVTKEDSourceSink::initialSetup(), and kEpsilonViscosityAux::initialSetup().
|
inline |
Definition at line 91 of file NS.h.
Referenced by INSFVVelocityVariable::adGradSln(), LMC::computeAGradient(), LMC::computeLambdaGradient(), PolynomialChaos::computePartialDerivative(), CoupledValueFunctionFreeEnergy::computeProperties(), GrainBoundaryArea::computeQpIntegral(), and OptimizeSolve::objectiveAndGradientFunctionWrapper().
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.
porosity | the porosity |
fi | the face to inspect for porosity jumps |
time | A temporal argument indicating at what time state to evaluate the porosity |
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().
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}$
[in] | mu | dynamic viscosity |
[in] | cp | isobaric specific heat |
[in] | k | thermal conductivity |
[in] | dmu | derivative of dynamic viscosity with respect to $$ |
[in] | dcp | derivative of isobaric specific heat with respect to $$ |
[in] | dk | derivative of thermal conductivity with respect to $$ |
Definition at line 53 of file NavierStokesMethods.C.
Referenced by GeneralFluidProps::computeQpProperties(), and GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl().
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}$
[in] | Re | Reynolds number |
[in] | rho | density |
[in] | mu | dynamic viscosity |
[in] | drho | partial derivative of density with respect to arbitrary variable $$ |
[in] | dmu | partial derivative of dynamic viscosity with respect to arbitrary variable $$ |
Definition at line 46 of file NavierStokesMethods.C.
Referenced by GeneralFluidProps::computeQpProperties(), and GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl().
|
inline |
Definition at line 97 of file NS.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyTimeKernels(), WCNSFVFlowPhysics::addMassTimeKernels(), WCNSFVFlowPhysics::addMomentumTimeKernels(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyTimeKernels(), AriaLaserWeld304LStainlessSteelFunctorMaterial::AriaLaserWeld304LStainlessSteelFunctorMaterial(), GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), INSFVEnthalpyFunctorMaterial::INSFVEnthalpyFunctorMaterial(), PINSFVEnergyTimeDerivative::PINSFVEnergyTimeDerivative(), RhoFromPTFunctorMaterial::RhoFromPTFunctorMaterial(), INSFVEnergyTimeDerivative::validParams(), PINSFVEnergyTimeDerivative::validParams(), WCNSFVMomentumTimeDerivative::validParams(), WCNSFVEnergyTimeDerivative::validParams(), and WCNSFVMassTimeDerivative::validParams().
auto NS::wallHeatTransferCoefficient | ( | const T1 & | Nu, |
const T2 & | k, | ||
const T3 & | D_h | ||
) |
Compute wall heat transfer coefficient.
Nu | Nusselt number |
k | Thermal conductivity |
D_h | Hydraulic diameter |
Definition at line 183 of file NavierStokesMethods.h.
Referenced by ADConvectiveHeatTransferCoefficientMaterial::computeQpProperties(), ADWallHeatTransferCoefficientGnielinskiMaterial::computeQpProperties(), WallHeatTransferCoefficient3EqnDittusBoelterMaterial::computeQpProperties(), ConvectiveHeatTransferCoefficientMaterial::computeQpProperties(), ADWallHeatTransferCoefficientSchadMaterial::computeQpProperties(), ADWallHeatTransferCoefficientWolfMcCarthyMaterial::computeQpProperties(), ADWallHeatTransferCoefficientWeismanMaterial::computeQpProperties(), ADWallHeatTransferCoefficientKazimiMaterial::computeQpProperties(), ADWallHeatTransferCoefficientMikityukMaterial::computeQpProperties(), ADWallHeatTransferCoefficientLyonMaterial::computeQpProperties(), ADWallHeatTransferCoefficient3EqnDittusBoelterMaterial::computeQpProperties(), ADWallHTCGnielinskiAnnularMaterial::computeQpProperties(), DittusBoelterFunctorMaterialTempl< is_ad >::DittusBoelterFunctorMaterialTempl(), and TEST().
|
static |
Definition at line 85 of file NS.h.
Referenced by StochasticTools::BiasCorrectedAccelerated< std::vector< InType >, std::vector< OutType > >::compute(), and StochasticTools::BiasCorrectedAccelerated< InType, OutType >::compute().
|
static |
Definition at line 134 of file NS.h.
Referenced by SolidMechanicsPlasticWeakPlaneShear::activeConstraints(), SolidMechanicsPlasticWeakPlaneTensile::activeConstraints(), PorousFlowActionBase::addCapillaryPressureVG(), ElbowPipe1Phase::buildMeshNodes(), MultiPlasticityLinearSystem::calculateJacobian(), PorousFlowVanGenuchten::capillaryPressure(), PorousFlowVanGenuchten::capillaryPressureHys(), Beta::cdf(), Gamma::cdf(), NSFVBase::commonMomentumEquationParams(), StochasticTools::BiasCorrectedAccelerated< std::vector< InType >, std::vector< OutType > >::compute(), StochasticTools::BiasCorrectedAccelerated< InType, OutType >::compute(), PCNSFVKT::computeAlphaAndOmega(), ExponentialSoftening::computeCrackingRelease(), ADExponentialSoftening::computeCrackingRelease(), InterWrapper1PhaseProblem::computeDP(), SubChannel1PhaseProblem::computeDP(), PCNSFVKT::computeFaceFlux(), ADShaftConnectedPump1PhaseUserObject::computeFluxesAndResiduals(), ADShaftConnectedTurbine1PhaseUserObject::computeFluxesAndResiduals(), ADShaftConnectedCompressor1PhaseUserObject::computeFluxesAndResiduals(), QuadSubChannel1PhaseProblem::computeh(), TriSubChannel1PhaseProblem::computeh(), InterWrapper1PhaseProblem::computeh(), InterWrapper1PhaseProblem::computeInterpolatedValue(), SubChannel1PhaseProblem::computeInterpolatedValue(), InterWrapper1PhaseProblem::computeP(), SubChannel1PhaseProblem::computeP(), TotalLagrangianStressDivergenceBase< G >::computeQpJacobianDisplacement(), TotalLagrangianStressDivergenceBaseS< G >::computeQpJacobianDisplacement(), UpdatedLagrangianStressDivergenceBase< G >::computeQpJacobianDisplacement(), HomogenizedTotalLagrangianStressDivergenceR::computeQpJacobianDisplacement(), HomogenizedTotalLagrangianStressDivergenceA::computeQpJacobianDisplacement(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), PCNSFVKT::computeQpResidual(), HomogenizedTotalLagrangianStressDivergenceR::computeScalarQpOffDiagJacobian(), DensityUpdateTwoConstraints::computeUpdatedDensity(), InterWrapper1PhaseProblem::computeWij(), SubChannel1PhaseProblem::computeWijResidual(), XFEMCutElem::computeXFEMWeights(), NormalSampler::computeZ(), SolidMechanicsPlasticMeanCapTC::consistentTangentOperator(), RichardsSUPGstandard::cosh_relation(), RichardsSUPGstandard::cosh_relation_prime(), TemperaturePressureFunctionFluidProperties::cp_from_p_T(), PertinentGeochemicalSystem::createModel(), LeadFluidProperties::cv_from_p_T(), LeadBismuthFluidProperties::cv_from_p_T(), LeadLithiumFluidProperties::cv_from_p_T(), TemperaturePressureFunctionFluidProperties::cv_from_p_T(), PorousFlowVanGenuchten::d2CapillaryPressure(), PorousFlowVanGenuchten::d2capillaryPressureHys(), PorousFlowVanGenuchten::d2EffectiveSaturation(), PorousFlowVanGenuchten::d2saturationHys(), PorousFlowVanGenuchten::dCapillaryPressure(), PorousFlowVanGenuchten::dcapillaryPressureHys(), PorousFlowVanGenuchten::dEffectiveSaturation(), PorousFlowVanGenuchten::dsaturationHys(), RichardsSUPGstandard::dtauSUPG_dgradp(), RichardsSUPGstandard::dtauSUPG_dp(), PorousFlowVanGenuchten::effectiveSaturation(), DetailedPinMeshGeneratorBase::generatePin(), StochasticTools::GaussianProcess::getGradient(), SingleVariableReturnMappingSolutionTempl< is_ad >::internalSolve(), ComputeMultiPlasticityStress::lineSearch(), Beta::pdf(), Gamma::pdf(), Beta::quantile(), Gamma::quantile(), SolidMechanicsPlasticMohrCoulombMulti::returnPlane(), THM::rho_from_arhoA_alpha_A(), PorousFlowVanGenuchten::saturationHys(), INSBase::tauNodal(), RichardsSUPGstandard::tauSUPG(), TEST(), TEST_F(), THM::v_from_arhoA_alpha_A(), NSFVMixturePhaseInterface::validParams(), NSFVEnergyAmbientConvection::validParams(), MarvelTriWettedPerimIC::value(), and MarvelTriFlowAreaIC::value().
|
static |
Definition at line 113 of file NS.h.
Referenced by LinearFVMomentumBoussinesq::validParams(), and INSFVMomentumBoussinesq::validParams().
|
static |
Definition at line 150 of file NS.h.
Referenced by WCNSLinearFVTwoPhaseMixturePhysics::addPhaseInterfaceTerm(), WCNSFVTwoPhaseMixturePhysics::addPhaseInterfaceTerm(), and WCNSFVTwoPhaseMixturePhysics::commonMixtureParams().
|
static |
Definition at line 27 of file NS.h.
Referenced by RankTwoScalarTools::axialStress(), DiscreteLineSegmentInterface::getAlignmentAxis(), DiscreteLineSegmentInterface::getElementBoundaryCoordinates(), RotationTensor::RotationTensor(), RotationTensor::update(), SmoothTransitionFunction::validParams(), CosineHumpFunction::validParams(), and PiecewiseFunction::validParams().
|
static |
Definition at line 168 of file NS.h.
Referenced by ReceiveBuffer< Object, Context >::blocking_receive_packed_range(), buildStiffnessMatrix(), TestBoundaryFlux::calcFlux(), CZMComputeDisplacementJumpTotalLagrangianTempl< is_ad >::computeFandR(), BilinearMixedModeCohesiveZoneModel::computeFandR(), UpdatedLagrangianStressDivergenceBase< G >::computeQpJacobianTemperature(), ComputeHypoelasticStVenantKirchhoffStress::computeQpSmallStress(), SolidMechanicsPlasticDruckerPrager::dbothAB(), FOR_NAME(), Water97FluidProperties::henryConstant(), SolidMechanicsPlasticDruckerPrager::initializeAandB(), ComputeLagrangianObjectiveStress::polarDecomposition(), and umat_().
|
static |
Definition at line 28 of file NS.h.
Referenced by HexagonalLatticeUtils::closestPinIndex(), SmoothCircleBaseIC::computeCircleGradient(), RndSmoothCircleIC::computeCircleValue(), SmoothCircleBaseIC::computeCircleValue(), DiscreteNucleationMarker::computeElementMarker(), HexagonalLatticeUtils::computePinAndDuctCoordinates(), SmoothSuperellipsoidBaseIC::computeSuperellipsoidGradient(), SmoothSuperellipsoidBaseIC::computeSuperellipsoidInverseValue(), SmoothSuperellipsoidBaseIC::computeSuperellipsoidValue(), EFAElement3D::createChild(), DiscreteNucleationFromFile::DiscreteNucleationFromFile(), SCMTriDuctMeshGenerator::ductCorners(), DiscreteNucleationMap::execute(), DetailedPinMeshGeneratorBase::generatePin(), XFEMCutElem3D::getCutPlaneNormal(), RankTwoScalarTools::getSphericalComponent(), RankTwoScalarTools::hoopStress(), TriSubChannelMesh::pinIndex(), HexagonalLatticeUtils::pinIndex(), RankTwoScalarTools::radialStress(), TriInterWrapperMesh::rodPositions(), TriSubChannelMesh::rodPositions(), TEST(), triRodPositionsRef(), and ThumbIC::value().
|
static |
Definition at line 111 of file NS.h.
Referenced by NumericalFluxGasMixHLLC::calcFlux(), ADNumericalFlux3EqnHLLC::calcFlux(), QuadSubChannel1PhaseProblem::computeFrictionFactor(), TriSubChannel1PhaseProblem::computeFrictionFactor(), and FunctorIsotropicDragCoefficients< FunctorErgunDragCoefficients >::FunctorIsotropicDragCoefficients().
|
static |
Definition at line 153 of file NS.h.
Referenced by CNSAction::act(), QuasiStaticSolidMechanicsPhysics::actOutputMatProp(), MultiSpeciesDiffusionPhysicsBase::addComponent(), GradientOperatorCoordinates::Cartesian::addGradOp(), GradientOperatorCoordinates::AxisymmetricCylindrical::addGradOp(), INSAction::addINSMomentum(), INSAction::addINSNoBCBC(), INSAction::addINSTimeKernels(), INSAction::addINSVelocityAux(), INSAction::addINSVelocityBC(), CNSAction::addNoPenetrationBC(), CNSAction::addNSMomentumInviscidFlux(), CNSAction::addNSMomentumInviscidSpecifiedPressureBC(), CNSAction::addNSMomentumWeakStagnationBC(), CNSAction::addNSSUPGMomentum(), CNSAction::addNSVelocityAux(), INSFVRhieChowInterpolator::addToA(), HSBoundaryInterface::check(), ShaftConnectable::checkShaftConnection(), TorqueTempl< is_ad >::componentJacobian(), StressDivergenceRZTensors::computeAverageGradientPhi(), StressDivergenceTensors::computeAverageGradientPhi(), ADComputeIncrementalShellStrain::computeBMatrix(), ADComputeFiniteShellStrain::computeBNLMatrix(), MechanicsFiniteStrainBaseNOSPD::computeDinvFTDU(), GeneralizedPlaneStrainOffDiagOSPD::computeDispFullOffDiagJacobianScalar(), GeneralizedPlaneStrainOffDiagNOSPD::computeDispFullOffDiagJacobianScalar(), GeneralizedPlaneStrainOffDiag::computeDispOffDiagJacobianScalar(), GeneralizedPlaneStrainOffDiagNOSPD::computeDispPartialOffDiagJacobianScalar(), GeneralizedPlaneStrainOffDiagOSPD::computeDispPartialOffDiagJacobianScalar(), MechanicsFiniteStrainBaseNOSPD::computeDJDU(), MechanicsFiniteStrainBaseNOSPD::computeDSDU(), MechanicsBaseNOSPD::computeDSDU(), StressDivergenceBeam::computeGlobalResidual(), ADComputeIncrementalShellStrain::computeGMatrix(), ConvectedMesh::computePGVelocityJacobian(), DashpotBC::computeQpOffDiagJacobian(), AbaqusUMATStress::computeQpStress(), ComputeLagrangianStrainBase< G >::computeQpUnstabilizedDeformationGradient(), ConvectedMeshPSPG::dStrongResidualDDisp(), ConvectedMeshPSPG::dStrongResidualDVel(), PenaltyFrictionUserObject::getAccumulatedSlip(), BrineFluidProperties::getComponent(), MechanicalContactConstraint::getConnectedDofIndices(), MechanicalContactConstraint::getCoupledVarComponent(), PenaltyFrictionUserObject::getDeltaTangentialLagrangeMultiplier(), PenaltyFrictionUserObject::getFrictionalContactPressure(), HSBoundaryInterface::getHSBoundaryName(), PenaltyFrictionUserObject::getTangentialVelocity(), GradientOperator< C >::gradOp(), TotalLagrangianStressDivergenceBase< G >::gradTest(), TotalLagrangianStressDivergenceBaseS< G >::gradTest(), UpdatedLagrangianStressDivergenceBase< G >::gradTest(), TotalLagrangianStressDivergenceBase< G >::gradTrial(), TotalLagrangianStressDivergenceBaseS< G >::gradTrial(), UpdatedLagrangianStressDivergenceBase< G >::gradTrial(), TotalLagrangianStressDivergenceBase< G >::gradTrialStabilized(), TotalLagrangianStressDivergenceBaseS< G >::gradTrialStabilized(), UpdatedLagrangianStressDivergenceBase< G >::gradTrialStabilized(), TotalLagrangianStressDivergenceBase< G >::gradTrialUnstabilized(), TotalLagrangianStressDivergenceBaseS< G >::gradTrialUnstabilized(), UpdatedLagrangianStressDivergenceBase< G >::gradTrialUnstabilized(), HSBoundaryInterface::HSBoundaryInterface(), Simulation::identifyLoops(), PetscProjectSolutionOntoBounds::lineSearch(), TotalLagrangianStressDivergenceBaseS< G >::precalculateJacobianDisplacement(), TotalLagrangianStressDivergenceBase< G >::precalculateJacobianDisplacement(), UpdatedLagrangianStressDivergenceBase< G >::precalculateJacobianDisplacement(), RhieChowMassFlux::selectPressureGradient(), ADComputeFiniteShellStrain::updatedxyz(), ADComputeFiniteShellStrain::updateGVectors(), MortarGenericTraction::validParams(), TangentialMortarMechanicalContact::validParams(), NormalMortarMechanicalContact::validParams(), MMSTestFunc::validParams(), JinSlabCoeffFunc::validParams(), CartesianMortarMechanicalContact::validParams(), VectorCurrentSource::validParams(), ADMatWaveReaction::validParams(), EMRobinBC::validParams(), DiffusionFluxFVAux::validParams(), PorousFlowElementNormal::validParams(), VectorTransientAbsorbingBC::validParams(), ADConductionCurrent::validParams(), VectorEMRobinBC::validParams(), GrainAdvectionAux::validParams(), TorqueTempl< is_ad >::validParams(), PorousFlowDarcyVelocityComponentTempl< is_ad >::validParams(), RANFSTieNode::validParams(), RANFSNormalMechanicalContact::validParams(), DarcyFluxComponent::validParams(), AEFVKernel::validParams(), and AEFVBC::validParams().
|
static |
Definition at line 121 of file NS.h.
Referenced by WCNSFVTurbulencePhysics::addAuxiliaryKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), WCNSFVTurbulencePhysics::addFluidEnergyTurbulenceKernels(), PNSFVSolidHeatTransferPhysics::addMaterials(), WCNSFVFluidHeatTransferPhysicsBase::addMaterials(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyTimeKernels(), AriaLaserWeld304LStainlessSteelFunctorMaterial::AriaLaserWeld304LStainlessSteelFunctorMaterial(), WCNSFVInletTemperatureBC::boundaryValue(), ThermalFunctionSolidPropertiesTest::buildObjects(), NSFVBase::commonFluidEnergyEquationParams(), QuadSubChannel1PhaseProblem::computeBeta(), TriSubChannel1PhaseProblem::computeBeta(), ADSimpleTurbine1PhaseUserObject::computeFluxesAndResiduals(), TriSubChannel1PhaseProblem::computeh(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), PrandtlNumberAux::computeValue(), FluidPropertiesInterrogator::computeVaporMixture(), ConjugateHTNumbersFunctorMaterialTempl< is_ad >::ConjugateHTNumbersFunctorMaterialTempl(), PBSodiumFluidProperties::cp_from_p_T(), HelmholtzFluidProperties::cp_from_p_T(), SodiumSaturationFluidProperties::cp_from_p_T(), SimpleFluidProperties::cp_from_p_T(), NaKFluidProperties::cp_from_p_T(), NaClFluidProperties::cp_from_p_T(), StiffenedGasFluidProperties::cp_from_p_T(), SalineMoltenSaltFluidProperties::cp_from_p_T(), TabulatedFluidProperties::cp_from_p_T(), LeadLithiumFluidProperties::cp_from_p_T(), LeadBismuthFluidProperties::cp_from_p_T(), CaloricallyImperfectGas::cp_from_p_T(), LeadFluidProperties::cp_from_p_T(), TemperaturePressureFunctionFluidProperties::cp_from_p_T(), FlibeFluidProperties::cp_from_p_T(), HeliumFluidProperties::cp_from_p_T(), FlinakFluidProperties::cp_from_p_T(), ThermalUCProperties::cp_from_T(), ThermalCompositeSiCProperties::cp_from_T(), ThermalGraphiteProperties::cp_from_T(), ThermalMonolithicSiCProperties::cp_from_T(), ThermalSS316Properties::cp_from_T(), ThermalFunctionSolidProperties::cp_from_T(), CaloricallyImperfectGas::cp_from_T(), StiffenedGasFluidProperties::cp_from_v_e(), LinearFluidProperties::cp_from_v_e(), CaloricallyImperfectGas::cp_from_v_e(), TestSinglePhaseFluidProperties::cp_from_v_e(), LeadLithiumFluidProperties::cp_from_v_e(), LeadBismuthFluidProperties::cp_from_v_e(), LeadFluidProperties::cp_from_v_e(), SimpleFluidProperties::cp_from_v_e(), TemperaturePressureFunctionFluidProperties::cp_from_v_e(), FlibeFluidProperties::cp_from_v_e(), FlinakFluidProperties::cp_from_v_e(), HeliumFluidProperties::cp_from_v_e(), TabulatedFluidProperties::cp_from_v_e(), LeadFluidProperties::cv_from_p_T(), LeadLithiumFluidProperties::cv_from_p_T(), LeadBismuthFluidProperties::cv_from_p_T(), FlibeFluidProperties::cv_from_v_e(), FlinakFluidProperties::cv_from_v_e(), SodiumSaturationFluidProperties::e_from_p_T(), FlibeFluidProperties::e_from_p_T(), FlinakFluidProperties::e_from_p_T(), CaloricallyImperfectGas::e_from_v_h(), SubChannel1PhaseProblem::externalSolve(), InterWrapper1PhaseProblem::externalSolve(), CaloricallyImperfectGas::gamma_from_p_T(), CaloricallyImperfectGas::gamma_from_v_e(), GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), LeadFluidProperties::h_from_p_T(), FlibeFluidProperties::h_from_p_T(), FlinakFluidProperties::h_from_p_T(), LeadBismuthFluidProperties::h_from_v_e(), LeadLithiumFluidProperties::h_from_v_e(), LeadFluidProperties::h_from_v_e(), FlibeFluidProperties::p_from_v_e(), FlinakFluidProperties::p_from_v_e(), THM::Peclet(), fp::prandtl(), HeatTransferUtils::prandtl(), THM::Prandtl(), prandtlPropertyDerivative(), FlibeFluidProperties::T_from_v_e(), FlinakFluidProperties::T_from_v_e(), TEST(), TEST_F(), fp::thermalDiffusivity(), HeatTransferUtils::thermalDiffusivity(), PINSFVEnergyTimeDerivative::validParams(), INSFVTurbulentTemperatureWallFunction::validParams(), WCNSFVEnergyFluxBC::validParams(), INSElementIntegralEnergyAdvectionTempl< is_ad >::validParams(), PNSFVSolidHeatTransferPhysics::validParams(), WCNSFVInletTemperatureBC::validParams(), NSFVOutflowTemperatureBC::validParams(), ThermalDiffusivityFunctorMaterial::validParams(), INSFVEnthalpyFunctorMaterial::validParams(), TurbulentConductivityAux::validParams(), WCNSFVMixingLengthEnergyDiffusion::validParams(), and GeneralFunctorFluidPropsTempl< is_ad >::validParams().
|
static |
Definition at line 119 of file NS.h.
Referenced by LaserWeld316LStainlessSteel::computeQpProperties().
|
static |
Definition at line 112 of file NS.h.
Referenced by FunctorIsotropicDragCoefficients< FunctorErgunDragCoefficients >::FunctorIsotropicDragCoefficients().
|
static |
Definition at line 122 of file NS.h.
Referenced by ADSimpleTurbine1PhaseUserObject::computeFluxesAndResiduals(), FluidPropertiesInterrogator::computeVaporMixture(), SodiumSaturationFluidProperties::cv_from_p_T(), LeadFluidProperties::cv_from_p_T(), SimpleFluidProperties::cv_from_p_T(), StiffenedGasFluidProperties::cv_from_p_T(), LeadBismuthFluidProperties::cv_from_p_T(), LeadLithiumFluidProperties::cv_from_p_T(), CaloricallyImperfectGas::cv_from_p_T(), TabulatedFluidProperties::cv_from_p_T(), TemperaturePressureFunctionFluidProperties::cv_from_p_T(), FlibeFluidProperties::cv_from_p_T(), FlinakFluidProperties::cv_from_p_T(), HeliumFluidProperties::cv_from_p_T(), CaloricallyImperfectGas::cv_from_T(), LinearFluidProperties::cv_from_v_e(), StiffenedGasFluidProperties::cv_from_v_e(), TestSinglePhaseFluidProperties::cv_from_v_e(), CaloricallyImperfectGas::cv_from_v_e(), LeadBismuthFluidProperties::cv_from_v_e(), LeadLithiumFluidProperties::cv_from_v_e(), LeadFluidProperties::cv_from_v_e(), SimpleFluidProperties::cv_from_v_e(), TemperaturePressureFunctionFluidProperties::cv_from_v_e(), FlibeFluidProperties::cv_from_v_e(), FlinakFluidProperties::cv_from_v_e(), TabulatedFluidProperties::cv_from_v_e(), HeliumFluidProperties::cv_from_v_e(), CaloricallyImperfectGas::e_from_v_h(), CaloricallyImperfectGas::gamma_from_p_T(), CaloricallyImperfectGas::gamma_from_v_e(), GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), NSTemperatureDerivs< NSEnergyViscousBC >::get_hess(), CaloricallyImperfectGas::setupLookupTables(), FlibeFluidProperties::T_from_v_e(), FlinakFluidProperties::T_from_v_e(), and TEST_F().
|
static |
Definition at line 33 of file NS.h.
Referenced by CNSAction::act(), WCNSFVTwoPhaseMixturePhysics::addAdvectionSlipTerm(), WCNSFVTurbulencePhysics::addAuxiliaryKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSFVFluidHeatTransferPhysics::addEnergyTimeKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), WCNSFVTurbulencePhysics::addFlowTurbulenceKernels(), WCNSFVTurbulencePhysics::addFluidEnergyTurbulenceKernels(), WCNSFVTurbulencePhysics::addFVBCs(), WCNSFVFlowPhysics::addInletBC(), WCNSFVTurbulencePhysics::addKEpsilonAdvection(), WCNSFVTurbulencePhysics::addKEpsilonSink(), WCNSFVFlowPhysics::addMassKernels(), WCNSFVFlowPhysics::addMassTimeKernels(), PNSFVSolidHeatTransferPhysics::addMaterials(), WCNSLinearFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTurbulencePhysics::addMaterials(), WCNSFVFluidHeatTransferPhysicsBase::addMaterials(), WCNSFVFlowPhysics::addMomentumAdvectionKernels(), WCNSLinearFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumGravityKernels(), WCNSFVFlowPhysics::addMomentumTimeKernels(), CNSAction::addNSInternalEnergyAux(), CNSAction::addNSMassInviscidFlux(), CNSAction::addNSMassUnspecifiedNormalFlowBC(), CNSAction::addNSMassWeakStagnationBC(), CNSAction::addNSSUPGMass(), CNSAction::addNSTimeKernels(), CNSAction::addNSVelocityAux(), WCNSFVFlowPhysics::addOutletBC(), WCNSFVTwoPhaseMixturePhysics::addPhaseChangeEnergySource(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyTimeKernels(), WCNSLinearFVFlowPhysics::addRhieChowUserObjects(), WCNSFVScalarTransportPhysics::addScalarInletBC(), WCNSFVFlowPhysics::addSolverVariables(), CNSAction::addSpecificTotalEnthalpyAux(), CNSAction::addSpecificVolumeComputation(), WCNSFVFlowPhysics::addWallsBC(), AriaLaserWeld304LStainlessSteelFunctorMaterial::AriaLaserWeld304LStainlessSteelFunctorMaterial(), HelmholtzFluidProperties::c_from_p_T(), NSFVBase::commonMomentumEquationParams(), RichardsMaterial::computeDerivedQuantities(), Q2PNodalMass::computeQpJacobian(), RichardsLumpedMassChange::computeQpJacobian(), Q2PNodalMass::computeQpOffDiagJacobian(), RichardsLumpedMassChange::computeQpOffDiagJacobian(), DensityTempl< is_ad >::computeQpProperties(), PorousFlowFluidStateBaseMaterialTempl< is_ad >::computeQpProperties(), Q2PNodalMass::computeQpResidual(), RichardsLumpedMassChange::computeQpResidual(), HelmholtzFluidProperties::cp_from_p_T(), HelmholtzFluidProperties::cv_from_p_T(), NaKFluidProperties::e_from_p_rho(), HelmholtzFluidProperties::e_from_p_T(), BrineFluidProperties::e_from_p_T_X(), NodalDensity::execute(), GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), HelmholtzFluidProperties::h_from_p_T(), SimpleFluidProperties::h_from_p_T(), BernoulliPressureVariable::initialSetup(), PorousFlowFluidStateBaseMaterialTempl< is_ad >::initQpStatefulProperties(), INSFVMomentumBoussinesq::INSFVMomentumBoussinesq(), NitrogenFluidProperties::k_from_p_T(), HydrogenFluidProperties::k_from_p_T(), CO2FluidProperties::k_from_p_T(), NitrogenFluidProperties::k_from_rho_T(), HydrogenFluidProperties::k_from_rho_T(), CO2FluidProperties::k_from_rho_T(), Water97FluidProperties::k_from_rho_T(), Water97FluidProperties::k_from_rho_T_template(), LinearFVMomentumBoussinesq::LinearFVMomentumBoussinesq(), NitrogenFluidProperties::mu_from_p_T(), HydrogenFluidProperties::mu_from_p_T(), NitrogenFluidProperties::mu_from_rho_T(), HydrogenFluidProperties::mu_from_rho_T(), CO2FluidProperties::mu_from_rho_T(), Water97FluidProperties::mu_from_rho_T(), Water97FluidProperties::mu_from_rho_T_template(), HelmholtzFluidProperties::p_from_rho_T(), CO2FluidProperties::p_from_rho_T(), PINSFVEnergyTimeDerivative::PINSFVEnergyTimeDerivative(), RichardsFullyUpwindFlux::prepareNodalValues(), Q2PSaturationFlux::prepareNodalValues(), Q2PPorepressureFlux::prepareNodalValues(), Q2PBorehole::prepareNodalValues(), RichardsBorehole::prepareNodalValues(), HelmholtzFluidProperties::rho_from_p_T(), CO2FluidProperties::rho_from_p_T(), Water97FluidProperties::rho_from_p_T_template(), HelmholtzFluidProperties::s_from_p_T(), CNSAction::setBCCommonParams(), CNSAction::setKernelCommonParams(), NaKFluidProperties::T_from_p_rho(), TEST_F(), PressureEqualsDensityMaterial::validParams(), PINSFVEnergyTimeDerivative::validParams(), INSFVMomentumTimeDerivative::validParams(), PCNSFVDensityTimeDerivative::validParams(), PINSFVMomentumFrictionCorrection::validParams(), INSFVEnergyTimeDerivative::validParams(), INSFVTurbulentTemperatureWallFunction::validParams(), INSFVMassAdvection::validParams(), NSFVPumpFunctorMaterial::validParams(), NSFVDispersePhaseDragFunctorMaterial::validParams(), PINSFVMomentumFriction::validParams(), ReynoldsNumberFunctorAux::validParams(), NSThermalBC::validParams(), INSFVkEpsilonViscosityFunctorMaterial::validParams(), INSFVMixingLengthReynoldsStress::validParams(), INSElementIntegralEnergyAdvectionTempl< is_ad >::validParams(), INSFVMomentumGravity::validParams(), INSFVTurbulentAdvection::validParams(), WCNSFV2PMomentumAdvectionSlip::validParams(), WCNSFV2PInterfaceAreaSourceSink::validParams(), WCNSFVEnergyTimeDerivative::validParams(), WCNSFVMomentumTimeDerivative::validParams(), NSFVPhaseChangeSource::validParams(), LinearFVMomentumBoussinesq::validParams(), PNSFVSolidHeatTransferPhysics::validParams(), INSFVMeshAdvection::validParams(), WCNSFVMassTimeDerivative::validParams(), INSFVMomentumBoussinesq::validParams(), WCNSFV2PSlipVelocityFunctorMaterial::validParams(), INSFVWallFunctionBC::validParams(), NSFVOutflowTemperatureBC::validParams(), WCNSFVInletVelocityBC::validParams(), WCNSFVInletTemperatureBC::validParams(), WCNSFVFluxBCBase::validParams(), NSImposedVelocityBC::validParams(), RANSYPlusAux::validParams(), INSFVTKESourceSink::validParams(), NSInternalEnergyAux::validParams(), INSFVEnthalpyFunctorMaterial::validParams(), INSFVMomentumAdvection::validParams(), PINSFVFunctorBC::validParams(), ThermalDiffusivityFunctorMaterial::validParams(), RhoFromPTFunctorMaterial::validParams(), INSFVTKEDSourceSink::validParams(), ConservedVarValuesMaterial::validParams(), WCNSFVMixingLengthEnergyDiffusion::validParams(), INSFVTurbulentViscosityWallFunction::validParams(), kEpsilonViscosityAux::validParams(), NavierStokesLHDGAssemblyHelper::validParams(), PorousConservedVarMaterial::validParams(), INSFVMomentumAdvectionOutflowBC::validParams(), INSFVTKEDWallFunctionBC::validParams(), INSFVMassAdvectionOutflowBC::validParams(), NSTemperatureL2::validParams(), ReynoldsNumberFunctorMaterial::validParams(), NSVelocityAux::validParams(), GeneralFunctorFluidPropsTempl< is_ad >::validParams(), NSIntegratedBC::validParams(), NSKernel::validParams(), BernoulliPressureVariable::validParams(), NSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), PNSInitialCondition::validParams(), NSSpecificTotalEnthalpyAux::validParams(), FunctorPebbleBedDragCoefficients< FunctorErgunDragCoefficients >::validParams(), NavierStokesMaterial::validParams(), RhieChowMassFlux::validParams(), NSImposedVelocityDirectionBC::validParams(), NSInitialCondition::value(), NSFunctionInitialCondition::value(), PNSInitialCondition::value(), and RichardsSUPGstandard::velSUPG().
|
static |
Definition at line 22 of file NS.h.
Referenced by WCNSFVTurbulencePhysics::addFlowTurbulenceKernels(), WCNSFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addMomentumAdvectionKernels(), WCNSLinearFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSLinearFVFlowPhysics::addMomentumFluxKernels(), WCNSLinearFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), WCNSLinearFVFlowPhysics::addMomentumGravityKernels(), WCNSFVFlowPhysics::addMomentumGravityKernels(), WCNSLinearFVFlowPhysics::addMomentumPressureKernels(), WCNSFVFlowPhysics::addMomentumPressureKernels(), WCNSLinearFVFlowPhysics::addMomentumTimeKernels(), WCNSFVFlowPhysics::addMomentumTimeKernels(), WCNSFVFlowPhysics::addMomentumViscousDissipationKernels(), WCNSFVFlowPhysics::addOutletBC(), WCNSFVFlowPhysics::addSeparatorBC(), WCNSFVFlowPhysics::addWallsBC(), XFEMRankTwoTensorMarkerUserObject::doesElementCrack(), TEST(), testDirections(), CoupledHeatTransferAction::validParams(), and CoupledDirectionalMeshHeightInterpolation::validParams().
|
static |
Definition at line 192 of file NS.h.
Referenced by INSFVTurbulentViscosityWallFunction::boundaryValue(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), kEpsilonViscosityAux::computeValue(), findUStar(), and findyPlus().
|
static |
|
static |
Definition at line 196 of file NS.h.
Referenced by kEpsilonViscosityAux::computeValue(), and INSFVkEpsilonViscosityFunctorMaterial::INSFVkEpsilonViscosityFunctorMaterial().
|
static |
Definition at line 165 of file NS.h.
Referenced by ReferenceElementJacobianDamper::computeDamping(), HillCreepStressUpdateTempl< is_ad >::computeDerivative(), DerivativeMultiPhaseBase::computeF(), CZMComputeDisplacementJumpTotalLagrangianTempl< is_ad >::computeFandR(), FlowModel1PhaseUtils::computeFluxFromPrimitive(), FlowModelGasMixUtils::computeFluxFromPrimitive(), MathCTDFreeEnergyTempl< is_ad >::computeQpProperties(), EshelbyTensorTempl< is_ad >::computeQpProperties(), BilinearMixedModeCohesiveZoneModel::computeQpProperties(), ComputeHypoelasticStVenantKirchhoffStress::computeQpSmallStress(), HillCreepStressUpdateTempl< is_ad >::computeQsigmaChanged(), HillCreepStressUpdateTempl< is_ad >::computeStrainFinalize(), FormIFunction(), PetscContactLineSearch::lineSearch(), PetscProjectSolutionOntoBounds::lineSearch(), HillConstantsTempl< is_ad >::rotateHillConstants(), and MMSTestFunc::value().
|
static |
Definition at line 87 of file NS.h.
Referenced by WCNSFVFluidHeatTransferPhysicsBase::addMaterials(), CNSFVHLLCStagnationInletBC::CNSFVHLLCStagnationInletBC(), PCNSFVStrongBC::validParams(), WCNSLinearFVFluidHeatTransferPhysics::validParams(), INSFVEnthalpyFunctorMaterial::validParams(), GeneralFluidProps::validParams(), PorousMixedVarMaterial::validParams(), PorousPrimitiveVarMaterial::validParams(), RhoFromPTFunctorMaterial::validParams(), PCNSFVHLLCBC::validParams(), HLLCUserObject::validParams(), LinearFVEnthalpyFunctorMaterial::validParams(), ConservedVarValuesMaterial::validParams(), SoundspeedMat::validParams(), PorousConservedVarMaterial::validParams(), CNSFVHLLCBCBase::validParams(), PCNSFVHLLC::validParams(), GeneralFunctorFluidPropsTempl< is_ad >::validParams(), PCNSFVKT::validParams(), CNSFVHLLCBase::validParams(), PCNSFVHLLC::waveSpeed(), and WCNSLinearFVFluidHeatTransferPhysics::WCNSLinearFVFluidHeatTransferPhysics().
|
static |
Definition at line 166 of file NS.h.
Referenced by buildStiffnessMatrix(), ComputeSimoHughesJ2PlasticityStress::computeDerivative(), HillCreepStressUpdateTempl< is_ad >::computeDerivative(), ComputeLayeredCosseratElasticityTensor::ComputeLayeredCosseratElasticityTensor(), ComputeFiniteStrain::computeQpIncrements(), ComputeSimoHughesJ2PlasticityStress::computeQpPK1Stress(), HillCreepStressUpdateTempl< is_ad >::computeQsigmaChanged(), ComputeSimoHughesJ2PlasticityStress::computeReferenceResidual(), ComputeSimoHughesJ2PlasticityStress::computeResidual(), HillCreepStressUpdateTempl< is_ad >::computeStrainFinalize(), FOR_NAME(), GradientOperator< C >::gradOp(), PetscContactLineSearch::lineSearch(), PetscProjectSolutionOntoBounds::lineSearch(), ComputeSimoHughesJ2PlasticityStress::preStep(), HillConstantsTempl< is_ad >::rotateHillConstants(), TEST_F(), and umat_().
|
static |
|
static |
Definition at line 61 of file NS.h.
Referenced by PorousFlowFluidStateBaseMaterialTempl< is_ad >::computeQpProperties(), Water97FluidProperties::e_from_p_T_template(), PorousFlowFluidStateBaseMaterialTempl< is_ad >::initQpStatefulProperties(), CaloricallyImperfectGas::setupLookupTables(), and TEST_F().
|
static |
Definition at line 130 of file NS.h.
Referenced by AddGeochemistrySolverAction::act(), DisplacementGradientsAction::act(), SolidMechanicsPlasticMeanCapTC::activeConstraints(), CoupledHeatTransferAction::addBCs(), AddCoupledEqSpeciesAction::AddCoupledEqSpeciesAction(), AddCoupledSolidKinSpeciesAction::AddCoupledSolidKinSpeciesAction(), WCNSFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyHeatConductionKernels(), RadiationTransferAction::addRadiationObject(), CoupledHeatTransferAction::addTransfers(), AriaLaserWeld304LStainlessSteelFunctorMaterial::AriaLaserWeld304LStainlessSteelFunctorMaterial(), PolygonMeshGeneratorBase::backgroundNodes(), Component2D::build2DMesh(), Component2D::build2DMesh2ndOrder(), Component2D::buildMesh(), FileMeshComponent::buildMesh(), Component1D::buildMesh(), ThermalFunctionSolidPropertiesTest::buildObjects(), FiniteStrainCrystalPlasticity::calc_schmid_tensor(), FiniteStrainCPSlipRateRes::calcDtauDsliprate(), CrystalPlasticitySlipRateGSS::calcFlowDirection(), FiniteStrainUObasedCP::calcJacobian(), FiniteStrainCrystalPlasticity::calcJacobian(), ComputeMultipleCrystalPlasticityStress::calculateJacobian(), MultiPlasticityLinearSystem::calculateJacobian(), CrystalPlasticityStressUpdateBase::calculateSchmidTensor(), CFLTimeStepSizeTempl< is_ad >::CFLTimeStepSizeTempl(), GeochemicalSystem::checkAndInitialize(), SingularShapeTensorEliminatorUserObjectPD::checkShapeTensorSingularity(), PolynomialQuadrature::clenshaw_curtis(), EFAFace::combineTwoEdges(), NSFVBase::commonFluidEnergyEquationParams(), RichardsMaterial::compute2ndDerivedQuantities(), neml2::LAROMANCE6DInterpolation::compute_interpolation(), InteractionIntegralTempl< is_ad >::computeAuxFields(), QuadSubChannel1PhaseProblem::computeBeta(), TriSubChannel1PhaseProblem::computeBeta(), ADComputeIncrementalShellStrain::computeBMatrix(), ADComputeFiniteShellStrain::computeBNLMatrix(), ComputeStrainBaseNOSPD::computeBondHorizonQpDeformationGradient(), HexagonalLatticeUtils::computeChannelPinIndices(), LatticeSmoothCircleIC::computeCircleCenters(), ComputeStrainBaseNOSPD::computeConventionalQpDeformationGradient(), DerivativeMultiPhaseMaterial::computeD3F(), DerivativeTwoPhaseMaterial::computeD3F(), MechanicsFiniteStrainBaseNOSPD::computeDinvFTDU(), GeneralizedPlaneStrainOffDiagOSPD::computeDispFullOffDiagJacobianScalar(), FiniteStrainHyperElasticViscoPlastic::computeDpk2Dfpinv(), CohesiveZoneModelTools::computedRdF(), MechanicsFiniteStrainBaseNOSPD::computeDSDFhat(), PODReducedBasisTrainer::computeEigenDecomposition(), MorrisReporterContext< DataType >::computeElementaryEffects(), ADComputeIncrementalShellStrain::computeGMatrix(), FiniteStrainHyperElasticViscoPlastic::computeIntVarDerivatives(), ShaftConnectableUserObjectInterface::computeMomentOfInertiaScalarJacobianWRTFlowDofs(), ADComputeFiniteShellStrain::computeNodeNormal(), ADComputeIncrementalShellStrain::computeNodeNormal(), MechanicsOSPD::computeNonlocalJacobian(), HorizonStabilizedFormIFiniteStrainMechanicsNOSPD::computeNonlocalJacobian(), HorizonStabilizedFormIIFiniteStrainMechanicsNOSPD::computeNonlocalJacobian(), HyperElasticPhaseFieldIsoDamage::computeNumStiffness(), HorizonStabilizedFormIFiniteStrainMechanicsNOSPD::computePDNonlocalOffDiagJacobian(), HorizonStabilizedFormIIFiniteStrainMechanicsNOSPD::computePDNonlocalOffDiagJacobian(), HyperElasticPhaseFieldIsoDamage::computePK2StressAndDerivative(), FiniteStrainHyperElasticViscoPlastic::computePK2StressAndDerivative(), ADComputeFiniteShellStrain::computeProperties(), RichardsPiecewiseLinearSinkFlux::computeQpIntegral(), Q2PPiecewiseLinearSinkFlux::computeQpIntegral(), NSMomentumViscousFlux::computeQpJacobian(), NSMomentumViscousBC::computeQpJacobian(), FiniteStrainHyperElasticViscoPlastic::computeQpJacobian(), NSEnergyViscousFlux::computeQpOffDiagJacobian(), NSMomentumViscousFlux::computeQpOffDiagJacobian(), INSChorinPredictor::computeQpOffDiagJacobian(), SLKKSMultiACBulkC::computeQpOffDiagJacobian(), SwitchingFunctionConstraintEta::computeQpOffDiagJacobian(), InertialTorque::computeQpOffDiagJacobian(), PhaseFieldFractureMechanicsOffDiag::computeQpOffDiagJacobian(), INSSplitMomentum::computeQpOffDiagJacobian(), StressDivergenceRZTensors::computeQpOffDiagJacobian(), NSMomentumViscousBC::computeQpOffDiagJacobian(), NSEnergyViscousBC::computeQpOffDiagJacobian(), ComputeSimoHughesJ2PlasticityStress::computeQpPK1Stress(), StrainGradDispDerivatives::computeQpProperties(), ComputeCosseratSmallStrain::computeQpProperties(), ComputeCosseratIncrementalSmallStrain::computeQpProperties(), ElectrochemicalSinteringMaterial::computeQpProperties(), ADComputeIsotropicElasticityTensorShell::computeQpProperties(), ForceDensityMaterial::computeQpProperties(), ThirdPhaseSuppressionMaterial::computeQpProperties(), INSChorinPredictor::computeQpResidual(), InertialTorque::computeQpResidual(), MomentBalancing::computeQpResidual(), INSSplitMomentum::computeQpResidual(), PorousFlowSink::computeQpResidual(), Q2PPiecewiseLinearSink::computeQpResidual(), RichardsPiecewiseLinearSink::computeQpResidual(), ComputeHypoelasticStVenantKirchhoffStress::computeQpSmallStress(), AbaqusUMATStress::computeQpStress(), NodalRankTwoPD::computeRankTwoTensors(), ADInertialForceShell::computeShellInertialForces(), ComputeLinearElasticPFFractureStress::computeStrainVolDev(), NavierStokesMaterial::computeStrongResiduals(), RichardsMaterial::computeSUPG(), HEVPFlowRatePowerLawJ2::computeTensorDerivative(), ShaftConnectableUserObjectInterface::computeTorqueScalarJacobianWRTFlowDofs(), PrandtlNumberAux::computeValue(), FluidPropertiesInterrogator::computeVaporMixture(), ComputeVolumetricEigenstrain::ComputeVolumetricEigenstrain(), ConjugateHTNumbersFunctorMaterialTempl< is_ad >::ConjugateHTNumbersFunctorMaterialTempl(), EFAElement2D::connectNeighbors(), EFAElement3D::connectNeighbors(), EFAFragment3D::connectSubfaces(), SolidMechanicsPlasticMeanCapTC::consistentTangentOperator(), SolidMechanicsPlasticTensileMulti::consistentTangentOperator(), CappedDruckerPragerCosseratStressUpdate::consistentTangentOperator(), CappedDruckerPragerStressUpdate::consistentTangentOperator(), TwoParameterPlasticityStressUpdate::consistentTangentOperator(), ComputeMultiPlasticityStress::consistentTangentOperator(), CappedMohrCoulombCosseratStressUpdate::consistentTangentOperatorV(), TensileStressUpdate::consistentTangentOperatorV(), CappedMohrCoulombStressUpdate::consistentTangentOperatorV(), EFAElement2D::createChild(), EFAElement3D::createFaces(), PeridynamicsMesh::createNeighborHorizonBasedData(), PeridynamicsMesh::createNodeHorizBasedData(), PeridynamicsMesh::createPeridynamicsMeshData(), SurrogateTrainer::crossValidate(), HeatTransferModels::cylindricalThermalConductance(), CappedWeakPlaneStressUpdate::d2qdstress2(), DerivativeMultiPhaseBase::DerivativeMultiPhaseBase(), DerivativeTwoPhaseMaterial::DerivativeTwoPhaseMaterial(), SolidMechanicsPlasticTensile::dflowPotential_dstress(), SolidMechanicsPlasticMohrCoulomb::dflowPotential_dstress(), SolidMechanicsPlasticWeakPlaneShear::dflowPotential_dstress(), SolidMechanicsPlasticJ2::dflowPotential_dstress(), DiscreteLineSegmentInterface::DiscreteLineSegmentInterface(), MultiParameterPlasticityStressUpdate::dnRHSdVar(), NSViscStressTensorDerivs< NSEnergyViscousBC >::dtau(), PolygonMeshGeneratorBase::ductNodes(), MultiParameterPlasticityStressUpdate::dVardTrial(), EFAFace::EFAFace(), ElasticityTensorTools::elasticJacobian(), ElasticityTensorTools::elasticJacobianWC(), ComputeMultipleCrystalPlasticityStress::elastoPlasticTangentModuli(), FiniteStrainUObasedCP::elastoPlasticTangentModuli(), FiniteStrainCrystalPlasticity::elastoPlasticTangentModuli(), ElectrochemicalSinteringMaterial::ElectrochemicalSinteringMaterial(), euler2RGB(), Legendre::evaluateOrthonormal(), CompositeSeriesBasisInterface::evaluateSeries(), Legendre::evaluateStandard(), CFLTimeStepSizeTempl< is_ad >::execute(), ComputeGrainForceAndTorque::executeJacobian(), ComputeExternalGrainForceAndTorque::executeJacobian(), SubChannel1PhaseProblem::externalSolve(), InterWrapper1PhaseProblem::externalSolve(), MultiPlasticityDebugger::fddflowPotential_dstress(), MultiPlasticityDebugger::fdJacobian(), AdvectiveFluxCalculatorBase::finalize(), MorrisReporterContext< DataType >::finalize(), CrackMeshCut3DUserObject::findBoundaryEdges(), FinEfficiencyFunctorMaterialTempl< is_ad >::FinEfficiencyFunctorMaterialTempl(), CompositeSeriesBasisInterface::formatCoefficients(), EFAElement2D::fragmentSanityCheck(), GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), RevolveGenerator::generate(), MeshGeneratorPD::generate(), DetailedPinMeshGeneratorBase::generatePin(), GeochemistryTimeDependentReactor::GeochemistryTimeDependentReactor(), GeochemicalSystem::getAlgebraicVariableDenseValues(), GeochemicalSystem::getAlgebraicVariableValues(), EFAElement3D::getCommonEdgeID(), DiscreteLineSegmentInterface::getElementBoundaryCoordinates(), GeochemicalSystem::getKineticMoles(), ShaftConnectableUserObjectInterface::getMomentOfInertiaJacobianData(), EFAElement2D::getPhantomNodeOnEdge(), EFAElement3D::getPhantomNodeOnFace(), XFEMCutElem2D::getPhysicalQuadraturePoints(), ShaftConnectableUserObjectInterface::getTorqueJacobianData(), LAROMANCEStressUpdateBaseTempl< is_ad >::getTransformedLimits(), XFEM::getXFEMqRuleOnSurface(), CrackMeshCut3DUserObject::growFront(), GrainForceAndTorqueSum::initialize(), MaskedGrainForceAndTorque::initialize(), StochasticTools::inplaceSort(), EFAFragment3D::isEdgeConnected(), Q2PPiecewiseLinearSink::jac(), PorousFlowSink::jac(), RichardsPiecewiseLinearSink::jac(), MethaneFluidProperties::k_from_p_T(), SodiumSaturationFluidProperties::k_from_p_T(), NaKFluidProperties::k_from_p_T(), NitrogenFluidProperties::k_from_p_T(), SimpleFluidProperties::k_from_p_T(), HydrogenFluidProperties::k_from_p_T(), NaClFluidProperties::k_from_p_T(), StiffenedGasFluidProperties::k_from_p_T(), LeadBismuthFluidProperties::k_from_p_T(), LeadLithiumFluidProperties::k_from_p_T(), LeadFluidProperties::k_from_p_T(), CaloricallyImperfectGas::k_from_p_T(), TabulatedFluidProperties::k_from_p_T(), IdealGasFluidProperties::k_from_p_T(), SalineMoltenSaltFluidProperties::k_from_p_T(), CO2FluidProperties::k_from_p_T(), TemperaturePressureFunctionFluidProperties::k_from_p_T(), FlibeFluidProperties::k_from_p_T(), HeliumFluidProperties::k_from_p_T(), FlinakFluidProperties::k_from_p_T(), ThermalUCProperties::k_from_T(), ThermalCompositeSiCProperties::k_from_T(), ThermalGraphiteProperties::k_from_T(), ThermalMonolithicSiCProperties::k_from_T(), ThermalSS316Properties::k_from_T(), ThermalFunctionSolidProperties::k_from_T(), StiffenedGasFluidProperties::k_from_v_e(), CaloricallyImperfectGas::k_from_v_e(), TestSinglePhaseFluidProperties::k_from_v_e(), LeadBismuthFluidProperties::k_from_v_e(), LeadLithiumFluidProperties::k_from_v_e(), IdealGasFluidProperties::k_from_v_e(), LeadFluidProperties::k_from_v_e(), SimpleFluidProperties::k_from_v_e(), TabulatedFluidProperties::k_from_v_e(), PolynomialQuadrature::legendre(), ElasticityTensorTools::momentJacobian(), ElasticityTensorTools::momentJacobianWC(), GeochemistryTimeDependentReactor::newTemperature(), IndependentMHDecision::nextSamples(), PMCMCDecision::nextSamples(), IndependentMHDecision::nextSeeds(), ComputeLagrangianObjectiveStress::objectiveUpdateGreenNaghdi(), ComputeLagrangianObjectiveStress::objectiveUpdateJaumann(), GatherRCDataFaceThread< RangeType >::onFace(), GeochemistryConsoleOutput::output(), THM::Peclet(), ComputeLagrangianObjectiveStress::polarDecomposition(), GeochemistryTimeDependentReactor::postSolveFlowThrough(), fp::prandtl(), HeatTransferUtils::prandtl(), THM::Prandtl(), prandtlPropertyDerivative(), PolycrystalHex::precomputeGrainStructure(), SLKKSMultiACBulkC::precomputeQpJacobian(), SLKKSMultiPhaseConcentration::precomputeQpResidual(), SLKKSMultiACBulkC::precomputeQpResidual(), GeochemistryTimeDependentReactor::preSolveFlush(), EFAElement2D::printElement(), EFAElement3D::printElement(), PolygonMeshGeneratorBase::quadElemDef(), CrackMeshCut3DUserObject::refineBoundary(), CrackMeshCut3DUserObject::refineFront(), GeochemistryTimeDependentReactor::removeCurrentSpecies(), EFAElement3D::removePhantomEmbeddedNode(), StochasticTools::reshapeVector(), SolidMechanicsPlasticMeanCapTC::returnMap(), PolygonMeshGeneratorBase::ringNodes(), TriInterWrapperMesh::rodPositions(), TriSubChannelMesh::rodPositions(), SCMDetailedTriSubChannelMeshGenerator::SCMDetailedTriSubChannelMeshGenerator(), SCMTriInterWrapperMeshGenerator::SCMTriInterWrapperMeshGenerator(), SCMTriSubChannelMeshGenerator::SCMTriSubChannelMeshGenerator(), GeochemicalSystem::setAlgebraicVariables(), AttribINSFVBCs::setFrom(), AttribINSFVMomentumResidualObject::setFrom(), GeochemicalSystem::setKineticMoles(), GeochemicalSystem::setMineralRelatedFreeMoles(), Xfem::shapeFunc2D(), SLKKSMultiPhaseBase::SLKKSMultiPhaseBase(), SolidMechanicsPlasticIsotropicSD::SolidMechanicsPlasticIsotropicSD(), XFEMCutElem2D::solveMomentFitting(), CrystalPlasticityStressUpdateBase::sortCrossSlipFamilies(), ADVolumeJunctionBaseUserObject::storeConnectionData(), ComputeLagrangianObjectiveStress::stressAdvectionDerivative(), EFAElement2D::switchNode(), EFAElement3D::switchNode(), TEST(), TEST_F(), fp::thermalDiffusivity(), HeatTransferUtils::thermalDiffusivity(), ElasticityTensorTools::toMooseVoigtNotationIndexConversion(), ElasticityTensorTools::toVoigtNotationIndexConversion(), CrystalPlasticityStressUpdateBase::transformHexagonalMillerBravaisSlipSystems(), CrackMeshCut3DUserObject::triangulation(), ADComputeFiniteShellStrain::updatedxyz(), GeochemicalSystem::updateOldWithCurrent(), ComputeLagrangianObjectiveStress::updateTensor(), ThermalDiffusivityFunctorMaterial::validParams(), PINSFVEnergyDiffusion::validParams(), GeneralFunctorFluidPropsTempl< is_ad >::validParams(), NSFVFunctorHeatFluxBC::validParams(), MMSTestFunc::value(), wallHeatTransferCoefficient(), and Simulation::~Simulation().
|
static |
Definition at line 170 of file NS.h.
Referenced by ExponentialCovariance::computeCovarianceMatrix(), MaternHalfIntCovariance::computeCovarianceMatrix(), SquaredExponentialCovariance::computeCovarianceMatrix(), LMC::computeCovarianceMatrix(), HillPlasticityStressUpdateTempl< is_ad >::computeDeltaDerivatives(), HillElastoPlasticityStressUpdateTempl< is_ad >::computeDeltaDerivatives(), SquaredExponentialCovariance::computedKdlf(), ExponentialCovariance::computedKdlf(), MaternHalfIntCovariance::computedKdlf(), TriSubChannel1PhaseProblem::computeh(), HillPlasticityStressUpdateTempl< is_ad >::computeOmega(), HillElastoPlasticityStressUpdateTempl< is_ad >::computeOmega(), ComputeSimoHughesJ2PlasticityStress::computeQpPK1Stress(), ADWallHTCGnielinskiAnnularMaterial::computeQpProperties(), ExponentialCovariance::ExponentialFunction(), INSFVMushyPorousFrictionFunctorMaterial::INSFVMushyPorousFrictionFunctorMaterial(), MaternHalfIntCovariance::maternHalfIntFunction(), sobolidx(), and SquaredExponentialCovariance::SquaredExponentialFunction().
|
static |
Definition at line 120 of file NS.h.
Referenced by LaserWeld316LStainlessSteel::computeQpProperties(), and NSFVFunctorHeatFluxBC::validParams().
|
static |
Definition at line 132 of file NS.h.
Referenced by WCNSFVTurbulencePhysics::addAuxiliaryKernels(), WCNSFVTurbulencePhysics::addAuxiliaryVariables(), WCNSFVTurbulencePhysics::addFluidEnergyTurbulenceKernels(), WCNSFVTurbulencePhysics::addMaterials(), and WCNSFVTurbulencePhysics::WCNSFVTurbulencePhysics().
|
static |
Definition at line 116 of file NS.h.
Referenced by GrandPotentialKernelAction::act(), WCNSFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyHeatConductionKernels(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), NSFVFunctorHeatFluxBC::computeQpResidual(), NSFVHeatFluxBC::computeQpResidual(), FunctorIsotropicEffectiveFluidThermalConductivity< FunctorKappaFluid >::FunctorIsotropicEffectiveFluidThermalConductivity(), RadiativeP1DiffusionCoefficientMaterialTempl< is_ad >::RadiativeP1DiffusionCoefficientMaterialTempl(), INSFVTurbulentTemperatureWallFunction::validParams(), PINSFVEnergyAnisotropicDiffusion::validParams(), and NSFVFunctorHeatFluxBC::validParams().
|
static |
Definition at line 117 of file NS.h.
Referenced by NSFVFunctorHeatFluxBC::validParams().
|
static |
Definition at line 147 of file NS.h.
Referenced by WCNSFVTwoPhaseMixturePhysics::addPhaseChangeEnergySource().
|
static |
Definition at line 80 of file NS.h.
Referenced by CNSAction::act(), CNSAction::addNSMachAux(), NSInitialCondition::validParams(), PNSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), NSInitialCondition::value(), PNSInitialCondition::value(), and NSFunctionInitialCondition::value().
|
static |
Definition at line 198 of file NS.h.
Referenced by findyPlus().
|
static |
Definition at line 74 of file NS.h.
Referenced by WCNSFVTurbulencePhysics::addFlowTurbulenceKernels(), WCNSFVTurbulencePhysics::addFluidEnergyTurbulenceKernels(), WCNSFVTurbulencePhysics::addMaterials(), and WCNSFVTurbulencePhysics::addScalarAdvectionTurbulenceKernels().
|
static |
|
static |
Definition at line 35 of file NS.h.
Referenced by CNSAction::act(), CNSAction::addNoPenetrationBC(), CNSAction::addNSMomentumInviscidFlux(), CNSAction::addNSMomentumInviscidSpecifiedPressureBC(), CNSAction::addNSMomentumWeakStagnationBC(), CNSAction::addNSSUPGMomentum(), CNSAction::addNSTimeKernels(), CNSAction::addNSVelocityAux(), CNSAction::coupleMomentums(), PressureEqualsDensityMaterial::validParams(), ConservedVarValuesMaterial::validParams(), CNSFVHLLCSpecifiedMassFluxAndTemperatureBC::validParams(), NSKernel::validParams(), NSIntegratedBC::validParams(), NSInitialCondition::validParams(), PNSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), NavierStokesMaterial::validParams(), NSInitialCondition::value(), NSFunctionInitialCondition::value(), and PNSInitialCondition::value().
|
static |
Definition at line 36 of file NS.h.
Referenced by CNSAction::act(), CNSAction::addNoPenetrationBC(), CNSAction::addNSMomentumInviscidFlux(), CNSAction::addNSMomentumInviscidSpecifiedPressureBC(), CNSAction::addNSMomentumWeakStagnationBC(), CNSAction::addNSSUPGMomentum(), CNSAction::addNSTimeKernels(), CNSAction::addNSVelocityAux(), CNSAction::coupleMomentums(), PressureEqualsDensityMaterial::validParams(), ConservedVarValuesMaterial::validParams(), CNSFVHLLCSpecifiedMassFluxAndTemperatureBC::validParams(), NSKernel::validParams(), NSIntegratedBC::validParams(), NSInitialCondition::validParams(), PNSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), NavierStokesMaterial::validParams(), NSInitialCondition::value(), NSFunctionInitialCondition::value(), and PNSInitialCondition::value().
|
static |
Definition at line 37 of file NS.h.
Referenced by CNSAction::act(), CNSAction::addNoPenetrationBC(), CNSAction::addNSMomentumInviscidFlux(), CNSAction::addNSMomentumInviscidSpecifiedPressureBC(), CNSAction::addNSMomentumWeakStagnationBC(), CNSAction::addNSSUPGMomentum(), CNSAction::addNSTimeKernels(), CNSAction::addNSVelocityAux(), CNSAction::coupleMomentums(), PressureEqualsDensityMaterial::validParams(), ConservedVarValuesMaterial::validParams(), CNSFVHLLCSpecifiedMassFluxAndTemperatureBC::validParams(), NSKernel::validParams(), NSIntegratedBC::validParams(), NSInitialCondition::validParams(), PNSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), NavierStokesMaterial::validParams(), NSInitialCondition::value(), NSFunctionInitialCondition::value(), and PNSInitialCondition::value().
|
static |
Definition at line 123 of file NS.h.
Referenced by WCNSFVTurbulencePhysics::addAuxiliaryKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), WCNSFVTurbulencePhysics::addFVBCs(), WCNSFVTurbulencePhysics::addKEpsilonSink(), WCNSLinearFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTurbulencePhysics::addMaterials(), WCNSLinearFVFlowPhysics::addMomentumFluxKernels(), WCNSLinearFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumViscousDissipationKernels(), WCNSFVFlowPhysics::addWallsBC(), AriaLaserWeld304LStainlessSteelFunctorMaterial::AriaLaserWeld304LStainlessSteelFunctorMaterial(), INSFVTurbulentViscosityWallFunction::boundaryValue(), INSFVTKEDWallFunctionBC::boundaryValue(), NSFVBase::commonMomentumEquationParams(), HyperElasticPhaseFieldIsoDamage::computeDamageStress(), IntegralDirectedSurfaceForce::computeFaceInfoIntegral(), PINSFVMomentumFriction::computeFrictionWCoefficient(), TriSubChannel1PhaseProblem::computeh(), PorousFlowBrine::computeQpProperties(), PorousFlowMultiComponentFluidTempl< is_ad >::computeQpProperties(), PorousFlowSingleComponentFluidTempl< is_ad >::computeQpProperties(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), INSFVTKESourceSink::computeQpResidual(), INSFVTKEDSourceSink::computeQpResidual(), ComputeLinearElasticPFFractureStress::computeStrainSpectral(), ComputeLinearElasticPFFractureStress::computeStrainVolDev(), PrandtlNumberAux::computeValue(), WallFunctionWallShearStressAux::computeValue(), WallFunctionYPlusAux::computeValue(), RANSYPlusAux::computeValue(), kEpsilonViscosityAux::computeValue(), FluidPropertiesInterrogator::computeVaporMixture(), ConjugateHTNumbersFunctorMaterialTempl< is_ad >::ConjugateHTNumbersFunctorMaterialTempl(), SolidMechanicsPlasticJ2::consistentTangentOperator(), SolidMechanicsPlasticDruckerPragerHyperbolic::consistentTangentOperator(), SolidMechanicsPlasticTensileMulti::consistentTangentOperator(), NSViscStressTensorDerivs< NSEnergyViscousBC >::dtau(), SubChannel1PhaseProblem::externalSolve(), InterWrapper1PhaseProblem::externalSolve(), MorrisReporterContext< DataType >::finalize(), findUStar(), findyPlus(), PolynomialQuadrature::gauss_hermite(), GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), fp::grashof(), HeatTransferUtils::grashof(), PolynomialQuadrature::hermite(), KernelDensity1D::KernelDensity1D(), fp::laplace(), HeatTransferUtils::laplace(), MorrisReporterContext< DataType >::MorrisReporterContext(), MethaneFluidProperties::mu_from_p_T(), CO2FluidProperties::mu_from_p_T(), NitrogenFluidProperties::mu_from_p_T(), HydrogenFluidProperties::mu_from_p_T(), NaKFluidProperties::mu_from_p_T(), SodiumSaturationFluidProperties::mu_from_p_T(), StiffenedGasFluidProperties::mu_from_p_T(), TabulatedFluidProperties::mu_from_p_T(), CaloricallyImperfectGas::mu_from_p_T(), LeadBismuthFluidProperties::mu_from_p_T(), LeadLithiumFluidProperties::mu_from_p_T(), LeadFluidProperties::mu_from_p_T(), SalineMoltenSaltFluidProperties::mu_from_p_T(), IdealGasFluidProperties::mu_from_p_T(), Water97FluidProperties::mu_from_p_T(), SimpleFluidProperties::mu_from_p_T(), TemperaturePressureFunctionFluidProperties::mu_from_p_T(), FlibeFluidProperties::mu_from_p_T(), HeliumFluidProperties::mu_from_p_T(), FlinakFluidProperties::mu_from_p_T(), BrineFluidProperties::mu_from_p_T_X(), NitrogenFluidProperties::mu_from_rho_T(), HydrogenFluidProperties::mu_from_rho_T(), CO2FluidProperties::mu_from_rho_T(), Water97FluidProperties::mu_from_rho_T(), StiffenedGasFluidProperties::mu_from_v_e(), LinearTestFluidProperties::mu_from_v_e(), TestSinglePhaseFluidProperties::mu_from_v_e(), CaloricallyImperfectGas::mu_from_v_e(), LeadLithiumFluidProperties::mu_from_v_e(), LeadBismuthFluidProperties::mu_from_v_e(), LeadFluidProperties::mu_from_v_e(), IdealGasFluidProperties::mu_from_v_e(), TabulatedFluidProperties::mu_from_v_e(), SimpleFluidProperties::mu_from_v_e(), PINSFVMomentumFriction::PINSFVMomentumFriction(), PolynomialChaosTrainer::postTrain(), PolynomialRegressionTrainer::postTrain(), fp::prandtl(), HeatTransferUtils::prandtl(), THM::Prandtl(), prandtlPropertyDerivative(), SolidMechanicsPlasticJ2::returnMap(), SolidMechanicsPlasticDruckerPragerHyperbolic::returnMap(), HeatTransferUtils::reynolds(), fp::reynolds(), THM::Reynolds(), reynoldsPropertyDerivative(), NitrogenFluidProperties::rho_mu_from_p_T(), HydrogenFluidProperties::rho_mu_from_p_T(), CO2FluidProperties::rho_mu_from_p_T(), Water97FluidProperties::rho_mu_from_p_T(), SinglePhaseFluidProperties::rho_mu_from_p_T(), MultiComponentFluidProperties::rho_mu_from_p_T_X(), TEST(), TEST_F(), PINSFVMomentumFrictionCorrection::validParams(), ReynoldsNumberFunctorAux::validParams(), PINSFVMomentumFriction::validParams(), INSFVTurbulentTemperatureWallFunction::validParams(), LinearFVMomentumFriction::validParams(), NSFVDispersePhaseDragFunctorMaterial::validParams(), INSFVMushyPorousFrictionFunctorMaterial::validParams(), RANSYPlusAux::validParams(), WCNSFV2PSlipVelocityFunctorMaterial::validParams(), INSFVTKESourceSink::validParams(), INSFVMomentumDiffusion::validParams(), kEpsilonViscosityAux::validParams(), INSFVTurbulentViscosityWallFunction::validParams(), NavierStokesLHDGAssemblyHelper::validParams(), INSFVTKEDSourceSink::validParams(), LinearWCNSFVMomentumFlux::validParams(), INSFVTKEDWallFunctionBC::validParams(), ReynoldsNumberFunctorMaterial::validParams(), GeneralFunctorFluidPropsTempl< is_ad >::validParams(), and IntegralDirectedSurfaceForce::validParams().
|
static |
Definition at line 129 of file NS.h.
Referenced by WCNSFVTurbulencePhysics::addMaterials().
|
static |
Definition at line 125 of file NS.h.
Referenced by WCNSFVTurbulencePhysics::addAuxiliaryKernels(), WCNSFVTurbulencePhysics::addFVBCs(), WCNSFVTurbulencePhysics::addKEpsilonSink(), WCNSFVTurbulencePhysics::addMaterials(), kEpsilonViscosityAux::computeValue(), INSFVkEpsilonViscosityFunctorMaterial::INSFVkEpsilonViscosityFunctorMaterial(), INSFVTKESourceSink::validParams(), INSFVTurbulentViscosityWallFunction::validParams(), TurbulentConductivityAux::validParams(), INSFVTKEDSourceSink::validParams(), and INSFVTKEDWallFunctionBC::validParams().
|
static |
Definition at line 194 of file NS.h.
Referenced by INSFVTurbulentViscosityWallFunction::boundaryValue(), kEpsilonViscosityAux::computeValue(), and INSFVkEpsilonViscosityFunctorMaterial::INSFVkEpsilonViscosityFunctorMaterial().
|
static |
Definition at line 127 of file NS.h.
Referenced by WCNSFVTurbulencePhysics::addMaterials(), and WCNSFVTurbulencePhysics::addScalarAdvectionTurbulenceKernels().
|
static |
Definition at line 25 of file NS.h.
Referenced by FunctorPebbleBedDragCoefficients< FunctorErgunDragCoefficients >::validParams().
|
static |
Definition at line 104 of file NS.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyTimeKernels(), WCNSFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addMassTimeKernels(), WCNSFVFlowPhysics::addMomentumAdvectionKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumGravityKernels(), WCNSFVFlowPhysics::addMomentumPressureKernels(), WCNSFVFlowPhysics::addMomentumViscousDissipationKernels(), WCNSFVFlowPhysics::addOutletBC(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyHeatConductionKernels(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyTimeKernels(), WCNSFVFlowPhysicsBase::addPorousMediumSpeedMaterial(), WCNSFVFlowPhysics::addRhieChowUserObjects(), WCNSFVScalarTransportPhysics::addScalarAdvectionKernels(), WCNSFVFlowPhysics::addSolverVariables(), INSFEFluidMassKernel::computeQpJacobian(), INSFEFluidMomentumKernel::computeQpJacobian(), INSFEFluidWallMomentumBC::computeQpJacobian(), INSFEFluidEnergyKernel::computeQpJacobian(), INSFEFluidMomentumBC::computeQpJacobian(), INSFEFluidWallMomentumBC::computeQpOffDiagJacobian(), INSFEFluidMomentumKernel::computeQpOffDiagJacobian(), INSFEFluidMomentumBC::computeQpOffDiagJacobian(), PorousFlowPorosityLinear::computeQpProperties(), INSFEFluidMassKernel::computeQpResidual(), INSFEFluidMomentumKernel::computeQpResidual(), INSFEFluidWallMomentumBC::computeQpResidual(), INSFEFluidEnergyKernel::computeQpResidual(), INSFEFluidMomentumBC::computeQpResidual(), BernoulliPressureVariable::initialSetup(), isPorosityJumpFace(), PINSFVRhieChowInterpolator::PINSFVRhieChowInterpolator(), PINSFVRhieChowInterpolatorSegregated::PINSFVRhieChowInterpolatorSegregated(), PCNSFVDensityTimeDerivative::validParams(), PINSFVEnergyTimeDerivative::validParams(), PINSFVMomentumPressurePorosityGradient::validParams(), PCNSFVMomentumFriction::validParams(), HasPorosityJumpFace::validParams(), PINSFVMomentumAdvection::validParams(), NSFVBase::validParams(), PINSFVMomentumDiffusion::validParams(), PINSFVMomentumFriction::validParams(), PINSFVMomentumPressure::validParams(), PWCNSFVMomentumFluxBC::validParams(), PWCNSFVMassTimeDerivative::validParams(), PINSFVRhieChowInterpolatorSegregated::validParams(), FVPorosityTimeDerivative::validParams(), PINSFVSpeedFunctorMaterial::validParams(), PINSFVMomentumBoussinesq::validParams(), PINSFVScalarFieldAdvection::validParams(), PINSFVMomentumGravity::validParams(), PINSFVMomentumPressureFlux::validParams(), PINSFVMomentumAdvectionOutflowBC::validParams(), PINSFVEnergyAnisotropicDiffusion::validParams(), LinearFrictionFactorFunctorMaterial::validParams(), GeneralFluidProps::validParams(), PINSFVFunctorBC::validParams(), HLLCUserObject::validParams(), PorousMixedVarMaterial::validParams(), PorousPrimitiveVarMaterial::validParams(), PorousConservedVarMaterial::validParams(), PINSFVRhieChowInterpolator::validParams(), PINSFVEnergyDiffusion::validParams(), PNSFVMomentumPressureFluxRZ::validParams(), GeneralFunctorFluidPropsTempl< is_ad >::validParams(), BernoulliPressureVariable::validParams(), FunctorPebbleBedDragCoefficients< FunctorErgunDragCoefficients >::validParams(), NSFVHeatFluxBC::validParams(), and NSFVFunctorHeatFluxBC::validParams().
|
static |
Definition at line 137 of file NS.h.
Referenced by GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), and DittusBoelterFunctorMaterialTempl< is_ad >::validParams().
|
static |
Definition at line 56 of file NS.h.
Referenced by INSAction::act(), CNSAction::act(), PorousFlowBrineCO2::activityCoefficient(), INSAction::addINSMomentum(), INSAction::addINSNoBCBC(), INSAction::addINSPressureBC(), WCNSFVFluidHeatTransferPhysicsBase::addMaterials(), CNSAction::addNoPenetrationBC(), CNSAction::addNSMomentumInviscidFlux(), CNSAction::addSpecificTotalEnthalpyAux(), Water97FluidProperties::b23T(), Water97FluidProperties::b2bc(), Water97FluidProperties::b3ab(), SimpleFluidProperties::beta_from_p_T(), HeliumFluidProperties::beta_from_p_T(), TemperaturePressureFunctionFluidProperties::beta_from_p_T(), FlinakFluidProperties::beta_from_p_T(), StiffenedGasFluidProperties::c2_from_p_rho(), HelmholtzFluidProperties::c_from_p_T(), SimpleFluidProperties::c_from_p_T(), TabulatedFluidProperties::c_from_p_T(), Water97FluidProperties::c_from_p_T_template(), TabulatedFluidProperties::checkInputVariables(), PorousFlowBrineCO2::checkVariables(), IntegralDirectedSurfaceForce::computeFaceInfoIntegral(), PorousFlowFluidStateBaseMaterialTempl< is_ad >::computeQpProperties(), PBSodiumFluidProperties::cp_from_p_T(), HelmholtzFluidProperties::cp_from_p_T(), SodiumSaturationFluidProperties::cp_from_p_T(), SimpleFluidProperties::cp_from_p_T(), NaClFluidProperties::cp_from_p_T(), SalineMoltenSaltFluidProperties::cp_from_p_T(), StiffenedGasFluidProperties::cp_from_p_T(), TabulatedFluidProperties::cp_from_p_T(), Water97FluidProperties::cp_from_p_T(), TemperaturePressureFunctionFluidProperties::cp_from_p_T(), FlibeFluidProperties::cp_from_p_T(), HeliumFluidProperties::cp_from_p_T(), FlinakFluidProperties::cp_from_p_T(), Water97FluidProperties::cp_from_p_T_template(), BrineFluidProperties::cp_from_p_T_X(), PBSodiumFluidProperties::cv_from_p_T(), HelmholtzFluidProperties::cv_from_p_T(), SodiumSaturationFluidProperties::cv_from_p_T(), NaKFluidProperties::cv_from_p_T(), SimpleFluidProperties::cv_from_p_T(), NaClFluidProperties::cv_from_p_T(), StiffenedGasFluidProperties::cv_from_p_T(), TabulatedFluidProperties::cv_from_p_T(), Water97FluidProperties::cv_from_p_T(), TemperaturePressureFunctionFluidProperties::cv_from_p_T(), FlibeFluidProperties::cv_from_p_T(), FlinakFluidProperties::cv_from_p_T(), HeliumFluidProperties::cv_from_p_T(), Water97FluidProperties::cv_from_p_T_template(), PorousFlowBroadbridgeWhite::d2EffectiveSaturation(), PorousFlowBroadbridgeWhite::dEffectiveSaturation(), Water97FluidProperties::densityRegion3(), StiffenedGasTwoPhaseFluidProperties::dT_sat_dp(), NaKFluidProperties::e_from_p_rho(), TabulatedFluidProperties::e_from_p_rho(), HelmholtzFluidProperties::e_from_p_T(), NaKFluidProperties::e_from_p_T(), SodiumSaturationFluidProperties::e_from_p_T(), TabulatedFluidProperties::e_from_p_T(), NaClFluidProperties::e_from_p_T(), Water97FluidProperties::e_from_p_T(), SalineMoltenSaltFluidProperties::e_from_p_T(), TemperaturePressureFunctionFluidProperties::e_from_p_T(), FlibeFluidProperties::e_from_p_T(), HeliumFluidProperties::e_from_p_T(), FlinakFluidProperties::e_from_p_T(), Water97FluidProperties::e_from_p_T_template(), BrineFluidProperties::e_from_p_T_X(), PorousFlowBroadbridgeWhite::effectiveSaturation(), PorousFlowWaterNCG::equilibriumMassFractions(), PorousFlowBrineCO2::equilibriumMassFractions(), PorousFlowBrineCO2::equilibriumMoleFractions(), PorousFlowBrineCO2::equilibriumMoleFractionsLowTemp(), CavityPressureUserObject::execute(), PorousFlowBrineCO2::fugacityCoefficientCO2HighTemp(), PorousFlowBrineCO2::fugacityCoefficientH2OHighTemp(), PorousFlowBrineCO2::fugacityCoefficientsHighTemp(), PorousFlowBrineCO2::fugacityCoefficientsLowTemp(), PorousFlowBrineCO2::funcABHighTemp(), PorousFlowBrineCO2::funcABLowTemp(), PorousFlowWaterNCG::gasDensity(), PorousFlowWaterNCG::gasProperties(), PorousFlowBrineCO2::gasProperties(), GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), WCNSFVFlowPhysicsBase::getFlowVariableName(), LinearFVMomentumPressure::getPressureVariable(), SodiumSaturationFluidProperties::h_from_p_T(), HelmholtzFluidProperties::h_from_p_T(), NaKFluidProperties::h_from_p_T(), TabulatedFluidProperties::h_from_p_T(), NaClFluidProperties::h_from_p_T(), SimpleFluidProperties::h_from_p_T(), TemperaturePressureFunctionFluidProperties::h_from_p_T(), Water97FluidProperties::h_from_p_T(), FlibeFluidProperties::h_from_p_T(), FlinakFluidProperties::h_from_p_T(), HeliumFluidProperties::h_from_p_T(), Water97FluidProperties::h_from_p_T_template(), BrineFluidProperties::h_from_p_T_X(), PorousFlowFluidStateBaseMaterialTempl< is_ad >::initQpStatefulProperties(), Water97FluidProperties::inRegion(), Water97FluidProperties::inRegionPH(), NitrogenFluidProperties::k_from_p_T(), HydrogenFluidProperties::k_from_p_T(), TabulatedFluidProperties::k_from_p_T(), SalineMoltenSaltFluidProperties::k_from_p_T(), CO2FluidProperties::k_from_p_T(), Water97FluidProperties::k_from_p_T(), TemperaturePressureFunctionFluidProperties::k_from_p_T(), HeliumFluidProperties::k_from_p_T(), BrineFluidProperties::k_from_p_T_X(), TemperaturePressureFunctionFluidProperties::k_from_v_e(), PorousFlowWaterNCG::liquidDensity(), PorousFlowWaterNCG::liquidProperties(), PorousFlowBrineCO2::liquidProperties(), PorousFlowWaterNCG::massFractions(), PorousFlowBrineCO2::massFractions(), NitrogenFluidProperties::mu_from_p_T(), CO2FluidProperties::mu_from_p_T(), HydrogenFluidProperties::mu_from_p_T(), TabulatedFluidProperties::mu_from_p_T(), SalineMoltenSaltFluidProperties::mu_from_p_T(), Water97FluidProperties::mu_from_p_T(), TemperaturePressureFunctionFluidProperties::mu_from_p_T(), HeliumFluidProperties::mu_from_p_T(), BrineFluidProperties::mu_from_p_T_X(), TemperaturePressureFunctionFluidProperties::mu_from_v_e(), PrintMatricesNSProblem::onTimestepEnd(), CO2FluidProperties::p_from_rho_T(), SinglePhaseFluidProperties::p_T_from_h_s(), SinglePhaseFluidProperties::p_T_from_v_e(), SinglePhaseFluidProperties::p_T_from_v_h(), Water97FluidProperties::p_T_from_v_h(), PINSFVRhieChowInterpolator::pinsfvSetup(), NSMomentumInviscidBC::pressureQpResidualHelper(), NSEnergyInviscidBC::qpJacobianTermA(), NSEnergyInviscidBC::qpResidualHelper(), RhieChowInterpolatorBase::RhieChowInterpolatorBase(), RhieChowMassFlux::RhieChowMassFlux(), SodiumSaturationFluidProperties::rho_from_p_T(), PBSodiumFluidProperties::rho_from_p_T(), HelmholtzFluidProperties::rho_from_p_T(), TabulatedFluidProperties::rho_from_p_T(), CO2FluidProperties::rho_from_p_T(), SalineMoltenSaltFluidProperties::rho_from_p_T(), Water97FluidProperties::rho_from_p_T(), NaClFluidProperties::rho_from_p_T(), SimpleFluidProperties::rho_from_p_T(), TemperaturePressureFunctionFluidProperties::rho_from_p_T(), FlibeFluidProperties::rho_from_p_T(), FlinakFluidProperties::rho_from_p_T(), HeliumFluidProperties::rho_from_p_T(), Water97FluidProperties::rho_from_p_T_template(), BrineFluidProperties::rho_from_p_T_X(), NitrogenFluidProperties::rho_mu_from_p_T(), HydrogenFluidProperties::rho_mu_from_p_T(), CO2FluidProperties::rho_mu_from_p_T(), MultiComponentFluidProperties::rho_mu_from_p_T_X(), TabulatedFluidProperties::s_from_h_p(), Water97FluidProperties::s_from_h_p(), HelmholtzFluidProperties::s_from_p_T(), TabulatedFluidProperties::s_from_p_T(), PorousFlowWaterNCG::saturation(), PorousFlowBrineCO2::saturation(), ThermochimicaDataBase< is_nodal >::server(), INSAction::setKernelCommonParams(), INSAction::setNoBCCommonParams(), PorousFlowBrineCO2::solveEquilibriumMoleFractionHighTemp(), CO2FluidProperties::sublimationPressure(), Water97FluidProperties::subregion2ph(), Water97FluidProperties::subregion3(), Water97FluidProperties::subregion3ph(), HelmholtzFluidProperties::T_from_p_h(), TabulatedFluidProperties::T_from_p_h(), Water97FluidProperties::T_from_p_h(), Water97FluidProperties::T_from_p_h_ad(), NaKFluidProperties::T_from_p_rho(), TabulatedFluidProperties::T_from_p_rho(), TabulatedFluidProperties::T_from_p_s(), StiffenedGasTwoPhaseFluidProperties::T_sat(), Water97FluidProperties::temperature_from_ph1(), Water97FluidProperties::temperature_from_ph2a(), Water97FluidProperties::temperature_from_ph2b(), Water97FluidProperties::temperature_from_ph2c(), Water97FluidProperties::temperature_from_ph3a(), Water97FluidProperties::temperature_from_ph3b(), Water97FluidProperties::tempXY(), TEST_F(), PorousFlowWaterVapor::thermophysicalProperties(), PorousFlowWaterNCG::thermophysicalProperties(), PorousFlowBrineCO2::thermophysicalProperties(), PorousFlowWaterNCG::totalMassFraction(), PorousFlowBrineCO2::totalMassFraction(), PorousFlowWaterNCG::twoPhaseProperties(), PorousFlowBrineCO2::twoPhaseProperties(), SodiumSaturationFluidProperties::v_from_p_T(), TabulatedFluidProperties::v_from_p_T(), Water97FluidProperties::v_from_p_T(), TemperaturePressureFunctionFluidProperties::v_from_p_T(), FlibeFluidProperties::v_from_p_T(), FlinakFluidProperties::v_from_p_T(), Water97FluidProperties::v_from_p_T_template(), PINSFVMomentumPressurePorosityGradient::validParams(), INSFVMomentumPressure::validParams(), INSADMaterial::validParams(), MomentumFreeBC::validParams(), NSMomentumInviscidFluxWithGradP::validParams(), PressureGradient::validParams(), PCNSFVStrongBC::validParams(), NSEntropyError::validParams(), LinearFVMomentumPressure::validParams(), WCNSFV2PInterfaceAreaSourceSink::validParams(), INSBase::validParams(), InternalEnergyAux::validParams(), INSFVMomentumPressureFlux::validParams(), NSEnergyInviscidUnspecifiedBC::validParams(), INSADMomentumPressure::validParams(), NSEnergyInviscidSpecifiedNormalFlowBC::validParams(), INSStressComponentAux::validParams(), NSMomentumInviscidFlux::validParams(), NSEnergyInviscidSpecifiedDensityAndVelocityBC::validParams(), NSMomentumInviscidSpecifiedNormalFlowBC::validParams(), INSFVEnthalpyFunctorMaterial::validParams(), INSChorinCorrector::validParams(), PINSFVFunctorBC::validParams(), PorousMixedVarMaterial::validParams(), CNSFVHLLCSpecifiedPressureBC::validParams(), LinearFVEnthalpyFunctorMaterial::validParams(), RhoFromPTFunctorMaterial::validParams(), PCNSFVHLLCSpecifiedPressureBC::validParams(), PorousPrimitiveVarMaterial::validParams(), INSADMomentumNoBCBC::validParams(), NavierStokesLHDGAssemblyHelper::validParams(), EnthalpyAux::validParams(), PrintMatricesNSProblem::validParams(), PNSFVMomentumPressureFluxRZ::validParams(), INSProjection::validParams(), NSStagnationPressureBC::validParams(), GeneralFunctorFluidPropsTempl< is_ad >::validParams(), IntegralDirectedSurfaceForce::validParams(), NSPressurePin::validParams(), INSMomentumNoBCBCBase::validParams(), NSInitialCondition::validParams(), PNSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), NSSpecificTotalEnthalpyAux::validParams(), NSPressureNeumannBC::validParams(), RhieChowInterpolatorBase::validParams(), RhieChowMassFlux::validParams(), NSInitialCondition::value(), PNSInitialCondition::value(), NSFunctionInitialCondition::value(), TabulatedFluidProperties::vaporTemperature(), Water97FluidProperties::vaporTemperature(), SinglePhaseFluidProperties::vaporTemperature(), Water97FluidProperties::vaporTemperature_ad(), and TabulatedFluidProperties::writeTabulatedData().
|
static |
Definition at line 162 of file NS.h.
Referenced by ComputeConcentrationDependentElasticityTensor::ComputeConcentrationDependentElasticityTensor(), ADComputeSmearedCrackingStress::computeCrackStrainAndOrientation(), ComputeSmearedCrackingStress::computeCrackStrainAndOrientation(), CohesiveZoneModelTools::computedRdF(), ComputeElasticityTensorTempl< is_ad >::ComputeElasticityTensorTempl(), DiscreteLineSegmentInterface::computeRealPointFromReferencePoint(), CylindricalRankTwoAux::computeValue(), DiscreteLineSegmentInterface::getElementBoundaryCoordinates(), ConservedNormalNoiseVeneer< ConservedNoiseBase >::getQpRandom(), EulerAngleUpdaterCheck::initialize(), EulerAngleUpdater::initialize(), FluidPropertiesUtils::NewtonSolve(), ComputeSimoHughesJ2PlasticityStress::preStep(), ComputeSmearedCrackingStress::updateCrackingStateAndStress(), ADComputeSmearedCrackingStress::updateCrackingStateAndStress(), ComputeSmearedCrackingStress::updateLocalElasticityTensor(), ADComputeSmearedCrackingStress::updateLocalElasticityTensor(), ComputeSmearedCrackingStress::updateStressTensorForCracking(), and ADComputeSmearedCrackingStress::updateStressTensorForCracking().
|
static |
Definition at line 139 of file NS.h.
Referenced by GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), ReynoldsNumberFunctorMaterial::ReynoldsNumberFunctorMaterial(), DittusBoelterFunctorMaterialTempl< is_ad >::validParams(), and ExponentialFrictionFunctorMaterial::validParams().
|
static |
Definition at line 140 of file NS.h.
Referenced by GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl().
|
static |
Definition at line 141 of file NS.h.
Referenced by GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl().
|
static |
Definition at line 118 of file NS.h.
Referenced by LaserWeld316LStainlessSteel::computeQpProperties(), NSEnergyWeakStagnationBC::computeQpResidual(), NSMomentumConvectiveWeakStagnationBC::computeQpResidual(), NSMomentumPressureWeakStagnationBC::computeQpResidual(), NSWeakStagnationBaseBC::rhoStatic(), and NSWeakStagnationBaseBC::staticValues().
|
static |
Definition at line 163 of file NS.h.
Referenced by ComputeLagrangianObjectiveStress::advectStress(), TriInterWrapper1PhaseProblem::computeDP(), InterWrapper1PhaseProblem::computeDP(), SubChannel1PhaseProblem::computeDP(), TriSubChannel1PhaseProblem::computeFrictionFactor(), ComputeSurfaceTensionKKS::computeQpProperties(), ComputeInterfaceStress::computeQpProperties(), euler2RGB(), SubChannel1PhaseProblem::externalSolve(), InterWrapper1PhaseProblem::externalSolve(), StochasticTools::SobolCalculator< InType, OutType >::finalize(), BrineFluidProperties::k_from_p_T_X(), Water97FluidProperties::k_from_rho_T_template(), ComputeLagrangianObjectiveStress::objectiveUpdateGreenNaghdi(), ComputeLagrangianObjectiveStress::objectiveUpdateJaumann(), ComputeLagrangianObjectiveStress::objectiveUpdateTruesdell(), NavierStokesProblem::setupLSCMatrices(), and ComputeLagrangianObjectiveStress::stressAdvectionDerivative().
|
static |
Definition at line 105 of file NS.h.
Referenced by PINSFVRhieChowInterpolator::PINSFVRhieChowInterpolator(), PINSFVRhieChowInterpolator::pinsfvSetup(), and WCNSFVFlowPhysics::WCNSFVFlowPhysics().
|
static |
Definition at line 68 of file NS.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyTimeKernels(), WCNSFVFluidHeatTransferPhysicsBase::addMaterials(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyTimeKernels(), AriaLaserWeld304LStainlessSteelFunctorMaterial::AriaLaserWeld304LStainlessSteelFunctorMaterial(), WCNSFVFluidHeatTransferPhysicsBase::getSpecificEnthalpyName(), INSFVEnthalpyFunctorMaterial::INSFVEnthalpyFunctorMaterial(), PINSFVEnergyTimeDerivative::PINSFVEnergyTimeDerivative(), INSFVEnergyTimeDerivative::validParams(), PINSFVEnergyTimeDerivative::validParams(), WCNSFVEnergyTimeDerivative::validParams(), INSFVEnthalpyFunctorMaterial::validParams(), and LinearFVEnthalpyFunctorMaterial::validParams().
|
static |
Definition at line 62 of file NS.h.
Referenced by CNSAction::act(), CNSAction::addNSInternalEnergyAux(), CNSAction::addNSMachAux(), CNSAction::addPressureOrTemperatureAux(), NSPressureAux::validParams(), NSMachAux::validParams(), NSTemperatureAux::validParams(), NSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), PNSInitialCondition::validParams(), NSInitialCondition::value(), NSFunctionInitialCondition::value(), and PNSInitialCondition::value().
|
static |
Definition at line 69 of file NS.h.
Referenced by CNSAction::act(), CNSAction::addNSEnergyInviscidFlux(), CNSAction::addNSSUPGEnergy(), CNSAction::addNSSUPGMass(), CNSAction::addNSSUPGMomentum(), CNSAction::addSpecificTotalEnthalpyAux(), NSEnergyInviscidFlux::validParams(), NSSUPGBase::validParams(), NSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), PNSInitialCondition::validParams(), NavierStokesMaterial::validParams(), NSInitialCondition::value(), PNSInitialCondition::value(), and NSFunctionInitialCondition::value().
|
static |
Definition at line 81 of file NS.h.
Referenced by CNSAction::act(), CNSAction::addNSMachAux(), CNSAction::addPressureOrTemperatureAux(), CNSAction::addSpecificVolumeComputation(), NSPressureAux::validParams(), NSMachAux::validParams(), NSTemperatureAux::validParams(), NSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), PNSInitialCondition::validParams(), NSInitialCondition::value(), NSFunctionInitialCondition::value(), and PNSInitialCondition::value().
|
static |
Definition at line 143 of file NS.h.
Referenced by WCNSFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysicsBase::addNonPorousMediumSpeedMaterial(), PINSFVMomentumFriction::computeFrictionWCoefficient(), ExponentialFrictionFunctorMaterial::ExponentialFrictionFunctorMaterial(), LinearFrictionFactorFunctorMaterial::LinearFrictionFactorFunctorMaterial(), NSFVDispersePhaseDragFunctorMaterial::NSFVDispersePhaseDragFunctorMaterial(), PINSFVMomentumFrictionCorrection::PINSFVMomentumFrictionCorrection(), PINSFVSpeedFunctorMaterial::PINSFVSpeedFunctorMaterial(), PINSFVMomentumFrictionCorrection::validParams(), NSFVPumpFunctorMaterial::validParams(), ReynoldsNumberFunctorAux::validParams(), PecletNumberFunctorAux::validParams(), PINSFVMomentumFriction::validParams(), PINSFVSpeedFunctorMaterial::validParams(), ExponentialFrictionFunctorMaterial::validParams(), ReynoldsNumberFunctorMaterial::validParams(), and GeneralFunctorFluidPropsTempl< is_ad >::validParams().
|
static |
Definition at line 34 of file NS.h.
Referenced by PNSInitialCondition::validParams(), and PNSInitialCondition::value().
|
static |
|
static |
Definition at line 39 of file NS.h.
Referenced by PorousMixedVarMaterial::validParams(), PorousConservedVarMaterial::validParams(), PCNSFVHLLCSpecifiedMassFluxAndTemperatureBC::validParams(), PNSInitialCondition::validParams(), and PNSInitialCondition::value().
|
static |
Definition at line 40 of file NS.h.
Referenced by PorousMixedVarMaterial::PorousMixedVarMaterial(), PorousMixedVarMaterial::validParams(), PorousConservedVarMaterial::validParams(), PCNSFVHLLCSpecifiedMassFluxAndTemperatureBC::validParams(), PNSInitialCondition::validParams(), and PNSInitialCondition::value().
|
static |
Definition at line 41 of file NS.h.
Referenced by PorousMixedVarMaterial::PorousMixedVarMaterial(), PorousMixedVarMaterial::validParams(), PorousConservedVarMaterial::validParams(), PCNSFVHLLCSpecifiedMassFluxAndTemperatureBC::validParams(), PNSInitialCondition::validParams(), and PNSInitialCondition::value().
|
static |
Definition at line 66 of file NS.h.
Referenced by PNSInitialCondition::validParams(), and PNSInitialCondition::value().
|
static |
Definition at line 72 of file NS.h.
Referenced by PNSInitialCondition::validParams(), and PNSInitialCondition::value().
|
static |
Definition at line 53 of file NS.h.
Referenced by PINSFVMomentumFriction::computeFrictionWCoefficient(), PorousPrimitiveVarMaterial::computeQpProperties(), and PCNSFVStrongBC::validParams().
|
static |
Definition at line 54 of file NS.h.
Referenced by WCNSFVFlowPhysicsBase::addPorousMediumSpeedMaterial().
|
static |
Definition at line 50 of file NS.h.
Referenced by LinearFrictionFactorFunctorMaterial::LinearFrictionFactorFunctorMaterial(), PINSFVSpeedFunctorMaterial::PINSFVSpeedFunctorMaterial(), PINSFVSpeedFunctorMaterial::validParams(), LinearFrictionFactorFunctorMaterial::validParams(), PINSFVFunctorBC::validParams(), PorousPrimitiveVarMaterial::validParams(), PNSInitialCondition::validParams(), and PNSInitialCondition::value().
|
static |
Definition at line 51 of file NS.h.
Referenced by LinearFrictionFactorFunctorMaterial::LinearFrictionFactorFunctorMaterial(), PINSFVSpeedFunctorMaterial::PINSFVSpeedFunctorMaterial(), PorousPrimitiveVarMaterial::PorousPrimitiveVarMaterial(), PINSFVSpeedFunctorMaterial::validParams(), LinearFrictionFactorFunctorMaterial::validParams(), PINSFVFunctorBC::validParams(), PorousPrimitiveVarMaterial::validParams(), PNSInitialCondition::validParams(), and PNSInitialCondition::value().
|
static |
Definition at line 52 of file NS.h.
Referenced by LinearFrictionFactorFunctorMaterial::LinearFrictionFactorFunctorMaterial(), PINSFVSpeedFunctorMaterial::PINSFVSpeedFunctorMaterial(), PorousPrimitiveVarMaterial::PorousPrimitiveVarMaterial(), PINSFVSpeedFunctorMaterial::validParams(), LinearFrictionFactorFunctorMaterial::validParams(), PINSFVFunctorBC::validParams(), PorousPrimitiveVarMaterial::validParams(), PNSInitialCondition::validParams(), and PNSInitialCondition::value().
|
static |
Definition at line 106 of file NS.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyAmbientConvection(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyAmbientConvection(), WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyWallBC(), WCNSFVFluidHeatTransferPhysicsBase::addMaterials(), WCNSLinearFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyAmbientConvection(), ADConvectionHeatTransfer3DBC::computeQpResidual(), ConjugateHTNumbersFunctorMaterialTempl< is_ad >::ConjugateHTNumbersFunctorMaterialTempl(), ConvectionHeatFluxFunctorMaterialTempl< is_ad >::ConvectionHeatFluxFunctorMaterialTempl(), GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl(), LinearFVMomentumBoussinesq::getTemperatureVariable(), FVConvectionCorrelationInterface::validParams(), PCNSFVStrongBC::validParams(), PINSFVEnergyAmbientConvection::validParams(), WCNSFVEnergyFluxBC::validParams(), PNSFVSolidHeatTransferPhysics::validParams(), LinearFVMomentumBoussinesq::validParams(), DittusBoelterFunctorMaterialTempl< is_ad >::validParams(), INSFVMomentumBoussinesq::validParams(), PorousPrimitiveVarMaterial::validParams(), LinearFVConvectiveHeatTransferBC::validParams(), LinearFVEnthalpyFunctorMaterial::validParams(), PorousMixedVarMaterial::validParams(), LinearFVVolumetricHeatTransfer::validParams(), GeneralFunctorFluidPropsTempl< is_ad >::validParams(), and WCNSFVFluidHeatTransferPhysicsBase::validParams().
|
static |
Definition at line 148 of file NS.h.
Referenced by WCNSFVTwoPhaseMixturePhysics::addPhaseChangeEnergySource().
|
static |
Definition at line 107 of file NS.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyAmbientConvection(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyAmbientConvection(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyWallBC(), PNSFVSolidHeatTransferPhysics::addPINSSolidEnergyAmbientConvection(), ConjugateHTNumbersFunctorMaterialTempl< is_ad >::ConjugateHTNumbersFunctorMaterialTempl(), ConvectionHeatFluxFunctorMaterialTempl< is_ad >::ConvectionHeatFluxFunctorMaterialTempl(), FVConvectionCorrelationInterface::validParams(), PINSFVEnergyAmbientConvection::validParams(), PNSFVSolidHeatTransferPhysics::validParams(), LinearFVVolumetricHeatTransfer::validParams(), and LinearFVConvectiveHeatTransferBC::validParams().
|
static |
Definition at line 149 of file NS.h.
Referenced by WCNSFVTwoPhaseMixturePhysics::addPhaseChangeEnergySource().
|
static |
Definition at line 59 of file NS.h.
Referenced by CNSAction::act(), PorousFlowBrineCO2::activityCoefficient(), PorousFlowBrineCO2::activityCoefficientCO2(), PorousFlowBrineCO2::activityCoefficientH2O(), PorousFlowBrineCO2::activityCoefficientHighTemp(), MortarGapHeatTransferAction::addMortarVariable(), CNSAction::addNSEnergyInviscidSpecifiedPressureBC(), CNSAction::addNSSUPGEnergy(), CNSAction::addNSSUPGMass(), CNSAction::addNSSUPGMomentum(), CNSAction::addPressureOrTemperatureAux(), Water97FluidProperties::b23p(), PBSodiumFluidProperties::beta_from_p_T(), SimpleFluidProperties::beta_from_p_T(), StiffenedGasFluidProperties::beta_from_p_T(), HeliumFluidProperties::beta_from_p_T(), TemperaturePressureFunctionFluidProperties::beta_from_p_T(), FlinakFluidProperties::beta_from_p_T(), GeochemicalSystem::buildTemperatureDependentQuantities(), HelmholtzFluidProperties::c_from_p_T(), SimpleFluidProperties::c_from_p_T(), TabulatedFluidProperties::c_from_p_T(), Water97FluidProperties::c_from_p_T_template(), TabulatedFluidProperties::checkInputVariables(), PorousFlowWaterNCG::checkVariables(), PorousFlowBrineCO2::checkVariables(), ComputeDilatationThermalExpansionFunctionEigenstrainTempl< is_ad >::computeDilatation(), PorousFlowFluidStateSingleComponentTempl< is_ad >::computeQpProperties(), PBSodiumFluidProperties::cp_from_p_T(), HelmholtzFluidProperties::cp_from_p_T(), SodiumSaturationFluidProperties::cp_from_p_T(), SimpleFluidProperties::cp_from_p_T(), NaKFluidProperties::cp_from_p_T(), NaClFluidProperties::cp_from_p_T(), SalineMoltenSaltFluidProperties::cp_from_p_T(), StiffenedGasFluidProperties::cp_from_p_T(), TabulatedFluidProperties::cp_from_p_T(), CaloricallyImperfectGas::cp_from_p_T(), Water97FluidProperties::cp_from_p_T(), TemperaturePressureFunctionFluidProperties::cp_from_p_T(), FlibeFluidProperties::cp_from_p_T(), HeliumFluidProperties::cp_from_p_T(), FlinakFluidProperties::cp_from_p_T(), Water97FluidProperties::cp_from_p_T_template(), BrineFluidProperties::cp_from_p_T_X(), PBSodiumFluidProperties::cv_from_p_T(), HelmholtzFluidProperties::cv_from_p_T(), SodiumSaturationFluidProperties::cv_from_p_T(), NaKFluidProperties::cv_from_p_T(), SimpleFluidProperties::cv_from_p_T(), NaClFluidProperties::cv_from_p_T(), StiffenedGasFluidProperties::cv_from_p_T(), CaloricallyImperfectGas::cv_from_p_T(), TabulatedFluidProperties::cv_from_p_T(), Water97FluidProperties::cv_from_p_T(), TemperaturePressureFunctionFluidProperties::cv_from_p_T(), FlibeFluidProperties::cv_from_p_T(), FlinakFluidProperties::cv_from_p_T(), HeliumFluidProperties::cv_from_p_T(), Water97FluidProperties::cv_from_p_T_template(), Water97FluidProperties::densityRegion3(), NaKFluidProperties::e_from_p_rho(), TemperaturePressureFunctionFluidProperties::e_from_p_rho(), Water97FluidProperties::e_from_p_rho_template(), HelmholtzFluidProperties::e_from_p_T(), SodiumSaturationFluidProperties::e_from_p_T(), NaKFluidProperties::e_from_p_T(), TabulatedFluidProperties::e_from_p_T(), NaClFluidProperties::e_from_p_T(), Water97FluidProperties::e_from_p_T(), SimpleFluidProperties::e_from_p_T(), SalineMoltenSaltFluidProperties::e_from_p_T(), TemperaturePressureFunctionFluidProperties::e_from_p_T(), HeliumFluidProperties::e_from_p_T(), FlibeFluidProperties::e_from_p_T(), FlinakFluidProperties::e_from_p_T(), Water97FluidProperties::e_from_p_T_template(), BrineFluidProperties::e_from_p_T_X(), PorousFlowWaterNCG::enthalpyOfDissolution(), PorousFlowBrineCO2::enthalpyOfDissolution(), PorousFlowBrineCO2::enthalpyOfDissolutionGas(), PorousFlowBrineCO2::equilibriumConstantCO2(), EquilibriumConstantFit::EquilibriumConstantFit(), PorousFlowBrineCO2::equilibriumConstantH2O(), EquilibriumConstantInterpolator::EquilibriumConstantInterpolator(), PorousFlowWaterNCG::equilibriumMassFractions(), PorousFlowBrineCO2::equilibriumMassFractions(), PorousFlowBrineCO2::equilibriumMoleFractions(), PorousFlowBrineCO2::equilibriumMoleFractionsLowTemp(), GeochemistrySpatialReactor::execute(), PBSodiumFluidProperties::F_enthalpy(), PorousFlowBrineCO2::fugacityCoefficientCO2HighTemp(), PorousFlowBrineCO2::fugacityCoefficientH2OHighTemp(), PorousFlowBrineCO2::fugacityCoefficientsHighTemp(), PorousFlowBrineCO2::fugacityCoefficientsLowTemp(), PorousFlowBrineCO2::funcABHighTemp(), PorousFlowBrineCO2::funcABLowTemp(), PorousFlowWaterNCG::gasDensity(), PorousFlowWaterNCG::gasProperties(), PorousFlowBrineCO2::gasProperties(), WCNSFVFlowPhysicsBase::getFlowVariableName(), PBSodiumFluidProperties::h_from_p_T(), SodiumSaturationFluidProperties::h_from_p_T(), HelmholtzFluidProperties::h_from_p_T(), NaKFluidProperties::h_from_p_T(), TabulatedFluidProperties::h_from_p_T(), NaClFluidProperties::h_from_p_T(), SalineMoltenSaltFluidProperties::h_from_p_T(), SimpleFluidProperties::h_from_p_T(), TemperaturePressureFunctionFluidProperties::h_from_p_T(), Water97FluidProperties::h_from_p_T(), FlibeFluidProperties::h_from_p_T(), FlinakFluidProperties::h_from_p_T(), HeliumFluidProperties::h_from_p_T(), Water97FluidProperties::h_from_p_T_template(), BrineFluidProperties::h_from_p_T_X(), BrineFluidProperties::haliteSolubility(), BrineFluidProperties::henryConstant(), PorousFlowBrineCO2::henryConstant(), Water97FluidProperties::henryConstant(), PorousFlowFluidStateSingleComponentTempl< is_ad >::initQpStatefulProperties(), Water97FluidProperties::inRegion(), PBSodiumFluidProperties::k_from_p_T(), MethaneFluidProperties::k_from_p_T(), SodiumSaturationFluidProperties::k_from_p_T(), NaKFluidProperties::k_from_p_T(), NitrogenFluidProperties::k_from_p_T(), HydrogenFluidProperties::k_from_p_T(), NaClFluidProperties::k_from_p_T(), StiffenedGasFluidProperties::k_from_p_T(), CaloricallyImperfectGas::k_from_p_T(), TabulatedFluidProperties::k_from_p_T(), SalineMoltenSaltFluidProperties::k_from_p_T(), CO2FluidProperties::k_from_p_T(), Water97FluidProperties::k_from_p_T(), TemperaturePressureFunctionFluidProperties::k_from_p_T(), FlibeFluidProperties::k_from_p_T(), HeliumFluidProperties::k_from_p_T(), FlinakFluidProperties::k_from_p_T(), Water97FluidProperties::k_from_p_T_template(), BrineFluidProperties::k_from_p_T_X(), NitrogenFluidProperties::k_from_rho_T(), HydrogenFluidProperties::k_from_rho_T(), CO2FluidProperties::k_from_rho_T(), Water97FluidProperties::k_from_rho_T(), Water97FluidProperties::k_from_rho_T_template(), TemperaturePressureFunctionFluidProperties::k_from_v_e(), FlibeFluidProperties::k_from_v_e(), FlinakFluidProperties::k_from_v_e(), Water97FluidProperties::k_from_v_e_template(), PorousFlowWaterNCG::liquidDensity(), PorousFlowWaterNCG::liquidProperties(), PorousFlowBrineCO2::liquidProperties(), PorousFlowWaterNCG::massFractions(), PorousFlowBrineCO2::massFractions(), ComputeMeanThermalExpansionFunctionEigenstrainTempl< is_ad >::meanThermalExpansionCoefficient(), CO2FluidProperties::meltingPressure(), PBSodiumFluidProperties::mu_from_p_T(), MethaneFluidProperties::mu_from_p_T(), NitrogenFluidProperties::mu_from_p_T(), CO2FluidProperties::mu_from_p_T(), HydrogenFluidProperties::mu_from_p_T(), NaKFluidProperties::mu_from_p_T(), SodiumSaturationFluidProperties::mu_from_p_T(), StiffenedGasFluidProperties::mu_from_p_T(), TabulatedFluidProperties::mu_from_p_T(), CaloricallyImperfectGas::mu_from_p_T(), SalineMoltenSaltFluidProperties::mu_from_p_T(), Water97FluidProperties::mu_from_p_T(), SimpleFluidProperties::mu_from_p_T(), TemperaturePressureFunctionFluidProperties::mu_from_p_T(), FlibeFluidProperties::mu_from_p_T(), HeliumFluidProperties::mu_from_p_T(), FlinakFluidProperties::mu_from_p_T(), Water97FluidProperties::mu_from_p_T_template(), BrineFluidProperties::mu_from_p_T_X(), PBSodiumFluidProperties::mu_from_rho_T(), NitrogenFluidProperties::mu_from_rho_T(), HydrogenFluidProperties::mu_from_rho_T(), CO2FluidProperties::mu_from_rho_T(), Water97FluidProperties::mu_from_rho_T(), Water97FluidProperties::mu_from_rho_T_template(), TemperaturePressureFunctionFluidProperties::mu_from_v_e(), FlibeFluidProperties::mu_from_v_e(), FlinakFluidProperties::mu_from_v_e(), HelmholtzFluidProperties::p_from_rho_T(), CO2FluidProperties::p_from_rho_T(), FlinakFluidProperties::p_from_v_e(), FlibeFluidProperties::p_from_v_e(), SodiumSaturationFluidProperties::p_from_v_e(), SimpleFluidProperties::p_from_v_e(), StiffenedGasTwoPhaseFluidProperties::p_sat(), SinglePhaseFluidProperties::p_T_from_h_s(), SinglePhaseFluidProperties::p_T_from_v_e(), SinglePhaseFluidProperties::p_T_from_v_h(), Water97FluidProperties::p_T_from_v_h(), CO2FluidProperties::partialDensity(), PorousFlowBrineCO2::partialDensityCO2(), SodiumSaturationFluidProperties::rho_from_p_T(), PBSodiumFluidProperties::rho_from_p_T(), HelmholtzFluidProperties::rho_from_p_T(), TabulatedFluidProperties::rho_from_p_T(), NaKFluidProperties::rho_from_p_T(), CO2FluidProperties::rho_from_p_T(), SalineMoltenSaltFluidProperties::rho_from_p_T(), NaClFluidProperties::rho_from_p_T(), Water97FluidProperties::rho_from_p_T(), SimpleFluidProperties::rho_from_p_T(), TemperaturePressureFunctionFluidProperties::rho_from_p_T(), FlibeFluidProperties::rho_from_p_T(), FlinakFluidProperties::rho_from_p_T(), HeliumFluidProperties::rho_from_p_T(), Water97FluidProperties::rho_from_p_T_template(), BrineFluidProperties::rho_from_p_T_X(), NitrogenFluidProperties::rho_mu_from_p_T(), HydrogenFluidProperties::rho_mu_from_p_T(), CO2FluidProperties::rho_mu_from_p_T(), Water97FluidProperties::rho_mu_from_p_T(), MultiComponentFluidProperties::rho_mu_from_p_T_X(), Water97FluidProperties::s_from_h_p(), HelmholtzFluidProperties::s_from_p_T(), TabulatedFluidProperties::s_from_p_T(), MethaneFluidProperties::saturatedLiquidDensity(), NitrogenFluidProperties::saturatedLiquidDensity(), CO2FluidProperties::saturatedLiquidDensity(), MethaneFluidProperties::saturatedVaporDensity(), NitrogenFluidProperties::saturatedVaporDensity(), CO2FluidProperties::saturatedVaporDensity(), PorousFlowWaterNCG::saturation(), PorousFlowBrineCO2::saturation(), ThermochimicaDataBase< is_nodal >::server(), GeochemistryActivityCoefficientsDebyeHuckel::setInternalParameters(), GeochemicalSystem::setTemperature(), CaloricallyImperfectGas::setupLookupTables(), PorousFlowBrineCO2::smoothCubicInterpolation(), PorousFlowBrineCO2::solveEquilibriumMoleFractionHighTemp(), CO2FluidProperties::sublimationPressure(), Water97FluidProperties::subregion3(), Water97FluidProperties::T_drhodT_from_p_rho(), PBSodiumFluidProperties::T_from_p_h(), Water97FluidProperties::T_from_p_h(), Water97FluidProperties::T_from_p_h_ad(), FlibeFluidProperties::T_from_p_rho(), FlinakFluidProperties::T_from_p_rho(), PBSodiumFluidProperties::temperature_correction(), TEST_F(), PorousFlowWaterNCG::thermophysicalProperties(), PorousFlowBrineCO2::thermophysicalProperties(), PorousFlowWaterNCG::totalMassFraction(), PorousFlowBrineCO2::totalMassFraction(), PorousFlowWaterNCG::twoPhaseProperties(), PorousFlowBrineCO2::twoPhaseProperties(), umat_(), SodiumSaturationFluidProperties::v_from_p_T(), TabulatedFluidProperties::v_from_p_T(), Water97FluidProperties::v_from_p_T(), TemperaturePressureFunctionFluidProperties::v_from_p_T(), FlibeFluidProperties::v_from_p_T(), FlinakFluidProperties::v_from_p_T(), Water97FluidProperties::v_from_p_T_template(), NSLiquidFractionAux::validParams(), INSElementIntegralEnergyAdvectionTempl< is_ad >::validParams(), RhoFromPTFunctorMaterial::validParams(), NSSUPGBase::validParams(), NSStagnationTemperatureBC::validParams(), NSEnergyThermalFlux::validParams(), PCNSFVHLLCSpecifiedMassFluxAndTemperatureBC::validParams(), CNSFVHLLCSpecifiedMassFluxAndTemperatureBC::validParams(), AriaLaserWeld304LStainlessSteelFunctorMaterial::validParams(), INSAction::validParams(), NSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), PNSInitialCondition::validParams(), NSEnergyViscousBC::validParams(), NSEnergyInviscidBC::validParams(), NavierStokesMaterial::validParams(), NSInitialCondition::value(), PNSInitialCondition::value(), NSFunctionInitialCondition::value(), MethaneFluidProperties::vaporPressure(), NitrogenFluidProperties::vaporPressure(), HydrogenFluidProperties::vaporPressure(), CO2FluidProperties::vaporPressure(), TabulatedFluidProperties::vaporPressure(), BrineFluidProperties::vaporPressure(), Water97FluidProperties::vaporPressure(), SinglePhaseFluidProperties::vaporPressure(), Water97FluidProperties::vaporPressureTemplate(), and TabulatedFluidProperties::writeTabulatedData().
|
static |
Definition at line 133 of file NS.h.
Referenced by ThermalDiffusivityFunctorMaterial::ThermalDiffusivityFunctorMaterial(), and PecletNumberFunctorAux::validParams().
|
static |
Definition at line 176 of file NS.h.
Referenced by WCNSFVTurbulencePhysics::addAuxiliaryKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), WCNSFVTurbulencePhysics::addFVBCs(), WCNSFVTurbulencePhysics::addKEpsilonSink(), WCNSFVTurbulencePhysics::addMaterials(), INSFVTKEDWallFunctionBC::boundaryValue(), INSFVTKESourceSink::computeQpResidual(), RANSYPlusAux::RANSYPlusAux(), INSFVkEpsilonViscosityFunctorMaterial::validParams(), INSFVMixingLengthTKEDBC::validParams(), INSFVTurbulentTemperatureWallFunction::validParams(), RANSYPlusAux::validParams(), INSFVTurbulentViscosityWallFunction::validParams(), INSFVTKEDSourceSink::validParams(), kEpsilonViscosityAux::validParams(), INSFVTKEDWallFunctionBC::validParams(), and WCNSFVTurbulencePhysics::validParams().
|
static |
Definition at line 177 of file NS.h.
Referenced by WCNSFVTurbulencePhysics::addAuxiliaryKernels(), WCNSFVTurbulencePhysics::addKEpsilonSink(), WCNSFVTurbulencePhysics::addMaterials(), INSFVkEpsilonViscosityFunctorMaterial::validParams(), INSFVTKESourceSink::validParams(), kEpsilonViscosityAux::validParams(), and WCNSFVTurbulencePhysics::validParams().
|
static |
Definition at line 65 of file NS.h.
Referenced by CNSAction::act(), CNSAction::addNSEnergyInviscidFlux(), CNSAction::addNSEnergyInviscidSpecifiedPressureBC(), CNSAction::addNSEnergyWeakStagnationBC(), CNSAction::addNSInternalEnergyAux(), CNSAction::addNSSUPGEnergy(), CNSAction::addNSTimeKernels(), CNSAction::addSpecificTotalEnthalpyAux(), CNSAction::setBCCommonParams(), CNSAction::setKernelCommonParams(), PressureEqualsDensityMaterial::validParams(), NSInternalEnergyAux::validParams(), ConservedVarValuesMaterial::validParams(), PorousConservedVarMaterial::validParams(), NSKernel::validParams(), NSIntegratedBC::validParams(), NSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), PNSInitialCondition::validParams(), NSSpecificTotalEnthalpyAux::validParams(), NavierStokesMaterial::validParams(), NSInitialCondition::value(), NSFunctionInitialCondition::value(), and PNSInitialCondition::value().
|
static |
Definition at line 58 of file NS.h.
Referenced by GeneralFunctorFluidPropsTempl< is_ad >::GeneralFunctorFluidPropsTempl().
|
static |
Definition at line 78 of file NS.h.
Referenced by WCNSFVFlowPhysics::addWallsBC(), and MixingLengthTurbulentViscosityFunctorMaterial::MixingLengthTurbulentViscosityFunctorMaterial().
|
static |
Definition at line 138 of file NS.h.
Referenced by WCNSFVTurbulencePhysics::addAuxiliaryKernels(), and WCNSFVTurbulencePhysics::validParams().
|
static |
Definition at line 84 of file NS.h.
Referenced by RigidBodyMultiKernelAction::act(), GrainGrowthAction::act(), GrainGrowthLinearizedInterfaceAction::act(), CommonSolidMechanicsAction::act(), PolycrystalStoredEnergyAction::act(), PolycrystalKernelAction::act(), GrainGrowthAction::addBnds(), GradientOperatorCoordinates::AxisymmetricCylindrical::addGradOp(), GradientOperatorCoordinates::CentrosymmetricSpherical::addGradOp(), ElemExtrema::atVertex(), TraceRayTools::atVertex(), ClaimRays::buildPointNeighbors(), InterfaceMeshCut2DUserObject::calculateSignedDistance(), DisplacementAboutAxis::calculateTransformationMatrices(), StudentT::cdf(), StochasticTools::BiasCorrectedAccelerated< InType, OutType >::compute(), FluidPropertiesInterrogator::compute1Phase(), RZSymmetry::computeCircumference(), PODReducedBasisTrainer::computeEigenDecomposition(), HillElastoPlasticityStressUpdateTempl< is_ad >::computeElasticityTensorEigenDecomposition(), RDG3EqnMaterial::computeElementPrimitiveVariables(), ADNumericalFlux3EqnCentered::computeFlux(), HillPlasticityStressUpdateTempl< is_ad >::computeHillTensorEigenDecomposition(), StochasticTools::POD::computePOD(), FlowModelGasMixUtils::computePrimitiveSolution(), FlowModel1PhaseUtils::computePrimitiveSolutionVector(), CosseratStressDivergenceTensors::computeQpOffDiagJacobian(), ACInterfaceKobayashi1::computeQpOffDiagJacobian(), InertialTorque::computeQpOffDiagJacobian(), MomentBalancing::computeQpOffDiagJacobian(), PorousFlowDarcyVelocityMaterial::computeQpProperties(), PorousMixedVarMaterial::computeQpProperties(), PorousPrimitiveVarMaterial::computeQpProperties(), PorousFlowAqueousPreDisChemistry::computeQpProperties(), PorousFlowMassFractionAqueousEquilibriumChemistry::computeQpProperties(), PorousFlowEffectiveFluidPressureTempl< is_ad >::computeQpProperties(), PorousFlowThermalConductivityIdealTempl< is_ad >::computeQpProperties(), PorousFlowMatrixInternalEnergyTempl< is_ad >::computeQpProperties(), PorousFlowPorosityHMBiotModulus::computeQpProperties(), PorousFlowPermeabilityKozenyCarmanBaseTempl< is_ad >::computeQpProperties(), PorousFlowThermalConductivityFromPorosityTempl< is_ad >::computeQpProperties(), PorousFlowTotalGravitationalDensityFullySaturatedFromPorosity::computeQpProperties(), PorousFlowPermeabilityExponentialTempl< is_ad >::computeQpProperties(), PorousFlowPorosityExponentialBase::computeQpProperties(), PorousFlowJoinerTempl< is_ad >::computeQpProperties(), INSFVMassAdvection::computeQpResidual(), 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(), InterWrapper1PhaseProblem::createPetscVector(), SubChannel1PhaseProblem::createPetscVector(), dataLoad(), dataStore(), MultiParameterPlasticityStressUpdate::dVardTrial(), StabilizationUtils::elementAverage(), INSFVMomentumAdvectionOutflowBC::gatherRCData(), SCMDetailedQuadInterWrapperMeshGenerator::generate(), NSPressureDerivs< NSPressureNeumannBC >::get_grad(), NSPressureDerivs< NSPressureNeumannBC >::get_hess(), LAROMANCEStressUpdateBaseTempl< is_ad >::getMakeFrameHelper(), SumPostprocessor::getValue(), INSFVRhieChowInterpolator::getVelocity(), GradientOperator< C >::gradOp(), ConstantViewFactorSurfaceRadiation::initialize(), SurrogateModelScalarAux::initialSetup(), TraceRayTools::intersectTriangle(), ViewFactorBase::maxDevReciprocity(), ViewFactorBase::maxDevRowSum(), RayTracingAngularQuadrature::orthonormalVector(), StudentT::pdf(), Xfem::polyhedron_volume_3d(), ACInterfaceKobayashi1::precomputeQpJacobian(), ADACInterfaceKobayashi1::precomputeQpResidual(), ACInterfaceKobayashi1::precomputeQpResidual(), StudentT::quantile(), Xfem::r8vec_norm(), EBSDReader::readFile(), SolidMechanicsPlasticMohrCoulombMulti::returnTip(), NormalSampler::sample(), Simulation::setupInitialConditionsFromFile(), StochasticTools::stochasticAllGather(), StochasticTools::stochasticGather(), TEST(), TEST_F(), THMParsedFunctionWrapper::THMParsedFunctionWrapper(), THM::v_from_arhoA_alpha_A(), THM::v_from_rho(), THM::v_from_rhoA_A(), FourierNoise::value(), FlowModelGasMixIC::value(), PorousFlowFluidStateFlash::vaporMassFraction(), WCNSFVFluxBCBase::varVelocity(), ViewFactorBase::ViewFactorBase(), and WCNSFV2PSlipVelocityFunctorMaterial::WCNSFV2PSlipVelocityFunctorMaterial().
|
static |
Definition at line 45 of file NS.h.
Referenced by INSAction::act(), INSAction::addINSMomentum(), INSAction::addINSNoBCBC(), INSAction::addINSTemperature(), INSAction::addINSTimeKernels(), INSAction::addINSVelocityAux(), INSAction::addINSVelocityBC(), INSFVInletIntensityTKEBC::boundaryValue(), INSFVTurbulentViscosityWallFunction::boundaryValue(), INSFVTKEDWallFunctionBC::boundaryValue(), PorousFlowDispersiveFlux::computeQpJac(), DashpotBC::computeQpJacobian(), DashpotBC::computeQpOffDiagJacobian(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), WCNSFV2PInterfaceAreaSourceSink::computeQpResidual(), PorousFlowDispersiveFlux::computeQpResidual(), NSEnergyViscousFlux::computeQpResidual(), INSFVTKESourceSink::computeQpResidual(), FVPorousFlowDispersiveFlux::computeQpResidual(), INSFVTKEDSourceSink::computeQpResidual(), DashpotBC::computeQpResidual(), computeSpeed(), INSFVWallFunctionBC::computeStrongResidual(), WallFunctionYPlusAux::computeValue(), WallFunctionWallShearStressAux::computeValue(), RANSYPlusAux::computeValue(), kEpsilonViscosityAux::computeValue(), INSFVRhieChowInterpolator::getVelocity(), InterfaceMeshCutUserObjectBase::initialize(), INSFVRhieChowInterpolator::INSFVRhieChowInterpolator(), INSFVRhieChowInterpolatorSegregated::INSFVRhieChowInterpolatorSegregated(), NSFVDispersePhaseDragFunctorMaterial::NSFVDispersePhaseDragFunctorMaterial(), PINSFVSpeedFunctorMaterial::PINSFVSpeedFunctorMaterial(), PINSFVSpeedFunctorMaterial::validParams(), and INSElementIntegralEnergyAdvectionTempl< is_ad >::validParams().
const std::string NS::velocity_vector[3] = {velocity_x, velocity_y, velocity_z} |
Definition at line 49 of file NS.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSFVFlowPhysics::addInletBC(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
static |
Definition at line 46 of file NS.h.
Referenced by INSAction::act(), CNSAction::act(), INSAction::addINSMomentum(), INSAction::addINSNoBCBC(), INSAction::addINSTemperature(), INSAction::addINSTimeKernels(), INSAction::addINSVelocityAux(), INSAction::addINSVelocityBC(), CNSAction::addNSVelocityAux(), WCNSFVScalarTransportPhysics::addScalarInletBC(), CNSAction::coupleVelocities(), WCNSFVFlowPhysicsBase::getFlowVariableName(), PINSFVSpeedFunctorMaterial::PINSFVSpeedFunctorMaterial(), INSAction::setKernelCommonParams(), INSAction::setNoBCCommonParams(), ExplicitDynamicsContactConstraint::solveImpactEquations(), PINSFVSpeedFunctorMaterial::validParams(), WCNSFVFluxBCBase::validParams(), NSInternalEnergyAux::validParams(), NSMachAux::validParams(), NSTemperatureL2::validParams(), NSIntegratedBC::validParams(), NSKernel::validParams(), NSInitialCondition::validParams(), PNSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), NavierStokesMaterial::validParams(), NSImposedVelocityDirectionBC::validParams(), NSInitialCondition::value(), NSFunctionInitialCondition::value(), and PNSInitialCondition::value().
|
static |
Definition at line 47 of file NS.h.
Referenced by INSAction::act(), CNSAction::act(), INSAction::addINSMomentum(), INSAction::addINSNoBCBC(), INSAction::addINSTemperature(), INSAction::addINSTimeKernels(), INSAction::addINSVelocityAux(), INSAction::addINSVelocityBC(), CNSAction::addNSVelocityAux(), WCNSFVScalarTransportPhysics::addScalarInletBC(), CNSAction::coupleVelocities(), WCNSFVFlowPhysicsBase::getFlowVariableName(), PINSFVSpeedFunctorMaterial::PINSFVSpeedFunctorMaterial(), INSAction::setKernelCommonParams(), INSAction::setNoBCCommonParams(), ExplicitDynamicsContactConstraint::solveImpactEquations(), PINSFVSpeedFunctorMaterial::validParams(), WCNSFVFluxBCBase::validParams(), NSInternalEnergyAux::validParams(), NSMachAux::validParams(), NSTemperatureL2::validParams(), NSIntegratedBC::validParams(), NSKernel::validParams(), NSInitialCondition::validParams(), PNSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), NavierStokesMaterial::validParams(), NSImposedVelocityDirectionBC::validParams(), NSInitialCondition::value(), NSFunctionInitialCondition::value(), and PNSInitialCondition::value().
|
static |
Definition at line 48 of file NS.h.
Referenced by INSAction::act(), CNSAction::act(), INSAction::addINSMomentum(), INSAction::addINSNoBCBC(), INSAction::addINSTemperature(), INSAction::addINSTimeKernels(), INSAction::addINSVelocityAux(), INSAction::addINSVelocityBC(), CNSAction::addNSVelocityAux(), WCNSFVScalarTransportPhysics::addScalarInletBC(), CNSAction::coupleVelocities(), WCNSFVFlowPhysicsBase::getFlowVariableName(), PINSFVSpeedFunctorMaterial::PINSFVSpeedFunctorMaterial(), INSAction::setKernelCommonParams(), INSAction::setNoBCCommonParams(), ExplicitDynamicsContactConstraint::solveImpactEquations(), PINSFVSpeedFunctorMaterial::validParams(), WCNSFVFluxBCBase::validParams(), NSInternalEnergyAux::validParams(), NSMachAux::validParams(), NSTemperatureL2::validParams(), NSIntegratedBC::validParams(), NSKernel::validParams(), NSInitialCondition::validParams(), PNSInitialCondition::validParams(), NSFunctionInitialCondition::validParams(), NavierStokesMaterial::validParams(), NSImposedVelocityDirectionBC::validParams(), NSInitialCondition::value(), NSFunctionInitialCondition::value(), and PNSInitialCondition::value().
|
static |
Definition at line 191 of file NS.h.
Referenced by INSFVTurbulentViscosityWallFunction::boundaryValue(), INSFVTurbulentTemperatureWallFunction::computeQpResidual(), INSFVTKESourceSink::computeQpResidual(), INSFVTKEDSourceSink::computeQpResidual(), kEpsilonViscosityAux::computeValue(), findUStar(), and findyPlus().
|
static |
|
static |
Definition at line 169 of file NS.h.
Referenced by SphereSurfaceMeshGenerator::generate(), HeatTransferFromHeatStructure3D1Phase::getFlowChannelAxisAlignment(), QuadSubChannel1PhaseProblem::initializeSolution(), TriSubChannel1PhaseProblem::initializeSolution(), HillElastoPlasticityStressUpdateTempl< is_ad >::initQpStatefulProperties(), PorousFlowWaterNCG::massFractions(), PorousFlowBrineCO2::massFractions(), CaloricallyImperfectGas::p_from_h_s(), ComputeLagrangianObjectiveStress::polarDecomposition(), JohnsonSB::quantile(), CaloricallyImperfectGas::s_from_h_p(), CaloricallyImperfectGas::s_from_p_T(), CaloricallyImperfectGas::s_from_v_e(), PorousFlowWaterNCG::saturation(), PorousFlowBrineCO2::saturation(), TEST_F(), PorousFlowWaterNCG::thermophysicalProperties(), PorousFlowBrineCO2::thermophysicalProperties(), PorousFlowWaterNCG::totalMassFraction(), PorousFlowBrineCO2::totalMassFraction(), PorousFlowWaterNCG::twoPhaseProperties(), and PorousFlowBrineCO2::twoPhaseProperties().