Applies a wall function to the turbulent viscosity field. More...
#include <INSFVTurbulentViscosityWallFunction.h>
Public Types | |
| enum | TEST_TYPE |
| enum | ResidualTagType { ResidualTagType::NonReference, ResidualTagType::Reference } |
| typedef DataFileName | DataFileParameterType |
Public Member Functions | |
| INSFVTurbulentViscosityWallFunction (const InputParameters ¶meters) | |
| ADReal | boundaryValue (const FaceInfo &fi, const Moose::StateArg &state) const override |
| const SubProblem & | subProblem () const |
| const MooseVariableFV< Real > & | variable () const |
| bool | hasFaceSide (const FaceInfo &fi, bool fi_elem_side) const override |
| virtual bool | enabled () const |
| std::shared_ptr< MooseObject > | getSharedPtr () |
| std::shared_ptr< const MooseObject > | getSharedPtr () const |
| bool | isKokkosObject (IsKokkosObjectKey &&) const |
| 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 |
| virtual const std::set< BoundaryID > & | boundaryIDs () const |
| const std::vector< BoundaryName > & | boundaryNames () const |
| unsigned int | numBoundaryIDs () const |
| bool | hasBoundary (const BoundaryName &name) const |
| bool | hasBoundary (const std::vector< BoundaryName > &names) const |
| bool | hasBoundary (const BoundaryID &id) const |
| bool | hasBoundary (const std::vector< BoundaryID > &ids, TEST_TYPE type=ALL) const |
| bool | hasBoundary (const std::set< BoundaryID > &ids, TEST_TYPE type=ALL) const |
| bool | isBoundarySubset (const std::set< BoundaryID > &ids) const |
| bool | isBoundarySubset (const std::vector< BoundaryID > &ids) const |
| bool | hasBoundaryMaterialProperty (const std::string &prop_name) const |
| virtual bool | boundaryRestricted () const |
| const std::set< BoundaryID > & | meshBoundaryIDs () const |
| virtual bool | checkVariableBoundaryIntegrity () const |
| virtual void | initialSetup () |
| virtual void | timestepSetup () |
| virtual void | jacobianSetup () |
| virtual void | residualSetup () |
| virtual void | subdomainSetup () |
| virtual void | customSetup (const ExecFlagType &) |
| const ExecFlagEnum & | getExecuteOnEnum () const |
| const Function & | getFunction (const std::string &name) const |
| const Function & | getFunctionByName (const FunctionName &name) const |
| bool | hasFunction (const std::string ¶m_name) const |
| bool | hasFunctionByName (const FunctionName &name) const |
| UserObjectName | getUserObjectName (const std::string ¶m_name) const |
| const T & | getUserObject (const std::string ¶m_name, bool is_dependency=true) const |
| const T & | getUserObjectByName (const UserObjectName &object_name, bool is_dependency=true) const |
| const UserObject & | getUserObjectBase (const std::string ¶m_name, bool is_dependency=true) const |
| const UserObject & | getUserObjectBaseByName (const UserObjectName &object_name, bool is_dependency=true) const |
| bool | isImplicit () |
| Moose::StateArg | determineState () const |
| bool | isDefaultPostprocessorValue (const std::string ¶m_name, const unsigned int index=0) const |
| bool | hasPostprocessor (const std::string ¶m_name, const unsigned int index=0) const |
| bool | hasPostprocessorByName (const PostprocessorName &name) const |
| std::size_t | coupledPostprocessors (const std::string ¶m_name) const |
| const PostprocessorName & | getPostprocessorName (const std::string ¶m_name, const unsigned int index=0) const |
| const VectorPostprocessorValue & | getVectorPostprocessorValue (const std::string ¶m_name, const std::string &vector_name) const |
| const VectorPostprocessorValue & | getVectorPostprocessorValue (const std::string ¶m_name, const std::string &vector_name, bool needs_broadcast) const |
| const VectorPostprocessorValue & | getVectorPostprocessorValueByName (const VectorPostprocessorName &name, const std::string &vector_name) const |
| const VectorPostprocessorValue & | getVectorPostprocessorValueByName (const VectorPostprocessorName &name, const std::string &vector_name, bool needs_broadcast) const |
| const VectorPostprocessorValue & | getVectorPostprocessorValueOld (const std::string ¶m_name, const std::string &vector_name) const |
| const VectorPostprocessorValue & | getVectorPostprocessorValueOld (const std::string ¶m_name, const std::string &vector_name, bool needs_broadcast) const |
| const VectorPostprocessorValue & | getVectorPostprocessorValueOldByName (const VectorPostprocessorName &name, const std::string &vector_name) const |
| const VectorPostprocessorValue & | getVectorPostprocessorValueOldByName (const VectorPostprocessorName &name, const std::string &vector_name, bool needs_broadcast) const |
| const ScatterVectorPostprocessorValue & | getScatterVectorPostprocessorValue (const std::string ¶m_name, const std::string &vector_name) const |
| const ScatterVectorPostprocessorValue & | getScatterVectorPostprocessorValueByName (const VectorPostprocessorName &name, const std::string &vector_name) const |
| const ScatterVectorPostprocessorValue & | getScatterVectorPostprocessorValueOld (const std::string ¶m_name, const std::string &vector_name) const |
| const ScatterVectorPostprocessorValue & | getScatterVectorPostprocessorValueOldByName (const VectorPostprocessorName &name, const std::string &vector_name) const |
| bool | hasVectorPostprocessor (const std::string ¶m_name, const std::string &vector_name) const |
| bool | hasVectorPostprocessor (const std::string ¶m_name) const |
| bool | hasVectorPostprocessorByName (const VectorPostprocessorName &name, const std::string &vector_name) const |
| bool | hasVectorPostprocessorByName (const VectorPostprocessorName &name) const |
| const VectorPostprocessorName & | getVectorPostprocessorName (const std::string ¶m_name) const |
| PenetrationLocator & | getPenetrationLocator (const BoundaryName &primary, const BoundaryName &secondary, Order order) |
| PenetrationLocator & | getQuadraturePenetrationLocator (const BoundaryName &primary, const BoundaryName &secondary, Order order) |
| NearestNodeLocator & | getNearestNodeLocator (const BoundaryName &primary, const BoundaryName &secondary) |
| NearestNodeLocator & | getQuadratureNearestNodeLocator (const BoundaryName &primary, const BoundaryName &secondary) |
| bool | requiresGeometricSearch () const |
| virtual void | meshChanged () |
| void | useVectorTag (const TagName &tag_name, VectorTagsKey) |
| void | useVectorTag (TagID tag_id, VectorTagsKey) |
| void | useMatrixTag (const TagName &tag_name, MatrixTagsKey) |
| void | useMatrixTag (TagID tag_id, MatrixTagsKey) |
| bool | isVectorTagged () |
| bool | isMatrixTagged () |
| bool | hasVectorTags () const |
| const std::set< TagID > & | getVectorTags (VectorTagsKey) const |
| const std::set< TagID > & | getMatrixTags (MatrixTagsKey) const |
| MooseVariableBase * | mooseVariableBase () const |
| MooseVariableField< Real > & | mooseVariableField () |
| MooseVariableFE< Real > * | mooseVariable () const |
| MooseVariableFV< Real > * | mooseVariableFV () const |
| MooseLinearVariableFV< Real > * | mooseLinearVariableFV () const |
| const std::set< MooseVariableFieldBase *> & | getMooseVariableDependencies () const |
| std::set< MooseVariableFieldBase *> | checkAllVariables (const DofObjectType &dof_object, const std::set< MooseVariableFieldBase * > &vars_to_omit={}) |
| std::set< MooseVariableFieldBase *> | checkVariables (const DofObjectType &dof_object, const std::set< MooseVariableFieldBase * > &vars_to_check) |
| void | addMooseVariableDependency (MooseVariableFieldBase *var) |
| void | addMooseVariableDependency (const std::vector< MooseVariableFieldBase * > &vars) |
| Moose::FaceArg | makeFace (const FaceInfo &fi, const Moose::FV::LimiterType limiter_type, const bool elem_is_upwind, const bool correct_skewness=false, const Moose::StateArg *state_limiter=nullptr) const |
| Moose::FaceArg | makeCDFace (const FaceInfo &fi, const bool correct_skewness=false) const |
| const Distribution & | getDistribution (const std::string &name) const |
| const T & | getDistribution (const std::string &name) const |
| const Distribution & | getDistribution (const std::string &name) const |
| const T & | getDistribution (const std::string &name) const |
| const Distribution & | getDistributionByName (const DistributionName &name) const |
| const T & | getDistributionByName (const std::string &name) const |
| const Distribution & | getDistributionByName (const DistributionName &name) const |
| const T & | getDistributionByName (const std::string &name) const |
| bool | hasUserObject (const std::string ¶m_name) const |
| bool | hasUserObject (const std::string ¶m_name) const |
| bool | hasUserObject (const std::string ¶m_name) const |
| bool | hasUserObject (const std::string ¶m_name) const |
| bool | hasUserObjectByName (const UserObjectName &object_name) const |
| bool | hasUserObjectByName (const UserObjectName &object_name) const |
| bool | hasUserObjectByName (const UserObjectName &object_name) const |
| bool | hasUserObjectByName (const UserObjectName &object_name) const |
| const PostprocessorValue & | getPostprocessorValue (const std::string ¶m_name, const unsigned int index=0) const |
| const PostprocessorValue & | getPostprocessorValue (const std::string ¶m_name, const unsigned int index=0) const |
| const PostprocessorValue & | getPostprocessorValueOld (const std::string ¶m_name, const unsigned int index=0) const |
| const PostprocessorValue & | getPostprocessorValueOld (const std::string ¶m_name, const unsigned int index=0) const |
| const PostprocessorValue & | getPostprocessorValueOlder (const std::string ¶m_name, const unsigned int index=0) const |
| const PostprocessorValue & | getPostprocessorValueOlder (const std::string ¶m_name, const unsigned int index=0) const |
| virtual const PostprocessorValue & | getPostprocessorValueByName (const PostprocessorName &name) const |
| virtual const PostprocessorValue & | getPostprocessorValueByName (const PostprocessorName &name) const |
| const PostprocessorValue & | getPostprocessorValueOldByName (const PostprocessorName &name) const |
| const PostprocessorValue & | getPostprocessorValueOldByName (const PostprocessorName &name) const |
| const PostprocessorValue & | getPostprocessorValueOlderByName (const PostprocessorName &name) const |
| const PostprocessorValue & | getPostprocessorValueOlderByName (const PostprocessorName &name) const |
| bool | isVectorPostprocessorDistributed (const std::string ¶m_name) const |
| bool | isVectorPostprocessorDistributed (const std::string ¶m_name) const |
| bool | isVectorPostprocessorDistributedByName (const VectorPostprocessorName &name) const |
| bool | isVectorPostprocessorDistributedByName (const VectorPostprocessorName &name) 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) |
| static bool | restricted (const std::set< BoundaryID > &ids) |
| static std::string | deduceFunctorName (const std::string &name, const InputParameters ¶ms) |
Public Attributes | |
| ALL | |
| ANY | |
| usingCombinedWarningSolutionWarnings | |
| const ConsoleStream | _console |
Static Public Attributes | |
| 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 |
Protected Member Functions | |
| std::string | deduceFunctorName (const std::string &name) const |
| Moose::FaceArg | singleSidedFaceArg (const FaceInfo *fi=nullptr, Moose::FV::LimiterType limiter_type=Moose::FV::LimiterType::CentralDifference, bool correct_skewness=false, const Moose::StateArg *state_limiter=nullptr) const |
| void | flagInvalidSolutionInternal (const InvalidSolutionID invalid_solution_id) const |
| InvalidSolutionID | registerInvalidSolutionInternal (const std::string &message, const bool warning) const |
| bool | hasBoundaryMaterialPropertyHelper (const std::string &prop_name) const |
| KOKKOS_FUNCTION dof_id_type | numKokkosBoundaryNodes () const |
| KOKKOS_FUNCTION dof_id_type | numKokkosBoundarySides () const |
| KOKKOS_FUNCTION ContiguousNodeID | kokkosBoundaryNodeID (ThreadID tid) const |
| KOKKOS_FUNCTION auto | kokkosBoundaryElementSideID (ThreadID tid) const |
| virtual void | addUserObjectDependencyHelper (const UserObject &) const |
| virtual void | addPostprocessorDependencyHelper (const PostprocessorName &) const |
| virtual void | addVectorPostprocessorDependencyHelper (const VectorPostprocessorName &) const |
| void | prepareVectorTag (Assembly &assembly, unsigned int ivar) |
| void | prepareVectorTag (Assembly &assembly, unsigned int ivar, ResidualTagType tag_type) |
| void | prepareVectorTag (Assembly &assembly, unsigned int ivar, ResidualTagType tag_type) |
| void | prepareVectorTagNeighbor (Assembly &assembly, unsigned int ivar) |
| void | prepareVectorTagLower (Assembly &assembly, unsigned int ivar) |
| void | prepareMatrixTag (Assembly &assembly, unsigned int ivar, unsigned int jvar) |
| void | prepareMatrixTag (Assembly &assembly, unsigned int ivar, unsigned int jvar, DenseMatrix< Number > &k) const |
| void | prepareMatrixTagNonlocal (Assembly &assembly, unsigned int ivar, unsigned int jvar) |
| void | prepareMatrixTagNeighbor (Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::DGJacobianType type) |
| void | prepareMatrixTagNeighbor (Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::DGJacobianType type, DenseMatrix< Number > &k) const |
| void | prepareMatrixTagLower (Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::ConstraintJacobianType type) |
| void | accumulateTaggedLocalResidual () |
| void | assignTaggedLocalResidual () |
| void | accumulateTaggedLocalMatrix () |
| void | accumulateTaggedLocalMatrix (Assembly &assembly, unsigned int ivar, unsigned int jvar, const DenseMatrix< Number > &k) |
| void | accumulateTaggedLocalMatrix (Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::DGJacobianType type, const DenseMatrix< Number > &k) |
| void | accumulateTaggedNonlocalMatrix () |
| void | assignTaggedLocalMatrix () |
| void | addResiduals (Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) |
| void | addResiduals (Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, const std::vector< Real > &scaling_factors) |
| void | addResiduals (Assembly &assembly, const DenseVector< T > &residuals, const Indices &dof_indices, Real scaling_factor) |
| void | addResiduals (Assembly &assembly, const ADResidualsPacket &packet) |
| void | addResidualsAndJacobian (Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) |
| void | addResidualsAndJacobian (Assembly &assembly, const ADResidualsPacket &packet) |
| void | addJacobian (Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) |
| void | addJacobian (Assembly &assembly, const ADResidualsPacket &packet) |
| void | addJacobian (Assembly &assembly, DenseMatrix< Real > &local_k, const std::vector< dof_id_type > &row_indices, const std::vector< dof_id_type > &column_indices, Real scaling_factor) |
| void | addResidualsWithoutConstraints (Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) |
| void | addResidualsAndJacobianWithoutConstraints (Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) |
| void | addJacobianWithoutConstraints (Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) |
| void | addJacobianElement (Assembly &assembly, Real value, dof_id_type row_index, dof_id_type column_index, Real scaling_factor) |
| void | setResidual (SystemBase &sys, const T &residual, MooseVariableFE< T > &var) |
| void | setResidual (SystemBase &sys, Real residual, dof_id_type dof_index) |
| void | setResidual (SystemBase &sys, SetResidualFunctor set_residual_functor) |
| virtual const OutputTools< Real >::VariableValue & | value () |
| virtual const OutputTools< Real >::VariableValue & | valueOld () |
| virtual const OutputTools< Real >::VariableValue & | valueOlder () |
| virtual const OutputTools< Real >::VariableValue & | dot () |
| virtual const OutputTools< Real >::VariableValue & | dotDot () |
| virtual const OutputTools< Real >::VariableValue & | dotOld () |
| virtual const OutputTools< Real >::VariableValue & | dotDotOld () |
| virtual const VariableValue & | dotDu () |
| virtual const VariableValue & | dotDotDu () |
| virtual const OutputTools< Real >::VariableGradient & | gradient () |
| virtual const OutputTools< Real >::VariableGradient & | gradientOld () |
| virtual const OutputTools< Real >::VariableGradient & | gradientOlder () |
| virtual const OutputTools< Real >::VariableSecond & | second () |
| virtual const OutputTools< Real >::VariableSecond & | secondOld () |
| virtual const OutputTools< Real >::VariableSecond & | secondOlder () |
| virtual const OutputTools< Real >::VariableTestSecond & | secondTest () |
| virtual const OutputTools< Real >::VariableTestSecond & | secondTestFace () |
| virtual const OutputTools< Real >::VariablePhiSecond & | secondPhi () |
| virtual const OutputTools< Real >::VariablePhiSecond & | secondPhiFace () |
| const Moose::Functor< T > & | getFunctor (const std::string &name) |
| const Moose::Functor< T > & | getFunctor (const std::string &name, THREAD_ID tid) |
| const Moose::Functor< T > & | getFunctor (const std::string &name, SubProblem &subproblem) |
| const Moose::Functor< T > & | getFunctor (const std::string &name, SubProblem &subproblem, THREAD_ID tid) |
| bool | isFunctor (const std::string &name) const |
| bool | isFunctor (const std::string &name, const SubProblem &subproblem) const |
| Moose::ElemArg | makeElemArg (const Elem *elem, bool correct_skewnewss=false) const |
| void | checkFunctorSupportsSideIntegration (const std::string &name, bool qp_integration) |
Private Attributes | |
| const unsigned int | _dim |
| the dimension of the domain More... | |
| const Moose::Functor< ADReal > & | _u_var |
| x-velocity More... | |
| const Moose::Functor< ADReal > * | _v_var |
| y-velocity More... | |
| const Moose::Functor< ADReal > * | _w_var |
| z-velocity More... | |
| const Moose::Functor< ADReal > & | _rho |
| Density. More... | |
| const Moose::Functor< ADReal > & | _mu |
| Dynamic viscosity. More... | |
| const Moose::Functor< ADReal > & | _mu_t |
| Turbulent dynamic viscosity. More... | |
| const Moose::Functor< ADReal > & | _k |
| Turbulent kinetic energy. More... | |
| const Real | _C_mu |
| C_mu turbulent coefficient. More... | |
| NS::WallTreatmentEnum | _wall_treatment |
| Method used for wall treatment. More... | |
| const bool | _preserve_sparsity_pattern |
| For Newton solves we want to add extra zero-valued terms regardless of y-plus to avoid sparsity pattern changes as y-plus changes near the walls. More... | |
| const Real | _mut_30 |
Applies a wall function to the turbulent viscosity field.
Definition at line 19 of file INSFVTurbulentViscosityWallFunction.h.
| INSFVTurbulentViscosityWallFunction::INSFVTurbulentViscosityWallFunction | ( | const InputParameters & | parameters | ) |
Definition at line 36 of file INSFVTurbulentViscosityWallFunction.C.
|
overridevirtual |
Implements FVDirichletBCBase.
Definition at line 54 of file INSFVTurbulentViscosityWallFunction.C.
|
static |
Definition at line 17 of file INSFVTurbulentViscosityWallFunction.C.
Referenced by WCNSFVTurbulencePhysics::validParams().
|
private |
C_mu turbulent coefficient.
Definition at line 50 of file INSFVTurbulentViscosityWallFunction.h.
Referenced by boundaryValue().
|
private |
the dimension of the domain
Definition at line 30 of file INSFVTurbulentViscosityWallFunction.h.
|
private |
Turbulent kinetic energy.
Definition at line 47 of file INSFVTurbulentViscosityWallFunction.h.
Referenced by boundaryValue().
|
private |
Dynamic viscosity.
Definition at line 42 of file INSFVTurbulentViscosityWallFunction.h.
Referenced by boundaryValue().
|
private |
Turbulent dynamic viscosity.
Definition at line 44 of file INSFVTurbulentViscosityWallFunction.h.
|
private |
Definition at line 59 of file INSFVTurbulentViscosityWallFunction.h.
Referenced by boundaryValue().
|
private |
For Newton solves we want to add extra zero-valued terms regardless of y-plus to avoid sparsity pattern changes as y-plus changes near the walls.
Definition at line 56 of file INSFVTurbulentViscosityWallFunction.h.
Referenced by boundaryValue().
|
private |
Density.
Definition at line 40 of file INSFVTurbulentViscosityWallFunction.h.
Referenced by boundaryValue().
|
private |
x-velocity
Definition at line 33 of file INSFVTurbulentViscosityWallFunction.h.
Referenced by boundaryValue().
|
private |
y-velocity
Definition at line 35 of file INSFVTurbulentViscosityWallFunction.h.
Referenced by boundaryValue().
|
private |
z-velocity
Definition at line 37 of file INSFVTurbulentViscosityWallFunction.h.
Referenced by boundaryValue().
|
private |
Method used for wall treatment.
Definition at line 53 of file INSFVTurbulentViscosityWallFunction.h.
Referenced by boundaryValue().
1.8.14