Typedefs | |
typedef unsigned int | FlowModelID |
Functions | |
FlowModelID | registerFlowModelID () |
Register a new flow mode type and return its ID. More... | |
template<> | |
Component1DConnection::EEndType | stringToEnum (const std::string &s) |
template<> | |
Component2D::ExternalBoundaryType | stringToEnum (const std::string &s) |
template<> | |
FlowChannelBase::EConvHeatTransGeom | stringToEnum (const std::string &s) |
template<> | |
FlowChannelBase::EPipeType | stringToEnum (const std::string &s) |
template<> | |
FlowChannelBase::EPipeLocation | stringToEnum (const std::string &s) |
void | associateSyntax (Syntax &syntax) |
void | registerActions (Syntax &syntax) |
template<typename T > | |
int | sgn (T val) |
The sign function. More... | |
bool | absoluteFuzzyEqualVectors (const RealVectorValue &a, const RealVectorValue &b, const Real &tol=libMesh::TOLERANCE *libMesh::TOLERANCE) |
Tests if two real-valued vectors are equal within some absolute tolerance. More... | |
bool | areParallelVectors (const RealVectorValue &a, const RealVectorValue &b, const Real &tol=libMesh::TOLERANCE *libMesh::TOLERANCE) |
Tests if two real-valued vectors are parallel within some absolute tolerance. More... | |
bool | haveSameDirection (const RealVectorValue &a, const RealVectorValue &b, const Real &tol=libMesh::TOLERANCE *libMesh::TOLERANCE) |
Tests if two real-valued vectors are in the same direction. More... | |
Real | applyQuotientRule (const Real &num, const Real &den, const Real &dnum_dy, const Real &dden_dy) |
Computes a derivative of a fraction using quotient rule for a derivative w.r.t. More... | |
DenseVector< Real > | applyQuotientRule (const Real &num, const Real &den, const DenseVector< Real > &dnum_dy, const DenseVector< Real > &dden_dy) |
Computes a derivative of a fraction using quotient rule for a derivative w.r.t. More... | |
template<typename T1 , typename T2 , typename T3 , typename T4 , typename T5 > | |
auto | Reynolds (const T1 &volume_fraction, const T2 &rho, const T3 &vel, const T4 &D_h, const T5 &mu) |
Compute Reynolds number. More... | |
template<typename T1 , typename T2 , typename T3 > | |
auto | Prandtl (const T1 &cp, const T2 &mu, const T3 &k) |
Compute Prandtl number. More... | |
template<typename T1 , typename T2 , typename T3 , typename T4 , typename T5 , typename T6 > | |
auto | Peclet (const T1 &volume_fraction, const T2 &cp, const T3 &rho, const T4 &vel, const T5 &D_h, const T6 &k) |
Compute Peclet number. More... | |
template<typename T1 , typename T2 , typename T3 , typename T4 , typename T5 > | |
auto | Grashof (const T1 &beta, const T2 &dT, const T3 &D_h, const T4 &rho_liquid, const T5 &mu_liquid, const Real &gravity_magnitude) |
Compute Grashof number. More... | |
template<typename T1 , typename T2 > | |
auto | Laplace (const T1 &surf_tension, const T2 &delta_rho, const Real &gravity_magnitude) |
Compute Laplace number (or coefficient) More... | |
template<typename T1 , typename T2 , typename T3 , typename T4 > | |
auto | viscosityNumber (const T1 &viscosity, const T2 &surf_tension, const T3 &rho_k, const T4 &delta_rho, const Real &gravity_magnitude) |
Compute viscosity number (or coefficient) More... | |
template<typename T1 , typename T2 > | |
auto | Dean (const T1 &Re, const T2 &doD) |
Compute Dean number. More... | |
void | vel_from_arhoA_arhouA (Real arhoA, Real arhouA, Real &vel, Real &dvel_darhoA, Real &dvel_darhouA) |
Computes velocity and its derivatives from alpha*rho*A and alpha*rho*u*A. More... | |
ADReal | vel_from_arhoA_arhouA (ADReal arhoA, ADReal arhouA) |
Computes velocity from alpha*rho*A and alpha*rho*u*A. More... | |
Real | dvel_darhoA (Real arhoA, Real arhouA) |
Derivative of velocity w.r.t. More... | |
Real | dvel_darhouA (Real arhoA) |
Derivative of velocity w.r.t. More... | |
void | rho_from_arhoA_alpha_A (Real arhoA, Real alpha, Real A, Real &rho, Real &drho_darhoA, Real &drho_dalpha) |
Computes density and its derivatives from alpha*rho*A, alpha, and area. More... | |
ADReal | rho_from_arhoA_alpha_A (ADReal arhoA, ADReal alpha, ADReal A) |
Computes density from alpha*rho*A, alpha, and area. More... | |
void | v_from_rhoA_A (Real rhoA, Real A, Real &v, Real &dv_drhoA) |
Computes specific volume and its derivatives from rho*A, and area. More... | |
ADReal | v_from_rhoA_A (ADReal rhoA, ADReal A) |
Computes specific volume and its derivatives from rho*A, and area. More... | |
void | v_from_arhoA_alpha_A (Real arhoA, Real alpha, Real A, Real &v, Real &dv_darhoA, Real &dv_dalpha) |
Computes specific volume and its derivatives from alpha*rho*A, volume fraction, and area. More... | |
ADReal | v_from_arhoA_alpha_A (ADReal arhoA, ADReal alpha, ADReal A) |
Computes specific volume and its derivatives from alpha*rho*A, volume fraction, and area. More... | |
void | v_from_rho (Real rho, Real &v, Real &dv_drho) |
Computes specific volume and its derivative with respect to density. More... | |
Real | dv_dalpha_liquid (Real area, Real arhoA, bool is_liquid) |
Derivative of specific volume wrt alpha_liquid. More... | |
Real | dv_darhoA (Real area, Real arhoA) |
Derivative of specific volume wrt density equation solution variable. More... | |
void | e_from_arhoA_arhouA_arhoEA (Real arhoA, Real arhouA, Real arhoEA, Real &e, Real &de_darhoA, Real &de_darhouA, Real &de_darhoEA) |
Computes specific internal energy and its derivatives from alpha*rho*A, alpha*rho*u*A, and alpha*rho*E*A. More... | |
ADReal | e_from_arhoA_arhouA_arhoEA (ADReal arhoA, ADReal arhouA, ADReal arhoEA) |
void | e_from_E_vel (Real E, Real vel, Real &e, Real &de_dE, Real &de_dvel) |
Computes specific internal energy and its derivatives from specific total energy and velocity. More... | |
ADReal | e_from_E_vel (ADReal E, ADReal vel) |
Computes specific internal energy from specific total energy and velocity. More... | |
Real | de_darhoA (Real arhoA, Real arhouA, Real arhoEA) |
Derivative of specific internal energy wrt density of the phase (rhoA or arhoA) More... | |
Real | de_darhouA (Real arhoA, Real arhouA) |
Derivative of specific internal energy wrt momentum of the phase (rhouA or arhouA) More... | |
Real | de_darhoEA (Real arhoA) |
Derivative of specific internal energy wrt total energy of the phase (rhoEA or arhoEA) More... | |
void | E_from_arhoA_arhoEA (Real arhoA, Real arhoEA, Real &E, Real &dE_darhoA, Real &dE_darhoEA) |
Computes specific total energy and its derivatives from alpha*rho*A and alpha*rho*E*A. More... | |
ADReal | E_from_arhoA_arhoEA (ADReal arhoA, ADReal arhoEA) |
Computes specific total energy from alpha*rho*A and alpha*rho*E*A. More... | |
void | E_from_e_vel (Real e, Real vel, Real &E, Real &dE_de, Real &dE_dvel) |
Computes specific total energy and its derivatives from specific internal energy and velocity. More... | |
void | h_from_e_p_rho (Real e, Real p, Real rho, Real &h, Real &dh_de, Real &dh_dp, Real &dh_drho) |
Computes specific enthalpy and its derivatives from specific internal energy, pressure, and density. More... | |
ADReal | h_from_e_p_rho (ADReal e, ADReal p, ADReal rho) |
bool | isInlet (Real vel, Real normal) |
Determine if inlet boundary condition should be applied. More... | |
bool | isInlet (ADReal vel, Real normal) |
bool | isOutlet (Real vel, Real normal) |
Determine if outlet boundary condition should be applied. More... | |
bool | isOutlet (ADReal vel, Real normal) |
template<typename T > | |
T | stringToEnum (const std::string &s) |
Converts a string to an enum. More... | |
template<typename T > | |
T | stringToEnum (const std::string &s, const std::map< std::string, T > &enum_map) |
Converts a string to an enum using a map of string to enum. More... | |
template<typename T > | |
MooseEnum | getMooseEnum (const std::string &default_key, const std::map< std::string, T > &enum_map) |
Gets MooseEnum corresponding to an enum, using a map of string to enum. More... | |
void | computeOrthogonalDirections (const RealVectorValue &n_unnormalized, RealVectorValue &t1, RealVectorValue &t2) |
Computes two unit vectors orthogonal to the given vector. More... | |
void | allGatherADVectorMap (const Parallel::Communicator &comm, std::map< dof_id_type, std::vector< ADReal >> &this_map) |
Parallel gather of a map of DoF ID to AD vector. More... | |
void | allGatherADVectorMapSum (const Parallel::Communicator &comm, std::map< dof_id_type, std::vector< ADReal >> &this_map) |
Parallel gather of a map of DoF ID to AD vector. More... | |
DenseVector< Real > | applyQuotientRule (const Real &num, const Real &den, const DenseVector< Real > &dnum_dy, const DenseVector< Real > &dden_dy) |
Variables | |
FlowModelID | FM_INVALID = registerFlowModelID() |
FlowModelID | FM_SINGLE_PHASE = registerFlowModelID() |
FlowModelID | FM_TWO_PHASE = registerFlowModelID() |
FlowModelID | FM_TWO_PHASE_NCG = registerFlowModelID() |
FlowModelID | FM_GAS_MIX = registerFlowModelID() |
static const size_t | MAX_VARIABLE_LENGTH = 31 |
static const std::string | AREA = "A" |
static const std::string | AREA_LINEAR = "A_linear" |
static const std::string | DENSITY = "rho" |
static const std::string | DIRECTION = "direction" |
static const std::string | DYNAMIC_VISCOSITY = "mu" |
static const std::string | FRICTION_FACTOR_DARCY = "f_D" |
static const std::string | HEAT_FLUX_WALL = "q_wall" |
static const std::string | HEAT_FLUX_PERIMETER = "P_hf" |
static const std::string | HEAT_TRANSFER_COEFFICIENT_WALL = "Hw" |
static const std::string | HYDRAULIC_DIAMETER = "D_h" |
static const std::string | MASS_DIFFUSION_COEFFICIENT = "mass_diffusion_coefficient" |
static const std::string | MASS_FRACTION = "mass_fraction" |
static const std::string | NUSSELT_NUMBER = "Nu" |
static const std::string | PRESSURE = "p" |
static const std::string | REYNOLDS_NUMBER = "Re" |
static const std::string | RHOA = "rhoA" |
static const std::string | RHOEA = "rhoEA" |
static const std::string | RHOUA = "rhouA" |
static const std::string | SOUND_SPEED = "c" |
static const std::string | SPECIFIC_ENTHALPY = "h" |
static const std::string | SPECIFIC_HEAT_CONSTANT_PRESSURE = "cp" |
static const std::string | SPECIFIC_HEAT_CONSTANT_VOLUME = "cv" |
static const std::string | SPECIFIC_INTERNAL_ENERGY = "e" |
static const std::string | SPECIFIC_TOTAL_ENTHALPY = "H" |
static const std::string | SPECIFIC_VOLUME = "v" |
static const std::string | TEMPERATURE = "T" |
static const std::string | TEMPERATURE_WALL = "T_wall" |
static const std::string | THERMAL_CONDUCTIVITY = "k" |
static const std::string | UNITY = "unity" |
static const std::string | VELOCITY = "vel" |
static const std::string | VELOCITY_X = "vel_x" |
static const std::string | VELOCITY_Y = "vel_y" |
static const std::string | VELOCITY_Z = "vel_z" |
static const std::string | XIRHOA = "xirhoA" |
static const Real | gravity_const = 9.81 |
static VectorValue< Real > | default_gravity_vector = VectorValue<Real>(0.0, 0.0, -gravity_const) |
static const Real | Stefan_Boltzman_const = 5.670e-8 |
typedef unsigned int THM::FlowModelID |
Definition at line 29 of file ThermalHydraulicsApp.h.
bool THM::absoluteFuzzyEqualVectors | ( | const RealVectorValue & | a, |
const RealVectorValue & | b, | ||
const Real & | tol = libMesh::TOLERANCE * libMesh::TOLERANCE |
||
) |
Tests if two real-valued vectors are equal within some absolute tolerance.
[in] | a | First vector |
[in] | b | Second vector |
[in] | tol | Absolute tolerance |
Definition at line 18 of file Numerics.C.
Referenced by areParallelVectors(), and TEST().
void THM::allGatherADVectorMap | ( | const Parallel::Communicator & | comm, |
std::map< dof_id_type, std::vector< ADReal >> & | this_map | ||
) |
Parallel gather of a map of DoF ID to AD vector.
[in] | comm | Parallel communicator |
[in,out] | this_map | Data map |
Definition at line 47 of file THMUtils.C.
Referenced by ADHeatTransferFromHeatStructure3D1PhaseUserObject::finalize(), StoreVariableByElemIDSideUserObject::finalize(), and FlowChannelHeatStructureCouplerUserObject::finalize().
void THM::allGatherADVectorMapSum | ( | const Parallel::Communicator & | comm, |
std::map< dof_id_type, std::vector< ADReal >> & | this_map | ||
) |
Parallel gather of a map of DoF ID to AD vector.
In contrast to allGatherADVectorMap
, this function does not assume that each of the maps from the different processors have unique keys; it applies a sum if the key exists on multiple processors.
[in] | comm | Parallel communicator |
[in,out] | this_map | Data map |
Definition at line 58 of file THMUtils.C.
Referenced by HSCoupler2D2DRadiationUserObject::finalize(), and HSCoupler2D3DUserObject::finalize().
DenseVector<Real> THM::applyQuotientRule | ( | const Real & | num, |
const Real & | den, | ||
const DenseVector< Real > & | dnum_dy, | ||
const DenseVector< Real > & | dden_dy | ||
) |
Definition at line 45 of file Numerics.C.
Real THM::applyQuotientRule | ( | const Real & | num, |
const Real & | den, | ||
const Real & | dnum_dy, | ||
const Real & | dden_dy | ||
) |
Computes a derivative of a fraction using quotient rule for a derivative w.r.t.
a scalar quantity
[in] | num | numerator value |
[in] | den | denominator value |
[in] | dnum_dy | derivative of numerator value |
[in] | dden_dy | derivative of denominator value |
Definition at line 39 of file Numerics.C.
DenseVector<Real> THM::applyQuotientRule | ( | const Real & | num, |
const Real & | den, | ||
const DenseVector< Real > & | dnum_dy, | ||
const DenseVector< Real > & | dden_dy | ||
) |
Computes a derivative of a fraction using quotient rule for a derivative w.r.t.
a vector quantity
[in] | num | numerator value |
[in] | den | denominator value |
[in] | dnum_dy | derivative of numerator value |
[in] | dden_dy | derivative of denominator value |
bool THM::areParallelVectors | ( | const RealVectorValue & | a, |
const RealVectorValue & | b, | ||
const Real & | tol = libMesh::TOLERANCE * libMesh::TOLERANCE |
||
) |
Tests if two real-valued vectors are parallel within some absolute tolerance.
[in] | a | First vector |
[in] | b | Second vector |
[in] | tol | Absolute tolerance |
Definition at line 26 of file Numerics.C.
Referenced by ADJunctionParallelChannels1PhaseUserObject::computeFluxesAndResiduals(), ADGateValve1PhaseUserObject::finalize(), DiscreteLineSegmentInterface::getAlignmentAxis(), haveSameDirection(), and TEST().
Definition at line 18 of file THMSyntax.C.
Referenced by ThermalHydraulicsApp::registerAll().
void THM::computeOrthogonalDirections | ( | const RealVectorValue & | n_unnormalized, |
RealVectorValue & | t1, | ||
RealVectorValue & | t2 | ||
) |
Computes two unit vectors orthogonal to the given vector.
The input vector need not be normalized; it will be normalized within this function.
[in] | n_unnormalized | Vector for which to find orthogonal directions |
[out] | t1 | First orthogonal unit vector |
[out] | t2 | Second orthogonal unit vector |
Definition at line 22 of file THMUtils.C.
Referenced by ADVolumeJunction1PhaseUserObject::computeFluxesAndResiduals(), NumericalFlux1D::getFlux(), and TEST().
Derivative of specific internal energy wrt density of the phase (rhoA or arhoA)
arhoA | - density equation solution variable: alpha*rho*A |
arhouA | - momentum equation solution variable: alpha*rho*u*A |
arhoEA | - energy equation solution variable: alpha*rho*E*A |
Definition at line 181 of file Numerics.C.
Referenced by FluidProperties3EqnMaterial::computeQpProperties(), e_from_arhoA_arhouA_arhoEA(), and TEST().
Derivative of specific internal energy wrt total energy of the phase (rhoEA or arhoEA)
arhoA | - density equation solution variable: alpha*rho*A |
Definition at line 193 of file Numerics.C.
Referenced by FluidProperties3EqnMaterial::computeQpProperties(), e_from_arhoA_arhouA_arhoEA(), and TEST().
Derivative of specific internal energy wrt momentum of the phase (rhouA or arhouA)
arhoA | - density equation solution variable: alpha*rho*A |
arhouA | - momentum equation solution variable: alpha*rho*u*A |
Definition at line 187 of file Numerics.C.
Referenced by FluidProperties3EqnMaterial::computeQpProperties(), e_from_arhoA_arhouA_arhoEA(), and TEST().
auto THM::Dean | ( | const T1 & | Re, |
const T2 & | doD | ||
) |
Compute Dean number.
Re | Reynolds number |
doD | tube diameter to coil diameter ratio |
Definition at line 239 of file Numerics.h.
Referenced by TEST().
Derivative of specific volume wrt alpha_liquid.
Makes sense only when using 7-equation model
area | - The cross-sectional area |
arhoA | - density equation solution variable: alpha*rho*A |
is_liquid | - True if the specific volume corresponds to liquid phase |
Definition at line 134 of file Numerics.C.
Referenced by TEST().
Derivative of specific volume wrt density equation solution variable.
area | - Cross-sectional area |
arhoA | - density equation solution variable: alpha*rho*A |
Definition at line 141 of file Numerics.C.
Referenced by FluidProperties3EqnMaterial::computeQpProperties(), TEST(), and v_from_arhoA_alpha_A().
Derivative of velocity w.r.t.
alpha*rho*A
[in] | arhoA | alpha*rho*A |
[in] | arhouA | alpha*rho*u*A |
Definition at line 72 of file Numerics.C.
Referenced by TEST(), and vel_from_arhoA_arhouA().
Derivative of velocity w.r.t.
alpha*rho*u*A
[in] | arhoA | alpha*rho*A |
Definition at line 78 of file Numerics.C.
Referenced by TEST(), and vel_from_arhoA_arhouA().
void THM::E_from_arhoA_arhoEA | ( | Real | arhoA, |
Real | arhoEA, | ||
Real & | E, | ||
Real & | dE_darhoA, | ||
Real & | dE_darhoEA | ||
) |
Computes specific total energy and its derivatives from alpha*rho*A and alpha*rho*E*A.
[in] | arhoA | alpha*rho*A |
[in] | arhoEA | alpha*rho*E*A |
[out] | E | specific total energy |
[out] | dE_darhoA | derivative of specific total energy w.r.t. alpha*rho*A |
[out] | dE_darhoEA | derivative of specific total energy w.r.t. alpha*rho*E*A |
Definition at line 199 of file Numerics.C.
Referenced by TEST().
Computes specific total energy from alpha*rho*A and alpha*rho*E*A.
[in] | arhoA | alpha*rho*A |
[in] | arhoEA | alpha*rho*E*A |
Definition at line 206 of file Numerics.C.
void THM::e_from_arhoA_arhouA_arhoEA | ( | Real | arhoA, |
Real | arhouA, | ||
Real | arhoEA, | ||
Real & | e, | ||
Real & | de_darhoA, | ||
Real & | de_darhouA, | ||
Real & | de_darhoEA | ||
) |
Computes specific internal energy and its derivatives from alpha*rho*A, alpha*rho*u*A, and alpha*rho*E*A.
[in] | arhoA | alpha*rho*A |
[in] | arhouA | alpha*rho*u*A |
[in] | arhoEA | alpha*rho*E*A |
[out] | e | specific internal energy |
[out] | de_darhoA | derivative of specific internal energy w.r.t. alpha*rho*A |
[out] | de_darhouA | derivative of specific internal energy w.r.t. alpha*rho*u*A |
[out] | de_darhoEA | derivative of specific internal energy w.r.t. alpha*rho*E*A |
Definition at line 147 of file Numerics.C.
Referenced by ADShaftConnectedCompressor1PhaseUserObject::computeFluxesAndResiduals(), and TEST().
Definition at line 162 of file Numerics.C.
Computes specific internal energy and its derivatives from specific total energy and velocity.
[in] | E | specific total energy |
[in] | vel | velocity |
[out] | e | specific internal energy |
[out] | de_dE | derivative of specific internal energy w.r.t. specific total energy |
[out] | de_dvel | derivative of specific internal energy w.r.t. velocity |
Definition at line 168 of file Numerics.C.
Referenced by TEST().
Computes specific internal energy from specific total energy and velocity.
[in] | E | specific total energy |
[in] | vel | velocity |
Definition at line 175 of file Numerics.C.
Computes specific total energy and its derivatives from specific internal energy and velocity.
[in] | e | specific internal energy |
[in] | vel | velocity |
[out] | E | specific total energy |
[out] | dE_de | derivative of specific total energy w.r.t. specific internal energy |
[out] | dE_dvel | derivative of specific total energy w.r.t. velocity |
Definition at line 212 of file Numerics.C.
Referenced by TEST().
MooseEnum THM::getMooseEnum | ( | const std::string & | default_key, |
const std::map< std::string, T > & | enum_map | ||
) |
Gets MooseEnum corresponding to an enum, using a map of string to enum.
T | enum type |
[in] | default_key | key corresponding to default value |
[in] | enum_map | map of string to enum |
Definition at line 66 of file THMEnums.h.
auto THM::Grashof | ( | const T1 & | beta, |
const T2 & | dT, | ||
const T3 & | D_h, | ||
const T4 & | rho_liquid, | ||
const T5 & | mu_liquid, | ||
const Real & | gravity_magnitude | ||
) |
Compute Grashof number.
beta | Thermal expansion coefficient |
dT | |T_w - T| |
D_h | Hydraulic diameter |
rho_liquid | Density of liquid |
mu_liquid | Viscosity of liquid |
gravity_magnitude | Gravitational acceleration magnitude |
Definition at line 178 of file Numerics.h.
Referenced by TEST().
void THM::h_from_e_p_rho | ( | Real | e, |
Real | p, | ||
Real | rho, | ||
Real & | h, | ||
Real & | dh_de, | ||
Real & | dh_dp, | ||
Real & | dh_drho | ||
) |
Computes specific enthalpy and its derivatives from specific internal energy, pressure, and density.
[in] | e | specific internal energy |
[in] | p | pressure |
[in] | rho | density |
[out] | h | specific enthalpy |
[out] | dh_de | derivative of specific enthalpy w.r.t. specific internal energy |
[out] | dh_dp | derivative of specific enthalpy w.r.t. pressure |
[out] | dh_drho | derivative of specific enthalpy w.r.t. density |
Definition at line 220 of file Numerics.C.
Referenced by ADShaftConnectedCompressor1PhaseUserObject::computeFluxesAndResiduals(), and TEST().
Definition at line 229 of file Numerics.C.
bool THM::haveSameDirection | ( | const RealVectorValue & | a, |
const RealVectorValue & | b, | ||
const Real & | tol = libMesh::TOLERANCE * libMesh::TOLERANCE |
||
) |
Tests if two real-valued vectors are in the same direction.
[in] | a | First vector |
[in] | b | Second vector |
[in] | tol | Absolute tolerance |
Definition at line 33 of file Numerics.C.
Referenced by TEST().
Determine if inlet boundary condition should be applied.
vel | Velocity of the phase |
normal | Outward normal vector |
Definition at line 235 of file Numerics.C.
Referenced by ADVolumeJunction1PhaseUserObject::computeFluxesAndResiduals(), ADBoundaryFlux3EqnGhostMassFlowRateTemperature::getGhostCellSolution(), ADBoundaryFlux3EqnGhostVelocityTemperature::getGhostCellSolution(), ADBoundaryFlux3EqnGhostStagnationPressureTemperature::getGhostCellSolution(), ADBoundaryFlux3EqnGhostDensityVelocity::getGhostCellSolution(), and TEST().
Definition at line 241 of file Numerics.C.
Determine if outlet boundary condition should be applied.
vel | Velocity of the phase |
normal | Outward normal vector |
Definition at line 247 of file Numerics.C.
Referenced by ADJunctionParallelChannels1PhaseUserObject::computeFluxesAndResiduals(), and TEST().
Definition at line 253 of file Numerics.C.
auto THM::Laplace | ( | const T1 & | surf_tension, |
const T2 & | delta_rho, | ||
const Real & | gravity_magnitude | ||
) |
Compute Laplace number (or coefficient)
surf_tension | Surface tension |
delta_rho | Difference in density of phases |
gravity_magnitude | Gravitational acceleration magnitude |
Definition at line 200 of file Numerics.h.
auto THM::Peclet | ( | const T1 & | volume_fraction, |
const T2 & | cp, | ||
const T3 & | rho, | ||
const T4 & | vel, | ||
const T5 & | D_h, | ||
const T6 & | k | ||
) |
Compute Peclet number.
volume_fraction | The volume fraction of the phase |
rho | The density of the phase |
vel | The velocity of the phase |
D_h | The hydraulic diameter |
k | Thermal conductivity |
cp | Specific heat |
k | Thermal conductivity |
Definition at line 153 of file Numerics.h.
Referenced by InterWrapper1PhaseProblem::computeInterpolatedValue(), SubChannel1PhaseProblem::computeInterpolatedValue(), InterWrapper1PhaseProblem::computeInterpolationCoefficients(), SubChannel1PhaseProblem::computeInterpolationCoefficients(), ADWallHeatTransferCoefficientLyonMaterial::computeQpProperties(), ADWallHeatTransferCoefficientKazimiMaterial::computeQpProperties(), ADWallHeatTransferCoefficientSchadMaterial::computeQpProperties(), ADWallHeatTransferCoefficientMikityukMaterial::computeQpProperties(), and TEST().
auto THM::Prandtl | ( | const T1 & | cp, |
const T2 & | mu, | ||
const T3 & | k | ||
) |
Compute Prandtl number.
cp | Specific heat |
mu | Dynamic viscosity |
k | Thermal conductivity |
Definition at line 133 of file Numerics.h.
Referenced by ADPrandtlNumberMaterial::computeQpProperties(), ADWallHeatTransferCoefficientGnielinskiMaterial::computeQpProperties(), PrandtlNumberMaterial::computeQpProperties(), WallHeatTransferCoefficient3EqnDittusBoelterMaterial::computeQpProperties(), ADWallHeatTransferCoefficientWeismanMaterial::computeQpProperties(), ADWallHeatTransferCoefficientWolfMcCarthyMaterial::computeQpProperties(), ADWallHeatTransferCoefficient3EqnDittusBoelterMaterial::computeQpProperties(), ADWallHTCGnielinskiAnnularMaterial::computeQpProperties(), PrandtlNumberAux::computeValue(), and TEST().
Definition at line 43 of file THMSyntax.C.
Referenced by ThermalHydraulicsApp::registerAll().
FlowModelID THM::registerFlowModelID | ( | ) |
Register a new flow mode type and return its ID.
Definition at line 34 of file ThermalHydraulicsApp.C.
auto THM::Reynolds | ( | const T1 & | volume_fraction, |
const T2 & | rho, | ||
const T3 & | vel, | ||
const T4 & | D_h, | ||
const T5 & | mu | ||
) |
Compute Reynolds number.
volume_fraction | The volume fraction of the phase |
rho | The density of the phase |
vel | The velocity of the phase |
D_h | The hydraulic diameter |
mu | The viscosity of the phase |
Definition at line 118 of file Numerics.h.
Referenced by ADWallFrictionChengMaterial::computeQpProperties(), ADWallFrictionChurchillMaterial::computeQpProperties(), ADWallHeatTransferCoefficientWolfMcCarthyMaterial::computeQpProperties(), ADWallHeatTransferCoefficient3EqnDittusBoelterMaterial::computeQpProperties(), ADWallHeatTransferCoefficientGnielinskiMaterial::computeQpProperties(), WallHeatTransferCoefficient3EqnDittusBoelterMaterial::computeQpProperties(), ADWallHeatTransferCoefficientWeismanMaterial::computeQpProperties(), WallFrictionChurchillMaterial::computeQpProperties(), ADReynoldsNumberMaterial::computeQpProperties(), ADWallHTCGnielinskiAnnularMaterial::computeQpProperties(), ReynoldsNumberMaterial::computeQpProperties(), ReynoldsNumberAux::computeValue(), and TEST().
void THM::rho_from_arhoA_alpha_A | ( | Real | arhoA, |
Real | alpha, | ||
Real | A, | ||
Real & | rho, | ||
Real & | drho_darhoA, | ||
Real & | drho_dalpha | ||
) |
Computes density and its derivatives from alpha*rho*A, alpha, and area.
[in] | arhoA | alpha*rho*A |
[in] | alpha | volume fraction |
[in] | A | area |
[out] | rho | density |
[out] | drho_darhoA | derivative of density w.r.t. alpha*rho*A |
[out] | drho_dalpha | derivative of density w.r.t. alpha |
Definition at line 84 of file Numerics.C.
Referenced by TEST().
Computes density from alpha*rho*A, alpha, and area.
[in] | arhoA | alpha*rho*A |
[in] | alpha | volume fraction |
[in] | A | area |
Definition at line 94 of file Numerics.C.
int THM::sgn | ( | T | val | ) |
The sign function.
val | The argument of the sign function |
Definition at line 41 of file Numerics.h.
Referenced by PolynomialQuadrature::ClenshawCurtisGrid::ClenshawCurtisGrid(), PorousFlowAqueousPreDisChemistry::computeQpReactionRates(), PorousFlowAqueousPreDisChemistry::dQpReactionRate_dT(), PolynomialQuadrature::hermite(), PolynomialQuadrature::legendre(), Normal::quantile(), BrentsMethod::root(), PolynomialQuadrature::SmolyakGrid::SmolyakGrid(), Water97FluidProperties::temperature_from_ph2a(), and Water97FluidProperties::temperature_from_ph2c().
T THM::stringToEnum | ( | const std::string & | s | ) |
Converts a string to an enum.
This template is designed to be specialized and use the other version of this function in conjunction with the correct map.
T | enum type |
[in] | s | string to convert |
Definition at line 18 of file Component1DConnection.C.
Referenced by SlopeReconstruction1DInterface< true >::SlopeReconstruction1DInterface(), and ViewFactorRayStudy::ViewFactorRayStudy().
T THM::stringToEnum | ( | const std::string & | s, |
const std::map< std::string, T > & | enum_map | ||
) |
Converts a string to an enum using a map of string to enum.
T | enum type |
[in] | s | string to convert |
[in] | enum_map | map of string to enum |
Definition at line 53 of file THMEnums.h.
Component1DConnection::EEndType THM::stringToEnum | ( | const std::string & | s | ) |
Definition at line 18 of file Component1DConnection.C.
Component2D::ExternalBoundaryType THM::stringToEnum | ( | const std::string & | s | ) |
Definition at line 28 of file Component2D.C.
FlowChannelBase::EConvHeatTransGeom THM::stringToEnum | ( | const std::string & | s | ) |
Definition at line 49 of file FlowChannelBase.C.
FlowChannelBase::EPipeType THM::stringToEnum | ( | const std::string & | s | ) |
Definition at line 57 of file FlowChannelBase.C.
FlowChannelBase::EPipeLocation THM::stringToEnum | ( | const std::string & | s | ) |
Definition at line 64 of file FlowChannelBase.C.
void THM::v_from_arhoA_alpha_A | ( | Real | arhoA, |
Real | alpha, | ||
Real | A, | ||
Real & | v, | ||
Real & | dv_darhoA, | ||
Real & | dv_dalpha | ||
) |
Computes specific volume and its derivatives from alpha*rho*A, volume fraction, and area.
[in] | arhoA | alpha*rho*A |
[in] | alpha | volume fraction |
[in] | A | area |
[out] | dv_darhoA | derivative of specific volume w.r.t. alpha*rho*A |
[out] | dv_dalpha | derivative of specific volume w.r.t. volume fraction |
Definition at line 113 of file Numerics.C.
Referenced by TEST().
Computes specific volume and its derivatives from alpha*rho*A, volume fraction, and area.
[in] | arhoA | alpha*rho*A |
[in] | alpha | volume fraction |
[in] | A | area |
Definition at line 121 of file Numerics.C.
Computes specific volume and its derivative with respect to density.
[in] | rho | density |
[in] | v | specific volume |
[in] | dv_drho | derivative of specific volume w.r.t. density |
Definition at line 127 of file Numerics.C.
Referenced by TEST().
Computes specific volume and its derivatives from rho*A, and area.
[in] | rhoA | rho*A |
[in] | A | area |
[out] | dv_drhoA | derivative of specific volume w.r.t. rho*A |
Definition at line 100 of file Numerics.C.
Referenced by ADSimpleTurbine1PhaseUserObject::computeFluxesAndResiduals(), ADVolumeJunction1PhaseUserObject::computeFluxesAndResiduals(), ADJunctionParallelChannels1PhaseUserObject::computeFluxesAndResiduals(), VolumeJunction1PhaseAux::computeValue(), and TEST().
Computes specific volume and its derivatives from rho*A, and area.
[in] | rhoA | rho*A |
[in] | A | area |
Definition at line 107 of file Numerics.C.
void THM::vel_from_arhoA_arhouA | ( | Real | arhoA, |
Real | arhouA, | ||
Real & | vel, | ||
Real & | dvel_darhoA, | ||
Real & | dvel_darhouA | ||
) |
Computes velocity and its derivatives from alpha*rho*A and alpha*rho*u*A.
[in] | arhoA | alpha*rho*A |
[in] | arhouA | alpha*rho*u*A |
[out] | vel | velocity |
[out] | dvel_darhoA | derivative of velocity w.r.t. alpha*rho*A |
[out] | dvel_darhouA | derivative of velocity w.r.t. alpha*rho*u*A |
Definition at line 58 of file Numerics.C.
Referenced by FluidProperties3EqnMaterial::computeQpProperties(), and TEST().
Computes velocity from alpha*rho*A and alpha*rho*u*A.
arhoA | alpha*rho*A |
arhouA | alpha*rho*u*A |
Definition at line 66 of file Numerics.C.
auto THM::viscosityNumber | ( | const T1 & | viscosity, |
const T2 & | surf_tension, | ||
const T3 & | rho_k, | ||
const T4 & | delta_rho, | ||
const Real & | gravity_magnitude | ||
) |
Compute viscosity number (or coefficient)
viscosity | Viscosity |
surf_tension | Surface tension |
rho_k | Density of k-th phase of interest |
delta_rho | Density difference |
gravity_magnitude | Gravitational acceleration magnitude |
Definition at line 218 of file Numerics.h.
Referenced by TEST().
|
static |
Definition at line 14 of file THMNames.h.
Referenced by FlowModel1PhaseBase::addDensityAux(), FlowModelGasMix::addDensityIC(), FlowModel1PhaseBase::addEnergyGravityKernel(), FlowModelGasMix::addFluidPropertiesMaterials(), FlowChannel1PhaseBase::addHydraulicDiameterMaterial(), FlowModel1PhaseBase::addMomentumFrictionKernel(), FlowModel1PhaseBase::addMomentumGravityKernel(), FlowModelGasMix::addPressureAux(), FlowModel1PhaseBase::addRhoAIC(), FlowModelGasMix::addRhoEAIC(), FlowModelGasMix::addSlopeReconstructionMaterial(), FlowModel1PhaseBase::addSpecificTotalEnthalpyAux(), FlowModel1PhaseBase::addSpecificTotalEnthalpyIC(), FlowModel1PhaseBase::addSpecificVolumeAux(), FlowModel1PhaseBase::addSpecificVolumeIC(), and FlowModelGasMix::addTemperatureAux().
|
static |
Definition at line 15 of file THMNames.h.
Referenced by FlowModelGasMix::addMassDiffusionEnergyDGKernel(), FlowModelGasMix::addMassDiffusionSpeciesDGKernel(), FlowModel1PhaseBase::addMomentumAreaGradientKernel(), FlowModelGasMix::addRDGAdvectionDGKernels(), FlowModelGasMix::addSlopeReconstructionMaterial(), FlowBoundary1Phase::addWeakBCs(), and FlowBoundaryGasMix::addWeakBCs().
|
static |
Definition at line 29 of file Numerics.h.
Referenced by GravityInterface::validParams().
|
static |
Definition at line 16 of file THMNames.h.
Referenced by FlowModel1PhaseBase::addDensityAux(), FlowModelGasMix::addDensityIC(), FlowModel1PhaseBase::addEnergyGravityKernel(), FlowModelGasMix::addMassDiffusionEnergyDGKernel(), FlowModelGasMix::addMassDiffusionSpeciesDGKernel(), FlowModel1PhaseBase::addMomentumFrictionKernel(), FlowModel1PhaseBase::addMomentumGravityKernel(), FlowModel1PhaseBase::addRhoAIC(), FlowModel1PhaseBase::addVariables(), and PorousFlowPropertyAuxTempl< is_ad >::computeValue().
|
static |
Definition at line 17 of file THMNames.h.
Referenced by FlowModel1PhaseBase::addEnergyGravityKernel(), FlowModelGasMix::addMassDiffusionEnergyDGKernel(), FlowModelGasMix::addMassDiffusionSpeciesDGKernel(), FlowModel1PhaseBase::addMomentumAreaGradientKernel(), FlowModel1PhaseBase::addMomentumGravityKernel(), and FlowModel1PhaseBase::addVelocityAux().
|
static |
Definition at line 18 of file THMNames.h.
FlowModelID THM::FM_GAS_MIX = registerFlowModelID() |
Definition at line 45 of file ThermalHydraulicsApp.C.
Referenced by FlowChannelGasMix::getFlowModelID().
FlowModelID THM::FM_INVALID = registerFlowModelID() |
Definition at line 41 of file ThermalHydraulicsApp.C.
FlowModelID THM::FM_SINGLE_PHASE = registerFlowModelID() |
Definition at line 42 of file ThermalHydraulicsApp.C.
Referenced by FlowChannel1Phase::getFlowModelID(), and ThermalHydraulicsApp::registerAll().
FlowModelID THM::FM_TWO_PHASE = registerFlowModelID() |
Definition at line 43 of file ThermalHydraulicsApp.C.
FlowModelID THM::FM_TWO_PHASE_NCG = registerFlowModelID() |
Definition at line 44 of file ThermalHydraulicsApp.C.
|
static |
Definition at line 19 of file THMNames.h.
Referenced by FlowModel1PhaseBase::addMomentumFrictionKernel().
|
static |
Definition at line 26 of file Numerics.h.
Referenced by Pump1Phase::buildVolumeJunctionUserObject(), ShaftConnectedPump1Phase::buildVolumeJunctionUserObject(), ADSpecificImpulse1Phase::finalize(), SpecificImpulse1Phase::finalize(), and FlowModelSetup::validParams().
|
static |
Definition at line 21 of file THMNames.h.
|
static |
Definition at line 20 of file THMNames.h.
|
static |
Definition at line 22 of file THMNames.h.
|
static |
Definition at line 23 of file THMNames.h.
Referenced by FlowChannel1PhaseBase::addHydraulicDiameterMaterial(), and FlowModel1PhaseBase::addMomentumFrictionKernel().
|
static |
Definition at line 24 of file THMNames.h.
Referenced by FlowModelGasMix::addMassDiffusionEnergyDGKernel(), and FlowModelGasMix::addMassDiffusionSpeciesDGKernel().
|
static |
Definition at line 25 of file THMNames.h.
Referenced by FlowModelGasMix::addInitialConditions(), FlowModelGasMix::addMassDiffusionEnergyDGKernel(), FlowModelGasMix::addMassDiffusionSpeciesDGKernel(), FlowModelGasMix::addMassFractionAux(), FlowModelGasMix::addVariables(), and FlowModelGasMix::addXiRhoAIC().
|
static |
Definition at line 45 of file ThermalHydraulicsApp.h.
Referenced by Simulation::checkVariableNameLength().
|
static |
Definition at line 26 of file THMNames.h.
|
static |
Definition at line 27 of file THMNames.h.
Referenced by FlowModel1PhaseBase::addInitialConditions(), FlowModelGasMix::addMassDiffusionEnergyDGKernel(), FlowModel1PhaseBase::addMomentumAreaGradientKernel(), FlowModelGasMix::addPressureAux(), FlowModel1PhaseBase::addSpecificTotalEnthalpyAux(), FlowModel1PhaseBase::addSpecificTotalEnthalpyIC(), and FlowModel1PhaseBase::addVariables().
|
static |
Definition at line 28 of file THMNames.h.
|
static |
Definition at line 29 of file THMNames.h.
Referenced by FlowModel1PhaseBase::addDensityAux(), FlowModelGasMix::addFluidPropertiesMaterials(), FlowModel1PhaseBase::addKernels(), FlowModelGasMix::addMassFractionAux(), FlowModelGasMix::addPressureAux(), FlowModelGasMix::addRDGAdvectionDGKernels(), FlowModel1PhaseBase::addRhoAIC(), FlowModel1PhaseBase::addRhoUAIC(), FlowModelGasMix::addSlopeReconstructionMaterial(), FlowModel1PhaseBase::addSpecificInternalEnergyAux(), FlowModel1PhaseBase::addSpecificInternalEnergyIC(), FlowModel1PhaseBase::addSpecificTotalEnthalpyAux(), FlowModel1PhaseBase::addSpecificTotalEnthalpyIC(), FlowModel1PhaseBase::addSpecificVolumeAux(), FlowModel1PhaseBase::addSpecificVolumeIC(), FlowModelGasMix::addTemperatureAux(), FlowModel1PhaseBase::addVariables(), FlowModel1PhaseBase::addVelocityAux(), FlowBoundary1Phase::addWeakBCs(), FlowBoundaryGasMix::addWeakBCs(), FlowModelGasMix::addXiRhoAIC(), and FlowModelGasMix::solutionVariableNames().
|
static |
Definition at line 30 of file THMNames.h.
Referenced by FlowModel1PhaseBase::addEnergyGravityKernel(), FlowModelGasMix::addFluidPropertiesMaterials(), FlowModel1PhaseBase::addKernels(), FlowModelGasMix::addMassDiffusionEnergyDGKernel(), FlowModelGasMix::addPressureAux(), FlowModelGasMix::addRDGAdvectionDGKernels(), FlowModelGasMix::addRhoEAIC(), FlowModelGasMix::addSlopeReconstructionMaterial(), FlowModel1PhaseBase::addSpecificInternalEnergyAux(), FlowModel1PhaseBase::addSpecificInternalEnergyIC(), FlowModel1PhaseBase::addSpecificTotalEnthalpyAux(), FlowModel1PhaseBase::addSpecificTotalEnthalpyIC(), FlowModelGasMix::addTemperatureAux(), FlowModel1PhaseBase::addVariables(), FlowBoundary1Phase::addWeakBCs(), FlowBoundaryGasMix::addWeakBCs(), and FlowModelGasMix::solutionVariableNames().
|
static |
Definition at line 31 of file THMNames.h.
Referenced by FlowModelGasMix::addFluidPropertiesMaterials(), FlowModel1PhaseBase::addKernels(), FlowModel1PhaseBase::addMomentumAreaGradientKernel(), FlowModel1PhaseBase::addMomentumFrictionKernel(), FlowModel1PhaseBase::addMomentumGravityKernel(), FlowModelGasMix::addPressureAux(), FlowModelGasMix::addRDGAdvectionDGKernels(), FlowModel1PhaseBase::addRhoUAIC(), FlowModelGasMix::addSlopeReconstructionMaterial(), FlowModel1PhaseBase::addSpecificInternalEnergyAux(), FlowModel1PhaseBase::addSpecificInternalEnergyIC(), FlowModelGasMix::addTemperatureAux(), FlowModel1PhaseBase::addVariables(), FlowModel1PhaseBase::addVelocityAux(), FlowBoundary1Phase::addWeakBCs(), FlowBoundaryGasMix::addWeakBCs(), and FlowModelGasMix::solutionVariableNames().
|
static |
Definition at line 32 of file THMNames.h.
|
static |
Definition at line 33 of file THMNames.h.
|
static |
Definition at line 34 of file THMNames.h.
|
static |
Definition at line 35 of file THMNames.h.
|
static |
Definition at line 36 of file THMNames.h.
Referenced by FlowModel1PhaseBase::addSpecificInternalEnergyAux(), FlowModel1PhaseBase::addSpecificInternalEnergyIC(), and FlowModel1PhaseBase::addVariables().
|
static |
Definition at line 37 of file THMNames.h.
Referenced by FlowModel1PhaseBase::addSpecificTotalEnthalpyAux(), FlowModel1PhaseBase::addSpecificTotalEnthalpyIC(), and FlowModel1PhaseBase::addVariables().
|
static |
Definition at line 38 of file THMNames.h.
Referenced by FlowModel1PhaseBase::addSpecificVolumeAux(), FlowModel1PhaseBase::addSpecificVolumeIC(), and FlowModel1PhaseBase::addVariables().
|
static |
Definition at line 32 of file Numerics.h.
|
static |
Definition at line 39 of file THMNames.h.
Referenced by FlowModel1PhaseBase::addInitialConditions(), FlowModelGasMix::addMassDiffusionEnergyDGKernel(), FlowModelGasMix::addTemperatureAux(), and FlowModel1PhaseBase::addVariables().
|
static |
Definition at line 40 of file THMNames.h.
|
static |
Definition at line 41 of file THMNames.h.
|
static |
Definition at line 42 of file THMNames.h.
|
static |
Definition at line 43 of file THMNames.h.
Referenced by FlowModel1PhaseBase::addEnergyGravityKernel(), FlowModelGasMix::addMassDiffusionEnergyDGKernel(), FlowModel1PhaseBase::addMomentumFrictionKernel(), FlowModel1PhaseBase::addVariables(), FlowModel1PhaseBase::addVelocityAux(), and FlowModel1PhaseBase::addVelocityIC().
|
static |
Definition at line 44 of file THMNames.h.
Referenced by FlowModel1PhaseBase::addVariables(), FlowModel1PhaseBase::addVelocityAux(), and FlowModel1PhaseBase::addVelocityIC().
|
static |
Definition at line 45 of file THMNames.h.
Referenced by FlowModel1PhaseBase::addVariables(), FlowModel1PhaseBase::addVelocityAux(), and FlowModel1PhaseBase::addVelocityIC().
|
static |
Definition at line 46 of file THMNames.h.
Referenced by FlowModel1PhaseBase::addVariables(), FlowModel1PhaseBase::addVelocityAux(), and FlowModel1PhaseBase::addVelocityIC().
|
static |
Definition at line 47 of file THMNames.h.
Referenced by FlowModelGasMix::addFluidPropertiesMaterials(), FlowModelGasMix::addKernels(), FlowModelGasMix::addMassDiffusionSpeciesDGKernel(), FlowModelGasMix::addMassFractionAux(), FlowModelGasMix::addPressureAux(), FlowModelGasMix::addRDGAdvectionDGKernels(), FlowModelGasMix::addSlopeReconstructionMaterial(), FlowModelGasMix::addTemperatureAux(), FlowModelGasMix::addVariables(), FlowBoundaryGasMix::addWeakBCs(), FlowModelGasMix::addXiRhoAIC(), and FlowModelGasMix::solutionVariableNames().