#include <DisplacedProblem.h>
Classes | |
class | UpdateDisplacedMeshThread |
Public Types | |
using | DataFileParameterType = DataFileName |
The parameter type this interface expects for a data file name. More... | |
Public Member Functions | |
DisplacedProblem (DisplacedProblem &&)=delete | |
DisplacedProblem & | operator= (DisplacedProblem &&)=delete |
DisplacedProblem (const InputParameters ¶meters) | |
~DisplacedProblem () | |
virtual EquationSystems & | es () override |
virtual MooseMesh & | mesh () override |
virtual const MooseMesh & | mesh () const override |
const MooseMesh & | mesh (bool libmesh_dbg_var(use_displaced)) const override |
MooseMesh & | refMesh () |
DisplacedSystem & | solverSys (const unsigned int sys_num) |
DisplacedSystem & | auxSys () |
virtual const SystemBase & | systemBaseNonlinear (const unsigned int sys_num) const override |
Return the nonlinear system object as a base class reference given the system number. More... | |
virtual SystemBase & | systemBaseNonlinear (const unsigned int sys_num) override |
virtual const SystemBase & | systemBaseLinear (const unsigned int sys_num) const override |
Return the linear system object as a base class reference given the system number. More... | |
virtual SystemBase & | systemBaseLinear (const unsigned int sys_num) override |
virtual const SystemBase & | systemBaseSolver (const unsigned int sys_num) const override |
Return the solver system object as a base class reference given the system number. More... | |
virtual SystemBase & | systemBaseSolver (const unsigned int sys_num) override |
virtual const SystemBase & | systemBaseAuxiliary () const override |
Return the auxiliary system object as a base class reference. More... | |
virtual SystemBase & | systemBaseAuxiliary () override |
const std::vector< std::string > & | getDisplacementVarNames () const |
virtual void | createQRules (QuadratureType type, Order order, Order volume_order, Order face_order, SubdomainID block, bool allow_negative_qweights=true) |
void | bumpVolumeQRuleOrder (Order order, SubdomainID block) |
void | bumpAllQRuleOrder (Order order, SubdomainID block) |
virtual void | init () override |
virtual bool | solverSystemConverged (const unsigned int solver_sys_num) override |
virtual unsigned int | nlSysNum (const NonlinearSystemName &nl_sys_name) const override |
virtual unsigned int | linearSysNum (const LinearSystemName &sys_name) const override |
virtual unsigned int | solverSysNum (const SolverSystemName &sys_name) const override |
void | addTimeIntegrator () |
Get the time integrators from the problem. More... | |
virtual void | saveOldSolutions () |
Allocate vectors and save old solutions into them. More... | |
virtual void | restoreOldSolutions () |
Restore old solutions from the backup vectors and deallocate them. More... | |
void | syncAuxSolution (const NumericVector< Number > &aux_soln) |
Copy the provided solution into the displaced auxiliary system. More... | |
void | syncSolutions () |
Copy the solutions on the undisplaced systems to the displaced systems. More... | |
void | syncSolutions (const std::map< unsigned int, const NumericVector< Number > *> &nl_solns, const NumericVector< Number > &aux_soln) |
Synchronize the solutions on the displaced systems to the given solutions. More... | |
virtual void | updateMesh (bool mesh_changing=false) |
Copy the solutions on the undisplaced systems to the displaced systems and reinitialize the geometry search data and Dirac kernel information due to mesh displacement. More... | |
virtual void | updateMesh (const std::map< unsigned int, const NumericVector< Number > *> &nl_soln, const NumericVector< Number > &aux_soln) |
Synchronize the solutions on the displaced systems to the given solutions and reinitialize the geometry search data and Dirac kernel information due to mesh displacement. More... | |
virtual TagID | addVectorTag (const TagName &tag_name, const Moose::VectorTagType type=Moose::VECTOR_TAG_RESIDUAL) override |
Create a Tag. More... | |
virtual const VectorTag & | getVectorTag (const TagID tag_id) const override |
Get a VectorTag from a TagID. More... | |
virtual TagID | getVectorTagID (const TagName &tag_name) const override |
Get a TagID from a TagName. More... | |
virtual TagName | vectorTagName (const TagID tag_id) const override |
Retrieve the name associated with a TagID. More... | |
virtual bool | vectorTagExists (const TagID tag_id) const override |
Check to see if a particular Tag exists. More... | |
virtual bool | vectorTagExists (const TagName &tag_name) const override |
Check to see if a particular Tag exists by using Tag name. More... | |
virtual unsigned int | numVectorTags (const Moose::VectorTagType type=Moose::VECTOR_TAG_ANY) const override |
The total number of tags, which can be limited to the tag type. More... | |
virtual const std::vector< VectorTag > & | getVectorTags (const Moose::VectorTagType type=Moose::VECTOR_TAG_ANY) const override |
Return all vector tags, where a tag is represented by a map from name to ID. More... | |
virtual Moose::VectorTagType | vectorTagType (const TagID tag_id) const override |
virtual TagID | addMatrixTag (TagName tag_name) override |
Create a Tag. More... | |
virtual TagID | getMatrixTagID (const TagName &tag_name) const override |
Get a TagID from a TagName. More... | |
virtual TagName | matrixTagName (TagID tag) override |
Retrieve the name associated with a TagID. More... | |
virtual bool | matrixTagExists (const TagName &tag_name) const override |
Check to see if a particular Tag exists. More... | |
virtual bool | matrixTagExists (TagID tag_id) const override |
Check to see if a particular Tag exists. More... | |
virtual unsigned int | numMatrixTags () const override |
The total number of tags. More... | |
virtual bool | safeAccessTaggedMatrices () const override |
Is it safe to access the tagged matrices. More... | |
virtual bool | safeAccessTaggedVectors () const override |
Is it safe to access the tagged vectors. More... | |
virtual bool | isTransient () const override |
virtual bool | hasVariable (const std::string &var_name) const override |
Whether or not this problem has the variable. More... | |
virtual const MooseVariableFieldBase & | getVariable (const THREAD_ID tid, const std::string &var_name, Moose::VarKindType expected_var_type=Moose::VarKindType::VAR_ANY, Moose::VarFieldType expected_var_field_type=Moose::VarFieldType::VAR_FIELD_ANY) const override |
Returns the variable reference for requested variable which must be of the expected_var_type (Nonlinear vs. More... | |
virtual MooseVariable & | getStandardVariable (const THREAD_ID tid, const std::string &var_name) override |
Returns the variable reference for requested MooseVariable which may be in any system. More... | |
virtual MooseVariableFieldBase & | getActualFieldVariable (const THREAD_ID tid, const std::string &var_name) override |
Returns the variable reference for requested MooseVariableField which may be in any system. More... | |
virtual VectorMooseVariable & | getVectorVariable (const THREAD_ID tid, const std::string &var_name) override |
Returns the variable reference for requested VectorMooseVariable which may be in any system. More... | |
virtual ArrayMooseVariable & | getArrayVariable (const THREAD_ID tid, const std::string &var_name) override |
Returns the variable reference for requested ArrayMooseVariable which may be in any system. More... | |
virtual bool | hasScalarVariable (const std::string &var_name) const override |
Returns a Boolean indicating whether any system contains a variable with the name provided. More... | |
virtual MooseVariableScalar & | getScalarVariable (const THREAD_ID tid, const std::string &var_name) override |
Returns the scalar variable reference from whichever system contains it. More... | |
virtual System & | getSystem (const std::string &var_name) override |
Returns the equation system containing the variable provided. More... | |
virtual void | addVariable (const std::string &var_type, const std::string &name, InputParameters ¶meters, unsigned int nl_system_number) |
virtual void | addAuxVariable (const std::string &var_type, const std::string &name, InputParameters ¶meters) |
virtual void | initAdaptivity () |
void | meshChanged (bool contract_mesh, bool clean_refinement_flags) |
virtual void | prepare (const Elem *elem, const THREAD_ID tid) override |
virtual void | prepareNonlocal (const THREAD_ID tid) |
virtual void | prepareFace (const Elem *elem, const THREAD_ID tid) override |
virtual void | prepare (const Elem *elem, unsigned int ivar, unsigned int jvar, const std::vector< dof_id_type > &dof_indices, const THREAD_ID tid) override |
virtual void | setCurrentSubdomainID (const Elem *elem, const THREAD_ID tid) override |
virtual void | setNeighborSubdomainID (const Elem *elem, unsigned int side, const THREAD_ID tid) override |
virtual void | prepareBlockNonlocal (unsigned int ivar, unsigned int jvar, const std::vector< dof_id_type > &idof_indices, const std::vector< dof_id_type > &jdof_indices, const THREAD_ID tid) |
virtual void | prepareAssembly (const THREAD_ID tid) override |
virtual void | prepareAssemblyNeighbor (const THREAD_ID tid) |
virtual bool | reinitDirac (const Elem *elem, const THREAD_ID tid) override |
Returns true if the Problem has Dirac kernels it needs to compute on elem. More... | |
virtual void | reinitElem (const Elem *elem, const THREAD_ID tid) override |
virtual void | reinitElemPhys (const Elem *elem, const std::vector< Point > &phys_points_in_elem, const THREAD_ID tid) override |
virtual void | reinitElemFace (const Elem *elem, unsigned int side, const THREAD_ID tid) override |
virtual void | reinitNode (const Node *node, const THREAD_ID tid) override |
virtual void | reinitNodeFace (const Node *node, BoundaryID bnd_id, const THREAD_ID tid) override |
virtual void | reinitNodes (const std::vector< dof_id_type > &nodes, const THREAD_ID tid) override |
virtual void | reinitNodesNeighbor (const std::vector< dof_id_type > &nodes, const THREAD_ID tid) override |
virtual void | reinitNeighbor (const Elem *elem, unsigned int side, const THREAD_ID tid) override |
void | reinitNeighbor (const Elem *elem, unsigned int side, const THREAD_ID tid, const std::vector< Point > *neighbor_reference_points) |
reinitialize neighbor routine More... | |
virtual void | reinitNeighborPhys (const Elem *neighbor, unsigned int neighbor_side, const std::vector< Point > &physical_points, const THREAD_ID tid) override |
virtual void | reinitNeighborPhys (const Elem *neighbor, const std::vector< Point > &physical_points, const THREAD_ID tid) override |
virtual void | reinitElemNeighborAndLowerD (const Elem *elem, unsigned int side, const THREAD_ID tid) override |
virtual void | reinitScalars (const THREAD_ID tid, bool reinit_for_derivative_reordering=false) override |
fills the VariableValue arrays for scalar variables from the solution vector More... | |
virtual void | reinitOffDiagScalars (const THREAD_ID tid) override |
virtual void | getDiracElements (std::set< const Elem *> &elems) override |
Fills "elems" with the elements that should be looped over for Dirac Kernels. More... | |
virtual void | clearDiracInfo () override |
Gets called before Dirac Kernels are asked to add the points they are supposed to be evaluated in. More... | |
virtual void | addResidual (const THREAD_ID tid) override |
virtual void | addResidualNeighbor (const THREAD_ID tid) override |
virtual void | addResidualLower (const THREAD_ID tid) override |
virtual void | addCachedResidualDirectly (NumericVector< Number > &residual, const THREAD_ID tid) |
virtual void | setResidual (NumericVector< Number > &residual, const THREAD_ID tid) override |
virtual void | setResidualNeighbor (NumericVector< Number > &residual, const THREAD_ID tid) override |
virtual void | addJacobian (const THREAD_ID tid) override |
virtual void | addJacobianNonlocal (const THREAD_ID tid) |
virtual void | addJacobianNeighbor (const THREAD_ID tid) override |
virtual void | addJacobianNeighborLowerD (const THREAD_ID tid) override |
virtual void | addJacobianLowerD (const THREAD_ID tid) override |
virtual void | addJacobianBlockTags (SparseMatrix< Number > &jacobian, unsigned int ivar, unsigned int jvar, const libMesh::DofMap &dof_map, std::vector< dof_id_type > &dof_indices, const std::set< TagID > &tags, const THREAD_ID tid) |
void | addJacobianBlockNonlocal (SparseMatrix< Number > &jacobian, unsigned int ivar, unsigned int jvar, const libMesh::DofMap &dof_map, const std::vector< dof_id_type > &idof_indices, const std::vector< dof_id_type > &jdof_indices, const std::set< TagID > &tags, const THREAD_ID tid) |
virtual void | addJacobianNeighbor (SparseMatrix< Number > &jacobian, unsigned int ivar, unsigned int jvar, const libMesh::DofMap &dof_map, std::vector< dof_id_type > &dof_indices, std::vector< dof_id_type > &neighbor_dof_indices, const std::set< TagID > &tags, const THREAD_ID tid) override |
virtual void | cacheJacobianNonlocal (const THREAD_ID tid) |
virtual void | prepareShapes (unsigned int var, const THREAD_ID tid) override |
virtual void | prepareFaceShapes (unsigned int var, const THREAD_ID tid) override |
virtual void | prepareNeighborShapes (unsigned int var, const THREAD_ID tid) override |
virtual Assembly & | assembly (const THREAD_ID tid, const unsigned int sys_num) override |
virtual const Assembly & | assembly (const THREAD_ID tid, const unsigned int sys_num) const override |
virtual void | updateGeomSearch (GeometricSearchData::GeometricSearchType type=GeometricSearchData::ALL) override |
virtual GeometricSearchData & | geomSearchData () override |
virtual bool | computingPreSMOResidual (const unsigned int nl_sys_num) const override |
Returns true if the problem is in the process of computing it's initial residual. More... | |
virtual void | onTimestepBegin () override |
virtual void | onTimestepEnd () override |
virtual std::set< dof_id_type > & | ghostedElems () override |
Return the list of elements that should have their DoFs ghosted to this processor. More... | |
virtual void | addGhostedElem (dof_id_type elem_id) override |
Will make sure that all dofs connected to elem_id are ghosted to this processor. More... | |
virtual void | addGhostedBoundary (BoundaryID boundary_id) override |
Will make sure that all necessary elements from boundary_id are ghosted to this processor. More... | |
virtual void | ghostGhostedBoundaries () override |
Causes the boundaries added using addGhostedBoundary to actually be ghosted. More... | |
void | undisplaceMesh () |
Resets the displaced mesh to the reference mesh. More... | |
virtual LineSearch * | getLineSearch () override |
virtual const CouplingMatrix * | couplingMatrix (const unsigned int nl_sys_num) const override |
The coupling matrix defining what blocks exist in the preconditioning matrix. More... | |
virtual bool | haveDisplaced () const override final |
Whether we have a displaced problem in our simulation. More... | |
virtual bool | computingScalingJacobian () const override final |
Getter for whether we're computing the scaling jacobian. More... | |
virtual bool | computingScalingResidual () const override final |
Getter for whether we're computing the scaling residual. More... | |
virtual void | initialSetup () override |
virtual void | timestepSetup () override |
virtual void | customSetup (const ExecFlagType &exec_type) override |
virtual void | residualSetup () override |
virtual void | jacobianSetup () override |
virtual void | haveADObjects (bool have_ad_objects) override |
Method for setting whether we have any ad objects. More... | |
virtual std::size_t | numNonlinearSystems () const override |
virtual std::size_t | numLinearSystems () const override |
virtual std::size_t | numSolverSystems () const override |
virtual unsigned int | currentNlSysNum () const override |
virtual unsigned int | currentLinearSysNum () const override |
virtual const std::vector< VectorTag > & | currentResidualVectorTags () const override |
Return the residual vector tags we are currently computing. More... | |
virtual void | needFV () override |
marks this problem as including/needing finite volume functionality. More... | |
virtual bool | haveFV () const override |
returns true if this problem includes/needs finite volume functionality. More... | |
virtual bool | hasNonlocalCoupling () const override |
Whether the simulation has active nonlocal coupling which should be accounted for in the Jacobian. More... | |
virtual bool | checkNonlocalCouplingRequirement () const override |
virtual const libMesh::CouplingMatrix & | nonlocalCouplingMatrix (const unsigned i) const override |
virtual const MooseVariableFieldBase & | getVariable (const THREAD_ID tid, const std::string &var_name, Moose::VarKindType expected_var_type=Moose::VarKindType::VAR_ANY, Moose::VarFieldType expected_var_field_type=Moose::VarFieldType::VAR_FIELD_ANY) const=0 |
Returns the variable reference for requested variable which must be of the expected_var_type (Nonlinear vs. More... | |
virtual MooseVariableFieldBase & | getVariable (const THREAD_ID tid, const std::string &var_name, Moose::VarKindType expected_var_type=Moose::VarKindType::VAR_ANY, Moose::VarFieldType expected_var_field_type=Moose::VarFieldType::VAR_FIELD_ANY) |
virtual void | haveADObjects (bool have_ad_objects) |
Method for setting whether we have any ad objects. More... | |
bool | haveADObjects () const |
Method for reading wehther we have any ad objects. More... | |
virtual const MooseMesh & | mesh (bool use_displaced) const =0 |
virtual bool | nlConverged (const unsigned int nl_sys_num) |
virtual bool | converged (const unsigned int sys_num) |
Eventually we want to convert this virtual over to taking a solver system number argument. More... | |
bool | defaultGhosting () |
Whether or not the user has requested default ghosting ot be on. More... | |
void | addNotZeroedVectorTag (const TagID tag) |
Adds a vector tag to the list of vectors that will not be zeroed when other tagged vectors are. More... | |
bool | vectorTagNotZeroed (const TagID tag) const |
Checks if a vector tag is in the list of vectors that will not be zeroed when other tagged vectors are. More... | |
std::vector< VectorTag > | getVectorTags (const std::set< TagID > &tag_ids) const |
virtual std::map< TagName, TagID > & | getMatrixTags () |
Return all matrix tags in the system, where a tag is represented by a map from name to ID. More... | |
virtual bool | hasLinearVariable (const std::string &var_name) const |
Whether or not this problem has this linear variable. More... | |
virtual bool | hasAuxiliaryVariable (const std::string &var_name) const |
Whether or not this problem has this auxiliary variable. More... | |
virtual MooseVariableFieldBase & | getVariable (const THREAD_ID tid, const std::string &var_name, Moose::VarKindType expected_var_type=Moose::VarKindType::VAR_ANY, Moose::VarFieldType expected_var_field_type=Moose::VarFieldType::VAR_FIELD_ANY) |
virtual void | setActiveElementalMooseVariables (const std::set< MooseVariableFieldBase *> &moose_vars, const THREAD_ID tid) |
Set the MOOSE variables to be reinited on each element. More... | |
virtual const std::set< MooseVariableFieldBase * > & | getActiveElementalMooseVariables (const THREAD_ID tid) const |
Get the MOOSE variables to be reinited on each element. More... | |
virtual bool | hasActiveElementalMooseVariables (const THREAD_ID tid) const |
Whether or not a list of active elemental moose variables has been set. More... | |
virtual void | clearActiveElementalMooseVariables (const THREAD_ID tid) |
Clear the active elemental MooseVariableFieldBase. More... | |
Moose::CoordinateSystemType | getCoordSystem (SubdomainID sid) const |
unsigned int | getAxisymmetricRadialCoord () const |
Returns the desired radial direction for RZ coordinate transformation. More... | |
virtual DiracKernelInfo & | diracKernelInfo () |
virtual Real | finalNonlinearResidual (const unsigned int nl_sys_num) const |
virtual unsigned int | nNonlinearIterations (const unsigned int nl_sys_num) const |
virtual unsigned int | nLinearIterations (const unsigned int nl_sys_num) const |
virtual void | cacheResidual (const THREAD_ID tid) |
virtual void | cacheResidualNeighbor (const THREAD_ID tid) |
virtual void | addCachedResidual (const THREAD_ID tid) |
virtual void | setResidual (libMesh::NumericVector< libMesh::Number > &residual, const THREAD_ID tid)=0 |
virtual void | setResidualNeighbor (libMesh::NumericVector< libMesh::Number > &residual, const THREAD_ID tid)=0 |
virtual void | cacheJacobian (const THREAD_ID tid) |
virtual void | cacheJacobianNeighbor (const THREAD_ID tid) |
virtual void | addCachedJacobian (const THREAD_ID tid) |
virtual void | reinitLowerDElem (const Elem *lower_d_elem, const THREAD_ID tid, const std::vector< Point > *const pts=nullptr, const std::vector< Real > *const weights=nullptr) |
virtual void | setCurrentBoundaryID (BoundaryID bid, const THREAD_ID tid) |
sets the current boundary ID in assembly More... | |
virtual void | reinitElemFaceRef (const Elem *elem, unsigned int side, Real tolerance, const std::vector< Point > *const pts, const std::vector< Real > *const weights=nullptr, const THREAD_ID tid=0) |
reinitialize FE objects on a given element on a given side at a given set of reference points and then compute variable data. More... | |
virtual void | reinitNeighborFaceRef (const Elem *neighbor_elem, unsigned int neighbor_side, Real tolerance, const std::vector< Point > *const pts, const std::vector< Real > *const weights=nullptr, const THREAD_ID tid=0) |
reinitialize FE objects on a given neighbor element on a given side at a given set of reference points and then compute variable data. More... | |
void | reinitNeighborLowerDElem (const Elem *elem, const THREAD_ID tid=0) |
reinitialize a neighboring lower dimensional element More... | |
void | reinitMortarElem (const Elem *elem, const THREAD_ID tid=0) |
Reinit a mortar element to obtain a valid JxW. More... | |
virtual void | storeSubdomainMatPropName (SubdomainID block_id, const std::string &name) |
Adds the given material property to a storage map based on block ids. More... | |
virtual void | storeBoundaryMatPropName (BoundaryID boundary_id, const std::string &name) |
Adds the given material property to a storage map based on boundary ids. More... | |
virtual void | storeSubdomainZeroMatProp (SubdomainID block_id, const MaterialPropertyName &name) |
Adds to a map based on block ids of material properties for which a zero value can be returned. More... | |
virtual void | storeBoundaryZeroMatProp (BoundaryID boundary_id, const MaterialPropertyName &name) |
Adds to a map based on boundary ids of material properties for which a zero value can be returned. More... | |
virtual void | storeSubdomainDelayedCheckMatProp (const std::string &requestor, SubdomainID block_id, const std::string &name) |
Adds to a map based on block ids of material properties to validate. More... | |
virtual void | storeBoundaryDelayedCheckMatProp (const std::string &requestor, BoundaryID boundary_id, const std::string &name) |
Adds to a map based on boundary ids of material properties to validate. More... | |
virtual void | checkBlockMatProps () |
Checks block material properties integrity. More... | |
virtual void | checkBoundaryMatProps () |
Checks boundary material properties integrity. More... | |
virtual void | markMatPropRequested (const std::string &) |
Helper method for adding a material property name to the _material_property_requested set. More... | |
virtual bool | isMatPropRequested (const std::string &prop_name) const |
Find out if a material property has been requested by any object. More... | |
void | addConsumedPropertyName (const MooseObjectName &obj_name, const std::string &prop_name) |
Helper for tracking the object that is consuming a property for MaterialPropertyDebugOutput. More... | |
const std::map< MooseObjectName, std::set< std::string > > & | getConsumedPropertyMap () const |
Return the map that tracks the object with consumed material properties. More... | |
virtual std::set< SubdomainID > | getMaterialPropertyBlocks (const std::string &prop_name) |
Get a vector containing the block ids the material property is defined on. More... | |
virtual std::vector< SubdomainName > | getMaterialPropertyBlockNames (const std::string &prop_name) |
Get a vector of block id equivalences that the material property is defined on. More... | |
virtual bool | hasBlockMaterialProperty (SubdomainID block_id, const std::string &prop_name) |
Check if a material property is defined on a block. More... | |
virtual std::set< BoundaryID > | getMaterialPropertyBoundaryIDs (const std::string &prop_name) |
Get a vector containing the block ids the material property is defined on. More... | |
virtual std::vector< BoundaryName > | getMaterialPropertyBoundaryNames (const std::string &prop_name) |
Get a vector of block id equivalences that the material property is defined on. More... | |
virtual bool | hasBoundaryMaterialProperty (BoundaryID boundary_id, const std::string &prop_name) |
Check if a material property is defined on a block. More... | |
const bool & | currentlyComputingJacobian () const |
Returns true if the problem is in the process of computing the Jacobian. More... | |
void | setCurrentlyComputingJacobian (const bool currently_computing_jacobian) |
Set whether or not the problem is in the process of computing the Jacobian. More... | |
const bool & | currentlyComputingResidualAndJacobian () const |
Returns true if the problem is in the process of computing the residual and the Jacobian. More... | |
void | setCurrentlyComputingResidualAndJacobian (bool currently_computing_residual_and_jacobian) |
Set whether or not the problem is in the process of computing the Jacobian. More... | |
bool | computingNonlinearResid () const |
Returns true if the problem is in the process of computing the nonlinear residual. More... | |
virtual void | computingNonlinearResid (const bool computing_nonlinear_residual) |
Set whether or not the problem is in the process of computing the nonlinear residual. More... | |
const bool & | currentlyComputingResidual () const |
Returns true if the problem is in the process of computing the residual. More... | |
virtual void | setCurrentlyComputingResidual (const bool currently_computing_residual) |
Set whether or not the problem is in the process of computing the residual. More... | |
virtual void | clearActiveFEVariableCoupleableMatrixTags (const THREAD_ID tid) |
virtual void | clearActiveFEVariableCoupleableVectorTags (const THREAD_ID tid) |
virtual void | setActiveFEVariableCoupleableVectorTags (std::set< TagID > &vtags, const THREAD_ID tid) |
virtual void | setActiveFEVariableCoupleableMatrixTags (std::set< TagID > &mtags, const THREAD_ID tid) |
virtual void | clearActiveScalarVariableCoupleableMatrixTags (const THREAD_ID tid) |
virtual void | clearActiveScalarVariableCoupleableVectorTags (const THREAD_ID tid) |
virtual void | setActiveScalarVariableCoupleableVectorTags (std::set< TagID > &vtags, const THREAD_ID tid) |
virtual void | setActiveScalarVariableCoupleableMatrixTags (std::set< TagID > &mtags, const THREAD_ID tid) |
const std::set< TagID > & | getActiveScalarVariableCoupleableVectorTags (const THREAD_ID tid) const |
const std::set< TagID > & | getActiveScalarVariableCoupleableMatrixTags (const THREAD_ID tid) const |
const std::set< TagID > & | getActiveFEVariableCoupleableVectorTags (const THREAD_ID tid) const |
const std::set< TagID > & | getActiveFEVariableCoupleableMatrixTags (const THREAD_ID tid) const |
bool | haveADObjects () const |
Method for reading wehther we have any ad objects. More... | |
void | addAlgebraicGhostingFunctor (libMesh::GhostingFunctor &algebraic_gf, bool to_mesh=true) |
Add an algebraic ghosting functor to this problem's DofMaps. More... | |
void | addCouplingGhostingFunctor (libMesh::GhostingFunctor &coupling_gf, bool to_mesh=true) |
Add a coupling functor to this problem's DofMaps. More... | |
void | removeAlgebraicGhostingFunctor (libMesh::GhostingFunctor &algebraic_gf) |
Remove an algebraic ghosting functor from this problem's DofMaps. More... | |
void | removeCouplingGhostingFunctor (libMesh::GhostingFunctor &coupling_gf) |
Remove a coupling ghosting functor from this problem's DofMaps. More... | |
virtual void | automaticScaling (bool automatic_scaling) |
Automatic scaling setter. More... | |
bool | automaticScaling () const |
Automatic scaling getter. More... | |
void | hasScalingVector (const unsigned int nl_sys_num) |
Tells this problem that the assembly associated with the given nonlinear system number involves a scaling vector. More... | |
void | clearAllDofIndices () |
Clear dof indices from variables in nl and aux systems. More... | |
template<typename T > | |
const Moose::Functor< T > & | getFunctor (const std::string &name, const THREAD_ID tid, const std::string &requestor_name, bool requestor_is_ad) |
bool | hasFunctor (const std::string &name, const THREAD_ID tid) const |
checks whether we have a functor corresponding to name on the thread id tid More... | |
template<typename T > | |
bool | hasFunctorWithType (const std::string &name, const THREAD_ID tid) const |
checks whether we have a functor of type T corresponding to name on the thread id tid More... | |
template<typename T > | |
void | addFunctor (const std::string &name, const Moose::FunctorBase< T > &functor, const THREAD_ID tid) |
add a functor to the problem functor container More... | |
template<typename T , typename PolymorphicLambda > | |
const Moose::FunctorBase< T > & | addPiecewiseByBlockLambdaFunctor (const std::string &name, PolymorphicLambda my_lammy, const std::set< ExecFlagType > &clearance_schedule, const MooseMesh &mesh, const std::set< SubdomainID > &block_ids, const THREAD_ID tid) |
Add a functor that has block-wise lambda definitions, e.g. More... | |
void | setFunctorOutput (bool set_output) |
Setter for debug functor output. More... | |
template<typename T > | |
void | registerUnfilledFunctorRequest (T *functor_interface, const std::string &functor_name, const THREAD_ID tid) |
Register an unfulfilled functor request. More... | |
void | reinitFVFace (const THREAD_ID tid, const FaceInfo &fi) |
reinitialize the finite volume assembly data for the provided face and thread More... | |
void | preparePRefinement () |
Prepare DofMap and Assembly classes with our p-refinement information. More... | |
bool | doingPRefinement () const |
bool | havePRefinement () const |
Query whether p-refinement has been requested at any point during the simulation. More... | |
virtual void | setCurrentLowerDElem (const Elem *const lower_d_elem, const THREAD_ID tid) |
Set the current lower dimensional element. More... | |
template<typename T > | |
MooseVariableFEBase & | getVariableHelper (const THREAD_ID tid, const std::string &var_name, Moose::VarKindType expected_var_type, Moose::VarFieldType expected_var_field_type, const std::vector< T > &systems, const SystemBase &aux) const |
void | _setCLIOption () |
For Internal Use. More... | |
virtual void | terminateSolve () |
Allow objects to request clean termination of the solve. More... | |
virtual bool | isSolveTerminationRequested () const |
Check of termination has been requested. More... | |
const ConsoleStream & | console () const |
Return console handle. More... | |
virtual bool | enabled () const |
Return the enabled status of the object. More... | |
std::shared_ptr< MooseObject > | getSharedPtr () |
Get another shared pointer to this object that has the same ownership group. More... | |
std::shared_ptr< const MooseObject > | getSharedPtr () const |
MooseApp & | getMooseApp () const |
Get the MooseApp this class is associated with. More... | |
const std::string & | type () const |
Get the type of this class. More... | |
virtual const std::string & | name () const |
Get the name of the class. More... | |
std::string | typeAndName () const |
Get the class's combined type and name; useful in error handling. More... | |
std::string | errorPrefix (const std::string &error_type) const |
void | callMooseError (std::string msg, const bool with_prefix) const |
Calls moose error with the message msg . More... | |
MooseObjectParameterName | uniqueParameterName (const std::string ¶meter_name) const |
The unique parameter name of a valid parameter of this object for accessing parameter controls. More... | |
const InputParameters & | parameters () const |
Get the parameters of the object. More... | |
MooseObjectName | uniqueName () const |
The unique name for accessing input parameters of this object in the InputParameterWarehouse. More... | |
template<typename T > | |
const T & | getParam (const std::string &name) const |
Retrieve a parameter for the object. More... | |
template<typename T1 , typename T2 > | |
std::vector< std::pair< T1, T2 > > | getParam (const std::string ¶m1, const std::string ¶m2) const |
Retrieve two parameters and provide pair of parameters for the object. More... | |
template<typename T > | |
const T * | queryParam (const std::string &name) const |
Query a parameter for the object. More... | |
template<typename T > | |
const T & | getRenamedParam (const std::string &old_name, const std::string &new_name) const |
Retrieve a renamed parameter for the object. More... | |
template<typename T > | |
T | getCheckedPointerParam (const std::string &name, const std::string &error_string="") const |
Verifies that the requested parameter exists and is not NULL and returns it to the caller. More... | |
bool | isParamValid (const std::string &name) const |
Test if the supplied parameter is valid. More... | |
bool | isParamSetByUser (const std::string &nm) const |
Test if the supplied parameter is set by a user, as opposed to not set or set to default. More... | |
template<typename... Args> | |
void | paramError (const std::string ¶m, Args... args) const |
Emits an error prefixed with the file and line number of the given param (from the input file) along with the full parameter path+name followed by the given args as the message. More... | |
template<typename... Args> | |
void | paramWarning (const std::string ¶m, Args... args) const |
Emits a warning prefixed with the file and line number of the given param (from the input file) along with the full parameter path+name followed by the given args as the message. More... | |
template<typename... Args> | |
void | paramInfo (const std::string ¶m, Args... args) const |
Emits an informational message prefixed with the file and line number of the given param (from the input file) along with the full parameter path+name followed by the given args as the message. More... | |
void | connectControllableParams (const std::string ¶meter, const std::string &object_type, const std::string &object_name, const std::string &object_parameter) const |
Connect controllable parameter of this action with the controllable parameters of the objects added by this action. More... | |
template<typename... Args> | |
void | mooseError (Args &&... args) const |
Emits an error prefixed with object name and type. More... | |
template<typename... Args> | |
void | mooseErrorNonPrefixed (Args &&... args) const |
Emits an error without the prefixing included in mooseError(). More... | |
template<typename... Args> | |
void | mooseDocumentedError (const std::string &repo_name, const unsigned int issue_num, Args &&... args) const |
Emits a documented error with object name and type. More... | |
template<typename... Args> | |
void | mooseWarning (Args &&... args) const |
Emits a warning prefixed with object name and type. More... | |
template<typename... Args> | |
void | mooseWarningNonPrefixed (Args &&... args) const |
Emits a warning without the prefixing included in mooseWarning(). More... | |
template<typename... Args> | |
void | mooseDeprecated (Args &&... args) const |
template<typename... Args> | |
void | mooseInfo (Args &&... args) const |
const Parallel::Communicator & | comm () const |
processor_id_type | n_processors () const |
processor_id_type | processor_id () const |
std::string | getDataFileName (const std::string ¶m) const |
Deprecated method. More... | |
std::string | getDataFileNameByName (const std::string &relative_path) const |
Deprecated method. More... | |
std::string | getDataFilePath (const std::string &relative_path) const |
Returns the path of a data file for a given relative file path. More... | |
PerfGraph & | perfGraph () |
Get the PerfGraph. More... | |
Static Public Member Functions | |
static InputParameters | validParams () |
static void | selectVectorTagsFromSystem (const SystemBase &system, const std::vector< VectorTag > &input_vector_tags, std::set< TagID > &selected_tags) |
Select the vector tags which belong to a specific system. More... | |
static void | selectMatrixTagsFromSystem (const SystemBase &system, const std::map< TagName, TagID > &input_matrix_tags, std::set< TagID > &selected_tags) |
Select the matrix tags which belong to a specific system. More... | |
Public Attributes | |
std::map< std::string, std::vector< dof_id_type > > | _var_dof_map |
const ConsoleStream | _console |
An instance of helper class to write streams to the Console objects. More... | |
Protected Member Functions | |
template<typename T > | |
MooseVariableFieldBase & | getVariableHelper (const THREAD_ID tid, const std::string &var_name, Moose::VarKindType expected_var_type, Moose::VarFieldType expected_var_field_type, const std::vector< T > &nls, const SystemBase &aux) const |
Helper function called by getVariable that handles the logic for checking whether Variables of the requested type are available. More... | |
bool | verifyVectorTags () const |
Verify the integrity of _vector_tags and _typed_vector_tags. More... | |
void | markFamilyPRefinement (const InputParameters ¶ms) |
Mark a variable family for either disabling or enabling p-refinement with valid parameters of a variable. More... | |
PerfID | registerTimedSection (const std::string §ion_name, const unsigned int level) const |
Call to register a named section for timing. More... | |
PerfID | registerTimedSection (const std::string §ion_name, const unsigned int level, const std::string &live_message, const bool print_dots=true) const |
Call to register a named section for timing. More... | |
std::string | timedSectionName (const std::string §ion_name) const |
Protected Attributes | |
FEProblemBase & | _mproblem |
MooseMesh & | _mesh |
EquationSystems | _eq |
MooseMesh & | _ref_mesh |
reference mesh More... | |
std::vector< std::string > | _displacements |
std::vector< std::unique_ptr< DisplacedSystem > > | _displaced_solver_systems |
std::unique_ptr< DisplacedSystem > | _displaced_aux |
std::vector< const NumericVector< Number > * > | _nl_solution |
The nonlinear system solutions. More... | |
const NumericVector< Number > * | _aux_solution |
The auxiliary system solution. More... | |
std::vector< std::vector< std::unique_ptr< Assembly > > > | _assembly |
GeometricSearchData | _geometric_search_data |
std::map< TagName, TagID > | _matrix_tag_name_to_tag_id |
The currently declared tags. More... | |
std::map< TagID, TagName > | _matrix_tag_id_to_tag_name |
Reverse map. More... | |
Factory & | _factory |
The Factory for building objects. More... | |
DiracKernelInfo | _dirac_kernel_info |
std::map< SubdomainID, std::set< std::string > > | _map_block_material_props |
Map of material properties (block_id -> list of properties) More... | |
std::map< BoundaryID, std::set< std::string > > | _map_boundary_material_props |
Map for boundary material properties (boundary_id -> list of properties) More... | |
std::map< SubdomainID, std::set< MaterialPropertyName > > | _zero_block_material_props |
Set of properties returned as zero properties. More... | |
std::map< BoundaryID, std::set< MaterialPropertyName > > | _zero_boundary_material_props |
std::set< std::string > | _material_property_requested |
set containing all material property names that have been requested by getMaterialProperty* More... | |
std::vector< std::set< MooseVariableFieldBase * > > | _active_elemental_moose_variables |
This is the set of MooseVariableFieldBase that will actually get reinited by a call to reinit(elem) More... | |
std::vector< unsigned int > | _has_active_elemental_moose_variables |
Whether or not there is currently a list of active elemental moose variables. More... | |
std::vector< std::set< TagID > > | _active_fe_var_coupleable_matrix_tags |
std::vector< std::set< TagID > > | _active_fe_var_coupleable_vector_tags |
std::vector< std::set< TagID > > | _active_sc_var_coupleable_matrix_tags |
std::vector< std::set< TagID > > | _active_sc_var_coupleable_vector_tags |
bool | _default_ghosting |
Whether or not to use default libMesh coupling. More... | |
std::set< dof_id_type > | _ghosted_elems |
Elements that should have Dofs ghosted to the local processor. More... | |
bool | _currently_computing_jacobian |
Flag to determine whether the problem is currently computing Jacobian. More... | |
bool | _currently_computing_residual_and_jacobian |
Flag to determine whether the problem is currently computing the residual and Jacobian. More... | |
bool | _computing_nonlinear_residual |
Whether the non-linear residual is being evaluated. More... | |
bool | _currently_computing_residual |
Whether the residual is being evaluated. More... | |
bool | _safe_access_tagged_matrices |
Is it safe to retrieve data from tagged matrices. More... | |
bool | _safe_access_tagged_vectors |
Is it safe to retrieve data from tagged vectors. More... | |
bool | _have_ad_objects |
AD flag indicating whether any AD objects have been added. More... | |
std::unordered_set< TagID > | _not_zeroed_tagged_vectors |
the list of vector tags that will not be zeroed when all other tags are More... | |
bool | _cli_option_found |
True if the CLI option is found. More... | |
bool | _color_output |
True if we're going to attempt to write color output. More... | |
bool | _termination_requested |
True if termination of the solve has been requested. More... | |
const bool & | _enabled |
Reference to the "enable" InputParameters, used by Controls for toggling on/off MooseObjects. More... | |
MooseApp & | _app |
The MOOSE application this is associated with. More... | |
const std::string | _type |
The type of this class. More... | |
const std::string | _name |
The name of this class. More... | |
const InputParameters & | _pars |
Parameters of this object, references the InputParameters stored in the InputParametersWarehouse. More... | |
ActionFactory & | _action_factory |
Builds Actions. More... | |
const Parallel::Communicator & | _communicator |
MooseApp & | _pg_moose_app |
The MooseApp that owns the PerfGraph. More... | |
const std::string | _prefix |
A prefix to use for all sections. More... | |
std::map< SubdomainID, std::multimap< std::string, std::string > > | _map_block_material_props_check |
Data structures of the requested material properties. More... | |
std::map< BoundaryID, std::multimap< std::string, std::string > > | _map_boundary_material_props_check |
Private Member Functions | |
virtual std::pair< bool, unsigned int > | determineSolverSystem (const std::string &var_name, bool error_if_not_found=false) const override |
Friends | |
class | UpdateDisplacedMeshThread |
class | Restartable |
Definition at line 37 of file DisplacedProblem.h.
|
inherited |
The parameter type this interface expects for a data file name.
Definition at line 27 of file DataFileInterface.h.
|
delete |
DisplacedProblem::DisplacedProblem | ( | const InputParameters & | parameters | ) |
Definition at line 45 of file DisplacedProblem.C.
|
default |
|
inlineinherited |
For Internal Use.
Definition at line 32 of file Problem.h.
|
inherited |
Add an algebraic ghosting functor to this problem's DofMaps.
Definition at line 1023 of file SubProblem.C.
|
virtual |
Definition at line 597 of file DisplacedProblem.C.
Reimplemented in FEProblemBase.
Definition at line 1326 of file SubProblem.C.
Referenced by FEProblemBase::addCachedJacobian().
Reimplemented in FEProblemBase.
Definition at line 1305 of file SubProblem.C.
Referenced by FEProblemBase::addCachedResidual().
|
virtual |
Definition at line 967 of file DisplacedProblem.C.
|
inherited |
Helper for tracking the object that is consuming a property for MaterialPropertyDebugOutput.
Definition at line 736 of file SubProblem.C.
Referenced by MaterialPropertyInterface::addConsumedPropertyName().
|
inherited |
Add a coupling functor to this problem's DofMaps.
Definition at line 1056 of file SubProblem.C.
|
inherited |
add a functor to the problem functor container
Definition at line 1375 of file SubProblem.h.
Referenced by FEProblemBase::addFunction(), SubProblem::addPiecewiseByBlockLambdaFunctor(), FEProblemBase::addUserObject(), and SystemBase::addVariable().
|
overridevirtual |
Will make sure that all necessary elements from boundary_id are ghosted to this processor.
boundary_id | Boundary ID |
Implements SubProblem.
Definition at line 1159 of file DisplacedProblem.C.
|
overridevirtual |
Will make sure that all dofs connected to elem_id are ghosted to this processor.
Implements SubProblem.
Definition at line 1153 of file DisplacedProblem.C.
Implements SubProblem.
Definition at line 1007 of file DisplacedProblem.C.
void DisplacedProblem::addJacobianBlockNonlocal | ( | SparseMatrix< Number > & | jacobian, |
unsigned int | ivar, | ||
unsigned int | jvar, | ||
const libMesh::DofMap & | dof_map, | ||
const std::vector< dof_id_type > & | idof_indices, | ||
const std::vector< dof_id_type > & | jdof_indices, | ||
const std::set< TagID > & | tags, | ||
const THREAD_ID | tid | ||
) |
Definition at line 1056 of file DisplacedProblem.C.
|
virtual |
Definition at line 1043 of file DisplacedProblem.C.
Implements SubProblem.
Definition at line 1031 of file DisplacedProblem.C.
Implements SubProblem.
Definition at line 1019 of file DisplacedProblem.C.
|
overridevirtual |
Implements SubProblem.
Implements SubProblem.
Definition at line 1025 of file DisplacedProblem.C.
Definition at line 1013 of file DisplacedProblem.C.
|
overridevirtual |
Create a Tag.
Tags can be associated with Vectors and Matrices and allow objects (such as Kernels) to arbitrarily contribute values to any set of vectors/matrics
Note: If the tag is already present then this will simply return the TagID of that Tag
tag_name | The name of the tag to create, the TagID will get automatically generated |
Reimplemented from SubProblem.
Definition at line 441 of file DisplacedProblem.C.
Adds a vector tag to the list of vectors that will not be zeroed when other tagged vectors are.
tag | the TagID of the vector that will be manually managed |
Definition at line 149 of file SubProblem.C.
Referenced by FEProblemBase::createTagVectors().
|
inherited |
Add a functor that has block-wise lambda definitions, e.g.
the evaluations of the functor are based on a user-provided lambda expression.
name | The name of the functor to add |
my_lammy | The lambda expression that will be called when the functor is evaluated |
clearance_schedule | How often to clear functor evaluations. The default value is always, which means that the functor will be re-evaluated every time it is called. If it is something other than always, than cached values may be returned |
mesh | The mesh on which this functor operates |
block_ids | The blocks on which the lambda expression is defined |
tid | The thread on which the functor we are adding will run |
Definition at line 1338 of file SubProblem.h.
Referenced by FunctorMaterial::addFunctorPropertyByBlocks().
Implements SubProblem.
Definition at line 946 of file DisplacedProblem.C.
Implements SubProblem.
Definition at line 960 of file DisplacedProblem.C.
Implements SubProblem.
Definition at line 953 of file DisplacedProblem.C.
void DisplacedProblem::addTimeIntegrator | ( | ) |
Get the time integrators from the problem.
Definition at line 201 of file DisplacedProblem.C.
|
virtual |
Definition at line 588 of file DisplacedProblem.C.
|
overridevirtual |
Create a Tag.
Tags can be associated with Vectors and Matrices and allow objects (such as Kernels) to arbitrarily contribute values to any set of vectors/matrics
Note: If the tag is already present then this will simply return the TagID of that Tag, but the type must be the same.
tag_name | The name of the tag to create, the TagID will get automatically generated |
type | The type of the tag |
Reimplemented from SubProblem.
Definition at line 386 of file DisplacedProblem.C.
|
overridevirtual |
Implements SubProblem.
Definition at line 1317 of file DisplacedProblem.C.
Referenced by setCurrentSubdomainID(), and setNeighborSubdomainID().
|
overridevirtual |
Implements SubProblem.
Definition at line 1326 of file DisplacedProblem.C.
|
virtualinherited |
Automatic scaling setter.
automatic_scaling | A boolean representing whether we are performing automatic scaling |
Reimplemented in FEProblemBase.
Definition at line 1155 of file SubProblem.C.
Referenced by MooseVariableBase::initialSetup().
|
inherited |
Automatic scaling getter.
Definition at line 1162 of file SubProblem.C.
Referenced by FEProblemBase::automaticScaling(), and DisplacedProblem().
|
inline |
Definition at line 59 of file DisplacedProblem.h.
void DisplacedProblem::bumpAllQRuleOrder | ( | Order | order, |
SubdomainID | block | ||
) |
Definition at line 141 of file DisplacedProblem.C.
void DisplacedProblem::bumpVolumeQRuleOrder | ( | Order | order, |
SubdomainID | block | ||
) |
Definition at line 133 of file DisplacedProblem.C.
Reimplemented in FEProblemBase.
Definition at line 1312 of file SubProblem.C.
Referenced by FEProblemBase::cacheJacobian().
Reimplemented in FEProblemBase.
Definition at line 1320 of file SubProblem.C.
Referenced by FEProblemBase::cacheJacobianNeighbor().
Definition at line 1037 of file DisplacedProblem.C.
Reimplemented in FEProblemBase.
Definition at line 1291 of file SubProblem.C.
Referenced by FEProblemBase::cacheResidual().
Reimplemented in FEProblemBase.
Definition at line 1298 of file SubProblem.C.
Referenced by FEProblemBase::cacheResidualNeighbor().
|
inherited |
Calls moose error with the message msg
.
Will prefix the message with the subapp name if one exists.
If with_prefix
, then add the prefix from errorPrefix() to the error.
Definition at line 33 of file MooseBase.C.
Referenced by InputParameters::callMooseErrorHelper(), MooseBaseErrorInterface::mooseDocumentedError(), MooseBaseErrorInterface::mooseError(), MooseBaseErrorInterface::mooseErrorNonPrefixed(), and MooseBaseParameterInterface::paramError().
|
virtualinherited |
Checks block material properties integrity.
Definition at line 623 of file SubProblem.C.
Referenced by FEProblemBase::checkProblemIntegrity().
|
virtualinherited |
Checks boundary material properties integrity.
Definition at line 665 of file SubProblem.C.
Referenced by FEProblemBase::checkProblemIntegrity().
|
overridevirtual |
Implements SubProblem.
Definition at line 1413 of file DisplacedProblem.C.
Clear the active elemental MooseVariableFieldBase.
If there are no active variables then they will all be reinited. Call this after finishing the computation that was using a restricted set of MooseVariableFieldBase
tid | The thread id |
Reimplemented in FEProblemBase.
Definition at line 466 of file SubProblem.C.
Referenced by FEProblemBase::clearActiveElementalMooseVariables().
Reimplemented in FEProblemBase.
Definition at line 384 of file SubProblem.C.
Referenced by FEProblemBase::clearActiveFEVariableCoupleableMatrixTags().
Reimplemented in FEProblemBase.
Definition at line 378 of file SubProblem.C.
Referenced by FEProblemBase::clearActiveFEVariableCoupleableVectorTags().
|
virtualinherited |
Reimplemented in FEProblemBase.
Definition at line 425 of file SubProblem.C.
Referenced by FEProblemBase::clearActiveScalarVariableCoupleableMatrixTags().
|
virtualinherited |
Reimplemented in FEProblemBase.
Definition at line 419 of file SubProblem.C.
Referenced by FEProblemBase::clearActiveScalarVariableCoupleableVectorTags().
|
inherited |
Clear dof indices from variables in nl and aux systems.
Definition at line 1177 of file SubProblem.C.
Referenced by FEProblemBase::solve().
|
overridevirtual |
Gets called before Dirac Kernels are asked to add the points they are supposed to be evaluated in.
Implements SubProblem.
Definition at line 940 of file DisplacedProblem.C.
|
inlineinherited |
Returns true if the problem is in the process of computing the nonlinear residual.
Definition at line 707 of file SubProblem.h.
|
inlinevirtualinherited |
Set whether or not the problem is in the process of computing the nonlinear residual.
Reimplemented in FEProblemBase.
Definition at line 712 of file SubProblem.h.
|
overridevirtual |
Returns true if the problem is in the process of computing it's initial residual.
Implements SubProblem.
Definition at line 1183 of file DisplacedProblem.C.
|
finaloverridevirtual |
Getter for whether we're computing the scaling jacobian.
Implements SubProblem.
Definition at line 1241 of file DisplacedProblem.C.
|
finaloverridevirtual |
Getter for whether we're computing the scaling residual.
Implements SubProblem.
Definition at line 1247 of file DisplacedProblem.C.
|
inherited |
Connect controllable parameter of this action with the controllable parameters of the objects added by this action.
parameter | Name of the controllable parameter of this action |
object_type | Type of the object added by this action. |
object_name | Name of the object added by this action. |
object_parameter | Name of the parameter of the object. |
Definition at line 33 of file MooseBaseParameterInterface.C.
|
inlineinherited |
Return console handle.
Definition at line 48 of file Problem.h.
Referenced by Moose::SlepcSupport::mooseSlepcEPSMonitor(), ComputeMarkerThread::printBlockExecutionInformation(), ComputeDiracThread::printBlockExecutionInformation(), ComputeIndicatorThread::printBlockExecutionInformation(), ComputeUserObjectsThread::printBlockExecutionInformation(), ComputeLinearFVElementalThread::printBlockExecutionInformation(), ComputeLinearFVFaceThread::printBlockExecutionInformation(), NonlinearThread::printBlockExecutionInformation(), NonlinearThread::printBoundaryExecutionInformation(), ComputeInitialConditionThread::printGeneralExecutionInformation(), ComputeFVInitialConditionThread::printGeneralExecutionInformation(), ComputeNodalUserObjectsThread::printGeneralExecutionInformation(), ComputeNodalKernelBcsThread::printGeneralExecutionInformation(), ComputeNodalKernelsThread::printGeneralExecutionInformation(), ComputeElemDampingThread::printGeneralExecutionInformation(), ComputeNodalKernelBCJacobiansThread::printGeneralExecutionInformation(), ComputeNodalDampingThread::printGeneralExecutionInformation(), ComputeMarkerThread::printGeneralExecutionInformation(), ComputeDiracThread::printGeneralExecutionInformation(), ComputeNodalKernelJacobiansThread::printGeneralExecutionInformation(), ComputeIndicatorThread::printGeneralExecutionInformation(), ComputeThreadedGeneralUserObjectsThread::printGeneralExecutionInformation(), ComputeUserObjectsThread::printGeneralExecutionInformation(), ComputeLinearFVElementalThread::printGeneralExecutionInformation(), ComputeLinearFVFaceThread::printGeneralExecutionInformation(), and NonlinearThread::printGeneralExecutionInformation().
|
inlinevirtualinherited |
Eventually we want to convert this virtual over to taking a solver system number argument.
We will have to first convert apps to use solverSystemConverged, and then once that is done, we can change this signature. Then we can go through the apps again and convert back to this changed API
Definition at line 113 of file SubProblem.h.
Referenced by FEProblemBase::initialSetup(), EigenExecutionerBase::inversePowerIteration(), EigenExecutionerBase::nonlinearSolve(), FEProblemSolve::solve(), LStableDirk2::solve(), LStableDirk3::solve(), ImplicitMidpoint::solve(), ExplicitTVDRK2::solve(), AStableDirk4::solve(), LStableDirk4::solve(), ExplicitRK2::solve(), solverSystemConverged(), SubProblem::solverSystemConverged(), and AB2PredictorCorrector::step().
|
overridevirtual |
The coupling matrix defining what blocks exist in the preconditioning matrix.
Implements SubProblem.
Definition at line 1235 of file DisplacedProblem.C.
|
virtual |
Definition at line 119 of file DisplacedProblem.C.
|
overridevirtual |
Implements SubProblem.
Definition at line 611 of file DisplacedProblem.C.
|
inlineinherited |
Returns true if the problem is in the process of computing the Jacobian.
Definition at line 684 of file SubProblem.h.
Referenced by PenetrationLocator::detectPenetration(), ComputeUserObjectsThread::onBoundary(), ComputeUserObjectsThread::onElement(), ComputeUserObjectsThread::printBlockExecutionInformation(), SubProblem::reinitElemFaceRef(), and NEML2Utils::shouldCompute().
|
inlineinherited |
Returns true if the problem is in the process of computing the residual.
Definition at line 720 of file SubProblem.h.
|
inlineinherited |
Returns true if the problem is in the process of computing the residual and the Jacobian.
Definition at line 1487 of file SubProblem.h.
Referenced by SubProblem::reinitElemFaceRef(), and NEML2Utils::shouldCompute().
|
overridevirtual |
Implements SubProblem.
Definition at line 605 of file DisplacedProblem.C.
Referenced by addCachedResidualDirectly(), addJacobian(), addJacobianBlockNonlocal(), addJacobianBlockTags(), addJacobianLowerD(), addJacobianNeighbor(), addJacobianNeighborLowerD(), addJacobianNonlocal(), addResidual(), addResidualLower(), addResidualNeighbor(), cacheJacobianNonlocal(), prepareAssembly(), prepareAssemblyNeighbor(), prepareBlockNonlocal(), prepareFaceShapes(), prepareNeighborShapes(), prepareNonlocal(), prepareShapes(), reinitDirac(), reinitElemNeighborAndLowerD(), reinitOffDiagScalars(), setResidual(), and setResidualNeighbor().
|
overridevirtual |
Return the residual vector tags we are currently computing.
Implements SubProblem.
Definition at line 1353 of file DisplacedProblem.C.
Referenced by addResidual(), addResidualLower(), and addResidualNeighbor().
|
overridevirtual |
Reimplemented from SubProblem.
Definition at line 1273 of file DisplacedProblem.C.
|
inlineinherited |
Whether or not the user has requested default ghosting ot be on.
Definition at line 144 of file SubProblem.h.
Referenced by AuxiliarySystem::AuxiliarySystem(), DisplacedSystem::DisplacedSystem(), and NonlinearSystemBase::NonlinearSystemBase().
|
overrideprivatevirtual |
Implements SubProblem.
Definition at line 1310 of file DisplacedProblem.C.
|
virtualinherited |
Definition at line 748 of file SubProblem.C.
|
inherited |
Definition at line 1361 of file SubProblem.C.
Referenced by FEProblemBase::meshChanged().
|
inlinevirtualinherited |
Return the enabled status of the object.
Reimplemented in EigenKernel.
Definition at line 40 of file MooseObject.h.
Referenced by EigenKernel::enabled().
|
inherited |
Definition at line 43 of file MooseBase.C.
Referenced by MooseBase::callMooseError(), MooseBaseErrorInterface::mooseDeprecated(), MooseBaseErrorInterface::mooseInfo(), MooseBaseErrorInterface::mooseWarning(), and MooseBaseParameterInterface::paramErrorMsg().
|
inlineoverridevirtual |
Implements SubProblem.
Definition at line 48 of file DisplacedProblem.h.
Referenced by DisplacedProblem::UpdateDisplacedMeshThread::init().
Reimplemented in FEProblemBase.
Definition at line 754 of file SubProblem.C.
Referenced by Residual::getValue().
|
inlineoverridevirtual |
Implements SubProblem.
Definition at line 316 of file DisplacedProblem.h.
|
virtualinherited |
Get the MOOSE variables to be reinited on each element.
tid | The thread id |
Definition at line 454 of file SubProblem.C.
Referenced by SystemBase::prepare(), SystemBase::prepareFace(), FEProblemBase::prepareMaterials(), and SystemBase::reinitElem().
|
inherited |
Definition at line 390 of file SubProblem.C.
|
inherited |
Definition at line 396 of file SubProblem.C.
Referenced by MultiAppVariableValueSamplePostprocessorTransfer::execute().
|
inherited |
Definition at line 431 of file SubProblem.C.
Referenced by MooseVariableScalar::reinit().
|
inherited |
Definition at line 437 of file SubProblem.C.
|
overridevirtual |
Returns the variable reference for requested MooseVariableField which may be in any system.
Implements SubProblem.
Definition at line 515 of file DisplacedProblem.C.
|
overridevirtual |
Returns the variable reference for requested ArrayMooseVariable which may be in any system.
Implements SubProblem.
Definition at line 539 of file DisplacedProblem.C.
|
inherited |
Returns the desired radial direction for RZ coordinate transformation.
Definition at line 796 of file SubProblem.C.
|
inherited |
Verifies that the requested parameter exists and is not NULL and returns it to the caller.
The template parameter must be a pointer or an error will be thrown.
Definition at line 286 of file MooseBaseParameterInterface.h.
|
inherited |
Return the map that tracks the object with consumed material properties.
Definition at line 742 of file SubProblem.C.
Referenced by MaterialPropertyDebugOutput::output().
|
inherited |
Definition at line 1278 of file SubProblem.C.
Referenced by BlockRestrictable::getBlockCoordSystem(), MultiApp::getBoundingBox(), Assembly::reinitLowerDElem(), Assembly::reinitNeighborLowerDElem(), and Assembly::setCoordinateTransformation().
|
inherited |
Deprecated method.
The data file paths are now automatically set within the InputParameters object, so using getParam<DataFileName>("param_name") is now sufficient.
Definition at line 21 of file DataFileInterface.C.
|
inherited |
Deprecated method.
Use getDataFilePath() instead.
Definition at line 31 of file DataFileInterface.C.
|
inherited |
Returns the path of a data file for a given relative file path.
This can be used for hardcoded datafile names and will search the same locations as getDataFileName
Definition at line 40 of file DataFileInterface.C.
Referenced by DataFileInterface::getDataFileNameByName().
Fills "elems" with the elements that should be looped over for Dirac Kernels.
Implements SubProblem.
Definition at line 934 of file DisplacedProblem.C.
|
inline |
Definition at line 74 of file DisplacedProblem.h.
|
inherited |
T | The type that the functor will return when evaluated, e.g. ADReal or Real |
name | The name of the functor to retrieve |
tid | The thread ID that we are retrieving the functor property for |
requestor_name | The name of the object that is requesting this functor property |
requestor_is_ad | Whether the requesting object is an AD object |
Definition at line 1214 of file SubProblem.h.
Referenced by FunctorInterface::getFunctorByName().
|
overridevirtual |
Implements SubProblem.
Definition at line 1229 of file DisplacedProblem.C.
|
virtualinherited |
Get a vector of block id equivalences that the material property is defined on.
Definition at line 489 of file SubProblem.C.
Referenced by MaterialPropertyInterface::getMaterialPropertyBlockNames().
|
virtualinherited |
Get a vector containing the block ids the material property is defined on.
Definition at line 473 of file SubProblem.C.
Referenced by SubProblem::getMaterialPropertyBlockNames(), and MaterialPropertyInterface::getMaterialPropertyBlocks().
|
virtualinherited |
Get a vector containing the block ids the material property is defined on.
Definition at line 525 of file SubProblem.C.
Referenced by MaterialPropertyInterface::getMaterialPropertyBoundaryIDs(), and SubProblem::getMaterialPropertyBoundaryNames().
|
virtualinherited |
Get a vector of block id equivalences that the material property is defined on.
Definition at line 541 of file SubProblem.C.
Referenced by MaterialPropertyInterface::getMaterialPropertyBoundaryNames().
|
overridevirtual |
Get a TagID from a TagName.
Reimplemented from SubProblem.
Definition at line 447 of file DisplacedProblem.C.
|
inlinevirtualinherited |
Return all matrix tags in the system, where a tag is represented by a map from name to ID.
Definition at line 253 of file SubProblem.h.
Referenced by NonlinearSystemBase::computeJacobian(), FEProblemBase::computeJacobian(), EigenProblem::computeJacobianAB(), NonlinearSystemBase::computeJacobianBlocks(), EigenProblem::computeJacobianTag(), FEProblemBase::computeLinearSystemSys(), and FEProblemBase::computeResidualAndJacobian().
|
inlineinherited |
Get the MooseApp this class is associated with.
Definition at line 45 of file MooseBase.h.
Referenced by ChainControlSetupAction::act(), AddDefaultConvergenceAction::addDefaultMultiAppFixedPointConvergence(), AddDefaultConvergenceAction::addDefaultNonlinearConvergence(), AddDefaultConvergenceAction::addDefaultSteadyStateConvergence(), FEProblemBase::advanceState(), ParsedChainControl::buildFunction(), ReporterTransferInterface::checkHasReporterValue(), AddDefaultConvergenceAction::checkUnusedMultiAppFixedPointConvergenceParameters(), AddDefaultConvergenceAction::checkUnusedNonlinearConvergenceParameters(), AddDefaultConvergenceAction::checkUnusedSteadyStateConvergenceParameters(), Coupleable::checkWritableVar(), ComponentPhysicsInterface::ComponentPhysicsInterface(), MooseBaseParameterInterface::connectControllableParams(), Coupleable::Coupleable(), MortarData::createMortarInterface(), EigenProblem::doFreeNonlinearPowerIterations(), Terminator::execute(), FEProblemSolve::FEProblemSolve(), SolutionInvalidInterface::flagInvalidSolutionInternal(), ChainControl::getChainControlDataSystem(), DefaultConvergenceBase::getSharedExecutionerParam(), ChainControlDataPostprocessor::initialSetup(), MaterialPropertyInterface::MaterialPropertyInterface(), MooseVariableDataFV< OutputType >::MooseVariableDataFV(), ProgressOutput::output(), PetscOutputInterface::petscLinearOutput(), PetscOutputInterface::petscNonlinearOutput(), PetscOutputInterface::PetscOutputInterface(), PostprocessorInterface::postprocessorsAdded(), MultiApp::preTransfer(), Reporter::Reporter(), ReporterInterface::reportersAdded(), MultiApp::restore(), and VectorPostprocessorInterface::vectorPostprocessorsAdded().
|
inherited |
Retrieve a parameter for the object.
name | The name of the parameter |
Definition at line 215 of file MooseBaseParameterInterface.h.
Referenced by CreateDisplacedProblemAction::act(), AddPeriodicBCAction::act(), DiffusionPhysicsBase::addPostprocessors(), ADNodalKernel::ADNodalKernel(), ArrayParsedAux::ArrayParsedAux(), AddPeriodicBCAction::autoTranslationBoundaries(), BicubicSplineFunction::BicubicSplineFunction(), ComponentPhysicsInterface::ComponentPhysicsInterface(), FunctorAux::computeValue(), FEProblemBase::createTagSolutions(), CutMeshByLevelSetGenerator::CutMeshByLevelSetGenerator(), DebugResidualAux::DebugResidualAux(), AccumulateReporter::declareLateValues(), DerivativeParsedMaterialTempl< is_ad >::DerivativeParsedMaterialTempl(), DynamicObjectRegistrationAction::DynamicObjectRegistrationAction(), EigenKernel::EigenKernel(), ElementGroupCentroidPositions::ElementGroupCentroidPositions(), FEProblemBase::FEProblemBase(), FEProblemSolve::FEProblemSolve(), FiniteDifferencePreconditioner::FiniteDifferencePreconditioner(), ParsedSubdomainGeneratorBase::functionInitialize(), FVInterfaceKernel::FVInterfaceKernel(), BoundaryLayerSubdomainGenerator::generate(), ExtraNodesetGenerator::generate(), FileMeshGenerator::generate(), BlockDeletionGenerator::generate(), BreakMeshByBlockGenerator::generate(), CoarsenBlockGenerator::generate(), GeneratedMeshGenerator::generate(), RefineBlockGenerator::generate(), RefineSidesetGenerator::generate(), MeshExtruderGenerator::generate(), GenericConstantRankTwoTensorTempl< is_ad >::GenericConstantRankTwoTensorTempl(), GenericConstantSymmetricRankTwoTensorTempl< is_ad >::GenericConstantSymmetricRankTwoTensorTempl(), MooseApp::getCheckpointDirectories(), DataFileInterface::getDataFileName(), ExecutorInterface::getExecutor(), GhostingUserObject::GhostingUserObject(), FixedPointIterationAdaptiveDT::init(), TimeSequenceStepper::init(), IterationAdaptiveDT::init(), AdvancedOutput::init(), AttribThread::initFrom(), AttribSysNum::initFrom(), AttribResidualObject::initFrom(), AttribDisplaced::initFrom(), BlockRestrictable::initializeBlockRestrictable(), BoundaryRestrictable::initializeBoundaryRestrictable(), Console::initialSetup(), SampledOutput::initSample(), IterationAdaptiveDT::limitDTToPostprocessorValue(), MooseMesh::MooseMesh(), MooseStaticCondensationPreconditioner::MooseStaticCondensationPreconditioner(), MooseVariableBase::MooseVariableBase(), MultiSystemSolveObject::MultiSystemSolveObject(), NEML2ModelExecutor::NEML2ModelExecutor(), NestedDivision::NestedDivision(), ConsoleUtils::outputExecutionInformation(), ParsedCurveGenerator::ParsedCurveGenerator(), ParsedElementDeletionGenerator::ParsedElementDeletionGenerator(), ParsedGenerateNodeset::ParsedGenerateNodeset(), ParsedGenerateSideset::ParsedGenerateSideset(), ParsedMaterialTempl< is_ad >::ParsedMaterialTempl(), ParsedNodeTransformGenerator::ParsedNodeTransformGenerator(), ParsedODEKernel::ParsedODEKernel(), ParsedPostprocessor::ParsedPostprocessor(), PiecewiseByBlockFunctorMaterialTempl< T >::PiecewiseByBlockFunctorMaterialTempl(), PiecewiseConstantByBlockMaterialTempl< is_ad >::PiecewiseConstantByBlockMaterialTempl(), ReferenceResidualInterface::ReferenceResidualInterface(), RenameBlockGenerator::RenameBlockGenerator(), Moose::FV::setInterpolationMethod(), SetupMeshAction::setupMesh(), SingleMatrixPreconditioner::SingleMatrixPreconditioner(), TimePeriod::TimePeriod(), UniqueExtraIDMeshGenerator::UniqueExtraIDMeshGenerator(), FunctorIC::value(), VariableCondensationPreconditioner::VariableCondensationPreconditioner(), and VectorOfPostprocessors::VectorOfPostprocessors().
|
inherited |
Retrieve two parameters and provide pair of parameters for the object.
param1 | The name of first parameter |
param2 | The name of second parameter |
Definition at line 279 of file MooseBaseParameterInterface.h.
|
inherited |
Retrieve a renamed parameter for the object.
This helper makes sure we check both names before erroring, and that only one parameter is passed to avoid silent errors
old_name | the old name for the parameter |
new_name | the new name for the parameter |
Definition at line 229 of file MooseBaseParameterInterface.h.
|
overridevirtual |
Returns the scalar variable reference from whichever system contains it.
Implements SubProblem.
Definition at line 563 of file DisplacedProblem.C.
|
inherited |
Get another shared pointer to this object that has the same ownership group.
Wrapper around shared_from_this().
Definition at line 68 of file MooseObject.C.
Referenced by MFEMProblem::addBoundaryCondition(), MFEMProblem::addKernel(), and MFEMProblem::addMFEMSolver().
|
inherited |
Definition at line 81 of file MooseObject.C.
|
overridevirtual |
Returns the variable reference for requested MooseVariable which may be in any system.
Implements SubProblem.
Definition at line 503 of file DisplacedProblem.C.
|
overridevirtual |
Returns the equation system containing the variable provided.
Implements SubProblem.
Definition at line 575 of file DisplacedProblem.C.
virtual const MooseVariableFieldBase& SubProblem::getVariable |
Returns the variable reference for requested variable which must be of the expected_var_type (Nonlinear vs.
Auxiliary) and expected_var_field_type (standard, scalar, vector). The default values of VAR_ANY and VAR_FIELD_ANY should be used when "any" type of variable is acceptable. Throws an error if the variable in question is not in the expected System or of the expected type.
|
inline |
Definition at line 279 of file SubProblem.h.
|
overridevirtual |
Returns the variable reference for requested variable which must be of the expected_var_type (Nonlinear vs.
Auxiliary) and expected_var_field_type (standard, scalar, vector). The default values of VAR_ANY and VAR_FIELD_ANY should be used when "any" type of variable is acceptable. Throws an error if the variable in question is not in the expected System or of the expected type.
Implements SubProblem.
Definition at line 489 of file DisplacedProblem.C.
Referenced by init().
|
inlinevirtualinherited |
Definition at line 279 of file SubProblem.h.
|
inherited |
Definition at line 818 of file SubProblem.C.
|
protectedinherited |
Helper function called by getVariable that handles the logic for checking whether Variables of the requested type are available.
Referenced by getVariable(), and FEProblemBase::getVariable().
Get a VectorTag from a TagID.
Reimplemented from SubProblem.
Definition at line 393 of file DisplacedProblem.C.
Referenced by addCachedResidualDirectly(), setResidual(), and setResidualNeighbor().
|
overridevirtual |
Get a TagID from a TagName.
Reimplemented from SubProblem.
Definition at line 399 of file DisplacedProblem.C.
|
overridevirtual |
Return all vector tags, where a tag is represented by a map from name to ID.
Can optionally be limited to a vector tag type.
Reimplemented from SubProblem.
Definition at line 429 of file DisplacedProblem.C.
|
inherited |
Definition at line 172 of file SubProblem.C.
Referenced by FEProblemBase::computeLinearSystemSys(), EigenProblem::computeResidualAB(), FEProblemBase::computeResidualAndJacobian(), NonlinearSystemBase::computeResidualInternal(), EigenProblem::computeResidualTag(), ComputeResidualAndJacobianThread::determineObjectWarehouses(), getVectorTags(), SubProblem::numVectorTags(), ComputeMortarFunctor::operator()(), and FEProblemBase::setCurrentResidualVectorTags().
|
overridevirtual |
Returns the variable reference for requested VectorMooseVariable which may be in any system.
Implements SubProblem.
Definition at line 527 of file DisplacedProblem.C.
|
overridevirtual |
Return the list of elements that should have their DoFs ghosted to this processor.
Reimplemented from SubProblem.
Definition at line 113 of file DisplacedProblem.C.
|
overridevirtual |
Causes the boundaries added using addGhostedBoundary to actually be ghosted.
Implements SubProblem.
Definition at line 1165 of file DisplacedProblem.C.
|
virtualinherited |
Whether or not a list of active elemental moose variables has been set.
Definition at line 460 of file SubProblem.C.
Referenced by SystemBase::prepare(), SystemBase::prepareFace(), and SystemBase::reinitElem().
|
virtualinherited |
Whether or not this problem has this auxiliary variable.
Definition at line 811 of file SubProblem.C.
Referenced by SubProblem::getFunctor(), and NearestNodeValueAux::NearestNodeValueAux().
|
virtualinherited |
Check if a material property is defined on a block.
Definition at line 511 of file SubProblem.C.
|
virtualinherited |
Check if a material property is defined on a block.
Definition at line 570 of file SubProblem.C.
|
inherited |
checks whether we have a functor corresponding to name
on the thread id tid
Definition at line 1270 of file SubProblem.C.
Referenced by FunctorInterface::isFunctor().
|
inherited |
checks whether we have a functor of type T corresponding to name
on the thread id tid
Definition at line 1320 of file SubProblem.h.
|
virtualinherited |
Whether or not this problem has this linear variable.
Definition at line 802 of file SubProblem.C.
Referenced by SubProblem::getFunctor().
|
overridevirtual |
Whether the simulation has active nonlocal coupling which should be accounted for in the Jacobian.
For this to return true, there must be at least one active nonlocal kernel or boundary condition
Implements SubProblem.
Definition at line 1383 of file DisplacedProblem.C.
|
overridevirtual |
Returns a Boolean indicating whether any system contains a variable with the name provided.
Implements SubProblem.
Definition at line 551 of file DisplacedProblem.C.
Tells this problem that the assembly associated with the given nonlinear system number involves a scaling vector.
Definition at line 1170 of file SubProblem.C.
Referenced by SystemBase::addScalingVector().
|
overridevirtual |
Whether or not this problem has the variable.
Implements SubProblem.
Definition at line 477 of file DisplacedProblem.C.
|
inline |
Method for setting whether we have any ad objects.
Definition at line 767 of file SubProblem.h.
|
inline |
Method for reading wehther we have any ad objects.
Definition at line 771 of file SubProblem.h.
|
overridevirtual |
Method for setting whether we have any ad objects.
Reimplemented from SubProblem.
Definition at line 1303 of file DisplacedProblem.C.
|
inlineinherited |
Method for reading wehther we have any ad objects.
Definition at line 771 of file SubProblem.h.
Referenced by FEProblemBase::computeJacobianTags(), FEProblemBase::computeResidualAndJacobian(), and FEProblemBase::init().
|
inlinefinaloverridevirtual |
Whether we have a displaced problem in our simulation.
Implements SubProblem.
Definition at line 355 of file DisplacedProblem.h.
|
overridevirtual |
returns true if this problem includes/needs finite volume functionality.
Implements SubProblem.
Definition at line 1377 of file DisplacedProblem.C.
Referenced by init(), and updateMesh().
|
inlineinherited |
Query whether p-refinement has been requested at any point during the simulation.
Definition at line 1009 of file SubProblem.h.
Referenced by AdvancedOutput::initAvailableLists(), and FEProblemBase::meshChanged().
|
overridevirtual |
Implements Problem.
Definition at line 149 of file DisplacedProblem.C.
|
virtual |
Definition at line 196 of file DisplacedProblem.C.
|
overridevirtual |
Reimplemented from SubProblem.
Definition at line 1253 of file DisplacedProblem.C.
|
virtualinherited |
Find out if a material property has been requested by any object.
Definition at line 730 of file SubProblem.C.
|
inlineinherited |
Test if the supplied parameter is set by a user, as opposed to not set or set to default.
nm | The name of the parameter to test |
Definition at line 128 of file MooseBaseParameterInterface.h.
Referenced by SetupDebugAction::act(), ADConservativeAdvectionBC::ADConservativeAdvectionBC(), DiffusionCG::addFEBCs(), DiffusionPhysicsBase::addInitialConditions(), MFEMMesh::buildMesh(), LibtorchNeuralNetControl::conditionalParameterError(), DiffusionPhysicsBase::DiffusionPhysicsBase(), ElementSubdomainModifierBase::ElementSubdomainModifierBase(), MooseBaseParameterInterface::getRenamedParam(), DefaultConvergenceBase::getSharedExecutionerParam(), AddVariableAction::init(), PhysicsBase::initializePhysics(), ElementSubdomainModifierBase::initialSetup(), MatrixSymmetryCheck::MatrixSymmetryCheck(), MeshDiagnosticsGenerator::MeshDiagnosticsGenerator(), MultiAppGeneralFieldTransfer::MultiAppGeneralFieldTransfer(), SolutionInvalidityOutput::output(), Output::Output(), MultiAppGeneralFieldTransfer::outputValueConflicts(), PetscExternalPartitioner::partition(), PiecewiseTabularBase::PiecewiseTabularBase(), MooseMesh::prepare(), SolutionUserObjectBase::readXda(), PhysicsBase::reportPotentiallyMissedParameters(), MFEMSolverBase::setPreconditioner(), SideSetsFromBoundingBoxGenerator::SideSetsFromBoundingBoxGenerator(), TimedSubdomainModifier::TimedSubdomainModifier(), and XYDelaunayGenerator::XYDelaunayGenerator().
|
inlineinherited |
Test if the supplied parameter is valid.
name | The name of the parameter to test |
Definition at line 122 of file MooseBaseParameterInterface.h.
Referenced by HierarchicalGridPartitioner::_do_partition(), GridPartitioner::_do_partition(), CopyNodalVarsAction::act(), SetupMeshAction::act(), SetupDebugAction::act(), ComposeTimeStepperAction::act(), SetAdaptivityOptionsAction::act(), AddVariableAction::act(), CreateDisplacedProblemAction::act(), CommonOutputAction::act(), ADConservativeAdvectionBC::ADConservativeAdvectionBC(), DiffusionCG::addFEKernels(), DiffusionFV::addFVBCs(), DiffusionFV::addFVKernels(), DiffusionPhysicsBase::addInitialConditions(), CylinderComponent::addMeshGenerators(), AddPeriodicBCAction::AddPeriodicBCAction(), DiffusionPhysicsBase::addPostprocessors(), AdvectiveFluxAux::AdvectiveFluxAux(), ArrayHFEMDirichletBC::ArrayHFEMDirichletBC(), ArrayVarReductionAux::ArrayVarReductionAux(), AddPeriodicBCAction::autoTranslationBoundaries(), BicubicSplineFunction::BicubicSplineFunction(), BlockDeletionGenerator::BlockDeletionGenerator(), TimedSubdomainModifier::buildFromFile(), PiecewiseTabularBase::buildFromFile(), PiecewiseTabularBase::buildFromJSON(), ParsedChainControl::buildFunction(), GeneratedMesh::buildMesh(), MooseMesh::buildTypedMesh(), CartesianGridDivision::CartesianGridDivision(), CartesianMeshGenerator::CartesianMeshGenerator(), LibmeshPartitioner::clone(), SampledOutput::cloneMesh(), CombinerGenerator::CombinerGenerator(), FunctorAux::computeValue(), ConservativeAdvectionTempl< is_ad >::ConservativeAdvectionTempl(), FEProblemSolve::convergenceSetup(), CopyMeshPartitioner::CopyMeshPartitioner(), CSVReaderVectorPostprocessor::CSVReaderVectorPostprocessor(), CutMeshByLevelSetGeneratorBase::CutMeshByLevelSetGeneratorBase(), ConstantReporter::declareConstantReporterValues(), DGKernelBase::DGKernelBase(), DiffusionFluxAux::DiffusionFluxAux(), DomainUserObject::DomainUserObject(), DynamicObjectRegistrationAction::DynamicObjectRegistrationAction(), Eigenvalue::Eigenvalue(), ElementGroupCentroidPositions::ElementGroupCentroidPositions(), PIDTransientControl::execute(), MultiAppNearestNodeTransfer::execute(), MultiAppUserObjectTransfer::execute(), Exodus::Exodus(), ExtraIDIntegralReporter::ExtraIDIntegralReporter(), ExtraIDIntegralVectorPostprocessor::ExtraIDIntegralVectorPostprocessor(), FEProblemBase::FEProblemBase(), FEProblemSolve::FEProblemSolve(), FieldSplitPreconditioner::FieldSplitPreconditioner(), FileOutput::FileOutput(), SpatialUserObjectVectorPostprocessor::fillPoints(), CombinerGenerator::fillPositions(), MultiApp::fillPositions(), FiniteDifferencePreconditioner::FiniteDifferencePreconditioner(), FixedPointSolve::FixedPointSolve(), FunctionDT::FunctionDT(), FunctionValuePostprocessor::FunctionValuePostprocessor(), FVInterfaceKernel::FVInterfaceKernel(), FVMassMatrix::FVMassMatrix(), AddMetaDataGenerator::generate(), BreakBoundaryOnSubdomainGenerator::generate(), ElementGenerator::generate(), ExtraNodesetGenerator::generate(), FileMeshGenerator::generate(), LowerDBlockFromSidesetGenerator::generate(), SubdomainPerElementGenerator::generate(), GeneratedMeshGenerator::generate(), BlockDeletionGenerator::generate(), ParsedSubdomainGeneratorBase::generate(), MeshExtruderGenerator::generate(), ParsedExtraElementIDGenerator::generate(), XYZDelaunayGenerator::generate(), XYDelaunayGenerator::generate(), XYMeshLineCutter::generate(), SubdomainBoundingBoxGenerator::generate(), DistributedRectilinearMeshGenerator::generate(), PropertyReadFile::getFileNames(), MultiAppNearestNodeTransfer::getLocalEntitiesAndComponents(), MeshGenerator::getMeshGeneratorNameFromParam(), MeshGenerator::getMeshGeneratorNamesFromParam(), MooseBaseParameterInterface::getRenamedParam(), MultiAppNearestNodeTransfer::getTargetLocalNodes(), Terminator::handleMessage(), HFEMDirichletBC::HFEMDirichletBC(), EigenExecutionerBase::init(), IterationAdaptiveDT::init(), Eigenvalue::init(), AdvancedOutput::initExecutionTypes(), BlockRestrictable::initializeBlockRestrictable(), BoundaryRestrictable::initializeBoundaryRestrictable(), MultiAppCloneReporterTransfer::initialSetup(), SolutionIC::initialSetup(), MultiAppVariableValueSampleTransfer::initialSetup(), PiecewiseTabularBase::initialSetup(), SolutionScalarAux::initialSetup(), ParsedConvergence::initialSetup(), SolutionAux::initialSetup(), Console::initialSetup(), MooseParsedVectorFunction::initialSetup(), MultiAppGeneralFieldTransfer::initialSetup(), MooseParsedGradFunction::initialSetup(), MooseParsedFunction::initialSetup(), SampledOutput::initSample(), IterationAdaptiveDT::IterationAdaptiveDT(), LeastSquaresFit::LeastSquaresFit(), LibmeshPartitioner::LibmeshPartitioner(), LibtorchNeuralNetControl::LibtorchNeuralNetControl(), MassMatrix::MassMatrix(), MatCoupledForce::MatCoupledForce(), MatDiffusionBase< Real >::MatDiffusionBase(), MeshGeneratorComponent::MeshGeneratorComponent(), MFEMExecutioner::MFEMExecutioner(), MooseMesh::MooseMesh(), MoosePreconditioner::MoosePreconditioner(), MooseStaticCondensationPreconditioner::MooseStaticCondensationPreconditioner(), MooseVariableBase::MooseVariableBase(), MooseVariableFV< Real >::MooseVariableFV(), MortarConstraintBase::MortarConstraintBase(), MoveNodeGenerator::MoveNodeGenerator(), MultiApp::MultiApp(), MultiAppCloneReporterTransfer::MultiAppCloneReporterTransfer(), MultiAppGeneralFieldNearestLocationTransfer::MultiAppGeneralFieldNearestLocationTransfer(), MultiAppGeneralFieldShapeEvaluationTransfer::MultiAppGeneralFieldShapeEvaluationTransfer(), MultiAppGeneralFieldTransfer::MultiAppGeneralFieldTransfer(), MultiAppGeneralFieldUserObjectTransfer::MultiAppGeneralFieldUserObjectTransfer(), MultiAppPostprocessorInterpolationTransfer::MultiAppPostprocessorInterpolationTransfer(), MultiAppPostprocessorTransfer::MultiAppPostprocessorTransfer(), MultiAppReporterTransfer::MultiAppReporterTransfer(), MultiAppTransfer::MultiAppTransfer(), MultiAppUserObjectTransfer::MultiAppUserObjectTransfer(), MultiAppVariableValueSampleTransfer::MultiAppVariableValueSampleTransfer(), MultiSystemSolveObject::MultiSystemSolveObject(), NodeSetsGeneratorBase::NodeSetsGeneratorBase(), EigenExecutionerBase::normalizeSolution(), Output::Output(), MultiAppGeneralFieldTransfer::outputValueConflicts(), ParsedCurveGenerator::ParsedCurveGenerator(), PetscOutput::PetscOutput(), PhysicsBasedPreconditioner::PhysicsBasedPreconditioner(), PIDTransientControl::PIDTransientControl(), PiecewiseTabularBase::PiecewiseTabularBase(), PlaneIDMeshGenerator::PlaneIDMeshGenerator(), MooseMesh::prepare(), MooseBaseParameterInterface::queryParam(), MultiApp::readCommandLineArguments(), SolutionUserObjectBase::readExodusII(), ReferenceResidualInterface::ReferenceResidualInterface(), RenameBlockGenerator::RenameBlockGenerator(), ReporterPointSource::ReporterPointSource(), PhysicsBase::reportPotentiallyMissedParameters(), ParsedSubdomainMeshGenerator::setBlockName(), MooseMesh::setCoordSystem(), FileOutput::setFileBase(), FileOutput::setFileBaseInternal(), Split::setup(), SideSetsGeneratorBase::setup(), SetupMeshAction::setupMesh(), SideDiffusiveFluxIntegralTempl< is_ad, Real >::SideDiffusiveFluxIntegralTempl(), SideSetsGeneratorBase::SideSetsGeneratorBase(), SolutionUserObjectBase::SolutionUserObjectBase(), WebServerControl::startServer(), Terminator::Terminator(), TimeIntervalTimes::TimeIntervalTimes(), TimePeriod::TimePeriod(), MultiAppDofCopyTransfer::transfer(), TransformGenerator::TransformGenerator(), TransientBase::TransientBase(), FunctorIC::value(), VariableCondensationPreconditioner::VariableCondensationPreconditioner(), VectorMagnitudeFunctorMaterialTempl< is_ad >::VectorMagnitudeFunctorMaterialTempl(), WebServerControl::WebServerControl(), XYDelaunayGenerator::XYDelaunayGenerator(), and XYZDelaunayGenerator::XYZDelaunayGenerator().
|
inlinevirtualinherited |
Check of termination has been requested.
This should be called by transient Executioners in the keepGoing() member.
Definition at line 43 of file Problem.h.
Referenced by TransientBase::keepGoing().
|
overridevirtual |
|
overridevirtual |
Reimplemented from SubProblem.
Definition at line 1293 of file DisplacedProblem.C.
|
overridevirtual |
linear_sys_name
Implements SubProblem.
Definition at line 1395 of file DisplacedProblem.C.
|
protectedinherited |
Mark a variable family for either disabling or enabling p-refinement with valid parameters of a variable.
Definition at line 1367 of file SubProblem.C.
Referenced by FEProblemBase::addAuxArrayVariable(), FEProblemBase::addAuxVariable(), and FEProblemBase::addVariable().
|
virtualinherited |
Helper method for adding a material property name to the _material_property_requested set.
Definition at line 724 of file SubProblem.C.
Referenced by MaterialBase::markMatPropRequested(), and MaterialPropertyInterface::markMatPropRequested().
|
overridevirtual |
Check to see if a particular Tag exists.
Reimplemented from SubProblem.
Definition at line 459 of file DisplacedProblem.C.
|
overridevirtual |
Check to see if a particular Tag exists.
Reimplemented from SubProblem.
Definition at line 465 of file DisplacedProblem.C.
|
overridevirtual |
Retrieve the name associated with a TagID.
Reimplemented from SubProblem.
Definition at line 453 of file DisplacedProblem.C.
|
inlineoverridevirtual |
Implements SubProblem.
Definition at line 49 of file DisplacedProblem.h.
Referenced by SidesetAroundSubdomainUpdater::finalize(), and mesh().
|
inlineoverridevirtual |
|
inlineoverride |
Definition at line 51 of file DisplacedProblem.h.
|
pure virtualinherited |
Implemented in FEProblemBase.
void DisplacedProblem::meshChanged | ( | bool | contract_mesh, |
bool | clean_refinement_flags | ||
) |
Definition at line 1116 of file DisplacedProblem.C.
|
inlineinherited |
Definition at line 91 of file MooseBaseErrorInterface.h.
Referenced by FEProblemBase::addAuxArrayVariable(), FEProblemBase::addAuxScalarVariable(), FEProblemBase::addAuxVariable(), FEProblemBase::advanceMultiApps(), MultiApp::appProblem(), MooseMesh::buildSideList(), ChangeOverTimestepPostprocessor::ChangeOverTimestepPostprocessor(), AddVariableAction::determineType(), EigenProblem::EigenProblem(), Eigenvalue::Eigenvalue(), MooseMesh::elem(), UserForcingFunction::f(), FaceFaceConstraint::FaceFaceConstraint(), FunctionDT::FunctionDT(), RandomICBase::generateRandom(), MooseMesh::getBoundariesToElems(), DataFileInterface::getDataFileName(), DataFileInterface::getDataFileNameByName(), Control::getExecuteOptions(), FEProblemBase::getNonlinearSystem(), FEProblemBase::getUserObjects(), FEProblemBase::hasPostprocessor(), MatDiffusionBase< Real >::MatDiffusionBase(), MultiAppNearestNodeTransfer::MultiAppNearestNodeTransfer(), MultiAppShapeEvaluationTransfer::MultiAppShapeEvaluationTransfer(), MultiAppUserObjectTransfer::MultiAppUserObjectTransfer(), NodalScalarKernel::NodalScalarKernel(), MooseMesh::node(), FixedPointSolve::numPicardIts(), RelationshipManager::operator>=(), PercentChangePostprocessor::PercentChangePostprocessor(), ReferenceResidualConvergence::ReferenceResidualConvergence(), Residual::Residual(), MooseMesh::setBoundaryToNormalMap(), Exodus::setOutputDimension(), and UserForcingFunction::UserForcingFunction().
|
inlineinherited |
Emits a documented error with object name and type.
Documented errors are errors that have an issue associated with them.
The repository name repo_name
links a named repository to a URL and should be registered at the application level with registerRepository(). See Moose.C for an example of the "moose" repository registration.
repo_name | The repository name where the issue resides |
issue_num | The number of the issue |
args | The error message to be combined |
Definition at line 61 of file MooseBaseErrorInterface.h.
Referenced by ArrayDGLowerDKernel::ArrayDGLowerDKernel(), ArrayHFEMDirichletBC::ArrayHFEMDirichletBC(), ArrayLowerDIntegratedBC::ArrayLowerDIntegratedBC(), DGLowerDKernel::DGLowerDKernel(), HFEMDirichletBC::HFEMDirichletBC(), and LowerDIntegratedBC::LowerDIntegratedBC().
|
inlineinherited |
Emits an error prefixed with object name and type.
Definition at line 29 of file MooseBaseErrorInterface.h.
Referenced by CopyMeshPartitioner::_do_partition(), HierarchicalGridPartitioner::_do_partition(), GridPartitioner::_do_partition(), PetscExternalPartitioner::_do_partition(), MultiAppGeneralFieldTransfer::acceptPointInOriginMesh(), AddVectorPostprocessorAction::act(), AddICAction::act(), AutoCheckpointAction::act(), CheckFVBCAction::act(), CreateExecutionerAction::act(), AddBoundsVectorsAction::act(), InitProblemAction::act(), SetupMeshCompleteAction::act(), AddMeshGeneratorAction::act(), CheckIntegrityAction::act(), AddFVICAction::act(), CreateProblemAction::act(), CreateProblemDefaultAction::act(), CombineComponentsMeshes::act(), SetupMeshAction::act(), SplitMeshAction::act(), AdaptivityAction::act(), ChainControlSetupAction::act(), DeprecatedBlockAction::act(), SetupPredictorAction::act(), SetupTimeStepperAction::act(), AddTimeStepperAction::act(), CreateDisplacedProblemAction::act(), MaterialDerivativeTestAction::act(), SetAdaptivityOptionsAction::act(), MaterialOutputAction::act(), AddMFEMSubMeshAction::act(), CommonOutputAction::act(), AddPeriodicBCAction::act(), Action::Action(), FEProblemBase::adaptMesh(), ADConservativeAdvectionBC::ADConservativeAdvectionBC(), MooseVariableFV< Real >::adCurlSln(), MooseVariableFV< Real >::adCurlSlnNeighbor(), AddActionComponentAction::AddActionComponentAction(), MFEMProblem::addBoundaryCondition(), FEProblemBase::addBoundaryCondition(), DiffusionCG::addBoundaryConditionsFromComponents(), PhysicsComponentInterface::addBoundaryConditionsFromComponents(), FEProblemBase::addConstraint(), FEProblemBase::addDamper(), FEProblemBase::addDGKernel(), FEProblemBase::addDiracKernel(), DistributedRectilinearMeshGenerator::addElement(), FEProblemBase::addFunction(), SubProblem::addFunctor(), FEProblemBase::addFVInitialCondition(), ADDGKernel::ADDGKernel(), FEProblemBase::addHDGKernel(), FEProblemBase::addInitialCondition(), PhysicsComponentInterface::addInitialConditionsFromComponents(), FEProblemBase::addInterfaceKernel(), MFEMProblem::addKernel(), FEProblemBase::addKernel(), FEProblem::addLineSearch(), FEProblemBase::addLineSearch(), MFEMProblem::addMaterial(), MeshGenerator::addMeshSubgenerator(), MFEMProblem::addMFEMFESpaceFromMOOSEVariable(), FEProblemBase::addOutput(), SubProblem::addPiecewiseByBlockLambdaFunctor(), DiracKernelBase::addPoint(), DistributedRectilinearMeshGenerator::addPoint(), DiracKernelBase::addPointWithValidId(), FEProblemBase::addPostprocessor(), FEProblemBase::addPredictor(), CreateDisplacedProblemAction::addProxyRelationshipManagers(), MooseMesh::addQuadratureNode(), Action::addRelationshipManager(), FEProblemBase::addReporter(), FEProblemBase::addScalarKernel(), AddVariableAction::addVariable(), FEProblemBase::addVectorPostprocessor(), SubProblem::addVectorTag(), MooseLinearVariableFV< Real >::adError(), ADInterfaceKernelTempl< T >::ADInterfaceKernelTempl(), ADPiecewiseLinearInterpolationMaterial::ADPiecewiseLinearInterpolationMaterial(), MooseVariableScalar::adUDot(), Output::advancedExecuteOn(), AdvectiveFluxAux::AdvectiveFluxAux(), MooseVariableBase::allDofIndices(), NEML2ModelExecutor::applyPredictor(), MultiApp::appPostprocessorValue(), MultiApp::appProblem(), MultiApp::appProblemBase(), MultiApp::appUserObjectBase(), ArrayConstantIC::ArrayConstantIC(), ArrayDGKernel::ArrayDGKernel(), ArrayDiffusion::ArrayDiffusion(), ArrayFunctionIC::ArrayFunctionIC(), ArrayReaction::ArrayReaction(), ArrayTimeDerivative::ArrayTimeDerivative(), AddPeriodicBCAction::autoTranslationBoundaries(), AuxKernelTempl< Real >::AuxKernelTempl(), Function::average(), Axisymmetric2D3DSolutionFunction::Axisymmetric2D3DSolutionFunction(), BatchMeshGeneratorAction::BatchMeshGeneratorAction(), BicubicSplineFunction::BicubicSplineFunction(), BlockDeletionGenerator::BlockDeletionGenerator(), BoundingValueElementDamper::BoundingValueElementDamper(), BoundingValueNodalDamper::BoundingValueNodalDamper(), BreakMeshByBlockGeneratorBase::BreakMeshByBlockGeneratorBase(), MooseMesh::buildCoarseningMap(), MultiApp::buildComm(), DistributedRectilinearMeshGenerator::buildCube(), TimedSubdomainModifier::buildFromFile(), PiecewiseTabularBase::buildFromFile(), PiecewiseTabularBase::buildFromJSON(), TimedSubdomainModifier::buildFromParameters(), PiecewiseTabularBase::buildFromXY(), PiecewiseLinearBase::buildInterpolation(), MooseMesh::buildLowerDMesh(), TiledMesh::buildMesh(), GeneratedMesh::buildMesh(), SpiralAnnularMesh::buildMesh(), MeshGeneratorMesh::buildMesh(), ImageMeshGenerator::buildMesh3D(), ImageMesh::buildMesh3D(), MooseMesh::buildRefinementMap(), MaterialBase::buildRequiredMaterials(), MooseMesh::buildSideList(), MooseMesh::buildTypedMesh(), MooseMesh::cacheFaceInfoVariableOwnership(), CartesianGridDivision::CartesianGridDivision(), CartesianMeshGenerator::CartesianMeshGenerator(), ChangeOverFixedPointPostprocessor::ChangeOverFixedPointPostprocessor(), ChangeOverTimePostprocessor::ChangeOverTimePostprocessor(), EigenExecutionerBase::chebyshev(), SubProblem::checkBlockMatProps(), PhysicsBase::checkBlockRestrictionIdentical(), ComponentBoundaryConditionInterface::checkBoundaryConditionsAllRequested(), SubProblem::checkBoundaryMatProps(), PhysicsBase::checkComponentType(), IterationCountConvergence::checkConvergence(), MooseMesh::checkCoordinateSystems(), DiffusionLHDGAssemblyHelper::checkCoupling(), FEProblemBase::checkDependMaterialsHelper(), FEProblemBase::checkDisplacementOrders(), FEProblemBase::checkDuplicatePostprocessorVariableNames(), DefaultConvergenceBase::checkDuplicateSetSharedExecutionerParams(), MooseMesh::checkDuplicateSubdomainNames(), FEProblemBase::checkExceptionAndStopSolve(), NEML2ModelExecutor::checkExecutionStage(), MaterialBase::checkExecutionStage(), MeshGenerator::checkGetMesh(), ReporterTransferInterface::checkHasReporterValue(), FEProblemBase::checkICRestartError(), Steady::checkIntegrity(), EigenExecutionerBase::checkIntegrity(), Eigenvalue::checkIntegrity(), DefaultNonlinearConvergence::checkIterationType(), DefaultMultiAppFixedPointConvergence::checkIterationType(), DefaultSteadyStateConvergence::checkIterationType(), ExplicitTimeIntegrator::checkLinearConvergence(), MeshDiagnosticsGenerator::checkNonConformalMeshFromAdaptivity(), MeshDiagnosticsGenerator::checkNonMatchingEdges(), PostprocessorInterface::checkParam(), FEProblemBase::checkProblemIntegrity(), Sampler::checkReinitStatus(), MultiAppGeneralFieldNearestLocationTransfer::checkRestrictionsForSource(), MultiAppPostprocessorToAuxScalarTransfer::checkSiblingsTransferSupported(), MultiAppScalarToAuxScalarTransfer::checkSiblingsTransferSupported(), MultiAppPostprocessorTransfer::checkSiblingsTransferSupported(), MultiAppReporterTransfer::checkSiblingsTransferSupported(), MultiAppMFEMCopyTransfer::checkSiblingsTransferSupported(), MultiAppCopyTransfer::checkSiblingsTransferSupported(), MultiAppTransfer::checkSiblingsTransferSupported(), MaterialBase::checkStatefulSanity(), AddDefaultConvergenceAction::checkUnusedMultiAppFixedPointConvergenceParameters(), AddDefaultConvergenceAction::checkUnusedNonlinearConvergenceParameters(), AddDefaultConvergenceAction::checkUnusedSteadyStateConvergenceParameters(), FEProblemBase::checkUserObjects(), Moose::PetscSupport::checkUserProvidedPetscOption(), DomainUserObject::checkVariable(), MultiAppTransfer::checkVariable(), MeshDiagnosticsGenerator::checkWatertightNodesets(), MeshDiagnosticsGenerator::checkWatertightSidesets(), LibmeshPartitioner::clone(), MooseMesh::clone(), CombinerGenerator::CombinerGenerator(), ComparisonPostprocessor::comparisonIsTrue(), MooseVariableFieldBase::componentName(), CompositeFunction::CompositeFunction(), ElementH1ErrorFunctionAux::compute(), NodalPatchRecovery::compute(), FEProblemBase::computeBounds(), VariableCondensationPreconditioner::computeDInverseDiag(), CompositionDT::computeDT(), ArrayDGKernel::computeElemNeighJacobian(), ArrayDGKernel::computeElemNeighResidual(), InternalSideIntegralPostprocessor::computeFaceInfoIntegral(), SideIntegralPostprocessor::computeFaceInfoIntegral(), MooseVariableFieldBase::computeFaceValues(), TimeSequenceStepperBase::computeFailedDT(), IterationAdaptiveDT::computeFailedDT(), TimeStepper::computeFailedDT(), MooseMesh::computeFiniteVolumeCoords(), HistogramVectorPostprocessor::computeHistogram(), ArrayKernel::computeJacobian(), ArrayIntegratedBC::computeJacobian(), FVFluxKernel::computeJacobian(), NodalConstraint::computeJacobian(), FEProblemBase::computeJacobianTags(), LowerDIntegratedBC::computeLowerDOffDiagJacobian(), ArrayLowerDIntegratedBC::computeLowerDOffDiagJacobian(), EigenProblem::computeMatricesTags(), ArrayDGKernel::computeOffDiagElemNeighJacobian(), ArrayKernel::computeOffDiagJacobian(), ArrayIntegratedBC::computeOffDiagJacobian(), FVElementalKernel::computeOffDiagJacobian(), MortarScalarBase::computeOffDiagJacobianScalar(), DGLowerDKernel::computeOffDiagLowerDJacobian(), ArrayDGLowerDKernel::computeOffDiagLowerDJacobian(), MaterialBase::computeProperties(), SideFVFluxBCIntegral::computeQpIntegral(), ScalarKernel::computeQpJacobian(), CoupledTiedValueConstraint::computeQpJacobian(), TiedValueConstraint::computeQpJacobian(), NodalEqualValueConstraint::computeQpJacobian(), LinearNodalConstraint::computeQpJacobian(), EqualValueBoundaryConstraint::computeQpJacobian(), NodeElemConstraint::computeQpJacobian(), CoupledTiedValueConstraint::computeQpOffDiagJacobian(), ScalarKernel::computeQpResidual(), MassMatrix::computeQpResidual(), HDGKernel::computeQpResidual(), DiffusionLHDGDirichletBC::computeQpResidual(), NodalEqualValueConstraint::computeQpResidual(), DiffusionLHDGPrescribedGradientBC::computeQpResidual(), IPHDGBC::computeQpResidual(), KernelValue::computeQpResidual(), TorchScriptMaterial::computeQpValues(), InterfaceQpValueUserObject::computeRealValue(), ArrayKernel::computeResidual(), ArrayIntegratedBC::computeResidual(), FVFluxBC::computeResidual(), FVFluxKernel::computeResidual(), NodalConstraint::computeResidual(), FVFluxKernel::computeResidualAndJacobian(), ResidualObject::computeResidualAndJacobian(), FEProblemBase::computeResidualAndJacobian(), HDGKernel::computeResidualAndJacobianOnSide(), FEProblemBase::computeResidualInternal(), FEProblemBase::computeResidualTag(), FEProblemBase::computeResidualTags(), FEProblemBase::computeResidualType(), KernelScalarBase::computeScalarOffDiagJacobian(), ADKernelScalarBase::computeScalarQpResidual(), ADMortarScalarBase::computeScalarQpResidual(), MortarScalarBase::computeScalarQpResidual(), KernelScalarBase::computeScalarQpResidual(), TimeStepper::computeStep(), ActuallyExplicitEuler::computeTimeDerivatives(), ExplicitEuler::computeTimeDerivatives(), ImplicitEuler::computeTimeDerivatives(), BDF2::computeTimeDerivatives(), NewmarkBeta::computeTimeDerivatives(), CentralDifference::computeTimeDerivatives(), CrankNicolson::computeTimeDerivatives(), LStableDirk2::computeTimeDerivatives(), LStableDirk3::computeTimeDerivatives(), ImplicitMidpoint::computeTimeDerivatives(), ExplicitTVDRK2::computeTimeDerivatives(), AStableDirk4::computeTimeDerivatives(), LStableDirk4::computeTimeDerivatives(), ExplicitRK2::computeTimeDerivatives(), MultiAppGeometricInterpolationTransfer::computeTransformation(), BuildArrayVariableAux::computeValue(), TagVectorArrayVariableAux::computeValue(), NearestNodeValueAux::computeValue(), ProjectionAux::computeValue(), PenetrationAux::computeValue(), ConcentricCircleMesh::ConcentricCircleMesh(), ConditionalEnableControl::ConditionalEnableControl(), TimeStepper::constrainStep(), LibtorchNeuralNetControl::controlNeuralNet(), TransientBase::convergedToSteadyState(), ParsedConvergence::convertRealToBool(), CopyMeshPartitioner::CopyMeshPartitioner(), CoupledForceNodalKernel::CoupledForceNodalKernel(), MultiApp::createApp(), AddVariableAction::createInitialConditionAction(), Function::curl(), MooseVariableFV< Real >::curlPhi(), CutMeshByPlaneGenerator::CutMeshByPlaneGenerator(), SidesetInfoVectorPostprocessor::dataHelper(), DebugResidualAux::DebugResidualAux(), ReporterTransferInterface::declareClone(), MeshGenerator::declareMeshProperty(), ReporterTransferInterface::declareVectorClone(), DefaultSteadyStateConvergence::DefaultSteadyStateConvergence(), FunctorRelationshipManager::delete_remote_elements(), MooseMesh::deleteRemoteElements(), BicubicSplineFunction::derivative(), DerivativeSumMaterialTempl< is_ad >::DerivativeSumMaterialTempl(), MooseMesh::detectPairedSidesets(), FEProblemBase::determineSolverSystem(), DGKernel::DGKernel(), MeshDiagnosticsGenerator::diagnosticsLog(), DistributedPositions::DistributedPositions(), Function::div(), FunctorBinnedValuesDivision::divisionIndex(), MooseVariableFV< Real >::divPhi(), FunctorRelationshipManager::dofmap_reinit(), EigenProblem::doFreeNonlinearPowerIterations(), FEProblemBase::duplicateVariableCheck(), EigenProblem::EigenProblem(), Eigenvalue::Eigenvalue(), Eigenvalues::Eigenvalues(), ElementalVariableValue::ElementalVariableValue(), ElementGroupCentroidPositions::ElementGroupCentroidPositions(), ElementIntegerAux::ElementIntegerAux(), ElementMaterialSampler::ElementMaterialSampler(), ElementQualityAux::ElementQualityAux(), ElementSubdomainModifierBase::ElementSubdomainModifierBase(), ElementUOAux::ElementUOAux(), ExtraIDIntegralVectorPostprocessor::elementValue(), DistributedRectilinearMeshGenerator::elemId(), ProjectionAux::elemOnNodeVariableIsDefinedOn(), EigenKernel::enabled(), MooseMesh::errorIfDistributedMesh(), MultiAppTransfer::errorIfObjectExecutesOnTransferInSourceApp(), SideIntegralPostprocessor::errorNoFaceInfo(), SideIntegralFunctorPostprocessorTempl< false >::errorNoFaceInfo(), SolutionUserObjectBase::evalMeshFunction(), SolutionUserObjectBase::evalMeshFunctionGradient(), SolutionUserObjectBase::evalMultiValuedMeshFunction(), SolutionUserObjectBase::evalMultiValuedMeshFunctionGradient(), FixedPointSolve::examineFixedPointConvergence(), MultiAppGeneralFieldTransfer::examineReceivedValueConflicts(), RealToBoolChainControl::execute(), RestartableDataReporter::execute(), DiscreteElementUserObject::execute(), MultiAppScalarToAuxScalarTransfer::execute(), MultiAppPostprocessorToAuxScalarTransfer::execute(), NodalValueSampler::execute(), MultiAppPostprocessorTransfer::execute(), MultiAppPostprocessorInterpolationTransfer::execute(), ElementQualityChecker::execute(), PositionsFunctorValueSampler::execute(), GreaterThanLessThanPostprocessor::execute(), PointValue::execute(), MultiAppVariableValueSampleTransfer::execute(), MultiAppVariableValueSamplePostprocessorTransfer::execute(), FindValueOnLine::execute(), MultiAppNearestNodeTransfer::execute(), MultiAppMFEMCopyTransfer::execute(), MultiAppCopyTransfer::execute(), WebServerControl::execute(), MultiAppUserObjectTransfer::execute(), MultiAppGeometricInterpolationTransfer::execute(), InterfaceQpUserObjectBase::execute(), TransientBase::execute(), LeastSquaresFit::execute(), VectorPostprocessorComparison::execute(), LeastSquaresFitHistory::execute(), TimeExtremeValue::execute(), Eigenvalue::execute(), DomainUserObject::execute(), FEProblemBase::execute(), FEProblemBase::executeControls(), MultiAppVectorPostprocessorTransfer::executeFromMultiapp(), MultiAppVectorPostprocessorTransfer::executeToMultiapp(), Exodus::Exodus(), ExplicitSSPRungeKutta::ExplicitSSPRungeKutta(), MultiAppGeneralFieldTransfer::extractOutgoingPoints(), NEML2ModelExecutor::extractOutputs(), ExtraIDIntegralVectorPostprocessor::ExtraIDIntegralVectorPostprocessor(), FEProblemSolve::FEProblemSolve(), FileOutput::FileOutput(), NEML2ModelExecutor::fillInputs(), QuadraturePointMultiApp::fillPositions(), CentroidMultiApp::fillPositions(), MultiApp::fillPositions(), MultiAppGeometricInterpolationTransfer::fillSourceInterpolationPoints(), VerifyElementUniqueID::finalize(), VerifyNodalUniqueID::finalize(), DiscreteElementUserObject::finalize(), ElementQualityChecker::finalize(), MemoryUsage::finalize(), PointSamplerBase::finalize(), NearestPointAverage::finalize(), NearestPointIntegralVariablePostprocessor::finalize(), Transfer::find_sys(), BreakMeshByBlockGeneratorBase::findFreeBoundaryId(), FunctionDT::FunctionDT(), FunctionMaterialBase< is_ad >::FunctionMaterialBase(), FunctionScalarAux::FunctionScalarAux(), FunctionScalarIC::FunctionScalarIC(), FunctorSmootherTempl< T >::FunctorSmootherTempl(), FVInitialConditionTempl< T >::FVInitialConditionTempl(), FVMassMatrix::FVMassMatrix(), FVMatAdvection::FVMatAdvection(), FVScalarLagrangeMultiplierInterface::FVScalarLagrangeMultiplierInterface(), GapValueAux::GapValueAux(), WorkBalance::gather(), ElementOrderConversionGenerator::generate(), BlockToMeshConverterGenerator::generate(), FileMeshGenerator::generate(), LowerDBlockFromSidesetGenerator::generate(), ExtraNodesetGenerator::generate(), MoveNodeGenerator::generate(), PlaneIDMeshGenerator::generate(), RenameBlockGenerator::generate(), RenameBoundaryGenerator::generate(), SideSetsFromNormalsGenerator::generate(), SmoothMeshGenerator::generate(), SubdomainPerElementGenerator::generate(), TiledMeshGenerator::generate(), BreakMeshByBlockGenerator::generate(), MeshRepairGenerator::generate(), CoarsenBlockGenerator::generate(), FlipSidesetGenerator::generate(), GeneratedMeshGenerator::generate(), MeshDiagnosticsGenerator::generate(), SideSetsFromPointsGenerator::generate(), ParsedGenerateNodeset::generate(), CombinerGenerator::generate(), MeshCollectionGenerator::generate(), AllSideSetsByNormalsGenerator::generate(), AdvancedExtruderGenerator::generate(), MeshExtruderGenerator::generate(), SideSetsFromBoundingBoxGenerator::generate(), StackGenerator::generate(), StitchedMeshGenerator::generate(), XYZDelaunayGenerator::generate(), CutMeshByLevelSetGeneratorBase::generate(), SpiralAnnularMeshGenerator::generate(), XYDelaunayGenerator::generate(), XYMeshLineCutter::generate(), PatternedMeshGenerator::generate(), SubdomainBoundingBoxGenerator::generate(), DistributedRectilinearMeshGenerator::generate(), BoundingBoxNodeSetGenerator::generate(), MeshGenerator::generateData(), GeneratedMesh::GeneratedMesh(), GeneratedMeshGenerator::GeneratedMeshGenerator(), MeshGenerator::generateInternal(), CircularBoundaryCorrectionGenerator::generateRadialCorrectionFactor(), RandomICBase::generateRandom(), GenericConstantMaterialTempl< is_ad >::GenericConstantMaterialTempl(), GenericConstantVectorMaterialTempl< is_ad >::GenericConstantVectorMaterialTempl(), GenericFunctionMaterialTempl< is_ad >::GenericFunctionMaterialTempl(), GenericFunctionVectorMaterialTempl< is_ad >::GenericFunctionVectorMaterialTempl(), GenericFunctorGradientMaterialTempl< is_ad >::GenericFunctorGradientMaterialTempl(), GenericFunctorMaterialTempl< is_ad >::GenericFunctorMaterialTempl(), GenericFunctorTimeDerivativeMaterialTempl< is_ad >::GenericFunctorTimeDerivativeMaterialTempl(), GenericVectorFunctorMaterialTempl< is_ad >::GenericVectorFunctorMaterialTempl(), getActualFieldVariable(), FEProblemBase::getActualFieldVariable(), getArrayVariable(), FEProblemBase::getArrayVariable(), MooseMesh::getAxisymmetricRadialCoord(), MFEMFESpace::getBasis(), NEML2BatchIndexGenerator::getBatchIndex(), MooseMesh::getBlockConnectedBlocks(), VariableOldValueBounds::getBound(), MooseMesh::getBoundaryID(), MultiApp::getBoundingBox(), ChainControl::getChainControlDataByName(), MooseMesh::getCoarseningMap(), MultiApp::getCommandLineArgs(), MooseVariableBase::getContinuity(), Control::getControllableParameterByName(), FEProblemBase::getConvergence(), MooseMesh::getCoordSystem(), PhysicsBase::getCoupledPhysics(), PropertyReadFile::getData(), DataFileInterface::getDataFilePath(), TransfiniteMeshGenerator::getDiscreteEdge(), FEProblemBase::getDistribution(), MooseVariableBase::getDofIndices(), VariableCondensationPreconditioner::getDofToCondense(), TransfiniteMeshGenerator::getEdge(), GhostingUserObject::getElementalValue(), ElementUOProvider::getElementalValueLong(), ElementUOProvider::getElementalValueReal(), PropertyReadFile::getElementData(), MooseMesh::getElementIDIndex(), Material::getElementIDNeighbor(), Material::getElementIDNeighborByName(), MooseMesh::getElemIDMapping(), MooseMesh::getElemIDsOnBlocks(), MultiAppFieldTransfer::getEquationSystem(), MultiApp::getExecutioner(), MFEMVectorFESpace::getFECName(), MultiAppTransfer::getFromMultiApp(), MultiAppTransfer::getFromMultiAppInfo(), FEProblemBase::getFunction(), SubProblem::getFunctor(), FEProblemBase::getFVMatsAndDependencies(), MooseMesh::getGeneralAxisymmetricCoordAxis(), DistributedRectilinearMeshGenerator::getGhostNeighbors(), DistributedRectilinearMeshGenerator::getIndices(), FEProblemBase::getLinearConvergenceNames(), SolutionUserObjectBase::getLocalVarIndex(), Material::getMaterialByName(), FEProblemBase::getMaterialData(), SubProblem::getMatrixTagID(), GeneratedMesh::getMaxInDimension(), AnnularMesh::getMaxInDimension(), FEProblemBase::getMaxQps(), FEProblemBase::getMeshDivision(), MeshGenerator::getMeshGeneratorNameFromParam(), MeshGenerator::getMeshGeneratorNamesFromParam(), AnnularMesh::getMinInDimension(), GeneratedMesh::getMinInDimension(), MultiAppTransfer::getMultiApp(), FEProblemBase::getMultiAppFixedPointConvergenceName(), DistributedRectilinearMeshGenerator::getNeighbors(), Times::getNextTime(), MooseMesh::getNodeBlockIds(), PropertyReadFile::getNodeData(), MooseMesh::getNodeList(), FEProblemBase::getNonlinearConvergenceNames(), EigenProblem::getNonlinearEigenSystem(), FEProblemBase::getNonlinearSystem(), NEML2ModelExecutor::getOutput(), NEML2ModelExecutor::getOutputDerivative(), NEML2ModelExecutor::getOutputParameterDerivative(), MooseMesh::getPairedBoundaryMapping(), MaterialOutputAction::getParams(), ImageMeshGenerator::GetPixelInfo(), ImageMesh::GetPixelInfo(), PlaneIDMeshGenerator::getPlaneID(), Positions::getPosition(), Positions::getPositions(), FEProblemBase::getPositionsObject(), Positions::getPositionsVector2D(), Positions::getPositionsVector3D(), Positions::getPositionsVector4D(), PostprocessorInterface::getPostprocessorValueByNameInternal(), Times::getPreviousTime(), ComponentMaterialPropertyInterface::getPropertyValue(), InterfaceQpUserObjectBase::getQpValue(), MooseMesh::getRefinementMap(), ReporterInterface::getReporterName(), Reporter::getReporterValueName(), FEProblemBase::getSampler(), WebServerControl::getScalarJSONValue(), getScalarVariable(), FEProblemBase::getScalarVariable(), MooseObject::getSharedPtr(), InterfaceQpUserObjectBase::getSideAverageValue(), PhysicsBase::getSolverSystem(), getStandardVariable(), FEProblemBase::getStandardVariable(), FEProblemBase::getSteadyStateConvergenceName(), MooseMesh::getSubdomainBoundaryIds(), TimedSubdomainModifier::getSubdomainIDAndCheck(), getSystem(), FEProblemBase::getSystem(), Times::getTimeAtIndex(), FEProblemBase::getTimeFromStateArg(), TransientBase::getTimeIntegratorNames(), Times::getTimes(), MultiAppTransfer::getToMultiApp(), MultiAppTransfer::getToMultiAppInfo(), MooseMesh::getUniqueCoordSystem(), FEProblemBase::getUserObject(), FEProblemBase::getUserObjectBase(), UserObjectInterface::getUserObjectBaseByName(), UserObjectInterface::getUserObjectName(), NumRelationshipManagers::getValue(), VectorPostprocessorComponent::getValue(), Residual::getValue(), SideAverageValue::getValue(), JSONFileReader::getValue(), LineValueSampler::getValue(), FindValueOnLine::getValueAtPoint(), SubProblem::getVariableHelper(), JSONFileReader::getVector(), VectorPostprocessorInterface::getVectorPostprocessorName(), SubProblem::getVectorTag(), SubProblem::getVectorTagID(), getVectorVariable(), FEProblemBase::getVectorVariable(), GhostingFromUOAux::GhostingFromUOAux(), MultiApp::globalAppToLocal(), MooseParsedVectorFunction::gradient(), Function::gradient(), FEProblemBase::handleException(), Terminator::handleMessage(), MooseVariableBase::hasDoFsOnNodes(), PostprocessorInterface::hasPostprocessor(), PostprocessorInterface::hasPostprocessorByName(), ReporterInterface::hasReporterValue(), ReporterInterface::hasReporterValueByName(), VectorPostprocessorInterface::hasVectorPostprocessor(), VectorPostprocessorInterface::hasVectorPostprocessorByName(), HDGKernel::HDGKernel(), TransientBase::incrementStepOrReject(), FixedPointIterationAdaptiveDT::init(), CrankNicolson::init(), CSVTimeSequenceStepper::init(), ExplicitTimeIntegrator::init(), EigenExecutionerBase::init(), FEProblem::init(), TransientBase::init(), AddAuxVariableAction::init(), IterationAdaptiveDT::init(), Eigenvalue::init(), AddVariableAction::init(), MooseMesh::init(), Sampler::init(), FEProblemBase::init(), MultiApp::init(), FEProblemBase::initialAdaptMesh(), NestedDivision::initialize(), ReporterPositions::initialize(), TransformedPositions::initialize(), DistributedPositions::initialize(), ElementGroupCentroidPositions::initialize(), FunctorPositions::initialize(), ReporterTimes::initialize(), FunctorTimes::initialize(), ParsedDownSelectionPositions::initialize(), ParsedConvergence::initializeConstantSymbol(), PhysicsBase::initializePhysics(), SteffensenSolve::initialSetup(), MultiAppCloneReporterTransfer::initialSetup(), SolutionIC::initialSetup(), PiecewiseLinearBase::initialSetup(), ChainControlDataPostprocessor::initialSetup(), MultiAppConservativeTransfer::initialSetup(), IntegralPreservingFunctionIC::initialSetup(), FullSolveMultiApp::initialSetup(), PiecewiseLinear::initialSetup(), CoarsenedPiecewiseLinear::initialSetup(), LinearFVAdvection::initialSetup(), LinearFVAnisotropicDiffusion::initialSetup(), SolutionScalarAux::initialSetup(), LinearFVDiffusion::initialSetup(), MultiAppGeneralFieldNearestLocationTransfer::initialSetup(), MultiAppDofCopyTransfer::initialSetup(), ExplicitTimeIntegrator::initialSetup(), SolutionAux::initialSetup(), ReferenceResidualConvergence::initialSetup(), NodalVariableValue::initialSetup(), Axisymmetric2D3DSolutionFunction::initialSetup(), Exodus::initialSetup(), CSV::initialSetup(), MooseParsedFunction::initialSetup(), SolutionUserObjectBase::initialSetup(), FEProblemBase::initialSetup(), SubProblem::initialSetup(), AdvancedOutput::initOutputList(), MFEMProblem::initProblemOperator(), AdvancedOutput::initShowHideLists(), Function::integral(), InterfaceDiffusiveFluxIntegralTempl< is_ad >::InterfaceDiffusiveFluxIntegralTempl(), InterfaceIntegralVariableValuePostprocessor::InterfaceIntegralVariableValuePostprocessor(), InterfaceKernelTempl< T >::InterfaceKernelTempl(), InterfaceTimeKernel::InterfaceTimeKernel(), InternalSideIndicatorBase::InternalSideIndicatorBase(), MultiAppGeometricInterpolationTransfer::interpolateTargetPoints(), EigenExecutionerBase::inversePowerIteration(), InversePowerMethod::InversePowerMethod(), Sampler::isAdaptiveSamplingCompleted(), MooseMesh::isBoundaryFullyExternalToSubdomains(), MooseVariableBase::isNodal(), IterationAdaptiveDT::IterationAdaptiveDT(), IterationCountConvergence::IterationCountConvergence(), LeastSquaresFit::LeastSquaresFit(), LibmeshPartitioner::LibmeshPartitioner(), LibtorchNeuralNetControl::LibtorchNeuralNetControl(), LinearCombinationPostprocessor::LinearCombinationPostprocessor(), LinearNodalConstraint::LinearNodalConstraint(), LineMaterialSamplerBase< Real >::LineMaterialSamplerBase(), LineSearch::lineSearch(), LineValueSampler::LineValueSampler(), MultiAppGeneralFieldTransfer::locatePointReceivers(), LowerBoundNodalKernel::LowerBoundNodalKernel(), MooseLinearVariableFV< Real >::lowerDError(), PNGOutput::makePNG(), ReporterPointMarker::markerSetup(), SubProblem::markFamilyPRefinement(), MassMatrix::MassMatrix(), Material::Material(), MaterialRealTensorValueAuxTempl< is_ad >::MaterialRealTensorValueAuxTempl(), MaterialRealVectorValueAuxTempl< T, is_ad, is_functor >::MaterialRealVectorValueAuxTempl(), MaterialStdVectorRealGradientAux::MaterialStdVectorRealGradientAux(), Distribution::median(), FunctorRelationshipManager::mesh_reinit(), MeshDiagnosticsGenerator::MeshDiagnosticsGenerator(), MeshExtruderGenerator::MeshExtruderGenerator(), MeshRepairGenerator::MeshRepairGenerator(), SetupMeshAction::modifyParamsForUseSplit(), MeshMetaDataInterface::mooseErrorInternal(), MooseLinearVariableFV< Real >::MooseLinearVariableFV(), MooseMesh::MooseMesh(), MooseObject::MooseObject(), UserObjectInterface::mooseObjectError(), MooseStaticCondensationPreconditioner::MooseStaticCondensationPreconditioner(), MooseVariableBase::MooseVariableBase(), MooseVariableConstMonomial::MooseVariableConstMonomial(), MoveNodeGenerator::MoveNodeGenerator(), MultiApp::MultiApp(), MultiAppMFEMCopyTransfer::MultiAppMFEMCopyTransfer(), MultiAppPostprocessorTransfer::MultiAppPostprocessorTransfer(), MultiAppTransfer::MultiAppTransfer(), MultiAppUserObjectTransfer::MultiAppUserObjectTransfer(), MultiAppVariableValueSamplePostprocessorTransfer::MultiAppVariableValueSamplePostprocessorTransfer(), NearestNodeDistanceAux::NearestNodeDistanceAux(), NearestNodeValueAux::NearestNodeValueAux(), FEProblemBase::needsPreviousNewtonIteration(), NewmarkBeta::NewmarkBeta(), NodalConstraint::NodalConstraint(), MooseVariableFV< Real >::nodalDofIndex(), MooseVariableFV< Real >::nodalDofIndexNeighbor(), MooseLinearVariableFV< Real >::nodalError(), MooseVariableFV< Real >::nodalMatrixTagValue(), NodalPatchRecoveryBase::nodalPatchRecovery(), NodalPatchRecoveryAuxBase::NodalPatchRecoveryAuxBase(), NodalScalarKernel::NodalScalarKernel(), MooseVariableFV< Real >::nodalValueArray(), MooseVariableFV< Real >::nodalValueOldArray(), MooseVariableFV< Real >::nodalValueOlderArray(), NodalVariableValue::NodalVariableValue(), MooseVariableFV< Real >::nodalVectorTagValue(), DistributedRectilinearMeshGenerator::nodeId(), MooseVariableFV< Real >::numberOfDofsNeighbor(), NumDOFs::NumDOFs(), NumFailedTimeSteps::NumFailedTimeSteps(), DistributedRectilinearMeshGenerator::numNeighbors(), NumNonlinearIterations::NumNonlinearIterations(), NumVars::NumVars(), Output::onInterval(), FunctorRelationshipManager::operator()(), RelationshipManager::operator==(), ActionComponent::outerSurfaceArea(), ActionComponent::outerSurfaceBoundaries(), XDA::output(), SolutionHistory::output(), Exodus::output(), Output::Output(), AdvancedOutput::outputElementalVariables(), AdvancedOutput::outputInput(), AdvancedOutput::outputNodalVariables(), AdvancedOutput::outputPostprocessors(), AdvancedOutput::outputReporters(), AdvancedOutput::outputScalarVariables(), Exodus::outputSetup(), AdvancedOutput::outputSystemInformation(), Console::outputVectorPostprocessors(), AdvancedOutput::outputVectorPostprocessors(), DistributedRectilinearMeshGenerator::paritionSquarely(), PiecewiseBilinear::parse(), ParsedConvergence::ParsedConvergence(), ParsedCurveGenerator::ParsedCurveGenerator(), ParsedODEKernel::ParsedODEKernel(), MultiAppConservativeTransfer::performAdjustment(), ExplicitTimeIntegrator::performExplicitSolve(), PetscExternalPartitioner::PetscExternalPartitioner(), MooseVariableFV< Real >::phiLowerSize(), PhysicsBasedPreconditioner::PhysicsBasedPreconditioner(), PIDTransientControl::PIDTransientControl(), PiecewiseBilinear::PiecewiseBilinear(), PiecewiseLinearInterpolationMaterial::PiecewiseLinearInterpolationMaterial(), PiecewiseMulticonstant::PiecewiseMulticonstant(), PiecewiseMultiInterpolation::PiecewiseMultiInterpolation(), PiecewiseTabularBase::PiecewiseTabularBase(), CutMeshByLevelSetGeneratorBase::pointPairLevelSetInterception(), SolutionUserObjectBase::pointValueGradientWrapper(), SolutionUserObjectBase::pointValueWrapper(), ReporterInterface::possiblyCheckHasReporter(), VectorPostprocessorInterface::possiblyCheckHasVectorPostprocessorByName(), LStableDirk2::postResidual(), LStableDirk3::postResidual(), ImplicitMidpoint::postResidual(), ExplicitTVDRK2::postResidual(), AStableDirk4::postResidual(), LStableDirk4::postResidual(), ExplicitRK2::postResidual(), EigenProblem::postScaleEigenVector(), VariableCondensationPreconditioner::preallocateCondensedJacobian(), ADKernelValueTempl< T >::precomputeQpJacobian(), Predictor::Predictor(), TransientBase::preExecute(), MooseMesh::prepare(), MooseMesh::prepared(), FixedPointSolve::printFixedPointConvergenceReason(), PseudoTimestep::PseudoTimestep(), MultiApp::readCommandLineArguments(), PropertyReadFile::readData(), SolutionUserObjectBase::readExodusII(), SolutionUserObjectBase::readXda(), CoarsenBlockGenerator::recursiveCoarsen(), FunctorRelationshipManager::redistribute(), ReferenceResidualConvergence::ReferenceResidualConvergence(), Sampler::reinit(), RelativeSolutionDifferenceNorm::RelativeSolutionDifferenceNorm(), PhysicsBase::reportPotentiallyMissedParameters(), RinglebMesh::RinglebMesh(), RinglebMeshGenerator::RinglebMeshGenerator(), PiecewiseMultiInterpolation::sample(), ScalarComponentIC::ScalarComponentIC(), MortarScalarBase::scalarVariable(), DistributedRectilinearMeshGenerator::scaleNodalPositions(), BicubicSplineFunction::secondDerivative(), MooseVariableFV< Real >::secondPhi(), MooseVariableFV< Real >::secondPhiFace(), MooseVariableFV< Real >::secondPhiFaceNeighbor(), MooseVariableFV< Real >::secondPhiNeighbor(), FunctorRelationshipManager::set_mesh(), MooseVariableBase::setActiveTags(), DistributedRectilinearMeshGenerator::setBoundaryNames(), MooseMesh::setCoordSystem(), FEProblemBase::setCoupling(), PiecewiseBase::setData(), FileOutput::setFileBaseInternal(), MooseMesh::setGeneralAxisymmetricCoordAxes(), FEProblemSolve::setInnerSolve(), MeshGenerator::setMeshProperty(), FVPointValueConstraint::setMyElem(), FEProblemBase::setNonlocalCouplingMatrix(), Sampler::setNumberOfCols(), Sampler::setNumberOfRandomSeeds(), Sampler::setNumberOfRows(), Exodus::setOutputDimensionInExodusWriter(), AddPeriodicBCAction::setPeriodicVars(), MFEMSolverBase::setPreconditioner(), MultiAppGeneralFieldTransfer::setSolutionVectorValues(), Split::setup(), TransientMultiApp::setupApp(), SetupMeshAction::setupMesh(), TimeSequenceStepperBase::setupSequence(), TransientBase::setupTimeIntegrator(), TimePeriodBase::setupTimes(), IntegratedBCBase::shouldApply(), PhysicsBase::shouldCreateIC(), PhysicsBase::shouldCreateTimeDerivative(), PhysicsBase::shouldCreateVariable(), SideAdvectiveFluxIntegralTempl< is_ad >::SideAdvectiveFluxIntegralTempl(), SideDiffusiveFluxIntegralTempl< is_ad, Real >::SideDiffusiveFluxIntegralTempl(), SideSetsFromNormalsGenerator::SideSetsFromNormalsGenerator(), SideSetsFromPointsGenerator::SideSetsFromPointsGenerator(), SingleMatrixPreconditioner::SingleMatrixPreconditioner(), SolutionTimeAdaptiveDT::SolutionTimeAdaptiveDT(), SolutionUserObjectBase::SolutionUserObjectBase(), ExplicitTVDRK2::solve(), ExplicitRK2::solve(), TimeIntegrator::solve(), FEProblemBase::solverSysNum(), FullSolveMultiApp::solveStep(), SpatialAverageBase::SpatialAverageBase(), UserObject::spatialPoints(), NearestPointAverage::spatialValue(), NearestPointIntegralVariablePostprocessor::spatialValue(), MeshDivisionFunctorReductionVectorPostprocessor::spatialValue(), UserObject::spatialValue(), SpiralAnnularMesh::SpiralAnnularMesh(), SpiralAnnularMeshGenerator::SpiralAnnularMeshGenerator(), WebServerControl::startServer(), StitchedMesh::StitchedMesh(), WebServerControl::stringifyJSONType(), MultiAppGeometricInterpolationTransfer::subdomainIDsNode(), Constraint::subdomainSetup(), NodalUserObject::subdomainSetup(), GeneralUserObject::subdomainSetup(), MaterialBase::subdomainSetup(), FEProblemBase::swapBackMaterialsNeighbor(), systemBaseLinear(), Console::systemInfoFlags(), FEProblemBase::systemNumForVariable(), TerminateChainControl::terminate(), Terminator::Terminator(), CutMeshByLevelSetGeneratorBase::tet4ElemCutter(), ThreadedGeneralUserObject::threadJoin(), DiscreteElementUserObject::threadJoin(), GeneralUserObject::threadJoin(), Function::timeDerivative(), TimedSubdomainModifier::TimedSubdomainModifier(), TimeExtremeValue::TimeExtremeValue(), Function::timeIntegral(), MooseLinearVariableFV< Real >::timeIntegratorError(), TimeIntervalTimes::TimeIntervalTimes(), TimePeriodBase::TimePeriodBase(), VectorPostprocessorVisualizationAux::timestepSetup(), MultiAppDofCopyTransfer::transfer(), MultiAppMFEMCopyTransfer::transfer(), MultiAppShapeEvaluationTransfer::transferVariable(), TransformedPositions::TransformedPositions(), FEProblemBase::trustUserCouplingMatrix(), MooseVariableScalar::uDot(), MooseVariableScalar::uDotDot(), MooseVariableScalar::uDotDotOld(), FEProblemBase::uDotDotOldRequested(), MooseVariableScalar::uDotOld(), FEProblemBase::uDotOldRequested(), Positions::unrollMultiDPositions(), ScalarKernelBase::uOld(), AuxScalarKernel::uOld(), Checkpoint::updateCheckpointFiles(), EqualValueBoundaryConstraint::updateConstrainedNodes(), SolutionUserObjectBase::updateExodusBracketingTimeIndices(), FEProblemBase::updateMaxQps(), MFEMHypreADS::updateSolver(), MFEMHypreAMS::updateSolver(), MFEMHypreBoomerAMG::updateSolver(), MFEMOperatorJacobiSmoother::updateSolver(), MFEMCGSolver::updateSolver(), MFEMGMRESSolver::updateSolver(), MFEMHypreFGMRES::updateSolver(), MFEMHyprePCG::updateSolver(), MFEMHypreGMRES::updateSolver(), MFEMSuperLU::updateSolver(), UpperBoundNodalKernel::UpperBoundNodalKernel(), NearestPointAverage::userObjectValue(), NearestPointIntegralVariablePostprocessor::userObjectValue(), BoundingBoxIC::value(), PiecewiseConstantFromCSV::value(), IntegralPreservingFunctionIC::value(), Axisymmetric2D3DSolutionFunction::value(), Function::value(), ValueRangeMarker::ValueRangeMarker(), ValueThresholdMarker::ValueThresholdMarker(), VariableCondensationPreconditioner::VariableCondensationPreconditioner(), PhysicsBase::variableExists(), MultiAppTransfer::variableIntegrityCheck(), VariableTimeIntegrationAux::VariableTimeIntegrationAux(), AddVariableAction::variableType(), VariableValueVolumeHistogram::VariableValueVolumeHistogram(), VectorMagnitudeFunctorMaterialTempl< is_ad >::VectorMagnitudeFunctorMaterialTempl(), VectorNodalBC::VectorNodalBC(), SubProblem::vectorTagName(), SubProblem::vectorTagType(), MooseParsedGradFunction::vectorValue(), MooseParsedFunction::vectorValue(), Function::vectorValue(), SubProblem::verifyVectorTags(), ActionComponent::volume(), VTKOutput::VTKOutput(), WebServerControl::WebServerControl(), DOFMapOutput::writeStreamToFile(), and Console::writeStreamToFile().
|
inlineinherited |
Emits an error without the prefixing included in mooseError().
Definition at line 40 of file MooseBaseErrorInterface.h.
|
inlineinherited |
Definition at line 98 of file MooseBaseErrorInterface.h.
Referenced by SetupRecoverFileBaseAction::act(), AStableDirk4::AStableDirk4(), MeshDiagnosticsGenerator::checkNonConformalMeshFromAdaptivity(), MultiAppGeneralFieldNearestLocationTransfer::evaluateInterpValuesNearestNode(), PIDTransientControl::execute(), Executioner::Executioner(), ExplicitRK2::ExplicitRK2(), ExplicitTVDRK2::ExplicitTVDRK2(), DataFileInterface::getDataFilePath(), MFEMScalarFESpace::getFECName(), MultiAppTransfer::getPointInTargetAppFrame(), ImplicitMidpoint::ImplicitMidpoint(), ParsedDownSelectionPositions::initialize(), PropertyReadFile::initialize(), MultiAppGeneralFieldTransfer::initialSetup(), InversePowerMethod::InversePowerMethod(), LStableDirk2::LStableDirk2(), LStableDirk3::LStableDirk3(), LStableDirk4::LStableDirk4(), PNGOutput::makeMeshFunc(), NonlinearEigen::NonlinearEigen(), SolutionInvalidityOutput::output(), MultiAppGeneralFieldTransfer::outputValueConflicts(), ProjectionAux::ProjectionAux(), ReferenceResidualConvergence::ReferenceResidualConvergence(), MFEMDataCollection::registerFields(), FEProblemBase::setRestartFile(), SolutionUserObjectBase::SolutionUserObjectBase(), SymmetryTransformGenerator::SymmetryTransformGenerator(), TransientBase::takeStep(), and TransientBase::TransientBase().
|
inlineinherited |
Emits a warning prefixed with object name and type.
Definition at line 75 of file MooseBaseErrorInterface.h.
Referenced by CopyMeshPartitioner::_do_partition(), AddKernelAction::act(), MeshOnlyAction::act(), AddFunctionAction::act(), MaterialOutputAction::act(), CommonOutputAction::act(), MFEMProblem::addFunction(), MooseMesh::addPeriodicVariable(), DiracKernelBase::addPoint(), BoundaryMarker::BoundaryMarker(), DistributedRectilinearMeshGenerator::buildCube(), MultiAppVariableValueSamplePostprocessorTransfer::cacheElemToPostprocessorData(), CartesianMeshGenerator::CartesianMeshGenerator(), CheckOutputAction::checkConsoleOutput(), MultiAppTransfer::checkMultiAppExecuteOn(), MeshDiagnosticsGenerator::checkNonMatchingEdges(), ActionComponent::checkRequiredTasks(), PhysicsBase::checkRequiredTasks(), SampledOutput::cloneMesh(), MultiAppGeneralFieldTransfer::closestToPosition(), VariableValueElementSubdomainModifier::computeSubdomainID(), GapValueAux::computeValue(), MultiApp::createApp(), DebugResidualAux::DebugResidualAux(), MeshDiagnosticsGenerator::diagnosticsLog(), CylindricalGridDivision::divisionIndex(), SphericalGridDivision::divisionIndex(), CartesianGridDivision::divisionIndex(), ElementMaterialSampler::ElementMaterialSampler(), Postprocessor::evaluateDotWarning(), MeshDivisionFunctorReductionVectorPostprocessor::execute(), ElementQualityChecker::finalize(), FiniteDifferencePreconditioner::FiniteDifferencePreconditioner(), FixedPointSolve::FixedPointSolve(), SubdomainPerElementGenerator::generate(), StitchedMeshGenerator::generate(), ParsedGenerateSideset::generate(), MultiAppTransfer::getAppInfo(), FunctorBinnedValuesDivision::getBinIndex(), DataFileInterface::getDataFilePath(), PointSamplerBase::getLocalElemContainingPoint(), FEProblemBase::getMaterial(), LineValueSampler::getValue(), Terminator::handleMessage(), IndicatorMarker::IndicatorMarker(), CylindricalGridDivision::initialize(), SphericalGridDivision::initialize(), ElementGroupCentroidPositions::initialize(), CartesianGridDivision::initialize(), MultiAppGeneralFieldNearestLocationTransfer::initialSetup(), BoundsBase::initialSetup(), ReferenceResidualConvergence::initialSetup(), MultiAppGeneralFieldTransfer::initialSetup(), FEProblemBase::initialSetup(), AdvancedOutput::initPostprocessorOrVectorPostprocessorLists(), MaterialBase::initStatefulProperties(), LeastSquaresFit::LeastSquaresFit(), IterationAdaptiveDT::limitDTToPostprocessorValue(), FEProblemBase::mesh(), MultiAppGeneralFieldTransfer::MultiAppGeneralFieldTransfer(), NewmarkBeta::NewmarkBeta(), NodalPatchRecovery::NodalPatchRecovery(), NonlocalIntegratedBC::NonlocalIntegratedBC(), NonlocalKernel::NonlocalKernel(), Output::Output(), MultiAppGeneralFieldTransfer::outputValueConflicts(), PiecewiseConstantFromCSV::PiecewiseConstantFromCSV(), Executioner::problem(), PropertyReadFile::readData(), TestSourceStepper::rejectStep(), PhysicsBase::reportPotentiallyMissedParameters(), MaterialBase::resetQpProperties(), SecondTimeDerivativeAux::SecondTimeDerivativeAux(), MooseMesh::setCoordSystem(), SidesetAroundSubdomainUpdater::SidesetAroundSubdomainUpdater(), FEProblemBase::sizeZeroes(), TransientMultiApp::solveStep(), Tecplot::Tecplot(), TimeDerivativeAux::TimeDerivativeAux(), Checkpoint::updateCheckpointFiles(), SampledOutput::updateSample(), PiecewiseConstantFromCSV::value(), and VariableCondensationPreconditioner::VariableCondensationPreconditioner().
|
inlineinherited |
Emits a warning without the prefixing included in mooseWarning().
Definition at line 85 of file MooseBaseErrorInterface.h.
|
inlinevirtualinherited |
Get the name of the class.
Reimplemented in MooseVariableBase.
Definition at line 57 of file MooseBase.h.
Referenced by AddElementalFieldAction::act(), CopyNodalVarsAction::act(), AdaptivityAction::act(), AddTimeStepperAction::act(), DeprecatedBlockAction::act(), SetupTimeIntegratorAction::act(), AddActionComponentAction::act(), DisplayGhostingAction::act(), MaterialOutputAction::act(), AddPeriodicBCAction::act(), FEProblemBase::addAnyRedistributers(), Executioner::addAttributeReporter(), MFEMProblem::addAuxKernel(), FEProblemBase::addAuxKernel(), FEProblemBase::addAuxScalarKernel(), addAuxVariable(), MFEMProblem::addBoundaryCondition(), FEProblemBase::addBoundaryCondition(), PhysicsComponentInterface::addComponent(), FEProblemBase::addConstraint(), FEProblemBase::addConvergence(), FEProblemBase::addDamper(), Registry::addDataFilePath(), FEProblemBase::addDGKernel(), FEProblemBase::addDiracKernel(), FEProblemBase::addDistribution(), MooseApp::addExecutor(), MooseApp::addExecutorParams(), MFEMProblem::addFESpace(), MFEMProblem::addFunction(), FEProblemBase::addFunction(), SubProblem::addFunctor(), MFEMProblem::addFunctorMaterial(), FEProblemBase::addFunctorMaterial(), FunctorMaterial::addFunctorProperty(), FunctorMaterial::addFunctorPropertyByBlocks(), FEProblemBase::addFVBC(), FEProblemBase::addFVInitialCondition(), FEProblemBase::addFVInterfaceKernel(), FEProblemBase::addFVKernel(), ADDGKernel::ADDGKernel(), FEProblemBase::addHDGKernel(), FEProblemBase::addIndicator(), MFEMProblem::addInitialCondition(), FEProblemBase::addInitialCondition(), FEProblemBase::addInterfaceKernel(), FEProblemBase::addInterfaceMaterial(), MFEMProblem::addKernel(), FEProblemBase::addKernel(), FEProblemBase::addLinearFVBC(), FEProblemBase::addLinearFVKernel(), FEProblemBase::addMarker(), FEProblemBase::addMaterial(), FEProblemBase::addMaterialHelper(), ComponentMaterialPropertyInterface::addMaterials(), FEProblemBase::addMeshDivision(), MooseApp::addMeshGenerator(), ComponentMeshTransformHelper::addMeshGenerators(), CylinderComponent::addMeshGenerators(), MeshGenerator::addMeshSubgenerator(), MFEMProblem::addMFEMPreconditioner(), MFEMProblem::addMFEMSolver(), FEProblemBase::addMultiApp(), FEProblemBase::addNodalKernel(), FEProblemBase::addObject(), ComponentPhysicsInterface::addPhysics(), SubProblem::addPiecewiseByBlockLambdaFunctor(), MFEMProblem::addPostprocessor(), FEProblemBase::addPostprocessor(), InitialConditionBase::addPostprocessorDependencyHelper(), UserObject::addPostprocessorDependencyHelper(), FEProblemBase::addPredictor(), CreateDisplacedProblemAction::addProxyRelationshipManagers(), Action::addRelationshipManager(), FEProblemBase::addReporter(), FEProblemBase::addSampler(), FEProblemBase::addScalarKernel(), FEProblemBase::addTimeIntegrator(), MFEMProblem::addTransfer(), FEProblemBase::addTransfer(), FEProblemBase::addUserObject(), InitialConditionBase::addUserObjectDependencyHelper(), UserObject::addUserObjectDependencyHelper(), AuxKernelTempl< Real >::addUserObjectDependencyHelper(), addVariable(), FEProblemBase::addVectorPostprocessor(), UserObject::addVectorPostprocessorDependencyHelper(), Output::advancedExecuteOn(), AdvancedExtruderGenerator::AdvancedExtruderGenerator(), MooseApp::appBinaryName(), MooseApp::appendMeshGenerator(), Registry::appNameFromAppPath(), MultiApp::appPostprocessorValue(), MultiApp::appProblem(), MultiApp::appProblemBase(), MultiApp::appUserObjectBase(), ArrayDGKernel::ArrayDGKernel(), PhysicsBase::assignBlocks(), AStableDirk4::AStableDirk4(), AuxKernelTempl< Real >::AuxKernelTempl(), Function::average(), MultiApp::backup(), CoarsenedPiecewiseLinear::buildCoarsenedGrid(), MFEMFESpace::buildFEC(), PiecewiseTabularBase::buildFromFile(), MultiAppVariableValueSamplePostprocessorTransfer::cacheElemToPostprocessorData(), MooseBase::callMooseError(), ChangeOverFixedPointPostprocessor::ChangeOverFixedPointPostprocessor(), ChangeOverTimePostprocessor::ChangeOverTimePostprocessor(), PhysicsBase::checkBlockRestrictionIdentical(), PhysicsBase::checkComponentType(), ParsedConvergence::checkConvergence(), DefaultNonlinearConvergence::checkConvergence(), FEProblemBase::checkDependMaterialsHelper(), ReporterTransferInterface::checkHasReporterValue(), FEProblemBase::checkICRestartError(), Material::checkMaterialProperty(), MooseApp::checkMetaDataIntegrity(), Damper::checkMinDamping(), Checkpoint::checkpointInfo(), Coupleable::checkWritableVar(), CompositeFunction::CompositeFunction(), MaterialBase::computeProperties(), FEProblemBase::computeUserObjectByName(), VectorPostprocessorVisualizationAux::computeValue(), MooseBaseParameterInterface::connectControllableParams(), ConstantPostprocessor::ConstantPostprocessor(), CommonOutputAction::create(), MultiApp::createApp(), MooseApp::createExecutors(), MeshGeneratorSystem::createMeshGeneratorOrder(), MooseApp::createRecoverablePerfGraph(), CutMeshByPlaneGenerator::CutMeshByPlaneGenerator(), MaterialBase::declareADProperty(), MeshGenerator::declareMeshesForSubByName(), MeshGenerator::declareNullMeshName(), MaterialBase::declareProperty(), DOFMapOutput::demangle(), DerivativeSumMaterialTempl< is_ad >::DerivativeSumMaterialTempl(), Registry::determineDataFilePath(), DGKernel::DGKernel(), DGKernelBase::DGKernelBase(), DomainUserObject::DomainUserObject(), DumpObjectsProblem::dumpObjectHelper(), ElementGroupCentroidPositions::ElementGroupCentroidPositions(), ElementMaterialSampler::ElementMaterialSampler(), ElementValueSampler::ElementValueSampler(), EigenKernel::enabled(), MooseMesh::errorIfDistributedMesh(), MooseBase::errorPrefix(), SolutionUserObjectBase::evalMeshFunction(), SolutionUserObjectBase::evalMeshFunctionGradient(), SolutionUserObjectBase::evalMultiValuedMeshFunction(), SolutionUserObjectBase::evalMultiValuedMeshFunctionGradient(), SideValueSampler::execute(), RestartableDataReporter::execute(), PointValue::execute(), MultiAppNearestNodeTransfer::execute(), WebServerControl::execute(), MultiAppGeneralFieldTransfer::execute(), ActionWarehouse::executeActionsWithAction(), Exodus::Exodus(), ExtraIDIntegralVectorPostprocessor::ExtraIDIntegralVectorPostprocessor(), FEProblemBase::FEProblemBase(), MultiApp::fillPositions(), PointSamplerBase::finalize(), ChainControl::fullControlDataName(), FunctionDT::FunctionDT(), FunctionIC::functionName(), FVFunctionIC::functionName(), FunctorPositions::FunctorPositions(), FunctorSmootherTempl< T >::FunctorSmootherTempl(), FVOneVarDiffusionInterface::FVOneVarDiffusionInterface(), MooseServer::gatherDocumentSymbols(), BoundaryDeletionGenerator::generate(), UniqueExtraIDMeshGenerator::generate(), RenameBlockGenerator::generate(), RenameBoundaryGenerator::generate(), GeneratedMeshGenerator::generate(), BreakMeshByBlockGenerator::generate(), ParsedSubdomainGeneratorBase::generate(), ParsedExtraElementIDGenerator::generate(), StitchedMeshGenerator::generate(), XYDelaunayGenerator::generate(), SubdomainBoundingBoxGenerator::generate(), MeshGenerator::generateInternal(), InterfaceMaterial::getADMaterialProperty(), Material::getADMaterialProperty(), MultiAppTransfer::getAppInfo(), MultiApp::getBoundingBox(), MooseApp::getCheckpointDirectories(), Control::getControllableParameterByName(), Control::getControllableValue(), Control::getControllableValueByName(), FEProblemBase::getConvergence(), Registry::getDataFilePath(), UserObject::getDependObjects(), DistributionInterface::getDistribution(), FEProblemBase::getDistribution(), DistributionInterface::getDistributionByName(), ElementUOProvider::getElementalValueLong(), ElementUOProvider::getElementalValueReal(), MultiApp::getExecutioner(), MooseApp::getExecutor(), FEProblemBase::getExecutor(), OutputWarehouse::getFileNumbers(), FEProblemBase::getFunction(), SubProblem::getFunctor(), NodalPatchRecovery::getGenericMaterialProperty(), InterfaceMaterial::getGenericMaterialProperty(), Material::getGenericMaterialProperty(), AuxKernelTempl< Real >::getGenericMaterialProperty(), InterfaceMaterial::getGenericNeighborMaterialProperty(), InterfaceMaterial::getGenericNeighborMaterialPropertyByName(), Material::getGenericOptionalMaterialProperty(), MaterialBase::getGenericZeroMaterialProperty(), MFEMProblem::getGridFunction(), SolutionUserObjectBase::getLocalVarIndex(), Marker::getMarkerValue(), Material::getMaterial(), FEProblemBase::getMaterial(), Material::getMaterialByName(), NodalPatchRecovery::getMaterialProperty(), InterfaceMaterial::getMaterialProperty(), Material::getMaterialProperty(), AuxKernelTempl< Real >::getMaterialProperty(), SubProblem::getMaterialPropertyBlockNames(), SubProblem::getMaterialPropertyBoundaryNames(), NodalPatchRecovery::getMaterialPropertyOld(), InterfaceMaterial::getMaterialPropertyOld(), Material::getMaterialPropertyOld(), AuxKernelTempl< Real >::getMaterialPropertyOld(), NodalPatchRecovery::getMaterialPropertyOlder(), InterfaceMaterial::getMaterialPropertyOlder(), Material::getMaterialPropertyOlder(), AuxKernelTempl< Real >::getMaterialPropertyOlder(), MFEMGeneralUserObject::getMatrixCoefficient(), MFEMGeneralUserObject::getMatrixCoefficientByName(), MeshGenerator::getMesh(), FEProblemBase::getMeshDivision(), MeshGenerator::getMeshesByName(), MooseApp::getMeshGenerator(), MeshGenerator::getMeshGeneratorNameFromParam(), MeshGenerator::getMeshGeneratorNamesFromParam(), ActionWarehouse::getMooseAppName(), MultiAppTransfer::getMultiApp(), InterfaceMaterial::getNeighborADMaterialProperty(), InterfaceMaterial::getNeighborMaterialProperty(), InterfaceMaterial::getNeighborMaterialPropertyOld(), InterfaceMaterial::getNeighborMaterialPropertyOlder(), MooseServer::getObjectParameters(), Material::getOptionalADMaterialProperty(), Material::getOptionalMaterialProperty(), Material::getOptionalMaterialPropertyOld(), Material::getOptionalMaterialPropertyOlder(), OutputWarehouse::getOutput(), MooseApp::getParam(), FEProblemBase::getPositionsObject(), FEProblemBase::getPostprocessorValueByName(), ComponentMaterialPropertyInterface::getPropertyValue(), ReporterData::getReporterInfo(), MooseApp::getRestartableDataMap(), MooseApp::getRestartableDataMapName(), MooseApp::getRestartableMetaData(), FEProblemBase::getSampler(), MFEMGeneralUserObject::getScalarCoefficient(), MFEMGeneralUserObject::getScalarCoefficientByName(), TransientBase::getTimeStepperName(), ProjectedStatefulMaterialStorageAction::getTypeEnum(), FEProblemBase::getUserObject(), FEProblemBase::getUserObjectBase(), MFEMGeneralUserObject::getVectorCoefficient(), MFEMGeneralUserObject::getVectorCoefficientByName(), Terminator::handleMessage(), Control::hasControllableParameterByName(), FEProblemBase::hasConvergence(), FEProblemBase::hasFunction(), SubProblem::hasFunctor(), SubProblem::hasFunctorWithType(), MooseApp::hasMeshGenerator(), AdvancedOutput::hasOutputHelper(), FEProblemBase::hasPostprocessor(), FEProblemBase::hasPostprocessorValueByName(), MooseApp::hasRelationshipManager(), MooseApp::hasRestartableDataMap(), MooseApp::hasRestartableMetaData(), FEProblemBase::hasUserObject(), IterationAdaptiveDT::init(), AddVariableAction::init(), AdvancedOutput::init(), AdvancedOutput::initExecutionTypes(), AttribName::initFrom(), NestedDivision::initialize(), TransformedPositions::initialize(), JSONOutput::initialSetup(), SideFVFluxBCIntegral::initialSetup(), SolutionScalarAux::initialSetup(), MultiAppProjectionTransfer::initialSetup(), NodalVariableValue::initialSetup(), Console::initialSetup(), SolutionUserObjectBase::initialSetup(), AdvancedOutput::initOutputList(), AdvancedOutput::initPostprocessorOrVectorPostprocessorLists(), MaterialBase::initStatefulProperties(), Function::integral(), InterfaceKernelTempl< T >::InterfaceKernelTempl(), MeshGenerator::isChildMeshGenerator(), MeshGenerator::isNullMeshName(), MooseApp::isParamValid(), MeshGenerator::isParentMeshGenerator(), LinearCombinationFunction::LinearCombinationFunction(), FEProblemBase::logAdd(), Marker::Marker(), MaterialBase::markMatPropRequested(), MatDiffusionBase< Real >::MatDiffusionBase(), Material::Material(), MaterialDerivativeTestKernelBase< Real >::MaterialDerivativeTestKernelBase(), Distribution::median(), MemoryUsageReporter::MemoryUsageReporter(), MeshGenerator::meshPropertyPrefix(), OutputWarehouse::mooseConsole(), MooseVariableInterface< Real >::MooseVariableInterface(), MultiAppGeneralFieldTransfer::MultiAppGeneralFieldTransfer(), MultiAppUserObjectTransfer::MultiAppUserObjectTransfer(), NodalPatchRecoveryAuxBase::NodalPatchRecoveryAuxBase(), NodalValueSampler::NodalValueSampler(), Registry::objData(), MeshGenerator::Comparator::operator()(), ProgressOutput::output(), DOFMapOutput::output(), Output::Output(), AdvancedOutput::outputElementalVariables(), ConsoleUtils::outputExecutionInformation(), MaterialOutputAction::outputHelper(), AdvancedOutput::outputInput(), AdvancedOutput::outputNodalVariables(), Exodus::outputPostprocessors(), AdvancedOutput::outputPostprocessors(), TableOutput::outputReporter(), AdvancedOutput::outputReporters(), AdvancedOutput::outputScalarVariables(), AdvancedOutput::outputSystemInformation(), AdvancedOutput::outputVectorPostprocessors(), ParsedCurveGenerator::ParsedCurveGenerator(), MooseServer::parseDocumentForDiagnostics(), ParsedODEKernel::ParsedODEKernel(), ComponentPhysicsInterface::physicsExists(), PiecewiseBilinear::PiecewiseBilinear(), PiecewiseByBlockFunctorMaterialTempl< T >::PiecewiseByBlockFunctorMaterialTempl(), MooseApp::possiblyLoadRestartableMetaData(), PhysicsBase::prefix(), MooseMesh::prepare(), BlockRestrictionDebugOutput::printBlockRestrictionMap(), PerfGraphLivePrint::printStats(), MultiApp::readCommandLineArguments(), Receiver::Receiver(), Executor::Result::record(), AppFactory::reg(), Registry::registerObjectsTo(), FEProblemBase::registerRandomInterface(), MooseApp::registerRestartableDataMapName(), MooseApp::registerRestartableNameWithFilter(), GlobalParamsAction::remove(), MaterialBase::resetQpProperties(), MultiApp::restore(), ScalarComponentIC::ScalarComponentIC(), MultiApp::setAppOutputFileBase(), MooseMesh::setBoundaryName(), Control::setControllableValue(), Control::setControllableValueByName(), GlobalParamsAction::setDoubleIndexParam(), OutputWarehouse::setFileNumbers(), GlobalParamsAction::setParam(), FEProblemBase::setPostprocessorValueByName(), FEProblemBase::setResidualObjectParamsAndLog(), GlobalParamsAction::setScalarParam(), MooseMesh::setSubdomainName(), GlobalParamsAction::setTripleIndexParam(), NodeSetsGeneratorBase::setup(), Split::setup(), SideSetsGeneratorBase::setup(), TransientMultiApp::setupApp(), GlobalParamsAction::setVectorParam(), FullSolveMultiApp::showStatusMessage(), SideSetExtruderGenerator::SideSetExtruderGenerator(), TransientMultiApp::solveStep(), UserObject::spatialValue(), WebServerControl::startServer(), StitchedMesh::StitchedMesh(), SubProblem::storeBoundaryDelayedCheckMatProp(), SubProblem::storeBoundaryMatPropName(), MaterialBase::storeBoundaryZeroMatProp(), SubProblem::storeBoundaryZeroMatProp(), SubProblem::storeSubdomainDelayedCheckMatProp(), SubProblem::storeSubdomainMatPropName(), MaterialBase::storeSubdomainZeroMatProp(), SubProblem::storeSubdomainZeroMatProp(), MaterialBase::subdomainSetup(), TaggingInterface::TaggingInterface(), VectorPostprocessorVisualizationAux::timestepSetup(), to_json(), MultiAppDofCopyTransfer::transfer(), TransientMultiApp::TransientMultiApp(), MooseServer::traverseParseTreeAndFillSymbols(), MooseBase::typeAndName(), MooseBaseParameterInterface::uniqueParameterName(), FVFluxBC::uOnGhost(), FVFluxBC::uOnUSub(), UserObject::UserObject(), UserObjectInterface::userObjectName(), ParsedAux::validateGenericVectorNames(), PhysicsBase::variableExists(), MultiAppTransfer::variableIntegrityCheck(), VectorMagnitudeFunctorMaterialTempl< is_ad >::VectorMagnitudeFunctorMaterialTempl(), Convergence::verboseOutput(), AdvancedOutput::wantOutput(), Coupleable::writableCoupledValue(), Coupleable::writableVariable(), Console::write(), and MooseApp::writeRestartableMetaData().
|
overridevirtual |
marks this problem as including/needing finite volume functionality.
Implements SubProblem.
Definition at line 1371 of file DisplacedProblem.C.
|
virtualinherited |
nl_sys_num
is converged. Reimplemented in MFEMProblem.
Definition at line 716 of file SubProblem.C.
Reimplemented in FEProblemBase.
Definition at line 766 of file SubProblem.C.
Referenced by IterationInfo::execute(), and NumLinearIterations::getValue().
|
overridevirtual |
nl_sys_name
Implements SubProblem.
Definition at line 1389 of file DisplacedProblem.C.
|
virtualinherited |
Reimplemented in FEProblemBase.
Definition at line 760 of file SubProblem.C.
Referenced by IterationInfo::execute(), and NumNonlinearIterations::finalize().
|
overridevirtual |
Implements SubProblem.
Definition at line 1407 of file DisplacedProblem.C.
|
overridevirtual |
Implements SubProblem.
Definition at line 1341 of file DisplacedProblem.C.
|
overridevirtual |
The total number of tags.
Reimplemented from SubProblem.
Definition at line 471 of file DisplacedProblem.C.
|
overridevirtual |
Implements SubProblem.
Definition at line 1335 of file DisplacedProblem.C.
|
overridevirtual |
Implements SubProblem.
Definition at line 1347 of file DisplacedProblem.C.
|
overridevirtual |
The total number of tags, which can be limited to the tag type.
Reimplemented from SubProblem.
Definition at line 423 of file DisplacedProblem.C.
|
overridevirtual |
|
overridevirtual |
|
delete |
|
inherited |
Emits an error prefixed with the file and line number of the given param (from the input file) along with the full parameter path+name followed by the given args as the message.
If this object's parameters were not created directly by the Parser, then this function falls back to the normal behavior of mooseError - only printing a message using the given args.
Definition at line 255 of file MooseBaseParameterInterface.h.
Referenced by HierarchicalGridPartitioner::_do_partition(), AutoCheckpointAction::act(), SetupDebugAction::act(), CommonOutputAction::act(), AddPeriodicBCAction::act(), ADConservativeAdvectionBC::ADConservativeAdvectionBC(), DiffusionCG::addFEKernels(), DiffusionFV::addFVKernels(), NEML2ModelExecutor::addGatheredParameter(), NEML2ModelExecutor::addGatheredVariable(), ADDGKernel::ADDGKernel(), CylinderComponent::addMeshGenerators(), AddPeriodicBCAction::AddPeriodicBCAction(), ReporterPointSource::addPoints(), ADIntegratedBCTempl< T >::ADIntegratedBCTempl(), ADKernelTempl< T >::ADKernelTempl(), ADNodalKernel::ADNodalKernel(), ADPenaltyPeriodicSegmentalConstraint::ADPenaltyPeriodicSegmentalConstraint(), ADPeriodicSegmentalConstraint::ADPeriodicSegmentalConstraint(), AdvancedExtruderGenerator::AdvancedExtruderGenerator(), AdvectiveFluxAux::AdvectiveFluxAux(), ADVectorFunctionDirichletBC::ADVectorFunctionDirichletBC(), AnnularMesh::AnnularMesh(), AnnularMeshGenerator::AnnularMeshGenerator(), ArrayBodyForce::ArrayBodyForce(), ArrayDGKernel::ArrayDGKernel(), ArrayDGLowerDKernel::ArrayDGLowerDKernel(), ArrayDirichletBC::ArrayDirichletBC(), ArrayHFEMDirichletBC::ArrayHFEMDirichletBC(), ArrayIntegratedBC::ArrayIntegratedBC(), ArrayKernel::ArrayKernel(), ArrayLowerDIntegratedBC::ArrayLowerDIntegratedBC(), ArrayParsedAux::ArrayParsedAux(), ArrayPenaltyDirichletBC::ArrayPenaltyDirichletBC(), ArrayVacuumBC::ArrayVacuumBC(), ArrayVarReductionAux::ArrayVarReductionAux(), ParsedSubdomainIDsGenerator::assignElemSubdomainID(), AuxKernelTempl< Real >::AuxKernelTempl(), BatchMeshGeneratorAction::BatchMeshGeneratorAction(), BlockDeletionGenerator::BlockDeletionGenerator(), BlockWeightedPartitioner::BlockWeightedPartitioner(), BoundsBase::BoundsBase(), BreakMeshByBlockGenerator::BreakMeshByBlockGenerator(), BuildArrayVariableAux::BuildArrayVariableAux(), PiecewiseTabularBase::buildFromFile(), MFEMMesh::buildMesh(), CartesianGridDivision::CartesianGridDivision(), checkComponent(), MeshGenerator::checkGetMesh(), ComponentInitialConditionInterface::checkInitialConditionsAllRequested(), BatchMeshGeneratorAction::checkInputParameterType(), PhysicsBase::checkIntegrityEarly(), PostprocessorInterface::checkParam(), FEProblemBase::checkProblemIntegrity(), MultiAppReporterTransfer::checkSiblingsTransferSupported(), Coupleable::checkVar(), MultiAppTransfer::checkVariable(), CircularBoundaryCorrectionGenerator::CircularBoundaryCorrectionGenerator(), CircularBoundaryCorrectionGenerator::circularCenterCalculator(), MultiAppGeneralFieldTransfer::closestToPosition(), CoarsenBlockGenerator::CoarsenBlockGenerator(), CombinerGenerator::CombinerGenerator(), ComponentInitialConditionInterface::ComponentInitialConditionInterface(), ComponentMaterialPropertyInterface::ComponentMaterialPropertyInterface(), CompositionDT::CompositionDT(), FunctorAux::computeValue(), ConcentricCircleMeshGenerator::ConcentricCircleMeshGenerator(), LibtorchNeuralNetControl::conditionalParameterError(), ConservativeAdvectionTempl< is_ad >::ConservativeAdvectionTempl(), ConstantVectorPostprocessor::ConstantVectorPostprocessor(), ContainsPointAux::ContainsPointAux(), CopyValueAux::CopyValueAux(), Coupleable::Coupleable(), CoupledForceTempl< is_ad >::CoupledForceTempl(), CoupledValueFunctionMaterialTempl< is_ad >::CoupledValueFunctionMaterialTempl(), MultiApp::createApp(), MeshGeneratorSystem::createMeshGenerator(), CylindricalGridDivision::CylindricalGridDivision(), ConstantReporter::declareConstantReporterValues(), AccumulateReporter::declareLateValues(), DefaultMultiAppFixedPointConvergence::DefaultMultiAppFixedPointConvergence(), DGKernel::DGKernel(), DGKernelBase::DGKernelBase(), DGLowerDKernel::DGLowerDKernel(), DiffusionFluxAux::DiffusionFluxAux(), DomainUserObject::DomainUserObject(), EigenProblem::EigenProblem(), Eigenvalue::Eigenvalue(), ElementGroupCentroidPositions::ElementGroupCentroidPositions(), ElementLengthAux::ElementLengthAux(), ElementLpNormAux::ElementLpNormAux(), ExtraIDIntegralVectorPostprocessor::elementValue(), ElementValueSampler::ElementValueSampler(), ElementVectorL2Error::ElementVectorL2Error(), EqualValueEmbeddedConstraintTempl< is_ad >::EqualValueEmbeddedConstraintTempl(), ReporterPointSource::errorCheck(), ExamplePatchMeshGenerator::ExamplePatchMeshGenerator(), MultiAppNearestNodeTransfer::execute(), MultiAppUserObjectTransfer::execute(), ExtraElementIDAux::ExtraElementIDAux(), ExtraElementIntegerDivision::ExtraElementIntegerDivision(), ExtraIDIntegralVectorPostprocessor::ExtraIDIntegralVectorPostprocessor(), FEProblemSolve::FEProblemSolve(), FileMeshGenerator::FileMeshGenerator(), FillBetweenCurvesGenerator::FillBetweenCurvesGenerator(), FillBetweenSidesetsGenerator::FillBetweenSidesetsGenerator(), ReporterPointSource::fillPoint(), SpatialUserObjectVectorPostprocessor::fillPoints(), CombinerGenerator::fillPositions(), MultiApp::fillPositions(), InternalSideIndicatorBase::finalize(), ForcingFunctionAux::ForcingFunctionAux(), FullSolveMultiApp::FullSolveMultiApp(), FunctionArrayAux::FunctionArrayAux(), FunctionValuePostprocessor::FunctionValuePostprocessor(), FunctorADConverterTempl< T >::FunctorADConverterTempl(), FunctorAux::FunctorAux(), FunctorBinnedValuesDivision::FunctorBinnedValuesDivision(), FunctorCoordinatesFunctionAux::FunctorCoordinatesFunctionAux(), FunctorElementalGradientAuxTempl< is_ad >::FunctorElementalGradientAuxTempl(), FunctorExtremaPositions::FunctorExtremaPositions(), FunctorIC::FunctorIC(), FunctorPositions::FunctorPositions(), FunctorVectorElementalAuxTempl< is_ad >::FunctorVectorElementalAuxTempl(), FVAdvection::FVAdvection(), FVFluxBC::FVFluxBC(), FVInterfaceKernel::FVInterfaceKernel(), FVOneVarDiffusionInterface::FVOneVarDiffusionInterface(), FVTwoVarContinuityConstraint::FVTwoVarContinuityConstraint(), BoundaryDeletionGenerator::generate(), UniqueExtraIDMeshGenerator::generate(), ExtraNodesetGenerator::generate(), AddMetaDataGenerator::generate(), BlockToMeshConverterGenerator::generate(), BreakBoundaryOnSubdomainGenerator::generate(), ElementsToTetrahedronsConverter::generate(), FillBetweenCurvesGenerator::generate(), FillBetweenSidesetsGenerator::generate(), LowerDBlockFromSidesetGenerator::generate(), PlaneIDMeshGenerator::generate(), RenameBlockGenerator::generate(), RenameBoundaryGenerator::generate(), BlockDeletionGenerator::generate(), BreakMeshByBlockGenerator::generate(), CoarsenBlockGenerator::generate(), FlipSidesetGenerator::generate(), GeneratedMeshGenerator::generate(), ParsedSubdomainGeneratorBase::generate(), RefineBlockGenerator::generate(), RefineSidesetGenerator::generate(), AdvancedExtruderGenerator::generate(), BreakMeshByElementGenerator::generate(), CircularBoundaryCorrectionGenerator::generate(), CombinerGenerator::generate(), MeshCollectionGenerator::generate(), MeshExtruderGenerator::generate(), ParsedCurveGenerator::generate(), ParsedExtraElementIDGenerator::generate(), StackGenerator::generate(), StitchedMeshGenerator::generate(), XYZDelaunayGenerator::generate(), XYDelaunayGenerator::generate(), XYMeshLineCutter::generate(), CutMeshByLevelSetGeneratorBase::generate(), SubdomainBoundingBoxGenerator::generate(), PatternedMeshGenerator::generate(), GeneratedMeshGenerator::GeneratedMeshGenerator(), GenericFunctorGradientMaterialTempl< is_ad >::GenericFunctorGradientMaterialTempl(), GenericFunctorMaterialTempl< is_ad >::GenericFunctorMaterialTempl(), GenericFunctorTimeDerivativeMaterialTempl< is_ad >::GenericFunctorTimeDerivativeMaterialTempl(), GenericVectorFunctorMaterialTempl< is_ad >::GenericVectorFunctorMaterialTempl(), PropertyReadFile::getBlockData(), ComponentBoundaryConditionInterface::getBoundaryCondition(), MultiApp::getCommandLineArgs(), PropertyReadFile::getData(), PropertyReadFile::getFileNames(), Sampler::getGlobalSamples(), ComponentInitialConditionInterface::getInitialCondition(), NEML2Action::getInputParameterMapping(), MultiAppNearestNodeTransfer::getLocalEntitiesAndComponents(), Sampler::getLocalSamples(), MeshGenerator::getMeshGeneratorNameFromParam(), MeshGenerator::getMeshGeneratorNamesFromParam(), Sampler::getNextLocalRow(), FEProblemSolve::getParamFromNonlinearSystemVectorParam(), PostprocessorInterface::getPostprocessorNameInternal(), PostprocessorInterface::getPostprocessorValueInternal(), MultiAppNearestNodeTransfer::getTargetLocalNodes(), UserObjectInterface::getUserObjectBase(), UserObjectInterface::getUserObjectName(), HFEMDirichletBC::HFEMDirichletBC(), AddVariableAction::init(), MultiApp::init(), DistributedPositions::initialize(), BlockWeightedPartitioner::initialize(), BlockRestrictable::initializeBlockRestrictable(), BoundaryRestrictable::initializeBoundaryRestrictable(), PhysicsBase::initializePhysics(), JSONOutput::initialSetup(), MultiAppCloneReporterTransfer::initialSetup(), SolutionIC::initialSetup(), SideFVFluxBCIntegral::initialSetup(), ElementSubdomainModifierBase::initialSetup(), MultiAppVariableValueSamplePostprocessorTransfer::initialSetup(), MultiAppGeneralFieldNearestLocationTransfer::initialSetup(), MultiAppDofCopyTransfer::initialSetup(), HistogramVectorPostprocessor::initialSetup(), ReferenceResidualConvergence::initialSetup(), PiecewiseConstantFromCSV::initialSetup(), LibtorchControlValuePostprocessor::initialSetup(), MultiAppGeneralFieldTransfer::initialSetup(), SampledOutput::initSample(), AddMetaDataGenerator::inputChecker(), IntegratedBC::IntegratedBC(), InterfaceDiffusiveFluxIntegralTempl< is_ad >::InterfaceDiffusiveFluxIntegralTempl(), InterfaceValueUserObjectAux::InterfaceValueUserObjectAux(), InternalSideIndicatorBase::InternalSideIndicatorBase(), InterpolatedStatefulMaterialTempl< T >::InterpolatedStatefulMaterialTempl(), InversePowerMethod::InversePowerMethod(), IterationAdaptiveDT::IterationAdaptiveDT(), MultiApp::keepSolutionDuringRestore(), Kernel::Kernel(), LibtorchNeuralNetControl::LibtorchNeuralNetControl(), LinearCombinationFunction::LinearCombinationFunction(), LinearFVAdvectionDiffusionFunctorRobinBC::LinearFVAdvectionDiffusionFunctorRobinBC(), LowerDIntegratedBC::LowerDIntegratedBC(), PNGOutput::makeMeshFunc(), MatCoupledForce::MatCoupledForce(), MaterialADConverterTempl< T >::MaterialADConverterTempl(), MaterialFunctorConverterTempl< T >::MaterialFunctorConverterTempl(), MatrixSymmetryCheck::MatrixSymmetryCheck(), PatternedMeshGenerator::mergeSubdomainNameMaps(), MeshCollectionGenerator::MeshCollectionGenerator(), MeshDiagnosticsGenerator::MeshDiagnosticsGenerator(), MeshDivisionAux::MeshDivisionAux(), MeshGenerator::MeshGenerator(), MeshGeneratorComponent::MeshGeneratorComponent(), MFEMGenericFunctorMaterial::MFEMGenericFunctorMaterial(), MFEMGenericFunctorVectorMaterial::MFEMGenericFunctorVectorMaterial(), MooseLinearVariableFV< Real >::MooseLinearVariableFV(), UserObjectInterface::mooseObjectError(), MoosePreconditioner::MoosePreconditioner(), MooseStaticCondensationPreconditioner::MooseStaticCondensationPreconditioner(), MooseVariableBase::MooseVariableBase(), MortarConstraintBase::MortarConstraintBase(), MortarNodalAuxKernelTempl< ComputeValueType >::MortarNodalAuxKernelTempl(), MultiApp::moveApp(), MoveNodeGenerator::MoveNodeGenerator(), MultiApp::MultiApp(), MultiAppCloneReporterTransfer::MultiAppCloneReporterTransfer(), MultiAppGeneralFieldNearestLocationTransfer::MultiAppGeneralFieldNearestLocationTransfer(), MultiAppGeneralFieldShapeEvaluationTransfer::MultiAppGeneralFieldShapeEvaluationTransfer(), MultiAppGeneralFieldTransfer::MultiAppGeneralFieldTransfer(), MultiAppGeneralFieldUserObjectTransfer::MultiAppGeneralFieldUserObjectTransfer(), MultiAppGeometricInterpolationTransfer::MultiAppGeometricInterpolationTransfer(), MultiAppNearestNodeTransfer::MultiAppNearestNodeTransfer(), MultiAppPostprocessorInterpolationTransfer::MultiAppPostprocessorInterpolationTransfer(), MultiAppPostprocessorToAuxScalarTransfer::MultiAppPostprocessorToAuxScalarTransfer(), MultiAppPostprocessorTransfer::MultiAppPostprocessorTransfer(), MultiAppProjectionTransfer::MultiAppProjectionTransfer(), MultiAppReporterTransfer::MultiAppReporterTransfer(), MultiAppScalarToAuxScalarTransfer::MultiAppScalarToAuxScalarTransfer(), MultiAppShapeEvaluationTransfer::MultiAppShapeEvaluationTransfer(), MultiAppTransfer::MultiAppTransfer(), MultiAppUserObjectTransfer::MultiAppUserObjectTransfer(), MultiAppVariableValueSamplePostprocessorTransfer::MultiAppVariableValueSamplePostprocessorTransfer(), MultiAppVariableValueSampleTransfer::MultiAppVariableValueSampleTransfer(), MultiAppVectorPostprocessorTransfer::MultiAppVectorPostprocessorTransfer(), MultiSystemSolveObject::MultiSystemSolveObject(), NearestNodeValueAux::NearestNodeValueAux(), NEML2Action::NEML2Action(), NestedDivision::NestedDivision(), NodalBC::NodalBC(), NodalEqualValueConstraint::NodalEqualValueConstraint(), NodalKernel::NodalKernel(), NodalPatchRecoveryAux::NodalPatchRecoveryAux(), NodalValueSampler::NodalValueSampler(), Output::Output(), ParsedCurveGenerator::ParsedCurveGenerator(), ParsedFunctorMaterialTempl< is_ad >::ParsedFunctorMaterialTempl(), ParsedPostprocessor::ParsedPostprocessor(), PatternedMeshGenerator::PatternedMeshGenerator(), PenaltyPeriodicSegmentalConstraint::PenaltyPeriodicSegmentalConstraint(), PeriodicSegmentalConstraint::PeriodicSegmentalConstraint(), PIDTransientControl::PIDTransientControl(), PlaneDeletionGenerator::PlaneDeletionGenerator(), PlaneIDMeshGenerator::PlaneIDMeshGenerator(), PointwiseRenormalizeVector::PointwiseRenormalizeVector(), PolyLineMeshGenerator::PolyLineMeshGenerator(), ReporterInterface::possiblyCheckHasReporter(), VectorPostprocessorInterface::possiblyCheckHasVectorPostprocessor(), LibmeshPartitioner::prepareBlocksForSubdomainPartitioner(), ProjectedMaterialPropertyNodalPatchRecoveryAux::ProjectedMaterialPropertyNodalPatchRecoveryAux(), ProjectionAux::ProjectionAux(), PropertyReadFile::PropertyReadFile(), RandomIC::RandomIC(), MultiApp::readCommandLineArguments(), PropertyReadFile::readData(), SolutionUserObjectBase::readXda(), ReferenceResidualConvergence::ReferenceResidualConvergence(), RefineBlockGenerator::RefineBlockGenerator(), RefineSidesetGenerator::RefineSidesetGenerator(), RenameBlockGenerator::RenameBlockGenerator(), RenameBoundaryGenerator::RenameBoundaryGenerator(), ReporterPointSource::ReporterPointSource(), FEProblemBase::restoreSolutions(), SecondTimeDerivativeAux::SecondTimeDerivativeAux(), FEProblemBase::setLinearConvergenceNames(), FEProblemBase::setNonlinearConvergenceNames(), MooseMesh::setPartitioner(), NodeSetsGeneratorBase::setup(), SideSetsGeneratorBase::setup(), NEML2Action::setupDerivativeMappings(), NEML2Action::setupParameterDerivativeMappings(), TimeSequenceStepperBase::setupSequence(), SidesetAroundSubdomainUpdater::SidesetAroundSubdomainUpdater(), SideSetsFromBoundingBoxGenerator::SideSetsFromBoundingBoxGenerator(), SideValueSampler::SideValueSampler(), SingleRankPartitioner::SingleRankPartitioner(), SphericalGridDivision::SphericalGridDivision(), SymmetryTransformGenerator::SymmetryTransformGenerator(), Terminator::Terminator(), TimeDerivativeAux::TimeDerivativeAux(), Transfer::Transfer(), TransformGenerator::TransformGenerator(), TransientMultiApp::TransientMultiApp(), ParsedCurveGenerator::tSectionSpaceDefiner(), UniqueExtraIDMeshGenerator::UniqueExtraIDMeshGenerator(), UserObject::UserObject(), Checkpoint::validateExecuteOn(), ParsedAux::validateGenericVectorNames(), ParsedMaterialBase::validateVectorNames(), FunctorIC::value(), VariableCondensationPreconditioner::VariableCondensationPreconditioner(), VectorBodyForce::VectorBodyForce(), VectorFunctionDirichletBC::VectorFunctionDirichletBC(), VectorFunctionIC::VectorFunctionIC(), VolumeAux::VolumeAux(), WebServerControl::WebServerControl(), XYDelaunayGenerator::XYDelaunayGenerator(), XYMeshLineCutter::XYMeshLineCutter(), and XYZDelaunayGenerator::XYZDelaunayGenerator().
|
inlineinherited |
Get the parameters of the object.
Definition at line 62 of file MooseBaseParameterInterface.h.
Referenced by SetupDebugAction::act(), AddActionComponentAction::act(), CommonOutputAction::act(), Action::Action(), FEProblemBase::addAnyRedistributers(), MFEMProblem::addAuxKernel(), FEProblemBase::addAuxKernel(), FEProblemBase::addAuxScalarKernel(), MFEMProblem::addAuxVariable(), addAuxVariable(), MFEMProblem::addBoundaryCondition(), FEProblemBase::addBoundaryCondition(), FEProblemBase::addConstraint(), FEProblemBase::addConvergence(), FEProblemBase::addDamper(), AddDefaultConvergenceAction::addDefaultMultiAppFixedPointConvergence(), FEProblemBase::addDefaultMultiAppFixedPointConvergence(), ReferenceResidualProblem::addDefaultNonlinearConvergence(), AddDefaultConvergenceAction::addDefaultNonlinearConvergence(), FEProblemBase::addDefaultNonlinearConvergence(), AddDefaultConvergenceAction::addDefaultSteadyStateConvergence(), FEProblemBase::addDefaultSteadyStateConvergence(), FEProblemBase::addDGKernel(), FEProblemBase::addDiracKernel(), FEProblemBase::addDistribution(), MFEMProblem::addFESpace(), MFEMProblem::addFunction(), FEProblemBase::addFunction(), MFEMProblem::addFunctorMaterial(), FEProblemBase::addFunctorMaterial(), FEProblemBase::addFVBC(), FEProblemBase::addFVInitialCondition(), FEProblemBase::addFVInterfaceKernel(), FEProblemBase::addFVKernel(), MFEMProblem::addGridFunction(), FEProblemBase::addHDGKernel(), FEProblemBase::addIndicator(), MFEMProblem::addInitialCondition(), FEProblemBase::addInitialCondition(), DiffusionPhysicsBase::addInitialConditions(), FEProblemBase::addInterfaceKernel(), FEProblemBase::addInterfaceMaterial(), MFEMProblem::addKernel(), FEProblemBase::addKernel(), FEProblemBase::addLinearFVBC(), FEProblemBase::addLinearFVKernel(), FEProblem::addLineSearch(), FEProblemBase::addMarker(), FEProblemBase::addMaterial(), FEProblemBase::addMaterialHelper(), FEProblemBase::addMeshDivision(), MFEMProblem::addMFEMFESpaceFromMOOSEVariable(), MFEMProblem::addMFEMPreconditioner(), MFEMProblem::addMFEMSolver(), FEProblemBase::addMultiApp(), FEProblemBase::addNodalKernel(), FEProblemBase::addObject(), FEProblemBase::addObjectParamsHelper(), FEProblemBase::addOutput(), MFEMProblem::addPostprocessor(), FEProblemBase::addPostprocessor(), FEProblemBase::addPredictor(), FEProblemBase::addReporter(), FEProblemBase::addSampler(), FEProblemBase::addScalarKernel(), MFEMProblem::addSubMesh(), FEProblemBase::addTimeIntegrator(), MFEMProblem::addTransfer(), FEProblemBase::addTransfer(), FEProblemBase::addUserObject(), MFEMProblem::addVariable(), addVariable(), FEProblemBase::addVectorPostprocessor(), ADPiecewiseLinearInterpolationMaterial::ADPiecewiseLinearInterpolationMaterial(), AdvancedOutput::AdvancedOutput(), ADVectorFunctionDirichletBC::ADVectorFunctionDirichletBC(), AnnularMesh::AnnularMesh(), AnnularMeshGenerator::AnnularMeshGenerator(), Action::associateWithParameter(), AuxKernelTempl< Real >::AuxKernelTempl(), AuxScalarKernel::AuxScalarKernel(), BoundsBase::BoundsBase(), MooseMesh::buildTypedMesh(), PostprocessorInterface::checkParam(), AddDefaultConvergenceAction::checkUnusedMultiAppFixedPointConvergenceParameters(), AddDefaultConvergenceAction::checkUnusedNonlinearConvergenceParameters(), AddDefaultConvergenceAction::checkUnusedSteadyStateConvergenceParameters(), SampledOutput::cloneMesh(), LibtorchNeuralNetControl::conditionalParameterError(), Console::Console(), CommonOutputAction::create(), MultiApp::createApp(), Postprocessor::declareValue(), DumpObjectsProblem::deduceNecessaryParameters(), DefaultMultiAppFixedPointConvergence::DefaultMultiAppFixedPointConvergence(), DumpObjectsProblem::dumpObjectHelper(), DumpObjectsProblem::DumpObjectsProblem(), EigenProblem::EigenProblem(), Eigenvalue::Eigenvalue(), ElementMaterialSampler::ElementMaterialSampler(), ExamplePatchMeshGenerator::ExamplePatchMeshGenerator(), Executor::Executor(), Exodus::Exodus(), FEProblem::FEProblem(), FEProblemBase::FEProblemBase(), FixedPointSolve::FixedPointSolve(), FunctorSmootherTempl< T >::FunctorSmootherTempl(), GapValueAux::GapValueAux(), ParsedSubdomainGeneratorBase::generate(), MooseBaseParameterInterface::getCheckedPointerParam(), ActionWarehouse::getCurrentActionName(), ExecutorInterface::getExecutor(), Material::getMaterial(), ReporterInterface::getReporterName(), Reporter::getReporterValueName(), UserObjectInterface::getUserObjectName(), VectorPostprocessorInterface::getVectorPostprocessorName(), GhostingUserObject::GhostingUserObject(), AttribSystem::initFrom(), AttribDisplaced::initFrom(), BlockRestrictable::initializeBlockRestrictable(), FullSolveMultiApp::initialSetup(), FEProblemBase::initNullSpaceVectors(), InterfaceDiffusiveFluxIntegralTempl< is_ad >::InterfaceDiffusiveFluxIntegralTempl(), InterfaceIntegralVariableValuePostprocessor::InterfaceIntegralVariableValuePostprocessor(), InterfaceKernelTempl< T >::InterfaceKernelTempl(), isValid(), IterationAdaptiveDT::IterationAdaptiveDT(), LibtorchNeuralNetControl::LibtorchNeuralNetControl(), MFEMCGSolver::MFEMCGSolver(), MFEMGMRESSolver::MFEMGMRESSolver(), MFEMHypreADS::MFEMHypreADS(), MFEMHypreAMS::MFEMHypreAMS(), MFEMHypreBoomerAMG::MFEMHypreBoomerAMG(), MFEMHypreFGMRES::MFEMHypreFGMRES(), MFEMHypreGMRES::MFEMHypreGMRES(), MFEMHyprePCG::MFEMHyprePCG(), MFEMOperatorJacobiSmoother::MFEMOperatorJacobiSmoother(), MFEMSuperLU::MFEMSuperLU(), MooseObject::MooseObject(), UserObjectInterface::mooseObjectError(), MooseVariableInterface< Real >::MooseVariableInterface(), MultiApp::MultiApp(), MultiAppGeneralFieldTransfer::MultiAppGeneralFieldTransfer(), MultiAppGeneralFieldUserObjectTransfer::MultiAppGeneralFieldUserObjectTransfer(), MultiAppTransfer::MultiAppTransfer(), MultiAppVariableValueSamplePostprocessorTransfer::MultiAppVariableValueSamplePostprocessorTransfer(), NodeFaceConstraint::NodeFaceConstraint(), OverlayMeshGenerator::OverlayMeshGenerator(), PenetrationAux::PenetrationAux(), PiecewiseBilinear::PiecewiseBilinear(), PiecewiseLinearInterpolationMaterial::PiecewiseLinearInterpolationMaterial(), NEML2Action::printSummary(), ProjectedStatefulMaterialStorageAction::processProperty(), PropertyReadFile::PropertyReadFile(), PseudoTimestep::PseudoTimestep(), RandomIC::RandomIC(), ReferenceResidualConvergence::ReferenceResidualConvergence(), InputParameterWarehouse::removeInputParameters(), FEProblem::setInputParametersFEProblem(), FEProblemBase::setInputParametersFEProblem(), FEProblemBase::setResidualObjectParamsAndLog(), SideSetsGeneratorBase::setup(), SideSetsFromBoundingBoxGenerator::SideSetsFromBoundingBoxGenerator(), Moose::PetscSupport::storePetscOptions(), DumpObjectsProblem::stringifyParameters(), TaggingInterface::TaggingInterface(), Transfer::Transfer(), TransientBase::TransientBase(), VectorBodyForce::VectorBodyForce(), VectorFunctionDirichletBC::VectorFunctionDirichletBC(), VectorFunctionIC::VectorFunctionIC(), and VectorMagnitudeFunctorMaterialTempl< is_ad >::VectorMagnitudeFunctorMaterialTempl().
|
inherited |
Emits an informational message prefixed with the file and line number of the given param (from the input file) along with the full parameter path+name followed by the given args as the message.
If this object's parameters were not created directly by the Parser, then this function falls back to the normal behavior of mooseInfo - only printing a message using the given args.
Definition at line 272 of file MooseBaseParameterInterface.h.
Referenced by GridPartitioner::_do_partition(), ComboMarker::ComboMarker(), Control::Control(), FunctorIC::FunctorIC(), and TransientMultiApp::TransientMultiApp().
|
inherited |
Emits a warning prefixed with the file and line number of the given param (from the input file) along with the full parameter path+name followed by the given args as the message.
If this object's parameters were not created directly by the Parser, then this function falls back to the normal behavior of mooseWarning - only printing a message using the given args.
Definition at line 265 of file MooseBaseParameterInterface.h.
Referenced by GridPartitioner::_do_partition(), EigenProblem::checkProblemIntegrity(), CombinerGenerator::copyIntoMesh(), DefaultMultiAppFixedPointConvergence::DefaultMultiAppFixedPointConvergence(), MultiAppNearestNodeTransfer::execute(), FEProblemSolve::FEProblemSolve(), UniqueExtraIDMeshGenerator::generate(), PlaneIDMeshGenerator::generate(), Terminator::initialSetup(), SampledOutput::initSample(), MooseMesh::MooseMesh(), FEProblemBase::setPreserveMatrixSparsityPattern(), and Terminator::Terminator().
|
inherited |
Get the PerfGraph.
Definition at line 78 of file PerfGraphInterface.C.
Referenced by CommonOutputAction::act(), PerfGraphData::finalize(), and PerfGraphOutput::output().
Implements SubProblem.
|
overridevirtual |
Implements SubProblem.
Implements SubProblem.
Definition at line 690 of file DisplacedProblem.C.
Definition at line 696 of file DisplacedProblem.C.
|
virtual |
Definition at line 680 of file DisplacedProblem.C.
Implements SubProblem.
Definition at line 640 of file DisplacedProblem.C.
Implements SubProblem.
Definition at line 1096 of file DisplacedProblem.C.
|
overridevirtual |
Implements SubProblem.
Definition at line 1102 of file DisplacedProblem.C.
Definition at line 634 of file DisplacedProblem.C.
|
inherited |
Prepare DofMap
and Assembly
classes with our p-refinement information.
Definition at line 1332 of file SubProblem.C.
Referenced by FEProblemBase::init().
Implements SubProblem.
Definition at line 1090 of file DisplacedProblem.C.
|
inherited |
Query a parameter for the object.
If the parameter is not valid, nullptr will be returned
name | The name of the parameter |
Definition at line 222 of file MooseBaseParameterInterface.h.
MooseMesh & DisplacedProblem::refMesh | ( | ) |
|
protectedinherited |
Call to register a named section for timing.
section_name | The name of the code section to be timed |
level | The importance of the timer - lower is more important (0 will always come out) |
Definition at line 53 of file PerfGraphInterface.C.
|
protectedinherited |
Call to register a named section for timing.
section_name | The name of the code section to be timed |
level | The importance of the timer - lower is more important (0 will always come out) |
live_message | The message to be printed to the screen during execution |
print_dots | Whether or not progress dots should be printed for this section |
Definition at line 64 of file PerfGraphInterface.C.
|
inherited |
Register an unfulfilled functor request.
Returns true if the Problem has Dirac kernels it needs to compute on elem.
Implements SubProblem.
Definition at line 702 of file DisplacedProblem.C.
Implements SubProblem.
Definition at line 726 of file DisplacedProblem.C.
Referenced by reinitDirac(), and reinitElemPhys().
|
overridevirtual |
Implements SubProblem.
Definition at line 753 of file DisplacedProblem.C.
|
virtualinherited |
reinitialize FE objects on a given element on a given side at a given set of reference points and then compute variable data.
Note that this method makes no assumptions about what's been called beforehand, e.g. you don't have to call some prepare method before this one. This is an all-in-one reinit
Reimplemented in FEProblemBase.
Definition at line 882 of file SubProblem.C.
Referenced by FEProblemBase::reinitElemFaceRef().
|
overridevirtual |
Implements SubProblem.
Definition at line 891 of file DisplacedProblem.C.
|
overridevirtual |
Implements SubProblem.
Definition at line 734 of file DisplacedProblem.C.
reinitialize the finite volume assembly data for the provided face and thread
Definition at line 1284 of file SubProblem.C.
|
virtualinherited |
Reimplemented in FEProblemBase.
Definition at line 957 of file SubProblem.C.
Referenced by Moose::Mortar::loopOverMortarSegments(), reinitElemNeighborAndLowerD(), and FEProblemBase::reinitLowerDElem().
Reinit a mortar element to obtain a valid JxW.
Definition at line 994 of file SubProblem.C.
Referenced by Moose::Mortar::loopOverMortarSegments().
|
overridevirtual |
Implements SubProblem.
Referenced by reinitElemNeighborAndLowerD().
void DisplacedProblem::reinitNeighbor | ( | const Elem * | elem, |
unsigned int | side, | ||
const THREAD_ID | tid, | ||
const std::vector< Point > * | neighbor_reference_points | ||
) |
reinitialize neighbor routine
elem | The element driving the reinit (note that this is not the neighbor) |
side | The side, e.g. face, of the elem that we want to reinit |
tid | The thread for which we are reiniting |
neighbor_reference_points | Specify the referrence points for the neighbor element. Useful if the element and neighbor faces are not coincident |
|
virtualinherited |
reinitialize FE objects on a given neighbor element on a given side at a given set of reference points and then compute variable data.
Note that this method makes no assumptions about what's been called beforehand, e.g. you don't have to call some prepare method before this one. This is an all-in-one reinit
Reimplemented in FEProblemBase.
Definition at line 921 of file SubProblem.C.
Referenced by FEProblemBase::reinitNeighborFaceRef().
reinitialize a neighboring lower dimensional element
Definition at line 987 of file SubProblem.C.
Referenced by Moose::Mortar::loopOverMortarSegments().
|
overridevirtual |
Implements SubProblem.
|
overridevirtual |
Implements SubProblem.
Implements SubProblem.
Definition at line 764 of file DisplacedProblem.C.
|
overridevirtual |
Implements SubProblem.
Definition at line 775 of file DisplacedProblem.C.
|
overridevirtual |
Implements SubProblem.
Definition at line 786 of file DisplacedProblem.C.
|
overridevirtual |
Implements SubProblem.
Definition at line 794 of file DisplacedProblem.C.
Implements SubProblem.
Definition at line 928 of file DisplacedProblem.C.
|
overridevirtual |
fills the VariableValue arrays for scalar variables from the solution vector
tid | The thread id |
reinit_for_derivative_reordering | A flag indicating whether we are reinitializing for the purpose of re-ordering derivative information for ADNodalBCs |
Implements SubProblem.
Definition at line 919 of file DisplacedProblem.C.
|
inherited |
Remove an algebraic ghosting functor from this problem's DofMaps.
Definition at line 1067 of file SubProblem.C.
|
inherited |
Remove a coupling ghosting functor from this problem's DofMaps.
Definition at line 1110 of file SubProblem.C.
|
overridevirtual |
Reimplemented from SubProblem.
Definition at line 1283 of file DisplacedProblem.C.
|
virtual |
Restore old solutions from the backup vectors and deallocate them.
Definition at line 218 of file DisplacedProblem.C.
|
overridevirtual |
Is it safe to access the tagged matrices.
Reimplemented from SubProblem.
Definition at line 1359 of file DisplacedProblem.C.
|
overridevirtual |
Is it safe to access the tagged vectors.
Reimplemented from SubProblem.
Definition at line 1365 of file DisplacedProblem.C.
|
virtual |
Allocate vectors and save old solutions into them.
Definition at line 210 of file DisplacedProblem.C.
|
staticinherited |
Select the matrix tags which belong to a specific system.
system | Reference to the system |
input_matrix_tags | A map of matrix tags |
selected_tags | A set which gets populated by the tag-ids that belong to the system |
Definition at line 300 of file SubProblem.C.
Referenced by FEProblemBase::computeLinearSystemSys().
|
staticinherited |
Select the vector tags which belong to a specific system.
system | Reference to the system |
input_vector_tags | A vector of vector tags |
selected_tags | A set which gets populated by the tag-ids that belong to the system |
Definition at line 289 of file SubProblem.C.
Referenced by FEProblemBase::computeLinearSystemSys(), FEProblemBase::computeResidualAndJacobian(), and ComputeResidualAndJacobianThread::determineObjectWarehouses().
|
virtualinherited |
Set the MOOSE variables to be reinited on each element.
moose_vars | A set of variables that need to be reinited each time reinit() is called. |
tid | The thread id |
Reimplemented in FEProblemBase.
Definition at line 443 of file SubProblem.C.
Referenced by FEProblemBase::setActiveElementalMooseVariables().
|
virtualinherited |
Reimplemented in FEProblemBase.
Definition at line 363 of file SubProblem.C.
Referenced by FEProblemBase::setActiveFEVariableCoupleableMatrixTags().
|
virtualinherited |
Reimplemented in FEProblemBase.
Definition at line 369 of file SubProblem.C.
Referenced by FEProblemBase::setActiveFEVariableCoupleableVectorTags().
|
virtualinherited |
Reimplemented in FEProblemBase.
Definition at line 402 of file SubProblem.C.
Referenced by FEProblemBase::setActiveScalarVariableCoupleableMatrixTags().
|
virtualinherited |
Reimplemented in FEProblemBase.
Definition at line 409 of file SubProblem.C.
Referenced by FEProblemBase::setActiveScalarVariableCoupleableVectorTags().
|
virtualinherited |
sets the current boundary ID in assembly
Reimplemented in FEProblemBase.
Definition at line 789 of file SubProblem.C.
Referenced by FEProblemBase::setCurrentBoundaryID().
|
virtualinherited |
Set the current lower dimensional element.
This can be null
Reimplemented in FEProblemBase.
Definition at line 1380 of file SubProblem.C.
Referenced by FEProblemBase::setCurrentLowerDElem().
|
inlineinherited |
Set whether or not the problem is in the process of computing the Jacobian.
Definition at line 689 of file SubProblem.h.
Referenced by FEProblemBase::computeResidualAndJacobian(), and FEProblemBase::resetState().
|
inlinevirtualinherited |
Set whether or not the problem is in the process of computing the residual.
Reimplemented in FEProblemBase.
Definition at line 725 of file SubProblem.h.
|
inlineinherited |
Set whether or not the problem is in the process of computing the Jacobian.
Definition at line 1493 of file SubProblem.h.
Referenced by FEProblemBase::computeResidualAndJacobian(), and FEProblemBase::resetState().
|
overridevirtual |
Implements SubProblem.
Definition at line 664 of file DisplacedProblem.C.
|
inlineinherited |
Setter for debug functor output.
Definition at line 924 of file SubProblem.h.
|
overridevirtual |
Implements SubProblem.
Definition at line 672 of file DisplacedProblem.C.
|
overridevirtual |
Definition at line 989 of file DisplacedProblem.C.
|
pure virtualinherited |
|
overridevirtual |
Definition at line 998 of file DisplacedProblem.C.
|
pure virtualinherited |
|
inline |
Definition at line 476 of file DisplacedProblem.h.
|
overridevirtual |
solver_sys_name
Implements SubProblem.
Definition at line 1401 of file DisplacedProblem.C.
|
overridevirtual |
sys_num
is converged Reimplemented from SubProblem.
Definition at line 1177 of file DisplacedProblem.C.
|
virtualinherited |
Adds to a map based on boundary ids of material properties to validate.
requestor | The MOOSE object name requesting the material property |
boundary_id | The block id for the MaterialProperty |
name | The name of the property |
Definition at line 615 of file SubProblem.C.
Referenced by MaterialPropertyInterface::checkMaterialProperty().
|
virtualinherited |
Adds the given material property to a storage map based on boundary ids.
This is method is called from within the Material class when the property is first registered.
boundary_id | The block id for the MaterialProperty |
name | The name of the property |
Definition at line 589 of file SubProblem.C.
Referenced by MaterialBase::registerPropName().
|
virtualinherited |
Adds to a map based on boundary ids of material properties for which a zero value can be returned.
Thes properties are optional and will not trigger a missing material property error.
boundary_id | The block id for the MaterialProperty |
name | The name of the property |
Definition at line 601 of file SubProblem.C.
Referenced by MaterialBase::storeBoundaryZeroMatProp().
|
virtualinherited |
Adds to a map based on block ids of material properties to validate.
block_id | The block id for the MaterialProperty |
name | The name of the property |
Definition at line 607 of file SubProblem.C.
Referenced by MaterialPropertyInterface::checkMaterialProperty().
|
virtualinherited |
Adds the given material property to a storage map based on block ids.
This is method is called from within the Material class when the property is first registered.
block_id | The block id for the MaterialProperty |
name | The name of the property |
Definition at line 583 of file SubProblem.C.
Referenced by MaterialBase::registerPropName().
|
virtualinherited |
Adds to a map based on block ids of material properties for which a zero value can be returned.
Thes properties are optional and will not trigger a missing material property error.
block_id | The block id for the MaterialProperty |
name | The name of the property |
Definition at line 595 of file SubProblem.C.
Referenced by MaterialBase::storeSubdomainZeroMatProp().
void DisplacedProblem::syncAuxSolution | ( | const NumericVector< Number > & | aux_soln | ) |
Copy the provided solution into the displaced auxiliary system.
Definition at line 226 of file DisplacedProblem.C.
Referenced by syncSolutions().
void DisplacedProblem::syncSolutions | ( | ) |
Copy the solutions on the undisplaced systems to the displaced systems.
Definition at line 233 of file DisplacedProblem.C.
Referenced by updateMesh().
void DisplacedProblem::syncSolutions | ( | const std::map< unsigned int, const NumericVector< Number > *> & | nl_solns, |
const NumericVector< Number > & | aux_soln | ||
) |
Synchronize the solutions on the displaced systems to the given solutions.
The nonlinear solutions argument is a map from the nonlinear system number to the solution that we want to set that nonlinear system's solution to
|
inlineoverridevirtual |
Return the auxiliary system object as a base class reference.
Implements SubProblem.
Definition at line 70 of file DisplacedProblem.h.
|
inlineoverridevirtual |
Implements SubProblem.
Definition at line 71 of file DisplacedProblem.h.
|
inlineoverridevirtual |
Return the linear system object as a base class reference given the system number.
Implements SubProblem.
Definition at line 500 of file DisplacedProblem.h.
|
inlineoverridevirtual |
Implements SubProblem.
Definition at line 506 of file DisplacedProblem.h.
|
inlineoverridevirtual |
Return the nonlinear system object as a base class reference given the system number.
Implements SubProblem.
Definition at line 484 of file DisplacedProblem.h.
|
inlineoverridevirtual |
Implements SubProblem.
Definition at line 492 of file DisplacedProblem.h.
|
inlineoverridevirtual |
Return the solver system object as a base class reference given the system number.
Implements SubProblem.
Definition at line 512 of file DisplacedProblem.h.
|
inlineoverridevirtual |
Implements SubProblem.
Definition at line 520 of file DisplacedProblem.h.
|
inlinevirtualinherited |
Allow objects to request clean termination of the solve.
Definition at line 37 of file Problem.h.
Referenced by Terminator::execute(), and TerminateChainControl::terminate().
|
protectedinherited |
section_name
.Optionally adds a prefix if one is defined.
Definition at line 47 of file PerfGraphInterface.C.
Referenced by PerfGraphInterface::registerTimedSection().
|
overridevirtual |
Reimplemented from SubProblem.
Definition at line 1263 of file DisplacedProblem.C.
|
inlineinherited |
Get the type of this class.
Definition at line 51 of file MooseBase.h.
Referenced by CreateProblemDefaultAction::act(), SetupDebugAction::act(), MaterialDerivativeTestAction::act(), MaterialOutputAction::act(), FEProblemBase::addAuxArrayVariable(), FEProblemBase::addAuxScalarVariable(), FEProblemBase::addAuxVariable(), FEProblemBase::addConvergence(), FEProblemBase::addDistribution(), MooseApp::addExecutor(), MooseApp::addExecutorParams(), MFEMProblem::addFunction(), FEProblemBase::addFunction(), FEProblemBase::addMeshDivision(), MooseApp::addMeshGenerator(), MeshGenerator::addMeshSubgenerator(), FEProblemBase::addObject(), MFEMProblem::addPostprocessor(), FEProblemBase::addPredictor(), CreateDisplacedProblemAction::addProxyRelationshipManagers(), FEProblemBase::addReporter(), FEProblemBase::addSampler(), FEProblemBase::addTimeIntegrator(), MooseServer::addValuesToList(), addVectorTag(), SubProblem::addVectorTag(), FEProblemBase::advanceMultiApps(), MooseApp::appendMeshGenerator(), AuxKernelTempl< Real >::AuxKernelTempl(), FEProblemBase::backupMultiApps(), BatchMeshGeneratorAction::BatchMeshGeneratorAction(), BoundaryPreservedMarker::BoundaryPreservedMarker(), DistributedRectilinearMeshGenerator::buildCube(), MooseMesh::buildHRefinementAndCoarseningMaps(), MooseMesh::buildLowerDMesh(), MooseMesh::buildPRefinementAndCoarseningMaps(), PhysicsBase::checkComponentType(), MeshDiagnosticsGenerator::checkNonConformalMeshFromAdaptivity(), ActionComponent::checkRequiredTasks(), PhysicsBase::checkRequiredTasks(), ADDGKernel::computeElemNeighJacobian(), DGKernel::computeElemNeighJacobian(), ElemElemConstraint::computeElemNeighJacobian(), ArrayDGKernel::computeElemNeighJacobian(), ADDGKernel::computeElemNeighResidual(), DGKernel::computeElemNeighResidual(), ElemElemConstraint::computeElemNeighResidual(), ArrayDGKernel::computeElemNeighResidual(), LowerDIntegratedBC::computeLowerDJacobian(), ArrayLowerDIntegratedBC::computeLowerDJacobian(), DGLowerDKernel::computeLowerDJacobian(), ArrayDGLowerDKernel::computeLowerDJacobian(), LowerDIntegratedBC::computeLowerDOffDiagJacobian(), ArrayLowerDIntegratedBC::computeLowerDOffDiagJacobian(), ArrayHFEMDirichletBC::computeLowerDQpJacobian(), ArrayHFEMDiffusion::computeLowerDQpJacobian(), HFEMDirichletBC::computeLowerDQpJacobian(), HFEMDiffusion::computeLowerDQpJacobian(), ArrayHFEMDirichletBC::computeLowerDQpOffDiagJacobian(), HFEMDirichletBC::computeLowerDQpOffDiagJacobian(), ArrayLowerDIntegratedBC::computeLowerDQpOffDiagJacobian(), ArrayDGLowerDKernel::computeLowerDQpOffDiagJacobian(), FEProblemBase::computeMultiAppsDT(), ADDGKernel::computeOffDiagElemNeighJacobian(), DGKernel::computeOffDiagElemNeighJacobian(), ArrayDGKernel::computeOffDiagElemNeighJacobian(), DGLowerDKernel::computeOffDiagLowerDJacobian(), ArrayDGLowerDKernel::computeOffDiagLowerDJacobian(), DGConvection::computeQpJacobian(), ScalarKernel::computeQpJacobian(), InterfaceDiffusion::computeQpJacobian(), ArrayDGDiffusion::computeQpJacobian(), InterfaceReaction::computeQpJacobian(), CoupledTiedValueConstraint::computeQpJacobian(), TiedValueConstraint::computeQpJacobian(), DGDiffusion::computeQpJacobian(), LinearNodalConstraint::computeQpJacobian(), EqualValueBoundaryConstraint::computeQpJacobian(), CoupledTiedValueConstraint::computeQpOffDiagJacobian(), HFEMTestJump::computeQpOffDiagJacobian(), HFEMTrialJump::computeQpOffDiagJacobian(), ArrayDGKernel::computeQpOffDiagJacobian(), ArrayHFEMDiffusion::computeQpResidual(), DGConvection::computeQpResidual(), HFEMDiffusion::computeQpResidual(), ScalarKernel::computeQpResidual(), InterfaceDiffusion::computeQpResidual(), ADMatInterfaceReaction::computeQpResidual(), InterfaceReaction::computeQpResidual(), ADDGAdvection::computeQpResidual(), ArrayDGDiffusion::computeQpResidual(), CoupledTiedValueConstraint::computeQpResidual(), TiedValueConstraint::computeQpResidual(), DGDiffusion::computeQpResidual(), LinearNodalConstraint::computeQpResidual(), ADDGDiffusion::computeQpResidual(), HFEMTrialJump::computeQpResidual(), EqualValueBoundaryConstraint::computeQpResidual(), HFEMTestJump::computeQpResidual(), FEProblemBase::computeSystems(), FEProblemBase::computeUserObjectByName(), FEProblemBase::computeUserObjects(), FEProblemBase::computeUserObjectsInternal(), createQRules(), FEProblemBase::createQRules(), MooseApp::createRecoverablePerfGraph(), DumpObjectsProblem::deduceNecessaryParameters(), DumpObjectsProblem::dumpObjectHelper(), FEProblemBase::duplicateVariableCheck(), MooseBase::errorPrefix(), FEProblemBase::execMultiApps(), FEProblemBase::execMultiAppTransfers(), FEProblemBase::execTransfers(), WebServerControl::execute(), SteadyBase::execute(), ActionWarehouse::executeActionsWithAction(), FEProblemBase::finishMultiAppStep(), FVScalarLagrangeMultiplierInterface::FVScalarLagrangeMultiplierInterface(), MooseServer::gatherDocumentReferencesLocations(), LowerDBlockFromSidesetGenerator::generate(), SubdomainPerElementGenerator::generate(), PatternedMeshGenerator::generate(), MeshGenerator::generateInternal(), MultiAppTransfer::getAppInfo(), TransfiniteMeshGenerator::getEdge(), ElementGenerator::getElemType(), MooseServer::getInputLookupDefinitionNodes(), FEProblemBase::getMaterial(), FEProblemBase::getMaterialData(), MaterialOutputAction::getParams(), ReporterData::getReporterInfo(), FEProblemBase::getTransfers(), getVectorTags(), SubProblem::getVectorTags(), CommonOutputAction::hasConsole(), FEProblemBase::hasMultiApps(), AdvancedOutput::hasOutput(), FEProblemBase::incrementMultiAppTStep(), AdvancedOutput::initAvailableLists(), FunctorPositions::initialize(), FunctorTimes::initialize(), MultiAppConservativeTransfer::initialSetup(), LinearFVDiffusion::initialSetup(), LinearFVAdvection::initialSetup(), LinearFVAnisotropicDiffusion::initialSetup(), ArrayDGDiffusion::initQpResidual(), AdvancedOutput::initShowHideLists(), RelationshipManager::isType(), FEProblemBase::logAdd(), MaterialFunctorConverterTempl< T >::MaterialFunctorConverterTempl(), MFEMProblem::mesh(), MooseObject::MooseObject(), MultiAppMFEMCopyTransfer::MultiAppMFEMCopyTransfer(), numVectorTags(), SubProblem::numVectorTags(), Console::output(), AdvancedOutput::output(), ConsoleUtils::outputExecutionInformation(), SampledOutput::outputStep(), Output::outputStep(), FEProblemBase::outputStep(), MooseServer::parseDocumentForDiagnostics(), MooseMesh::prepare(), ProjectedStatefulMaterialStorageAction::processProperty(), MooseApp::recursivelyCreateExecutors(), SolutionInvalidInterface::registerInvalidSolutionInternal(), FEProblemBase::restoreMultiApps(), MeshRepairGenerator::separateSubdomainsByElementType(), FEProblemBase::setCoupling(), MooseApp::setupOptions(), ExplicitTVDRK2::solve(), ExplicitRK2::solve(), WebServerControl::startServer(), MooseBase::typeAndName(), ScalarKernelBase::uOld(), AuxScalarKernel::uOld(), updateGeomSearch(), FEProblemBase::updateGeomSearch(), UserObjectInterface::userObjectType(), and AdvancedOutput::wantOutput().
|
inherited |
Get the class's combined type and name; useful in error handling.
Definition at line 27 of file MooseBase.C.
Referenced by MaterialPropertyStorage::addProperty(), MeshGeneratorSystem::dataDrivenError(), ReporterContext< std::vector< T > >::finalize(), and ReporterData::getReporterInfo().
void DisplacedProblem::undisplaceMesh | ( | ) |
Resets the displaced mesh to the reference mesh.
Required when refining the DisplacedMesh.
Definition at line 1199 of file DisplacedProblem.C.
|
inlineinherited |
The unique name for accessing input parameters of this object in the InputParameterWarehouse.
Definition at line 67 of file MooseBaseParameterInterface.h.
Referenced by MooseBaseParameterInterface::connectControllableParams(), and Action::uniqueActionName().
|
inlineinherited |
The unique parameter name of a valid parameter of this object for accessing parameter controls.
Definition at line 52 of file MooseBaseParameterInterface.h.
|
overridevirtual |
Implements SubProblem.
Definition at line 1108 of file DisplacedProblem.C.
|
virtual |
Copy the solutions on the undisplaced systems to the displaced systems and reinitialize the geometry search data and Dirac kernel information due to mesh displacement.
The parameter mesh_changing
indicates whether this method is getting called because of mesh changes, e.g. due to mesh adaptivity. If mesh_changing
we need to renitialize the GeometricSearchData instead of simply update. Reinitialization operations are a super-set of update operations. Reinitialization for example re-generates neighbor nodes in NearestNodeLocators, while update does not. Additionally we do not want to use the undisplaced mesh solution because it may be out-of-sync, whereas our displaced mesh solution should be in the correct state after getting restricted/prolonged in EquationSystems::reinit
Definition at line 266 of file DisplacedProblem.C.
Referenced by meshChanged().
|
virtual |
Synchronize the solutions on the displaced systems to the given solutions and reinitialize the geometry search data and Dirac kernel information due to mesh displacement.
|
static |
Definition at line 34 of file DisplacedProblem.C.
|
overridevirtual |
Check to see if a particular Tag exists.
Reimplemented from SubProblem.
Definition at line 411 of file DisplacedProblem.C.
|
overridevirtual |
Check to see if a particular Tag exists by using Tag name.
Reimplemented from SubProblem.
Definition at line 417 of file DisplacedProblem.C.
|
overridevirtual |
Retrieve the name associated with a TagID.
Reimplemented from SubProblem.
Definition at line 405 of file DisplacedProblem.C.
|
inherited |
Checks if a vector tag is in the list of vectors that will not be zeroed when other tagged vectors are.
tag | the TagID of the vector that is currently being checked |
Definition at line 155 of file SubProblem.C.
Referenced by SystemBase::zeroTaggedVector().
|
overridevirtual |
Reimplemented from SubProblem.
Definition at line 435 of file DisplacedProblem.C.
|
protectedinherited |
Verify the integrity of _vector_tags and _typed_vector_tags.
Definition at line 241 of file SubProblem.C.
Referenced by SubProblem::addVectorTag(), SubProblem::getVectorTag(), SubProblem::getVectorTagID(), SubProblem::getVectorTags(), SubProblem::numVectorTags(), SubProblem::vectorTagExists(), SubProblem::vectorTagName(), and SubProblem::vectorTagType().
|
friend |
Definition at line 472 of file DisplacedProblem.h.
|
friend |
Definition at line 471 of file DisplacedProblem.h.
|
protectedinherited |
Builds Actions.
Definition at line 179 of file MooseBaseParameterInterface.h.
Referenced by AddActionComponentAction::act(), CreateMeshSetupActionsForComponents::act(), ActionComponent::checkRequiredTasks(), PhysicsBase::checkRequiredTasks(), CommonOutputAction::create(), AddVariableAction::createInitialConditionAction(), DynamicObjectRegistrationAction::DynamicObjectRegistrationAction(), CreateExecutionerAction::setupAutoPreconditioning(), and ReadExecutorParamsAction::setupAutoPreconditioning().
|
protectedinherited |
This is the set of MooseVariableFieldBase that will actually get reinited by a call to reinit(elem)
Definition at line 1075 of file SubProblem.h.
Referenced by SubProblem::clearActiveElementalMooseVariables(), SubProblem::getActiveElementalMooseVariables(), SubProblem::setActiveElementalMooseVariables(), and SubProblem::SubProblem().
|
protectedinherited |
Definition at line 1081 of file SubProblem.h.
Referenced by SubProblem::clearActiveFEVariableCoupleableMatrixTags(), SubProblem::getActiveFEVariableCoupleableMatrixTags(), SubProblem::setActiveFEVariableCoupleableMatrixTags(), and SubProblem::SubProblem().
|
protectedinherited |
Definition at line 1083 of file SubProblem.h.
Referenced by SubProblem::clearActiveFEVariableCoupleableVectorTags(), SubProblem::getActiveFEVariableCoupleableVectorTags(), SubProblem::setActiveFEVariableCoupleableVectorTags(), and SubProblem::SubProblem().
|
protectedinherited |
Definition at line 1085 of file SubProblem.h.
Referenced by SubProblem::clearActiveScalarVariableCoupleableMatrixTags(), SubProblem::getActiveScalarVariableCoupleableMatrixTags(), SubProblem::setActiveScalarVariableCoupleableMatrixTags(), and SubProblem::SubProblem().
|
protectedinherited |
Definition at line 1087 of file SubProblem.h.
Referenced by SubProblem::clearActiveScalarVariableCoupleableVectorTags(), SubProblem::getActiveScalarVariableCoupleableVectorTags(), SubProblem::setActiveScalarVariableCoupleableVectorTags(), and SubProblem::SubProblem().
|
protectedinherited |
The MOOSE application this is associated with.
Definition at line 84 of file MooseBase.h.
|
protected |
Definition at line 406 of file DisplacedProblem.h.
Referenced by addCachedResidualDirectly(), addJacobian(), addJacobianBlockNonlocal(), addJacobianBlockTags(), addJacobianLowerD(), addJacobianNeighbor(), addJacobianNeighborLowerD(), addJacobianNonlocal(), addResidual(), addResidualLower(), addResidualNeighbor(), assembly(), bumpAllQRuleOrder(), bumpVolumeQRuleOrder(), cacheJacobianNonlocal(), createQRules(), DisplacedProblem(), init(), prepareAssembly(), prepareAssemblyNeighbor(), prepareBlockNonlocal(), prepareFaceShapes(), prepareNeighborShapes(), prepareNonlocal(), prepareShapes(), reinitDirac(), reinitElemFace(), reinitElemNeighborAndLowerD(), reinitElemPhys(), reinitNode(), reinitNodeFace(), reinitOffDiagScalars(), setCurrentSubdomainID(), setNeighborSubdomainID(), setResidual(), and setResidualNeighbor().
|
protected |
The auxiliary system solution.
Definition at line 404 of file DisplacedProblem.h.
Referenced by updateMesh().
|
protectedinherited |
True if the CLI option is found.
Definition at line 52 of file Problem.h.
Referenced by Problem::_setCLIOption().
|
protectedinherited |
|
protectedinherited |
Whether the non-linear residual is being evaluated.
Definition at line 1102 of file SubProblem.h.
Referenced by SubProblem::computingNonlinearResid(), and FEProblemBase::computingNonlinearResid().
|
inherited |
An instance of helper class to write streams to the Console objects.
Definition at line 31 of file ConsoleStreamInterface.h.
Referenced by IterationAdaptiveDT::acceptStep(), MeshOnlyAction::act(), SetupDebugAction::act(), MaterialOutputAction::act(), Adaptivity::adaptMesh(), FEProblemBase::adaptMesh(), PerfGraph::addToExecutionList(), SimplePredictor::apply(), SystemBase::applyScalingFactors(), MultiApp::backup(), FEProblemBase::backupMultiApps(), CoarsenedPiecewiseLinear::buildCoarsenedGrid(), DefaultSteadyStateConvergence::checkConvergence(), MeshDiagnosticsGenerator::checkElementOverlap(), MeshDiagnosticsGenerator::checkElementTypes(), MeshDiagnosticsGenerator::checkElementVolumes(), FEProblemBase::checkExceptionAndStopSolve(), SolverSystem::checkInvalidSolution(), MeshDiagnosticsGenerator::checkLocalJacobians(), MeshDiagnosticsGenerator::checkNonConformalMesh(), MeshDiagnosticsGenerator::checkNonConformalMeshFromAdaptivity(), MeshDiagnosticsGenerator::checkNonMatchingEdges(), MeshDiagnosticsGenerator::checkNonPlanarSides(), FEProblemBase::checkProblemIntegrity(), ReferenceResidualConvergence::checkRelativeConvergence(), MeshDiagnosticsGenerator::checkSidesetsOrientation(), MeshDiagnosticsGenerator::checkWatertightNodesets(), MeshDiagnosticsGenerator::checkWatertightSidesets(), IterationAdaptiveDT::computeAdaptiveDT(), TransientBase::computeConstrainedDT(), DefaultMultiAppFixedPointConvergence::computeCustomConvergencePostprocessor(), NonlinearSystemBase::computeDamping(), FixedPointIterationAdaptiveDT::computeDT(), IterationAdaptiveDT::computeDT(), IterationAdaptiveDT::computeFailedDT(), IterationAdaptiveDT::computeInitialDT(), IterationAdaptiveDT::computeInterpolationDT(), LinearSystem::computeLinearSystemTags(), FEProblemBase::computeLinearSystemTags(), NonlinearSystemBase::computeScaling(), Problem::console(), IterationAdaptiveDT::constrainStep(), TimeStepper::constrainStep(), MultiApp::createApp(), FEProblemBase::execMultiApps(), FEProblemBase::execMultiAppTransfers(), MFEMSteady::execute(), MessageFromInput::execute(), SteadyBase::execute(), Eigenvalue::execute(), ActionWarehouse::executeActionsWithAction(), ActionWarehouse::executeAllActions(), MeshGeneratorSystem::executeMeshGenerators(), ElementQualityChecker::finalize(), FEProblemBase::finishMultiAppStep(), MeshRepairGenerator::fixOverlappingNodes(), CoarsenBlockGenerator::generate(), MeshGenerator::generateInternal(), VariableCondensationPreconditioner::getDofToCondense(), InversePowerMethod::init(), NonlinearEigen::init(), FEProblemBase::initialAdaptMesh(), DefaultMultiAppFixedPointConvergence::initialize(), EigenExecutionerBase::inversePowerIteration(), FEProblemBase::joinAndFinalize(), TransientBase::keepGoing(), IterationAdaptiveDT::limitDTByFunction(), IterationAdaptiveDT::limitDTToPostprocessorValue(), FEProblemBase::logAdd(), EigenExecutionerBase::makeBXConsistent(), Console::meshChanged(), MooseBaseErrorInterface::mooseDeprecated(), MooseBaseErrorInterface::mooseInfo(), MooseBaseErrorInterface::mooseWarning(), MooseBaseErrorInterface::mooseWarningNonPrefixed(), ReferenceResidualConvergence::nonlinearConvergenceSetup(), ReporterDebugOutput::output(), PerfGraphOutput::output(), SolutionInvalidityOutput::output(), MaterialPropertyDebugOutput::output(), DOFMapOutput::output(), VariableResidualNormsDebugOutput::output(), Console::output(), ControlOutput::outputActiveObjects(), ControlOutput::outputChangedControls(), ControlOutput::outputControls(), Console::outputInput(), Console::outputPostprocessors(), PseudoTimestep::outputPseudoTimestep(), Console::outputReporters(), DefaultMultiAppFixedPointConvergence::outputResidualNorm(), Console::outputScalarVariables(), Console::outputSystemInformation(), FEProblemBase::possiblyRebuildGeomSearchPatches(), EigenExecutionerBase::postExecute(), AB2PredictorCorrector::postSolve(), ActionWarehouse::printActionDependencySets(), BlockRestrictionDebugOutput::printBlockRestrictionMap(), SolutionInvalidity::printDebug(), EigenExecutionerBase::printEigenvalue(), SecantSolve::printFixedPointConvergenceHistory(), SteffensenSolve::printFixedPointConvergenceHistory(), PicardSolve::printFixedPointConvergenceHistory(), FixedPointSolve::printFixedPointConvergenceReason(), PerfGraphLivePrint::printLiveMessage(), MaterialPropertyDebugOutput::printMaterialMap(), PerfGraphLivePrint::printStats(), NEML2Action::printSummary(), AutomaticMortarGeneration::projectPrimaryNodesSinglePair(), AutomaticMortarGeneration::projectSecondaryNodesSinglePair(), CoarsenBlockGenerator::recursiveCoarsen(), SolutionTimeAdaptiveDT::rejectStep(), MultiApp::restore(), FEProblemBase::restoreMultiApps(), FEProblemBase::restoreSolutions(), NonlinearSystemBase::setInitialSolution(), MooseApp::setupOptions(), Checkpoint::shouldOutput(), SubProblem::showFunctorRequestors(), SubProblem::showFunctors(), FullSolveMultiApp::showStatusMessage(), EigenProblem::solve(), FEProblemSolve::solve(), FixedPointSolve::solve(), NonlinearSystem::solve(), LinearSystem::solve(), LStableDirk2::solve(), LStableDirk3::solve(), ImplicitMidpoint::solve(), ExplicitTVDRK2::solve(), LStableDirk4::solve(), AStableDirk4::solve(), ExplicitRK2::solve(), TransientMultiApp::solveStep(), FixedPointSolve::solveStep(), PerfGraphLivePrint::start(), AB2PredictorCorrector::step(), NonlinearEigen::takeStep(), TransientBase::takeStep(), TerminateChainControl::terminate(), Convergence::verboseOutput(), Console::writeTimestepInformation(), Console::writeVariableNorms(), and FEProblemBase::~FEProblemBase().
|
protectedinherited |
Flag to determine whether the problem is currently computing Jacobian.
Definition at line 1096 of file SubProblem.h.
Referenced by EigenProblem::computeJacobianBlocks(), FEProblemBase::computeJacobianBlocks(), FEProblemBase::computeJacobianTags(), SubProblem::currentlyComputingJacobian(), and SubProblem::setCurrentlyComputingJacobian().
|
protectedinherited |
Whether the residual is being evaluated.
Definition at line 1105 of file SubProblem.h.
Referenced by SubProblem::currentlyComputingResidual(), SubProblem::setCurrentlyComputingResidual(), and FEProblemBase::setCurrentlyComputingResidual().
|
protectedinherited |
Flag to determine whether the problem is currently computing the residual and Jacobian.
Definition at line 1099 of file SubProblem.h.
Referenced by SubProblem::currentlyComputingResidualAndJacobian(), and SubProblem::setCurrentlyComputingResidualAndJacobian().
|
protectedinherited |
Whether or not to use default libMesh coupling.
Definition at line 1090 of file SubProblem.h.
Referenced by SubProblem::defaultGhosting().
|
protectedinherited |
Definition at line 1049 of file SubProblem.h.
Referenced by clearDiracInfo(), FEProblemBase::clearDiracInfo(), SubProblem::diracKernelInfo(), getDiracElements(), FEProblemBase::getDiracElements(), FEProblemBase::meshChanged(), reinitDirac(), FEProblemBase::reinitDirac(), and updateMesh().
|
protected |
Definition at line 398 of file DisplacedProblem.h.
Referenced by addAuxVariable(), addTimeIntegrator(), auxSys(), customSetup(), DisplacedProblem(), getActualFieldVariable(), getArrayVariable(), getScalarVariable(), getStandardVariable(), getVariable(), getVectorVariable(), hasScalarVariable(), hasVariable(), init(), initialSetup(), jacobianSetup(), meshChanged(), prepareFace(), reinitDirac(), reinitElem(), reinitElemFace(), reinitElemPhys(), reinitNode(), reinitNodeFace(), reinitNodes(), reinitNodesNeighbor(), reinitScalars(), residualSetup(), restoreOldSolutions(), saveOldSolutions(), syncAuxSolution(), systemBaseAuxiliary(), timestepSetup(), and updateMesh().
|
protected |
Definition at line 397 of file DisplacedProblem.h.
Referenced by addCachedResidualDirectly(), addTimeIntegrator(), addVariable(), customSetup(), DisplacedProblem(), getActualFieldVariable(), getArrayVariable(), getScalarVariable(), getStandardVariable(), getVariable(), getVectorVariable(), hasScalarVariable(), hasVariable(), init(), initialSetup(), jacobianSetup(), meshChanged(), prepareFace(), reinitDirac(), reinitElem(), reinitElemFace(), reinitElemPhys(), reinitNode(), reinitNodeFace(), reinitNodes(), reinitNodesNeighbor(), reinitScalars(), residualSetup(), restoreOldSolutions(), saveOldSolutions(), setResidual(), setResidualNeighbor(), solverSys(), syncSolutions(), systemBaseNonlinear(), systemBaseSolver(), timestepSetup(), and updateMesh().
|
protected |
Definition at line 395 of file DisplacedProblem.h.
Referenced by getDisplacementVarNames(), and init().
|
protectedinherited |
Reference to the "enable" InputParameters, used by Controls for toggling on/off MooseObjects.
Definition at line 51 of file MooseObject.h.
Referenced by MooseObject::enabled().
|
protected |
Definition at line 392 of file DisplacedProblem.h.
Referenced by DisplacedProblem(), es(), getSystem(), init(), and meshChanged().
|
protectedinherited |
The Factory for building objects.
Definition at line 1047 of file SubProblem.h.
Referenced by FEProblemBase::addAnyRedistributers(), FEProblemBase::addAuxArrayVariable(), FEProblemBase::addAuxScalarVariable(), FEProblemBase::addAuxVariable(), FEProblemBase::addConvergence(), FEProblemBase::addDefaultMultiAppFixedPointConvergence(), ReferenceResidualProblem::addDefaultNonlinearConvergence(), FEProblemBase::addDefaultNonlinearConvergence(), FEProblemBase::addDefaultSteadyStateConvergence(), FEProblemBase::addFunction(), FEProblemBase::addFunctorMaterial(), FEProblemBase::addFVInitialCondition(), FEProblemBase::addIndicator(), FEProblemBase::addInitialCondition(), FEProblem::addLineSearch(), FEProblemBase::addMarker(), FEProblemBase::addMaterialHelper(), FEProblemBase::addMeshDivision(), MFEMProblem::addMFEMFESpaceFromMOOSEVariable(), FEProblemBase::addMultiApp(), FEProblemBase::addObject(), FEProblemBase::addOutput(), FEProblemBase::addPredictor(), FEProblemBase::addTransfer(), FEProblemBase::addUserObject(), DumpObjectsProblem::deduceNecessaryParameters(), and FEProblemBase::getFunction().
|
protected |
Definition at line 408 of file DisplacedProblem.h.
Referenced by geomSearchData(), updateGeomSearch(), and updateMesh().
|
protectedinherited |
Elements that should have Dofs ghosted to the local processor.
Definition at line 1093 of file SubProblem.h.
Referenced by FEProblemBase::addGhostedElem(), SubProblem::ghostedElems(), FEProblemBase::initialSetup(), FEProblemBase::meshChanged(), FEProblemBase::possiblyRebuildGeomSearchPatches(), and FEProblemBase::reinitBecauseOfGhostingOrNewGeomObjects().
|
protectedinherited |
Whether or not there is currently a list of active elemental moose variables.
Definition at line 1079 of file SubProblem.h.
Referenced by SubProblem::clearActiveElementalMooseVariables(), SubProblem::hasActiveElementalMooseVariables(), SubProblem::setActiveElementalMooseVariables(), and SubProblem::SubProblem().
|
protectedinherited |
AD flag indicating whether any AD objects have been added.
Definition at line 1114 of file SubProblem.h.
Referenced by haveADObjects(), SubProblem::haveADObjects(), and FEProblemBase::haveADObjects().
|
protectedinherited |
Map of material properties (block_id -> list of properties)
Definition at line 1052 of file SubProblem.h.
Referenced by SubProblem::checkBlockMatProps(), SubProblem::getMaterialPropertyBlocks(), SubProblem::hasBlockMaterialProperty(), and SubProblem::storeSubdomainMatPropName().
|
protectedinherited |
Data structures of the requested material properties.
We store them in a map from boundary/block id to multimap. Each of the multimaps is a list of requestor object names to material property names.
Definition at line 1070 of file SubProblem.h.
Referenced by SubProblem::checkBlockMatProps(), and SubProblem::storeSubdomainDelayedCheckMatProp().
|
protectedinherited |
Map for boundary material properties (boundary_id -> list of properties)
Definition at line 1055 of file SubProblem.h.
Referenced by SubProblem::checkBoundaryMatProps(), SubProblem::getMaterialPropertyBoundaryIDs(), SubProblem::hasBoundaryMaterialProperty(), and SubProblem::storeBoundaryMatPropName().
|
protectedinherited |
Definition at line 1071 of file SubProblem.h.
Referenced by SubProblem::checkBoundaryMatProps(), and SubProblem::storeBoundaryDelayedCheckMatProp().
|
protectedinherited |
set containing all material property names that have been requested by getMaterialProperty*
Definition at line 1062 of file SubProblem.h.
Referenced by SubProblem::isMatPropRequested(), and SubProblem::markMatPropRequested().
|
protectedinherited |
Reverse map.
Definition at line 1044 of file SubProblem.h.
Referenced by SubProblem::addMatrixTag(), SubProblem::matrixTagExists(), and SubProblem::matrixTagName().
|
protectedinherited |
The currently declared tags.
Definition at line 1041 of file SubProblem.h.
Referenced by SubProblem::addMatrixTag(), SubProblem::getMatrixTagID(), SubProblem::getMatrixTags(), SubProblem::matrixTagExists(), and SubProblem::numMatrixTags().
|
protected |
Definition at line 391 of file DisplacedProblem.h.
Referenced by DisplacedProblem(), init(), mesh(), meshChanged(), reinitElemNeighborAndLowerD(), reinitElemPhys(), undisplaceMesh(), and updateMesh().
|
protected |
Definition at line 390 of file DisplacedProblem.h.
Referenced by addGhostedBoundary(), addGhostedElem(), addMatrixTag(), addTimeIntegrator(), addVectorTag(), checkNonlocalCouplingRequirement(), computingPreSMOResidual(), computingScalingJacobian(), computingScalingResidual(), couplingMatrix(), currentLinearSysNum(), currentNlSysNum(), currentResidualVectorTags(), determineSolverSystem(), DisplacedProblem(), getLineSearch(), getMatrixTagID(), getVectorTag(), getVectorTagID(), getVectorTags(), ghostedElems(), ghostGhostedBoundaries(), hasNonlocalCoupling(), haveADObjects(), haveFV(), init(), isTransient(), linearSysNum(), matrixTagExists(), matrixTagName(), needFV(), nlSysNum(), nonlocalCouplingMatrix(), numLinearSystems(), numMatrixTags(), numNonlinearSystems(), numSolverSystems(), numVectorTags(), safeAccessTaggedMatrices(), safeAccessTaggedVectors(), solverSysNum(), solverSystemConverged(), syncSolutions(), undisplaceMesh(), updateMesh(), vectorTagExists(), vectorTagName(), and vectorTagType().
|
protectedinherited |
The name of this class.
Definition at line 90 of file MooseBase.h.
Referenced by AddBCAction::act(), AddConstraintAction::act(), AddDamperAction::act(), AddFVInitialConditionAction::act(), AddNodalKernelAction::act(), AddFVInterfaceKernelAction::act(), AddInterfaceKernelAction::act(), AddPostprocessorAction::act(), AddMaterialAction::act(), AddDiracKernelAction::act(), AddIndicatorAction::act(), AddScalarKernelAction::act(), AddTransferAction::act(), AddUserObjectAction::act(), AddFunctorMaterialAction::act(), AddVectorPostprocessorAction::act(), AddKernelAction::act(), PartitionerAction::act(), AddDGKernelAction::act(), ReadExecutorParamsAction::act(), AddMarkerAction::act(), AddMultiAppAction::act(), AddMeshGeneratorAction::act(), AddInitialConditionAction::act(), AddPositionsAction::act(), AddReporterAction::act(), AddTimesAction::act(), AddFieldSplitAction::act(), AddFVKernelAction::act(), AddFVBCAction::act(), AddConvergenceAction::act(), AddMeshDivisionAction::act(), AddHDGKernelAction::act(), AddTimeStepperAction::act(), AddDistributionAction::act(), SetupPreconditionerAction::act(), SetupTimeIntegratorAction::act(), AddFunctionAction::act(), AddOutputAction::act(), AddLinearFVBCAction::act(), AddLinearFVKernelAction::act(), AddCorrectorAction::act(), AddMeshModifiersAction::act(), AddSamplerAction::act(), AddControlAction::act(), AddMFEMSolverAction::act(), AddMFEMPreconditionerAction::act(), AddMFEMSubMeshAction::act(), AddMFEMFESpaceAction::act(), AddPeriodicBCAction::act(), ADPiecewiseLinearInterpolationMaterial::ADPiecewiseLinearInterpolationMaterial(), BatchMeshGeneratorAction::BatchMeshGeneratorAction(), PiecewiseTabularBase::buildFromFile(), PiecewiseTabularBase::buildFromXY(), PiecewiseLinearBase::buildInterpolation(), CombinerGenerator::CombinerGenerator(), Executor::Executor(), ExtraIDIntegralReporter::ExtraIDIntegralReporter(), QuadraturePointMultiApp::fillPositions(), CentroidMultiApp::fillPositions(), MultiApp::fillPositions(), FunctionDT::FunctionDT(), FillBetweenSidesetsGenerator::generate(), FillBetweenPointVectorsGenerator::generate(), FillBetweenCurvesGenerator::generate(), NearestPointBase< LayeredSideDiffusiveFluxAverage, SideIntegralVariableUserObject >::name(), ParsedFunctorMaterialTempl< is_ad >::ParsedFunctorMaterialTempl(), PiecewiseBilinear::PiecewiseBilinear(), PiecewiseLinearInterpolationMaterial::PiecewiseLinearInterpolationMaterial(), PiecewiseBase::setData(), and AddVariableAction::varName().
|
protected |
The nonlinear system solutions.
Definition at line 401 of file DisplacedProblem.h.
Referenced by DisplacedProblem(), and updateMesh().
|
protectedinherited |
the list of vector tags that will not be zeroed when all other tags are
Definition at line 1117 of file SubProblem.h.
Referenced by SubProblem::addNotZeroedVectorTag(), FEProblemBase::restoreSolutions(), and SubProblem::vectorTagNotZeroed().
|
protectedinherited |
Parameters of this object, references the InputParameters stored in the InputParametersWarehouse.
Definition at line 173 of file MooseBaseParameterInterface.h.
Referenced by AddFVICAction::act(), AddICAction::act(), CreateProblemAction::act(), CreateProblemDefaultAction::act(), SetupMeshAction::act(), ComposeTimeStepperAction::act(), SetupDebugAction::act(), AddAuxKernelAction::act(), AddPeriodicBCAction::act(), CommonOutputAction::act(), FunctorMaterial::addFunctorPropertyByBlocks(), BreakMeshByBlockGeneratorBase::BreakMeshByBlockGeneratorBase(), PiecewiseTabularBase::buildFromFile(), PNGOutput::calculateRescalingValues(), MooseBaseParameterInterface::connectControllableParams(), Console::Console(), MaterialBase::declareADProperty(), MaterialBase::declareProperty(), FEProblemSolve::FEProblemSolve(), FunctionMaterialBase< is_ad >::FunctionMaterialBase(), FileMeshGenerator::generate(), MaterialBase::getGenericZeroMaterialProperty(), MeshGenerator::getMeshGeneratorNameFromParam(), MeshGenerator::getMeshGeneratorNamesFromParam(), MooseBaseParameterInterface::getParam(), MooseBaseParameterInterface::getRenamedParam(), MeshGenerator::hasGenerateData(), AddVariableAction::init(), AdvancedOutput::initExecutionTypes(), Console::initialSetup(), MooseBaseParameterInterface::isParamSetByUser(), MooseBaseParameterInterface::isParamValid(), MultiApp::keepSolutionDuringRestore(), MooseBaseParameterInterface::MooseBaseParameterInterface(), MooseBaseParameterInterface::paramErrorMsg(), GlobalParamsAction::parameters(), MooseBaseParameterInterface::parameters(), MooseMesh::prepare(), Eigenvalue::prepareSolverOptions(), MooseMesh::setCoordSystem(), MooseMesh::setPartitionerHelper(), SetupMeshAction::setupMesh(), TransientBase::setupTimeIntegrator(), MooseBaseParameterInterface::uniqueName(), and MooseBaseParameterInterface::uniqueParameterName().
|
protectedinherited |
The MooseApp that owns the PerfGraph.
Definition at line 124 of file PerfGraphInterface.h.
Referenced by PerfGraphInterface::perfGraph().
|
protectedinherited |
A prefix to use for all sections.
Definition at line 127 of file PerfGraphInterface.h.
Referenced by PerfGraphInterface::timedSectionName().
|
protected |
reference mesh
Definition at line 394 of file DisplacedProblem.h.
Referenced by DisplacedProblem(), DisplacedProblem::UpdateDisplacedMeshThread::hasDisplacement(), DisplacedProblem::UpdateDisplacedMeshThread::init(), DisplacedProblem::UpdateDisplacedMeshThread::onNode(), and refMesh().
|
protectedinherited |
Is it safe to retrieve data from tagged matrices.
Definition at line 1108 of file SubProblem.h.
Referenced by FEProblemBase::computeJacobianTags(), FEProblemBase::computeLinearSystemTags(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::resetState(), and SubProblem::safeAccessTaggedMatrices().
|
protectedinherited |
Is it safe to retrieve data from tagged vectors.
Definition at line 1111 of file SubProblem.h.
Referenced by FEProblemBase::computeLinearSystemTags(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualTags(), FEProblemBase::resetState(), and SubProblem::safeAccessTaggedVectors().
|
protectedinherited |
True if termination of the solve has been requested.
Definition at line 58 of file Problem.h.
Referenced by Problem::isSolveTerminationRequested(), and Problem::terminateSolve().
|
protectedinherited |
The type of this class.
Definition at line 87 of file MooseBase.h.
Referenced by ExplicitTimeIntegrator::ExplicitTimeIntegrator(), FEProblemSolve::FEProblemSolve(), FillBetweenCurvesGenerator::generate(), FillBetweenPointVectorsGenerator::generate(), FillBetweenSidesetsGenerator::generate(), ExplicitTimeIntegrator::init(), FEProblemBase::init(), MooseStaticCondensationPreconditioner::MooseStaticCondensationPreconditioner(), PhysicsBasedPreconditioner::PhysicsBasedPreconditioner(), FEProblemBase::solverTypeString(), and MooseBase::type().
|
inherited |
Definition at line 674 of file SubProblem.h.
Referenced by MooseVariableBase::allDofIndices(), FEProblemBase::setNonlocalCouplingMatrix(), and FEProblemBase::setVariableAllDoFMap().
|
protectedinherited |
Set of properties returned as zero properties.
Definition at line 1058 of file SubProblem.h.
Referenced by SubProblem::checkBlockMatProps(), FEProblemBase::checkDependMaterialsHelper(), and SubProblem::storeSubdomainZeroMatProp().
|
protectedinherited |
Definition at line 1059 of file SubProblem.h.
Referenced by SubProblem::checkBoundaryMatProps(), and SubProblem::storeBoundaryZeroMatProp().