This is the complete list of members for LinearFVScalarAdvection, including all inherited members.
_action_factory | LinearFVFluxKernel | protected |
_add_slip_model | LinearFVScalarAdvection | private |
_advected_interp_coeffs | LinearFVScalarAdvection | private |
_advected_interp_method | LinearFVScalarAdvection | private |
_app | LinearFVFluxKernel | protected |
_blk_material_data | LinearFVFluxKernel | protected |
_cached_matrix_contribution | LinearFVFluxKernel | protected |
_cached_rhs_contribution | LinearFVFluxKernel | protected |
_communicator | libMesh::ParallelObject | protected |
_console | LinearFVFluxKernel | |
_current_execute_flag | LinearFVFluxKernel | protected |
_current_face_area | LinearFVFluxKernel | protected |
_current_face_info | LinearFVFluxKernel | protected |
_current_face_type | LinearFVFluxKernel | protected |
_dof_indices | LinearFVFluxKernel | protected |
_dt | LinearFVFluxKernel | protected |
_dt_old | LinearFVFluxKernel | protected |
_enabled | LinearFVFluxKernel | protected |
_execute_enum | LinearFVFluxKernel | protected |
_factory | LinearFVFluxKernel | protected |
_fe_problem | LinearFVFluxKernel | protected |
_field_variable | LinearFVFluxKernel | protected |
_force_boundary_execution | LinearFVFluxKernel | protected |
_fv_variable | LinearFVFluxKernel | protected |
_is_implicit | LinearFVFluxKernel | protected |
_is_transient | LinearFVFluxKernel | protected |
_linear_fv_variable | LinearFVFluxKernel | protected |
_linear_system | LinearFVFluxKernel | protected |
_local_ke | LinearFVFluxKernel | protected |
_local_re | LinearFVFluxKernel | protected |
_mass_flux_provider | LinearFVScalarAdvection | protected |
_matrices | LinearFVFluxKernel | protected |
_matrix_contribution | LinearFVFluxKernel | protected |
_mci_feproblem | LinearFVFluxKernel | protected |
_mesh | LinearFVFluxKernel | protected |
_mvi_assembly | LinearFVFluxKernel | protected |
_name | LinearFVFluxKernel | protected |
_nodal | LinearFVFluxKernel | protected |
_nonlocal_ke | LinearFVFluxKernel | protected |
_pars | LinearFVFluxKernel | protected |
_restartable_app | LinearFVFluxKernel | protected |
_restartable_read_only | LinearFVFluxKernel | protected |
_restartable_system_name | LinearFVFluxKernel | protected |
_restartable_tid | LinearFVFluxKernel | protected |
_rhs_contribution | LinearFVFluxKernel | protected |
_subproblem | LinearFVFluxKernel | protected |
_sys | LinearFVFluxKernel | protected |
_sys_num | LinearFVFluxKernel | protected |
_t | LinearFVFluxKernel | protected |
_t_old | LinearFVFluxKernel | protected |
_t_step | LinearFVFluxKernel | protected |
_ti_feproblem | LinearFVFluxKernel | protected |
_ti_params | LinearFVFluxKernel | protected |
_tid | LinearFVFluxKernel | protected |
_type | LinearFVFluxKernel | protected |
_u_slip | LinearFVScalarAdvection | private |
_v_slip | LinearFVScalarAdvection | private |
_var | LinearFVFluxKernel | protected |
_var_num | LinearFVFluxKernel | protected |
_variable | LinearFVFluxKernel | protected |
_vectors | LinearFVFluxKernel | protected |
_volumetric_face_flux | LinearFVScalarAdvection | private |
_w_slip | LinearFVScalarAdvection | private |
accumulateTaggedLocalMatrix() | LinearFVFluxKernel | protected |
accumulateTaggedLocalMatrix(Assembly &assembly, unsigned int ivar, unsigned int jvar, const DenseMatrix< Number > &k) | LinearFVFluxKernel | protected |
accumulateTaggedLocalMatrix(Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::DGJacobianType type, const DenseMatrix< Number > &k) | LinearFVFluxKernel | protected |
accumulateTaggedLocalResidual() | LinearFVFluxKernel | protected |
accumulateTaggedNonlocalMatrix() | LinearFVFluxKernel | protected |
addJacobian(Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) | LinearFVFluxKernel | protected |
addJacobian(Assembly &assembly, const ADResidualsPacket &packet) | LinearFVFluxKernel | protected |
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) | LinearFVFluxKernel | protected |
addJacobianElement(Assembly &assembly, Real value, dof_id_type row_index, dof_id_type column_index, Real scaling_factor) | LinearFVFluxKernel | protected |
addJacobianWithoutConstraints(Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) | LinearFVFluxKernel | protected |
addMatrixContribution() override | LinearFVFluxKernel | virtual |
addMooseVariableDependency(MooseVariableFieldBase *var) | LinearFVFluxKernel | |
addMooseVariableDependency(const std::vector< MooseVariableFieldBase * > &vars) | LinearFVFluxKernel | |
addPostprocessorDependencyHelper(const PostprocessorName &) const | LinearFVFluxKernel | protectedvirtual |
addResiduals(Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) | LinearFVFluxKernel | protected |
addResiduals(Assembly &assembly, const DenseVector< T > &residuals, const Indices &dof_indices, Real scaling_factor) | LinearFVFluxKernel | protected |
addResiduals(Assembly &assembly, const ADResidualsPacket &packet) | LinearFVFluxKernel | protected |
addResidualsAndJacobian(Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) | LinearFVFluxKernel | protected |
addResidualsAndJacobian(Assembly &assembly, const ADResidualsPacket &packet) | LinearFVFluxKernel | protected |
addResidualsAndJacobianWithoutConstraints(Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) | LinearFVFluxKernel | protected |
addResidualsWithoutConstraints(Assembly &assembly, const Residuals &residuals, const Indices &dof_indices, Real scaling_factor) | LinearFVFluxKernel | protected |
addRightHandSideContribution() override | LinearFVFluxKernel | virtual |
addUserObjectDependencyHelper(const UserObject &) const | LinearFVFluxKernel | protectedvirtual |
addVectorPostprocessorDependencyHelper(const VectorPostprocessorName &) const | LinearFVFluxKernel | protectedvirtual |
assignTaggedLocalMatrix() | LinearFVFluxKernel | protected |
assignTaggedLocalResidual() | LinearFVFluxKernel | protected |
blockIDs() const | LinearFVFluxKernel | virtual |
BlockRestrictable(const MooseObject *moose_object, bool initialize=true) | BlockRestrictable | |
BlockRestrictable(const MooseObject *moose_object, const std::set< BoundaryID > &boundary_ids) | BlockRestrictable | |
blockRestricted() const | LinearFVFluxKernel | virtual |
blocks() const | LinearFVFluxKernel | |
blocksMaxDimension() const | LinearFVFluxKernel | |
callMooseError(std::string msg, const bool with_prefix) const | LinearFVFluxKernel | |
checkAllVariables(const DofObjectType &dof_object, const std::set< MooseVariableFieldBase * > &vars_to_omit={}) | LinearFVFluxKernel | |
checkFunctorSupportsSideIntegration(const std::string &name, bool qp_integration) | LinearFVFluxKernel | protected |
checkVariable(const MooseVariableFieldBase &variable) const | LinearFVFluxKernel | virtual |
checkVariables(const DofObjectType &dof_object, const std::set< MooseVariableFieldBase * > &vars_to_check) | LinearFVFluxKernel | |
comm() const | libMesh::ParallelObject | |
computeBoundaryMatrixContribution(const LinearFVBoundaryCondition &bc) override | LinearFVScalarAdvection | virtual |
computeBoundaryRHSContribution(const LinearFVBoundaryCondition &bc) override | LinearFVScalarAdvection | virtual |
computeElemMatrixContribution() override | LinearFVScalarAdvection | virtual |
computeElemRightHandSideContribution() override | LinearFVScalarAdvection | virtual |
computeNeighborMatrixContribution() override | LinearFVScalarAdvection | virtual |
computeNeighborRightHandSideContribution() override | LinearFVScalarAdvection | virtual |
connectControllableParams(const std::string ¶meter, const std::string &object_type, const std::string &object_name, const std::string &object_parameter) const | LinearFVFluxKernel | |
ConsoleStreamInterface(MooseApp &app) | ConsoleStreamInterface | |
coupledPostprocessors(const std::string ¶m_name) const | LinearFVFluxKernel | |
customSetup(const ExecFlagType &) | LinearFVFluxKernel | virtual |
DataFileInterface(const ParallelParamObject &parent) | DataFileInterface | |
DataFileParameterType typedef | LinearFVFluxKernel | |
declareManagedRestartableDataWithContext(const std::string &data_name, void *context, Args &&... args) | LinearFVFluxKernel | protected |
declareRecoverableData(const std::string &data_name, Args &&... args) | LinearFVFluxKernel | protected |
declareRestartableData(const std::string &data_name, Args &&... args) | LinearFVFluxKernel | protected |
declareRestartableDataWithContext(const std::string &data_name, void *context, Args &&... args) | LinearFVFluxKernel | protected |
declareRestartableDataWithObjectName(const std::string &data_name, const std::string &object_name, Args &&... args) | LinearFVFluxKernel | protected |
declareRestartableDataWithObjectNameWithContext(const std::string &data_name, const std::string &object_name, void *context, Args &&... args) | LinearFVFluxKernel | protected |
deduceFunctorName(const std::string &name, const InputParameters ¶ms) | LinearFVFluxKernel | static |
deduceFunctorName(const std::string &name) const | LinearFVFluxKernel | protected |
determineState() const | LinearFVFluxKernel | |
dot() | LinearFVFluxKernel | protectedvirtual |
dotDot() | LinearFVFluxKernel | protectedvirtual |
dotDotDu() | LinearFVFluxKernel | protectedvirtual |
dotDotOld() | LinearFVFluxKernel | protectedvirtual |
dotDu() | LinearFVFluxKernel | protectedvirtual |
dotOld() | LinearFVFluxKernel | protectedvirtual |
enabled() const | LinearFVFluxKernel | virtual |
errorPrefix(const std::string &error_type) const | LinearFVFluxKernel | |
FunctionInterface(const MooseObject *moose_object) | FunctionInterface | |
FunctorInterface(const MooseObject *moose_object) | FunctorInterface | |
FVRelationshipManagerInterface() | FVRelationshipManagerInterface | |
getBlockCoordSystem() | LinearFVFluxKernel | protected |
getCheckedPointerParam(const std::string &name, const std::string &error_string="") const | LinearFVFluxKernel | |
getDataFileName(const std::string ¶m) const | LinearFVFluxKernel | |
getDataFileNameByName(const std::string &relative_path) const | LinearFVFluxKernel | |
getDataFilePath(const std::string &relative_path) const | LinearFVFluxKernel | |
getExecuteOnEnum() const | LinearFVFluxKernel | |
getFunction(const std::string &name) const | LinearFVFluxKernel | |
getFunctionByName(const FunctionName &name) const | LinearFVFluxKernel | |
getFunctor(const std::string &name) | LinearFVFluxKernel | protected |
getFunctor(const std::string &name, THREAD_ID tid) | LinearFVFluxKernel | protected |
getFunctor(const std::string &name, SubProblem &subproblem) | LinearFVFluxKernel | protected |
getFunctor(const std::string &name, SubProblem &subproblem, THREAD_ID tid) | LinearFVFluxKernel | protected |
getMasterSeed() const | LinearFVFluxKernel | |
getMatrixTags(MatrixTagsKey) const | LinearFVFluxKernel | |
getMooseApp() const | LinearFVFluxKernel | |
getMooseVariableDependencies() const | LinearFVFluxKernel | |
getParam(const std::string &name) const | LinearFVFluxKernel | |
getParam(const std::string ¶m1, const std::string ¶m2) const | LinearFVFluxKernel | |
getPostprocessorName(const std::string ¶m_name, const unsigned int index=0) const | LinearFVFluxKernel | |
getPostprocessorValue(const std::string ¶m_name, const unsigned int index=0) const | LinearFVFluxKernel | |
getPostprocessorValue(const std::string ¶m_name, const unsigned int index=0) const | LinearFVFluxKernel | |
getPostprocessorValueByName(const PostprocessorName &name) const | LinearFVFluxKernel | virtual |
getPostprocessorValueByName(const PostprocessorName &name) const | LinearFVFluxKernel | virtual |
getPostprocessorValueOld(const std::string ¶m_name, const unsigned int index=0) const | LinearFVFluxKernel | |
getPostprocessorValueOld(const std::string ¶m_name, const unsigned int index=0) const | LinearFVFluxKernel | |
getPostprocessorValueOldByName(const PostprocessorName &name) const | LinearFVFluxKernel | |
getPostprocessorValueOldByName(const PostprocessorName &name) const | LinearFVFluxKernel | |
getPostprocessorValueOlder(const std::string ¶m_name, const unsigned int index=0) const | LinearFVFluxKernel | |
getPostprocessorValueOlder(const std::string ¶m_name, const unsigned int index=0) const | LinearFVFluxKernel | |
getPostprocessorValueOlderByName(const PostprocessorName &name) const | LinearFVFluxKernel | |
getPostprocessorValueOlderByName(const PostprocessorName &name) const | LinearFVFluxKernel | |
getRandomLong() const | LinearFVFluxKernel | |
getRandomReal() const | LinearFVFluxKernel | |
getRenamedParam(const std::string &old_name, const std::string &new_name) const | LinearFVFluxKernel | |
getResetOnTime() const | LinearFVFluxKernel | |
getRestartableData(const std::string &data_name) const | LinearFVFluxKernel | protected |
getScatterVectorPostprocessorValue(const std::string ¶m_name, const std::string &vector_name) const | LinearFVFluxKernel | |
getScatterVectorPostprocessorValueByName(const VectorPostprocessorName &name, const std::string &vector_name) const | LinearFVFluxKernel | |
getScatterVectorPostprocessorValueOld(const std::string ¶m_name, const std::string &vector_name) const | LinearFVFluxKernel | |
getScatterVectorPostprocessorValueOldByName(const VectorPostprocessorName &name, const std::string &vector_name) const | LinearFVFluxKernel | |
getSeed(std::size_t id) | LinearFVFluxKernel | |
getSharedPtr() | LinearFVFluxKernel | |
getSharedPtr() const | LinearFVFluxKernel | |
getUserObject(const std::string ¶m_name, bool is_dependency=true) const | LinearFVFluxKernel | |
getUserObjectBase(const std::string ¶m_name, bool is_dependency=true) const | LinearFVFluxKernel | |
getUserObjectBaseByName(const UserObjectName &object_name, bool is_dependency=true) const | LinearFVFluxKernel | |
getUserObjectByName(const UserObjectName &object_name, bool is_dependency=true) const | LinearFVFluxKernel | |
getUserObjectName(const std::string ¶m_name) const | LinearFVFluxKernel | |
getVectorPostprocessorName(const std::string ¶m_name) const | LinearFVFluxKernel | |
getVectorPostprocessorValue(const std::string ¶m_name, const std::string &vector_name) const | LinearFVFluxKernel | |
getVectorPostprocessorValue(const std::string ¶m_name, const std::string &vector_name, bool needs_broadcast) const | LinearFVFluxKernel | |
getVectorPostprocessorValueByName(const VectorPostprocessorName &name, const std::string &vector_name) const | LinearFVFluxKernel | |
getVectorPostprocessorValueByName(const VectorPostprocessorName &name, const std::string &vector_name, bool needs_broadcast) const | LinearFVFluxKernel | |
getVectorPostprocessorValueOld(const std::string ¶m_name, const std::string &vector_name) const | LinearFVFluxKernel | |
getVectorPostprocessorValueOld(const std::string ¶m_name, const std::string &vector_name, bool needs_broadcast) const | LinearFVFluxKernel | |
getVectorPostprocessorValueOldByName(const VectorPostprocessorName &name, const std::string &vector_name) const | LinearFVFluxKernel | |
getVectorPostprocessorValueOldByName(const VectorPostprocessorName &name, const std::string &vector_name, bool needs_broadcast) const | LinearFVFluxKernel | |
getVectorTags(VectorTagsKey) const | LinearFVFluxKernel | |
gradient() | LinearFVFluxKernel | protectedvirtual |
gradientOld() | LinearFVFluxKernel | protectedvirtual |
gradientOlder() | LinearFVFluxKernel | protectedvirtual |
hasBlockMaterialProperty(const std::string &prop_name) | LinearFVFluxKernel | |
hasBlockMaterialPropertyHelper(const std::string &prop_name) | LinearFVFluxKernel | protectedvirtual |
hasBlocks(const SubdomainName &name) const | LinearFVFluxKernel | |
hasBlocks(const std::vector< SubdomainName > &names) const | LinearFVFluxKernel | |
hasBlocks(const std::set< SubdomainName > &names) const | LinearFVFluxKernel | |
hasBlocks(SubdomainID id) const | LinearFVFluxKernel | |
hasBlocks(const std::vector< SubdomainID > &ids) const | LinearFVFluxKernel | |
hasBlocks(const std::set< SubdomainID > &ids) const | LinearFVFluxKernel | |
hasFaceSide(const FaceInfo &fi, bool fi_elem_side) const override | LinearFVFluxKernel | virtual |
hasFunction(const std::string ¶m_name) const | LinearFVFluxKernel | |
hasFunctionByName(const FunctionName &name) const | LinearFVFluxKernel | |
hasPostprocessor(const std::string ¶m_name, const unsigned int index=0) const | LinearFVFluxKernel | |
hasPostprocessorByName(const PostprocessorName &name) const | LinearFVFluxKernel | |
hasUserObject(const std::string ¶m_name) const | LinearFVFluxKernel | |
hasUserObject(const std::string ¶m_name) const | LinearFVFluxKernel | |
hasUserObject(const std::string ¶m_name) const | LinearFVFluxKernel | |
hasUserObject(const std::string ¶m_name) const | LinearFVFluxKernel | |
hasUserObjectByName(const UserObjectName &object_name) const | LinearFVFluxKernel | |
hasUserObjectByName(const UserObjectName &object_name) const | LinearFVFluxKernel | |
hasUserObjectByName(const UserObjectName &object_name) const | LinearFVFluxKernel | |
hasUserObjectByName(const UserObjectName &object_name) const | LinearFVFluxKernel | |
hasVectorPostprocessor(const std::string ¶m_name, const std::string &vector_name) const | LinearFVFluxKernel | |
hasVectorPostprocessor(const std::string ¶m_name) const | LinearFVFluxKernel | |
hasVectorPostprocessorByName(const VectorPostprocessorName &name, const std::string &vector_name) const | LinearFVFluxKernel | |
hasVectorPostprocessorByName(const VectorPostprocessorName &name) const | LinearFVFluxKernel | |
hasVectorTags() const | LinearFVFluxKernel | |
initializeBlockRestrictable(const MooseObject *moose_object) | LinearFVFluxKernel | protected |
initialSetup() | LinearFVFluxKernel | virtual |
isBlockSubset(const std::set< SubdomainID > &ids) const | LinearFVFluxKernel | |
isBlockSubset(const std::vector< SubdomainID > &ids) const | LinearFVFluxKernel | |
isDefaultPostprocessorValue(const std::string ¶m_name, const unsigned int index=0) const | LinearFVFluxKernel | |
isFunctor(const std::string &name) const | LinearFVFluxKernel | protected |
isFunctor(const std::string &name, const SubProblem &subproblem) const | LinearFVFluxKernel | protected |
isImplicit() | LinearFVFluxKernel | |
isMatrixTagged() | LinearFVFluxKernel | |
isNodal() const | LinearFVFluxKernel | |
isParamSetByUser(const std::string &nm) const | LinearFVFluxKernel | |
isParamValid(const std::string &name) const | LinearFVFluxKernel | |
isVectorPostprocessorDistributed(const std::string ¶m_name) const | LinearFVFluxKernel | |
isVectorPostprocessorDistributed(const std::string ¶m_name) const | LinearFVFluxKernel | |
isVectorPostprocessorDistributedByName(const VectorPostprocessorName &name) const | LinearFVFluxKernel | |
isVectorPostprocessorDistributedByName(const VectorPostprocessorName &name) const | LinearFVFluxKernel | |
isVectorTagged() | LinearFVFluxKernel | |
jacobianSetup() | LinearFVFluxKernel | virtual |
LinearFVFluxKernel(const InputParameters ¶ms) | LinearFVFluxKernel | |
LinearFVKernel(const InputParameters ¶ms) | LinearFVKernel | |
LinearFVScalarAdvection(const InputParameters ¶ms) | LinearFVScalarAdvection | |
LinearSystemContributionObject(const InputParameters ¶meters) | LinearSystemContributionObject | |
linkTaggedVectorsAndMatrices(const std::set< TagID > &vector_tags, const std::set< TagID > &matrix_tags) | LinearFVFluxKernel | |
makeCDFace(const FaceInfo &fi, const bool correct_skewness=false) const | LinearFVFluxKernel | |
makeElemArg(const Elem *elem, bool correct_skewnewss=false) const | LinearFVFluxKernel | 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 | LinearFVFluxKernel | |
meshBlockIDs() const | LinearFVFluxKernel | |
meshChanged() | LinearFVFluxKernel | virtual |
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 | LinearFVFluxKernel | |
mooseDocumentedError(const std::string &repo_name, const unsigned int issue_num, Args &&... args) const | LinearFVFluxKernel | |
mooseError(Args &&... args) const | LinearFVFluxKernel | |
mooseErrorNonPrefixed(Args &&... args) const | LinearFVFluxKernel | |
mooseInfo(Args &&... args) const | LinearFVFluxKernel | |
mooseLinearVariableFV() const | LinearFVFluxKernel | |
MooseObject(const InputParameters ¶meters) | MooseObject | |
mooseVariable() const | LinearFVFluxKernel | |
mooseVariableBase() const | LinearFVFluxKernel | |
MooseVariableDependencyInterface(const MooseObject *) | MooseVariableDependencyInterface | |
mooseVariableField() | LinearFVFluxKernel | |
mooseVariableFV() const | LinearFVFluxKernel | |
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 | LinearFVFluxKernel | |
mooseWarningNonPrefixed(Args &&... args) const | LinearFVFluxKernel | |
n_processors() const | libMesh::ParallelObject | |
name() const | LinearFVFluxKernel | virtual |
NonADFunctorInterface(const MooseObject *moose_object) | NonADFunctorInterface | |
numBlocks() const | LinearFVFluxKernel | |
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 | LinearFVFluxKernel | |
parameters() const | LinearFVFluxKernel | |
paramInfo(const std::string ¶m, Args... args) const | LinearFVFluxKernel | |
paramWarning(const std::string ¶m, Args... args) const | LinearFVFluxKernel | |
PostprocessorInterface(const MooseObject *moose_object) | PostprocessorInterface | |
PostprocessorInterface(const FEProblemBase *problem) | PostprocessorInterface | |
prepareMatrixTag(Assembly &assembly, unsigned int ivar, unsigned int jvar) | LinearFVFluxKernel | protected |
prepareMatrixTag(Assembly &assembly, unsigned int ivar, unsigned int jvar, DenseMatrix< Number > &k) const | LinearFVFluxKernel | protected |
prepareMatrixTagLower(Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::ConstraintJacobianType type) | LinearFVFluxKernel | protected |
prepareMatrixTagNeighbor(Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::DGJacobianType type) | LinearFVFluxKernel | protected |
prepareMatrixTagNeighbor(Assembly &assembly, unsigned int ivar, unsigned int jvar, Moose::DGJacobianType type, DenseMatrix< Number > &k) const | LinearFVFluxKernel | protected |
prepareMatrixTagNonlocal(Assembly &assembly, unsigned int ivar, unsigned int jvar) | LinearFVFluxKernel | protected |
prepareVectorTag(Assembly &assembly, unsigned int ivar) | LinearFVFluxKernel | protected |
prepareVectorTag(Assembly &assembly, unsigned int ivar, ResidualTagType tag_type) | LinearFVFluxKernel | protected |
LinearFVKernel::prepareVectorTag(Assembly &assembly, unsigned int ivar, ResidualTagType tag_type) | LinearFVKernel | protected |
LinearSystemContributionObject::prepareVectorTag(Assembly &assembly, unsigned int ivar, ResidualTagType tag_type) | LinearSystemContributionObject | protected |
TaggingInterface::prepareVectorTag(Assembly &assembly, unsigned int ivar, ResidualTagType tag_type) | TaggingInterface | protected |
prepareVectorTagLower(Assembly &assembly, unsigned int ivar) | LinearFVFluxKernel | protected |
prepareVectorTagNeighbor(Assembly &assembly, unsigned int ivar) | LinearFVFluxKernel | protected |
processor_id() const | libMesh::ParallelObject | |
queryParam(const std::string &name) const | LinearFVFluxKernel | |
RandomInterface(const InputParameters ¶meters, FEProblemBase &problem, THREAD_ID tid, bool is_nodal) | RandomInterface | |
residualSetup() | LinearFVFluxKernel | virtual |
ResidualTagType enum name | LinearFVFluxKernel | |
Restartable(const MooseObject *moose_object, const std::string &system_name) | Restartable | |
Restartable(const MooseObject *moose_object, const std::string &system_name, THREAD_ID tid) | Restartable | |
Restartable(MooseApp &moose_app, const std::string &name, const std::string &system_name, THREAD_ID tid, const bool read_only=false, const RestartableDataMapName &metaname="") | Restartable | |
restartableName(const std::string &data_name) const | LinearFVFluxKernel | protected |
second() | LinearFVFluxKernel | protectedvirtual |
secondOld() | LinearFVFluxKernel | protectedvirtual |
secondOlder() | LinearFVFluxKernel | protectedvirtual |
secondPhi() | LinearFVFluxKernel | protectedvirtual |
secondPhiFace() | LinearFVFluxKernel | protectedvirtual |
secondTest() | LinearFVFluxKernel | protectedvirtual |
secondTestFace() | LinearFVFluxKernel | protectedvirtual |
setCurrentFaceArea(const Real area) | LinearFVFluxKernel | |
setRandomDataPointer(RandomData *random_data) | LinearFVFluxKernel | |
setRandomResetFrequency(ExecFlagType exec_flag) | LinearFVFluxKernel | |
setResidual(SystemBase &sys, const T &residual, MooseVariableFE< T > &var) | LinearFVFluxKernel | protected |
setResidual(SystemBase &sys, Real residual, dof_id_type dof_index) | LinearFVFluxKernel | protected |
setResidual(SystemBase &sys, SetResidualFunctor set_residual_functor) | LinearFVFluxKernel | protected |
setRMParamsAdvection(const InputParameters &obj_params, InputParameters &rm_params, const unsigned short conditional_extended_layers) | LinearFVFluxKernel | static |
setRMParamsDiffusion(const InputParameters &obj_params, InputParameters &rm_params, const unsigned short conditional_extended_layers) | LinearFVFluxKernel | static |
setupFaceData(const FaceInfo *face_info) override | LinearFVScalarAdvection | virtual |
SetupInterface(const MooseObject *moose_object) | SetupInterface | |
singleSidedFaceArg(const FaceInfo *fi, Moose::FV::LimiterType limiter_type=Moose::FV::LimiterType::CentralDifference, bool correct_skewness=false) const | LinearFVFluxKernel | protected |
subdomainSetup() | LinearFVFluxKernel | virtual |
TaggingInterface(const MooseObject *moose_object) | TaggingInterface | |
timestepSetup() | LinearFVFluxKernel | virtual |
TransientInterface(const MooseObject *moose_object) | TransientInterface | |
type() const | LinearFVFluxKernel | |
typeAndName() const | LinearFVFluxKernel | |
uniqueName() const | LinearFVFluxKernel | |
uniqueParameterName(const std::string ¶meter_name) const | LinearFVFluxKernel | |
useMatrixTag(const TagName &tag_name, MatrixTagsKey) | LinearFVFluxKernel | |
useMatrixTag(TagID tag_id, MatrixTagsKey) | LinearFVFluxKernel | |
UserObjectInterface(const MooseObject *moose_object) | UserObjectInterface | |
useVectorTag(const TagName &tag_name, VectorTagsKey) | LinearFVFluxKernel | |
useVectorTag(TagID tag_id, VectorTagsKey) | LinearFVFluxKernel | |
validParams() | LinearFVScalarAdvection | static |
value() | LinearFVFluxKernel | protectedvirtual |
valueOld() | LinearFVFluxKernel | protectedvirtual |
valueOlder() | LinearFVFluxKernel | protectedvirtual |
variable() const override | LinearFVFluxKernel | virtual |
VectorPostprocessorInterface(const MooseObject *moose_object, bool broadcast_by_default=false) | VectorPostprocessorInterface | |
~BlockRestrictable() | BlockRestrictable | 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 |
~RandomInterface() | RandomInterface | |
~SetupInterface() | SetupInterface | virtual |
~TaggingInterface() | TaggingInterface | virtual |
~TransientInterface() | TransientInterface | virtual |
~VectorPostprocessorInterface()=default | VectorPostprocessorInterface | virtual |