Creates all the objects needed to solve the Navier Stokes mass and momentum equations. More...
#include <WCNSFVFlowPhysics.h>
Public Types | |
typedef DataFileName | DataFileParameterType |
Public Member Functions | |
WCNSFVFlowPhysics (const InputParameters ¶meters) | |
virtual MooseFunctorName | getLinearFrictionCoefName () const override |
Get the name of the linear friction coefficient. Returns an empty string if no friction. More... | |
UserObjectName | rhieChowUOName () const override |
Return the name of the Rhie Chow user object. More... | |
unsigned short | getNumberAlgebraicGhostingLayersNeeded () const override |
Return the number of algebraic ghosting layers needed. More... | |
bool | hasFlowEquations () const |
Whether the physics is actually creating the flow equations. More... | |
const std::vector< std::string > & | getVelocityNames () const |
To interface with other Physics. More... | |
const NonlinearVariableName & | getPressureName () const |
const NonlinearVariableName & | getFluidTemperatureName () const |
MooseFunctorName | getPorosityFunctorName (const bool smoothed) const |
const MooseEnum & | compressibility () const |
Return the compressibility of the flow equations selected. More... | |
bool | porousMediumTreatment () const |
Return whether a porous medium treatment is applied. More... | |
RealVectorValue | gravityVector () const |
Return the gravity vector. More... | |
const MooseFunctorName & | densityName () const |
Return the name of the density functor. More... | |
const MooseFunctorName & | dynamicViscosityName () const |
Return the name of the dynamic viscosity functor. More... | |
const MooseEnum & | getVelocityFaceInterpolationMethod () const |
Get the face interpolation method for velocity. More... | |
const MooseEnum & | getMomentumFaceInterpolationMethod () const |
Get the face interpolation method for momentum in the advection term. More... | |
const std::vector< BoundaryName > & | getInletBoundaries () const |
Get the inlet boundaries. More... | |
const std::vector< BoundaryName > & | getOutletBoundaries () const |
Get the outlet boundaries. More... | |
const std::vector< BoundaryName > & | getWallBoundaries () const |
Get the wall boundaries. More... | |
const std::vector< BoundaryName > & | getHydraulicSeparators () const |
Get the hydraulic separator boundaries. More... | |
const std::vector< Point > & | getFluxInletDirections () const |
Get the inlet direction if using a flux inlet. More... | |
const std::vector< PostprocessorName > & | getFluxInletPPs () const |
Get the inlet flux postprocessor if using a flux inlet. More... | |
virtual void | act () override final |
void | addBlocks (const std::vector< SubdomainName > &blocks) |
void | addBlocksById (const std::vector< SubdomainID > &block_ids) |
const std::vector< SubdomainName > & | blocks () const |
bool | checkBlockRestrictionIdentical (const std::string &object_name, const std::vector< SubdomainName > &blocks, const bool error_if_not_identical=true) const |
const T * | getCoupledPhysics (const PhysicsName &phys_name, const bool allow_fail=false) const |
const std::vector< T *> | getCoupledPhysics (const bool allow_fail=false) const |
unsigned int | dimension () const |
const ActionComponent & | getActionComponent (const ComponentName &comp_name) const |
void | checkComponentType (const ActionComponent &component) const |
virtual void | addComponent (const ActionComponent &component) |
const std::vector< VariableName > & | solverVariableNames () const |
const std::vector< VariableName > & | auxVariableNames () const |
void | timedAct () |
MooseObjectName | uniqueActionName () const |
const std::string & | specificTaskName () const |
const std::set< std::string > & | getAllTasks () const |
void | appendTask (const std::string &task) |
MooseApp & | getMooseApp () const |
const std::string & | type () const |
virtual const std::string & | name () const |
std::string | typeAndName () const |
std::string | errorPrefix (const std::string &error_type) const |
void | callMooseError (std::string msg, const bool with_prefix) const |
MooseObjectParameterName | uniqueParameterName (const std::string ¶meter_name) const |
const InputParameters & | parameters () const |
MooseObjectName | uniqueName () const |
const T & | getParam (const std::string &name) const |
std::vector< std::pair< T1, T2 > > | getParam (const std::string ¶m1, const std::string ¶m2) const |
const T & | getRenamedParam (const std::string &old_name, const std::string &new_name) const |
T | getCheckedPointerParam (const std::string &name, const std::string &error_string="") const |
bool | isParamValid (const std::string &name) const |
bool | isParamSetByUser (const std::string &nm) const |
void | paramError (const std::string ¶m, Args... args) const |
void | paramWarning (const std::string ¶m, Args... args) const |
void | paramInfo (const std::string ¶m, Args... args) const |
void | connectControllableParams (const std::string ¶meter, const std::string &object_type, const std::string &object_name, const std::string &object_parameter) const |
void | mooseError (Args &&... args) const |
void | mooseErrorNonPrefixed (Args &&... args) const |
void | mooseDocumentedError (const std::string &repo_name, const unsigned int issue_num, Args &&... args) const |
void | mooseWarning (Args &&... args) const |
void | mooseWarningNonPrefixed (Args &&... args) const |
void | mooseDeprecated (Args &&... args) const |
void | mooseInfo (Args &&... args) const |
std::string | getDataFileName (const std::string ¶m) const |
std::string | getDataFileNameByName (const std::string &relative_path) const |
std::string | getDataFilePath (const std::string &relative_path) const |
PerfGraph & | perfGraph () |
void | assertParamDefined (const std::string &libmesh_dbg_var(param)) const |
const Parallel::Communicator & | comm () const |
processor_id_type | n_processors () const |
processor_id_type | processor_id () const |
Static Public Member Functions | |
static InputParameters | validParams () |
Public Attributes | |
const ConsoleStream | _console |
Static Public Attributes | |
static constexpr auto | SYSTEM |
static constexpr auto | NAME |
Protected Member Functions | |
virtual void | initializePhysicsAdditional () override |
virtual void | actOnAdditionalTasks () override |
virtual void | addInitialConditions () override |
virtual void | addFVBCs () override |
virtual void | addMaterials () override |
virtual void | addPostprocessors () override |
void | addPorousMediumSpeedMaterial () |
Add material to define the local speed in porous medium flows. More... | |
void | addNonPorousMediumSpeedMaterial () |
Add material to define the local speed with no porous medium treatment. More... | |
VariableName | getFlowVariableName (const std::string &default_name) const |
Convenience routine to be able to retrieve the actual variable names from their default names. More... | |
bool | hasTurbulencePhysics () const |
Whether a turbulence Physics has been coupled in, to know which viscosity to pick on symmetry boundary conditions. More... | |
const WCNSFVTurbulencePhysics * | getCoupledTurbulencePhysics () const |
Find the turbulence physics. More... | |
bool | usingNavierStokesFVSyntax () const |
Detects if we are using the new Physics syntax or the old NavierStokesFV action. More... | |
InputParameters | getAdditionalRMParams () const override |
Parameters to change or add relationship managers. More... | |
void | assertParamDefined (const std::string ¶m) const |
bool | isTransient () const |
Factory & | getFactory () |
Factory & | getFactory () const |
virtual FEProblemBase & | getProblem () |
virtual const FEProblemBase & | getProblem () const |
void | prepareCopyVariablesFromMesh () const |
void | copyVariablesFromMesh (const std::vector< VariableName > &variables_to_copy, bool are_nonlinear=true) |
std::string | prefix () const |
void | saveSolverVariableName (const VariableName &var_name) |
void | saveAuxVariableName (const VariableName &var_name) |
bool | variableExists (const VariableName &var_name, bool error_if_aux) const |
bool | solverVariableExists (const VariableName &var_name) const |
const SolverSystemName & | getSolverSystem (unsigned int variable_index) const |
const SolverSystemName & | getSolverSystem (const VariableName &variable_name) const |
void | addRequiredPhysicsTask (const std::string &task) |
void | assignBlocks (InputParameters ¶ms, const std::vector< SubdomainName > &blocks) const |
bool | allMeshBlocks (const std::vector< SubdomainName > &blocks) const |
void | addPetscPairsToPetscOptions (const std::vector< std::pair< MooseEnumItem, std::string >> &petsc_pair_options) |
bool | addRelationshipManagers (Moose::RelationshipManagerType when_type, const InputParameters &moose_object_pars) |
void | associateWithParameter (const std::string ¶m_name, InputParameters ¶ms) const |
void | associateWithParameter (const InputParameters &from_params, const std::string ¶m_name, InputParameters ¶ms) const |
const T & | getMeshProperty (const std::string &data_name, const std::string &prefix) |
const T & | getMeshProperty (const std::string &data_name) |
bool | hasMeshProperty (const std::string &data_name, const std::string &prefix) const |
bool | hasMeshProperty (const std::string &data_name, const std::string &prefix) const |
bool | hasMeshProperty (const std::string &data_name) const |
bool | hasMeshProperty (const std::string &data_name) const |
std::string | meshPropertyName (const std::string &data_name) const |
PerfID | registerTimedSection (const std::string §ion_name, const unsigned int level) const |
PerfID | registerTimedSection (const std::string §ion_name, const unsigned int level, const std::string &live_message, const bool print_dots=true) const |
std::string | timedSectionName (const std::string §ion_name) const |
void | checkParamsBothSetOrNotSet (const std::string ¶m1, const std::string ¶m2) const |
void | checkSecondParamSetOnlyIfFirstOneTrue (const std::string ¶m1, const std::string ¶m2) const |
void | checkSecondParamSetOnlyIfFirstOneSet (const std::string ¶m1, const std::string ¶m2) const |
void | checkVectorParamsSameLength (const std::string ¶m1, const std::string ¶m2) const |
void | checkVectorParamAndMultiMooseEnumLength (const std::string ¶m1, const std::string ¶m2) const |
void | checkTwoDVectorParamsSameLength (const std::string ¶m1, const std::string ¶m2) const |
void | checkVectorParamsNoOverlap (const std::vector< std::string > ¶m_vecs) const |
void | checkTwoDVectorParamsNoRespectiveOverlap (const std::vector< std::string > ¶m_vecs) const |
void | checkTwoDVectorParamInnerSameLengthAsOneDVector (const std::string ¶m1, const std::string ¶m2) const |
void | checkTwoDVectorParamMultiMooseEnumSameLength (const std::string ¶m1, const std::string ¶m2, const bool error_for_param2) const |
void | checkVectorParamNotEmpty (const std::string ¶m1) const |
void | checkVectorParamsSameLengthIfSet (const std::string ¶m1, const std::string ¶m2, const bool ignore_empty_default_param2=false) const |
void | checkVectorParamLengthSameAsCombinedOthers (const std::string ¶m1, const std::string ¶m2, const std::string ¶m3) const |
void | checkBlockwiseConsistency (const std::string &block_param_name, const std::vector< std::string > ¶meter_names) const |
bool | parameterConsistent (const InputParameters &other_param, const std::string ¶m_name) const |
void | warnInconsistent (const InputParameters ¶meters, const std::string ¶m_name) const |
void | errorDependentParameter (const std::string ¶m1, const std::string &value_not_set, const std::vector< std::string > &dependent_params) const |
void | errorInconsistentDependentParameter (const std::string ¶m1, const std::string &value_set, const std::vector< std::string > &dependent_params) const |
Static Protected Member Functions | |
static std::string | meshPropertyName (const std::string &data_name, const std::string &prefix) |
Protected Attributes | |
const TagName | _pressure_tag = "p_tag" |
Name of the vector to hold pressure momentum equation contributions. More... | |
const bool | _has_flow_equations |
Boolean to keep track of whether the flow equations should be created. More... | |
const MooseEnum | _compressibility |
Compressibility type, can be compressible, incompressible or weakly-compressible. More... | |
const bool | _solve_for_dynamic_pressure |
Whether we are solving for the total or dynamic pressure. More... | |
const bool | _porous_medium_treatment |
Whether to use the porous medium treatment. More... | |
const MooseFunctorName | _porosity_name |
Name of the porosity functor. More... | |
MooseFunctorName | _flow_porosity_functor_name |
Name of the porosity functor for the flow equations (if smoothed) More... | |
const std::vector< std::string > | _velocity_names |
Velocity names. More... | |
const NonlinearVariableName | _pressure_name |
Pressure name. More... | |
const NonlinearVariableName | _fluid_temperature_name |
Fluid temperature name. More... | |
const MooseFunctorName | _density_name |
Name of the density material property. More... | |
const MooseFunctorName | _density_gravity_name |
Name of the density material property used for gravity and Boussinesq terms. More... | |
const MooseFunctorName | _dynamic_viscosity_name |
Name of the dynamic viscosity material property. More... | |
const MooseEnum | _velocity_interpolation |
The velocity face interpolation method for advecting other quantities. More... | |
const MooseEnum | _momentum_advection_interpolation |
The momentum face interpolation method for being advected. More... | |
const WCNSFVTurbulencePhysics * | _turbulence_physics |
Can be set to a coupled turbulence physics. More... | |
const std::vector< BoundaryName > | _inlet_boundaries |
Boundaries with a flow inlet specified on them. More... | |
const std::vector< BoundaryName > | _outlet_boundaries |
Boundaries with a flow outlet specified on them. More... | |
const std::vector< BoundaryName > | _wall_boundaries |
Boundaries which define a wall (slip/noslip/etc.) More... | |
const std::vector< BoundaryName > | _hydraulic_separators |
Hydraulic separator boundaries. More... | |
std::map< BoundaryName, MooseEnum > | _momentum_inlet_types |
Momentum inlet boundary types. More... | |
std::map< BoundaryName, MooseEnum > | _momentum_outlet_types |
Momentum outlet boundary types. More... | |
std::map< BoundaryName, MooseEnum > | _momentum_wall_types |
Momentum wall boundary types. More... | |
std::vector< PostprocessorName > | _flux_inlet_pps |
Postprocessors describing the momentum inlet for each boundary. Indexing based on the number of flux boundaries. More... | |
std::vector< Point > | _flux_inlet_directions |
Direction of each flux inlet. Indexing based on the number of flux boundaries. More... | |
std::map< BoundaryName, std::vector< MooseFunctorName > > | _momentum_inlet_functors |
Functors describing the momentum inlet for each boundary. More... | |
std::map< BoundaryName, MooseFunctorName > | _pressure_functors |
Functors describing the outlet pressure on each boundary. More... | |
std::map< BoundaryName, std::vector< MooseFunctorName > > | _momentum_wall_functors |
Functors describing the momentum for each wall boundary. More... | |
bool | _define_variables |
Whether to define variables if they do not exist. More... | |
std::vector< SolverSystemName > | _system_names |
std::vector< unsigned int > | _system_numbers |
const bool | _verbose |
const MooseEnum & | _preconditioning |
std::vector< SubdomainName > | _blocks |
std::string | _registered_identifier |
std::string | _specific_task_name |
std::set< std::string > | _all_tasks |
ActionWarehouse & | _awh |
const std::string & | _current_task |
std::shared_ptr< MooseMesh > & | _mesh |
std::shared_ptr< MooseMesh > & | _displaced_mesh |
std::shared_ptr< FEProblemBase > & | _problem |
PerfID | _act_timer |
MooseApp & | _app |
const std::string | _type |
const std::string | _name |
const InputParameters & | _pars |
Factory & | _factory |
ActionFactory & | _action_factory |
MooseApp & | _pg_moose_app |
const std::string | _prefix |
const Parallel::Communicator & | _communicator |
Private Member Functions | |
virtual void | addSolverVariables () override |
virtual void | addFVKernels () override |
virtual void | addUserObjects () override |
virtual void | addCorrectors () override |
void | addMassTimeKernels () |
Function adding kernels for the time derivative term of the weakly compressible continuity equation. More... | |
void | addMassKernels () |
Function adding kernels for the incompressible continuity equation. More... | |
void | addPressurePinKernel () |
Function adding the pressure constraint. More... | |
void | addMomentumTimeKernels () override |
Functions adding kernels for the incompressible momentum equation If the material properties are not constant, these can be used for weakly-compressible simulations (except the Boussinesq kernel) as well. More... | |
void | addMomentumViscousDissipationKernels () |
void | addMomentumMixingLengthKernels () |
void | addMomentumAdvectionKernels () |
void | addMomentumPressureKernels () override |
void | addMomentumGravityKernels () override |
void | addMomentumBoussinesqKernels () override |
void | addMomentumFrictionKernels () |
void | addInletBC () override |
Functions adding boundary conditions for the incompressible simulation. More... | |
void | addOutletBC () override |
void | addWallsBC () override |
void | addSeparatorBC () override |
bool | hasForchheimerFriction () const override |
Return whether a Forchheimer friction model is in use. More... | |
void | addRhieChowUserObjects () override |
Function which adds the RhieChow interpolator user objects for weakly and incompressible formulations. More... | |
void | checkRhieChowFunctorsDefined () const |
Checks that sufficient Rhie Chow coefficients have been defined for the given dimension, used for scalar or temperature advection by auxiliary variables. More... | |
Private Attributes | |
const unsigned | _porosity_smoothing_layers |
The number of smoothing layers if that treatment is used on porosity. More... | |
std::vector< std::vector< SubdomainName > > | _friction_blocks |
Subdomains where we want to have volumetric friction. More... | |
std::vector< std::vector< std::string > > | _friction_types |
The friction correlation types used for each block. More... | |
std::vector< std::vector< std::string > > | _friction_coeffs |
The coefficients used for each item if friction type. More... | |
UserObjectName | _rc_uo_name |
Name of the user object in charge of computing the Rhie Chow coefficients. More... | |
Creates all the objects needed to solve the Navier Stokes mass and momentum equations.
Definition at line 18 of file WCNSFVFlowPhysics.h.
WCNSFVFlowPhysics::WCNSFVFlowPhysics | ( | const InputParameters & | parameters | ) |
Definition at line 91 of file WCNSFVFlowPhysics.C.
|
overrideprotectedvirtualinherited |
Reimplemented from PhysicsBase.
Definition at line 240 of file WCNSFVFlowPhysicsBase.C.
|
overrideprivatevirtual |
Reimplemented from PhysicsBase.
Definition at line 1029 of file WCNSFVFlowPhysics.C.
|
overrideprotectedvirtualinherited |
Reimplemented from PhysicsBase.
Definition at line 248 of file WCNSFVFlowPhysicsBase.C.
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 262 of file WCNSFVFlowPhysics.C.
|
overrideprotectedvirtualinherited |
Reimplemented from PhysicsBase.
Definition at line 298 of file WCNSFVFlowPhysicsBase.C.
|
overrideprivatevirtual |
Functions adding boundary conditions for the incompressible simulation.
These are used for weakly-compressible simulations as well.
Implements WCNSFVFlowPhysicsBase.
Definition at line 672 of file WCNSFVFlowPhysics.C.
|
private |
Function adding kernels for the incompressible continuity equation.
Definition at line 325 of file WCNSFVFlowPhysics.C.
Referenced by addFVKernels().
|
private |
Function adding kernels for the time derivative term of the weakly compressible continuity equation.
Definition at line 304 of file WCNSFVFlowPhysics.C.
Referenced by addFVKernels().
|
overrideprotectedvirtualinherited |
Reimplemented from PhysicsBase.
Definition at line 257 of file WCNSFVFlowPhysicsBase.C.
|
private |
Definition at line 406 of file WCNSFVFlowPhysics.C.
Referenced by addFVKernels().
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 539 of file WCNSFVFlowPhysics.C.
Referenced by addFVKernels().
|
private |
Definition at line 577 of file WCNSFVFlowPhysics.C.
Referenced by addFVKernels().
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 504 of file WCNSFVFlowPhysics.C.
Referenced by addFVKernels().
|
private |
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 475 of file WCNSFVFlowPhysics.C.
Referenced by addFVKernels().
|
overrideprivatevirtual |
Functions adding kernels for the incompressible momentum equation If the material properties are not constant, these can be used for weakly-compressible simulations (except the Boussinesq kernel) as well.
Implements WCNSFVFlowPhysicsBase.
Definition at line 368 of file WCNSFVFlowPhysics.C.
Referenced by addFVKernels().
|
private |
Definition at line 437 of file WCNSFVFlowPhysics.C.
Referenced by addFVKernels().
|
protectedinherited |
Add material to define the local speed with no porous medium treatment.
Definition at line 283 of file WCNSFVFlowPhysicsBase.C.
Referenced by WCNSFVFlowPhysicsBase::addMaterials().
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 806 of file WCNSFVFlowPhysics.C.
|
protectedinherited |
Add material to define the local speed in porous medium flows.
Definition at line 266 of file WCNSFVFlowPhysicsBase.C.
Referenced by WCNSFVFlowPhysicsBase::addMaterials().
|
overrideprotectedvirtualinherited |
Reimplemented from PhysicsBase.
Definition at line 359 of file WCNSFVFlowPhysicsBase.C.
|
private |
Function adding the pressure constraint.
Definition at line 349 of file WCNSFVFlowPhysics.C.
Referenced by addFVKernels().
|
overrideprivatevirtual |
Function which adds the RhieChow interpolator user objects for weakly and incompressible formulations.
Implements WCNSFVFlowPhysicsBase.
Definition at line 1097 of file WCNSFVFlowPhysics.C.
Referenced by addUserObjects().
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 997 of file WCNSFVFlowPhysics.C.
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 152 of file WCNSFVFlowPhysics.C.
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 1022 of file WCNSFVFlowPhysics.C.
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 879 of file WCNSFVFlowPhysics.C.
|
private |
Checks that sufficient Rhie Chow coefficients have been defined for the given dimension, used for scalar or temperature advection by auxiliary variables.
Definition at line 1164 of file WCNSFVFlowPhysics.C.
Referenced by addRhieChowUserObjects().
|
inlineinherited |
Return the compressibility of the flow equations selected.
Definition at line 47 of file WCNSFVFlowPhysicsBase.h.
|
inlineinherited |
Return the name of the density functor.
Definition at line 53 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVTurbulencePhysics::addAuxiliaryKernels(), WCNSFVTurbulencePhysics::addFVBCs(), WCNSFVTurbulencePhysics::addInitialConditions(), WCNSFVTurbulencePhysics::addKEpsilonAdvection(), WCNSFVTurbulencePhysics::addKEpsilonSink(), WCNSFVTurbulencePhysics::addMaterials(), PNSFVSolidHeatTransferPhysics::checkFluidAndSolidHeatTransferPhysicsParameters(), and WCNSFVTwoPhaseMixturePhysics::WCNSFVTwoPhaseMixturePhysics().
|
inlineinherited |
Return the name of the dynamic viscosity functor.
Definition at line 55 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVTurbulencePhysics::addAuxiliaryKernels(), WCNSFVTurbulencePhysics::addFlowTurbulenceKernels(), WCNSFVTurbulencePhysics::addFVBCs(), WCNSFVTurbulencePhysics::addKEpsilonDiffusion(), WCNSFVTurbulencePhysics::addKEpsilonSink(), and WCNSFVTurbulencePhysics::addMaterials().
|
overrideprotectedvirtualinherited |
Parameters to change or add relationship managers.
Reimplemented from PhysicsBase.
Definition at line 42 of file NavierStokesPhysicsBase.C.
|
protectedinherited |
Find the turbulence physics.
Definition at line 405 of file WCNSFVFlowPhysicsBase.C.
Referenced by WCNSFVFlowPhysicsBase::actOnAdditionalTasks().
|
protectedinherited |
Convenience routine to be able to retrieve the actual variable names from their default names.
Definition at line 379 of file WCNSFVFlowPhysicsBase.C.
|
inlineinherited |
Definition at line 42 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVTurbulencePhysics::addFluidEnergyTurbulenceKernels(), and WCNSFVFlowPhysicsBase::getFlowVariableName().
|
inlineinherited |
Get the inlet direction if using a flux inlet.
Definition at line 72 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), and WCNSFVScalarTransportPhysics::addScalarInletBC().
|
inlineinherited |
Get the inlet flux postprocessor if using a flux inlet.
Definition at line 74 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), and WCNSFVScalarTransportPhysics::addScalarInletBC().
|
inlineinherited |
Get the hydraulic separator boundaries.
Definition at line 70 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergySeparatorBC().
|
inlineinherited |
Get the inlet boundaries.
Definition at line 64 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSLinearFVScalarTransportPhysics::addScalarInletBC(), and WCNSFVScalarTransportPhysics::addScalarInletBC().
|
overridevirtual |
Get the name of the linear friction coefficient. Returns an empty string if no friction.
Implements WCNSFVFlowPhysicsBase.
Definition at line 1182 of file WCNSFVFlowPhysics.C.
|
inlineinherited |
Get the face interpolation method for momentum in the advection term.
Definition at line 59 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVTwoPhaseMixturePhysics::addAdvectionSlipTerm().
|
overridevirtual |
Return the number of algebraic ghosting layers needed.
Implements NavierStokesPhysicsBase.
Definition at line 1083 of file WCNSFVFlowPhysics.C.
|
inlineinherited |
Get the outlet boundaries.
Definition at line 66 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFluidHeatTransferPhysics::addEnergyOutletBC(), and WCNSLinearFVScalarTransportPhysics::addScalarOutletBC().
|
inherited |
Definition at line 396 of file WCNSFVFlowPhysicsBase.C.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyTimeKernels(), WCNSFVScalarTransportPhysics::addScalarAdvectionKernels(), and WCNSFVCoupledAdvectionPhysicsHelper::getPorosityFunctorName().
|
inlineinherited |
Definition at line 41 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFluidHeatTransferPhysicsBase::addMaterials(), and WCNSFVFlowPhysicsBase::getFlowVariableName().
|
inlineinherited |
Get the face interpolation method for velocity.
Definition at line 57 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVTwoPhaseMixturePhysics::addAdvectionSlipTerm().
|
inlineinherited |
To interface with other Physics.
Definition at line 40 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVTwoPhaseMixturePhysics::addAdvectionSlipTerm(), WCNSFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTwoPhaseMixturePhysics::addPhaseDriftFluxTerm(), and WCNSFVFlowPhysicsBase::getFlowVariableName().
|
inlineinherited |
Get the wall boundaries.
Definition at line 68 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), and WCNSLinearFVFluidHeatTransferPhysics::addEnergyWallBC().
|
inlineinherited |
Return the gravity vector.
Definition at line 51 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVTwoPhaseMixturePhysics::addMaterials().
|
inlineinherited |
Whether the physics is actually creating the flow equations.
Definition at line 37 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVTwoPhaseMixturePhysics::addFVKernels(), and WCNSFVTurbulencePhysics::retrieveCoupledPhysics().
|
overrideprivatevirtual |
Return whether a Forchheimer friction model is in use.
Implements WCNSFVFlowPhysicsBase.
Definition at line 1073 of file WCNSFVFlowPhysics.C.
Referenced by addMomentumFrictionKernels().
|
inlineprotectedinherited |
Whether a turbulence Physics has been coupled in, to know which viscosity to pick on symmetry boundary conditions.
Definition at line 125 of file WCNSFVFlowPhysicsBase.h.
Referenced by addWallsBC().
|
overrideprotectedvirtualinherited |
Reimplemented from PhysicsBase.
Reimplemented in WCNSLinearFVFlowPhysics.
Definition at line 234 of file WCNSFVFlowPhysicsBase.C.
Referenced by WCNSLinearFVFlowPhysics::initializePhysicsAdditional().
|
inlineinherited |
Return whether a porous medium treatment is applied.
Definition at line 49 of file WCNSFVFlowPhysicsBase.h.
|
overridevirtual |
Return the name of the Rhie Chow user object.
Implements WCNSFVFlowPhysicsBase.
Definition at line 1175 of file WCNSFVFlowPhysics.C.
Referenced by addInletBC(), addMassKernels(), addMomentumAdvectionKernels(), addMomentumBoussinesqKernels(), addMomentumFrictionKernels(), addMomentumGravityKernels(), addMomentumPressureKernels(), addMomentumTimeKernels(), addMomentumViscousDissipationKernels(), addOutletBC(), addSeparatorBC(), and addWallsBC().
|
inlineprotectedinherited |
Detects if we are using the new Physics syntax or the old NavierStokesFV action.
Definition at line 32 of file NavierStokesPhysicsBase.h.
|
static |
Definition at line 24 of file WCNSFVFlowPhysics.C.
|
protectedinherited |
Compressibility type, can be compressible, incompressible or weakly-compressible.
Definition at line 143 of file WCNSFVFlowPhysicsBase.h.
Referenced by addFVKernels(), WCNSLinearFVFlowPhysics::addMomentumBoussinesqKernels(), addMomentumBoussinesqKernels(), addMomentumTimeKernels(), WCNSFVFlowPhysicsBase::compressibility(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Whether to define variables if they do not exist.
Definition at line 44 of file NavierStokesPhysicsBase.h.
Referenced by WCNSLinearFVFluidHeatTransferPhysics::addAuxiliaryVariables(), WCNSFVTurbulencePhysics::addAuxiliaryVariables(), WCNSFVTurbulencePhysics::addInitialConditions(), WCNSFVFluidHeatTransferPhysicsBase::addInitialConditions(), WCNSFVScalarTransportPhysicsBase::addInitialConditions(), WCNSFVFlowPhysicsBase::addInitialConditions(), WCNSFVFluidHeatTransferPhysics::addSolverVariables(), WCNSLinearFVFluidHeatTransferPhysics::addSolverVariables(), addSolverVariables(), WCNSLinearFVFlowPhysics::addSolverVariables(), WCNSFVTurbulencePhysics::addSolverVariables(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Name of the density material property used for gravity and Boussinesq terms.
Definition at line 164 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addMomentumBoussinesqKernels(), addMomentumBoussinesqKernels(), and addMomentumGravityKernels().
|
protectedinherited |
Name of the density material property.
Definition at line 162 of file WCNSFVFlowPhysicsBase.h.
Referenced by addInletBC(), addMassKernels(), addMassTimeKernels(), addMomentumAdvectionKernels(), addMomentumFrictionKernels(), WCNSLinearFVFlowPhysics::addMomentumTimeKernels(), addMomentumTimeKernels(), addOutletBC(), WCNSLinearFVFlowPhysics::addRhieChowUserObjects(), addSolverVariables(), addWallsBC(), and WCNSFVFlowPhysicsBase::densityName().
|
protectedinherited |
Name of the dynamic viscosity material property.
Definition at line 166 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addMomentumFluxKernels(), addMomentumFrictionKernels(), addMomentumViscousDissipationKernels(), addWallsBC(), and WCNSFVFlowPhysicsBase::dynamicViscosityName().
|
protectedinherited |
Name of the porosity functor for the flow equations (if smoothed)
Definition at line 152 of file WCNSFVFlowPhysicsBase.h.
Referenced by addMassTimeKernels(), addMomentumAdvectionKernels(), addMomentumBoussinesqKernels(), addMomentumGravityKernels(), addMomentumPressureKernels(), addMomentumViscousDissipationKernels(), addOutletBC(), WCNSFVFlowPhysicsBase::addPorousMediumSpeedMaterial(), WCNSFVFlowPhysicsBase::getPorosityFunctorName(), and WCNSFVFlowPhysics().
|
protectedinherited |
Fluid temperature name.
Definition at line 159 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addMomentumBoussinesqKernels(), addMomentumBoussinesqKernels(), and WCNSFVFlowPhysicsBase::getFluidTemperatureName().
|
protectedinherited |
Direction of each flux inlet. Indexing based on the number of flux boundaries.
Definition at line 195 of file WCNSFVFlowPhysicsBase.h.
Referenced by addInletBC(), WCNSFVFlowPhysicsBase::getFluxInletDirections(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Postprocessors describing the momentum inlet for each boundary. Indexing based on the number of flux boundaries.
Definition at line 193 of file WCNSFVFlowPhysicsBase.h.
Referenced by addInletBC(), and WCNSFVFlowPhysicsBase::getFluxInletPPs().
|
private |
Subdomains where we want to have volumetric friction.
Definition at line 79 of file WCNSFVFlowPhysics.h.
Referenced by addMomentumFrictionKernels(), and WCNSFVFlowPhysics().
|
private |
The coefficients used for each item if friction type.
Definition at line 83 of file WCNSFVFlowPhysics.h.
Referenced by addMomentumFrictionKernels(), and getLinearFrictionCoefName().
|
private |
The friction correlation types used for each block.
Definition at line 81 of file WCNSFVFlowPhysics.h.
Referenced by addFVKernels(), addMomentumFrictionKernels(), getLinearFrictionCoefName(), and hasForchheimerFriction().
|
protectedinherited |
Boolean to keep track of whether the flow equations should be created.
Definition at line 140 of file WCNSFVFlowPhysicsBase.h.
Referenced by addCorrectors(), addFVKernels(), WCNSLinearFVFlowPhysics::addFVKernels(), addRhieChowUserObjects(), addSolverVariables(), WCNSLinearFVFlowPhysics::addSolverVariables(), WCNSFVFlowPhysicsBase::hasFlowEquations(), and WCNSLinearFVFlowPhysics::WCNSLinearFVFlowPhysics().
|
protectedinherited |
Hydraulic separator boundaries.
Definition at line 183 of file WCNSFVFlowPhysicsBase.h.
Referenced by addSeparatorBC(), WCNSFVFlowPhysicsBase::getHydraulicSeparators(), and WCNSLinearFVFlowPhysics::WCNSLinearFVFlowPhysics().
|
protectedinherited |
Boundaries with a flow inlet specified on them.
Definition at line 177 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysicsBase::addPostprocessors(), WCNSFVFlowPhysicsBase::getInletBoundaries(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
The momentum face interpolation method for being advected.
Definition at line 171 of file WCNSFVFlowPhysicsBase.h.
Referenced by addMomentumAdvectionKernels(), WCNSLinearFVFlowPhysics::addMomentumFluxKernels(), and WCNSFVFlowPhysicsBase::getMomentumFaceInterpolationMethod().
|
protectedinherited |
Functors describing the momentum inlet for each boundary.
Definition at line 198 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addInletBC(), addInletBC(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Momentum inlet boundary types.
Definition at line 186 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addInletBC(), addInletBC(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Momentum outlet boundary types.
Definition at line 188 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addOutletBC(), addOutletBC(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Functors describing the momentum for each wall boundary.
Definition at line 202 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addWallsBC(), addWallsBC(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Momentum wall boundary types.
Definition at line 190 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addWallsBC(), addWallsBC(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Boundaries with a flow outlet specified on them.
Definition at line 179 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysicsBase::getOutletBoundaries(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Name of the porosity functor.
Definition at line 150 of file WCNSFVFlowPhysicsBase.h.
Referenced by addInletBC(), addRhieChowUserObjects(), addSolverVariables(), WCNSFVFlowPhysicsBase::getPorosityFunctorName(), and WCNSFVFlowPhysics().
|
private |
The number of smoothing layers if that treatment is used on porosity.
Definition at line 76 of file WCNSFVFlowPhysics.h.
|
protectedinherited |
Whether to use the porous medium treatment.
Definition at line 148 of file WCNSFVFlowPhysicsBase.h.
Referenced by addInletBC(), addMassKernels(), addMassTimeKernels(), WCNSFVFlowPhysicsBase::addMaterials(), addMomentumAdvectionKernels(), addMomentumBoussinesqKernels(), addMomentumFrictionKernels(), addMomentumGravityKernels(), addMomentumPressureKernels(), addMomentumTimeKernels(), addMomentumViscousDissipationKernels(), addOutletBC(), WCNSFVFlowPhysicsBase::addPorousMediumSpeedMaterial(), addRhieChowUserObjects(), addSolverVariables(), addWallsBC(), getNumberAlgebraicGhostingLayersNeeded(), WCNSFVFlowPhysicsBase::porousMediumTreatment(), WCNSLinearFVFlowPhysics::rhieChowUOName(), WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase(), and WCNSLinearFVFlowPhysics::WCNSLinearFVFlowPhysics().
|
protectedinherited |
Functors describing the outlet pressure on each boundary.
Definition at line 200 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addOutletBC(), addOutletBC(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Pressure name.
Definition at line 157 of file WCNSFVFlowPhysicsBase.h.
Referenced by addCorrectors(), WCNSFVFlowPhysicsBase::addInitialConditions(), WCNSLinearFVFlowPhysics::addInletBC(), addInletBC(), addMassKernels(), addMassTimeKernels(), WCNSLinearFVFlowPhysics::addMomentumPressureKernels(), addMomentumPressureKernels(), WCNSLinearFVFlowPhysics::addOutletBC(), addOutletBC(), WCNSLinearFVFlowPhysics::addPressureCorrectionKernels(), addPressurePinKernel(), WCNSLinearFVFlowPhysics::addRhieChowUserObjects(), addRhieChowUserObjects(), addSeparatorBC(), addSolverVariables(), WCNSLinearFVFlowPhysics::addSolverVariables(), WCNSLinearFVFlowPhysics::addWallsBC(), addWallsBC(), and WCNSFVFlowPhysicsBase::getPressureName().
|
protectedinherited |
Name of the vector to hold pressure momentum equation contributions.
Definition at line 137 of file WCNSFVFlowPhysicsBase.h.
|
private |
Name of the user object in charge of computing the Rhie Chow coefficients.
Definition at line 86 of file WCNSFVFlowPhysics.h.
Referenced by addRhieChowUserObjects(), and rhieChowUOName().
|
protectedinherited |
Whether we are solving for the total or dynamic pressure.
Definition at line 145 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addMomentumGravityKernels(), addMomentumGravityKernels(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Can be set to a coupled turbulence physics.
Definition at line 174 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysicsBase::actOnAdditionalTasks(), and WCNSFVFlowPhysicsBase::hasTurbulencePhysics().
|
protectedinherited |
The velocity face interpolation method for advecting other quantities.
Definition at line 169 of file WCNSFVFlowPhysicsBase.h.
Referenced by addMassKernels(), addMomentumAdvectionKernels(), and WCNSFVFlowPhysicsBase::getVelocityFaceInterpolationMethod().
|
protectedinherited |
Velocity names.
Definition at line 155 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysicsBase::addInitialConditions(), WCNSLinearFVFlowPhysics::addInletBC(), addInletBC(), addMomentumAdvectionKernels(), WCNSLinearFVFlowPhysics::addMomentumBoussinesqKernels(), addMomentumBoussinesqKernels(), WCNSLinearFVFlowPhysics::addMomentumFluxKernels(), addMomentumFrictionKernels(), WCNSLinearFVFlowPhysics::addMomentumGravityKernels(), addMomentumGravityKernels(), WCNSLinearFVFlowPhysics::addMomentumPressureKernels(), addMomentumPressureKernels(), WCNSLinearFVFlowPhysics::addMomentumTimeKernels(), addMomentumTimeKernels(), addMomentumViscousDissipationKernels(), WCNSFVFlowPhysicsBase::addNonPorousMediumSpeedMaterial(), WCNSLinearFVFlowPhysics::addOutletBC(), addOutletBC(), WCNSFVFlowPhysicsBase::addPorousMediumSpeedMaterial(), WCNSLinearFVFlowPhysics::addRhieChowUserObjects(), addRhieChowUserObjects(), addSeparatorBC(), addSolverVariables(), WCNSLinearFVFlowPhysics::addSolverVariables(), WCNSLinearFVFlowPhysics::addWallsBC(), addWallsBC(), WCNSFVFlowPhysicsBase::getVelocityNames(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Boundaries which define a wall (slip/noslip/etc.)
Definition at line 181 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addWallsBC(), WCNSFVFlowPhysicsBase::getWallBoundaries(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().