Base class for Physics which create the Navier Stokes flow equations. More...
#include <WCNSFVFlowPhysicsBase.h>
Public Types | |
| typedef DataFileName | DataFileParameterType |
Public Member Functions | |
| WCNSFVFlowPhysicsBase (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... | |
| NS::MomentumInletTypes | inletBoundaryType (const BoundaryName &boundary_name) const |
| Get the type of the inlet BC. 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 MooseFunctorName | getLinearFrictionCoefName () const =0 |
| Get the name of the linear friction coefficient. Returns an empty string if no friction. More... | |
| virtual UserObjectName | rhieChowUOName () const =0 |
| Return the name of the Rhie Chow user object. More... | |
| unsigned short | getNumberAlgebraicGhostingLayersNeeded () const override |
| Return the number of algebraic ghosting layers needed. 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 |
| const std::string & | name () const |
| std::string | typeAndName () const |
| MooseObjectParameterName | uniqueParameterName (const std::string ¶meter_name) const |
| MooseObjectName | uniqueName () const |
| const InputParameters & | parameters () const |
| const hit::Node * | getHitNode () const |
| bool | hasBase () const |
| const std::string & | getBase () 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 &name) const |
| void | connectControllableParams (const std::string ¶meter, const std::string &object_type, const std::string &object_name, const std::string &object_parameter) const |
| void | paramError (const std::string ¶m, Args... args) const |
| void | paramWarning (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 |
| std::string | messagePrefix (const bool hit_prefix=true) const |
| std::string | errorPrefix (const std::string &) const |
| void | mooseError (Args &&... args) const |
| void | mooseDocumentedError (const std::string &repo_name, const unsigned int issue_num, Args &&... args) const |
| void | mooseErrorNonPrefixed (Args &&... args) const |
| void | mooseWarning (Args &&... args) const |
| void | mooseWarning (Args &&... args) const |
| void | mooseWarningNonPrefixed (Args &&... args) const |
| void | mooseWarningNonPrefixed (Args &&... args) const |
| void | mooseDeprecated (Args &&... args) const |
| void | mooseDeprecated (Args &&... args) const |
| void | mooseInfo (Args &&... args) const |
| void | callMooseError (std::string msg, const bool with_prefix, const hit::Node *node=nullptr) 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 () |
| static void | callMooseError (MooseApp *const app, const InputParameters ¶ms, std::string msg, const bool with_prefix, const hit::Node *node) |
Public Attributes | |
| usingCombinedWarningSolutionWarnings | |
| const ConsoleStream | _console |
Static Public Attributes | |
| static const std::string | unique_action_name_param |
| static const std::string | type_param |
| static const std::string | name_param |
| static const std::string | unique_name_param |
| static const std::string | app_param |
| static const std::string | moose_base_param |
| static const std::string | kokkos_object_param |
| static constexpr auto | SYSTEM |
| static constexpr auto | NAME |
Protected Member Functions | |
| virtual void | initializePhysicsAdditional () override |
| virtual void | actOnAdditionalTasks () override |
| virtual void | addSolverVariables () override=0 |
| virtual void | addInitialConditions () override |
| virtual void | addFVKernels () override=0 |
| virtual void | addFVBCs () override |
| virtual void | addMaterials () override |
| virtual void | addUserObjects () override=0 |
| virtual void | addPostprocessors () override |
| virtual void | addMomentumTimeKernels ()=0 |
| Functions adding kernels for the flow momentum equations If the material properties are not constant, these can be used for weakly-compressible simulations (except the Boussinesq kernel) as well. More... | |
| virtual void | addMomentumPressureKernels ()=0 |
| virtual void | addMomentumGravityKernels ()=0 |
| virtual void | addMomentumFrictionKernels ()=0 |
| virtual void | addMomentumBoussinesqKernels ()=0 |
| virtual void | addInletBC ()=0 |
| Functions adding boundary conditions for the flow simulation. More... | |
| virtual void | addOutletBC ()=0 |
| virtual void | addWallsBC ()=0 |
| virtual void | addSeparatorBC ()=0 |
| virtual bool | hasForchheimerFriction () const =0 |
| Return whether a Forchheimer friction model is in use. More... | |
| 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... | |
| void | addFluidPropertiesFunctorMaterial () |
| Function which adds the general functor fluid properties functor material to define fluid functor material property. More... | |
| virtual void | addRhieChowUserObjects ()=0 |
| Function which adds the RhieChow interpolator user objects for weakly and incompressible formulations. 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 | flagInvalidSolutionInternal (const InvalidSolutionID invalid_solution_id) const |
| InvalidSolutionID | registerInvalidSolutionInternal (const std::string &message, const bool warning) 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 |
| Factory & | _factory |
| ActionFactory & | _action_factory |
| const std::string & | _type |
| const std::string & | _name |
| const InputParameters & | _pars |
| MooseApp & | _pg_moose_app |
| const std::string | _prefix |
| const Parallel::Communicator & | _communicator |
Base class for Physics which create the Navier Stokes flow equations.
Definition at line 29 of file WCNSFVFlowPhysicsBase.h.
| WCNSFVFlowPhysicsBase::WCNSFVFlowPhysicsBase | ( | const InputParameters & | parameters | ) |
Definition at line 101 of file WCNSFVFlowPhysicsBase.C.
|
overrideprotectedvirtual |
Reimplemented from PhysicsBase.
Definition at line 255 of file WCNSFVFlowPhysicsBase.C.
|
protected |
Function which adds the general functor fluid properties functor material to define fluid functor material property.
Definition at line 317 of file WCNSFVFlowPhysicsBase.C.
Referenced by addMaterials().
|
overrideprotectedvirtual |
Reimplemented from PhysicsBase.
Definition at line 263 of file WCNSFVFlowPhysicsBase.C.
|
overrideprotectedpure virtual |
Reimplemented from PhysicsBase.
Implemented in WCNSLinearFVFlowPhysics, and WCNSFVFlowPhysics.
|
overrideprotectedvirtual |
Reimplemented from PhysicsBase.
Definition at line 362 of file WCNSFVFlowPhysicsBase.C.
|
protectedpure virtual |
Functions adding boundary conditions for the flow simulation.
These are used for weakly-compressible simulations as well.
Implemented in WCNSFVFlowPhysics, and WCNSLinearFVFlowPhysics.
Referenced by addFVBCs().
|
overrideprotectedvirtual |
Reimplemented from PhysicsBase.
Definition at line 272 of file WCNSFVFlowPhysicsBase.C.
|
protectedpure virtual |
Implemented in WCNSFVFlowPhysics, and WCNSLinearFVFlowPhysics.
|
protectedpure virtual |
Implemented in WCNSFVFlowPhysics, and WCNSLinearFVFlowPhysics.
|
protectedpure virtual |
Implemented in WCNSFVFlowPhysics, and WCNSLinearFVFlowPhysics.
|
protectedpure virtual |
Implemented in WCNSFVFlowPhysics, and WCNSLinearFVFlowPhysics.
|
protectedpure virtual |
Functions adding kernels for the flow momentum equations If the material properties are not constant, these can be used for weakly-compressible simulations (except the Boussinesq kernel) as well.
Implemented in WCNSFVFlowPhysics, and WCNSLinearFVFlowPhysics.
|
protected |
Add material to define the local speed with no porous medium treatment.
Definition at line 302 of file WCNSFVFlowPhysicsBase.C.
Referenced by addMaterials().
|
protectedpure virtual |
Implemented in WCNSFVFlowPhysics, and WCNSLinearFVFlowPhysics.
Referenced by addFVBCs().
|
protected |
Add material to define the local speed in porous medium flows.
Definition at line 284 of file WCNSFVFlowPhysicsBase.C.
Referenced by addMaterials().
|
overrideprotectedvirtual |
Reimplemented from PhysicsBase.
Definition at line 422 of file WCNSFVFlowPhysicsBase.C.
|
protectedpure virtual |
Function which adds the RhieChow interpolator user objects for weakly and incompressible formulations.
Implemented in WCNSFVFlowPhysics, and WCNSLinearFVFlowPhysics.
|
protectedpure virtual |
Implemented in WCNSFVFlowPhysics, and WCNSLinearFVFlowPhysics.
Referenced by addFVBCs().
|
overrideprotectedpure virtual |
Reimplemented from PhysicsBase.
Implemented in WCNSLinearFVFlowPhysics, and WCNSFVFlowPhysics.
|
overrideprotectedpure virtual |
Reimplemented from PhysicsBase.
Implemented in WCNSLinearFVFlowPhysics, and WCNSFVFlowPhysics.
|
protectedpure virtual |
Implemented in WCNSFVFlowPhysics, and WCNSLinearFVFlowPhysics.
Referenced by addFVBCs().
|
inline |
Return the compressibility of the flow equations selected.
Definition at line 47 of file WCNSFVFlowPhysicsBase.h.
|
inline |
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().
|
inline |
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.
|
protected |
Find the turbulence physics.
Definition at line 468 of file WCNSFVFlowPhysicsBase.C.
Referenced by actOnAdditionalTasks().
|
protected |
Convenience routine to be able to retrieve the actual variable names from their default names.
Definition at line 442 of file WCNSFVFlowPhysicsBase.C.
|
inline |
Definition at line 42 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVTurbulencePhysics::addFluidEnergyTurbulenceKernels(), and getFlowVariableName().
|
inline |
Get the inlet direction if using a flux inlet.
Definition at line 83 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), and WCNSFVScalarTransportPhysics::addScalarInletBC().
|
inline |
Get the inlet flux postprocessor if using a flux inlet.
Definition at line 85 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), and WCNSFVScalarTransportPhysics::addScalarInletBC().
|
inline |
Get the hydraulic separator boundaries.
Definition at line 75 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergySeparatorBC().
|
inline |
Get the inlet boundaries.
Definition at line 69 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSLinearFVScalarTransportPhysics::addScalarInletBC(), and WCNSFVScalarTransportPhysics::addScalarInletBC().
|
pure virtual |
Get the name of the linear friction coefficient. Returns an empty string if no friction.
Implemented in WCNSLinearFVFlowPhysics, and WCNSFVFlowPhysics.
Referenced by WCNSLinearFVTwoPhaseMixturePhysics::addMaterials(), and WCNSFVTwoPhaseMixturePhysics::addMaterials().
|
inline |
Get the face interpolation method for momentum in the advection term.
Definition at line 59 of file WCNSFVFlowPhysicsBase.h.
|
inline |
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().
|
overridevirtual |
Return the number of algebraic ghosting layers needed.
Implements NavierStokesPhysicsBase.
Reimplemented in WCNSLinearFVFlowPhysics.
Definition at line 415 of file WCNSFVFlowPhysicsBase.C.
Referenced by WCNSFVFlowPhysics::getNumberAlgebraicGhostingLayersNeeded(), WCNSFVTurbulencePhysics::getNumberAlgebraicGhostingLayersNeeded(), WCNSFVFluidHeatTransferPhysicsBase::getNumberAlgebraicGhostingLayersNeeded(), and WCNSFVScalarTransportPhysicsBase::getNumberAlgebraicGhostingLayersNeeded().
|
inline |
Get the outlet boundaries.
Definition at line 71 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFluidHeatTransferPhysics::addEnergyOutletBC(), and WCNSLinearFVScalarTransportPhysics::addScalarOutletBC().
| MooseFunctorName WCNSFVFlowPhysicsBase::getPorosityFunctorName | ( | const bool | smoothed | ) | const |
Definition at line 459 of file WCNSFVFlowPhysicsBase.C.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyHeatConductionKernels(), WCNSFVFluidHeatTransferPhysics::addEnergyTimeKernels(), WCNSFVScalarTransportPhysics::addScalarAdvectionKernels(), and WCNSFVCoupledAdvectionPhysicsHelper::getPorosityFunctorName().
|
inline |
Definition at line 41 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyInletBC(), WCNSFVFluidHeatTransferPhysics::addEnergyWallBC(), WCNSFVFluidHeatTransferPhysicsBase::addInitialConditions(), WCNSFVFluidHeatTransferPhysics::addMaterials(), WCNSLinearFVFluidHeatTransferPhysics::addMaterials(), and getFlowVariableName().
|
inline |
Get the face interpolation method for velocity.
Definition at line 57 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVTwoPhaseMixturePhysics::addAdvectionSlipTerm().
|
inline |
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 getFlowVariableName().
|
inline |
Get the wall boundaries.
Definition at line 73 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFluidHeatTransferPhysics::addEnergyWallBC(), and WCNSFVFluidHeatTransferPhysics::addEnergyWallBC().
|
inline |
Return the gravity vector.
Definition at line 51 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVTwoPhaseMixturePhysics::addMaterials(), WCNSFVTwoPhaseMixturePhysics::addMaterials(), and WCNSLinearFVTwoPhaseMixturePhysics::checkIntegrity().
|
inline |
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().
|
protectedpure virtual |
Return whether a Forchheimer friction model is in use.
Implemented in WCNSFVFlowPhysics, and WCNSLinearFVFlowPhysics.
Referenced by addMaterials().
|
inlineprotected |
Whether a turbulence Physics has been coupled in, to know which viscosity to pick on symmetry boundary conditions.
Definition at line 139 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addWallsBC().
|
overrideprotectedvirtual |
Reimplemented from PhysicsBase.
Reimplemented in WCNSLinearFVFlowPhysics.
Definition at line 249 of file WCNSFVFlowPhysicsBase.C.
Referenced by WCNSLinearFVFlowPhysics::initializePhysicsAdditional().
|
inline |
Get the type of the inlet BC.
Definition at line 77 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFluidHeatTransferPhysics::addEnergyInletBC().
|
inline |
Return whether a porous medium treatment is applied.
Definition at line 49 of file WCNSFVFlowPhysicsBase.h.
|
pure virtual |
Return the name of the Rhie Chow user object.
Implemented in WCNSLinearFVFlowPhysics, and WCNSFVFlowPhysics.
Referenced by WCNSFVTwoPhaseMixturePhysics::addAdvectionSlipTerm(), WCNSFVFluidHeatTransferPhysics::addEnergyAdvectionKernels(), WCNSLinearFVFluidHeatTransferPhysics::addEnergyAdvectionKernels(), WCNSFVTurbulencePhysics::addFlowTurbulenceKernels(), WCNSFVTurbulencePhysics::addKEpsilonAdvection(), WCNSLinearFVTwoPhaseMixturePhysics::addPhaseDriftFluxTerm(), WCNSFVTwoPhaseMixturePhysics::addPhaseDriftFluxTerm(), WCNSFVScalarTransportPhysics::addScalarAdvectionKernels(), and WCNSLinearFVScalarTransportPhysics::addScalarAdvectionKernels().
|
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 18 of file WCNSFVFlowPhysicsBase.C.
Referenced by WCNSFVFlowPhysics::validParams(), and WCNSLinearFVFlowPhysics::validParams().
|
protected |
Compressibility type, can be compressible, incompressible or weakly-compressible.
Definition at line 157 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addFVKernels(), WCNSLinearFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumTimeKernels(), compressibility(), and 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(), addInitialConditions(), WCNSLinearFVFluidHeatTransferPhysics::addSolverVariables(), WCNSFVFluidHeatTransferPhysics::addSolverVariables(), WCNSFVFlowPhysics::addSolverVariables(), WCNSLinearFVFlowPhysics::addSolverVariables(), WCNSFVTurbulencePhysics::addSolverVariables(), and WCNSFVFlowPhysicsBase().
|
protected |
Name of the density material property used for gravity and Boussinesq terms.
Definition at line 178 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addFunctorMaterials(), WCNSLinearFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), and WCNSFVFlowPhysics::addMomentumGravityKernels().
|
protected |
Name of the density material property.
Definition at line 176 of file WCNSFVFlowPhysicsBase.h.
Referenced by addFluidPropertiesFunctorMaterial(), WCNSFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addMassKernels(), WCNSFVFlowPhysics::addMassTimeKernels(), WCNSFVFlowPhysics::addMomentumAdvectionKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), WCNSLinearFVFlowPhysics::addMomentumTimeKernels(), WCNSFVFlowPhysics::addMomentumTimeKernels(), WCNSFVFlowPhysics::addOutletBC(), WCNSLinearFVFlowPhysics::addRhieChowUserObjects(), WCNSFVFlowPhysics::addSolverVariables(), WCNSFVFlowPhysics::addWallsBC(), and densityName().
|
protected |
Name of the dynamic viscosity material property.
Definition at line 180 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addMomentumFluxKernels(), WCNSLinearFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumViscousDissipationKernels(), WCNSFVFlowPhysics::addWallsBC(), and dynamicViscosityName().
|
protected |
Name of the porosity functor for the flow equations (if smoothed)
Definition at line 166 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addMassTimeKernels(), WCNSFVFlowPhysics::addMomentumAdvectionKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumGravityKernels(), WCNSFVFlowPhysics::addMomentumPressureKernels(), WCNSFVFlowPhysics::addMomentumViscousDissipationKernels(), WCNSFVFlowPhysics::addOutletBC(), addPorousMediumSpeedMaterial(), getPorosityFunctorName(), and WCNSFVFlowPhysics::WCNSFVFlowPhysics().
|
protected |
Fluid temperature name.
Definition at line 173 of file WCNSFVFlowPhysicsBase.h.
Referenced by addFluidPropertiesFunctorMaterial(), WCNSLinearFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), and getFluidTemperatureName().
|
protected |
Direction of each flux inlet. Indexing based on the number of flux boundaries.
Definition at line 218 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addInletBC(), getFluxInletDirections(), and WCNSFVFlowPhysicsBase().
|
protected |
Postprocessors describing the momentum inlet for each boundary. Indexing based on the number of flux boundaries.
Definition at line 216 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addInletBC(), and getFluxInletPPs().
|
protected |
Subdomains where we want to have volumetric friction.
Definition at line 193 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), and WCNSFVFlowPhysicsBase().
|
protected |
The coefficients used for each item if friction type.
Definition at line 197 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), and WCNSFVFlowPhysics::getLinearFrictionCoefName().
|
protected |
The friction correlation types used for each block.
Definition at line 195 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addFVKernels(), WCNSLinearFVFlowPhysics::addFVKernels(), WCNSLinearFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::getLinearFrictionCoefName(), and WCNSFVFlowPhysics::hasForchheimerFriction().
|
protected |
Boolean to keep track of whether the flow equations should be created.
Definition at line 154 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addCorrectors(), WCNSFVFlowPhysics::addFVKernels(), WCNSLinearFVFlowPhysics::addFVKernels(), WCNSFVFlowPhysics::addRhieChowUserObjects(), WCNSFVFlowPhysics::addSolverVariables(), WCNSLinearFVFlowPhysics::addSolverVariables(), hasFlowEquations(), and WCNSLinearFVFlowPhysics::WCNSLinearFVFlowPhysics().
|
protected |
Hydraulic separator boundaries.
Definition at line 206 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addSeparatorBC(), getHydraulicSeparators(), and WCNSLinearFVFlowPhysics::WCNSLinearFVFlowPhysics().
|
protected |
Boundaries with a flow inlet specified on them.
Definition at line 200 of file WCNSFVFlowPhysicsBase.h.
Referenced by addPostprocessors(), getInletBoundaries(), and WCNSFVFlowPhysicsBase().
|
protected |
The momentum face interpolation method for being advected.
Definition at line 185 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addMomentumAdvectionKernels(), WCNSLinearFVFlowPhysics::addMomentumFluxKernels(), and getMomentumAdvectionFaceInterpolationMethod().
|
protected |
The momentum face interpolation method for stress terms.
Definition at line 187 of file WCNSFVFlowPhysicsBase.h.
Referenced by getMomentumFaceInterpolationMethod().
|
protected |
Functors describing the momentum inlet for each boundary.
Definition at line 221 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addInletBC(), and WCNSFVFlowPhysicsBase().
|
protected |
Momentum inlet boundary types.
Definition at line 209 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addInletBC(), inletBoundaryType(), and WCNSFVFlowPhysicsBase().
|
protected |
Momentum outlet boundary types.
Definition at line 211 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addOutletBC(), WCNSFVFlowPhysics::addOutletBC(), and WCNSFVFlowPhysicsBase().
|
protected |
Functors describing the momentum for each wall boundary.
Definition at line 225 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addWallsBC(), WCNSFVFlowPhysics::addWallsBC(), and WCNSFVFlowPhysicsBase().
|
protected |
Momentum wall boundary types.
Definition at line 213 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addWallsBC(), WCNSFVFlowPhysics::addWallsBC(), and WCNSFVFlowPhysicsBase().
|
protected |
Boundaries with a flow outlet specified on them.
Definition at line 202 of file WCNSFVFlowPhysicsBase.h.
Referenced by getOutletBoundaries(), and WCNSFVFlowPhysicsBase().
|
protected |
Name of the porosity functor.
Definition at line 164 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addRhieChowUserObjects(), WCNSFVFlowPhysics::addSolverVariables(), getPorosityFunctorName(), and WCNSFVFlowPhysics::WCNSFVFlowPhysics().
|
protected |
Whether to use the porous medium treatment.
Definition at line 162 of file WCNSFVFlowPhysicsBase.h.
Referenced by addFluidPropertiesFunctorMaterial(), WCNSFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addMassKernels(), WCNSFVFlowPhysics::addMassTimeKernels(), addMaterials(), WCNSFVFlowPhysics::addMomentumAdvectionKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumGravityKernels(), WCNSFVFlowPhysics::addMomentumPressureKernels(), WCNSFVFlowPhysics::addMomentumTimeKernels(), WCNSFVFlowPhysics::addMomentumViscousDissipationKernels(), WCNSFVFlowPhysics::addOutletBC(), addPorousMediumSpeedMaterial(), WCNSFVFlowPhysics::addRhieChowUserObjects(), WCNSFVFlowPhysics::addSolverVariables(), WCNSFVFlowPhysics::addWallsBC(), WCNSFVFlowPhysics::getNumberAlgebraicGhostingLayersNeeded(), porousMediumTreatment(), WCNSLinearFVFlowPhysics::rhieChowUOName(), WCNSFVFlowPhysicsBase(), and WCNSLinearFVFlowPhysics::WCNSLinearFVFlowPhysics().
|
protected |
Functors describing the outlet pressure on each boundary.
Definition at line 223 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addOutletBC(), WCNSFVFlowPhysics::addOutletBC(), and WCNSFVFlowPhysicsBase().
|
protected |
Pressure name.
Definition at line 171 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addCorrectors(), addFluidPropertiesFunctorMaterial(), WCNSFVFlowPhysics::addFVKernels(), addInitialConditions(), WCNSLinearFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addMassKernels(), WCNSFVFlowPhysics::addMassTimeKernels(), WCNSLinearFVFlowPhysics::addMomentumPressureKernels(), WCNSFVFlowPhysics::addMomentumPressureKernels(), WCNSLinearFVFlowPhysics::addOutletBC(), WCNSFVFlowPhysics::addOutletBC(), WCNSLinearFVFlowPhysics::addPressureCorrectionKernels(), WCNSFVFlowPhysics::addPressurePinKernel(), WCNSLinearFVFlowPhysics::addRhieChowUserObjects(), WCNSFVFlowPhysics::addRhieChowUserObjects(), WCNSFVFlowPhysics::addSeparatorBC(), WCNSFVFlowPhysics::addSolverVariables(), WCNSLinearFVFlowPhysics::addSolverVariables(), WCNSLinearFVFlowPhysics::addWallsBC(), WCNSFVFlowPhysics::addWallsBC(), and getPressureName().
|
protected |
Name of the vector to hold pressure momentum equation contributions.
Definition at line 151 of file WCNSFVFlowPhysicsBase.h.
|
protected |
Whether we are solving for the total or dynamic pressure.
Definition at line 159 of file WCNSFVFlowPhysicsBase.h.
Referenced by addFluidPropertiesFunctorMaterial(), WCNSLinearFVFlowPhysics::addMomentumGravityKernels(), WCNSFVFlowPhysics::addMomentumGravityKernels(), and WCNSFVFlowPhysicsBase().
|
protected |
Can be set to a coupled turbulence physics.
Definition at line 190 of file WCNSFVFlowPhysicsBase.h.
Referenced by actOnAdditionalTasks(), and hasTurbulencePhysics().
|
protected |
The velocity face interpolation method for advecting other quantities.
Definition at line 183 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSFVFlowPhysics::addMassKernels(), WCNSFVFlowPhysics::addMomentumAdvectionKernels(), and getVelocityFaceInterpolationMethod().
|
protected |
Velocity names.
Definition at line 169 of file WCNSFVFlowPhysicsBase.h.
Referenced by addInitialConditions(), WCNSLinearFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addInletBC(), WCNSFVFlowPhysics::addMomentumAdvectionKernels(), WCNSLinearFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSFVFlowPhysics::addMomentumBoussinesqKernels(), WCNSLinearFVFlowPhysics::addMomentumFluxKernels(), WCNSLinearFVFlowPhysics::addMomentumFrictionKernels(), WCNSFVFlowPhysics::addMomentumFrictionKernels(), WCNSLinearFVFlowPhysics::addMomentumGravityKernels(), WCNSFVFlowPhysics::addMomentumGravityKernels(), WCNSLinearFVFlowPhysics::addMomentumPressureKernels(), WCNSFVFlowPhysics::addMomentumPressureKernels(), WCNSLinearFVFlowPhysics::addMomentumTimeKernels(), WCNSFVFlowPhysics::addMomentumTimeKernels(), WCNSFVFlowPhysics::addMomentumViscousDissipationKernels(), addNonPorousMediumSpeedMaterial(), WCNSLinearFVFlowPhysics::addOutletBC(), WCNSFVFlowPhysics::addOutletBC(), addPorousMediumSpeedMaterial(), WCNSLinearFVFlowPhysics::addRhieChowUserObjects(), WCNSFVFlowPhysics::addRhieChowUserObjects(), WCNSFVFlowPhysics::addSeparatorBC(), WCNSFVFlowPhysics::addSolverVariables(), WCNSLinearFVFlowPhysics::addSolverVariables(), WCNSLinearFVFlowPhysics::addWallsBC(), WCNSFVFlowPhysics::addWallsBC(), getVelocityNames(), and WCNSFVFlowPhysicsBase().
|
protected |
Boundaries which define a wall (slip/noslip/etc.)
Definition at line 204 of file WCNSFVFlowPhysicsBase.h.
Referenced by WCNSLinearFVFlowPhysics::addWallsBC(), getWallBoundaries(), and WCNSFVFlowPhysicsBase().
1.8.14