_action_factory | MooseBaseParameterInterface | protected |
_app | MooseObject | protected |
_communicator | libMesh::ParallelObject | protected |
_console | ConsoleStreamInterface | |
_current_execute_flag | SetupInterface | protected |
_current_face_info | LinearFVBoundaryCondition | protected |
_current_face_type | LinearFVBoundaryCondition | protected |
_dt | TransientInterface | protected |
_dt_old | TransientInterface | protected |
_enabled | MooseObject | protected |
_execute_enum | SetupInterface | protected |
_factory | MooseBaseParameterInterface | protected |
_field_variable | MooseVariableInterface< Real > | protected |
_fv_problem | LinearFVBoundaryCondition | protected |
_fv_variable | MooseVariableInterface< Real > | protected |
_geometric_search_data | GeometricSearchInterface | protected |
_is_implicit | TransientInterface | protected |
_is_transient | TransientInterface | protected |
_linear_fv_variable | MooseVariableInterface< Real > | protected |
_local_ke | TaggingInterface | protected |
_local_re | TaggingInterface | protected |
_mci_feproblem | MeshChangedInterface | protected |
_mesh | LinearFVBoundaryCondition | protected |
_mvi_assembly | MooseVariableInterface< Real > | protected |
_name | MooseBase | protected |
_nodal | MooseVariableInterface< Real > | protected |
_nonlocal_ke | TaggingInterface | protected |
_pars | MooseBaseParameterInterface | protected |
_requires_geometric_search | GeometricSearchInterface | protected |
_subproblem | LinearFVBoundaryCondition | protected |
_sys | LinearFVBoundaryCondition | protected |
_sys_num | LinearFVBoundaryCondition | protected |
_t | TransientInterface | protected |
_t_old | TransientInterface | protected |
_t_step | TransientInterface | protected |
_ti_feproblem | TransientInterface | protected |
_ti_params | TransientInterface | protected |
_tid | LinearFVBoundaryCondition | protected |
_two_term_expansion | LinearFVAdvectionDiffusionExtrapolatedBC | protected |
_type | MooseBase | protected |
_var | LinearFVBoundaryCondition | protected |
_var_num | LinearFVBoundaryCondition | protected |
_variable | MooseVariableInterface< Real > | protected |
accumulateTaggedLocalMatrix() | TaggingInterface | protected |
accumulateTaggedLocalMatrix(Assembly &assembly, unsigned int ivar, unsigned int jvar, const DenseMatrix< Number > &k) | TaggingInterface | protected |
accumulateTaggedLocalMatrix(Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::DGJacobianType type, const DenseMatrix< Number > &k) | TaggingInterface | protected |
accumulateTaggedLocalResidual() | TaggingInterface | protected |
accumulateTaggedNonlocalMatrix() | TaggingInterface | protected |
addJacobian(Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) | TaggingInterface | protected |
addJacobian(Assembly &assembly, const ADResidualsPacket &packet) | TaggingInterface | inlineprotected |
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) | TaggingInterface | inlineprotected |
addJacobianElement(Assembly &assembly, Real value, dof_id_type row_index, dof_id_type column_index, Real scaling_factor) | TaggingInterface | inlineprotected |
addJacobianWithoutConstraints(Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) | TaggingInterface | protected |
addMooseVariableDependency(MooseVariableFieldBase *var) | MooseVariableDependencyInterface | inline |
addMooseVariableDependency(const std::vector< MooseVariableFieldBase *> &vars) | MooseVariableDependencyInterface | inline |
addPostprocessorDependencyHelper(const PostprocessorName &) const | PostprocessorInterface | inlineprotectedvirtual |
addResiduals(Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) | TaggingInterface | protected |
addResiduals(Assembly &assembly, const DenseVector< T > &residuals, const Indices &dof_indices, Real scaling_factor) | TaggingInterface | protected |
addResiduals(Assembly &assembly, const ADResidualsPacket &packet) | TaggingInterface | inlineprotected |
addResidualsAndJacobian(Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) | TaggingInterface | protected |
addResidualsAndJacobian(Assembly &assembly, const ADResidualsPacket &packet) | TaggingInterface | inlineprotected |
addResidualsAndJacobianWithoutConstraints(Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) | TaggingInterface | protected |
addResidualsWithoutConstraints(Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) | TaggingInterface | protected |
addUserObjectDependencyHelper(const UserObject &) const | UserObjectInterface | inlineprotectedvirtual |
addVectorPostprocessorDependencyHelper(const VectorPostprocessorName &) const | VectorPostprocessorInterface | inlineprotectedvirtual |
ALL enum value | BoundaryRestrictable | |
ANY enum value | BoundaryRestrictable | |
assignTaggedLocalMatrix() | TaggingInterface | protected |
assignTaggedLocalResidual() | TaggingInterface | protected |
boundaryIDs() const | BoundaryRestrictable | virtual |
boundaryNames() const | BoundaryRestrictable | |
BoundaryRestrictable(const MooseObject *moose_object, bool nodal) | BoundaryRestrictable | |
BoundaryRestrictable(const MooseObject *moose_object, const std::set< SubdomainID > &block_ids, bool nodal) | BoundaryRestrictable | |
BoundaryRestrictableRequired(const MooseObject *moose_object, bool nodal) | BoundaryRestrictableRequired | |
boundaryRestricted() const | BoundaryRestrictable | virtual |
callMooseError(std::string msg, const bool with_prefix) const | MooseBase | |
checkAllVariables(const DofObjectType &dof_object, const std::set< MooseVariableFieldBase *> &vars_to_omit={}) | MooseVariableDependencyInterface | |
checkFunctorSupportsSideIntegration(const std::string &name, bool qp_integration) | FunctorInterface | protected |
checkVariableBoundaryIntegrity() const | BoundaryRestrictable | inlinevirtual |
checkVariables(const DofObjectType &dof_object, const std::set< MooseVariableFieldBase *> &vars_to_check) | MooseVariableDependencyInterface | |
comm() const | libMesh::ParallelObject | |
computeBoundaryGradientMatrixContribution() const override | LinearFVAdvectionDiffusionOutflowBC | virtual |
computeBoundaryGradientRHSContribution() const override | LinearFVAdvectionDiffusionOutflowBC | virtual |
computeBoundaryNormalGradient() const override | LinearFVAdvectionDiffusionOutflowBC | virtual |
computeBoundaryValue() const override | LinearFVAdvectionDiffusionExtrapolatedBC | virtual |
computeBoundaryValueMatrixContribution() const override | LinearFVAdvectionDiffusionExtrapolatedBC | virtual |
computeBoundaryValueRHSContribution() const override | LinearFVAdvectionDiffusionExtrapolatedBC | virtual |
computeCellToFaceDistance() const | LinearFVBoundaryCondition | protected |
computeCellToFaceVector() const | LinearFVBoundaryCondition | protected |
connectControllableParams(const std::string ¶meter, const std::string &object_type, const std::string &object_name, const std::string &object_parameter) const | MooseBaseParameterInterface | |
ConsoleStreamInterface(MooseApp &app) | ConsoleStreamInterface | |
coupledPostprocessors(const std::string ¶m_name) const | PostprocessorInterface | |
currentFaceInfo() const | LinearFVBoundaryCondition | inline |
currentFaceType() const | LinearFVBoundaryCondition | inline |
customSetup(const ExecFlagType &) | SetupInterface | inlinevirtual |
DataFileInterface(const ParallelParamObject &parent) | DataFileInterface | |
DataFileParameterType typedef | DataFileInterface | |
deduceFunctorName(const std::string &name, const InputParameters ¶ms) | FunctorInterface | static |
deduceFunctorName(const std::string &name) const | FunctorInterface | protected |
determineState() const | TransientInterface | inline |
DistributionInterface(const MooseObject *moose_object) | DistributionInterface | |
dot() | MooseVariableInterface< Real > | protectedvirtual |
dotDot() | MooseVariableInterface< Real > | protectedvirtual |
dotDotDu() | MooseVariableInterface< Real > | protectedvirtual |
dotDotOld() | MooseVariableInterface< Real > | protectedvirtual |
dotDu() | MooseVariableInterface< Real > | protectedvirtual |
dotOld() | MooseVariableInterface< Real > | protectedvirtual |
enabled() const | MooseObject | inlinevirtual |
errorPrefix(const std::string &error_type) const | MooseBase | |
FunctionInterface(const MooseObject *moose_object) | FunctionInterface | |
FunctorInterface(const MooseObject *moose_object) | FunctorInterface | |
GeometricSearchInterface(const MooseObject *moose_object) | GeometricSearchInterface | |
getCheckedPointerParam(const std::string &name, const std::string &error_string="") const | MooseBaseParameterInterface | |
getDataFileName(const std::string ¶m) const | DataFileInterface | |
getDataFileNameByName(const std::string &relative_path) const | DataFileInterface | |
getDataFilePath(const std::string &relative_path) const | DataFileInterface | |
getDistribution(const std::string &name) const | DistributionInterface | |
getDistribution(const std::string &name) const | DistributionInterface | |
getDistributionByName(const DistributionName &name) const | DistributionInterface | |
getDistributionByName(const std::string &name) const | DistributionInterface | |
getExecuteOnEnum() const | SetupInterface | |
getFunction(const std::string &name) const | FunctionInterface | |
getFunctionByName(const FunctionName &name) const | FunctionInterface | |
getFunctor(const std::string &name) | FunctorInterface | protected |
getFunctor(const std::string &name, THREAD_ID tid) | FunctorInterface | protected |
getFunctor(const std::string &name, SubProblem &subproblem) | FunctorInterface | protected |
getFunctor(const std::string &name, SubProblem &subproblem, THREAD_ID tid) | FunctorInterface | protected |
getMatrixTags(MatrixTagsKey) const | TaggingInterface | inline |
getMooseApp() const | MooseBase | inline |
getMooseVariableDependencies() const | MooseVariableDependencyInterface | inline |
getNearestNodeLocator(const BoundaryName &primary, const BoundaryName &secondary) | GeometricSearchInterface | |
getParam(const std::string &name) const | MooseBaseParameterInterface | |
getParam(const std::string ¶m1, const std::string ¶m2) const | MooseBaseParameterInterface | |
getPenetrationLocator(const BoundaryName &primary, const BoundaryName &secondary, Order order) | GeometricSearchInterface | |
getPostprocessorName(const std::string ¶m_name, const unsigned int index=0) const | PostprocessorInterface | |
getPostprocessorValue(const std::string ¶m_name, const unsigned int index=0) const | PostprocessorInterface | |
getPostprocessorValueByName(const PostprocessorName &name) const | PostprocessorInterface | virtual |
getPostprocessorValueOld(const std::string ¶m_name, const unsigned int index=0) const | PostprocessorInterface | |
getPostprocessorValueOldByName(const PostprocessorName &name) const | PostprocessorInterface | |
getPostprocessorValueOlder(const std::string ¶m_name, const unsigned int index=0) const | PostprocessorInterface | |
getPostprocessorValueOlderByName(const PostprocessorName &name) const | PostprocessorInterface | |
getQuadratureNearestNodeLocator(const BoundaryName &primary, const BoundaryName &secondary) | GeometricSearchInterface | |
getQuadraturePenetrationLocator(const BoundaryName &primary, const BoundaryName &secondary, Order order) | GeometricSearchInterface | |
getRenamedParam(const std::string &old_name, const std::string &new_name) const | MooseBaseParameterInterface | |
getScatterVectorPostprocessorValue(const std::string ¶m_name, const std::string &vector_name) const | VectorPostprocessorInterface | |
getScatterVectorPostprocessorValueByName(const VectorPostprocessorName &name, const std::string &vector_name) const | VectorPostprocessorInterface | |
getScatterVectorPostprocessorValueOld(const std::string ¶m_name, const std::string &vector_name) const | VectorPostprocessorInterface | |
getScatterVectorPostprocessorValueOldByName(const VectorPostprocessorName &name, const std::string &vector_name) const | VectorPostprocessorInterface | |
getSharedPtr() | MooseObject | |
getSharedPtr() const | MooseObject | |
getUserObject(const std::string ¶m_name, bool is_dependency=true) const | UserObjectInterface | |
getUserObjectBase(const std::string ¶m_name, bool is_dependency=true) const | UserObjectInterface | |
getUserObjectBaseByName(const UserObjectName &object_name, bool is_dependency=true) const | UserObjectInterface | |
getUserObjectByName(const UserObjectName &object_name, bool is_dependency=true) const | UserObjectInterface | |
getUserObjectName(const std::string ¶m_name) const | UserObjectInterface | |
getVectorPostprocessorName(const std::string ¶m_name) const | VectorPostprocessorInterface | |
getVectorPostprocessorValue(const std::string ¶m_name, const std::string &vector_name) const | VectorPostprocessorInterface | |
getVectorPostprocessorValue(const std::string ¶m_name, const std::string &vector_name, bool needs_broadcast) const | VectorPostprocessorInterface | |
getVectorPostprocessorValueByName(const VectorPostprocessorName &name, const std::string &vector_name) const | VectorPostprocessorInterface | |
getVectorPostprocessorValueByName(const VectorPostprocessorName &name, const std::string &vector_name, bool needs_broadcast) const | VectorPostprocessorInterface | |
getVectorPostprocessorValueOld(const std::string ¶m_name, const std::string &vector_name) const | VectorPostprocessorInterface | |
getVectorPostprocessorValueOld(const std::string ¶m_name, const std::string &vector_name, bool needs_broadcast) const | VectorPostprocessorInterface | |
getVectorPostprocessorValueOldByName(const VectorPostprocessorName &name, const std::string &vector_name) const | VectorPostprocessorInterface | |
getVectorPostprocessorValueOldByName(const VectorPostprocessorName &name, const std::string &vector_name, bool needs_broadcast) const | VectorPostprocessorInterface | |
getVectorTags(VectorTagsKey) const | TaggingInterface | inline |
gradient() | MooseVariableInterface< Real > | protectedvirtual |
gradientOld() | MooseVariableInterface< Real > | protectedvirtual |
gradientOlder() | MooseVariableInterface< Real > | protectedvirtual |
hasBoundary(const BoundaryName &name) const | BoundaryRestrictable | |
hasBoundary(const std::vector< BoundaryName > &names) const | BoundaryRestrictable | |
hasBoundary(const BoundaryID &id) const | BoundaryRestrictable | |
hasBoundary(const std::vector< BoundaryID > &ids, TEST_TYPE type=ALL) const | BoundaryRestrictable | |
hasBoundary(const std::set< BoundaryID > &ids, TEST_TYPE type=ALL) const | BoundaryRestrictable | |
hasBoundaryMaterialProperty(const std::string &prop_name) const | BoundaryRestrictable | |
hasBoundaryMaterialPropertyHelper(const std::string &prop_name) const | BoundaryRestrictable | protected |
hasFaceSide(const FaceInfo &fi, bool fi_elem_side) const override | LinearFVBoundaryCondition | virtual |
hasFunction(const std::string ¶m_name) const | FunctionInterface | |
hasFunctionByName(const FunctionName &name) const | FunctionInterface | |
hasPostprocessor(const std::string ¶m_name, const unsigned int index=0) const | PostprocessorInterface | |
hasPostprocessorByName(const PostprocessorName &name) const | PostprocessorInterface | |
hasUserObject(const std::string ¶m_name) const | UserObjectInterface | |
hasUserObject(const std::string ¶m_name) const | UserObjectInterface | |
hasUserObjectByName(const UserObjectName &object_name) const | UserObjectInterface | |
hasUserObjectByName(const UserObjectName &object_name) const | UserObjectInterface | |
hasVectorPostprocessor(const std::string ¶m_name, const std::string &vector_name) const | VectorPostprocessorInterface | |
hasVectorPostprocessor(const std::string ¶m_name) const | VectorPostprocessorInterface | |
hasVectorPostprocessorByName(const VectorPostprocessorName &name, const std::string &vector_name) const | VectorPostprocessorInterface | |
hasVectorPostprocessorByName(const VectorPostprocessorName &name) const | VectorPostprocessorInterface | |
hasVectorTags() const | TaggingInterface | inline |
includesMaterialPropertyMultiplier() const | LinearFVAdvectionDiffusionBC | inlinevirtual |
initialSetup() | SetupInterface | virtual |
isBoundarySubset(const std::set< BoundaryID > &ids) const | BoundaryRestrictable | |
isBoundarySubset(const std::vector< BoundaryID > &ids) const | BoundaryRestrictable | |
isDefaultPostprocessorValue(const std::string ¶m_name, const unsigned int index=0) const | PostprocessorInterface | |
isFunctor(const std::string &name) const | FunctorInterface | protected |
isFunctor(const std::string &name, const SubProblem &subproblem) const | FunctorInterface | protected |
isImplicit() | TransientInterface | inline |
isMatrixTagged() | TaggingInterface | inline |
isParamSetByUser(const std::string &nm) const | MooseBaseParameterInterface | inline |
isParamValid(const std::string &name) const | MooseBaseParameterInterface | inline |
isVectorPostprocessorDistributed(const std::string ¶m_name) const | VectorPostprocessorInterface | |
isVectorPostprocessorDistributedByName(const VectorPostprocessorName &name) const | VectorPostprocessorInterface | |
isVectorTagged() | TaggingInterface | inline |
jacobianSetup() | SetupInterface | virtual |
LinearFVAdvectionDiffusionBC(const InputParameters ¶meters) | LinearFVAdvectionDiffusionBC | |
LinearFVAdvectionDiffusionExtrapolatedBC(const InputParameters ¶meters) | LinearFVAdvectionDiffusionExtrapolatedBC | |
LinearFVAdvectionDiffusionOutflowBC(const InputParameters ¶meters) | LinearFVAdvectionDiffusionOutflowBC | |
LinearFVBoundaryCondition(const InputParameters ¶meters) | LinearFVBoundaryCondition | |
makeCDFace(const FaceInfo &fi, const bool correct_skewness=false) const | FaceArgProducerInterface | inline |
makeElemArg(const Elem *elem, bool correct_skewnewss=false) const | FunctorInterface | protected |
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 | FaceArgProducerInterface | |
meshBoundaryIDs() const | BoundaryRestrictable | |
meshChanged() | MeshChangedInterface | inlinevirtual |
MeshChangedInterface(const InputParameters ¶ms) | MeshChangedInterface | |
MooseBase(const std::string &type, const std::string &name, MooseApp &app, const InputParameters ¶ms) | MooseBase | |
MooseBaseErrorInterface(const MooseBase &base) | MooseBaseErrorInterface | |
MooseBaseParameterInterface(const MooseBase &base, const InputParameters ¶meters) | MooseBaseParameterInterface | |
mooseDeprecated(Args &&... args) const | MooseBaseErrorInterface | inline |
mooseDocumentedError(const std::string &repo_name, const unsigned int issue_num, Args &&... args) const | MooseBaseErrorInterface | inline |
mooseError(Args &&... args) const | MooseBaseErrorInterface | inline |
mooseErrorNonPrefixed(Args &&... args) const | MooseBaseErrorInterface | inline |
mooseInfo(Args &&... args) const | MooseBaseErrorInterface | inline |
mooseLinearVariableFV() const | MooseVariableInterface< Real > | |
MooseObject(const InputParameters ¶meters) | MooseObject | |
mooseVariable() const | MooseVariableInterface< Real > | |
mooseVariableBase() const | MooseVariableInterface< Real > | inline |
MooseVariableDependencyInterface(const MooseObject *) | MooseVariableDependencyInterface | |
mooseVariableField() | MooseVariableInterface< Real > | |
mooseVariableFV() const | MooseVariableInterface< Real > | |
MooseVariableInterface(const MooseObject *moose_object, bool nodal, std::string var_param_name="variable", Moose::VarKindType expected_var_type=Moose::VarKindType::VAR_ANY, Moose::VarFieldType expected_var_field_type=Moose::VarFieldType::VAR_FIELD_ANY) | MooseVariableInterface< Real > | |
mooseWarning(Args &&... args) const | MooseBaseErrorInterface | inline |
mooseWarningNonPrefixed(Args &&... args) const | MooseBaseErrorInterface | inline |
n_processors() const | libMesh::ParallelObject | |
name() const | MooseBase | inlinevirtual |
NonADFunctorInterface(const MooseObject *moose_object) | NonADFunctorInterface | |
numBoundaryIDs() const | BoundaryRestrictable | |
operator=(const ParallelObject &libmesh_dbg_var(other)) | libMesh::ParallelObject | |
ParallelObject(const Parallel::Communicator &comm_in) | libMesh::ParallelObject | |
ParallelObject(const ParallelObject &other) | libMesh::ParallelObject | |
ParallelParamObject(const std::string &type, const std::string &name, MooseApp &app, const InputParameters ¶ms) | ParallelParamObject | |
paramError(const std::string ¶m, Args... args) const | MooseBaseParameterInterface | |
parameters() const | MooseBaseParameterInterface | inline |
paramInfo(const std::string ¶m, Args... args) const | MooseBaseParameterInterface | |
paramWarning(const std::string ¶m, Args... args) const | MooseBaseParameterInterface | |
PostprocessorInterface(const MooseObject *moose_object) | PostprocessorInterface | |
PostprocessorInterface(const FEProblemBase *problem) | PostprocessorInterface | |
prepareMatrixTag(Assembly &assembly, unsigned int ivar, unsigned int jvar) | TaggingInterface | protected |
prepareMatrixTag(Assembly &assembly, unsigned int ivar, unsigned int jvar, DenseMatrix< Number > &k) const | TaggingInterface | protected |
prepareMatrixTagLower(Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::ConstraintJacobianType type) | TaggingInterface | protected |
prepareMatrixTagNeighbor(Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::DGJacobianType type) | TaggingInterface | protected |
prepareMatrixTagNeighbor(Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::DGJacobianType type, DenseMatrix< Number > &k) const | TaggingInterface | protected |
prepareMatrixTagNonlocal(Assembly &assembly, unsigned int ivar, unsigned int jvar) | TaggingInterface | protected |
prepareVectorTag(Assembly &assembly, unsigned int ivar) | TaggingInterface | protected |
prepareVectorTag(Assembly &assembly, unsigned int ivar, ResidualTagType tag_type) | TaggingInterface | protected |
prepareVectorTagLower(Assembly &assembly, unsigned int ivar) | TaggingInterface | protected |
prepareVectorTagNeighbor(Assembly &assembly, unsigned int ivar) | TaggingInterface | protected |
processor_id() const | libMesh::ParallelObject | |
queryParam(const std::string &name) const | MooseBaseParameterInterface | |
requiresGeometricSearch() const | GeometricSearchInterface | inline |
residualSetup() | SetupInterface | virtual |
ResidualTagType enum name | TaggingInterface | |
restricted(const std::set< BoundaryID > &ids) | BoundaryRestrictable | static |
second() | MooseVariableInterface< Real > | protectedvirtual |
secondOld() | MooseVariableInterface< Real > | protectedvirtual |
secondOlder() | MooseVariableInterface< Real > | protectedvirtual |
secondPhi() | MooseVariableInterface< Real > | protectedvirtual |
secondPhiFace() | MooseVariableInterface< Real > | protectedvirtual |
secondTest() | MooseVariableInterface< Real > | protectedvirtual |
secondTestFace() | MooseVariableInterface< Real > | protectedvirtual |
setResidual(SystemBase &sys, const T &residual, MooseVariableFE< T > &var) | TaggingInterface | protected |
setResidual(SystemBase &sys, Real residual, dof_id_type dof_index) | TaggingInterface | inlineprotected |
setResidual(SystemBase &sys, SetResidualFunctor set_residual_functor) | TaggingInterface | protected |
setupFaceData(const FaceInfo *face_info, const FaceInfo::VarFaceNeighbors face_type) | LinearFVBoundaryCondition | inline |
SetupInterface(const MooseObject *moose_object) | SetupInterface | |
singleSidedFaceArg(const FaceInfo *fi, Moose::FV::LimiterType limiter_type=Moose::FV::LimiterType::CentralDifference, bool correct_skewness=false) const | LinearFVBoundaryCondition | protected |
subdomainSetup() | SetupInterface | virtual |
subProblem() const | LinearFVBoundaryCondition | inline |
TaggingInterface(const MooseObject *moose_object) | TaggingInterface | |
TEST_TYPE enum name | BoundaryRestrictable | |
timestepSetup() | SetupInterface | virtual |
TransientInterface(const MooseObject *moose_object) | TransientInterface | |
type() const | MooseBase | inline |
typeAndName() const | MooseBase | |
uniqueName() const | MooseBaseParameterInterface | inline |
uniqueParameterName(const std::string ¶meter_name) const | MooseBaseParameterInterface | inline |
useBoundaryGradientExtrapolation() const | LinearFVAdvectionDiffusionBC | inlinevirtual |
useMatrixTag(const TagName &tag_name, MatrixTagsKey) | TaggingInterface | |
useMatrixTag(TagID tag_id, MatrixTagsKey) | TaggingInterface | |
UserObjectInterface(const MooseObject *moose_object) | UserObjectInterface | |
useVectorTag(const TagName &tag_name, VectorTagsKey) | TaggingInterface | |
useVectorTag(TagID tag_id, VectorTagsKey) | TaggingInterface | |
validParams() | LinearFVAdvectionDiffusionOutflowBC | static |
value() | MooseVariableInterface< Real > | protectedvirtual |
valueOld() | MooseVariableInterface< Real > | protectedvirtual |
valueOlder() | MooseVariableInterface< Real > | protectedvirtual |
variable() const | LinearFVBoundaryCondition | inline |
VectorPostprocessorInterface(const MooseObject *moose_object, bool broadcast_by_default=false) | VectorPostprocessorInterface | |
~BoundaryRestrictable() | BoundaryRestrictable | virtual |
~FaceArgInterface()=default | FaceArgInterface | virtual |
~MeshChangedInterface()=default | MeshChangedInterface | virtual |
~MooseBase()=default | MooseBase | virtual |
~MooseBaseParameterInterface()=default | MooseBaseParameterInterface | virtual |
~MooseObject()=default | MooseObject | virtual |
~MooseVariableInterface() | MooseVariableInterface< Real > | virtual |
~ParallelObject()=default | libMesh::ParallelObject | virtual |
~ParallelParamObject()=default | ParallelParamObject | virtual |
~SetupInterface() | SetupInterface | virtual |
~TaggingInterface() | TaggingInterface | virtual |
~TransientInterface() | TransientInterface | virtual |
~VectorPostprocessorInterface()=default | VectorPostprocessorInterface | virtual |