Creates all the objects needed to solve the Navier-Stokes equations with the SIMPLE algorithm using the linear finite volume discretization Currently does not implement: More...
#include <WCNSLinearFVFlowPhysics.h>
Public Types | |
typedef DataFileName | DataFileParameterType |
Public Member Functions | |
WCNSLinearFVFlowPhysics (const InputParameters ¶meters) | |
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 & | getMomentumAdvectionFaceInterpolationMethod () const |
Get the face interpolation method for momentum in the advection term. More... | |
const MooseEnum & | getMomentumFaceInterpolationMethod () const |
Get the face interpolation method for momentum (mostly used in the stress terms) 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 * | queryParam (const std::string &name) 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 |
bool | allMeshBlocks (const std::set< SubdomainName > &blocks) const |
std::set< SubdomainID > | getSubdomainIDs (const std::set< SubdomainName > &blocks) const |
std::vector< std::string > | getSubdomainNamesAndIDs (const std::set< SubdomainID > &blocks) const |
void | addPetscPairsToPetscOptions (const std::vector< std::pair< MooseEnumItem, std::string >> &petsc_pair_options) |
bool | isVariableFV (const VariableName &var_name) const |
bool | isVariableScalar (const VariableName &var_name) const |
bool | shouldCreateVariable (const VariableName &var_name, const std::vector< SubdomainName > &blocks, const bool error_if_aux) |
bool | shouldCreateIC (const VariableName &var_name, const std::vector< SubdomainName > &blocks, const bool ic_is_default_ic, const bool error_if_already_defined) const |
bool | shouldCreateTimeDerivative (const VariableName &var_name, const std::vector< SubdomainName > &blocks, const bool error_if_already_defined) const |
void | reportPotentiallyMissedParameters (const std::vector< std::string > ¶m_names, const std::string &object_type) const |
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 | checkSecondParamNotSetIfFirstOneSet (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 MooseEnum | _momentum_face_interpolation |
The momentum face interpolation method for stress terms. More... | |
const WCNSFVTurbulencePhysics * | _turbulence_physics |
Can be set to a coupled turbulence physics. 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... | |
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 |
void | addPressureCorrectionKernels () |
Function adding kernels for the incompressible pressure correction equation. 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 | addMomentumFluxKernels () |
virtual void | addMomentumPressureKernels () override |
virtual void | addMomentumGravityKernels () override |
virtual void | addMomentumFrictionKernels () override |
virtual void | addMomentumBoussinesqKernels () override |
virtual void | addInletBC () override |
Functions adding boundary conditions for the flow simulation. More... | |
virtual void | addOutletBC () override |
virtual void | addWallsBC () override |
virtual void | addSeparatorBC () override |
virtual bool | hasForchheimerFriction () const override |
Return whether a Forchheimer friction model is in use. More... | |
virtual void | addRhieChowUserObjects () override |
Function which adds the RhieChow interpolator user objects for weakly and incompressible formulations. More... | |
virtual void | addFunctorMaterials () override |
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... | |
Private Attributes | |
const bool | _non_orthogonal_correction |
Whether to use the correction term for non-orthogonality. More... | |
Creates all the objects needed to solve the Navier-Stokes equations with the SIMPLE algorithm using the linear finite volume discretization Currently does not implement:
Definition at line 24 of file WCNSLinearFVFlowPhysics.h.
WCNSLinearFVFlowPhysics::WCNSLinearFVFlowPhysics | ( | const InputParameters & | parameters | ) |
Definition at line 63 of file WCNSLinearFVFlowPhysics.C.
|
overrideprotectedvirtualinherited |
Reimplemented from PhysicsBase.
Definition at line 252 of file WCNSFVFlowPhysicsBase.C.
|
overrideprivatevirtual |
Reimplemented from PhysicsBase.
Definition at line 615 of file WCNSLinearFVFlowPhysics.C.
|
overrideprotectedvirtualinherited |
Reimplemented from PhysicsBase.
Definition at line 260 of file WCNSFVFlowPhysicsBase.C.
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 162 of file WCNSLinearFVFlowPhysics.C.
|
overrideprotectedvirtualinherited |
Reimplemented from PhysicsBase.
Definition at line 310 of file WCNSFVFlowPhysicsBase.C.
|
overrideprivatevirtual |
Functions adding boundary conditions for the flow simulation.
These are used for weakly-compressible simulations as well.
Implements WCNSFVFlowPhysicsBase.
Definition at line 386 of file WCNSLinearFVFlowPhysics.C.
|
overrideprotectedvirtualinherited |
Reimplemented from PhysicsBase.
Definition at line 269 of file WCNSFVFlowPhysicsBase.C.
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 359 of file WCNSLinearFVFlowPhysics.C.
Referenced by addFVKernels().
|
private |
Definition at line 240 of file WCNSLinearFVFlowPhysics.C.
Referenced by addFVKernels().
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 285 of file WCNSLinearFVFlowPhysics.C.
Referenced by addFVKernels().
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 335 of file WCNSLinearFVFlowPhysics.C.
Referenced by addFVKernels().
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 267 of file WCNSLinearFVFlowPhysics.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 222 of file WCNSLinearFVFlowPhysics.C.
Referenced by addFVKernels().
|
protectedinherited |
Add material to define the local speed with no porous medium treatment.
Definition at line 295 of file WCNSFVFlowPhysicsBase.C.
Referenced by WCNSFVFlowPhysicsBase::addMaterials().
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 469 of file WCNSLinearFVFlowPhysics.C.
|
protectedinherited |
Add material to define the local speed in porous medium flows.
Definition at line 278 of file WCNSFVFlowPhysicsBase.C.
Referenced by WCNSFVFlowPhysicsBase::addMaterials().
|
overrideprotectedvirtualinherited |
Reimplemented from PhysicsBase.
Definition at line 370 of file WCNSFVFlowPhysicsBase.C.
|
private |
Function adding kernels for the incompressible pressure correction equation.
Definition at line 193 of file WCNSLinearFVFlowPhysics.C.
Referenced by addFVKernels().
|
overrideprivatevirtual |
Function which adds the RhieChow interpolator user objects for weakly and incompressible formulations.
Implements WCNSFVFlowPhysicsBase.
Definition at line 567 of file WCNSLinearFVFlowPhysics.C.
Referenced by addUserObjects().
|
inlineoverrideprivatevirtual |
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 102 of file WCNSLinearFVFlowPhysics.C.
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 560 of file WCNSLinearFVFlowPhysics.C.
|
overrideprivatevirtual |
Implements WCNSFVFlowPhysicsBase.
Definition at line 520 of file WCNSLinearFVFlowPhysics.C.
|
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(), WCNSFVTwoPhaseMixturePhysics::WCNSFVTwoPhaseMixturePhysics(), and WCNSLinearFVTwoPhaseMixturePhysics::WCNSLinearFVTwoPhaseMixturePhysics().
|
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 416 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 390 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 77 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 79 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), and WCNSFVScalarTransportPhysics::addScalarInletBC().
|
inlineinherited |
Get the hydraulic separator boundaries.
Definition at line 75 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergySeparatorBC().
|
inlineinherited |
Get the inlet boundaries.
Definition at line 69 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSLinearFVScalarTransportPhysics::addScalarInletBC(), and WCNSFVScalarTransportPhysics::addScalarInletBC().
|
inlineoverrideprivatevirtual |
Get the name of the linear friction coefficient. Returns an empty string if no friction.
Implements WCNSFVFlowPhysicsBase.
Definition at line 64 of file WCNSLinearFVFlowPhysics.h.
|
inlineinherited |
Get the face interpolation method for momentum in the advection term.
Definition at line 59 of file WCNSFVFlowPhysicsBase.h.
|
inlineinherited |
Get the face interpolation method for momentum (mostly used in the stress terms)
Definition at line 64 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVTwoPhaseMixturePhysics::addAdvectionSlipTerm(), and WCNSFVTurbulencePhysics::addFlowTurbulenceKernels().
|
overrideprivatevirtual |
Return the number of algebraic ghosting layers needed.
Reimplemented from WCNSFVFlowPhysicsBase.
Definition at line 648 of file WCNSLinearFVFlowPhysics.C.
|
inlineinherited |
Get the outlet boundaries.
Definition at line 71 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFluidHeatTransferPhysics::addEnergyOutletBC(), and WCNSLinearFVScalarTransportPhysics::addScalarOutletBC().
|
inherited |
Definition at line 407 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(), WCNSLinearFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTwoPhaseMixturePhysics::addMaterials(), WCNSLinearFVTwoPhaseMixturePhysics::addPhaseDriftFluxTerm(), WCNSFVTwoPhaseMixturePhysics::addPhaseDriftFluxTerm(), and WCNSFVFlowPhysicsBase::getFlowVariableName().
|
inlineinherited |
Get the wall boundaries.
Definition at line 73 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 WCNSLinearFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTwoPhaseMixturePhysics::addMaterials(), and WCNSLinearFVTwoPhaseMixturePhysics::checkIntegrity().
|
inlineinherited |
Whether the physics is actually creating the flow equations.
Definition at line 37 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVTwoPhaseMixturePhysics::addFVKernels(), WCNSFVTwoPhaseMixturePhysics::addFVKernels(), and WCNSFVTurbulencePhysics::retrieveCoupledPhysics().
|
inlineoverrideprivatevirtual |
Return whether a Forchheimer friction model is in use.
Implements WCNSFVFlowPhysicsBase.
Definition at line 59 of file WCNSLinearFVFlowPhysics.h.
|
inlineprotectedinherited |
Whether a turbulence Physics has been coupled in, to know which viscosity to pick on symmetry boundary conditions.
Definition at line 131 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addWallsBC().
|
overrideprotectedvirtual |
Reimplemented from WCNSFVFlowPhysicsBase.
Definition at line 82 of file WCNSLinearFVFlowPhysics.C.
|
inlineinherited |
Return whether a porous medium treatment is applied.
Definition at line 49 of file WCNSFVFlowPhysicsBase.h.
|
overrideprivatevirtual |
Return the name of the Rhie Chow user object.
Implements WCNSFVFlowPhysicsBase.
Definition at line 641 of file WCNSLinearFVFlowPhysics.C.
Referenced by addMomentumFluxKernels(), and addRhieChowUserObjects().
|
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 25 of file WCNSLinearFVFlowPhysics.C.
|
protectedinherited |
Compressibility type, can be compressible, incompressible or weakly-compressible.
Definition at line 149 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addFVKernels(), addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::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(), WCNSFVFlowPhysics::addSolverVariables(), addSolverVariables(), WCNSFVTurbulencePhysics::addSolverVariables(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Name of the density material property used for gravity and Boussinesq terms.
Definition at line 170 of file WCNSFVFlowPhysicsBase.h.
Referenced by addFunctorMaterials(), addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), and WCNSFVFlowPhysics::addMomentumGravityKernels().
|
protectedinherited |
Name of the density material property.
Definition at line 168 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addMassKernels(), WCNSFVFlowPhysics::addMassTimeKernels(), WCNSFVFlowPhysics::addMomentumAdvectionKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), addMomentumTimeKernels(), WCNSFVFlowPhysics::addMomentumTimeKernels(), WCNSFVFlowPhysics::addOutletBC(), addRhieChowUserObjects(), WCNSFVFlowPhysics::addSolverVariables(), WCNSFVFlowPhysics::addWallsBC(), and WCNSFVFlowPhysicsBase::densityName().
|
protectedinherited |
Name of the dynamic viscosity material property.
Definition at line 172 of file WCNSFVFlowPhysicsBase.h.
Referenced by addMomentumFluxKernels(), addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumViscousDissipationKernels(), WCNSFVFlowPhysics::addWallsBC(), and WCNSFVFlowPhysicsBase::dynamicViscosityName().
|
protectedinherited |
Name of the porosity functor for the flow equations (if smoothed)
Definition at line 158 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addMassTimeKernels(), WCNSFVFlowPhysics::addMomentumAdvectionKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumGravityKernels(), WCNSFVFlowPhysics::addMomentumPressureKernels(), WCNSFVFlowPhysics::addMomentumViscousDissipationKernels(), WCNSFVFlowPhysics::addOutletBC(), WCNSFVFlowPhysicsBase::addPorousMediumSpeedMaterial(), WCNSFVFlowPhysicsBase::getPorosityFunctorName(), and WCNSFVFlowPhysics::WCNSFVFlowPhysics().
|
protectedinherited |
Fluid temperature name.
Definition at line 165 of file WCNSFVFlowPhysicsBase.h.
Referenced by addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), and WCNSFVFlowPhysicsBase::getFluidTemperatureName().
|
protectedinherited |
Direction of each flux inlet. Indexing based on the number of flux boundaries.
Definition at line 210 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::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 208 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addInletBC(), and WCNSFVFlowPhysicsBase::getFluxInletPPs().
|
protectedinherited |
Subdomains where we want to have volumetric friction.
Definition at line 185 of file WCNSFVFlowPhysicsBase.h.
Referenced by addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
The coefficients used for each item if friction type.
Definition at line 189 of file WCNSFVFlowPhysicsBase.h.
Referenced by addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), and WCNSFVFlowPhysics::getLinearFrictionCoefName().
|
protectedinherited |
The friction correlation types used for each block.
Definition at line 187 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addFVKernels(), addFVKernels(), addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::getLinearFrictionCoefName(), and WCNSFVFlowPhysics::hasForchheimerFriction().
|
protectedinherited |
Boolean to keep track of whether the flow equations should be created.
Definition at line 146 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addCorrectors(), WCNSFVFlowPhysics::addFVKernels(), addFVKernels(), WCNSFVFlowPhysics::addRhieChowUserObjects(), WCNSFVFlowPhysics::addSolverVariables(), addSolverVariables(), WCNSFVFlowPhysicsBase::hasFlowEquations(), and WCNSLinearFVFlowPhysics().
|
protectedinherited |
Hydraulic separator boundaries.
Definition at line 198 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addSeparatorBC(), WCNSFVFlowPhysicsBase::getHydraulicSeparators(), and WCNSLinearFVFlowPhysics().
|
protectedinherited |
Boundaries with a flow inlet specified on them.
Definition at line 192 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 177 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addMomentumAdvectionKernels(), addMomentumFluxKernels(), and WCNSFVFlowPhysicsBase::getMomentumAdvectionFaceInterpolationMethod().
|
protectedinherited |
The momentum face interpolation method for stress terms.
Definition at line 179 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysicsBase::getMomentumFaceInterpolationMethod().
|
protectedinherited |
Functors describing the momentum inlet for each boundary.
Definition at line 213 of file WCNSFVFlowPhysicsBase.h.
Referenced by addInletBC(), WCNSFVFlowPhysics::addInletBC(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Momentum inlet boundary types.
Definition at line 201 of file WCNSFVFlowPhysicsBase.h.
Referenced by addInletBC(), WCNSFVFlowPhysics::addInletBC(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Momentum outlet boundary types.
Definition at line 203 of file WCNSFVFlowPhysicsBase.h.
Referenced by addOutletBC(), WCNSFVFlowPhysics::addOutletBC(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Functors describing the momentum for each wall boundary.
Definition at line 217 of file WCNSFVFlowPhysicsBase.h.
Referenced by addWallsBC(), WCNSFVFlowPhysics::addWallsBC(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Momentum wall boundary types.
Definition at line 205 of file WCNSFVFlowPhysicsBase.h.
Referenced by addWallsBC(), WCNSFVFlowPhysics::addWallsBC(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
private |
Whether to use the correction term for non-orthogonality.
Definition at line 74 of file WCNSLinearFVFlowPhysics.h.
Referenced by addMomentumFluxKernels(), and addPressureCorrectionKernels().
|
protectedinherited |
Boundaries with a flow outlet specified on them.
Definition at line 194 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysicsBase::getOutletBoundaries(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Name of the porosity functor.
Definition at line 156 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addRhieChowUserObjects(), WCNSFVFlowPhysics::addSolverVariables(), WCNSFVFlowPhysicsBase::getPorosityFunctorName(), and WCNSFVFlowPhysics::WCNSFVFlowPhysics().
|
protectedinherited |
Whether to use the porous medium treatment.
Definition at line 154 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addMassKernels(), WCNSFVFlowPhysics::addMassTimeKernels(), WCNSFVFlowPhysicsBase::addMaterials(), WCNSFVFlowPhysics::addMomentumAdvectionKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumGravityKernels(), WCNSFVFlowPhysics::addMomentumPressureKernels(), WCNSFVFlowPhysics::addMomentumTimeKernels(), WCNSFVFlowPhysics::addMomentumViscousDissipationKernels(), WCNSFVFlowPhysics::addOutletBC(), WCNSFVFlowPhysicsBase::addPorousMediumSpeedMaterial(), WCNSFVFlowPhysics::addRhieChowUserObjects(), WCNSFVFlowPhysics::addSolverVariables(), WCNSFVFlowPhysics::addWallsBC(), WCNSFVFlowPhysics::getNumberAlgebraicGhostingLayersNeeded(), WCNSFVFlowPhysicsBase::porousMediumTreatment(), rhieChowUOName(), WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase(), and WCNSLinearFVFlowPhysics().
|
protectedinherited |
Functors describing the outlet pressure on each boundary.
Definition at line 215 of file WCNSFVFlowPhysicsBase.h.
Referenced by addOutletBC(), WCNSFVFlowPhysics::addOutletBC(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Pressure name.
Definition at line 163 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addCorrectors(), WCNSFVFlowPhysics::addFVKernels(), WCNSFVFlowPhysicsBase::addInitialConditions(), addInletBC(), WCNSFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addMassKernels(), WCNSFVFlowPhysics::addMassTimeKernels(), addMomentumPressureKernels(), WCNSFVFlowPhysics::addMomentumPressureKernels(), addOutletBC(), WCNSFVFlowPhysics::addOutletBC(), addPressureCorrectionKernels(), WCNSFVFlowPhysics::addPressurePinKernel(), addRhieChowUserObjects(), WCNSFVFlowPhysics::addRhieChowUserObjects(), WCNSFVFlowPhysics::addSeparatorBC(), WCNSFVFlowPhysics::addSolverVariables(), addSolverVariables(), addWallsBC(), WCNSFVFlowPhysics::addWallsBC(), and WCNSFVFlowPhysicsBase::getPressureName().
|
protectedinherited |
Name of the vector to hold pressure momentum equation contributions.
Definition at line 143 of file WCNSFVFlowPhysicsBase.h.
|
protectedinherited |
Whether we are solving for the total or dynamic pressure.
Definition at line 151 of file WCNSFVFlowPhysicsBase.h.
Referenced by addMomentumGravityKernels(), WCNSFVFlowPhysics::addMomentumGravityKernels(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Can be set to a coupled turbulence physics.
Definition at line 182 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysicsBase::actOnAdditionalTasks(), and WCNSFVFlowPhysicsBase::hasTurbulencePhysics().
|
protectedinherited |
The velocity face interpolation method for advecting other quantities.
Definition at line 175 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addMassKernels(), WCNSFVFlowPhysics::addMomentumAdvectionKernels(), and WCNSFVFlowPhysicsBase::getVelocityFaceInterpolationMethod().
|
protectedinherited |
Velocity names.
Definition at line 161 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysicsBase::addInitialConditions(), addInletBC(), WCNSFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addMomentumAdvectionKernels(), addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), addMomentumFluxKernels(), addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), addMomentumGravityKernels(), WCNSFVFlowPhysics::addMomentumGravityKernels(), addMomentumPressureKernels(), WCNSFVFlowPhysics::addMomentumPressureKernels(), addMomentumTimeKernels(), WCNSFVFlowPhysics::addMomentumTimeKernels(), WCNSFVFlowPhysics::addMomentumViscousDissipationKernels(), WCNSFVFlowPhysicsBase::addNonPorousMediumSpeedMaterial(), addOutletBC(), WCNSFVFlowPhysics::addOutletBC(), WCNSFVFlowPhysicsBase::addPorousMediumSpeedMaterial(), addRhieChowUserObjects(), WCNSFVFlowPhysics::addRhieChowUserObjects(), WCNSFVFlowPhysics::addSeparatorBC(), WCNSFVFlowPhysics::addSolverVariables(), addSolverVariables(), addWallsBC(), WCNSFVFlowPhysics::addWallsBC(), WCNSFVFlowPhysicsBase::getVelocityNames(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().
|
protectedinherited |
Boundaries which define a wall (slip/noslip/etc.)
Definition at line 196 of file WCNSFVFlowPhysicsBase.h.
Referenced by addWallsBC(), WCNSFVFlowPhysicsBase::getWallBoundaries(), and WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase().