Problem that checks for convergence relative to a user-supplied reference quantity rather than the initial residual. More...
#include <ReferenceResidualProblem.h>
Public Types | |
enum | CoverageCheckMode { CoverageCheckMode::FALSE, CoverageCheckMode::TRUE, CoverageCheckMode::OFF, CoverageCheckMode::ON, CoverageCheckMode::SKIP_LIST, CoverageCheckMode::ONLY_LIST } |
using | DataFileParameterType = DataFileName |
The parameter type this interface expects for a data file name. More... | |
Public Member Functions | |
ReferenceResidualProblem (const InputParameters ¶ms) | |
virtual void | addDefaultNonlinearConvergence (const InputParameters ¶ms) override |
Adds the default nonlinear Convergence associated with the problem. More... | |
virtual bool | onlyAllowDefaultNonlinearConvergence () const override |
Returns true if an error will result if the user supplies 'nonlinear_convergence'. More... | |
virtual bool | getUseNonlinear () const |
virtual void | setUseNonlinear (bool use_nonlinear) |
virtual void | setInputParametersFEProblem (InputParameters ¶meters) override |
virtual NonlinearSystem & | getNonlinearSystem (const unsigned int nl_sys_num) override |
virtual void | addLineSearch (const InputParameters ¶meters) override |
add a MOOSE line search More... | |
virtual void | init () override |
virtual libMesh::EquationSystems & | es () override |
virtual MooseMesh & | mesh () override |
virtual const MooseMesh & | mesh () const override |
const MooseMesh & | mesh (bool use_displaced) const override |
void | setCoordSystem (const std::vector< SubdomainName > &blocks, const MultiMooseEnum &coord_sys) |
void | setAxisymmetricCoordAxis (const MooseEnum &rz_coord_axis) |
void | setCoupling (Moose::CouplingType type) |
Set the coupling between variables TODO: allow user-defined coupling. More... | |
Moose::CouplingType | coupling () const |
void | setCouplingMatrix (std::unique_ptr< libMesh::CouplingMatrix > cm, const unsigned int nl_sys_num) |
Set custom coupling matrix. More... | |
void | setCouplingMatrix (libMesh::CouplingMatrix *cm, const unsigned int nl_sys_num) |
const libMesh::CouplingMatrix * | couplingMatrix (const unsigned int nl_sys_num) const override |
The coupling matrix defining what blocks exist in the preconditioning matrix. More... | |
void | setNonlocalCouplingMatrix () |
Set custom coupling matrix for variables requiring nonlocal contribution. More... | |
bool | areCoupled (const unsigned int ivar, const unsigned int jvar, const unsigned int nl_sys_num) const |
bool | hasUOAuxStateCheck () const |
Whether or not MOOSE will perform a user object/auxiliary kernel state check. More... | |
bool | checkingUOAuxState () const |
Return a flag to indicate whether we are executing user objects and auxliary kernels for state check Note: This function can return true only when hasUOAuxStateCheck() returns true, i.e. More... | |
void | trustUserCouplingMatrix () |
Whether to trust the user coupling matrix even if we want to do things like be paranoid and create a full coupling matrix. More... | |
std::vector< std::pair< MooseVariableFEBase *, MooseVariableFEBase * > > & | couplingEntries (const THREAD_ID tid, const unsigned int nl_sys_num) |
std::vector< std::pair< MooseVariableFEBase *, MooseVariableFEBase * > > & | nonlocalCouplingEntries (const THREAD_ID tid, const unsigned int nl_sys_num) |
virtual bool | hasVariable (const std::string &var_name) const override |
Whether or not this problem has the variable. More... | |
bool | hasSolverVariable (const std::string &var_name) const |
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 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 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) |
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 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 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 libMesh::System & | getSystem (const std::string &var_name) override |
Returns the equation system containing the variable provided. More... | |
virtual void | setActiveElementalMooseVariables (const std::set< MooseVariableFEBase *> &moose_vars, const THREAD_ID tid) override |
Set the MOOSE variables to be reinited on each element. More... | |
virtual void | clearActiveElementalMooseVariables (const THREAD_ID tid) override |
Clear the active elemental MooseVariableFEBase. More... | |
virtual void | clearActiveFEVariableCoupleableMatrixTags (const THREAD_ID tid) override |
virtual void | clearActiveFEVariableCoupleableVectorTags (const THREAD_ID tid) override |
virtual void | setActiveFEVariableCoupleableVectorTags (std::set< TagID > &vtags, const THREAD_ID tid) override |
virtual void | setActiveFEVariableCoupleableMatrixTags (std::set< TagID > &mtags, const THREAD_ID tid) override |
virtual void | clearActiveScalarVariableCoupleableMatrixTags (const THREAD_ID tid) override |
virtual void | clearActiveScalarVariableCoupleableVectorTags (const THREAD_ID tid) override |
virtual void | setActiveScalarVariableCoupleableVectorTags (std::set< TagID > &vtags, const THREAD_ID tid) override |
virtual void | setActiveScalarVariableCoupleableMatrixTags (std::set< TagID > &mtags, const THREAD_ID tid) override |
virtual void | createQRules (libMesh::QuadratureType type, libMesh::Order order, libMesh::Order volume_order=libMesh::INVALID_ORDER, libMesh::Order face_order=libMesh::INVALID_ORDER, SubdomainID block=Moose::ANY_BLOCK_ID, bool allow_negative_qweights=true) |
void | bumpVolumeQRuleOrder (libMesh::Order order, SubdomainID block) |
Increases the element/volume quadrature order for the specified mesh block if and only if the current volume quadrature order is lower. More... | |
void | bumpAllQRuleOrder (libMesh::Order order, SubdomainID block) |
unsigned int | getMaxQps () const |
libMesh::Order | getMaxScalarOrder () const |
void | checkNonlocalCoupling () |
void | checkUserObjectJacobianRequirement (THREAD_ID tid) |
void | setVariableAllDoFMap (const std::vector< const MooseVariableFEBase *> &moose_vars) |
const std::vector< const MooseVariableFEBase * > & | getUserObjectJacobianVariables (const THREAD_ID tid) const |
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 std::vector< VariableName > | getVariableNames () |
Returns a list of all the variables in the problem (both from the NL and Aux systems. More... | |
void | initialSetup () override |
void | checkDuplicatePostprocessorVariableNames () |
void | timestepSetup () override |
void | customSetup (const ExecFlagType &exec_type) override |
void | residualSetup () override |
void | jacobianSetup () override |
virtual void | prepare (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 | prepareFace (const Elem *elem, 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 | setNeighborSubdomainID (const Elem *elem, const THREAD_ID tid) |
virtual void | prepareAssembly (const THREAD_ID tid) override |
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... | |
virtual void | sizeZeroes (unsigned int size, 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 |
void | reinitElemFace (const Elem *elem, unsigned int side, BoundaryID, const THREAD_ID tid) |
virtual void | reinitElemFace (const Elem *elem, unsigned int side, const THREAD_ID tid) override |
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) 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 |
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 | subdomainSetup (SubdomainID subdomain, const THREAD_ID tid) |
virtual void | neighborSubdomainSetup (SubdomainID subdomain, const THREAD_ID tid) |
virtual void | newAssemblyArray (std::vector< std::shared_ptr< SolverSystem >> &solver_systems) |
virtual void | initNullSpaceVectors (const InputParameters ¶meters, std::vector< std::shared_ptr< NonlinearSystemBase >> &nl) |
virtual void | solve (const unsigned int nl_sys_num) |
virtual void | solveLinearSystem (const unsigned int linear_sys_num, const Moose::PetscSupport::PetscOptions *po=nullptr) |
Build and solve a linear system. More... | |
virtual void | setException (const std::string &message) |
Set an exception, which is stored at this point by toggling a member variable in this class, and which must be followed up with by a call to checkExceptionAndStopSolve(). More... | |
virtual bool | hasException () |
Whether or not an exception has occurred. More... | |
virtual void | checkExceptionAndStopSolve (bool print_message=true) |
Check to see if an exception has occurred on any processor and, if possible, force the solve to fail, which will result in the time step being cut. More... | |
virtual bool | solverSystemConverged (const unsigned int solver_sys_num) override |
virtual unsigned int | nNonlinearIterations (const unsigned int nl_sys_num) const override |
virtual unsigned int | nLinearIterations (const unsigned int nl_sys_num) const override |
virtual Real | finalNonlinearResidual (const unsigned int nl_sys_num) const 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 std::string | solverTypeString (unsigned int solver_sys_num=0) |
Return solver type as a human readable string. More... | |
virtual bool | startedInitialSetup () |
Returns true if we are in or beyond the initialSetup stage. More... | |
virtual void | onTimestepBegin () override |
virtual void | onTimestepEnd () override |
virtual Real & | time () const |
virtual Real & | timeOld () const |
virtual int & | timeStep () const |
virtual Real & | dt () const |
virtual Real & | dtOld () const |
Real | getTimeFromStateArg (const Moose::StateArg &state) const |
Returns the time associated with the requested state . More... | |
virtual void | transient (bool trans) |
virtual bool | isTransient () const override |
virtual void | addTimeIntegrator (const std::string &type, const std::string &name, InputParameters ¶meters) |
virtual void | addPredictor (const std::string &type, const std::string &name, InputParameters ¶meters) |
virtual void | copySolutionsBackwards () |
virtual void | advanceState () |
Advance all of the state holding vectors / datastructures so that we can move to the next timestep. More... | |
virtual void | restoreSolutions () |
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 | needSolutionState (unsigned int oldest_needed, Moose::SolutionIterationType iteration_type) |
Declare that we need up to old (1) or older (2) solution states for a given type of iteration. More... | |
virtual void | outputStep (ExecFlagType type) |
Output the current step. More... | |
virtual void | postExecute () |
Method called at the end of the simulation. More... | |
void | forceOutput () |
Indicates that the next call to outputStep should be forced. More... | |
virtual void | initPetscOutputAndSomeSolverSettings () |
Reinitialize PETSc output for proper linear/nonlinear iteration display. More... | |
Moose::PetscSupport::PetscOptions & | getPetscOptions () |
Retrieve a writable reference the PETSc options (used by PetscSupport) More... | |
void | logAdd (const std::string &system, const std::string &name, const std::string &type, const InputParameters ¶ms) const |
Output information about the object just added to the problem. More... | |
virtual void | addFunction (const std::string &type, const std::string &name, InputParameters ¶meters) |
virtual bool | hasFunction (const std::string &name, const THREAD_ID tid=0) |
virtual Function & | getFunction (const std::string &name, const THREAD_ID tid=0) |
virtual void | addMeshDivision (const std::string &type, const std::string &name, InputParameters ¶ms) |
Add a MeshDivision. More... | |
MeshDivision & | getMeshDivision (const std::string &name, const THREAD_ID tid=0) const |
Get a MeshDivision. More... | |
virtual void | addConvergence (const std::string &type, const std::string &name, InputParameters ¶meters) |
Adds a Convergence object. More... | |
virtual Convergence & | getConvergence (const std::string &name, const THREAD_ID tid=0) const |
Gets a Convergence object. More... | |
virtual const std::vector< std::shared_ptr< Convergence > > & | getConvergenceObjects (const THREAD_ID tid=0) const |
Gets the Convergence objects. More... | |
virtual bool | hasConvergence (const std::string &name, const THREAD_ID tid=0) const |
Returns true if the problem has a Convergence object of the given name. More... | |
bool | needToAddDefaultNonlinearConvergence () const |
Returns true if the problem needs to add the default nonlinear convergence. More... | |
bool | needToAddDefaultMultiAppFixedPointConvergence () const |
Returns true if the problem needs to add the default fixed point convergence. More... | |
void | setNeedToAddDefaultNonlinearConvergence () |
Sets _need_to_add_default_nonlinear_convergence to true. More... | |
void | setNeedToAddDefaultMultiAppFixedPointConvergence () |
Sets _need_to_add_default_multiapp_fixed_point_convergence to true. More... | |
bool | hasSetMultiAppFixedPointConvergenceName () const |
Returns true if the problem has set the fixed point convergence name. More... | |
void | addDefaultMultiAppFixedPointConvergence (const InputParameters ¶ms) |
Adds the default fixed point Convergence associated with the problem. More... | |
virtual void | lineSearch () |
execute MOOSE line search More... | |
LineSearch * | getLineSearch () override |
getter for the MOOSE line search More... | |
virtual void | addDistribution (const std::string &type, const std::string &name, InputParameters ¶meters) |
The following functions will enable MOOSE to have the capability to import distributions. More... | |
virtual Distribution & | getDistribution (const std::string &name) |
virtual void | addSampler (const std::string &type, const std::string &name, InputParameters ¶meters) |
The following functions will enable MOOSE to have the capability to import Samplers. More... | |
virtual Sampler & | getSampler (const std::string &name, const THREAD_ID tid=0) |
NonlinearSystemBase & | getNonlinearSystemBase (const unsigned int sys_num) |
const NonlinearSystemBase & | getNonlinearSystemBase (const unsigned int sys_num) const |
void | setCurrentNonlinearSystem (const unsigned int nl_sys_num) |
NonlinearSystemBase & | currentNonlinearSystem () |
const NonlinearSystemBase & | currentNonlinearSystem () const |
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 & | 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 |
virtual const SystemBase & | getSystemBase (const unsigned int sys_num) const |
Get constant reference to a system in this problem. More... | |
virtual SystemBase & | getSystemBase (const unsigned int sys_num) |
Get non-constant reference to a system in this problem. More... | |
LinearSystem & | getLinearSystem (unsigned int sys_num) |
Get non-constant reference to a linear system. More... | |
const LinearSystem & | getLinearSystem (unsigned int sys_num) const |
Get a constant reference to a linear system. More... | |
SolverSystem & | getSolverSystem (unsigned int sys_num) |
Get non-constant reference to a solver system. More... | |
const SolverSystem & | getSolverSystem (unsigned int sys_num) const |
Get a constant reference to a solver system. More... | |
void | setCurrentLinearSystem (unsigned int sys_num) |
Set the current linear system pointer. More... | |
LinearSystem & | currentLinearSystem () |
Get a non-constant reference to the current linear system. More... | |
const LinearSystem & | currentLinearSystem () const |
Get a constant reference to the current linear system. More... | |
virtual const SystemBase & | systemBaseLinear (unsigned int sys_num) const override |
Get a constant base class reference to a linear system. More... | |
virtual SystemBase & | systemBaseLinear (unsigned int sys_num) override |
Get a non-constant base class reference to a linear system. More... | |
virtual void | addVariable (const std::string &var_type, const std::string &var_name, InputParameters ¶ms) |
Canonical method for adding a non-linear variable. More... | |
virtual void | addKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addHDGKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addNodalKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addScalarKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addBoundaryCondition (const std::string &bc_name, const std::string &name, InputParameters ¶meters) |
virtual void | addConstraint (const std::string &c_name, const std::string &name, InputParameters ¶meters) |
virtual void | addAuxVariable (const std::string &var_type, const std::string &var_name, InputParameters ¶ms) |
Canonical method for adding an auxiliary variable. More... | |
virtual void | addAuxVariable (const std::string &var_name, const libMesh::FEType &type, const std::set< SubdomainID > *const active_subdomains=NULL) |
virtual void | addAuxArrayVariable (const std::string &var_name, const libMesh::FEType &type, unsigned int components, const std::set< SubdomainID > *const active_subdomains=NULL) |
virtual void | addAuxScalarVariable (const std::string &var_name, libMesh::Order order, Real scale_factor=1., const std::set< SubdomainID > *const active_subdomains=NULL) |
virtual void | addAuxKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addAuxScalarKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
AuxiliarySystem & | getAuxiliarySystem () |
virtual void | addDiracKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addDGKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addFVKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addLinearFVKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addFVBC (const std::string &fv_bc_name, const std::string &name, InputParameters ¶meters) |
virtual void | addLinearFVBC (const std::string &fv_bc_name, const std::string &name, InputParameters ¶meters) |
virtual void | addFVInterfaceKernel (const std::string &fv_ik_name, const std::string &name, InputParameters ¶meters) |
virtual void | addInterfaceKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addInitialCondition (const std::string &ic_name, const std::string &name, InputParameters ¶meters) |
virtual void | addFVInitialCondition (const std::string &ic_name, const std::string &name, InputParameters ¶meters) |
Add an initial condition for a finite volume variables. More... | |
void | projectSolution () |
unsigned short | getCurrentICState () |
Retrieves the current initial condition state. More... | |
void | projectInitialConditionOnCustomRange (libMesh::ConstElemRange &elem_range, ConstBndNodeRange &bnd_node_range) |
Project initial conditions for custom elem_range and bnd_node_range This is needed when elements/boundary nodes are added to a specific subdomain at an intermediate step. More... | |
virtual void | addMaterial (const std::string &material_name, const std::string &name, InputParameters ¶meters) |
virtual void | addMaterialHelper (std::vector< MaterialWarehouse *> warehouse, const std::string &material_name, const std::string &name, InputParameters ¶meters) |
virtual void | addInterfaceMaterial (const std::string &material_name, const std::string &name, InputParameters ¶meters) |
virtual void | addFunctorMaterial (const std::string &functor_material_name, const std::string &name, InputParameters ¶meters) |
void | prepareMaterials (const std::unordered_set< unsigned int > &consumer_needed_mat_props, const SubdomainID blk_id, const THREAD_ID tid) |
Add the MooseVariables and the material properties that the current materials depend on to the dependency list. More... | |
void | reinitMaterials (SubdomainID blk_id, const THREAD_ID tid, bool swap_stateful=true) |
void | reinitMaterialsFace (SubdomainID blk_id, const THREAD_ID tid, bool swap_stateful=true, const std::deque< MaterialBase *> *reinit_mats=nullptr) |
reinit materials on element faces More... | |
void | reinitMaterialsNeighbor (SubdomainID blk_id, const THREAD_ID tid, bool swap_stateful=true, const std::deque< MaterialBase *> *reinit_mats=nullptr) |
reinit materials on the neighboring element face More... | |
void | reinitMaterialsBoundary (BoundaryID boundary_id, const THREAD_ID tid, bool swap_stateful=true, const std::deque< MaterialBase *> *reinit_mats=nullptr) |
reinit materials on a boundary More... | |
void | reinitMaterialsInterface (BoundaryID boundary_id, const THREAD_ID tid, bool swap_stateful=true) |
virtual void | swapBackMaterials (const THREAD_ID tid) |
virtual void | swapBackMaterialsFace (const THREAD_ID tid) |
virtual void | swapBackMaterialsNeighbor (const THREAD_ID tid) |
void | setActiveMaterialProperties (const std::unordered_set< unsigned int > &mat_prop_ids, const THREAD_ID tid) |
Record and set the material properties required by the current computing thread. More... | |
bool | hasActiveMaterialProperties (const THREAD_ID tid) const |
Method to check whether or not a list of active material roperties has been set. More... | |
void | clearActiveMaterialProperties (const THREAD_ID tid) |
Clear the active material properties. More... | |
template<typename T > | |
std::vector< std::shared_ptr< T > > | addObject (const std::string &type, const std::string &name, InputParameters ¶meters, const bool threaded=true, const std::string &var_param_name="variable") |
Method for creating and adding an object to the warehouse. More... | |
virtual void | addPostprocessor (const std::string &pp_name, const std::string &name, InputParameters ¶meters) |
virtual void | addVectorPostprocessor (const std::string &pp_name, const std::string &name, InputParameters ¶meters) |
virtual void | addReporter (const std::string &type, const std::string &name, InputParameters ¶meters) |
Add a Reporter object to the simulation. More... | |
const ReporterData & | getReporterData () const |
Provides const access the ReporterData object. More... | |
ReporterData & | getReporterData (ReporterData::WriteKey) |
Provides non-const access the ReporterData object that is used to store reporter values. More... | |
virtual std::vector< std::shared_ptr< UserObject > > | addUserObject (const std::string &user_object_name, const std::string &name, InputParameters ¶meters) |
const ExecuteMooseObjectWarehouse< UserObject > & | getUserObjects () const |
template<class T > | |
T & | getUserObject (const std::string &name, unsigned int tid=0) const |
Get the user object by its name. More... | |
const UserObject & | getUserObjectBase (const std::string &name, const THREAD_ID tid=0) const |
Get the user object by its name. More... | |
const Positions & | getPositionsObject (const std::string &name) const |
Get the Positions object by its name. More... | |
bool | hasUserObject (const std::string &name) const |
Check if there if a user object of given name. More... | |
bool | hasPostprocessorValueByName (const PostprocessorName &name) const |
Whether or not a Postprocessor value exists by a given name. More... | |
const PostprocessorValue & | getPostprocessorValueByName (const PostprocessorName &name, std::size_t t_index=0) const |
Get a read-only reference to the value associated with a Postprocessor that exists. More... | |
void | setPostprocessorValueByName (const PostprocessorName &name, const PostprocessorValue &value, std::size_t t_index=0) |
Set the value of a PostprocessorValue. More... | |
bool | hasPostprocessor (const std::string &name) const |
Deprecated. More... | |
const VectorPostprocessorValue & | getVectorPostprocessorValueByName (const std::string &object_name, const std::string &vector_name, std::size_t t_index=0) const |
Get a read-only reference to the vector value associated with the VectorPostprocessor. More... | |
void | setVectorPostprocessorValueByName (const std::string &object_name, const std::string &vector_name, const VectorPostprocessorValue &value, std::size_t t_index=0) |
Set the value of a VectorPostprocessor vector. More... | |
const VectorPostprocessor & | getVectorPostprocessorObjectByName (const std::string &object_name, const THREAD_ID tid=0) const |
Return the VPP object given the name. More... | |
virtual void | addDamper (const std::string &damper_name, const std::string &name, InputParameters ¶meters) |
void | setupDampers () |
bool | hasDampers () |
Whether or not this system has dampers. More... | |
virtual void | addIndicator (const std::string &indicator_name, const std::string &name, InputParameters ¶meters) |
virtual void | addMarker (const std::string &marker_name, const std::string &name, InputParameters ¶meters) |
virtual void | addMultiApp (const std::string &multi_app_name, const std::string &name, InputParameters ¶meters) |
Add a MultiApp to the problem. More... | |
std::shared_ptr< MultiApp > | getMultiApp (const std::string &multi_app_name) const |
Get a MultiApp object by name. More... | |
std::vector< std::shared_ptr< Transfer > > | getTransfers (ExecFlagType type, Transfer::DIRECTION direction) const |
Get Transfers by ExecFlagType and direction. More... | |
std::vector< std::shared_ptr< Transfer > > | getTransfers (Transfer::DIRECTION direction) const |
const ExecuteMooseObjectWarehouse< Transfer > & | getMultiAppTransferWarehouse (Transfer::DIRECTION direction) const |
Return the complete warehouse for MultiAppTransfer object for the given direction. More... | |
void | execMultiAppTransfers (ExecFlagType type, Transfer::DIRECTION direction) |
Execute MultiAppTransfers associated with execution flag and direction. More... | |
bool | execMultiApps (ExecFlagType type, bool auto_advance=true) |
Execute the MultiApps associated with the ExecFlagType. More... | |
void | finalizeMultiApps () |
void | incrementMultiAppTStep (ExecFlagType type) |
Advance the MultiApps t_step (incrementStepOrReject) associated with the ExecFlagType. More... | |
void | advanceMultiApps (ExecFlagType type) |
Deprecated method; use finishMultiAppStep and/or incrementMultiAppTStep depending on your purpose. More... | |
void | finishMultiAppStep (ExecFlagType type, bool recurse_through_multiapp_levels=false) |
Finish the MultiApp time step (endStep, postStep) associated with the ExecFlagType. More... | |
void | backupMultiApps (ExecFlagType type) |
Backup the MultiApps associated with the ExecFlagType. More... | |
void | restoreMultiApps (ExecFlagType type, bool force=false) |
Restore the MultiApps associated with the ExecFlagType. More... | |
Real | computeMultiAppsDT (ExecFlagType type) |
Find the smallest timestep over all MultiApps. More... | |
virtual void | addTransfer (const std::string &transfer_name, const std::string &name, InputParameters ¶meters) |
Add a Transfer to the problem. More... | |
void | execTransfers (ExecFlagType type) |
Execute the Transfers associated with the ExecFlagType. More... | |
Real | computeResidualL2Norm (NonlinearSystemBase &sys) |
Computes the residual of a nonlinear system using whatever is sitting in the current solution vector then returns the L2 norm. More... | |
Real | computeResidualL2Norm (LinearSystem &sys) |
Computes the residual of a linear system using whatever is sitting in the current solution vector then returns the L2 norm. More... | |
virtual Real | computeResidualL2Norm () |
Computes the residual using whatever is sitting in the current solution vector then returns the L2 norm. More... | |
virtual void | computeResidualSys (libMesh::NonlinearImplicitSystem &sys, const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual) |
This function is called by Libmesh to form a residual. More... | |
void | computeResidual (libMesh::NonlinearImplicitSystem &sys, const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual) |
This function is called by Libmesh to form a residual. More... | |
virtual void | computeResidual (const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual, const unsigned int nl_sys_num) |
Form a residual with default tags (nontime, time, residual). More... | |
void | computeResidualAndJacobian (const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual, libMesh::SparseMatrix< libMesh::Number > &jacobian) |
Form a residual and Jacobian with default tags. More... | |
virtual void | computeResidualTag (const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual, TagID tag) |
Form a residual vector for a given tag. More... | |
virtual void | computeResidualType (const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual, TagID tag) |
Form a residual vector for a given tag and "residual" tag. More... | |
virtual void | computeResidualInternal (const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual, const std::set< TagID > &tags) |
Form a residual vector for a set of tags. More... | |
virtual void | computeResidualTags (const std::set< TagID > &tags) |
Form multiple residual vectors and each is associated with one tag. More... | |
virtual void | computeJacobianSys (libMesh::NonlinearImplicitSystem &sys, const NumericVector< libMesh::Number > &soln, libMesh::SparseMatrix< libMesh::Number > &jacobian) |
Form a Jacobian matrix. More... | |
virtual void | computeJacobian (const NumericVector< libMesh::Number > &soln, libMesh::SparseMatrix< libMesh::Number > &jacobian, const unsigned int nl_sys_num) |
Form a Jacobian matrix with the default tag (system). More... | |
virtual void | computeJacobianTag (const NumericVector< libMesh::Number > &soln, libMesh::SparseMatrix< libMesh::Number > &jacobian, TagID tag) |
Form a Jacobian matrix for a given tag. More... | |
virtual void | computeJacobianInternal (const NumericVector< libMesh::Number > &soln, libMesh::SparseMatrix< libMesh::Number > &jacobian, const std::set< TagID > &tags) |
Form a Jacobian matrix for multiple tags. More... | |
virtual void | computeJacobianTags (const std::set< TagID > &tags) |
Form multiple matrices, and each is associated with a tag. More... | |
virtual void | computeJacobianBlocks (std::vector< JacobianBlock *> &blocks, const unsigned int nl_sys_num) |
Computes several Jacobian blocks simultaneously, summing their contributions into smaller preconditioning matrices. More... | |
virtual void | computeJacobianBlock (libMesh::SparseMatrix< libMesh::Number > &jacobian, libMesh::System &precond_system, unsigned int ivar, unsigned int jvar) |
Really not a good idea to use this. More... | |
virtual void | computeLinearSystemSys (libMesh::LinearImplicitSystem &sys, libMesh::SparseMatrix< libMesh::Number > &system_matrix, NumericVector< libMesh::Number > &rhs, const bool compute_gradients=true) |
Assemble both the right hand side and the system matrix of a given linear system. More... | |
void | computeLinearSystemTags (const NumericVector< libMesh::Number > &soln, const std::set< TagID > &vector_tags, const std::set< TagID > &matrix_tags, const bool compute_gradients=true) |
Assemble the current linear system given a set of vector and matrix tags. More... | |
virtual Real | computeDamping (const NumericVector< libMesh::Number > &soln, const NumericVector< libMesh::Number > &update) |
virtual bool | shouldUpdateSolution () |
Check to see whether the problem should update the solution. More... | |
virtual bool | updateSolution (NumericVector< libMesh::Number > &vec_solution, NumericVector< libMesh::Number > &ghosted_solution) |
Update the solution. More... | |
virtual void | predictorCleanup (NumericVector< libMesh::Number > &ghosted_solution) |
Perform cleanup tasks after application of predictor to solution vector. More... | |
virtual void | computeBounds (libMesh::NonlinearImplicitSystem &sys, NumericVector< libMesh::Number > &lower, NumericVector< libMesh::Number > &upper) |
virtual void | computeNearNullSpace (libMesh::NonlinearImplicitSystem &sys, std::vector< NumericVector< libMesh::Number > *> &sp) |
virtual void | computeNullSpace (libMesh::NonlinearImplicitSystem &sys, std::vector< NumericVector< libMesh::Number > *> &sp) |
virtual void | computeTransposeNullSpace (libMesh::NonlinearImplicitSystem &sys, std::vector< NumericVector< libMesh::Number > *> &sp) |
virtual void | computePostCheck (libMesh::NonlinearImplicitSystem &sys, const NumericVector< libMesh::Number > &old_soln, NumericVector< libMesh::Number > &search_direction, NumericVector< libMesh::Number > &new_soln, bool &changed_search_direction, bool &changed_new_soln) |
virtual void | computeIndicatorsAndMarkers () |
virtual void | computeIndicators () |
virtual void | computeMarkers () |
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 | addResidualScalar (const THREAD_ID tid=0) |
virtual void | cacheResidual (const THREAD_ID tid) override |
virtual void | cacheResidualNeighbor (const THREAD_ID tid) override |
virtual void | addCachedResidual (const THREAD_ID tid) override |
virtual void | addCachedResidualDirectly (NumericVector< libMesh::Number > &residual, const THREAD_ID tid) |
Allows for all the residual contributions that are currently cached to be added directly into the vector passed in. More... | |
virtual void | setResidual (NumericVector< libMesh::Number > &residual, const THREAD_ID tid) override |
virtual void | setResidual (libMesh::NumericVector< libMesh::Number > &residual, const THREAD_ID tid)=0 |
virtual void | setResidualNeighbor (NumericVector< libMesh::Number > &residual, const THREAD_ID tid) override |
virtual void | setResidualNeighbor (libMesh::NumericVector< libMesh::Number > &residual, const THREAD_ID tid)=0 |
virtual void | addJacobian (const THREAD_ID tid) override |
virtual void | addJacobianNeighbor (const THREAD_ID tid) override |
virtual void | addJacobianNeighbor (libMesh::SparseMatrix< libMesh::Number > &jacobian, unsigned int ivar, unsigned int jvar, const 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 | addJacobianNeighbor (libMesh::SparseMatrix< libMesh::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)=0 |
virtual void | addJacobianNeighborLowerD (const THREAD_ID tid) override |
virtual void | addJacobianLowerD (const THREAD_ID tid) override |
virtual void | addJacobianBlockTags (libMesh::SparseMatrix< libMesh::Number > &jacobian, unsigned int ivar, unsigned int jvar, const DofMap &dof_map, std::vector< dof_id_type > &dof_indices, const std::set< TagID > &tags, const THREAD_ID tid) |
virtual void | addJacobianScalar (const THREAD_ID tid=0) |
virtual void | addJacobianOffDiagScalar (unsigned int ivar, const THREAD_ID tid=0) |
virtual void | cacheJacobian (const THREAD_ID tid) override |
virtual void | cacheJacobianNeighbor (const THREAD_ID tid) override |
virtual void | addCachedJacobian (const THREAD_ID tid) override |
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 void | addDisplacedProblem (std::shared_ptr< DisplacedProblem > displaced_problem) |
virtual std::shared_ptr< const DisplacedProblem > | getDisplacedProblem () const |
virtual std::shared_ptr< DisplacedProblem > | getDisplacedProblem () |
virtual void | updateGeomSearch (GeometricSearchData::GeometricSearchType type=GeometricSearchData::ALL) override |
virtual void | updateMortarMesh () |
void | createMortarInterface (const std::pair< BoundaryID, BoundaryID > &primary_secondary_boundary_pair, const std::pair< SubdomainID, SubdomainID > &primary_secondary_subdomain_pair, bool on_displaced, bool periodic, const bool debug, const bool correct_edge_dropping, const Real minimum_projection_angle) |
const std::unordered_map< std::pair< BoundaryID, BoundaryID >, AutomaticMortarGeneration > & | getMortarInterfaces (bool on_displaced) const |
virtual void | possiblyRebuildGeomSearchPatches () |
virtual GeometricSearchData & | geomSearchData () override |
void | setRestartFile (const std::string &file_name) |
Communicate to the Resurector the name of the restart filer. More... | |
const MaterialPropertyRegistry & | getMaterialPropertyRegistry () const |
const InitialConditionWarehouse & | getInitialConditionWarehouse () const |
Return InitialCondition storage. More... | |
const FVInitialConditionWarehouse & | getFVInitialConditionWarehouse () const |
Return FVInitialCondition storage. More... | |
SolverParams & | solverParams (unsigned int solver_sys_num=0) |
Get the solver parameters. More... | |
const SolverParams & | solverParams (unsigned int solver_sys_num=0) const |
const version More... | |
Adaptivity & | adaptivity () |
virtual void | initialAdaptMesh () |
virtual bool | adaptMesh () |
unsigned int | getNumCyclesCompleted () |
bool | hasInitialAdaptivity () const |
Return a Boolean indicating whether initial AMR is turned on. More... | |
bool | hasInitialAdaptivity () const |
Return a Boolean indicating whether initial AMR is turned on. More... | |
void | initXFEM (std::shared_ptr< XFEMInterface > xfem) |
Create XFEM controller object. More... | |
std::shared_ptr< XFEMInterface > | getXFEM () |
Get a pointer to the XFEM controller object. More... | |
bool | haveXFEM () |
Find out whether the current analysis is using XFEM. More... | |
virtual bool | updateMeshXFEM () |
Update the mesh due to changing XFEM cuts. More... | |
virtual void | meshChanged (bool intermediate_change, bool contract_mesh, bool clean_refinement_flags) |
Update data after a mesh change. More... | |
void | notifyWhenMeshChanges (MeshChangedInterface *mci) |
Register an object that derives from MeshChangedInterface to be notified when the mesh changes. More... | |
void | notifyWhenMeshDisplaces (MeshDisplacedInterface *mdi) |
Register an object that derives from MeshDisplacedInterface to be notified when the displaced mesh gets updated. More... | |
void | initElementStatefulProps (const libMesh::ConstElemRange &elem_range, const bool threaded) |
Initialize stateful properties for elements in a specific elem_range This is needed when elements/boundary nodes are added to a specific subdomain at an intermediate step. More... | |
virtual void | checkProblemIntegrity () |
Method called to perform a series of sanity checks before a simulation is run. More... | |
void | registerRandomInterface (RandomInterface &random_interface, const std::string &name) |
void | setConstJacobian (bool state) |
Set flag that Jacobian is constant (for optimization purposes) More... | |
void | setKernelCoverageCheck (CoverageCheckMode mode) |
Set flag to indicate whether kernel coverage checks should be performed. More... | |
void | setKernelCoverageCheck (bool flag) |
Set flag to indicate whether kernel coverage checks should be performed. More... | |
void | setMaterialCoverageCheck (CoverageCheckMode mode) |
Set flag to indicate whether material coverage checks should be performed. More... | |
void | setMaterialCoverageCheck (bool flag) |
Set flag to indicate whether material coverage checks should be performed. More... | |
void | setParallelBarrierMessaging (bool flag) |
Toggle parallel barrier messaging (defaults to on). More... | |
void | setVerboseProblem (bool verbose) |
Make the problem be verbose. More... | |
bool | verboseMultiApps () const |
Whether or not to use verbose printing for MultiApps. More... | |
void | parentOutputPositionChanged () |
Calls parentOutputPositionChanged() on all sub apps. More... | |
unsigned int | subspaceDim (const std::string &prefix) const |
Dimension of the subspace spanned by vectors with a given prefix. More... | |
const MaterialWarehouse & | getMaterialWarehouse () const |
const MaterialWarehouse & | getRegularMaterialsWarehouse () const |
const MaterialWarehouse & | getDiscreteMaterialWarehouse () const |
const MaterialWarehouse & | getInterfaceMaterialsWarehouse () const |
std::shared_ptr< MaterialBase > | getMaterial (std::string name, Moose::MaterialDataType type, const THREAD_ID tid=0, bool no_warn=false) |
Return a pointer to a MaterialBase object. More... | |
MaterialData & | getMaterialData (Moose::MaterialDataType type, const THREAD_ID tid=0) const |
bool | restoreOriginalNonzeroPattern () const |
bool | errorOnJacobianNonzeroReallocation () const |
Will return True if the user wants to get an error when a nonzero is reallocated in the Jacobian by PETSc. More... | |
void | setErrorOnJacobianNonzeroReallocation (bool state) |
bool | preserveMatrixSparsityPattern () const |
Will return True if the executioner in use requires preserving the sparsity pattern of the matrices being formed during the solve. More... | |
void | setPreserveMatrixSparsityPattern (bool preserve) |
Set whether the sparsity pattern of the matrices being formed during the solve (usually the Jacobian) should be preserved. More... | |
bool | ignoreZerosInJacobian () const |
Will return true if zeros in the Jacobian are to be dropped from the sparsity pattern. More... | |
void | setIgnoreZerosInJacobian (bool state) |
Set whether the zeros in the Jacobian should be dropped from the sparsity pattern. More... | |
bool | acceptInvalidSolution () const |
Whether or not to accept the solution based on its invalidity. More... | |
bool | allowInvalidSolution () const |
Whether to accept / allow an invalid solution. More... | |
bool | showInvalidSolutionConsole () const |
Whether or not to print out the invalid solutions summary table in console. More... | |
bool | immediatelyPrintInvalidSolution () const |
Whether or not the solution invalid warnings are printed out immediately. More... | |
bool | hasTimeIntegrator () const |
Returns whether or not this Problem has a TimeIntegrator. More... | |
virtual void | execute (const ExecFlagType &exec_type) |
Convenience function for performing execution of MOOSE systems. More... | |
virtual void | executeAllObjects (const ExecFlagType &exec_type) |
virtual Executor & | getExecutor (const std::string &name) |
virtual void | computeUserObjects (const ExecFlagType &type, const Moose::AuxGroup &group) |
Call compute methods on UserObjects. More... | |
virtual void | computeUserObjectByName (const ExecFlagType &type, const Moose::AuxGroup &group, const std::string &name) |
Compute an user object with the given name. More... | |
void | needsPreviousNewtonIteration (bool state) |
Set a flag that indicated that user required values for the previous Newton iterate. More... | |
bool | needsPreviousNewtonIteration () const |
Check to see whether we need to compute the variable values of the previous Newton iterate. More... | |
ExecuteMooseObjectWarehouse< Control > & | getControlWarehouse () |
Reference to the control logic warehouse. More... | |
void | executeControls (const ExecFlagType &exec_type) |
Performs setup and execute calls for Control objects. More... | |
void | executeSamplers (const ExecFlagType &exec_type) |
Performs setup and execute calls for Sampler objects. More... | |
virtual void | updateActiveObjects () |
Update the active objects in the warehouses. More... | |
void | reportMooseObjectDependency (MooseObject *a, MooseObject *b) |
Register a MOOSE object dependency so we can either order operations properly or report when we cannot. More... | |
ExecuteMooseObjectWarehouse< MultiApp > & | getMultiAppWarehouse () |
bool | hasJacobian () const |
Returns _has_jacobian. More... | |
bool | constJacobian () const |
Returns _const_jacobian (whether a MOOSE object has specified that the Jacobian is the same as the previous time it was computed) More... | |
void | addOutput (const std::string &, const std::string &, InputParameters &) |
Adds an Output object. More... | |
TheWarehouse & | theWarehouse () const |
void | setSNESMFReuseBase (bool reuse, bool set_by_user) |
If or not to reuse the base vector for matrix-free calculation. More... | |
bool | useSNESMFReuseBase () |
Return a flag that indicates if we are reusing the vector base. More... | |
void | skipExceptionCheck (bool skip_exception_check) |
Set a flag that indicates if we want to skip exception and stop solve. More... | |
bool | isSNESMFReuseBaseSetbyUser () |
Return a flag to indicate if _snesmf_reuse_base is set by users. More... | |
bool & | petscOptionsInserted () |
If PETSc options are already inserted. More... | |
PetscOptions & | petscOptionsDatabase () |
virtual void | setUDotRequested (const bool u_dot_requested) |
Set boolean flag to true to store solution time derivative. More... | |
virtual void | setUDotDotRequested (const bool u_dotdot_requested) |
Set boolean flag to true to store solution second time derivative. More... | |
virtual void | setUDotOldRequested (const bool u_dot_old_requested) |
Set boolean flag to true to store old solution time derivative. More... | |
virtual void | setUDotDotOldRequested (const bool u_dotdot_old_requested) |
Set boolean flag to true to store old solution second time derivative. More... | |
virtual bool | uDotRequested () |
Get boolean flag to check whether solution time derivative needs to be stored. More... | |
virtual bool | uDotDotRequested () |
Get boolean flag to check whether solution second time derivative needs to be stored. More... | |
virtual bool | uDotOldRequested () |
Get boolean flag to check whether old solution time derivative needs to be stored. More... | |
virtual bool | uDotDotOldRequested () |
Get boolean flag to check whether old solution second time derivative needs to be stored. More... | |
void | haveADObjects (bool have_ad_objects) override |
Method for setting whether we have any ad objects. More... | |
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... | |
bool | haveADObjects () const |
Method for reading wehther we have any ad objects. More... | |
bool | shouldSolve () const |
const MortarData & | mortarData () const |
Returns the mortar data object. More... | |
MortarData & | mortarData () |
virtual bool | hasNeighborCoupling () const |
Whether the simulation has neighbor coupling. More... | |
virtual bool | hasMortarCoupling () const |
Whether the simulation has mortar coupling. More... | |
void | computingNonlinearResid (bool computing_nonlinear_residual) final |
Set whether or not the problem is in the process of computing the nonlinear residual. 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... | |
bool | computingNonlinearResid () const |
Returns true if the problem is in the process of computing the nonlinear residual. More... | |
void | setCurrentlyComputingResidual (bool currently_computing_residual) final |
Set whether or not the problem is in the process of computing the residual. More... | |
void | numGridSteps (unsigned int num_grid_steps) |
Set the number of steps in a grid sequences. More... | |
void | uniformRefine () |
uniformly refine the problem mesh(es). More... | |
void | automaticScaling (bool automatic_scaling) override |
Automatic scaling setter. More... | |
virtual void | automaticScaling (bool automatic_scaling) |
Automatic scaling setter. More... | |
bool | automaticScaling () const |
Automatic scaling getter. More... | |
bool | automaticScaling () const |
Automatic scaling getter. 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) override |
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) override |
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... | |
bool | fvBCsIntegrityCheck () const |
void | fvBCsIntegrityCheck (bool fv_bcs_integrity_check) |
void | getFVMatsAndDependencies (SubdomainID block_id, std::vector< std::shared_ptr< MaterialBase >> &face_materials, std::vector< std::shared_ptr< MaterialBase >> &neighbor_materials, std::set< MooseVariableFieldBase *> &variables, const THREAD_ID tid) |
Get the materials and variables potentially needed for FV. More... | |
void | resizeMaterialData (Moose::MaterialDataType data_type, unsigned int nqp, const THREAD_ID tid) |
Resize material data. More... | |
bool | haveDisplaced () const override final |
Whether we have a displaced problem in our simulation. More... | |
bool | hasLinearConvergenceObjects () const |
Whether we have linear convergence objects. More... | |
void | setNonlinearConvergenceNames (const std::vector< ConvergenceName > &convergence_names) |
Sets the nonlinear convergence object name(s) if there is one. More... | |
void | setLinearConvergenceNames (const std::vector< ConvergenceName > &convergence_names) |
Sets the linear convergence object name(s) if there is one. More... | |
void | setMultiAppFixedPointConvergenceName (const ConvergenceName &convergence_name) |
Sets the MultiApp fixed point convergence object name if there is one. More... | |
const std::vector< ConvergenceName > & | getNonlinearConvergenceNames () const |
Gets the nonlinear system convergence object name(s). More... | |
const std::vector< ConvergenceName > & | getLinearConvergenceNames () const |
Gets the linear convergence object name(s). More... | |
const ConvergenceName & | getMultiAppFixedPointConvergenceName () const |
Gets the MultiApp fixed point convergence object name. More... | |
void | computingScalingJacobian (bool computing_scaling_jacobian) |
Setter for whether we're computing the scaling jacobian. More... | |
bool | computingScalingJacobian () const override final |
Getter for whether we're computing the scaling jacobian. More... | |
void | computingScalingResidual (bool computing_scaling_residual) |
Setter for whether we're computing the scaling residual. More... | |
bool | computingScalingResidual () const override final |
MooseAppCoordTransform & | coordTransform () |
virtual std::size_t | numNonlinearSystems () const override |
virtual std::size_t | numLinearSystems () const override |
virtual std::size_t | numSolverSystems () const override |
bool | isSolverSystemNonlinear (const unsigned int sys_num) |
Check if the solver system is nonlinear. More... | |
virtual unsigned int | currentNlSysNum () const override |
virtual unsigned int | currentLinearSysNum () const override |
virtual unsigned int | nlSysNum (const NonlinearSystemName &nl_sys_name) const override |
unsigned int | linearSysNum (const LinearSystemName &linear_sys_name) const override |
unsigned int | solverSysNum (const SolverSystemName &solver_sys_name) const override |
unsigned int | systemNumForVariable (const VariableName &variable_name) const |
bool | getFailNextNonlinearConvergenceCheck () const |
Whether it will skip further residual evaluations and fail the next nonlinear convergence check(s) More... | |
bool | getFailNextSystemConvergenceCheck () const |
Whether it will fail the next system convergence check(s), triggering failed step behavior. More... | |
void | setFailNextNonlinearConvergenceCheck () |
Skip further residual evaluations and fail the next nonlinear convergence check(s) More... | |
void | setFailNextSystemConvergenceCheck () |
Tell the problem that the system(s) cannot be considered converged next time convergence is checked. More... | |
void | resetFailNextNonlinearConvergenceCheck () |
Tell the problem that the nonlinear convergence check(s) may proceed as normal. More... | |
void | resetFailNextSystemConvergenceCheck () |
Tell the problem that the system convergence check(s) may proceed as normal. More... | |
void | setExecutionPrinting (const ExecFlagEnum &print_exec) |
bool | shouldPrintExecution (const THREAD_ID tid) const |
Check whether the problem should output execution orders at this time. More... | |
void | reinitMortarUserObjects (BoundaryID primary_boundary_id, BoundaryID secondary_boundary_id, bool displaced) |
Call reinit on mortar user objects with matching primary boundary ID, secondary boundary ID, and displacement characteristics. More... | |
virtual const std::vector< VectorTag > & | currentResidualVectorTags () const override |
Return the residual vector tags we are currently computing. More... | |
void | setCurrentResidualVectorTags (const std::set< TagID > &vector_tags) |
Set the current residual vector tag data structure based on the passed in tag IDs. More... | |
void | clearCurrentResidualVectorTags () |
Clear the current residual vector tag data structure. More... | |
void | clearCurrentJacobianMatrixTags () |
Clear the current Jacobian matrix tag data structure ... 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... | |
bool | identifyVariableGroupsInNL () const |
Whether to identify variable groups in nonlinear systems. More... | |
virtual void | setCurrentLowerDElem (const Elem *const lower_d_elem, const THREAD_ID tid) override |
Set the current lower dimensional element. More... | |
virtual void | setCurrentBoundaryID (BoundaryID bid, const THREAD_ID tid) override |
sets the current boundary ID in assembly More... | |
const std::vector< NonlinearSystemName > & | getNonlinearSystemNames () const |
const std::vector< LinearSystemName > & | getLinearSystemNames () const |
const std::vector< SolverSystemName > & | getSolverSystemNames () const |
virtual const libMesh::CouplingMatrix & | nonlocalCouplingMatrix (const unsigned i) const override |
virtual bool | checkNonlocalCouplingRequirement () const override |
virtual Moose::FEBackend | feBackend () const |
const bool & | currentlyComputingResidual () const |
Returns true if the problem is in the process of computing the residual. More... | |
const bool & | currentlyComputingResidual () const |
Returns true if the problem is in the process of computing the residual. More... | |
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... | |
virtual TagID | addVectorTag (const TagName &tag_name, const Moose::VectorTagType type=Moose::VECTOR_TAG_RESIDUAL) |
Create a Tag. 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... | |
virtual const VectorTag & | getVectorTag (const TagID tag_id) const |
Get a VectorTag from a TagID. More... | |
std::vector< VectorTag > | getVectorTags (const std::set< TagID > &tag_ids) const |
virtual const std::vector< VectorTag > & | getVectorTags (const Moose::VectorTagType type=Moose::VECTOR_TAG_ANY) const |
Return all vector tags, where a tag is represented by a map from name to ID. More... | |
virtual TagID | getVectorTagID (const TagName &tag_name) const |
Get a TagID from a TagName. More... | |
virtual TagName | vectorTagName (const TagID tag) const |
Retrieve the name associated with a TagID. More... | |
virtual bool | vectorTagExists (const TagID tag_id) const |
Check to see if a particular Tag exists. More... | |
virtual bool | vectorTagExists (const TagName &tag_name) const |
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 |
The total number of tags, which can be limited to the tag type. More... | |
virtual Moose::VectorTagType | vectorTagType (const TagID tag_id) const |
virtual TagID | addMatrixTag (TagName tag_name) |
Create a Tag. More... | |
virtual TagID | getMatrixTagID (const TagName &tag_name) const |
Get a TagID from a TagName. More... | |
virtual TagName | matrixTagName (TagID tag) |
Retrieve the name associated with a TagID. More... | |
virtual bool | matrixTagExists (const TagName &tag_name) const |
Check to see if a particular Tag exists. More... | |
virtual bool | matrixTagExists (TagID tag_id) const |
Check to see if a particular Tag exists. More... | |
virtual unsigned int | numMatrixTags () const |
The total number of tags. More... | |
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 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... | |
Moose::CoordinateSystemType | getCoordSystem (SubdomainID sid) const |
unsigned int | getAxisymmetricRadialCoord () const |
Returns the desired radial direction for RZ coordinate transformation. More... | |
virtual DiracKernelInfo & | diracKernelInfo () |
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... | |
virtual std::set< dof_id_type > & | ghostedElems () |
Return the list of elements that should have their DoFs ghosted to this processor. 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... | |
virtual bool | safeAccessTaggedMatrices () const |
Is it safe to access the tagged matrices. More... | |
virtual bool | safeAccessTaggedVectors () const |
Is it safe to access the tagged vectors. More... | |
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 |
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... | |
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... | |
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... | |
template<typename T > | |
void | addGroupVariables (const std::set< T > &group_vars) |
Add a set of variables that need to be grouped together. More... | |
const libMesh::ConstElemRange & | getEvaluableElementRange () |
In general, {evaluable elements} >= {local elements} U {algebraic ghosting elements}. More... | |
const libMesh::ConstElemRange & | getNonlinearEvaluableElementRange () |
const libMesh::ConstElemRange & | getCurrentAlgebraicElementRange () |
These are the element and nodes that contribute to the jacobian and residual for this local processor. More... | |
const libMesh::ConstNodeRange & | getCurrentAlgebraicNodeRange () |
const ConstBndNodeRange & | getCurrentAlgebraicBndNodeRange () |
void | setCurrentAlgebraicElementRange (libMesh::ConstElemRange *range) |
These functions allow setting custom ranges for the algebraic elements, nodes, and boundary nodes that contribute to the jacobian and residual for this local processor. More... | |
void | setCurrentAlgebraicNodeRange (libMesh::ConstNodeRange *range) |
void | setCurrentAlgebraicBndNodeRange (ConstBndNodeRange *range) |
void | allowOutput (bool state) |
Ability to enable/disable all output calls. More... | |
template<typename T > | |
void | allowOutput (bool state) |
bool | hasMultiApps () const |
Returns whether or not the current simulation has any multiapps. More... | |
bool | hasMultiApps (ExecFlagType type) const |
bool | hasMultiApp (const std::string &name) const |
const AutomaticMortarGeneration & | getMortarInterface (const std::pair< BoundaryID, BoundaryID > &primary_secondary_boundary_pair, const std::pair< SubdomainID, SubdomainID > &primary_secondary_subdomain_pair, bool on_displaced) const |
Return the undisplaced or displaced mortar generation object associated with the provided boundaries and subdomains. More... | |
AutomaticMortarGeneration & | getMortarInterface (const std::pair< BoundaryID, BoundaryID > &primary_secondary_boundary_pair, const std::pair< SubdomainID, SubdomainID > &primary_secondary_subdomain_pair, bool on_displaced) |
const MaterialPropertyStorage & | getMaterialPropertyStorage () |
Return a reference to the material property storage. More... | |
const MaterialPropertyStorage & | getBndMaterialPropertyStorage () |
const MaterialPropertyStorage & | getNeighborMaterialPropertyStorage () |
const MooseObjectWarehouse< Indicator > & | getIndicatorWarehouse () |
Return indicator/marker storage. More... | |
const MooseObjectWarehouse< InternalSideIndicatorBase > & | getInternalSideIndicatorWarehouse () |
const MooseObjectWarehouse< Marker > & | getMarkerWarehouse () |
bool | needBoundaryMaterialOnSide (BoundaryID bnd_id, const THREAD_ID tid) |
These methods are used to determine whether stateful material properties need to be stored on internal sides. More... | |
bool | needInterfaceMaterialOnSide (BoundaryID bnd_id, const THREAD_ID tid) |
bool | needSubdomainMaterialOnSide (SubdomainID subdomain_id, const THREAD_ID tid) |
const ExecFlagType & | getCurrentExecuteOnFlag () const |
Return/set the current execution flag. More... | |
void | setCurrentExecuteOnFlag (const ExecFlagType &) |
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... | |
template<typename T > | |
static void | objectSetupHelper (const std::vector< T *> &objects, const ExecFlagType &exec_flag) |
Helpers for calling the necessary setup/execute functions for the supplied objects. More... | |
template<typename T > | |
static void | objectExecuteHelper (const std::vector< T *> &objects) |
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... | |
std::vector< Real > | _real_zero |
Convenience zeros. More... | |
std::vector< VariableValue > | _scalar_zero |
std::vector< VariableValue > | _zero |
std::vector< VariablePhiValue > | _phi_zero |
std::vector< MooseArray< ADReal > > | _ad_zero |
std::vector< VariableGradient > | _grad_zero |
std::vector< MooseArray< ADRealVectorValue > > | _ad_grad_zero |
std::vector< VariablePhiGradient > | _grad_phi_zero |
std::vector< VariableSecond > | _second_zero |
std::vector< MooseArray< ADRealTensorValue > > | _ad_second_zero |
std::vector< VariablePhiSecond > | _second_phi_zero |
std::vector< Point > | _point_zero |
std::vector< VectorVariableValue > | _vector_zero |
std::vector< VectorVariableCurl > | _vector_curl_zero |
Protected Member Functions | |
virtual void | meshChanged () |
Deprecated. More... | |
void | createTagVectors () |
Create extra tagged vectors and matrices. More... | |
void | createTagSolutions () |
Create extra tagged solution vectors. More... | |
virtual void | meshDisplaced () |
Update data after a mesh displaced. More... | |
void | computeSystems (const ExecFlagType &type) |
Do generic system computations. More... | |
bool | duplicateVariableCheck (const std::string &var_name, const libMesh::FEType &type, bool is_aux, const std::set< SubdomainID > *const active_subdomains) |
Helper to check for duplicate variable names across systems or within a single system. More... | |
void | computeUserObjectsInternal (const ExecFlagType &type, const Moose::AuxGroup &group, TheWarehouse::Query &query) |
void | checkDisplacementOrders () |
Verify that SECOND order mesh uses SECOND order displacements. More... | |
void | checkUserObjects () |
void | checkDependMaterialsHelper (const std::map< SubdomainID, std::vector< std::shared_ptr< MaterialBase >>> &materials_map) |
Helper method for checking Material object dependency. More... | |
void | checkCoordinateSystems () |
Verify that there are no element type/coordinate type conflicts. More... | |
void | reinitBecauseOfGhostingOrNewGeomObjects (bool mortar_changed=false) |
Call when it is possible that the needs for ghosted elements has changed. More... | |
void | addObjectParamsHelper (InputParameters ¶ms, const std::string &object_name, const std::string &var_param_name="variable") |
Helper for setting the "_subproblem" and "_sys" parameters in addObject() and in addUserObject(). More... | |
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 |
template<typename T , typename... Args> | |
T & | declareRestartableData (const std::string &data_name, Args &&... args) |
Declare a piece of data as "restartable" and initialize it. More... | |
template<typename T , typename... Args> | |
ManagedValue< T > | declareManagedRestartableDataWithContext (const std::string &data_name, void *context, Args &&... args) |
Declares a piece of "managed" restartable data and initialize it. More... | |
template<typename T , typename... Args> | |
const T & | getRestartableData (const std::string &data_name) const |
Declare a piece of data as "restartable" and initialize it Similar to declareRestartableData but returns a const reference to the object. More... | |
template<typename T , typename... Args> | |
T & | declareRestartableDataWithContext (const std::string &data_name, void *context, Args &&... args) |
Declare a piece of data as "restartable" and initialize it. More... | |
template<typename T , typename... Args> | |
T & | declareRecoverableData (const std::string &data_name, Args &&... args) |
Declare a piece of data as "recoverable" and initialize it. More... | |
template<typename T , typename... Args> | |
T & | declareRestartableDataWithObjectName (const std::string &data_name, const std::string &object_name, Args &&... args) |
Declare a piece of data as "restartable". More... | |
template<typename T , typename... Args> | |
T & | declareRestartableDataWithObjectNameWithContext (const std::string &data_name, const std::string &object_name, void *context, Args &&... args) |
Declare a piece of data as "restartable". More... | |
std::string | restartableName (const std::string &data_name) const |
Gets the name of a piece of restartable data given a data name, adding the system name and object name prefix. More... | |
Protected Attributes | |
bool | _use_nonlinear |
std::vector< std::shared_ptr< NonlinearSystem > > | _nl_sys |
MooseMesh & | _mesh |
bool | _initialized |
std::optional< std::vector< ConvergenceName > > | _nonlinear_convergence_names |
Nonlinear system(s) convergence name(s) More... | |
std::optional< std::vector< ConvergenceName > > | _linear_convergence_names |
Linear system(s) convergence name(s) (if any) More... | |
std::optional< ConvergenceName > | _multiapp_fixed_point_convergence_name |
MultiApp fixed point convergence name. More... | |
std::set< TagID > | _fe_vector_tags |
std::set< TagID > | _fe_matrix_tags |
std::set< TagID > | _linear_vector_tags |
Temporary storage for filtered vector tags for linear systems. More... | |
std::set< TagID > | _linear_matrix_tags |
Temporary storage for filtered matrix tags for linear systems. More... | |
const bool & | _solve |
Whether or not to actually solve the nonlinear system. More... | |
bool | _transient |
Real & | _time |
Real & | _time_old |
int & | _t_step |
Real & | _dt |
Real & | _dt_old |
bool | _need_to_add_default_nonlinear_convergence |
Flag that the problem needs to add the default nonlinear convergence. More... | |
bool | _need_to_add_default_multiapp_fixed_point_convergence |
Flag that the problem needs to add the default fixed point convergence. More... | |
const std::vector< LinearSystemName > | _linear_sys_names |
The linear system names. More... | |
const std::size_t | _num_linear_sys |
The number of linear systems. More... | |
std::vector< std::shared_ptr< LinearSystem > > | _linear_systems |
The vector of linear systems. More... | |
std::map< LinearSystemName, unsigned int > | _linear_sys_name_to_num |
Map from linear system name to number. More... | |
LinearSystem * | _current_linear_sys |
The current linear system that we are solving. More... | |
const bool | _using_default_nl |
Boolean to check if we have the default nonlinear system. More... | |
const std::vector< NonlinearSystemName > | _nl_sys_names |
The nonlinear system names. More... | |
const std::size_t | _num_nl_sys |
The number of nonlinear systems. More... | |
std::map< NonlinearSystemName, unsigned int > | _nl_sys_name_to_num |
Map from nonlinear system name to number. More... | |
NonlinearSystemBase * | _current_nl_sys |
The current nonlinear system that we are solving. More... | |
SolverSystem * | _current_solver_sys |
The current solver system. More... | |
std::vector< std::shared_ptr< SolverSystem > > | _solver_systems |
Combined container to base pointer of every solver system. More... | |
std::map< SolverVariableName, unsigned int > | _solver_var_to_sys_num |
Map connecting variable names with their respective solver systems. More... | |
std::map< SolverSystemName, unsigned int > | _solver_sys_name_to_num |
Map connecting solver system names with their respective systems. More... | |
std::vector< SolverSystemName > | _solver_sys_names |
The union of nonlinear and linear system names. More... | |
std::shared_ptr< AuxiliarySystem > | _aux |
The auxiliary system. More... | |
Moose::CouplingType | _coupling |
Type of variable coupling. More... | |
std::vector< std::unique_ptr< libMesh::CouplingMatrix > > | _cm |
Coupling matrix for variables. More... | |
std::map< std::string, unsigned int > | _subspace_dim |
Dimension of the subspace spanned by the vectors with a given prefix. More... | |
std::vector< std::vector< std::unique_ptr< Assembly > > > | _assembly |
The Assembly objects. More... | |
MooseObjectWarehouse< MeshDivision > | _mesh_divisions |
Warehouse to store mesh divisions NOTE: this could probably be moved to the MooseMesh instead of the Problem Time (and people's uses) will tell where this fits best. More... | |
MooseObjectWarehouse< Function > | _functions |
functions More... | |
MooseObjectWarehouse< Convergence > | _convergences |
convergence warehouse More... | |
MooseObjectWarehouse< KernelBase > | _nonlocal_kernels |
nonlocal kernels More... | |
MooseObjectWarehouse< IntegratedBCBase > | _nonlocal_integrated_bcs |
nonlocal integrated_bcs More... | |
MaterialPropertyRegistry | _material_prop_registry |
MaterialPropertyStorage & | _material_props |
MaterialPropertyStorage & | _bnd_material_props |
MaterialPropertyStorage & | _neighbor_material_props |
MooseObjectWarehouse< Marker > | _markers |
ReporterData | _reporter_data |
ExecuteMooseObjectWarehouse< UserObject > | _all_user_objects |
ExecuteMooseObjectWarehouse< MultiApp > | _multi_apps |
MultiApp Warehouse. More... | |
ExecuteMooseObjectWarehouse< TransientMultiApp > | _transient_multi_apps |
Storage for TransientMultiApps (only needed for calling 'computeDT') More... | |
ExecuteMooseObjectWarehouse< Transfer > | _transfers |
Normal Transfers. More... | |
ExecuteMooseObjectWarehouse< Transfer > | _to_multi_app_transfers |
Transfers executed just before MultiApps to transfer data to them. More... | |
ExecuteMooseObjectWarehouse< Transfer > | _from_multi_app_transfers |
Transfers executed just after MultiApps to transfer data from them. More... | |
ExecuteMooseObjectWarehouse< Transfer > | _between_multi_app_transfers |
Transfers executed just before MultiApps to transfer data between them. More... | |
std::map< std::string, std::unique_ptr< RandomData > > | _random_data_objects |
A map of objects that consume random numbers. More... | |
std::vector< std::unordered_map< SubdomainID, bool > > | _block_mat_side_cache |
Cache for calculating materials on side. More... | |
std::vector< std::unordered_map< BoundaryID, bool > > | _bnd_mat_side_cache |
Cache for calculating materials on side. More... | |
std::vector< std::unordered_map< BoundaryID, bool > > | _interface_mat_side_cache |
Cache for calculating materials on interface. More... | |
std::vector< MeshChangedInterface * > | _notify_when_mesh_changes |
Objects to be notified when the mesh changes. More... | |
std::vector< MeshDisplacedInterface * > | _notify_when_mesh_displaces |
Objects to be notified when the mesh displaces. More... | |
Adaptivity | _adaptivity |
unsigned int | _cycles_completed |
std::shared_ptr< XFEMInterface > | _xfem |
Pointer to XFEM controller. More... | |
MooseMesh * | _displaced_mesh |
std::shared_ptr< DisplacedProblem > | _displaced_problem |
GeometricSearchData | _geometric_search_data |
MortarData | _mortar_data |
bool | _reinit_displaced_elem |
Whether to call DisplacedProblem::reinitElem when this->reinitElem is called. More... | |
bool | _reinit_displaced_face |
Whether to call DisplacedProblem::reinitElemFace when this->reinitElemFace is called. More... | |
bool | _reinit_displaced_neighbor |
Whether to call DisplacedProblem::reinitNeighbor when this->reinitNeighbor is called. More... | |
bool | _input_file_saved |
whether input file has been written More... | |
bool | _has_dampers |
Whether or not this system has any Dampers associated with it. More... | |
bool | _has_constraints |
Whether or not this system has any Constraints. More... | |
bool | _snesmf_reuse_base |
If or not to resuse the base vector for matrix-free calculation. More... | |
bool | _skip_exception_check |
If or not skip 'exception and stop solve'. More... | |
bool | _snesmf_reuse_base_set_by_user |
If or not _snesmf_reuse_base is set by user. More... | |
bool | _has_initialized_stateful |
Whether nor not stateful materials have been initialized. More... | |
bool | _const_jacobian |
true if the Jacobian is constant More... | |
bool | _has_jacobian |
Indicates if the Jacobian was computed. More... | |
bool | _needs_old_newton_iter |
Indicates that we need to compute variable values for previous Newton iteration. More... | |
bool | _previous_nl_solution_required |
Indicates we need to save the previous NL iteration variable values. More... | |
bool | _has_nonlocal_coupling |
Indicates if nonlocal coupling is required/exists. More... | |
bool | _calculate_jacobian_in_uo |
std::vector< std::vector< const MooseVariableFEBase * > > | _uo_jacobian_moose_vars |
std::vector< unsigned char > | _has_active_material_properties |
Whether there are active material properties on each thread. More... | |
std::vector< SolverParams > | _solver_params |
CoverageCheckMode | _kernel_coverage_check |
Determines whether and which subdomains are to be checked to ensure that they have an active kernel. More... | |
std::vector< SubdomainName > | _kernel_coverage_blocks |
const bool | _boundary_restricted_node_integrity_check |
whether to perform checking of boundary restricted nodal object variable dependencies, e.g. More... | |
const bool | _boundary_restricted_elem_integrity_check |
whether to perform checking of boundary restricted elemental object variable dependencies, e.g. More... | |
CoverageCheckMode | _material_coverage_check |
Determines whether and which subdomains are to be checked to ensure that they have an active material. More... | |
std::vector< SubdomainName > | _material_coverage_blocks |
bool | _fv_bcs_integrity_check |
Whether to check overlapping Dirichlet and Flux BCs and/or multiple DirichletBCs per sideset. More... | |
const bool | _material_dependency_check |
Determines whether a check to verify material dependencies on every subdomain. More... | |
const bool | _uo_aux_state_check |
Whether or not checking the state of uo/aux evaluation. More... | |
unsigned int | _max_qps |
Maximum number of quadrature points used in the problem. More... | |
libMesh::Order | _max_scalar_order |
Maximum scalar variable order. More... | |
bool | _has_time_integrator |
Indicates whether or not this executioner has a time integrator (during setup) More... | |
bool | _has_exception |
Whether or not an exception has occurred. More... | |
bool | _parallel_barrier_messaging |
Whether or not information about how many transfers have completed is printed. More... | |
MooseEnum | _verbose_setup |
Whether or not to be verbose during setup. More... | |
bool | _verbose_multiapps |
Whether or not to be verbose with multiapps. More... | |
bool | _verbose_restore |
Whether or not to be verbose on solution restoration post a failed time step. More... | |
std::string | _exception_message |
The error message to go with an exception. More... | |
ExecFlagType | _current_execute_on_flag |
Current execute_on flag. More... | |
ExecuteMooseObjectWarehouse< Control > | _control_warehouse |
The control logic warehouse. More... | |
Moose::PetscSupport::PetscOptions | _petsc_options |
PETSc option storage. More... | |
PetscOptions | _petsc_option_data_base |
bool | _is_petsc_options_inserted |
If or not PETSc options have been added to database. More... | |
std::shared_ptr< LineSearch > | _line_search |
std::unique_ptr< libMesh::ConstElemRange > | _evaluable_local_elem_range |
std::unique_ptr< libMesh::ConstElemRange > | _nl_evaluable_local_elem_range |
std::unique_ptr< libMesh::ConstElemRange > | _aux_evaluable_local_elem_range |
std::unique_ptr< libMesh::ConstElemRange > | _current_algebraic_elem_range |
std::unique_ptr< libMesh::ConstNodeRange > | _current_algebraic_node_range |
std::unique_ptr< ConstBndNodeRange > | _current_algebraic_bnd_node_range |
bool | _using_ad_mat_props |
Automatic differentiaion (AD) flag which indicates whether any consumer has requested an AD material property or whether any suppier has declared an AD material property. More... | |
unsigned short | _current_ic_state |
const bool | _use_hash_table_matrix_assembly |
Whether to assemble matrices using hash tables instead of preallocating matrix memory. More... | |
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... | |
MooseApp & | _restartable_app |
Reference to the application. More... | |
const std::string | _restartable_system_name |
The system name this object is in. More... | |
const THREAD_ID | _restartable_tid |
The thread ID for this object. More... | |
const bool | _restartable_read_only |
Flag for toggling read only status (see ReporterData) More... | |
std::vector< std::vector< NonlinearVariableName > > | _group_variables |
Name of variables that are grouped together to check convergence. More... | |
bool | _use_group_variables |
True if any variables are grouped. More... | |
InitialConditionWarehouse | _ics |
FVInitialConditionWarehouse | _fv_ics |
ScalarInitialConditionWarehouse | _scalar_ics |
MaterialWarehouse | _materials |
MaterialWarehouse | _interface_materials |
MaterialWarehouse | _discrete_materials |
MaterialWarehouse | _all_materials |
MooseObjectWarehouse< Indicator > | _indicators |
MooseObjectWarehouse< InternalSideIndicatorBase > | _internal_side_indicators |
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 |
Problem that checks for convergence relative to a user-supplied reference quantity rather than the initial residual.
Definition at line 19 of file ReferenceResidualProblem.h.
|
inherited |
The parameter type this interface expects for a data file name.
Definition at line 27 of file DataFileInterface.h.
|
stronginherited |
Enumerator | |
---|---|
FALSE | |
TRUE | |
OFF | |
ON | |
SKIP_LIST | |
ONLY_LIST |
Definition at line 140 of file FEProblemBase.h.
ReferenceResidualProblem::ReferenceResidualProblem | ( | const InputParameters & | params | ) |
Definition at line 30 of file ReferenceResidualProblem.C.
|
inlineinherited |
For Internal Use.
Definition at line 32 of file Problem.h.
|
inherited |
Whether or not to accept the solution based on its invalidity.
If this returns false, it means that an invalid solution was encountered (an error) that was not allowed.
Definition at line 3785 of file FEProblemBase.C.
Referenced by SolverSystem::checkInvalidSolution(), and NonlinearSystem::converged().
|
inlineinherited |
Definition at line 1712 of file FEProblemBase.h.
Referenced by SteadyBase::execute(), Eigenvalue::execute(), FEProblemBase::initialAdaptMesh(), and FEProblemBase::initialSetup().
|
virtualinherited |
Reimplemented in DumpObjectsProblem.
Definition at line 7920 of file FEProblemBase.C.
Referenced by SteadyBase::execute(), Eigenvalue::execute(), and TransientBase::incrementStepOrReject().
|
inherited |
Add an algebraic ghosting functor to this problem's DofMaps.
Definition at line 1023 of file SubProblem.C.
|
virtualinherited |
Definition at line 3166 of file FEProblemBase.C.
|
virtualinherited |
Reimplemented in MFEMProblem.
Definition at line 3232 of file FEProblemBase.C.
|
virtualinherited |
Definition at line 3270 of file FEProblemBase.C.
|
virtualinherited |
Definition at line 3198 of file FEProblemBase.C.
|
virtualinherited |
Canonical method for adding an auxiliary variable.
var_type | the type of the variable, e.g. MooseVariableScalar |
var_name | the variable name, e.g. 'u' |
params | the InputParameters from which to construct the variable |
Reimplemented in MFEMProblem.
Definition at line 3095 of file FEProblemBase.C.
Referenced by AddElementalFieldAction::init(), and AddAuxVariableAction::init().
|
virtualinherited |
Definition at line 3126 of file FEProblemBase.C.
|
virtualinherited |
Reimplemented in MFEMProblem.
Definition at line 3024 of file FEProblemBase.C.
Referenced by DiffusionCG::addBoundaryConditionsFromComponents(), and DiffusionCG::addFEBCs().
Reimplemented from SubProblem.
Definition at line 1983 of file FEProblemBase.C.
Referenced by ComputeResidualAndJacobianThread::accumulate(), NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeResidualAndJacobianInternal(), NonlinearSystemBase::constraintJacobians(), NonlinearSystemBase::enforceNodalConstraintsJacobian(), ComputeNodalKernelBCJacobiansThread::onNode(), ComputeNodalKernelJacobiansThread::onNode(), and ComputeJacobianThread::postElement().
Reimplemented from SubProblem.
Definition at line 1869 of file FEProblemBase.C.
Referenced by ComputeResidualThread::accumulate(), ComputeResidualAndJacobianThread::accumulate(), NonlinearSystemBase::computeResidualAndJacobianInternal(), NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::constraintResiduals(), ComputeNodalKernelBcsThread::onNode(), and ComputeNodalKernelsThread::onNode().
|
virtualinherited |
Allows for all the residual contributions that are currently cached to be added directly into the vector passed in.
residual | The vector to add the cached contributions to. |
tid | The thread id. |
Definition at line 1877 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::constraintResiduals(), and NonlinearSystemBase::enforceNodalConstraintsResidual().
|
virtualinherited |
Definition at line 3042 of file FEProblemBase.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().
|
virtualinherited |
Adds a Convergence object.
Definition at line 2509 of file FEProblemBase.C.
Referenced by FEProblemBase::addDefaultMultiAppFixedPointConvergence(), addDefaultNonlinearConvergence(), and FEProblemBase::addDefaultNonlinearConvergence().
|
inherited |
Add a coupling functor to this problem's DofMaps.
Definition at line 1056 of file SubProblem.C.
|
virtualinherited |
Definition at line 5116 of file FEProblemBase.C.
|
inherited |
Adds the default fixed point Convergence associated with the problem.
This is called if the user does not supply 'multiapp_fixed_point_convergence'.
[in] | params | Parameters to apply to Convergence parameters |
Definition at line 2535 of file FEProblemBase.C.
|
overridevirtual |
Adds the default nonlinear Convergence associated with the problem.
This is called if the user does not supply 'nonlinear_convergence'.
[in] | params | Parameters to apply to Convergence parameters |
Reimplemented from FEProblemBase.
Definition at line 36 of file ReferenceResidualProblem.C.
|
virtualinherited |
Definition at line 3342 of file FEProblemBase.C.
|
virtualinherited |
Definition at line 3302 of file FEProblemBase.C.
|
virtualinherited |
Definition at line 7734 of file FEProblemBase.C.
|
virtualinherited |
The following functions will enable MOOSE to have the capability to import distributions.
Definition at line 2664 of file FEProblemBase.C.
|
virtualinherited |
Reimplemented in MFEMProblem.
Definition at line 2483 of file FEProblemBase.C.
Referenced by MFEMProblem::addFunction(), and FEProblemBase::getFunction().
|
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().
|
virtualinherited |
Reimplemented in MFEMProblem.
Definition at line 3792 of file FEProblemBase.C.
|
virtualinherited |
Definition at line 3396 of file FEProblemBase.C.
Referenced by DiffusionFV::addFVBCs().
|
virtualinherited |
Add an initial condition for a finite volume variables.
ic_name | The name of the boundary condition object |
name | The user-defined name from the input file |
parameters | The input parameters for construction |
Definition at line 3565 of file FEProblemBase.C.
|
virtualinherited |
We assume that variable1 and variable2 can live on different systems, in this case the user needs to create two interface kernels with flipped variables and parameters
Definition at line 3404 of file FEProblemBase.C.
|
virtualinherited |
Definition at line 3382 of file FEProblemBase.C.
Referenced by DiffusionFV::addFVKernels().
|
overridevirtualinherited |
Will make sure that all necessary elements from boundary_id are ghosted to this processor.
Implements SubProblem.
Definition at line 2079 of file FEProblemBase.C.
Referenced by DisplacedProblem::addGhostedBoundary().
|
overridevirtualinherited |
Will make sure that all dofs connected to elem_id are ghosted to this processor.
Implements SubProblem.
Definition at line 2072 of file FEProblemBase.C.
Referenced by DisplacedProblem::addGhostedElem(), and NodalPatchRecovery::NodalPatchRecovery().
|
inherited |
Add a set of variables that need to be grouped together.
For use in actions that create variables. This is templated for backwards compatibility to allow passing in std::string or NonlinearVariableName.
T | string type used for variable names |
group_vars | A set of solution variables that need to be grouped. |
Definition at line 48 of file ReferenceResidualInterface.h.
|
virtualinherited |
Definition at line 2938 of file FEProblemBase.C.
|
virtualinherited |
Definition at line 5147 of file FEProblemBase.C.
|
virtualinherited |
Reimplemented in MFEMProblem.
Definition at line 3505 of file FEProblemBase.C.
Referenced by DiffusionPhysicsBase::addInitialConditions(), and DiffusionPhysicsBase::addInitialConditionsFromComponents().
|
virtualinherited |
Definition at line 3433 of file FEProblemBase.C.
|
virtualinherited |
Definition at line 3830 of file FEProblemBase.C.
Implements SubProblem.
Definition at line 1916 of file FEProblemBase.C.
Referenced by ComputeDiracThread::postElement().
|
virtualinherited |
Definition at line 1991 of file FEProblemBase.C.
Referenced by ComputeJacobianBlocksThread::postElement().
Implements SubProblem.
Definition at line 1946 of file FEProblemBase.C.
Referenced by ComputeResidualAndJacobianThread::accumulateLower(), and ComputeJacobianThread::accumulateLower().
|
pure virtualinherited |
Implemented in DisplacedProblem.
Implements SubProblem.
Definition at line 1930 of file FEProblemBase.C.
Referenced by ComputeResidualAndJacobianThread::accumulateNeighbor(), ComputeJacobianThread::accumulateNeighbor(), and ComputeJacobianBlocksThread::postInternalSide().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 1938 of file FEProblemBase.C.
Referenced by ComputeResidualAndJacobianThread::accumulateNeighborLower(), and ComputeJacobianThread::accumulateNeighborLower().
|
virtualinherited |
Definition at line 1960 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::computeScalarKernelsJacobians().
Definition at line 1954 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::computeScalarKernelsJacobians().
|
virtualinherited |
Reimplemented in MFEMProblem.
Definition at line 2922 of file FEProblemBase.C.
Referenced by DiffusionCG::addFEKernels().
|
virtualinherited |
Definition at line 3423 of file FEProblemBase.C.
|
virtualinherited |
Definition at line 3415 of file FEProblemBase.C.
|
overridevirtualinherited |
add a MOOSE line search
Reimplemented from FEProblemBase.
Definition at line 129 of file FEProblem.C.
|
virtualinherited |
Definition at line 5190 of file FEProblemBase.C.
|
virtualinherited |
Reimplemented in MFEMProblem.
Definition at line 3822 of file FEProblemBase.C.
Referenced by ComponentMaterialPropertyInterface::addMaterials().
|
virtualinherited |
Definition at line 3838 of file FEProblemBase.C.
Referenced by FEProblemBase::addInterfaceMaterial(), and FEProblemBase::addMaterial().
|
virtualinherited |
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 in DisplacedProblem.
Definition at line 311 of file SubProblem.C.
Referenced by DisplacedProblem::addMatrixTag(), FEProblemBase::createTagVectors(), LinearSystem::LinearSystem(), and NonlinearSystemBase::NonlinearSystemBase().
|
virtualinherited |
Add a MeshDivision.
Definition at line 2619 of file FEProblemBase.C.
|
virtualinherited |
Add a MultiApp to the problem.
Definition at line 5227 of file FEProblemBase.C.
|
virtualinherited |
Definition at line 2954 of file FEProblemBase.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 |
Method for creating and adding an object to the warehouse.
T | The base object type (registered in the Factory) |
type | String type of the object (registered in the Factory) |
name | Name for the object to be created |
parameters | InputParameters for the object |
threaded | Whether or not to create n_threads copies of the object |
var_param_name | The name of the parameter on the object which holds the primary variable. |
Definition at line 3109 of file FEProblemBase.h.
|
protectedinherited |
Helper for setting the "_subproblem" and "_sys" parameters in addObject() and in addUserObject().
This is needed due to header includes/forward declaration issues
Definition at line 4180 of file FEProblemBase.C.
Referenced by FEProblemBase::addObject(), and FEProblemBase::addUserObject().
|
inherited |
Adds an Output object.
Definition at line 8772 of file FEProblemBase.C.
|
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().
|
virtualinherited |
Reimplemented in MFEMProblem.
Definition at line 4224 of file FEProblemBase.C.
Referenced by MFEMProblem::addPostprocessor(), and DiffusionPhysicsBase::addPostprocessors().
|
virtualinherited |
Definition at line 6757 of file FEProblemBase.C.
Referenced by AB2PredictorCorrector::AB2PredictorCorrector().
|
virtualinherited |
Add a Reporter object to the simulation.
type | C++ object type to construct |
name | A uniquely identifying object name |
parameters | Complete parameters for the object to be created. |
For an example use, refer to AddReporterAction.C/h
Definition at line 4252 of file FEProblemBase.C.
Referenced by MultiAppGeneralFieldTransfer::MultiAppGeneralFieldTransfer().
Implements SubProblem.
Definition at line 1816 of file FEProblemBase.C.
Referenced by ComputeDiracThread::postElement().
Implements SubProblem.
Definition at line 1836 of file FEProblemBase.C.
Referenced by ComputeResidualThread::accumulateLower(), ComputeResidualAndJacobianThread::accumulateLower(), ComputeResidualThread::accumulateNeighborLower(), and ComputeResidualAndJacobianThread::accumulateNeighborLower().
Implements SubProblem.
Definition at line 1826 of file FEProblemBase.C.
Referenced by ComputeResidualThread::accumulateNeighbor(), ComputeResidualAndJacobianThread::accumulateNeighbor(), ComputeResidualThread::accumulateNeighborLower(), and ComputeResidualAndJacobianThread::accumulateNeighborLower().
Definition at line 1846 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::computeResidualInternal().
|
virtualinherited |
The following functions will enable MOOSE to have the capability to import Samplers.
Definition at line 2687 of file FEProblemBase.C.
|
virtualinherited |
Definition at line 2987 of file FEProblemBase.C.
|
virtualinherited |
Definition at line 6722 of file FEProblemBase.C.
Referenced by TransientBase::setupTimeIntegrator().
|
virtualinherited |
Add a Transfer to the problem.
Reimplemented in MFEMProblem.
Definition at line 5574 of file FEProblemBase.C.
Referenced by MFEMProblem::addTransfer().
|
virtualinherited |
Definition at line 4265 of file FEProblemBase.C.
Referenced by MFEMProblem::addAuxKernel(), MFEMProblem::addBoundaryCondition(), MFEMProblem::addFESpace(), MFEMProblem::addFunctorMaterial(), MFEMProblem::addGridFunction(), MFEMProblem::addInitialCondition(), MFEMProblem::addKernel(), MFEMProblem::addMFEMPreconditioner(), MFEMProblem::addMFEMSolver(), FEProblemBase::addPostprocessor(), FEProblemBase::addReporter(), MFEMProblem::addSubMesh(), MFEMProblem::addTransfer(), and FEProblemBase::addVectorPostprocessor().
|
virtualinherited |
Canonical method for adding a non-linear variable.
var_type | the type of the variable, e.g. MooseVariableScalar |
var_name | the variable name, e.g. 'u' |
params | the InputParameters from which to construct the variable |
Reimplemented in MFEMProblem.
Definition at line 2827 of file FEProblemBase.C.
Referenced by MFEMProblem::addGridFunction(), DiffusionFV::addSolverVariables(), DiffusionCG::addSolverVariables(), and AddVariableAction::init().
|
virtualinherited |
Definition at line 4238 of file FEProblemBase.C.
Referenced by ExtraIDIntegralReporter::ExtraIDIntegralReporter().
|
virtualinherited |
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 in DisplacedProblem.
Definition at line 92 of file SubProblem.C.
Referenced by DisplacedProblem::addVectorTag(), SecantSolve::allocateStorage(), SteffensenSolve::allocateStorage(), PicardSolve::allocateStorage(), FEProblemBase::createTagSolutions(), FEProblemBase::createTagVectors(), NonlinearSystemBase::getResidualNonTimeVector(), NonlinearSystemBase::getResidualTimeVector(), LinearSystem::LinearSystem(), SystemBase::needSolutionState(), and NonlinearSystemBase::NonlinearSystemBase().
|
inlineinherited |
Deprecated method; use finishMultiAppStep and/or incrementMultiAppTStep depending on your purpose.
Definition at line 1304 of file FEProblemBase.h.
|
virtualinherited |
Advance all of the state holding vectors / datastructures so that we can move to the next timestep.
Reimplemented in DumpObjectsProblem.
Definition at line 6576 of file FEProblemBase.C.
Referenced by MFEMSteady::execute(), SteadyBase::execute(), Eigenvalue::execute(), TransientBase::incrementStepOrReject(), NonlinearEigen::init(), TransientMultiApp::setupApp(), ExplicitTVDRK2::solve(), ExplicitRK2::solve(), TransientMultiApp::solveStep(), NonlinearEigen::takeStep(), and InversePowerMethod::takeStep().
|
inlineinherited |
Whether to accept / allow an invalid solution.
Definition at line 1963 of file FEProblemBase.h.
Referenced by FEProblemBase::acceptInvalidSolution().
|
inherited |
Ability to enable/disable all output calls.
This is needed by Multiapps and applications to disable output for cases when executioners call other executions and when Multiapps are sub cycling.
Definition at line 6668 of file FEProblemBase.C.
Referenced by TransientMultiApp::resetApp(), and TransientMultiApp::solveStep().
|
inherited |
Definition at line 3060 of file FEProblemBase.h.
|
inherited |
Definition at line 6122 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::constraintJacobians().
|
inlineoverridevirtualinherited |
Implements SubProblem.
Definition at line 3208 of file FEProblemBase.h.
Referenced by ArrayNodalBC::computeJacobian(), VectorNodalBC::computeJacobian(), NodalBC::computeJacobian(), NonlinearSystemBase::computeJacobianInternal(), FEProblemBase::computeJacobianTags(), NonlinearSystemBase::computeNodalBCsResidualAndJacobian(), ArrayNodalBC::computeOffDiagJacobian(), VectorNodalBC::computeOffDiagJacobian(), NodalBC::computeOffDiagJacobian(), FEProblemBase::computeResidualAndJacobian(), NonlinearSystemBase::constraintJacobians(), FEProblemBase::initialSetup(), ComputeBoundaryInitialConditionThread::onNode(), MaxQpsThread::operator()(), ComputeJacobianThread::postElement(), and FEProblemBase::reinitScalars().
|
inlineoverridevirtualinherited |
Implements SubProblem.
Definition at line 3217 of file FEProblemBase.h.
|
inherited |
Automatic scaling getter.
Definition at line 1156 of file SubProblem.C.
Referenced by FEProblemBase::automaticScaling(), and DisplacedProblem::DisplacedProblem().
|
inherited |
Automatic scaling setter.
automatic_scaling | A boolean representing whether we are performing automatic scaling |
Definition at line 1149 of file SubProblem.C.
|
inherited |
Automatic scaling getter.
Definition at line 1156 of file SubProblem.C.
|
overridevirtualinherited |
Automatic scaling setter.
automatic_scaling | A boolean representing whether we are performing automatic scaling |
Reimplemented from SubProblem.
Definition at line 8955 of file FEProblemBase.C.
Referenced by DisplacedProblem::DisplacedProblem(), and FEProblemSolve::FEProblemSolve().
|
inherited |
Backup the MultiApps associated with the ExecFlagType.
Definition at line 5495 of file FEProblemBase.C.
Referenced by FEProblemBase::initialSetup(), and FixedPointSolve::solve().
|
inherited |
Definition at line 5979 of file FEProblemBase.C.
|
inherited |
Increases the element/volume quadrature order for the specified mesh block if and only if the current volume quadrature order is lower.
This can only cause the quadrature level to increase. If volume_order is lower than or equal to the current volume/elem quadrature rule order, then nothing is done (i.e. this function is idempotent).
Definition at line 5966 of file FEProblemBase.C.
Reimplemented from SubProblem.
Definition at line 1967 of file FEProblemBase.C.
Referenced by ComputeResidualAndJacobianThread::accumulate(), NonlinearSystemBase::constraintJacobians(), and ComputeJacobianThread::postElement().
Reimplemented from SubProblem.
Definition at line 1975 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::constraintJacobians().
Reimplemented from SubProblem.
Definition at line 1853 of file FEProblemBase.C.
Referenced by ComputeResidualThread::accumulate(), ComputeResidualAndJacobianThread::accumulate(), and NonlinearSystemBase::constraintResiduals().
Reimplemented from SubProblem.
Definition at line 1861 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::constraintResiduals().
|
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().
|
protectedinherited |
Verify that there are no element type/coordinate type conflicts.
Definition at line 8584 of file FEProblemBase.C.
Referenced by FEProblemBase::checkProblemIntegrity().
|
protectedinherited |
Helper method for checking Material object dependency.
These two sets are used to make sure that all dependent props on a block are actually supplied
Definition at line 8459 of file FEProblemBase.C.
Referenced by FEProblemBase::checkProblemIntegrity().
|
protectedinherited |
Verify that SECOND order mesh uses SECOND order displacements.
Definition at line 8383 of file FEProblemBase.C.
Referenced by FEProblemBase::checkProblemIntegrity().
|
inherited |
Definition at line 1468 of file FEProblemBase.C.
Referenced by FEProblemBase::checkProblemIntegrity().
|
virtualinherited |
Check to see if an exception has occurred on any processor and, if possible, force the solve to fail, which will result in the time step being cut.
Notes:
print_message | whether to print a message with exception information |
Definition at line 6404 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::computeJacobianInternal(), FEProblemBase::handleException(), and DisplacedProblem::updateMesh().
|
inlineinherited |
Return a flag to indicate whether we are executing user objects and auxliary kernels for state check Note: This function can return true only when hasUOAuxStateCheck() returns true, i.e.
the check has been activated by users through Problem/check_uo_aux_state input parameter.
Definition at line 197 of file FEProblemBase.h.
Referenced by MemoryUsage::execute(), VectorMemoryUsage::execute(), PerfGraphData::finalize(), MemoryUsage::finalize(), and VectorMemoryUsage::finalize().
|
inherited |
Definition at line 1593 of file FEProblemBase.C.
Referenced by FEProblemBase::initialSetup().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 9370 of file FEProblemBase.C.
Referenced by DisplacedProblem::checkNonlocalCouplingRequirement(), ComputeJacobianThread::compute(), ComputeFullJacobianThread::computeOnBoundary(), and ComputeFullJacobianThread::computeOnElement().
|
virtualinherited |
Method called to perform a series of sanity checks before a simulation is run.
This method doesn't return when errors are found, instead it generally calls mooseError() directly.
If a material is specified for any block in the simulation, then all blocks must have a material specified.
unsigned int is necessary to print SubdomainIDs in the statement below
vector is necessary to get the subdomain names
Reimplemented in EigenProblem.
Definition at line 8217 of file FEProblemBase.C.
Referenced by EigenProblem::checkProblemIntegrity().
Definition at line 1631 of file FEProblemBase.C.
Referenced by FEProblemBase::initialSetup().
|
protectedinherited |
Definition at line 8424 of file FEProblemBase.C.
Referenced by FEProblemBase::checkProblemIntegrity().
|
overridevirtualinherited |
Clear the active elemental MooseVariableFEBase.
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 MooseVariableFEBases
tid | The thread id |
Reimplemented from SubProblem.
Definition at line 5808 of file FEProblemBase.C.
Referenced by ComputeMaterialsObjectThread::post(), ComputeMarkerThread::post(), ComputeDiracThread::post(), ComputeIndicatorThread::post(), and ComputeUserObjectsThread::post().
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 5817 of file FEProblemBase.C.
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 5826 of file FEProblemBase.C.
Clear the active material properties.
Should be called at the end of every computing thread
tid | The thread id |
Definition at line 5874 of file FEProblemBase.C.
Referenced by NodalPatchRecovery::compute(), ComputeDiracThread::post(), ComputeIndicatorThread::post(), and ComputeUserObjectsThread::post().
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 5835 of file FEProblemBase.C.
Referenced by AuxiliarySystem::clearScalarVariableCoupleableTags().
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 5844 of file FEProblemBase.C.
Referenced by AuxiliarySystem::clearScalarVariableCoupleableTags().
|
inherited |
Clear dof indices from variables in nl and aux systems.
Definition at line 1171 of file SubProblem.C.
Referenced by FEProblemBase::solve().
|
inlineinherited |
Clear the current Jacobian matrix tag data structure ...
if someone creates it
Definition at line 2433 of file FEProblemBase.h.
Referenced by FEProblemBase::resetState().
|
inlineinherited |
Clear the current residual vector tag data structure.
Definition at line 3254 of file FEProblemBase.h.
Referenced by CrankNicolson::init(), and FEProblemBase::resetState().
|
overridevirtualinherited |
Gets called before Dirac Kernels are asked to add the points they are supposed to be evaluated in.
Implements SubProblem.
Definition at line 2453 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::computeDiracContributions().
|
virtualinherited |
Definition at line 7408 of file FEProblemBase.C.
Referenced by Moose::compute_bounds().
|
virtualinherited |
Definition at line 7687 of file FEProblemBase.C.
Referenced by FEProblemBase::computePostCheck().
|
virtualinherited |
Reimplemented in DumpObjectsProblem.
Definition at line 4457 of file FEProblemBase.C.
Referenced by FEProblemBase::computeIndicatorsAndMarkers(), TransientBase::endStep(), MFEMSteady::execute(), SteadyBase::execute(), Eigenvalue::execute(), and FEProblemBase::initialAdaptMesh().
|
virtualinherited |
Definition at line 4450 of file FEProblemBase.C.
|
virtualinherited |
Form a Jacobian matrix with the default tag (system).
Definition at line 7243 of file FEProblemBase.C.
Referenced by FEProblemBase::computeJacobianSys().
|
virtualinherited |
Really not a good idea to use this.
It computes just one block of the Jacobian into a smaller matrix. Calling this in a loop is EXTREMELY ineffecient! Try to use computeJacobianBlocks() instead!
jacobian | The matrix you want to fill |
precond_system | The libMesh::system of the preconditioning system |
ivar | the block-row of the Jacobian |
jvar | the block-column of the Jacobian |
Definition at line 7396 of file FEProblemBase.C.
|
virtualinherited |
Computes several Jacobian blocks simultaneously, summing their contributions into smaller preconditioning matrices.
Used by Physics-based preconditioning
blocks | The blocks to fill in (JacobianBlock is defined in ComputeJacobianBlocksThread) |
Reimplemented in EigenProblem.
Definition at line 7376 of file FEProblemBase.C.
Referenced by FEProblemBase::computeJacobianBlock(), and PhysicsBasedPreconditioner::setup().
|
virtualinherited |
Form a Jacobian matrix for multiple tags.
It should not be called directly by users.
Definition at line 7259 of file FEProblemBase.C.
Referenced by FEProblemBase::computeJacobian().
|
virtualinherited |
Form a Jacobian matrix.
It is called by Libmesh.
Definition at line 7221 of file FEProblemBase.C.
Referenced by Moose::compute_jacobian(), and NonlinearSystem::computeScalingJacobian().
|
virtualinherited |
Form a Jacobian matrix for a given tag.
Definition at line 7229 of file FEProblemBase.C.
Referenced by ActuallyExplicitEuler::solve(), and ExplicitSSPRungeKutta::solveStage().
Form multiple matrices, and each is associated with a tag.
Definition at line 7275 of file FEProblemBase.C.
Referenced by EigenProblem::computeJacobianAB(), FEProblemBase::computeJacobianInternal(), EigenProblem::computeJacobianTag(), FEProblemBase::computeJacobianTag(), and EigenProblem::computeMatricesTags().
|
virtualinherited |
Assemble both the right hand side and the system matrix of a given linear system.
sys | The linear system which should be assembled |
system_matrix | The sparse matrix which should hold the system matrix |
rhs | The vector which should hold the right hand side |
compute_gradients | A flag to disable the computation of new gradients during the assembly, can be used to lag gradients |
Definition at line 7452 of file FEProblemBase.C.
Referenced by Moose::compute_linear_system(), and FEProblemBase::computeResidualL2Norm().
|
inherited |
Assemble the current linear system given a set of vector and matrix tags.
soln | The solution which should be used for the system assembly |
vector_tags | The vector tags for the right hand side |
matrix_tags | The matrix tags for the matrix |
compute_gradients | A flag to disable the computation of new gradients during the assembly, can be used to lag gradients |
Definition at line 7489 of file FEProblemBase.C.
Referenced by FEProblemBase::computeLinearSystemSys().
|
virtualinherited |
Reimplemented in DumpObjectsProblem.
Definition at line 4499 of file FEProblemBase.C.
Referenced by FEProblemBase::adaptMesh(), FEProblemBase::computeIndicatorsAndMarkers(), TransientBase::endStep(), MFEMSteady::execute(), SteadyBase::execute(), Eigenvalue::execute(), and FEProblemBase::initialAdaptMesh().
|
inherited |
Find the smallest timestep over all MultiApps.
Definition at line 5547 of file FEProblemBase.C.
Referenced by TransientBase::constrainDTFromMultiApp().
|
virtualinherited |
Definition at line 7557 of file FEProblemBase.C.
Referenced by Moose::compute_nearnullspace().
|
virtualinherited |
Definition at line 7574 of file FEProblemBase.C.
Referenced by Moose::compute_nullspace().
|
virtualinherited |
Definition at line 7604 of file FEProblemBase.C.
Referenced by Moose::compute_postcheck().
|
inherited |
This function is called by Libmesh to form a residual.
This is deprecated. We should remove this as soon as RattleSnake is fixed.
Referenced by FEProblemBase::computeResidualL2Norm(), FEProblemBase::computeResidualSys(), ActuallyExplicitEuler::solve(), and ExplicitSSPRungeKutta::solveStage().
|
virtualinherited |
Form a residual with default tags (nontime, time, residual).
|
inherited |
Form a residual and Jacobian with default tags.
Definition at line 6866 of file FEProblemBase.C.
Referenced by ComputeResidualAndJacobian::residual_and_jacobian().
|
virtualinherited |
Form a residual vector for a set of tags.
It should not be called directly by users.
Definition at line 7025 of file FEProblemBase.C.
|
inherited |
Computes the residual of a nonlinear system using whatever is sitting in the current solution vector then returns the L2 norm.
Definition at line 6775 of file FEProblemBase.C.
Referenced by DefaultMultiAppFixedPointConvergence::checkConvergence(), Residual::getValue(), DefaultMultiAppFixedPointConvergence::initialize(), and DefaultMultiAppFixedPointConvergence::preExecute().
|
inherited |
Computes the residual of a linear system using whatever is sitting in the current solution vector then returns the L2 norm.
Definition at line 6783 of file FEProblemBase.C.
|
virtualinherited |
Computes the residual using whatever is sitting in the current solution vector then returns the L2 norm.
Reimplemented in EigenProblem.
Definition at line 6801 of file FEProblemBase.C.
|
virtualinherited |
This function is called by Libmesh to form a residual.
Definition at line 6823 of file FEProblemBase.C.
Referenced by NonlinearSystem::computeScalingResidual(), ComputeResidualFunctor::residual(), ComputeFDResidualFunctor::residual(), and NonlinearSystem::solve().
|
virtualinherited |
Form a residual vector for a given tag.
Definition at line 6996 of file FEProblemBase.C.
Form multiple residual vectors and each is associated with one tag.
Definition at line 7141 of file FEProblemBase.C.
Referenced by EigenProblem::computeResidualAB(), FEProblemBase::computeResidualInternal(), EigenProblem::computeResidualTag(), FEProblemBase::computeResidualTag(), and FEProblemBase::computeResidualType().
|
virtualinherited |
Form a residual vector for a given tag and "residual" tag.
Definition at line 7058 of file FEProblemBase.C.
|
protectedinherited |
Do generic system computations.
Definition at line 9271 of file FEProblemBase.C.
Referenced by FEProblemBase::computeBounds(), EigenProblem::computeJacobianBlocks(), FEProblemBase::computeJacobianBlocks(), FEProblemBase::computeJacobianTags(), FEProblemBase::computeLinearSystemTags(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualTags(), and FEProblemBase::execute().
|
virtualinherited |
Definition at line 7589 of file FEProblemBase.C.
Referenced by Moose::compute_transpose_nullspace().
|
virtualinherited |
Compute an user object with the given name.
Definition at line 4749 of file FEProblemBase.C.
Referenced by MultiAppConservativeTransfer::adjustTransferredSolution(), MultiAppConservativeTransfer::adjustTransferredSolutionNearestPoint(), MultiAppPostprocessorToAuxScalarTransfer::execute(), MultiAppPostprocessorTransfer::execute(), MultiAppGeneralFieldUserObjectTransfer::execute(), MultiAppUserObjectTransfer::execute(), MultiAppVectorPostprocessorTransfer::executeToMultiapp(), and MultiAppConservativeTransfer::postExecute().
|
virtualinherited |
Call compute methods on UserObjects.
Definition at line 4765 of file FEProblemBase.C.
Referenced by FEProblemBase::computeJacobianTags(), FEProblemBase::computeLinearSystemTags(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualTags(), FEProblemBase::execute(), and FEProblemBase::initialSetup().
|
protectedinherited |
Definition at line 4773 of file FEProblemBase.C.
Referenced by FEProblemBase::computeUserObjectByName(), and FEProblemBase::computeUserObjects().
|
inlineinherited |
Returns true if the problem is in the process of computing the nonlinear residual.
Definition at line 707 of file SubProblem.h.
|
inlineinherited |
Set whether or not the problem is in the process of computing the nonlinear residual.
Definition at line 712 of file SubProblem.h.
|
inlineinherited |
Returns true if the problem is in the process of computing the nonlinear residual.
Definition at line 707 of file SubProblem.h.
|
finalvirtualinherited |
Set whether or not the problem is in the process of computing the nonlinear residual.
Reimplemented from SubProblem.
Definition at line 8921 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::computeScaling(), ComputeFDResidualFunctor::residual(), ComputeResidualFunctor::residual(), and ComputeResidualAndJacobian::residual_and_jacobian().
|
overridevirtualinherited |
Returns true if the problem is in the process of computing it's initial residual.
Implements SubProblem.
Definition at line 6560 of file FEProblemBase.C.
Referenced by DisplacedProblem::computingPreSMOResidual().
|
inlineinherited |
Setter for whether we're computing the scaling jacobian.
Definition at line 2313 of file FEProblemBase.h.
Referenced by ComputeJacobianThread::compute(), SolverSystem::compute(), NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeScaling(), and DisplacedProblem::computingScalingJacobian().
|
inlinefinaloverridevirtualinherited |
Getter for whether we're computing the scaling jacobian.
Implements SubProblem.
Definition at line 2318 of file FEProblemBase.h.
|
inlineinherited |
Setter for whether we're computing the scaling residual.
Definition at line 2323 of file FEProblemBase.h.
Referenced by NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::computeResidualTags(), NonlinearSystemBase::computeScaling(), and DisplacedProblem::computingScalingResidual().
|
inlinefinaloverridevirtualinherited |
Implements SubProblem.
Definition at line 2331 of file FEProblemBase.h.
|
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().
|
inherited |
Returns _const_jacobian (whether a MOOSE object has specified that the Jacobian is the same as the previous time it was computed)
Definition at line 8766 of file FEProblemBase.C.
Referenced by Moose::SlepcSupport::moosePetscSNESFormMatricesTags(), and Moose::SlepcSupport::moosePetscSNESFormMatrixTag().
|
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(), DisplacedProblem::solverSystemConverged(), SubProblem::solverSystemConverged(), and AB2PredictorCorrector::step().
|
inherited |
Definition at line 9142 of file FEProblemBase.C.
|
virtualinherited |
Definition at line 6566 of file FEProblemBase.C.
Referenced by FEProblemBase::initialSetup().
|
inlineinherited |
Definition at line 165 of file FEProblemBase.h.
Referenced by DiffusionLHDGAssemblyHelper::checkCoupling(), and NonlinearSystemBase::computeJacobianInternal().
|
inherited |
Definition at line 6130 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::computeJacobianInternal(), ComputeFullJacobianThread::computeOnBoundary(), ComputeFullJacobianThread::computeOnElement(), ComputeFullJacobianThread::computeOnInterface(), ComputeFullJacobianThread::computeOnInternalFace(), Kernel::computeResidualAndJacobian(), NodalBC::computeResidualAndJacobian(), IntegratedBC::computeResidualAndJacobian(), ComputeNodalKernelBCJacobiansThread::onNode(), and ComputeNodalKernelJacobiansThread::onNode().
|
inlineoverridevirtualinherited |
The coupling matrix defining what blocks exist in the preconditioning matrix.
Implements SubProblem.
Definition at line 3226 of file FEProblemBase.h.
Referenced by DiffusionLHDGAssemblyHelper::checkCoupling(), DisplacedProblem::couplingMatrix(), and DisplacedProblem::init().
|
inherited |
Definition at line 7764 of file FEProblemBase.C.
|
virtualinherited |
Definition at line 5992 of file FEProblemBase.C.
|
protectedinherited |
Create extra tagged solution vectors.
Definition at line 678 of file FEProblemBase.C.
Referenced by DumpObjectsProblem::DumpObjectsProblem(), EigenProblem::EigenProblem(), ExternalProblem::ExternalProblem(), and FEProblem::FEProblem().
|
protectedinherited |
Create extra tagged vectors and matrices.
Definition at line 647 of file FEProblemBase.C.
Referenced by DumpObjectsProblem::DumpObjectsProblem(), EigenProblem::EigenProblem(), ExternalProblem::ExternalProblem(), and FEProblem::FEProblem().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 9159 of file FEProblemBase.C.
Referenced by DisplacedProblem::currentLinearSysNum().
|
inlineinherited |
Get a non-constant reference to the current linear system.
Definition at line 3194 of file FEProblemBase.h.
Referenced by FEProblemBase::currentLinearSysNum(), and Moose::PetscSupport::petscLinearConverged().
|
inlineinherited |
Get a constant reference to the current linear system.
Definition at line 3201 of file FEProblemBase.h.
|
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.
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().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 9148 of file FEProblemBase.C.
Referenced by DisplacedProblem::currentNlSysNum(), FEProblemBase::jacobianSetup(), and FEProblemBase::residualSetup().
|
inlineinherited |
Definition at line 3164 of file FEProblemBase.h.
Referenced by DefaultNonlinearConvergence::checkConvergence(), FEProblemBase::currentNlSysNum(), NonlinearSystemBase::jacobianSetup(), VariableResidualNormsDebugOutput::output(), Moose::PetscSupport::petscNonlinearConverged(), NonlinearSystemBase::residualSetup(), PetscOutput::solveSetup(), and ReferenceResidualConvergence::updateReferenceResidual().
|
inlineinherited |
Definition at line 3171 of file FEProblemBase.h.
|
inlineoverridevirtualinherited |
Return the residual vector tags we are currently computing.
Implements SubProblem.
Definition at line 3242 of file FEProblemBase.h.
Referenced by FEProblemBase::addResidual(), FEProblemBase::addResidualLower(), FEProblemBase::addResidualNeighbor(), FEProblemBase::addResidualScalar(), and DisplacedProblem::currentResidualVectorTags().
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 4549 of file FEProblemBase.C.
Referenced by FEProblemBase::execute().
|
protectedinherited |
Declares a piece of "managed" restartable data and initialize it.
Here, "managed" restartable data means that the caller can destruct this data upon destruction of the return value of this method. Therefore, this ManagedValue<T> wrapper should survive after the final calls to dataStore() for it. That is... at the very end.
This is needed for objects whose destruction ordering is important, and enables natural c++ destruction in reverse construction order of the object that declares it.
See delcareRestartableData and declareRestartableDataWithContext for more information.
Definition at line 276 of file Restartable.h.
|
protectedinherited |
Declare a piece of data as "recoverable" and initialize it.
This means that in the event of a restart this piece of data will be restored back to its previous value.
Note - this data will NOT be restored on Restart!
NOTE: This returns a reference! Make sure you store it in a reference!
data_name | The name of the data (usually just use the same name as the member variable) |
args | Arguments to forward to the constructor of the data |
Definition at line 351 of file Restartable.h.
|
protectedinherited |
Declare a piece of data as "restartable" and initialize it.
This means that in the event of a restart this piece of data will be restored back to its previous value.
NOTE: This returns a reference! Make sure you store it in a reference!
data_name | The name of the data (usually just use the same name as the member variable) |
args | Arguments to forward to the constructor of the data |
Definition at line 269 of file Restartable.h.
|
protectedinherited |
Declare a piece of data as "restartable" and initialize it.
This means that in the event of a restart this piece of data will be restored back to its previous value.
NOTE: This returns a reference! Make sure you store it in a reference!
data_name | The name of the data (usually just use the same name as the member variable) |
context | Context pointer that will be passed to the load and store functions |
args | Arguments to forward to the constructor of the data |
Definition at line 294 of file Restartable.h.
|
protectedinherited |
Declare a piece of data as "restartable".
This means that in the event of a restart this piece of data will be restored back to its previous value.
NOTE: This returns a reference! Make sure you store it in a reference!
data_name | The name of the data (usually just use the same name as the member variable) |
object_name | A supplied name for the object that is declaring this data. |
args | Arguments to forward to the constructor of the data |
Definition at line 323 of file Restartable.h.
|
protectedinherited |
Declare a piece of data as "restartable".
This means that in the event of a restart this piece of data will be restored back to its previous value.
NOTE: This returns a reference! Make sure you store it in a reference!
data_name | The name of the data (usually just use the same name as the member variable) |
object_name | A supplied name for the object that is declaring this data. |
context | Context pointer that will be passed to the load and store functions |
args | Arguments to forward to the constructor of the data |
Definition at line 333 of file Restartable.h.
|
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().
|
virtualinherited |
Definition at line 748 of file SubProblem.C.
|
inherited |
Definition at line 1355 of file SubProblem.C.
Referenced by FEProblemBase::meshChanged().
|
inlinevirtualinherited |
Definition at line 517 of file FEProblemBase.h.
Referenced by SolverSystem::compute(), AuxiliarySystem::compute(), EigenExecutionerBase::EigenExecutionerBase(), TimestepSize::getValue(), PseudoTimestep::outputPseudoTimestep(), and FixedPointSolve::solve().
|
inlinevirtualinherited |
|
protectedinherited |
Helper to check for duplicate variable names across systems or within a single system.
Definition at line 2715 of file FEProblemBase.C.
Referenced by FEProblemBase::addAuxArrayVariable(), FEProblemBase::addAuxScalarVariable(), FEProblemBase::addAuxVariable(), and FEProblemBase::addVariable().
|
inlinevirtualinherited |
Return the enabled status of the object.
Reimplemented in EigenKernel.
Definition at line 40 of file MooseObject.h.
Referenced by EigenKernel::enabled().
|
inlineinherited |
Will return True if the user wants to get an error when a nonzero is reallocated in the Jacobian by PETSc.
Definition at line 1923 of file FEProblemBase.h.
Referenced by NonlinearSystemBase::computeJacobianBlocks(), NonlinearSystemBase::computeJacobianInternal(), LinearSystem::computeLinearSystemInternal(), NonlinearSystemBase::computeResidualAndJacobianInternal(), and NonlinearSystemBase::constraintJacobians().
|
inherited |
Definition at line 43 of file MooseBase.C.
Referenced by MooseBase::callMooseError(), MooseBaseErrorInterface::mooseDeprecated(), MooseBaseErrorInterface::mooseInfo(), MooseBaseErrorInterface::mooseWarning(), and MooseBaseParameterInterface::paramErrorMsg().
|
inlineoverridevirtualinherited |
Implements SubProblem.
Definition at line 150 of file FEProblemBase.h.
Referenced by FEProblemBase::adaptMesh(), PhysicsBasedPreconditioner::addSystem(), MooseMesh::cacheFaceInfoVariableOwnership(), MooseMesh::cacheFVElementalDoFs(), DefaultNonlinearConvergence::DefaultNonlinearConvergence(), EigenProblem::EigenProblem(), MultiAppProjectionTransfer::execute(), FEProblem::FEProblem(), FEProblemBase::FEProblemBase(), FEProblemSolve::FEProblemSolve(), MultiAppFieldTransfer::getEquationSystem(), FEProblemBase::getEvaluableElementRange(), Adaptivity::init(), FEProblemBase::init(), MultiAppProjectionTransfer::initialSetup(), SampledOutput::initSample(), EigenExecutionerBase::inversePowerIteration(), FEProblemBase::meshChanged(), EigenExecutionerBase::nonlinearSolve(), DOFMapOutput::output(), Output::Output(), Moose::PetscSupport::petscSetKSPDefaults(), MultiAppProjectionTransfer::projectSolution(), FEProblemBase::reinitBecauseOfGhostingOrNewGeomObjects(), Moose::SlepcSupport::setEigenProblemSolverParams(), ExplicitTimeIntegrator::solveLinearSystem(), FEProblemBase::timestepSetup(), and SampledOutput::updateSample().
|
inherited |
Execute the MultiApps associated with the ExecFlagType.
Definition at line 5390 of file FEProblemBase.C.
Referenced by FEProblemBase::adaptMesh(), FEProblemBase::computeJacobianTags(), FEProblemBase::computeLinearSystemTags(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualTags(), MFEMSteady::execute(), MFEMTransient::execute(), TransientBase::execute(), SteadyBase::execute(), Eigenvalue::execute(), FEProblemBase::initialSetup(), EigenExecutionerBase::postExecute(), FixedPointSolve::solve(), and FixedPointSolve::solveStep().
|
inherited |
Execute MultiAppTransfers associated with execution flag and direction.
type | The execution flag to execute. |
direction | The direction (to or from) to transfer. |
Definition at line 5290 of file FEProblemBase.C.
Referenced by FEProblemBase::execMultiApps().
|
inherited |
Execute the Transfers associated with the ExecFlagType.
Note: This does not execute MultiApp Transfers! Those are executed automatically when MultiApps are executed.
Definition at line 5560 of file FEProblemBase.C.
Referenced by FEProblemBase::computeJacobianTags(), FEProblemBase::computeLinearSystemTags(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualTags(), FEProblemBase::initialSetup(), FixedPointSolve::solve(), and FixedPointSolve::solveStep().
|
virtualinherited |
Convenience function for performing execution of MOOSE systems.
Reimplemented in EigenProblem, and DumpObjectsProblem.
Definition at line 4586 of file FEProblemBase.C.
Referenced by EigenExecutionerBase::chebyshev(), FixedPointSolve::examineFixedPointConvergence(), MFEMSteady::execute(), MFEMTransient::execute(), TransientBase::execute(), SteadyBase::execute(), EigenProblem::execute(), NonlinearEigen::init(), MFEMSteady::init(), MFEMTransient::init(), Steady::init(), EigenExecutionerBase::init(), TransientBase::init(), FEProblemBase::initialSetup(), EigenExecutionerBase::makeBXConsistent(), EigenExecutionerBase::normalizeSolution(), Moose::PetscSupport::petscLinearConverged(), Moose::PetscSupport::petscNonlinearConverged(), EigenExecutionerBase::postExecute(), FixedPointSolve::solve(), FixedPointSolve::solveStep(), MFEMTransient::step(), InversePowerMethod::takeStep(), and NonlinearEigen::takeStep().
|
virtualinherited |
|
inherited |
Performs setup and execute calls for Control objects.
Definition at line 4987 of file FEProblemBase.C.
Referenced by FEProblemBase::computeJacobianTags(), FEProblemBase::computeLinearSystemTags(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualTags(), FEProblemBase::execute(), and FEProblemBase::initialSetup().
|
inherited |
Performs setup and execute calls for Sampler objects.
Definition at line 5032 of file FEProblemBase.C.
Referenced by FEProblemBase::execute().
|
inlinevirtualinherited |
Reimplemented in MFEMProblem.
Definition at line 2465 of file FEProblemBase.h.
Referenced by ConsoleUtils::outputExecutionInformation(), and ConsoleUtils::outputMeshInformation().
|
inherited |
Definition at line 5445 of file FEProblemBase.C.
Referenced by MFEMSteady::execute(), MFEMTransient::execute(), TransientBase::execute(), SteadyBase::execute(), and Eigenvalue::execute().
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 6554 of file FEProblemBase.C.
|
inherited |
Finish the MultiApp time step (endStep, postStep) associated with the ExecFlagType.
Optionally recurse through all multi-app levels
Definition at line 5473 of file FEProblemBase.C.
Referenced by FEProblemBase::advanceMultiApps(), MFEMTransient::execute(), TransientBase::execute(), TransientMultiApp::finishStep(), and TransientBase::incrementStepOrReject().
|
inherited |
Indicates that the next call to outputStep should be forced.
This is needed by the MultiApp system, if forceOutput is called the next call to outputStep, regardless of the type supplied to the call, will be executed with EXEC_FORCED.
Forced output will NOT override the allowOutput flag.
Definition at line 6674 of file FEProblemBase.C.
Referenced by TransientMultiApp::solveStep().
|
inlineinherited |
Definition at line 2251 of file FEProblemBase.h.
|
inlineinherited |
fv_bcs_integrity_check | Whether to perform a boundary condition integrity check for finite volume |
Definition at line 3232 of file FEProblemBase.h.
|
inlineoverridevirtualinherited |
Implements SubProblem.
Definition at line 1649 of file FEProblemBase.h.
Referenced by NonlinearSystemBase::augmentSparsity(), NonlinearSystemBase::computeJacobianInternal(), DMMooseGetEmbedding_Private(), and DMSetUp_Moose_Pre().
|
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.
|
overridevirtualinherited |
Returns the variable reference for requested MooseVariableField which may be in any system.
Implements SubProblem.
Definition at line 5688 of file FEProblemBase.C.
Referenced by MultiAppVariableValueSampleTransfer::execute().
|
overridevirtualinherited |
Returns the variable reference for requested ArrayMooseVariable which may be in any system.
Implements SubProblem.
Definition at line 5712 of file FEProblemBase.C.
Referenced by CoupleableMooseVariableDependencyIntermediateInterface::coupledArrayValueByName(), MultiAppVariableValueSamplePostprocessorTransfer::execute(), and PointwiseRenormalizeVector::PointwiseRenormalizeVector().
|
inlineinherited |
Definition at line 857 of file FEProblemBase.h.
Referenced by Adaptivity::adaptMesh(), DisplacedProblem::addTimeIntegrator(), ElementSubdomainModifierBase::applyIC(), TransientMultiApp::appTransferVector(), MooseMesh::cacheFaceInfoVariableOwnership(), MooseMesh::cacheFVElementalDoFs(), PNGOutput::calculateRescalingValues(), NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeNodalBCs(), NonlinearSystemBase::computeResidualTags(), NonlinearSystemBase::constraintResiduals(), DisplacedProblem::DisplacedProblem(), EigenExecutionerBase::EigenExecutionerBase(), FEProblemBase::execute(), ReferenceResidualConvergence::initialSetup(), FEProblemBase::initialSetup(), ActivateElementsUserObjectBase::initSolutions(), EigenExecutionerBase::inversePowerIteration(), PNGOutput::makeMeshFunc(), MultiAppVariableValueSamplePostprocessorTransfer::MultiAppVariableValueSamplePostprocessorTransfer(), ConsoleUtils::outputAuxiliarySystemInformation(), BlockRestrictionDebugOutput::printBlockRestrictionMap(), MultiApp::restore(), NonlinearSystemBase::setConstraintSecondaryValues(), TransientMultiApp::setupApp(), TransientMultiApp::solveStep(), AB2PredictorCorrector::step(), DisplacedProblem::syncSolutions(), ReferenceResidualConvergence::updateReferenceResidual(), and Coupleable::writableCoupledValue().
|
inherited |
Returns the desired radial direction for RZ coordinate transformation.
Definition at line 796 of file SubProblem.C.
|
inlineinherited |
Definition at line 1671 of file FEProblemBase.h.
|
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().
|
inlineinherited |
Reference to the control logic warehouse.
Definition at line 2043 of file FEProblemBase.h.
Referenced by LibtorchArtificialNeuralNetParameters::initialSetup(), and LibtorchControlValuePostprocessor::initialSetup().
|
virtualinherited |
Gets a Convergence object.
Definition at line 2603 of file FEProblemBase.C.
Referenced by FixedPointSolve::examineFixedPointConvergence(), FixedPointIterationAdaptiveDT::init(), ParsedConvergence::initializeConvergenceSymbol(), SteffensenSolve::initialSetup(), Moose::PetscSupport::petscLinearConverged(), Moose::PetscSupport::petscNonlinearConverged(), FEProblemSolve::solve(), FixedPointSolve::solve(), and FixedPointSolve::solveStep().
|
virtualinherited |
Gets the Convergence objects.
Definition at line 2613 of file FEProblemBase.C.
|
inherited |
Definition at line 1272 of file SubProblem.C.
Referenced by BlockRestrictable::getBlockCoordSystem(), MultiApp::getBoundingBox(), Assembly::reinitLowerDElem(), Assembly::reinitNeighborLowerDElem(), and Assembly::setCoordinateTransformation().
|
inherited |
Definition at line 9300 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::computeJacobianBlocks(), NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeNodalBCs(), NonlinearSystemBase::computeNodalBCsResidualAndJacobian(), NonlinearSystemBase::computeResidualInternal(), and NonlinearSystemBase::setInitialSolution().
|
inherited |
These are the element and nodes that contribute to the jacobian and residual for this local processor.
getCurrentAlgebraicElementRange() returns the element range that contributes to the system getCurrentAlgebraicNodeRange() returns the node range that contributes to the system getCurrentAlgebraicBndNodeRange returns the boundary node ranges that contributes to the system
Definition at line 9284 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::computeDamping(), NonlinearSystemBase::computeJacobianBlocks(), NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeResidualAndJacobianInternal(), NonlinearSystemBase::computeResidualInternal(), and NonlinearSystemBase::computeScaling().
|
inherited |
Definition at line 9292 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::computeDamping(), NonlinearSystemBase::computeJacobianInternal(), and NonlinearSystemBase::computeResidualInternal().
|
inherited |
Return/set the current execution flag.
Returns EXEC_NONE when not being executed.
Definition at line 4532 of file FEProblemBase.C.
Referenced by MultiAppGeneralFieldTransfer::acceptPointInOriginMesh(), MultiAppGeneralFieldTransfer::closestToPosition(), MultiAppGeneralFieldNearestLocationTransfer::computeNumSources(), CartesianGridDivision::divisionIndex(), CylindricalGridDivision::divisionIndex(), SphericalGridDivision::divisionIndex(), NearestPositionsDivision::divisionIndex(), PositionsFunctorValueSampler::execute(), PIDTransientControl::execute(), Terminator::execute(), Control::getControllableParameterByName(), Material::getMaterialByName(), MultiAppGeneralFieldNearestLocationTransfer::getNumDivisions(), NumPositions::getValue(), DistributedPositions::initialize(), TransformedPositions::initialize(), PositionsFunctorValueSampler::initialize(), ParsedDownSelectionPositions::initialize(), MultiAppGeneralFieldTransfer::locatePointReceivers(), ComputeUserObjectsThread::printBlockExecutionInformation(), ComputeInitialConditionThread::printGeneralExecutionInformation(), ComputeFVInitialConditionThread::printGeneralExecutionInformation(), ComputeNodalUserObjectsThread::printGeneralExecutionInformation(), ComputeNodalKernelBcsThread::printGeneralExecutionInformation(), ComputeNodalKernelsThread::printGeneralExecutionInformation(), ComputeElemDampingThread::printGeneralExecutionInformation(), ComputeNodalKernelBCJacobiansThread::printGeneralExecutionInformation(), ComputeMarkerThread::printGeneralExecutionInformation(), ComputeNodalDampingThread::printGeneralExecutionInformation(), ComputeDiracThread::printGeneralExecutionInformation(), ComputeIndicatorThread::printGeneralExecutionInformation(), ComputeNodalKernelJacobiansThread::printGeneralExecutionInformation(), ComputeThreadedGeneralUserObjectsThread::printGeneralExecutionInformation(), ComputeUserObjectsThread::printGeneralExecutionInformation(), ComputeLinearFVElementalThread::printGeneralExecutionInformation(), ComputeLinearFVFaceThread::printGeneralExecutionInformation(), NonlinearThread::printGeneralExecutionInformation(), MultiApp::restore(), SolutionInvalidityOutput::shouldOutput(), ElementReporter::shouldStore(), NodalReporter::shouldStore(), GeneralReporter::shouldStore(), and WebServerControl::startServer().
|
inherited |
Retrieves the current initial condition state.
Definition at line 9343 of file FEProblemBase.C.
Referenced by ComputeInitialConditionThread::operator()().
|
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 2434 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::computeDiracContributions().
|
inlineinherited |
Definition at line 1894 of file FEProblemBase.h.
|
inlinevirtualinherited |
Definition at line 1609 of file FEProblemBase.h.
Referenced by NonlinearSystemBase::assembleScalingVector(), MooseApp::attachRelationshipManagers(), NonlinearSystemBase::augmentSparsity(), NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeResidualAndJacobianInternal(), NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::computeScaling(), NonlinearSystemBase::constraintJacobians(), NonlinearSystemBase::constraintResiduals(), MultiApp::createApp(), DMMooseGetEmbedding_Private(), DMSetUp_Moose_Pre(), ActivateElementsUserObjectBase::execute(), MultiAppUserObjectTransfer::execute(), ActivateElementsUserObjectBase::finalize(), RadialAverage::finalize(), MultiApp::getBoundingBox(), MultiAppFieldTransfer::getEquationSystem(), Exodus::handleExodusIOMeshRenumbering(), EigenExecutionerBase::init(), Adaptivity::init(), NonlinearSystemBase::initialSetup(), FEProblemBase::initialSetup(), EigenExecutionerBase::inversePowerIteration(), Output::Output(), Exodus::outputSetup(), NonlinearSystemBase::overwriteNodeFace(), NonlinearSystemBase::reinitNodeFace(), NonlinearSystemBase::setConstraintSecondaryValues(), NonlinearSystemBase::setInitialSolution(), and ActivateElementsUserObjectBase::setNewBoundayName().
|
inlinevirtualinherited |
Definition at line 1613 of file FEProblemBase.h.
|
virtualinherited |
Definition at line 2673 of file FEProblemBase.C.
Referenced by DistributionInterface::getDistribution(), and DistributionInterface::getDistributionByName().
|
inherited |
In general, {evaluable elements} >= {local elements} U {algebraic ghosting elements}.
That is, the number of evaluable elements does NOT necessarily equal to the number of local and algebraic ghosting elements. For example, if using a Lagrange basis for all variables, if a non-local, non-algebraically-ghosted element is surrounded by neighbors which are local or algebraically ghosted, then all the nodal (Lagrange) degrees of freedom associated with the non-local, non-algebraically-ghosted element will be evaluable, and hence that element will be considered evaluable.
getNonlinearEvaluableElementRange() returns the evaluable element range based on the nonlinear system dofmap; getAuxliaryEvaluableElementRange() returns the evaluable element range based on the auxiliary system dofmap; getEvaluableElementRange() returns the element range that is evaluable based on both the nonlinear dofmap and the auxliary dofmap.
Definition at line 821 of file FEProblemBase.C.
Referenced by NodalPatchRecoveryBase::finalize().
|
inlinevirtualinherited |
Definition at line 1995 of file FEProblemBase.h.
|
inlineinherited |
Whether it will skip further residual evaluations and fail the next nonlinear convergence check(s)
Definition at line 2374 of file FEProblemBase.h.
Referenced by NonlinearSystemBase::computeScaling(), NonlinearSystem::converged(), Moose::PetscSupport::petscNonlinearConverged(), and ComputeResidualFunctor::residual().
|
inlineinherited |
Whether it will fail the next system convergence check(s), triggering failed step behavior.
Definition at line 2376 of file FEProblemBase.h.
Referenced by FEProblemBase::getFailNextNonlinearConvergenceCheck(), and Moose::PetscSupport::petscLinearConverged().
|
virtualinherited |
Definition at line 2552 of file FEProblemBase.C.
Referenced by MFEMProblem::addFunction(), FunctionInterface::getFunction(), FunctionInterface::getFunctionByName(), IterationAdaptiveDT::init(), MooseParsedFunctionWrapper::initialize(), ChainControlParsedFunctionWrapper::initializeFunctionInputs(), and ParsedConvergence::initializeFunctionSymbol().
|
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().
|
inlineinherited |
Return FVInitialCondition storage.
Definition at line 1698 of file FEProblemBase.h.
Referenced by ComputeFVInitialConditionThread::operator()(), and ComputeFVInitialConditionThread::printGeneralExecutionInformation().
|
inherited |
Get the materials and variables potentially needed for FV.
block_id | SubdomainID The subdomain id that we want to retrieve materials for |
face_materials | The face materials container that we will fill |
neighbor_materials | The neighbor materials container that we will fill |
variables | The variables container that we will fill that our materials depend on |
tid | The thread id |
Definition at line 8994 of file FEProblemBase.C.
|
inlineinherited |
Return indicator/marker storage.
Definition at line 1682 of file FEProblemBase.h.
|
inlineinherited |
Return InitialCondition storage.
Definition at line 1693 of file FEProblemBase.h.
Referenced by ComputeBoundaryInitialConditionThread::onNode(), ComputeInitialConditionThread::operator()(), and ComputeInitialConditionThread::printGeneralExecutionInformation().
|
inlineinherited |
Definition at line 1895 of file FEProblemBase.h.
|
inlineinherited |
Definition at line 1683 of file FEProblemBase.h.
|
inherited |
Gets the linear convergence object name(s).
Definition at line 9097 of file FEProblemBase.C.
Referenced by Moose::PetscSupport::petscLinearConverged().
|
inlineinherited |
Get non-constant reference to a linear system.
sys_num | The number of the linear system |
Definition at line 3178 of file FEProblemBase.h.
Referenced by IterationAdaptiveDT::acceptStep(), Moose::compute_linear_system(), ComputeLinearFVGreenGaussGradientFaceThread::operator()(), ComputeLinearFVGreenGaussGradientVolumeThread::operator()(), Moose::PetscSupport::petscSetDefaults(), and FEProblemSolve::solve().
|
inlineinherited |
Get a constant reference to a linear system.
sys_num | The number of the linear system |
Definition at line 3186 of file FEProblemBase.h.
|
inlineinherited |
Definition at line 2455 of file FEProblemBase.h.
Referenced by PhysicsBase::initializePhysics(), and MultiSystemSolveObject::MultiSystemSolveObject().
|
inlineoverridevirtualinherited |
getter for the MOOSE line search
Implements SubProblem.
Definition at line 702 of file FEProblemBase.h.
Referenced by DisplacedProblem::getLineSearch().
|
inlineinherited |
Definition at line 1687 of file FEProblemBase.h.
|
inherited |
Return a pointer to a MaterialBase object.
If no_warn is true, suppress warning about retrieving a material reference potentially during the material's calculation.
This will return enabled or disabled objects, the main purpose is for iterative materials.
Definition at line 3727 of file FEProblemBase.C.
Referenced by MaterialPropertyInterface::getMaterialByName().
|
inherited |
Definition at line 3756 of file FEProblemBase.C.
Referenced by BlockRestrictable::initializeBlockRestrictable(), and FEProblemBase::resizeMaterialData().
|
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().
|
inlineinherited |
Definition at line 1660 of file FEProblemBase.h.
Referenced by MaterialBase::checkStatefulSanity().
|
inlineinherited |
Return a reference to the material property storage.
Definition at line 1670 of file FEProblemBase.h.
|
inlineinherited |
Definition at line 1888 of file FEProblemBase.h.
Referenced by MaterialPropertyInterface::buildRequiredMaterials(), BlockRestrictable::hasBlockMaterialPropertyHelper(), BoundaryRestrictable::hasBoundaryMaterialPropertyHelper(), ElementSubdomainModifierBase::modify(), BlockRestrictionDebugOutput::printBlockRestrictionMap(), MaterialPropertyDebugOutput::printMaterialMap(), ComputeIndicatorThread::subdomainChanged(), NonlinearThread::subdomainChanged(), and ComputeUserObjectsThread::subdomainChanged().
|
virtualinherited |
Get a TagID from a TagName.
Reimplemented in DisplacedProblem.
Definition at line 342 of file SubProblem.C.
Referenced by Coupleable::coupledMatrixTagValue(), Coupleable::coupledMatrixTagValues(), ExplicitTimeIntegrator::ExplicitTimeIntegrator(), DisplacedProblem::getMatrixTagID(), TaggingInterface::TaggingInterface(), and TaggingInterface::useMatrixTag().
|
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().
|
inherited |
Definition at line 1579 of file FEProblemBase.C.
Referenced by MaterialBase::getMaxQps(), MaterialPropertyInterface::getMaxQps(), FEProblemBase::initialSetup(), FEProblemBase::reinitDirac(), Material::subdomainSetup(), and FEProblemBase::updateMaxQps().
|
inherited |
Definition at line 1587 of file FEProblemBase.C.
Referenced by ScalarCoupleable::coupledScalarOrder(), ScalarCoupleable::getADDefaultValue(), and ScalarCoupleable::getDefaultValue().
|
inherited |
Get a MeshDivision.
Definition at line 2634 of file FEProblemBase.C.
Referenced by NestedDivision::NestedDivision().
|
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(), FEProblemBase::advanceState(), ParsedChainControl::buildFunction(), ReporterTransferInterface::checkHasReporterValue(), AddDefaultConvergenceAction::checkUnusedMultiAppFixedPointConvergenceParameters(), AddDefaultConvergenceAction::checkUnusedNonlinearConvergenceParameters(), 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(), and VectorPostprocessorInterface::vectorPostprocessorsAdded().
|
inherited |
Return the undisplaced or displaced mortar generation object associated with the provided boundaries and subdomains.
Definition at line 7796 of file FEProblemBase.C.
|
inherited |
Definition at line 7806 of file FEProblemBase.C.
|
inherited |
Definition at line 7816 of file FEProblemBase.C.
Referenced by FEProblemBase::computeUserObjectsInternal(), and NonlinearSystemBase::initialSetup().
|
inherited |
Get a MultiApp object by name.
Definition at line 5284 of file FEProblemBase.C.
Referenced by FEProblemBase::addTransfer(), MultiAppPositions::initialize(), and MultiAppTransfer::MultiAppTransfer().
|
inherited |
Gets the MultiApp fixed point convergence object name.
Definition at line 9105 of file FEProblemBase.C.
Referenced by FEProblemBase::addDefaultMultiAppFixedPointConvergence(), FixedPointSolve::examineFixedPointConvergence(), FixedPointIterationAdaptiveDT::init(), SteffensenSolve::initialSetup(), FixedPointSolve::solve(), and FixedPointSolve::solveStep().
|
inherited |
Return the complete warehouse for MultiAppTransfer object for the given direction.
Definition at line 5379 of file FEProblemBase.C.
|
inlineinherited |
Definition at line 2067 of file FEProblemBase.h.
Referenced by MooseApp::errorCheck().
|
inlineinherited |
Definition at line 1672 of file FEProblemBase.h.
|
inherited |
Gets the nonlinear system convergence object name(s).
Definition at line 9073 of file FEProblemBase.C.
Referenced by addDefaultNonlinearConvergence(), FEProblemBase::addDefaultNonlinearConvergence(), and Moose::PetscSupport::petscNonlinearConverged().
|
inherited |
Definition at line 839 of file FEProblemBase.C.
Referenced by ElemSideNeighborLayersTester::execute().
|
inlineoverridevirtualinherited |
Reimplemented from FEProblemBase.
Definition at line 48 of file FEProblem.h.
|
inlineinherited |
Definition at line 3134 of file FEProblemBase.h.
Referenced by IterationAdaptiveDT::acceptStep(), Adaptivity::adaptMesh(), DisplacedProblem::addTimeIntegrator(), ADKernelTempl< T >::ADKernelTempl(), ElementSubdomainModifierBase::applyIC(), ArrayKernel::ArrayKernel(), Eigenvalue::checkIntegrity(), PseudoTimestep::currentResidualNorm(), DisplacedProblem::DisplacedProblem(), AB2PredictorCorrector::estimateTimeError(), VariableResidual::execute(), MatrixSymmetryCheck::execute(), GreaterThanLessThanPostprocessor::execute(), Executioner::Executioner(), FiniteDifferencePreconditioner::FiniteDifferencePreconditioner(), NumResidualEvaluations::getValue(), Residual::getValue(), Adaptivity::init(), ReferenceResidualConvergence::initialSetup(), ActivateElementsUserObjectBase::initSolutions(), Kernel::Kernel(), BoundaryElemIntegrityCheckThread::operator()(), DOFMapOutput::output(), SolutionHistory::output(), ConsoleUtils::outputExecutionInformation(), Console::outputSystemInformation(), Moose::PetscSupport::petscSetDefaults(), ReferenceResidualConvergence::ReferenceResidualConvergence(), Moose::PetscSupport::setLineSearchFromParams(), SingleMatrixPreconditioner::SingleMatrixPreconditioner(), AB2PredictorCorrector::step(), DisplacedProblem::syncSolutions(), and Console::writeVariableNorms().
|
inlineinherited |
Definition at line 3141 of file FEProblemBase.h.
|
inlineinherited |
Definition at line 2451 of file FEProblemBase.h.
Referenced by PhysicsBase::initializePhysics(), Console::meshChanged(), MultiSystemSolveObject::MultiSystemSolveObject(), ConsoleUtils::outputExecutionInformation(), and Console::outputSystemInformation().
|
inlineinherited |
|
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(), 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.
|
inlineinherited |
Retrieve a writable reference the PETSc options (used by PetscSupport)
Definition at line 604 of file FEProblemBase.h.
Referenced by Moose::PetscSupport::dontAddCommonKSPOptions(), Moose::PetscSupport::dontAddCommonSNESOptions(), Moose::PetscSupport::dontAddLinearConvergedReason(), Moose::PetscSupport::dontAddNonlinearConvergedReason(), Eigenvalue::Eigenvalue(), Moose::PetscSupport::isSNESVI(), ConsoleUtils::outputExecutionInformation(), Moose::PetscSupport::setConvergedReasonFlags(), Moose::SlepcSupport::setSlepcEigenSolverTolerances(), Split::setup(), Moose::SlepcSupport::slepcSetOptions(), FEProblemSolve::solve(), and Moose::PetscSupport::storePetscOptions().
|
inherited |
Get the Positions object by its name.
name | The name of the Positions object being retrieved |
Definition at line 4354 of file FEProblemBase.C.
Referenced by DistributedPositions::DistributedPositions(), MultiApp::fillPositions(), ParsedDownSelectionPositions::initialize(), Positions::initialized(), MultiAppGeneralFieldTransfer::MultiAppGeneralFieldTransfer(), and TransformedPositions::TransformedPositions().
|
inherited |
Get a read-only reference to the value associated with a Postprocessor that exists.
name | The name of the post-processor |
t_index | Flag for getting current (0), old (1), or older (2) values |
Note: This method is only for retrieving values that already exist, the Postprocessor and PostprocessorInterface objects should be used rather than this method for creating and getting values within objects.
Definition at line 4388 of file FEProblemBase.C.
Referenced by MFEMProblem::addPostprocessor(), MultiAppConservativeTransfer::adjustTransferredSolution(), MultiAppConservativeTransfer::adjustTransferredSolutionNearestPoint(), MultiApp::appPostprocessorValue(), MultiAppPostprocessorToAuxScalarTransfer::execute(), MultiAppPostprocessorTransfer::execute(), EigenProblem::formNorm(), MooseParsedFunctionWrapper::initialize(), ParsedConvergence::initializePostprocessorSymbol(), EigenExecutionerBase::inversePowerIteration(), TableOutput::outputPostprocessors(), Exodus::outputPostprocessors(), and EigenProblem::postScaleEigenVector().
|
inlineinherited |
Definition at line 1893 of file FEProblemBase.h.
Referenced by Moose::Mortar::setupMortarMaterials().
|
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.
|
inlineinherited |
Provides const access the ReporterData object.
NOTE: There is a private non-const version of this function that uses a key object only constructable by the correct interfaces. This was done by design to encourage the use of the Reporter and ReporterInterface classes.
Definition at line 1080 of file FEProblemBase.h.
Referenced by ReporterTransferInterface::addReporterTransferMode(), ReporterTransferInterface::checkHasReporterValue(), ReporterTransferInterface::clearVectorReporter(), ConstantPostprocessor::ConstantPostprocessor(), AccumulateReporter::declareAccumulateHelper(), ReporterTransferInterface::declareClone(), AccumulateReporter::declareLateValues(), VectorPostprocessor::declareVector(), ReporterTransferInterface::declareVectorClone(), FEProblemBase::execute(), PostprocessorInterface::getPostprocessorValueByNameInternal(), VectorPostprocessorInterface::getVectorPostprocessorByNameHelper(), VectorPostprocessorInterface::getVectorPostprocessorContextByNameHelper(), PostprocessorInterface::hasPostprocessorByName(), VectorPostprocessorInterface::hasVectorPostprocessorByName(), ReporterPositions::initialize(), ReporterTimes::initialize(), MooseParsedFunctionWrapper::initialize(), ParsedConvergence::initializeSymbols(), JSONOutput::initialSetup(), PostprocessorInterface::isDefaultPostprocessorValueByName(), ReporterDebugOutput::output(), Receiver::Receiver(), ReporterTransferInterface::resizeReporter(), ReporterTransferInterface::sumVectorReporter(), ReporterTransferInterface::transferFromVectorReporter(), ReporterTransferInterface::transferReporter(), and ReporterTransferInterface::transferToVectorReporter().
|
inlineinherited |
Provides non-const access the ReporterData object that is used to store reporter values.
see ReporterData.h
Definition at line 1087 of file FEProblemBase.h.
|
protectedinherited |
Declare a piece of data as "restartable" and initialize it Similar to declareRestartableData
but returns a const reference to the object.
Forwarded arguments are not allowed in this case because we assume that the object is restarted and we won't need different constructors to initialize it.
NOTE: This returns a const reference! Make sure you store it in a const reference!
data_name | The name of the data (usually just use the same name as the member variable) |
Definition at line 287 of file Restartable.h.
|
virtualinherited |
Definition at line 2697 of file FEProblemBase.C.
Referenced by SamplerInterface::getSampler(), and SamplerInterface::getSamplerByName().
|
overridevirtualinherited |
Returns the scalar variable reference from whichever system contains it.
Implements SubProblem.
Definition at line 5736 of file FEProblemBase.C.
Referenced by FEProblemBase::addInitialCondition(), EigenProblem::adjustEigenVector(), MultiAppScalarToAuxScalarTransfer::execute(), MooseParsedFunctionWrapper::initialize(), ChainControlParsedFunctionWrapper::initializeFunctionInputs(), TableOutput::outputScalarVariables(), and Exodus::outputScalarVariables().
|
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.
|
inlineinherited |
Get non-constant reference to a solver system.
sys_num | The number of the solver system |
Definition at line 3148 of file FEProblemBase.h.
Referenced by MooseApp::attachRelationshipManagers(), MooseMesh::cacheFaceInfoVariableOwnership(), MooseMesh::cacheFVElementalDoFs(), MultiSystemSolveObject::MultiSystemSolveObject(), ConsoleUtils::outputSolverSystemInformation(), Moose::PetscSupport::petscSetDefaultKSPNormType(), and Moose::PetscSupport::petscSetDefaultPCSide().
|
inlineinherited |
Get a constant reference to a solver system.
sys_num | The number of the solver system |
Definition at line 3156 of file FEProblemBase.h.
|
inlineinherited |
Definition at line 2459 of file FEProblemBase.h.
Referenced by ConsoleUtils::outputExecutionInformation().
|
overridevirtualinherited |
Returns the variable reference for requested MooseVariable which may be in any system.
Implements SubProblem.
Definition at line 5676 of file FEProblemBase.C.
Referenced by CoupleableMooseVariableDependencyIntermediateInterface::coupledValueByName().
|
overridevirtualinherited |
Returns the equation system containing the variable provided.
Implements SubProblem.
Definition at line 5748 of file FEProblemBase.C.
Referenced by FEProblemBase::addObjectParamsHelper(), and MultiApp::appTransferVector().
|
virtualinherited |
Get constant reference to a system in this problem.
sys_num | The number of the system |
Definition at line 8845 of file FEProblemBase.C.
Referenced by PhysicsBase::copyVariablesFromMesh().
|
virtualinherited |
Get non-constant reference to a system in this problem.
sys_num | The number of the system |
Definition at line 8854 of file FEProblemBase.C.
|
inherited |
Returns the time associated with the requested state
.
Definition at line 6701 of file FEProblemBase.C.
Referenced by Function::evaluate(), Function::evaluateDotHelper(), Function::evaluateGradientHelper(), Function::evaluateHelper(), and ParsedFunctorMaterialTempl< is_ad >::ParsedFunctorMaterialTempl().
|
inherited |
Get Transfers by ExecFlagType and direction.
Definition at line 5357 of file FEProblemBase.C.
|
inherited |
Definition at line 5368 of file FEProblemBase.C.
|
inlinevirtualinherited |
Definition at line 27 of file FEProblem.h.
|
inlineinherited |
Get the user object by its name.
name | The name of the user object being retrieved |
Definition at line 1107 of file FEProblemBase.h.
Referenced by ChangeOverFixedPointPostprocessor::ChangeOverFixedPointPostprocessor(), ChangeOverTimePostprocessor::ChangeOverTimePostprocessor(), ExtraIDIntegralReporter::ExtraIDIntegralReporter(), ReporterTransferInterface::hideVariableHelper(), EigenExecutionerBase::init(), Eigenvalue::init(), IntegralPreservingFunctionIC::initialSetup(), and EigenExecutionerBase::inversePowerIteration().
|
inherited |
Get the user object by its name.
name | The name of the user object being retrieved |
tid | The thread of the user object (defaults to 0) |
Definition at line 4338 of file FEProblemBase.C.
Referenced by MFEMProblem::addBoundaryCondition(), MFEMProblem::addKernel(), MultiAppConservativeTransfer::adjustTransferredSolution(), MultiAppConservativeTransfer::adjustTransferredSolutionNearestPoint(), MultiApp::appUserObjectBase(), EigenProblem::checkProblemIntegrity(), FunctorAux::computeValue(), UserObjectInterface::getUserObjectBaseByName(), UserObjectInterface::getUserObjectFromFEProblem(), VectorPostprocessorInterface::hasVectorPostprocessorByName(), MultiAppCloneReporterTransfer::initialSetup(), MultiAppConservativeTransfer::initialSetup(), Terminator::initialSetup(), and FunctorIC::value().
|
inlineinherited |
Definition at line 309 of file FEProblemBase.h.
Referenced by ComputeUserObjectsThread::onBoundary(), and ComputeUserObjectsThread::onElement().
|
inlineinherited |
Definition at line 1094 of file FEProblemBase.h.
|
inlineinherited |
Definition at line 279 of file SubProblem.h.
|
inherited |
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.
|
overridevirtualinherited |
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 5666 of file FEProblemBase.C.
Referenced by FEProblemBase::addFVInitialCondition(), FEProblemBase::addInitialCondition(), EigenProblem::adjustEigenVector(), MultiAppConservativeTransfer::adjustTransferredSolution(), MultiAppConservativeTransfer::adjustTransferredSolutionNearestPoint(), MultiAppGeneralFieldNearestLocationTransfer::buildKDTrees(), MultiAppGeneralFieldShapeEvaluationTransfer::buildMeshFunctions(), CoupleableMooseVariableDependencyIntermediateInterface::coupledArrayValueByName(), CoupleableMooseVariableDependencyIntermediateInterface::coupledValueByName(), NodalNormalsCorner::execute(), NodalNormalsEvaluator::execute(), MultiAppProjectionTransfer::execute(), MultiAppUserObjectTransfer::execute(), NodalNormalsPreprocessor::execute(), MultiAppGeometricInterpolationTransfer::execute(), LazyCoupleable::init(), AdvancedOutput::initAvailableLists(), MultiAppGeneralFieldNearestLocationTransfer::initialSetup(), MultiAppProjectionTransfer::initialSetup(), AdvancedOutput::initShowHideLists(), SolutionUserObjectBase::pointValueWrapper(), PointwiseRenormalizeVector::PointwiseRenormalizeVector(), BlockRestrictionDebugOutput::printBlockRestrictionMap(), MultiAppProjectionTransfer::projectSolution(), MultiAppDofCopyTransfer::transfer(), and MultiAppShapeEvaluationTransfer::transferVariable().
|
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 DisplacedProblem::getVariable(), and FEProblemBase::getVariable().
|
virtualinherited |
Returns a list of all the variables in the problem (both from the NL and Aux systems.
Definition at line 8605 of file FEProblemBase.C.
Referenced by EigenProblem::adjustEigenVector(), and AdvancedOutput::initAvailableLists().
|
inherited |
Return the VPP object given the name.
object_name | The name of the VPP object |
This is used by various output objects as well as the scatter value handling.
Definition at line 4432 of file FEProblemBase.C.
Referenced by VectorPostprocessorInterface::isVectorPostprocessorDistributedByName(), CSV::output(), and XMLOutput::outputVectorPostprocessors().
|
inherited |
Get a read-only reference to the vector value associated with the VectorPostprocessor.
object_name | The name of the VPP object. |
vector_name | The namve of the decalred vector within the object. |
Note: This method is only for retrieving values that already exist, the VectorPostprocessor and VectorPostprocessorInterface objects should be used rather than this method for creating and getting values within objects.
Definition at line 4413 of file FEProblemBase.C.
Referenced by HistogramVectorPostprocessor::execute().
Get a VectorTag from a TagID.
Reimplemented in DisplacedProblem.
Definition at line 161 of file SubProblem.C.
Referenced by FEProblemBase::addCachedResidualDirectly(), Assembly::cacheResidual(), Assembly::cacheResidualNodes(), DisplacedProblem::getVectorTag(), SubProblem::getVectorTags(), TaggingInterface::prepareVectorTagInternal(), TaggingInterface::prepareVectorTagLower(), TaggingInterface::prepareVectorTagNeighbor(), FEProblemBase::setResidual(), and FEProblemBase::setResidualNeighbor().
|
virtualinherited |
Get a TagID from a TagName.
Reimplemented in DisplacedProblem.
Definition at line 203 of file SubProblem.C.
Referenced by Coupleable::coupledVectorTagArrayGradient(), Coupleable::coupledVectorTagArrayGradients(), Coupleable::coupledVectorTagArrayValues(), Coupleable::coupledVectorTagDofValues(), Coupleable::coupledVectorTagGradient(), Coupleable::coupledVectorTagGradients(), Coupleable::coupledVectorTagValues(), MultiAppVariableValueSamplePostprocessorTransfer::execute(), DisplacedProblem::getVectorTagID(), MooseVariableDataBase< OutputType >::MooseVariableDataBase(), ReferenceResidualConvergence::ReferenceResidualConvergence(), SolverSystem::setSolution(), TaggingInterface::TaggingInterface(), MultiAppDofCopyTransfer::transfer(), TaggingInterface::useVectorTag(), Coupleable::vectorTagDofValueHelper(), and Coupleable::vectorTagValueHelper().
|
inherited |
Definition at line 172 of file SubProblem.C.
Referenced by FEProblemBase::computeLinearSystemSys(), EigenProblem::computeResidualAB(), FEProblemBase::computeResidualAndJacobian(), NonlinearSystemBase::computeResidualInternal(), EigenProblem::computeResidualTag(), ComputeResidualAndJacobianThread::determineObjectWarehouses(), DisplacedProblem::getVectorTags(), SubProblem::numVectorTags(), ComputeMortarFunctor::operator()(), and FEProblemBase::setCurrentResidualVectorTags().
|
virtualinherited |
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 in DisplacedProblem.
Definition at line 184 of file SubProblem.C.
|
overridevirtualinherited |
Returns the variable reference for requested VectorMooseVariable which may be in any system.
Implements SubProblem.
Definition at line 5700 of file FEProblemBase.C.
|
inlineinherited |
Get a pointer to the XFEM controller object.
Definition at line 1740 of file FEProblemBase.h.
|
inlinevirtualinherited |
Return the list of elements that should have their DoFs ghosted to this processor.
Reimplemented in DisplacedProblem.
Definition at line 672 of file SubProblem.h.
Referenced by SystemBase::augmentSendList(), NearestNodeLocator::findNodes(), DisplacedProblem::ghostedElems(), and NearestNodeLocator::updatePatch().
|
overridevirtualinherited |
Causes the boundaries added using addGhostedBoundary to actually be ghosted.
Implements SubProblem.
Definition at line 2087 of file FEProblemBase.C.
Referenced by DisplacedProblem::ghostGhostedBoundaries(), FEProblemBase::init(), and FEProblemBase::meshChanged().
|
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().
|
inherited |
Method to check whether or not a list of active material roperties has been set.
This method is called by reinitMaterials to determine whether Material computeProperties methods need to be called. If the return is False, this check prevents unnecessary material property computation
tid | The thread id |
Definition at line 5868 of file FEProblemBase.C.
Referenced by ComputeMarkerThread::onElement(), FEProblemBase::reinitMaterials(), FEProblemBase::reinitMaterialsBoundary(), FEProblemBase::reinitMaterialsFace(), FEProblemBase::reinitMaterialsInterface(), and FEProblemBase::reinitMaterialsNeighbor().
|
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.
|
virtualinherited |
Returns true if the problem has a Convergence object of the given name.
Definition at line 2597 of file FEProblemBase.C.
Referenced by ParsedConvergence::initializeSymbols().
|
inlineinherited |
Whether or not this system has dampers.
Definition at line 1244 of file FEProblemBase.h.
Referenced by NonlinearSystemBase::preInit(), and NonlinearSystem::solve().
|
inlinevirtualinherited |
Whether or not an exception has occurred.
Definition at line 475 of file FEProblemBase.h.
Referenced by NonlinearSystem::converged(), ThreadedElementLoop< ConstElemPointerRange >::keepGoing(), and ThreadedNodeLoop< ConstBndNodeRange, ConstBndNodeRange::const_iterator >::keepGoing().
|
virtualinherited |
Definition at line 2546 of file FEProblemBase.C.
Referenced by DiffusionCG::addFEBCs(), DiffusionCG::addFEKernels(), DiffusionFV::addFVBCs(), DiffusionFV::addFVKernels(), FunctorIC::FunctorIC(), FEProblemBase::getFunction(), FunctionInterface::hasFunctionByName(), MooseParsedFunctionWrapper::initialize(), ChainControlParsedFunctionWrapper::initializeFunctionInputs(), ParsedConvergence::initializeSymbols(), and MooseParsedFunction::initialSetup().
|
inherited |
checks whether we have a functor corresponding to name
on the thread id tid
Definition at line 1264 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.
|
inlineinherited |
Return a Boolean indicating whether initial AMR is turned on.
Definition at line 1728 of file FEProblemBase.h.
|
inlineinherited |
Return a Boolean indicating whether initial AMR is turned on.
Definition at line 1733 of file FEProblemBase.h.
|
inherited |
Returns _has_jacobian.
Definition at line 8760 of file FEProblemBase.C.
|
inherited |
Whether we have linear convergence objects.
Definition at line 9081 of file FEProblemBase.C.
Referenced by Moose::PetscSupport::petscSetDefaults().
|
virtualinherited |
Whether or not this problem has this linear variable.
Definition at line 802 of file SubProblem.C.
Referenced by SubProblem::getFunctor().
|
inlinevirtualinherited |
Whether the simulation has mortar coupling.
Definition at line 2190 of file FEProblemBase.h.
|
inherited |
Definition at line 5278 of file FEProblemBase.C.
|
inlineinherited |
Returns whether or not the current simulation has any multiapps.
Definition at line 1230 of file FEProblemBase.h.
Referenced by DefaultMultiAppFixedPointConvergence::checkConvergence(), FEProblemBase::checkProblemIntegrity(), DefaultMultiAppFixedPointConvergence::DefaultMultiAppFixedPointConvergence(), FixedPointIterationAdaptiveDT::init(), and DefaultMultiAppFixedPointConvergence::preExecute().
|
inherited |
Definition at line 5272 of file FEProblemBase.C.
|
inlinevirtualinherited |
Whether the simulation has neighbor coupling.
Definition at line 2185 of file FEProblemBase.h.
|
inlineoverridevirtualinherited |
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 2438 of file FEProblemBase.h.
Referenced by DisplacedProblem::hasNonlocalCoupling().
|
inherited |
Deprecated.
Use hasPostprocessorValueByName
Definition at line 4405 of file FEProblemBase.C.
Referenced by GenericFunctorTimeDerivativeMaterialTempl< is_ad >::GenericFunctorTimeDerivativeMaterialTempl().
|
inherited |
Whether or not a Postprocessor value exists by a given name.
name | The name of the Postprocessor |
Note: You should prioritize the use of PostprocessorInterface::hasPostprocessor and PostprocessorInterface::hasPostprocessorByName over this method when possible.
Definition at line 4382 of file FEProblemBase.C.
Referenced by DiffusionCG::addFEBCs(), DiffusionCG::addFEKernels(), DiffusionFV::addFVKernels(), FunctorAux::computeValue(), FunctorExtremaPositions::FunctorExtremaPositions(), FEProblemBase::hasPostprocessor(), MooseParsedFunction::initialSetup(), and FunctorIC::value().
|
overridevirtualinherited |
Returns a Boolean indicating whether any system contains a variable with the name provided.
Implements SubProblem.
Definition at line 5724 of file FEProblemBase.C.
Referenced by FEProblemBase::addInitialCondition(), FEProblemBase::addObjectParamsHelper(), EigenProblem::adjustEigenVector(), FEProblemBase::checkDuplicatePostprocessorVariableNames(), AdvancedOutput::initAvailableLists(), MooseParsedFunctionWrapper::initialize(), ChainControlParsedFunctionWrapper::initializeFunctionInputs(), AdvancedOutput::initShowHideLists(), and Split::setup().
Tells this problem that the assembly associated with the given nonlinear system number involves a scaling vector.
Definition at line 1164 of file SubProblem.C.
Referenced by SystemBase::addScalingVector().
|
inlineinherited |
Returns true if the problem has set the fixed point convergence name.
Definition at line 657 of file FEProblemBase.h.
|
inherited |
Definition at line 5656 of file FEProblemBase.C.
|
inlineinherited |
Returns whether or not this Problem has a TimeIntegrator.
Definition at line 1976 of file FEProblemBase.h.
Referenced by TransientBase::setupTimeIntegrator().
|
inlineinherited |
Whether or not MOOSE will perform a user object/auxiliary kernel state check.
Definition at line 189 of file FEProblemBase.h.
|
inherited |
Check if there if a user object of given name.
name | The name of the user object being checked for |
Definition at line 4369 of file FEProblemBase.C.
Referenced by MFEMProblem::addMFEMFESpaceFromMOOSEVariable(), FEProblemBase::addPostprocessor(), FEProblemBase::addReporter(), FEProblemBase::addVectorPostprocessor(), FunctorAux::computeValue(), DistributedPositions::DistributedPositions(), UserObjectInterface::hasUserObjectByName(), VectorPostprocessorInterface::hasVectorPostprocessorByName(), ReporterTransferInterface::hideVariableHelper(), ParsedDownSelectionPositions::initialize(), and TransformedPositions::TransformedPositions().
|
overridevirtualinherited |
Whether or not this problem has the variable.
Implements SubProblem.
Definition at line 5644 of file FEProblemBase.C.
Referenced by DiffusionCG::addFEBCs(), DiffusionCG::addFEKernels(), FEProblemBase::addFVInitialCondition(), DiffusionFV::addFVKernels(), FEProblemBase::addInitialCondition(), FEProblemBase::addObjectParamsHelper(), MultiAppTransfer::checkVariable(), FunctorIC::FunctorIC(), LazyCoupleable::init(), AdvancedOutput::initAvailableLists(), MooseParsedFunction::initialSetup(), AdvancedOutput::initShowHideLists(), BlockRestrictionDebugOutput::printBlockRestrictionMap(), and Split::setup().
|
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().
|
inlineinherited |
Method for setting whether we have any ad objects.
Definition at line 767 of file SubProblem.h.
|
inlineinherited |
Method for reading wehther we have any ad objects.
Definition at line 771 of file SubProblem.h.
|
overridevirtualinherited |
Method for setting whether we have any ad objects.
Reimplemented from SubProblem.
Definition at line 8837 of file FEProblemBase.C.
|
inlinefinaloverridevirtualinherited |
Whether we have a displaced problem in our simulation.
Implements SubProblem.
Definition at line 2281 of file FEProblemBase.h.
|
inlineoverridevirtualinherited |
returns true if this problem includes/needs finite volume functionality.
Implements SubProblem.
Definition at line 2436 of file FEProblemBase.h.
Referenced by NonlinearSystemBase::checkKernelCoverage(), NonlinearSystemBase::computeJacobianInternal(), ComputeFullJacobianThread::computeOnElement(), NonlinearThread::computeOnElement(), NonlinearSystemBase::computeResidualAndJacobianInternal(), NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::customSetup(), ComputeResidualThread::determineObjectWarehouses(), ComputeResidualAndJacobianThread::determineObjectWarehouses(), DisplacedProblem::haveFV(), FEProblemBase::init(), NonlinearSystemBase::initialSetup(), FEProblemBase::meshChanged(), FEProblemBase::projectSolution(), NonlinearThread::subdomainChanged(), FEProblemBase::swapBackMaterialsNeighbor(), and NonlinearSystemBase::timestepSetup().
|
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().
|
inlineinherited |
Find out whether the current analysis is using XFEM.
Definition at line 1743 of file FEProblemBase.h.
Referenced by FEProblemBase::initialSetup(), FixedPointSolve::solveStep(), TransientBase::takeStep(), and FEProblemBase::updateMeshXFEM().
|
inlineinherited |
Whether to identify variable groups in nonlinear systems.
This affects dof ordering
Definition at line 2443 of file FEProblemBase.h.
Referenced by NonlinearSystemBase::NonlinearSystemBase().
|
inlineinherited |
Will return true if zeros in the Jacobian are to be dropped from the sparsity pattern.
Note that this can make preserving the matrix sparsity pattern impossible.
Definition at line 1948 of file FEProblemBase.h.
Referenced by NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeResidualAndJacobianInternal(), and NonlinearSystemBase::constraintJacobians().
|
inlineinherited |
Whether or not the solution invalid warnings are printed out immediately.
Definition at line 1973 of file FEProblemBase.h.
Referenced by SolutionInvalidInterface::flagInvalidSolutionInternal().
|
inherited |
Advance the MultiApps t_step (incrementStepOrReject) associated with the ExecFlagType.
Definition at line 5463 of file FEProblemBase.C.
Referenced by TransientBase::incrementStepOrReject().
|
overridevirtualinherited |
Reimplemented from FEProblemBase.
Definition at line 86 of file FEProblem.C.
|
inherited |
Initialize stateful properties for elements in a specific elem_range
This is needed when elements/boundary nodes are added to a specific subdomain at an intermediate step.
Definition at line 8206 of file FEProblemBase.C.
Referenced by ActivateElementsUserObjectBase::finalize(), ElementSubdomainModifierBase::initElementStatefulProps(), and FEProblemBase::initialSetup().
|
virtualinherited |
Definition at line 7884 of file FEProblemBase.C.
Referenced by FEProblemBase::initialSetup().
|
overridevirtualinherited |
If this is a restart run, the user may want to override the start time, which we already set in the constructor. "_time" however will have been "restored" from the restart file. We need to honor the original request of the developer now that the restore has been completed.
If we are not recovering but we are doing restart (_app.getExodusFileRestart() == true) with additional uniform refinements. We have to delay the refinement until this point in time so that the equation systems are initialized and projections can be performed.
Reimplemented from SubProblem.
Definition at line 855 of file FEProblemBase.C.
Referenced by Steady::init(), TransientBase::init(), EigenExecutionerBase::init(), Eigenvalue::init(), and MFEMProblem::initialSetup().
|
virtualinherited |
Definition at line 730 of file FEProblemBase.C.
Referenced by EigenProblem::EigenProblem(), and FEProblem::FEProblem().
|
virtualinherited |
Reinitialize PETSc output for proper linear/nonlinear iteration display.
This also may be used for some PETSc-related solver settings
Reimplemented in EigenProblem.
Definition at line 6680 of file FEProblemBase.C.
Referenced by FEProblemBase::possiblyRebuildGeomSearchPatches(), LStableDirk2::solve(), LStableDirk3::solve(), ImplicitMidpoint::solve(), ExplicitTVDRK2::solve(), LStableDirk4::solve(), AStableDirk4::solve(), ExplicitRK2::solve(), and FEProblemBase::solve().
|
inherited |
Create XFEM controller object.
Definition at line 7982 of file FEProblemBase.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(), CreateDisplacedProblemAction::act(), SetAdaptivityOptionsAction::act(), AddVariableAction::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(), 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(), BlockDeletionGenerator::generate(), GeneratedMeshGenerator::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(), ParsedConvergence::initialSetup(), SolutionScalarAux::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(), 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(), FEProblemSolve::solve(), WebServerControl::startServer(), Terminator::Terminator(), TimeIntervalTimes::TimeIntervalTimes(), TimePeriod::TimePeriod(), MultiAppDofCopyTransfer::transfer(), TransformGenerator::TransformGenerator(), FunctorIC::value(), VariableCondensationPreconditioner::VariableCondensationPreconditioner(), VectorMagnitudeFunctorMaterialTempl< is_ad >::VectorMagnitudeFunctorMaterialTempl(), WebServerControl::WebServerControl(), XYDelaunayGenerator::XYDelaunayGenerator(), and XYZDelaunayGenerator::XYZDelaunayGenerator().
|
inlineinherited |
Return a flag to indicate if _snesmf_reuse_base is set by users.
Definition at line 2111 of file FEProblemBase.h.
|
inlineinherited |
Check if the solver system is nonlinear.
Definition at line 2346 of file FEProblemBase.h.
Referenced by FEProblemBase::addBoundaryCondition(), FEProblemBase::addConstraint(), FEProblemBase::addDamper(), FEProblemBase::addDGKernel(), FEProblemBase::addDiracKernel(), FEProblemBase::addHDGKernel(), FEProblemBase::addInterfaceKernel(), FEProblemBase::addKernel(), FEProblemBase::addScalarKernel(), and ConsoleUtils::outputExecutionInformation().
|
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().
|
inlineoverridevirtualinherited |
Implements SubProblem.
Definition at line 525 of file FEProblemBase.h.
Referenced by MFEMProblem::addVariable(), FixedPointSolve::autoAdvance(), FEProblemBase::checkExceptionAndStopSolve(), PhysicsBase::isTransient(), DisplacedProblem::isTransient(), PIDTransientControl::PIDTransientControl(), PseudoTimestep::PseudoTimestep(), TimePeriodBase::TimePeriodBase(), ScalarCoupleable::validateExecutionerType(), and Coupleable::validateExecutionerType().
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 9128 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::jacobianSetup().
|
overridevirtualinherited |
linear_sys_name
Implements SubProblem.
Definition at line 6290 of file FEProblemBase.C.
Referenced by Moose::compute_linear_system(), LinearSystem::computeGradients(), FEProblemBase::computeLinearSystemSys(), LinearSystem::computeLinearSystemTags(), and DisplacedProblem::linearSysNum().
|
virtualinherited |
execute MOOSE line search
Definition at line 2643 of file FEProblemBase.C.
Referenced by ComputeLineSearchObjectWrapper::linesearch().
|
inherited |
Output information about the object just added to the problem.
Definition at line 4168 of file FEProblemBase.C.
Referenced by FEProblemBase::addAuxArrayVariable(), FEProblemBase::addAuxKernel(), FEProblemBase::addAuxScalarKernel(), FEProblemBase::addAuxScalarVariable(), FEProblemBase::addAuxVariable(), FEProblemBase::addConstraint(), FEProblemBase::addDamper(), FEProblemBase::addDGKernel(), FEProblemBase::addDiracKernel(), FEProblemBase::addFunction(), FEProblemBase::addFunctorMaterial(), FEProblemBase::addIndicator(), FEProblemBase::addInitialCondition(), FEProblemBase::addInterfaceKernel(), FEProblemBase::addMarker(), FEProblemBase::addMaterialHelper(), FEProblemBase::addMultiApp(), FEProblemBase::addNodalKernel(), FEProblemBase::addObject(), FEProblemBase::addOutput(), FEProblemBase::addPredictor(), FEProblemBase::addScalarKernel(), FEProblemBase::addTimeIntegrator(), FEProblemBase::addTransfer(), FEProblemBase::addUserObject(), FEProblemBase::addVariable(), and FEProblemBase::setResidualObjectParamsAndLog().
|
protectedinherited |
Mark a variable family for either disabling or enabling p-refinement with valid parameters of a variable.
Definition at line 1361 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().
|
virtualinherited |
Check to see if a particular Tag exists.
Reimplemented in DisplacedProblem.
Definition at line 328 of file SubProblem.C.
Referenced by SystemBase::activeMatrixTag(), SystemBase::addMatrix(), SystemBase::associateMatrixToTag(), Coupleable::coupledMatrixTagValue(), Coupleable::coupledMatrixTagValues(), SystemBase::deactiveMatrixTag(), SystemBase::disassociateDefaultMatrixTags(), SystemBase::disassociateMatrixFromTag(), SystemBase::getMatrix(), SubProblem::getMatrixTagID(), SystemBase::matrixTagActive(), DisplacedProblem::matrixTagExists(), SystemBase::removeMatrix(), and TaggingInterface::useMatrixTag().
|
virtualinherited |
Check to see if a particular Tag exists.
Reimplemented in DisplacedProblem.
Definition at line 336 of file SubProblem.C.
|
virtualinherited |
Retrieve the name associated with a TagID.
Reimplemented in DisplacedProblem.
Definition at line 357 of file SubProblem.C.
Referenced by SystemBase::addMatrix(), DisplacedProblem::matrixTagName(), and SystemBase::removeMatrix().
|
inlineoverridevirtualinherited |
Implements SubProblem.
Reimplemented in MFEMProblem.
Definition at line 151 of file FEProblemBase.h.
Referenced by Adaptivity::adaptMesh(), FEProblemBase::addAnyRedistributers(), MultiAppConservativeTransfer::adjustTransferredSolution(), MultiAppConservativeTransfer::adjustTransferredSolutionNearestPoint(), PhysicsBasedPreconditioner::apply(), MultiAppGeneralFieldNearestLocationTransfer::buildKDTrees(), MultiAppVariableValueSamplePostprocessorTransfer::cacheElemToPostprocessorData(), SampledOutput::cloneMesh(), LinearSystem::computeGradients(), NonlinearSystemBase::computeJacobianInternal(), LinearSystem::computeLinearSystemInternal(), ComputeFullJacobianThread::computeOnInternalFace(), NonlinearSystemBase::computeResidualAndJacobianInternal(), NonlinearSystemBase::computeResidualInternal(), FEProblemBase::coordTransform(), MultiApp::createApp(), DMMooseGetEmbedding_Private(), ElementsAlongLine::ElementsAlongLine(), ElementsAlongPlane::ElementsAlongPlane(), MultiAppVariableValueSampleTransfer::execute(), MultiAppVariableValueSamplePostprocessorTransfer::execute(), ElementsAlongLine::execute(), ElementsAlongPlane::execute(), IntersectionPointsAlongLine::execute(), WorkBalance::execute(), MultiAppUserObjectTransfer::execute(), QuadraturePointMultiApp::fillPositions(), CentroidMultiApp::fillPositions(), MultiAppGeometricInterpolationTransfer::fillSourceInterpolationPoints(), FunctionPeriodicBoundary::FunctionPeriodicBoundary(), MultiApp::getBoundingBox(), Exodus::handleExodusIOMeshRenumbering(), NodePositions::initialize(), FunctorPositions::initialize(), FunctorTimes::initialize(), FunctorExtremaPositions::initialize(), ParsedDownSelectionPositions::initialize(), BlockRestrictable::initializeBlockRestrictable(), BoundaryRestrictable::initializeBoundaryRestrictable(), MultiAppGeneralFieldNearestLocationTransfer::initialSetup(), MultiAppDofCopyTransfer::initialSetup(), PiecewiseConstantFromCSV::initialSetup(), ImageFunction::initialSetup(), FEProblemBase::initialSetup(), MultiAppGeometricInterpolationTransfer::interpolateTargetPoints(), IntersectionPointsAlongLine::IntersectionPointsAlongLine(), Moose::Mortar::loopOverMortarSegments(), ReporterPointMarker::markerSetup(), MFEMProblem::mesh(), FEProblemBase::mesh(), MultiAppGeometricInterpolationTransfer::MultiAppGeometricInterpolationTransfer(), MultiAppUserObjectTransfer::MultiAppUserObjectTransfer(), ComputeNodalUserObjectsThread::onNode(), BoundaryNodeIntegrityCheckThread::onNode(), ComputeInitialConditionThread::operator()(), BoundaryElemIntegrityCheckThread::operator()(), ComputeLinearFVGreenGaussGradientVolumeThread::operator()(), Output::Output(), Exodus::outputEmptyTimestep(), ConsoleUtils::outputMeshInformation(), Exodus::outputNodalVariables(), Exodus::outputSetup(), PiecewiseConstantFromCSV::PiecewiseConstantFromCSV(), SolutionUserObjectBase::pointValueGradientWrapper(), SolutionUserObjectBase::pointValueWrapper(), MeshInfo::possiblyAddSidesetInfo(), MeshInfo::possiblyAddSubdomainInfo(), ComputeLinearFVElementalThread::printBlockExecutionInformation(), ComputeLinearFVFaceThread::printBlockExecutionInformation(), BlockRestrictionDebugOutput::printBlockRestrictionMap(), MaterialPropertyDebugOutput::printMaterialMap(), TopResidualDebugOutput::printTopResiduals(), SolutionUserObjectBase::SolutionUserObjectBase(), FixedPointSolve::solve(), TransientMultiApp::solveStep(), Moose::PetscSupport::storePetscOptions(), MultiAppDofCopyTransfer::transfer(), Checkpoint::updateCheckpointFiles(), and SampledOutput::updateSample().
|
inlineoverridevirtualinherited |
Implements SubProblem.
Reimplemented in MFEMProblem.
Definition at line 152 of file FEProblemBase.h.
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 638 of file FEProblemBase.C.
|
virtualinherited |
Update data after a mesh change.
Iff intermediate_change is true, only perform updates as necessary to prepare for another mesh change immediately-subsequent. An example of data that is not updated during an intermediate change is libMesh System matrix data. An example of data that is updated during an intermediate change is libMesh System vectors. These vectors are projected or restricted based off of adaptive mesh refinement or the changing of element subdomain IDs. The flags contract_mesh
and clean_refinement_flags
should generally only be set to true when the mesh has changed due to mesh refinement. contract_mesh
deletes children of coarsened elements and renumbers nodes and elements. clean_refinement_flags
resets refinement flags such that any subsequent calls to System::restrict_vectors
or System::prolong_vectors
before another AMR step do not mistakenly attempt to re-do the restriction/prolongation which occurred in this method
Definition at line 8037 of file FEProblemBase.C.
Referenced by SidesetAroundSubdomainUpdater::finalize(), ActivateElementsUserObjectBase::finalize(), Exodus::handleExodusIOMeshRenumbering(), ElementSubdomainModifierBase::modify(), and Adaptivity::uniformRefineWithProjection().
|
inlineprotectedvirtualinherited |
Deprecated.
Users should switch to overriding the meshChanged which takes arguments
Definition at line 2471 of file FEProblemBase.h.
Referenced by FEProblemBase::adaptMesh(), FEProblemBase::initialAdaptMesh(), FEProblemBase::meshChanged(), FEProblemBase::timestepSetup(), FEProblemBase::uniformRefine(), and FEProblemBase::updateMeshXFEM().
|
protectedvirtualinherited |
Update data after a mesh displaced.
Definition at line 8199 of file FEProblemBase.C.
Referenced by DisplacedProblem::updateMesh().
|
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(), CreateExecutionerAction::act(), AddICAction::act(), AddBoundsVectorsAction::act(), AddVectorPostprocessorAction::act(), AutoCheckpointAction::act(), CheckFVBCAction::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(), 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(), 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(), ExplicitEuler::computeTimeDerivatives(), ImplicitEuler::computeTimeDerivatives(), ActuallyExplicitEuler::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(), 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(), 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(), MultiAppPostprocessorToAuxScalarTransfer::execute(), NodalValueSampler::execute(), MultiAppScalarToAuxScalarTransfer::execute(), MultiAppPostprocessorInterpolationTransfer::execute(), MultiAppPostprocessorTransfer::execute(), ElementQualityChecker::execute(), PositionsFunctorValueSampler::execute(), GreaterThanLessThanPostprocessor::execute(), PointValue::execute(), MultiAppVariableValueSampleTransfer::execute(), MultiAppVariableValueSamplePostprocessorTransfer::execute(), FindValueOnLine::execute(), MultiAppNearestNodeTransfer::execute(), MultiAppMFEMCopyTransfer::execute(), MultiAppCopyTransfer::execute(), WebServerControl::execute(), InterfaceQpUserObjectBase::execute(), MultiAppGeometricInterpolationTransfer::execute(), MultiAppUserObjectTransfer::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(), ExtraNodesetGenerator::generate(), FileMeshGenerator::generate(), LowerDBlockFromSidesetGenerator::generate(), MoveNodeGenerator::generate(), PlaneIDMeshGenerator::generate(), RenameBlockGenerator::generate(), RenameBoundaryGenerator::generate(), SideSetsFromNormalsGenerator::generate(), SmoothMeshGenerator::generate(), SubdomainPerElementGenerator::generate(), TiledMeshGenerator::generate(), MeshDiagnosticsGenerator::generate(), BreakMeshByBlockGenerator::generate(), CoarsenBlockGenerator::generate(), FlipSidesetGenerator::generate(), GeneratedMeshGenerator::generate(), MeshRepairGenerator::generate(), SideSetsFromPointsGenerator::generate(), CombinerGenerator::generate(), AllSideSetsByNormalsGenerator::generate(), MeshExtruderGenerator::generate(), AdvancedExtruderGenerator::generate(), MeshCollectionGenerator::generate(), ParsedGenerateNodeset::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(), DisplacedProblem::getActualFieldVariable(), FEProblemBase::getActualFieldVariable(), DisplacedProblem::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(), AnnularMesh::getMaxInDimension(), GeneratedMesh::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(), DisplacedProblem::getScalarVariable(), FEProblemBase::getScalarVariable(), MooseObject::getSharedPtr(), InterfaceQpUserObjectBase::getSideAverageValue(), PhysicsBase::getSolverSystem(), DisplacedProblem::getStandardVariable(), FEProblemBase::getStandardVariable(), MooseMesh::getSubdomainBoundaryIds(), TimedSubdomainModifier::getSubdomainIDAndCheck(), DisplacedProblem::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(), DisplacedProblem::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(), TransientBase::init(), FEProblem::init(), AddAuxVariableAction::init(), IterationAdaptiveDT::init(), Eigenvalue::init(), AddVariableAction::init(), MooseMesh::init(), Sampler::init(), FEProblemBase::init(), MultiApp::init(), FEProblemBase::initialAdaptMesh(), NestedDivision::initialize(), ReporterPositions::initialize(), DistributedPositions::initialize(), TransformedPositions::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(), IntegralPreservingFunctionIC::initialSetup(), MultiAppConservativeTransfer::initialSetup(), FullSolveMultiApp::initialSetup(), PiecewiseLinear::initialSetup(), CoarsenedPiecewiseLinear::initialSetup(), LinearFVDiffusion::initialSetup(), LinearFVAnisotropicDiffusion::initialSetup(), MultiAppDofCopyTransfer::initialSetup(), SolutionScalarAux::initialSetup(), LinearFVAdvection::initialSetup(), MultiAppGeneralFieldNearestLocationTransfer::initialSetup(), SolutionAux::initialSetup(), ExplicitTimeIntegrator::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(), 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(), DisplacedProblem::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(), MFEMHypreAMS::updateSolver(), MFEMHypreADS::updateSolver(), MFEMCGSolver::updateSolver(), MFEMOperatorJacobiSmoother::updateSolver(), MFEMHypreBoomerAMG::updateSolver(), MFEMHypreFGMRES::updateSolver(), MFEMGMRESSolver::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(), 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(), and SymmetryTransformGenerator::SymmetryTransformGenerator().
|
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.
|
inlineinherited |
|
inlineinherited |
Definition at line 2180 of file FEProblemBase.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(), DisplacedProblem::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(), DisplacedProblem::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(), DefaultNonlinearConvergence::checkConvergence(), ParsedConvergence::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(), 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(), BreakMeshByBlockGenerator::generate(), GeneratedMeshGenerator::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(), 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(), TransientBase::getTimeStepperName(), ProjectedStatefulMaterialStorageAction::getTypeEnum(), FEProblemBase::getUserObject(), FEProblemBase::getUserObjectBase(), MFEMGeneralUserObject::getVectorCoefficient(), 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(), MooseApp::MooseApp(), 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().
|
inherited |
These methods are used to determine whether stateful material properties need to be stored on internal sides.
There are five situations where this may be the case: 1) DGKernels 2) IntegratedBCs 3)InternalSideUserObjects 4)ElementalAuxBCs 5)InterfaceUserObjects
Method 1:
bnd_id | the boundary id for which to see if stateful material properties need to be stored |
tid | the THREAD_ID of the caller |
Method 2:
subdomain_id | the subdomain id for which to see if stateful material properties need to be stored |
tid | the THREAD_ID of the caller |
Definition at line 8647 of file FEProblemBase.C.
Referenced by ComputeMaterialsObjectThread::onBoundary(), and ProjectMaterialProperties::onBoundary().
|
inlineoverridevirtualinherited |
marks this problem as including/needing finite volume functionality.
Implements SubProblem.
Definition at line 2435 of file FEProblemBase.h.
Referenced by DiffusionFV::initializePhysicsAdditional(), and DisplacedProblem::needFV().
|
inherited |
Definition at line 8683 of file FEProblemBase.C.
Referenced by ComputeMaterialsObjectThread::onInterface().
|
inherited |
Declare that we need up to old (1) or older (2) solution states for a given type of iteration.
oldest_needed | oldest solution state needed |
iteration_type | the type of iteration for which old/older states are needed |
Definition at line 704 of file FEProblemBase.C.
Referenced by FEProblemBase::createTagSolutions().
|
inherited |
Set a flag that indicated that user required values for the previous Newton iterate.
Definition at line 8752 of file FEProblemBase.C.
Referenced by Coupleable::coupledGradientPreviousNL(), Coupleable::coupledNodalValuePreviousNL(), Coupleable::coupledSecondPreviousNL(), Coupleable::coupledValuePreviousNL(), and NonlinearSystem::solve().
|
inherited |
Check to see whether we need to compute the variable values of the previous Newton iterate.
Definition at line 8746 of file FEProblemBase.C.
|
inherited |
Definition at line 8717 of file FEProblemBase.C.
Referenced by ComputeMaterialsObjectThread::subdomainChanged(), and ProjectMaterialProperties::subdomainChanged().
|
inlineinherited |
Returns true if the problem needs to add the default fixed point convergence.
Definition at line 642 of file FEProblemBase.h.
|
inlineinherited |
Returns true if the problem needs to add the default nonlinear convergence.
Definition at line 637 of file FEProblemBase.h.
|
virtualinherited |
Definition at line 2477 of file FEProblemBase.C.
Referenced by ThreadedFaceLoop< RangeType >::neighborSubdomainChanged().
|
virtualinherited |
Definition at line 716 of file FEProblemBase.C.
Referenced by DumpObjectsProblem::DumpObjectsProblem(), EigenProblem::EigenProblem(), ExternalProblem::ExternalProblem(), and FEProblem::FEProblem().
|
virtualinherited |
nl_sys_num
is converged. Reimplemented in MFEMProblem.
Definition at line 716 of file SubProblem.C.
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 6548 of file FEProblemBase.C.
Referenced by PiecewiseLinearFromVectorPostprocessor::valueInternal().
|
overridevirtualinherited |
nl_sys_name
Implements SubProblem.
Definition at line 6279 of file FEProblemBase.C.
Referenced by DisplacedProblem::nlSysNum().
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 6542 of file FEProblemBase.C.
Referenced by PiecewiseLinearFromVectorPostprocessor::valueInternal().
|
inherited |
Definition at line 6136 of file FEProblemBase.C.
Referenced by ComputeFullJacobianThread::computeOnBoundary(), and ComputeFullJacobianThread::computeOnElement().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 9364 of file FEProblemBase.C.
Referenced by DisplacedProblem::nonlocalCouplingMatrix().
|
inherited |
Register an object that derives from MeshChangedInterface to be notified when the mesh changes.
Definition at line 8187 of file FEProblemBase.C.
Referenced by MeshChangedInterface::MeshChangedInterface().
|
inherited |
Register an object that derives from MeshDisplacedInterface to be notified when the displaced mesh gets updated.
Definition at line 8193 of file FEProblemBase.C.
Referenced by MeshDisplacedInterface::MeshDisplacedInterface().
Set the number of steps in a grid sequences.
Definition at line 2201 of file FEProblemBase.h.
Referenced by FEProblemSolve::FEProblemSolve().
|
inlineoverridevirtualinherited |
Implements SubProblem.
Definition at line 2341 of file FEProblemBase.h.
Referenced by IterationAdaptiveDT::acceptStep(), FEProblemBase::addPredictor(), IterationAdaptiveDT::computeAdaptiveDT(), FEProblemSolve::FEProblemSolve(), EigenProblem::init(), Console::meshChanged(), DisplacedProblem::numLinearSystems(), Console::outputSystemInformation(), Moose::PetscSupport::petscSetDefaults(), and FEProblemBase::setLinearConvergenceNames().
|
inlinevirtualinherited |
The total number of tags.
Reimplemented in DisplacedProblem.
Definition at line 248 of file SubProblem.h.
Referenced by SystemBase::activeAllMatrixTags(), NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeScalarKernelsJacobians(), SystemBase::deactiveAllMatrixTags(), ComputeJacobianThread::determineObjectWarehouses(), ComputeResidualAndJacobianThread::determineObjectWarehouses(), Assembly::init(), MooseVariableDataBase< OutputType >::MooseVariableDataBase(), MooseVariableScalar::MooseVariableScalar(), DisplacedProblem::numMatrixTags(), ComputeNodalKernelBCJacobiansThread::pre(), ComputeNodalKernelJacobiansThread::pre(), and ComputeDiracThread::subdomainChanged().
|
inlineoverridevirtualinherited |
Implements SubProblem.
Definition at line 2339 of file FEProblemBase.h.
Referenced by IterationAdaptiveDT::acceptStep(), FEProblemBase::addPredictor(), DisplacedProblem::addTimeIntegrator(), DisplacedProblem::DisplacedProblem(), Executioner::Executioner(), EigenProblem::init(), FEProblemBase::jacobianSetup(), PNGOutput::makeMeshFunc(), Console::meshChanged(), DisplacedProblem::numNonlinearSystems(), ComputeBoundaryInitialConditionThread::onNode(), BoundaryElemIntegrityCheckThread::operator()(), ConsoleUtils::outputExecutionInformation(), Console::outputSystemInformation(), Moose::PetscSupport::petscSetDefaults(), ReferenceResidualConvergence::ReferenceResidualConvergence(), FEProblemBase::residualSetup(), Moose::SlepcSupport::setEigenProblemSolverParams(), Moose::PetscSupport::setLineSearchFromParams(), Moose::PetscSupport::setMFFDTypeFromParams(), FEProblemBase::setNonlinearConvergenceNames(), Moose::PetscSupport::setSolveTypeFromParams(), FEProblemSolve::solve(), FEProblemBase::solveLinearSystem(), Moose::SlepcSupport::storeSolveType(), and Console::writeVariableNorms().
|
inlineoverridevirtualinherited |
Implements SubProblem.
Definition at line 2343 of file FEProblemBase.h.
Referenced by ElementSubdomainModifierBase::applyIC(), MooseMesh::cacheFaceInfoVariableOwnership(), MooseMesh::cacheFVElementalDoFs(), Eigenvalue::Eigenvalue(), FEProblemBase::FEProblemBase(), TransientBase::getTimeIntegratorNames(), DisplacedProblem::numSolverSystems(), ConsoleUtils::outputExecutionInformation(), Moose::PetscSupport::petscSetDefaultKSPNormType(), Moose::PetscSupport::petscSetDefaultPCSide(), and FEProblemBase::solverParams().
|
virtualinherited |
The total number of tags, which can be limited to the tag type.
Reimplemented in DisplacedProblem.
Definition at line 195 of file SubProblem.C.
Referenced by NonlinearSystemBase::computeNodalBCs(), NonlinearSystemBase::computeResidualInternal(), ComputeResidualThread::determineObjectWarehouses(), MooseVariableDataBase< OutputType >::MooseVariableDataBase(), MooseVariableScalar::MooseVariableScalar(), DisplacedProblem::numVectorTags(), ComputeNodalKernelBcsThread::pre(), and ComputeNodalKernelsThread::pre().
|
staticinherited |
Definition at line 3101 of file FEProblemBase.h.
|
staticinherited |
Helpers for calling the necessary setup/execute functions for the supplied objects.
Definition at line 3067 of file FEProblemBase.h.
|
inlineoverridevirtual |
Returns true if an error will result if the user supplies 'nonlinear_convergence'.
Some problems are strongly tied to their convergence, and it does not make sense to use any convergence other than their default and additionally would be error-prone.
Reimplemented from FEProblemBase.
Definition at line 27 of file ReferenceResidualProblem.h.
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 6687 of file FEProblemBase.C.
Referenced by TransientBase::takeStep().
|
overridevirtualinherited |
Implements SubProblem.
Reimplemented in DumpObjectsProblem.
Definition at line 6696 of file FEProblemBase.C.
Referenced by NonlinearEigen::init(), EigenExecutionerBase::init(), FixedPointSolve::solveStep(), InversePowerMethod::takeStep(), and NonlinearEigen::takeStep().
|
virtualinherited |
Output the current step.
Will ensure that everything is in the proper state to be outputted. Then tell the OutputWarehouse to do its thing
type | The type execution flag (see Moose.h) |
Reimplemented in DumpObjectsProblem.
Definition at line 6650 of file FEProblemBase.C.
Referenced by TransientBase::endStep(), MFEMSteady::execute(), MFEMTransient::execute(), TransientBase::execute(), SteadyBase::execute(), Eigenvalue::execute(), NonlinearEigen::init(), InversePowerMethod::init(), EigenExecutionerBase::postExecute(), TransientBase::preExecute(), FixedPointSolve::solve(), TransientMultiApp::solveStep(), FixedPointSolve::solveStep(), and MFEMTransient::step().
|
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(), ElementsToTetrahedronsConverter::generate(), AddMetaDataGenerator::generate(), BlockToMeshConverterGenerator::generate(), FillBetweenCurvesGenerator::generate(), FillBetweenSidesetsGenerator::generate(), LowerDBlockFromSidesetGenerator::generate(), PlaneIDMeshGenerator::generate(), BreakBoundaryOnSubdomainGenerator::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(), CutMeshByLevelSetGeneratorBase::generate(), XYDelaunayGenerator::generate(), XYMeshLineCutter::generate(), PatternedMeshGenerator::generate(), SubdomainBoundingBoxGenerator::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(), 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(), SecondTimeDerivativeAux::SecondTimeDerivativeAux(), FEProblemBase::setLinearConvergenceNames(), FEProblemBase::setNonlinearConvergenceNames(), MooseMesh::setPartitioner(), NodeSetsGeneratorBase::setup(), SideSetsGeneratorBase::setup(), NEML2Action::setupDerivativeMappings(), NEML2Action::setupParameterDerivativeMappings(), TimeSequenceStepperBase::setupSequence(), SidesetAroundSubdomainUpdater::SidesetAroundSubdomainUpdater(), SideSetsFromBoundingBoxGenerator::SideSetsFromBoundingBoxGenerator(), 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(), DisplacedProblem::addAuxVariable(), MFEMProblem::addBoundaryCondition(), FEProblemBase::addBoundaryCondition(), FEProblemBase::addConstraint(), FEProblemBase::addConvergence(), FEProblemBase::addDamper(), AddDefaultConvergenceAction::addDefaultMultiAppFixedPointConvergence(), FEProblemBase::addDefaultMultiAppFixedPointConvergence(), addDefaultNonlinearConvergence(), AddDefaultConvergenceAction::addDefaultNonlinearConvergence(), FEProblemBase::addDefaultNonlinearConvergence(), 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(), DisplacedProblem::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(), 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(), 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 |
Calls parentOutputPositionChanged() on all sub apps.
Definition at line 4439 of file FEProblemBase.C.
Referenced by TransientBase::parentOutputPositionChanged().
|
inherited |
Get the PerfGraph.
Definition at line 78 of file PerfGraphInterface.C.
Referenced by CommonOutputAction::act(), PerfGraphData::finalize(), and PerfGraphOutput::output().
|
inlineinherited |
Definition at line 2119 of file FEProblemBase.h.
Referenced by Eigenvalue::prepareSolverOptions().
|
inlineinherited |
If PETSc options are already inserted.
Definition at line 2116 of file FEProblemBase.h.
Referenced by Eigenvalue::prepareSolverOptions().
|
virtualinherited |
Definition at line 7822 of file FEProblemBase.C.
Referenced by FEProblemBase::solve().
|
virtualinherited |
Method called at the end of the simulation.
Definition at line 5454 of file FEProblemBase.C.
Referenced by MFEMSteady::execute(), MFEMTransient::execute(), TransientBase::execute(), SteadyBase::execute(), and Eigenvalue::execute().
|
virtualinherited |
Perform cleanup tasks after application of predictor to solution vector.
ghosted_solution | Ghosted solution vector |
Definition at line 7729 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::setInitialSolution().
|
overridevirtualinherited |
Implements SubProblem.
Referenced by NodalPatchRecovery::compute(), ComputeMarkerThread::onElement(), ComputeElemDampingThread::onElement(), ComputeMaterialsObjectThread::onElement(), ComputeIndicatorThread::onElement(), ComputeUserObjectsThread::onElement(), and ComputeInitialConditionThread::operator()().
|
overridevirtualinherited |
Implements SubProblem.
Implements SubProblem.
Definition at line 1801 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::constraintJacobians(), NonlinearSystemBase::constraintResiduals(), NonlinearSystemBase::reinitNodeFace(), and NonlinearSystemBase::setConstraintSecondaryValues().
Implements SubProblem.
Definition at line 1715 of file FEProblemBase.C.
Referenced by ComputeUserObjectsThread::onInterface(), and ComputeUserObjectsThread::onInternalSide().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 2060 of file FEProblemBase.C.
Referenced by ComputeUserObjectsThread::onBoundary().
|
inherited |
Add the MooseVariables and the material properties that the current materials depend on to the dependency list.
consumer_needed_mat_props | The material properties needed by consumer objects (other than the materials themselves) |
blk_id | The subdomain ID for which we are preparing our list of needed vars and props |
tid | The thread ID we are preparing the requirements for |
This MUST be done after the moose variable dependency list has been set for all the other objects using the setActiveElementalMooseVariables
API!
Definition at line 3950 of file FEProblemBase.C.
Referenced by ComputeMarkerThread::subdomainChanged(), ComputeIndicatorThread::subdomainChanged(), NonlinearThread::subdomainChanged(), and ComputeUserObjectsThread::subdomainChanged().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 2066 of file FEProblemBase.C.
|
inherited |
Prepare DofMap
and Assembly
classes with our p-refinement information.
Definition at line 1326 of file SubProblem.C.
Referenced by FEProblemBase::init().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 2054 of file FEProblemBase.C.
Referenced by ComputeUserObjectsThread::onElement().
|
inlineinherited |
Will return True if the executioner in use requires preserving the sparsity pattern of the matrices being formed during the solve.
This is usually the Jacobian.
Definition at line 1937 of file FEProblemBase.h.
|
inherited |
Project initial conditions for custom elem_range
and bnd_node_range
This is needed when elements/boundary nodes are added to a specific subdomain at an intermediate step.
Definition at line 3674 of file FEProblemBase.C.
Referenced by ElementSubdomainModifierBase::applyIC(), and ActivateElementsUserObjectBase::initSolutions().
|
inherited |
Definition at line 3606 of file FEProblemBase.C.
Referenced by FEProblemBase::initialAdaptMesh(), and FEProblemBase::initialSetup().
|
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.
|
inherited |
Definition at line 8637 of file FEProblemBase.C.
Referenced by RandomInterface::setRandomResetFrequency().
|
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.
|
protectedinherited |
Call when it is possible that the needs for ghosted elements has changed.
mortar_changed | Whether an update of mortar data has been requested since the last EquationSystems (re)initialization |
Definition at line 5089 of file FEProblemBase.C.
Referenced by FEProblemBase::initialSetup(), FEProblemBase::meshChanged(), and FEProblemBase::possiblyRebuildGeomSearchPatches().
Returns true if the Problem has Dirac kernels it needs to compute on elem.
The maximum number of qps can rise if several Dirac points are added to a single element. In that case we need to resize the zeros to compensate.
Implements SubProblem.
Definition at line 2105 of file FEProblemBase.C.
Referenced by ComputeDiracThread::onElement().
Implements SubProblem.
Definition at line 2160 of file FEProblemBase.C.
Referenced by NodalPatchRecovery::compute(), ComputeMarkerThread::onElement(), ComputeElemDampingThread::onElement(), ComputeIndicatorThread::onElement(), ComputeMaterialsObjectThread::onElement(), ComputeUserObjectsThread::onElement(), ComputeInitialConditionThread::operator()(), FEProblemBase::reinitDirac(), and FEProblemBase::reinitElemPhys().
|
inherited |
|
overridevirtualinherited |
Implements SubProblem.
|
overridevirtualinherited |
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 from SubProblem.
Definition at line 8964 of file FEProblemBase.C.
Referenced by Moose::Mortar::loopOverMortarSegments().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 2346 of file FEProblemBase.C.
Referenced by ComputeMaterialsObjectThread::onInternalSide(), and NonlinearThread::onInternalSide().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 2171 of file FEProblemBase.C.
Referenced by MultiAppVariableValueSamplePostprocessorTransfer::execute().
reinitialize the finite volume assembly data for the provided face and thread
Definition at line 1278 of file SubProblem.C.
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 2219 of file FEProblemBase.C.
Referenced by ComputeUserObjectsThread::onBoundary(), NonlinearThread::prepareFace(), and FEProblemBase::reinitElemNeighborAndLowerD().
|
inherited |
Definition at line 3981 of file FEProblemBase.C.
Referenced by NodalPatchRecovery::compute(), ComputeMarkerThread::onElement(), ComputeIndicatorThread::onElement(), ComputeDiracThread::onElement(), and ComputeUserObjectsThread::onElement().
|
inherited |
reinit materials on a boundary
boundary_id | The boundary on which to reinit corresponding materials |
tid | The thread id |
swap_stateful | Whether to swap stateful material properties between MaterialData and MaterialPropertyStorage |
execute_stateful | Whether to execute material objects that have stateful properties. This should be false when for example executing material objects for mortar contexts in which stateful properties don't make sense |
Definition at line 4074 of file FEProblemBase.C.
Referenced by Moose::Mortar::loopOverMortarSegments(), ComputeUserObjectsThread::onBoundary(), NonlinearThread::onInterface(), ComputeUserObjectsThread::onInterface(), and NonlinearThread::prepareFace().
|
inherited |
reinit materials on element faces
blk_id | The subdomain on which the element owning the face lives |
tid | The thread id |
swap_stateful | Whether to swap stateful material properties between MaterialData and MaterialPropertyStorage |
execute_stateful | Whether to execute material objects that have stateful properties. This should be false when for example executing material objects for mortar contexts in which stateful properties don't make sense |
Definition at line 4004 of file FEProblemBase.C.
Referenced by Moose::Mortar::loopOverMortarSegments(), ComputeUserObjectsThread::onBoundary(), NonlinearThread::onInterface(), ComputeUserObjectsThread::onInterface(), ComputeIndicatorThread::onInternalSide(), NonlinearThread::onInternalSide(), ComputeUserObjectsThread::onInternalSide(), and NonlinearThread::prepareFace().
|
inherited |
Definition at line 4102 of file FEProblemBase.C.
Referenced by NonlinearThread::onInterface(), and ComputeUserObjectsThread::onInterface().
|
inherited |
reinit materials on the neighboring element face
blk_id | The subdomain on which the neighbor element lives |
tid | The thread id |
swap_stateful | Whether to swap stateful material properties between MaterialData and MaterialPropertyStorage |
execute_stateful | Whether to execute material objects that have stateful properties. This should be false when for example executing material objects for mortar contexts in which stateful properties don't make sense |
Definition at line 4034 of file FEProblemBase.C.
Referenced by Moose::Mortar::loopOverMortarSegments(), NonlinearThread::onInterface(), ComputeUserObjectsThread::onInterface(), ComputeIndicatorThread::onInternalSide(), NonlinearThread::onInternalSide(), ComputeUserObjectsThread::onInternalSide(), and NonlinearSystemBase::reinitNodeFace().
Reinit a mortar element to obtain a valid JxW.
Definition at line 994 of file SubProblem.C.
Referenced by Moose::Mortar::loopOverMortarSegments().
|
inherited |
Call reinit
on mortar user objects with matching primary boundary ID, secondary boundary ID, and displacement characteristics.
Definition at line 9214 of file FEProblemBase.C.
Referenced by Moose::Mortar::loopOverMortarSegments().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 2307 of file FEProblemBase.C.
Referenced by ComputeMaterialsObjectThread::onInterface(), NonlinearThread::onInterface(), ComputeUserObjectsThread::onInterface(), ComputeIndicatorThread::onInternalSide(), ComputeUserObjectsThread::onInternalSide(), and FEProblemBase::reinitElemNeighborAndLowerD().
|
overridevirtualinherited |
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 from SubProblem.
Definition at line 8979 of file FEProblemBase.C.
Referenced by Moose::Mortar::loopOverMortarSegments().
reinitialize a neighboring lower dimensional element
Definition at line 987 of file SubProblem.C.
Referenced by Moose::Mortar::loopOverMortarSegments().
|
overridevirtualinherited |
Implements SubProblem.
Referenced by NonlinearSystemBase::reinitNodeFace().
|
overridevirtualinherited |
Implements SubProblem.
Implements SubProblem.
Definition at line 2232 of file FEProblemBase.C.
Referenced by NodalPatchRecovery::compute(), NonlinearSystemBase::computeResidualInternal(), ComputeNodalUserObjectsThread::onNode(), ComputeNodalDampingThread::onNode(), ComputeNodalKernelsThread::onNode(), and ComputeNodalKernelJacobiansThread::onNode().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 2246 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::computeJacobianBlocks(), NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeNodalBCs(), NonlinearSystemBase::computeNodalBCsResidualAndJacobian(), NonlinearSystemBase::constraintJacobians(), NonlinearSystemBase::constraintResiduals(), ComputeNodalKernelBcsThread::onNode(), ComputeNodalKernelBCJacobiansThread::onNode(), NonlinearSystemBase::reinitNodeFace(), NonlinearSystemBase::setConstraintSecondaryValues(), and NonlinearSystemBase::setInitialSolution().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 2260 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::enforceNodalConstraintsJacobian(), and NonlinearSystemBase::enforceNodalConstraintsResidual().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 2271 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::enforceNodalConstraintsJacobian(), and NonlinearSystemBase::enforceNodalConstraintsResidual().
Implements SubProblem.
Definition at line 2299 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::computeScalarKernelsJacobians(), NonlinearSystemBase::constraintJacobians(), and NonlinearThread::onElement().
|
overridevirtualinherited |
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 2282 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::computeJacobianBlocks(), NonlinearSystemBase::computeJacobianInternal(), FEProblemBase::computeJacobianTags(), FEProblemBase::computeResidualAndJacobian(), NonlinearSystemBase::computeResidualAndJacobianInternal(), NonlinearSystemBase::computeResidualInternal(), FEProblemBase::computeResidualTags(), NonlinearSystemBase::computeScalarKernelsJacobians(), AuxiliarySystem::computeScalarVars(), and FEProblemBase::initialSetup().
|
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 1107 of file SubProblem.C.
|
inherited |
Register a MOOSE object dependency so we can either order operations properly or report when we cannot.
a -> b (a depends on b)
Definition at line 5083 of file FEProblemBase.C.
|
inlineinherited |
Tell the problem that the nonlinear convergence check(s) may proceed as normal.
Definition at line 2384 of file FEProblemBase.h.
Referenced by Moose::PetscSupport::petscNonlinearConverged().
|
inlineinherited |
Tell the problem that the system convergence check(s) may proceed as normal.
Definition at line 2386 of file FEProblemBase.h.
Referenced by Moose::PetscSupport::petscLinearConverged(), and FEProblemBase::resetFailNextNonlinearConvergenceCheck().
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 9114 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::residualSetup().
|
inherited |
Resize material data.
data_type | The type of material data to resize |
nqp | The number of quadrature points to resize for |
tid | The thread ID |
Definition at line 9050 of file FEProblemBase.C.
|
protectedinherited |
Gets the name of a piece of restartable data given a data name, adding the system name and object name prefix.
This should only be used in this interface and in testing.
Definition at line 66 of file Restartable.C.
Referenced by Restartable::declareRecoverableData(), and Restartable::declareRestartableDataHelper().
|
inherited |
Restore the MultiApps associated with the ExecFlagType.
force | Force restoration because something went wrong with the solve |
Definition at line 5519 of file FEProblemBase.C.
Referenced by TransientBase::incrementStepOrReject(), and FixedPointSolve::solve().
|
virtualinherited |
Restore old solutions from the backup vectors and deallocate them.
Definition at line 6640 of file FEProblemBase.C.
Referenced by EigenExecutionerBase::inversePowerIteration().
|
inlineinherited |
Definition at line 1917 of file FEProblemBase.h.
Referenced by NonlinearSystemBase::computeJacobianInternal().
|
virtualinherited |
Definition at line 6606 of file FEProblemBase.C.
Referenced by ActivateElementsUserObjectBase::initSolutions(), TimeStepper::rejectStep(), and FEProblemBase::updateMeshXFEM().
|
inlinevirtualinherited |
Is it safe to access the tagged matrices.
Reimplemented in DisplacedProblem.
Definition at line 731 of file SubProblem.h.
Referenced by MooseVariableScalar::reinit(), and DisplacedProblem::safeAccessTaggedMatrices().
|
inlinevirtualinherited |
Is it safe to access the tagged vectors.
Reimplemented in DisplacedProblem.
Definition at line 734 of file SubProblem.h.
Referenced by MooseVariableScalar::reinit(), and DisplacedProblem::safeAccessTaggedVectors().
|
virtualinherited |
Allocate vectors and save old solutions into them.
Definition at line 6630 of file FEProblemBase.C.
Referenced by EigenExecutionerBase::inversePowerIteration().
|
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().
|
overridevirtualinherited |
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 from SubProblem.
Definition at line 5798 of file FEProblemBase.C.
Referenced by FEProblemBase::prepareMaterials(), ComputeMarkerThread::subdomainChanged(), ComputeMaterialsObjectThread::subdomainChanged(), ComputeIndicatorThread::subdomainChanged(), ComputeDiracThread::subdomainChanged(), NonlinearThread::subdomainChanged(), and ComputeUserObjectsThread::subdomainChanged().
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 5760 of file FEProblemBase.C.
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 5769 of file FEProblemBase.C.
Referenced by MultiAppVariableValueSamplePostprocessorTransfer::execute(), ComputeNodalKernelBcsThread::onNode(), ComputeNodalKernelsThread::onNode(), ComputeNodalUserObjectsThread::subdomainChanged(), ComputeMaterialsObjectThread::subdomainChanged(), ComputeIndicatorThread::subdomainChanged(), NonlinearThread::subdomainChanged(), and ComputeUserObjectsThread::subdomainChanged().
|
inherited |
Record and set the material properties required by the current computing thread.
mat_prop_ids | The set of material properties required by the current computing thread. |
tid | The thread id |
Definition at line 5853 of file FEProblemBase.C.
Referenced by Moose::Mortar::loopOverMortarSegments(), FEProblemBase::prepareMaterials(), NodalPatchRecovery::reinitPatch(), NonlinearSystemBase::setConstraintSecondaryValues(), and ComputeDiracThread::subdomainChanged().
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 5778 of file FEProblemBase.C.
Referenced by AuxiliarySystem::setScalarVariableCoupleableTags().
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 5788 of file FEProblemBase.C.
Referenced by AuxiliarySystem::setScalarVariableCoupleableTags().
Definition at line 815 of file FEProblemBase.C.
Referenced by FEProblemBase::FEProblemBase().
|
inlineinherited |
Set flag that Jacobian is constant (for optimization purposes)
state | True if the Jacobian is constant, false otherwise |
Definition at line 1796 of file FEProblemBase.h.
Referenced by ExplicitEuler::preSolve(), ExplicitTVDRK2::preSolve(), and ExplicitRK2::preSolve().
|
inherited |
Definition at line 807 of file FEProblemBase.C.
Referenced by FEProblemBase::FEProblemBase().
|
inherited |
Set the coupling between variables TODO: allow user-defined coupling.
type | Type of coupling |
Definition at line 6029 of file FEProblemBase.C.
Referenced by FEProblemBase::init(), FEProblemBase::setCouplingMatrix(), and Moose::SlepcSupport::setEigenProblemSolverParams().
|
inherited |
Set custom coupling matrix.
cm | coupling matrix to be set |
nl_sys_num | which nonlinear system we are setting the coupling matrix for |
Definition at line 6053 of file FEProblemBase.C.
Referenced by MoosePreconditioner::setCouplingMatrix().
|
inherited |
Definition at line 6045 of file FEProblemBase.C.
|
inherited |
Definition at line 9331 of file FEProblemBase.C.
|
inherited |
These functions allow setting custom ranges for the algebraic elements, nodes, and boundary nodes that contribute to the jacobian and residual for this local processor.
setCurrentAlgebraicElementRange() sets the element range that contributes to the system. A nullptr will reset the range to use the mesh's range.
setCurrentAlgebraicNodeRange() sets the node range that contributes to the system. A nullptr will reset the range to use the mesh's range.
setCurrentAlgebraicBndNodeRange() sets the boundary node range that contributes to the system. A nullptr will reset the range to use the mesh's range.
range | A pointer to the const range object representing the algebraic elements, nodes, or boundary nodes. |
Definition at line 9309 of file FEProblemBase.C.
|
inherited |
Definition at line 9320 of file FEProblemBase.C.
|
overridevirtualinherited |
sets the current boundary ID in assembly
Reimplemented from SubProblem.
Definition at line 9245 of file FEProblemBase.C.
|
inherited |
Definition at line 4538 of file FEProblemBase.C.
Referenced by FEProblemBase::execute(), FEProblemBase::initialSetup(), and FEProblemBase::outputStep().
Set the current linear system pointer.
sys_num | The number of linear system |
Definition at line 9262 of file FEProblemBase.C.
Referenced by FEProblemBase::computeLinearSystemSys(), LinearSystem::computeLinearSystemTags(), and FEProblemBase::solveLinearSystem().
|
overridevirtualinherited |
Set the current lower dimensional element.
This can be null
Reimplemented from SubProblem.
Definition at line 9236 of file FEProblemBase.C.
|
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().
|
finalvirtualinherited |
Set whether or not the problem is in the process of computing the residual.
Reimplemented from SubProblem.
Definition at line 8931 of file FEProblemBase.C.
Referenced by FEProblemBase::computeResidualAndJacobian(), NonlinearSystemBase::computeResidualTags(), and FEProblemBase::resetState().
|
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().
Definition at line 9253 of file FEProblemBase.C.
Referenced by FEProblemBase::computeJacobian(), EigenProblem::computeJacobianAB(), EigenProblem::computeJacobianBlocks(), FEProblemBase::computeJacobianBlocks(), NonlinearSystemBase::computeJacobianInternal(), EigenProblem::computeJacobianTag(), EigenProblem::computeMatricesTags(), EigenProblem::computeResidualTag(), NonlinearSystemBase::computeResidualTags(), FEProblem::FEProblem(), EigenProblem::solve(), and FEProblemBase::solve().
|
inlineinherited |
Set the current residual vector tag data structure based on the passed in tag IDs.
Definition at line 3248 of file FEProblemBase.h.
Referenced by FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualTags(), and CrankNicolson::init().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 1762 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::constraintJacobians(), NonlinearSystemBase::constraintResiduals(), MultiAppVariableValueSamplePostprocessorTransfer::execute(), ElementalVariableValue::execute(), and ComputeInitialConditionThread::operator()().
|
inlineinherited |
Definition at line 1928 of file FEProblemBase.h.
|
virtualinherited |
Set an exception, which is stored at this point by toggling a member variable in this class, and which must be followed up with by a call to checkExceptionAndStopSolve().
message | The error message describing the exception, which will get printed when checkExceptionAndStopSolve() is called |
Definition at line 6397 of file FEProblemBase.C.
Referenced by ComputeThreadedGeneralUserObjectsThread::caughtMooseException(), ThreadedNodeLoop< ConstBndNodeRange, ConstBndNodeRange::const_iterator >::caughtMooseException(), ThreadedFaceLoop< RangeType >::caughtMooseException(), NonlinearSystemBase::computeDamping(), AuxiliarySystem::computeElementalVarsHelper(), AuxiliarySystem::computeMortarNodalVars(), FEProblemBase::handleException(), ComputeMortarFunctor::operator()(), and DisplacedProblem::updateMesh().
|
inlineinherited |
Definition at line 2392 of file FEProblemBase.h.
|
inlineinherited |
Skip further residual evaluations and fail the next nonlinear convergence check(s)
Definition at line 2379 of file FEProblemBase.h.
Referenced by Terminator::execute().
|
inlineinherited |
Tell the problem that the system(s) cannot be considered converged next time convergence is checked.
Definition at line 2381 of file FEProblemBase.h.
Referenced by FEProblemBase::setFailNextNonlinearConvergenceCheck().
|
inlineinherited |
Setter for debug functor output.
Definition at line 924 of file SubProblem.h.
|
inlineinherited |
Set whether the zeros in the Jacobian should be dropped from the sparsity pattern.
Definition at line 1951 of file FEProblemBase.h.
|
overridevirtualinherited |
Reimplemented from FEProblemBase.
Definition at line 120 of file FEProblem.C.
|
inlineinherited |
Set flag to indicate whether kernel coverage checks should be performed.
This check makes sure that at least one kernel is active on all subdomains in the domain (default: true).
Definition at line 1802 of file FEProblemBase.h.
|
inlineinherited |
Set flag to indicate whether kernel coverage checks should be performed.
This check makes sure that at least one kernel is active on all subdomains in the domain (default: true).
Definition at line 1808 of file FEProblemBase.h.
|
inherited |
Sets the linear convergence object name(s) if there is one.
Definition at line 9089 of file FEProblemBase.C.
Referenced by FEProblemSolve::FEProblemSolve().
|
inlineinherited |
Set flag to indicate whether material coverage checks should be performed.
This check makes sure that at least one material is active on all subdomains in the domain if any material is supplied. If no materials are supplied anywhere, a simulation is still considered OK as long as no properties are being requested anywhere.
Definition at line 1819 of file FEProblemBase.h.
|
inlineinherited |
Set flag to indicate whether material coverage checks should be performed.
This check makes sure that at least one material is active on all subdomains in the domain if any material is supplied. If no materials are supplied anywhere, a simulation is still considered OK as long as no properties are being requested anywhere.
Definition at line 1827 of file FEProblemBase.h.
|
inherited |
Sets the MultiApp fixed point convergence object name if there is one.
Definition at line 9067 of file FEProblemBase.C.
Referenced by FixedPointSolve::FixedPointSolve().
|
inlineinherited |
Sets _need_to_add_default_multiapp_fixed_point_convergence to true.
Definition at line 652 of file FEProblemBase.h.
Referenced by FixedPointSolve::FixedPointSolve().
|
inlineinherited |
Sets _need_to_add_default_nonlinear_convergence to true.
Definition at line 647 of file FEProblemBase.h.
Referenced by FEProblemSolve::FEProblemSolve().
|
virtualinherited |
|
inherited |
Sets the nonlinear convergence object name(s) if there is one.
Definition at line 9058 of file FEProblemBase.C.
Referenced by FEProblemSolve::FEProblemSolve().
|
inherited |
Set custom coupling matrix for variables requiring nonlocal contribution.
Definition at line 6070 of file FEProblemBase.C.
Referenced by FEProblemBase::initialSetup().
|
inlineinherited |
Toggle parallel barrier messaging (defaults to on).
Definition at line 1835 of file FEProblemBase.h.
|
inherited |
Set the value of a PostprocessorValue.
name | The name of the post-processor |
t_index | Flag for getting current (0), old (1), or older (2) values |
Note: This method is only for setting values that already exist, the Postprocessor and PostprocessorInterface objects should be used rather than this method for creating and getting values within objects.
WARNING! This method should be used with caution. It exists to allow Transfers and other similar objects to modify Postprocessor values. It is not intended for general use.
Definition at line 4396 of file FEProblemBase.C.
Referenced by MultiAppPostprocessorTransfer::execute(), PIDTransientControl::execute(), FEProblemBase::joinAndFinalize(), SecantSolve::transformPostprocessors(), SteffensenSolve::transformPostprocessors(), and PicardSolve::transformPostprocessors().
|
inherited |
Set whether the sparsity pattern of the matrices being formed during the solve (usually the Jacobian) should be preserved.
This global setting can be retrieved by kernels, notably those using AD, to decide whether to take additional care to preserve the sparsity pattern
Definition at line 3774 of file FEProblemBase.C.
|
pure virtualinherited |
|
overridevirtualinherited |
Definition at line 1896 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::constraintResiduals().
|
pure virtualinherited |
|
overridevirtualinherited |
Definition at line 1907 of file FEProblemBase.C.
|
inherited |
Communicate to the Resurector the name of the restart filer.
file_name | The file name for restarting from |
Definition at line 8590 of file FEProblemBase.C.
Referenced by Executioner::Executioner(), and FEProblemBase::FEProblemBase().
|
inlineinherited |
If or not to reuse the base vector for matrix-free calculation.
Definition at line 2090 of file FEProblemBase.h.
Referenced by FEProblemSolve::FEProblemSolve().
|
inlinevirtualinherited |
Set boolean flag to true to store old solution second time derivative.
Definition at line 2138 of file FEProblemBase.h.
Referenced by CentralDifference::CentralDifference(), and NewmarkBeta::NewmarkBeta().
|
inlinevirtualinherited |
Set boolean flag to true to store solution second time derivative.
Definition at line 2126 of file FEProblemBase.h.
Referenced by CentralDifference::CentralDifference(), and NewmarkBeta::NewmarkBeta().
|
inlinevirtualinherited |
Set boolean flag to true to store old solution time derivative.
Definition at line 2132 of file FEProblemBase.h.
Referenced by CentralDifference::CentralDifference(), and NewmarkBeta::NewmarkBeta().
|
inlinevirtualinherited |
Set boolean flag to true to store solution time derivative.
Definition at line 2123 of file FEProblemBase.h.
Referenced by TimeIntegrator::TimeIntegrator().
|
inherited |
Definition at line 5140 of file FEProblemBase.C.
|
inlinevirtualinherited |
Definition at line 28 of file FEProblem.h.
|
inherited |
Definition at line 1670 of file FEProblemBase.C.
Referenced by FEProblemBase::initialSetup(), and FEProblemBase::meshChanged().
|
inherited |
Set the value of a VectorPostprocessor vector.
object_name | The name of the VPP object |
vector_name | The name of the declared vector |
value | The data to apply to the vector |
t_index | Flag for getting current (0), old (1), or older (2) values |
Definition at line 4422 of file FEProblemBase.C.
|
inherited |
Make the problem be verbose.
Definition at line 9228 of file FEProblemBase.C.
Referenced by Executioner::Executioner(), and PhysicsBase::initializePhysics().
|
inherited |
Check whether the problem should output execution orders at this time.
Definition at line 9170 of file FEProblemBase.C.
Referenced by FEProblemBase::joinAndFinalize(), 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().
|
inlineinherited |
Definition at line 2174 of file FEProblemBase.h.
Referenced by MFEMSteady::execute(), and FEProblemSolve::solve().
|
virtualinherited |
Check to see whether the problem should update the solution.
Definition at line 7716 of file FEProblemBase.C.
Referenced by FEProblemBase::computePostCheck(), and NonlinearSystem::solve().
|
inlineinherited |
Whether or not to print out the invalid solutions summary table in console.
Definition at line 1968 of file FEProblemBase.h.
Referenced by SolverSystem::checkInvalidSolution().
Definition at line 2098 of file FEProblemBase.C.
|
inlineinherited |
Set a flag that indicates if we want to skip exception and stop solve.
Definition at line 2103 of file FEProblemBase.h.
Referenced by FEProblemSolve::FEProblemSolve().
Reimplemented in DumpObjectsProblem, EigenProblem, and ExternalProblem.
Definition at line 6335 of file FEProblemBase.C.
Referenced by EigenExecutionerBase::inversePowerIteration(), EigenExecutionerBase::nonlinearSolve(), FEProblemSolve::solve(), and AB2PredictorCorrector::step().
|
virtualinherited |
Build and solve a linear system.
linear_sys_num | The number of the linear system (1,..,num. of lin. systems) |
po | The petsc options for the solve, if not supplied, the defaults are used |
Reimplemented in DumpObjectsProblem.
Definition at line 6493 of file FEProblemBase.C.
Referenced by FEProblemSolve::solve().
|
inherited |
Get the solver parameters.
Definition at line 8622 of file FEProblemBase.C.
Referenced by NonlinearEigenSystem::attachPreconditioner(), SolverSystem::compute(), SlepcEigenSolverConfiguration::configure_solver(), Eigenvalue::Eigenvalue(), ExplicitTimeIntegrator::ExplicitTimeIntegrator(), FEProblemSolve::FEProblemSolve(), EigenProblem::init(), ExplicitTimeIntegrator::init(), FEProblemBase::init(), EigenProblem::isNonlinearEigenvalueSolver(), Moose::SlepcSupport::mooseSlepcEigenFormFunctionA(), Moose::SlepcSupport::mooseSlepcEigenFormFunctionAB(), Moose::SlepcSupport::mooseSlepcEigenFormFunctionB(), Moose::SlepcSupport::mooseSlepcEigenFormJacobianA(), MooseStaticCondensationPreconditioner::MooseStaticCondensationPreconditioner(), ConsoleUtils::outputExecutionInformation(), Moose::PetscSupport::petscSetDefaults(), PhysicsBasedPreconditioner::PhysicsBasedPreconditioner(), Eigenvalue::prepareSolverOptions(), NonlinearSystem::residualAndJacobianTogether(), Moose::SlepcSupport::setEigenProblemSolverParams(), Moose::PetscSupport::setLineSearchFromParams(), Moose::PetscSupport::setMFFDTypeFromParams(), Moose::PetscSupport::setSinglePetscOption(), Moose::PetscSupport::setSolveTypeFromParams(), NonlinearSystemBase::shouldEvaluatePreSMOResidual(), EigenProblem::solve(), FEProblemBase::solverParams(), EigenProblem::solverTypeString(), FEProblemBase::solverTypeString(), and Moose::SlepcSupport::storeSolveType().
|
inherited |
const version
Definition at line 8631 of file FEProblemBase.C.
|
overridevirtualinherited |
solver_sys_name
Implements SubProblem.
Definition at line 6301 of file FEProblemBase.C.
Referenced by FEProblemBase::addVariable(), MultiSystemSolveObject::MultiSystemSolveObject(), and DisplacedProblem::solverSysNum().
|
overridevirtualinherited |
sys_num
is converged Reimplemented from SubProblem.
Reimplemented in EigenProblem.
Definition at line 6533 of file FEProblemBase.C.
|
virtualinherited |
Return solver type as a human readable string.
Reimplemented in MFEMProblem, and EigenProblem.
Definition at line 9349 of file FEProblemBase.C.
Referenced by ConsoleUtils::outputExecutionInformation().
|
inlinevirtualinherited |
Returns true if we are in or beyond the initialSetup stage.
Definition at line 509 of file FEProblemBase.h.
Referenced by NEML2ModelExecutor::checkExecutionStage(), MaterialBase::checkExecutionStage(), and MaterialPropertyInterface::checkExecutionStage().
|
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().
|
virtualinherited |
Definition at line 2462 of file FEProblemBase.C.
Referenced by ComputeMarkerThread::subdomainChanged(), ComputeIndicatorThread::subdomainChanged(), ComputeMaterialsObjectThread::subdomainChanged(), ComputeDiracThread::subdomainChanged(), NonlinearThread::subdomainChanged(), ComputeUserObjectsThread::subdomainChanged(), and ThreadedFaceLoop< RangeType >::subdomainChanged().
|
inlineinherited |
Dimension of the subspace spanned by vectors with a given prefix.
prefix | Prefix of the vectors spanning the subspace. |
Definition at line 1877 of file FEProblemBase.h.
Referenced by FEProblemBase::computeNearNullSpace(), FEProblemBase::computeNullSpace(), and FEProblemBase::computeTransposeNullSpace().
Definition at line 4124 of file FEProblemBase.C.
Referenced by NodalPatchRecovery::compute(), LineMaterialSamplerBase< Real >::execute(), ComputeMarkerThread::onElement(), ComputeElemAuxVarsThread< AuxKernelType >::onElement(), ComputeIndicatorThread::onElement(), NonlinearThread::onElement(), and ComputeUserObjectsThread::onElement().
Definition at line 4131 of file FEProblemBase.C.
Referenced by NonlinearThread::onBoundary(), ComputeUserObjectsThread::onBoundary(), NonlinearThread::onInterface(), ComputeUserObjectsThread::onInterface(), ComputeIndicatorThread::onInternalSide(), NonlinearThread::onInternalSide(), ComputeUserObjectsThread::onInternalSide(), and ComputeElemAuxBcsThread< AuxKernelType >::operator()().
Definition at line 4139 of file FEProblemBase.C.
Referenced by NonlinearThread::onInterface(), ComputeUserObjectsThread::onInterface(), ComputeIndicatorThread::onInternalSide(), NonlinearThread::onInternalSide(), ComputeUserObjectsThread::onInternalSide(), and ComputeElemAuxBcsThread< AuxKernelType >::operator()().
|
overridevirtualinherited |
Return the auxiliary system object as a base class reference.
Implements SubProblem.
Definition at line 8909 of file FEProblemBase.C.
Referenced by PhysicsBase::copyVariablesFromMesh(), and MFEMProblem::getAuxVariableNames().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 8915 of file FEProblemBase.C.
|
overridevirtualinherited |
Get a constant base class reference to a linear system.
sys_num | The number of the linear system |
Implements SubProblem.
Definition at line 8877 of file FEProblemBase.C.
|
overridevirtualinherited |
Get a non-constant base class reference to a linear system.
sys_num | The number of the linear system |
Implements SubProblem.
Definition at line 8885 of file FEProblemBase.C.
|
overridevirtualinherited |
Return the nonlinear system object as a base class reference given the system number.
Implements SubProblem.
Definition at line 8863 of file FEProblemBase.C.
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 8870 of file FEProblemBase.C.
|
overridevirtualinherited |
Return the solver system object as a base class reference given the system number.
Implements SubProblem.
Definition at line 8893 of file FEProblemBase.C.
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 8901 of file FEProblemBase.C.
|
inherited |
variable_name
Can be nonlinear or auxiliary Definition at line 6320 of file FEProblemBase.C.
|
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().
|
inlineinherited |
Definition at line 2085 of file FEProblemBase.h.
Referenced by NonlinearSystemBase::addBoundaryCondition(), NonlinearSystemBase::addDGKernel(), NonlinearSystemBase::addDiracKernel(), NonlinearSystemBase::addHDGKernel(), NonlinearSystemBase::addInterfaceKernel(), NonlinearSystemBase::addKernel(), NonlinearSystemBase::addNodalKernel(), FEProblemBase::addObject(), NonlinearSystemBase::addScalarKernel(), NonlinearSystemBase::addSplit(), FEProblemBase::addUserObject(), NonlinearSystemBase::checkKernelCoverage(), FEProblemBase::checkUserObjectJacobianRequirement(), FEProblemBase::checkUserObjects(), NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeResidualAndJacobianInternal(), NonlinearSystemBase::computeResidualInternal(), FEProblemBase::computeUserObjectByName(), FEProblemBase::computeUserObjects(), LinearSystem::containsTimeKernel(), NonlinearSystemBase::customSetup(), FEProblemBase::customSetup(), ComputeResidualThread::determineObjectWarehouses(), ComputeResidualAndJacobianThread::determineObjectWarehouses(), FEProblemBase::executeSamplers(), ComputeLinearFVElementalThread::fetchBlockSystemContributionObjects(), ComputeLinearFVFaceThread::fetchBlockSystemContributionObjects(), FEProblemBase::getDistribution(), FEProblemBase::getMortarUserObjects(), FEProblemBase::getPositionsObject(), FEProblemBase::getSampler(), CompositionDT::getTimeSteppers(), FEProblemBase::getUserObject(), FEProblemBase::getUserObjectBase(), FEProblemBase::hasUserObject(), SideFVFluxBCIntegral::initialSetup(), ExplicitTimeIntegrator::initialSetup(), NonlinearSystemBase::initialSetup(), FEProblemBase::initialSetup(), AdvancedOutput::initPostprocessorOrVectorPostprocessorLists(), FEProblemBase::needBoundaryMaterialOnSide(), FEProblemBase::needInterfaceMaterialOnSide(), FEProblemBase::needSubdomainMaterialOnSide(), JSONOutput::outputReporters(), BlockRestrictionDebugOutput::printBlockRestrictionMap(), ComputeLinearFVElementalThread::setupSystemContributionObjects(), ComputeLinearFVFaceThread::setupSystemContributionObjects(), NonlinearThread::subdomainChanged(), NonlinearSystemBase::timestepSetup(), and FEProblemBase::timestepSetup().
|
inlinevirtualinherited |
Definition at line 514 of file FEProblemBase.h.
Referenced by EigenExecutionerBase::EigenExecutionerBase(), PseudoTimestep::execute(), Times::getCurrentTime(), FEProblemBase::getTimeFromStateArg(), TimePostprocessor::getValue(), InversePowerMethod::init(), NonlinearEigen::init(), SimulationTimes::initialize(), JSONOutput::outputReporters(), XMLOutput::outputVectorPostprocessors(), EigenExecutionerBase::postExecute(), ExplicitSSPRungeKutta::postResidual(), ActuallyExplicitEuler::postResidual(), Predictor::shouldApply(), ExplicitSSPRungeKutta::solve(), ActuallyExplicitEuler::solve(), FixedPointSolve::solve(), LStableDirk2::solve(), LStableDirk3::solve(), ImplicitMidpoint::solve(), ExplicitTVDRK2::solve(), AStableDirk4::solve(), LStableDirk4::solve(), ExplicitRK2::solve(), FixedPointSolve::solveStep(), and NumNonlinearIterations::timestepSetup().
|
protectedinherited |
section_name
.Optionally adds a prefix if one is defined.
Definition at line 47 of file PerfGraphInterface.C.
Referenced by PerfGraphInterface::registerTimedSection().
|
inlinevirtualinherited |
Definition at line 515 of file FEProblemBase.h.
Referenced by EigenExecutionerBase::EigenExecutionerBase(), FEProblemBase::getTimeFromStateArg(), Predictor::shouldApply(), ExplicitSSPRungeKutta::solve(), ActuallyExplicitEuler::solve(), LStableDirk2::solve(), LStableDirk3::solve(), ImplicitMidpoint::solve(), ExplicitTVDRK2::solve(), LStableDirk4::solve(), AStableDirk4::solve(), and ExplicitRK2::solve().
|
inlinevirtualinherited |
Definition at line 516 of file FEProblemBase.h.
Referenced by NewmarkBeta::computeTimeDerivatives(), EigenExecutionerBase::EigenExecutionerBase(), PseudoTimestep::execute(), NumTimeSteps::getValue(), NonlinearEigen::init(), InversePowerMethod::init(), PseudoTimestep::outputPseudoTimestep(), JSONOutput::outputReporters(), XMLOutput::outputVectorPostprocessors(), EigenExecutionerBase::postExecute(), TransientMultiApp::setupApp(), NonlinearSystem::solve(), PseudoTimestep::timestepEXP(), PseudoTimestep::timestepSER(), and RandomData::updateSeeds().
|
overridevirtualinherited |
Reimplemented from SubProblem.
Definition at line 1477 of file FEProblemBase.C.
Referenced by MFEMSteady::execute(), SteadyBase::execute(), Eigenvalue::execute(), NonlinearEigen::takeStep(), and TransientBase::takeStep().
|
inlinevirtualinherited |
Definition at line 524 of file FEProblemBase.h.
Referenced by EigenExecutionerBase::EigenExecutionerBase(), MFEMTransient::MFEMTransient(), and TransientBase::TransientBase().
|
inherited |
Whether to trust the user coupling matrix even if we want to do things like be paranoid and create a full coupling matrix.
See https://github.com/idaholab/moose/issues/16395 for detailed background
Definition at line 6060 of file FEProblemBase.C.
Referenced by SingleMatrixPreconditioner::SingleMatrixPreconditioner().
|
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(), DisplacedProblem::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(), HFEMDiffusion::computeQpResidual(), ArrayHFEMDiffusion::computeQpResidual(), DGConvection::computeQpResidual(), ScalarKernel::computeQpResidual(), InterfaceDiffusion::computeQpResidual(), ArrayDGDiffusion::computeQpResidual(), ADMatInterfaceReaction::computeQpResidual(), InterfaceReaction::computeQpResidual(), ADDGAdvection::computeQpResidual(), CoupledTiedValueConstraint::computeQpResidual(), TiedValueConstraint::computeQpResidual(), LinearNodalConstraint::computeQpResidual(), DGDiffusion::computeQpResidual(), ADDGDiffusion::computeQpResidual(), HFEMTestJump::computeQpResidual(), HFEMTrialJump::computeQpResidual(), EqualValueBoundaryConstraint::computeQpResidual(), FEProblemBase::computeSystems(), FEProblemBase::computeUserObjectByName(), FEProblemBase::computeUserObjects(), FEProblemBase::computeUserObjectsInternal(), DisplacedProblem::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(), DisplacedProblem::getVectorTags(), SubProblem::getVectorTags(), CommonOutputAction::hasConsole(), FEProblemBase::hasMultiApps(), AdvancedOutput::hasOutput(), FEProblemBase::incrementMultiAppTStep(), AdvancedOutput::initAvailableLists(), FunctorPositions::initialize(), FunctorTimes::initialize(), MultiAppConservativeTransfer::initialSetup(), LinearFVAnisotropicDiffusion::initialSetup(), LinearFVAdvection::initialSetup(), LinearFVDiffusion::initialSetup(), ArrayDGDiffusion::initQpResidual(), AdvancedOutput::initShowHideLists(), RelationshipManager::isType(), FEProblemBase::logAdd(), MaterialFunctorConverterTempl< T >::MaterialFunctorConverterTempl(), MFEMProblem::mesh(), MooseApp::MooseApp(), MooseObject::MooseObject(), MultiAppMFEMCopyTransfer::MultiAppMFEMCopyTransfer(), DisplacedProblem::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(), WebServerControl::startServer(), MooseBase::typeAndName(), ScalarKernelBase::uOld(), AuxScalarKernel::uOld(), DisplacedProblem::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().
|
inlinevirtualinherited |
Get boolean flag to check whether old solution second time derivative needs to be stored.
Definition at line 2161 of file FEProblemBase.h.
Referenced by SystemBase::addDotVectors().
|
inlinevirtualinherited |
Get boolean flag to check whether solution second time derivative needs to be stored.
Definition at line 2147 of file FEProblemBase.h.
Referenced by SystemBase::addDotVectors(), and FEProblemBase::addTimeIntegrator().
|
inlinevirtualinherited |
Get boolean flag to check whether old solution time derivative needs to be stored.
Definition at line 2150 of file FEProblemBase.h.
Referenced by SystemBase::addDotVectors().
|
inlinevirtualinherited |
Get boolean flag to check whether solution time derivative needs to be stored.
Definition at line 2144 of file FEProblemBase.h.
Referenced by SystemBase::addDotVectors().
|
inherited |
uniformly refine the problem mesh(es).
This will also prolong the the solution, and in order for that to be safe, we can only perform one refinement at a time
Definition at line 8939 of file FEProblemBase.C.
Referenced by FEProblemSolve::solve().
|
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.
|
virtualinherited |
Update the active objects in the warehouses.
Reimplemented in DumpObjectsProblem.
Definition at line 5056 of file FEProblemBase.C.
Referenced by MooseEigenSystem::eigenKernelOnCurrent(), MooseEigenSystem::eigenKernelOnOld(), and FixedPointSolve::solveStep().
|
overridevirtualinherited |
Implements SubProblem.
Definition at line 7743 of file FEProblemBase.C.
Referenced by NonlinearSystemBase::augmentSparsity(), and FEProblemBase::initialSetup().
|
virtualinherited |
Update the mesh due to changing XFEM cuts.
Definition at line 8010 of file FEProblemBase.C.
Referenced by FEProblemBase::initialSetup(), and FixedPointSolve::solveStep().
|
virtualinherited |
Definition at line 7754 of file FEProblemBase.C.
Referenced by FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualTags(), FEProblemBase::init(), FEProblemBase::initialSetup(), and FEProblemBase::meshChanged().
|
virtualinherited |
Update the solution.
vec_solution | Local solution vector that gets modified by this method |
ghosted_solution | Ghosted solution vector |
Definition at line 7722 of file FEProblemBase.C.
Referenced by FEProblemBase::computePostCheck().
|
inlineinherited |
Return a flag that indicates if we are reusing the vector base.
Definition at line 2098 of file FEProblemBase.h.
Referenced by NonlinearSystem::potentiallySetupFiniteDifferencing().
|
static |
Definition at line 18 of file ReferenceResidualProblem.C.
|
inlinevirtualinherited |
Check to see if a particular Tag exists.
Reimplemented in DisplacedProblem.
Definition at line 201 of file SubProblem.h.
Referenced by SystemBase::associateVectorToTag(), SystemBase::closeTaggedVector(), FEProblemBase::computePostCheck(), Coupleable::coupledVectorTagArrayGradient(), Coupleable::coupledVectorTagArrayGradients(), Coupleable::coupledVectorTagArrayValues(), Coupleable::coupledVectorTagDofValues(), Coupleable::coupledVectorTagGradient(), Coupleable::coupledVectorTagGradients(), ScalarCoupleable::coupledVectorTagScalarValue(), Coupleable::coupledVectorTagValues(), SystemBase::disassociateDefaultVectorTags(), SystemBase::disassociateVectorFromTag(), SystemBase::getVector(), SubProblem::getVectorTag(), FEProblemBase::needsPreviousNewtonIteration(), SystemBase::removeVector(), TaggingInterface::useVectorTag(), Coupleable::vectorTagDofValueHelper(), DisplacedProblem::vectorTagExists(), SubProblem::vectorTagName(), SubProblem::vectorTagType(), Coupleable::vectorTagValueHelper(), and SystemBase::zeroTaggedVector().
|
virtualinherited |
Check to see if a particular Tag exists by using Tag name.
Reimplemented in DisplacedProblem.
Definition at line 136 of file SubProblem.C.
|
virtualinherited |
Retrieve the name associated with a TagID.
Reimplemented in DisplacedProblem.
Definition at line 221 of file SubProblem.C.
Referenced by SystemBase::closeTaggedVector(), NonlinearSystemBase::getResidualNonTimeVector(), NonlinearSystemBase::getResidualTimeVector(), SystemBase::removeVector(), NonlinearSystemBase::residualGhosted(), DisplacedProblem::vectorTagName(), and SystemBase::zeroTaggedVector().
|
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().
|
virtualinherited |
Reimplemented in DisplacedProblem.
Definition at line 231 of file SubProblem.C.
Referenced by MooseVariableScalar::reinit(), TaggingInterface::TaggingInterface(), and DisplacedProblem::vectorTagType().
|
inlineinherited |
Whether or not to use verbose printing for MultiApps.
Definition at line 1843 of file FEProblemBase.h.
Referenced by MultiApp::backup(), MultiApp::createApp(), MultiApp::restore(), FullSolveMultiApp::showStatusMessage(), and TransientMultiApp::solveStep().
|
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().
|
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().
|
inherited |
Definition at line 2030 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::updateMaxQps(), and FEProblemBase::~FEProblemBase().
|
inherited |
Definition at line 2033 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::updateMaxQps(), and FEProblemBase::~FEProblemBase().
|
inherited |
Definition at line 2028 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::updateMaxQps(), and FEProblemBase::~FEProblemBase().
|
protectedinherited |
Definition at line 2747 of file FEProblemBase.h.
Referenced by FEProblemBase::adaptivity(), FEProblemBase::adaptMesh(), FEProblemBase::addAnyRedistributers(), FEProblemBase::checkProblemIntegrity(), FEProblemBase::computeMarkers(), FEProblemBase::hasInitialAdaptivity(), FEProblemBase::initialAdaptMesh(), and FEProblemBase::initialSetup().
|
protectedinherited |
Definition at line 2649 of file FEProblemBase.h.
Referenced by FEProblemBase::addFunctorMaterial(), FEProblemBase::addMaterialHelper(), FEProblemBase::checkProblemIntegrity(), FEProblemBase::computeBounds(), FEProblemBase::computeJacobianTags(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualTags(), FEProblemBase::customSetup(), FEProblemBase::getMaterial(), FEProblemBase::getMaterialWarehouse(), FEProblemBase::initialSetup(), FEProblemBase::neighborSubdomainSetup(), FEProblemBase::prepareMaterials(), FEProblemBase::setActiveMaterialProperties(), FEProblemBase::subdomainSetup(), FEProblemBase::timestepSetup(), and FEProblemBase::updateActiveObjects().
|
protectedinherited |
Definition at line 2665 of file FEProblemBase.h.
Referenced by FEProblemBase::addUserObject(), and FEProblemBase::getUserObjects().
|
protectedinherited |
The MOOSE application this is associated with.
Definition at line 84 of file MooseBase.h.
|
protectedinherited |
The Assembly objects.
The first index corresponds to the thread ID and the second index corresponds to the nonlinear system number
Definition at line 2612 of file FEProblemBase.h.
Referenced by FEProblemBase::addCachedResidualDirectly(), FEProblemBase::addJacobian(), FEProblemBase::addJacobianBlockTags(), FEProblemBase::addJacobianLowerD(), FEProblemBase::addJacobianNeighbor(), FEProblemBase::addJacobianNeighborLowerD(), FEProblemBase::addJacobianOffDiagScalar(), FEProblemBase::addJacobianScalar(), FEProblemBase::addResidual(), FEProblemBase::addResidualLower(), FEProblemBase::addResidualNeighbor(), FEProblemBase::addResidualScalar(), FEProblemBase::assembly(), FEProblemBase::bumpAllQRuleOrder(), FEProblemBase::bumpVolumeQRuleOrder(), FEProblemBase::couplingEntries(), FEProblemBase::createQRules(), FEProblem::init(), FEProblemBase::init(), FEProblemBase::initElementStatefulProps(), FEProblemBase::initialSetup(), FEProblemBase::initXFEM(), FEProblemBase::meshChanged(), FEProblemBase::newAssemblyArray(), FEProblemBase::nonlocalCouplingEntries(), FEProblemBase::prepareAssembly(), FEProblemBase::prepareFaceShapes(), FEProblemBase::prepareNeighborShapes(), FEProblemBase::prepareShapes(), FEProblemBase::reinitDirac(), FEProblemBase::reinitElemNeighborAndLowerD(), FEProblemBase::reinitElemPhys(), FEProblemBase::reinitMaterials(), FEProblemBase::reinitMaterialsBoundary(), FEProblemBase::reinitMaterialsFace(), FEProblemBase::reinitMaterialsInterface(), FEProblemBase::reinitMaterialsNeighbor(), FEProblemBase::reinitNeighbor(), FEProblemBase::reinitNode(), FEProblemBase::reinitNodeFace(), FEProblemBase::reinitOffDiagScalars(), FEProblemBase::reinitScalars(), FEProblemBase::setCurrentSubdomainID(), FEProblemBase::setResidual(), FEProblemBase::setResidualNeighbor(), FEProblemBase::swapBackMaterials(), FEProblemBase::swapBackMaterialsFace(), and FEProblemBase::swapBackMaterialsNeighbor().
|
protectedinherited |
The auxiliary system.
Definition at line 2602 of file FEProblemBase.h.
Referenced by FEProblemBase::addAuxArrayVariable(), FEProblemBase::addAuxKernel(), FEProblemBase::addAuxScalarKernel(), FEProblemBase::addAuxScalarVariable(), FEProblemBase::addAuxVariable(), FEProblemBase::addIndicator(), FEProblemBase::addMarker(), FEProblemBase::addMultiApp(), FEProblemBase::addObjectParamsHelper(), FEProblemBase::addTimeIntegrator(), FEProblemBase::addTransfer(), FEProblemBase::advanceState(), FEProblemBase::checkExceptionAndStopSolve(), FEProblemBase::computeBounds(), FEProblemBase::computeIndicators(), FEProblemBase::computeJacobianTags(), FEProblemBase::computeLinearSystemTags(), FEProblemBase::computeMarkers(), FEProblemBase::computePostCheck(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualTags(), FEProblemBase::computeSystems(), FEProblemBase::computeUserObjectsInternal(), FEProblemBase::copySolutionsBackwards(), FEProblemBase::createQRules(), FEProblemBase::createTagSolutions(), FEProblemBase::customSetup(), FEProblemBase::determineSolverSystem(), DumpObjectsProblem::DumpObjectsProblem(), FEProblemBase::duplicateVariableCheck(), EigenProblem::EigenProblem(), FEProblemBase::execute(), ExternalProblem::ExternalProblem(), FEProblem::FEProblem(), FEProblemBase::getActualFieldVariable(), FEProblemBase::getArrayVariable(), FEProblemBase::getAuxiliarySystem(), FEProblemBase::getScalarVariable(), FEProblemBase::getStandardVariable(), FEProblemBase::getSystem(), FEProblemBase::getSystemBase(), FEProblemBase::getVariable(), FEProblemBase::getVariableNames(), FEProblemBase::getVectorVariable(), FEProblemBase::hasScalarVariable(), FEProblemBase::hasVariable(), FEProblemBase::init(), FEProblemBase::initialSetup(), FEProblemBase::meshChanged(), FEProblemBase::needBoundaryMaterialOnSide(), FEProblemBase::needSolutionState(), FEProblemBase::outputStep(), FEProblemBase::prepareFace(), FEProblemBase::projectInitialConditionOnCustomRange(), FEProblemBase::projectSolution(), FEProblemBase::reinitDirac(), FEProblemBase::reinitElem(), FEProblemBase::reinitElemPhys(), FEProblemBase::reinitNeighbor(), FEProblemBase::reinitNode(), FEProblemBase::reinitNodeFace(), FEProblemBase::reinitNodes(), FEProblemBase::reinitNodesNeighbor(), FEProblemBase::reinitScalars(), FEProblemBase::restoreOldSolutions(), FEProblemBase::restoreSolutions(), FEProblemBase::saveOldSolutions(), FEProblemBase::systemBaseAuxiliary(), FEProblemBase::systemNumForVariable(), FEProblemBase::timestepSetup(), FEProblemBase::updateActiveObjects(), and FEProblemBase::updateMeshXFEM().
|
protectedinherited |
Definition at line 2882 of file FEProblemBase.h.
|
protectedinherited |
Transfers executed just before MultiApps to transfer data between them.
Definition at line 2683 of file FEProblemBase.h.
Referenced by FEProblemBase::addTransfer(), FEProblemBase::execMultiAppTransfers(), FEProblemBase::getMultiAppTransferWarehouse(), FEProblemBase::getTransfers(), FEProblemBase::initialSetup(), and FEProblemBase::updateActiveObjects().
|
protectedinherited |
Cache for calculating materials on side.
Definition at line 2689 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), and FEProblemBase::needSubdomainMaterialOnSide().
|
protectedinherited |
Cache for calculating materials on side.
Definition at line 2692 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), and FEProblemBase::needBoundaryMaterialOnSide().
|
protectedinherited |
Definition at line 2641 of file FEProblemBase.h.
Referenced by FEProblemBase::addAnyRedistributers(), FEProblemBase::advanceState(), FEProblemBase::checkProblemIntegrity(), FEProblemBase::getBndMaterialPropertyStorage(), FEProblemBase::getMaterialData(), FEProblemBase::initElementStatefulProps(), FEProblemBase::initialSetup(), FEProblemBase::initXFEM(), FEProblemBase::meshChanged(), FEProblemBase::reinitMaterialsBoundary(), FEProblemBase::reinitMaterialsFace(), FEProblemBase::reinitMaterialsInterface(), and FEProblemBase::swapBackMaterialsFace().
|
protectedinherited |
whether to perform checking of boundary restricted elemental object variable dependencies, e.g.
whether the variable dependencies are defined on the selected boundaries
Definition at line 2821 of file FEProblemBase.h.
Referenced by FEProblemBase::initialSetup().
|
protectedinherited |
whether to perform checking of boundary restricted nodal object variable dependencies, e.g.
whether the variable dependencies are defined on the selected boundaries
Definition at line 2817 of file FEProblemBase.h.
Referenced by FEProblemBase::initialSetup().
|
protectedinherited |
Definition at line 2802 of file FEProblemBase.h.
Referenced by FEProblemBase::checkNonlocalCoupling(), FEProblemBase::checkUserObjectJacobianRequirement(), and FEProblemBase::meshChanged().
|
protectedinherited |
True if the CLI option is found.
Definition at line 52 of file Problem.h.
Referenced by Problem::_setCLIOption().
|
protectedinherited |
Coupling matrix for variables.
Definition at line 2605 of file FEProblemBase.h.
Referenced by FEProblemBase::areCoupled(), FEProblemBase::couplingMatrix(), FEProblemBase::FEProblemBase(), FEProblemBase::init(), and FEProblemBase::setCouplingMatrix().
|
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(), 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(), FEProblemSolve::solve(), FixedPointSolve::solve(), EigenProblem::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 |
true if the Jacobian is constant
Definition at line 2789 of file FEProblemBase.h.
Referenced by FEProblemBase::computeJacobianTags(), FEProblemBase::constJacobian(), and FEProblemBase::setConstJacobian().
|
protectedinherited |
The control logic warehouse.
Definition at line 2867 of file FEProblemBase.h.
Referenced by FEProblemBase::executeControls(), FEProblemBase::getControlWarehouse(), and FEProblemBase::updateActiveObjects().
|
protectedinherited |
convergence warehouse
Definition at line 2623 of file FEProblemBase.h.
Referenced by FEProblemBase::addConvergence(), FEProblemBase::getConvergence(), FEProblemBase::getConvergenceObjects(), FEProblemBase::hasConvergence(), and FEProblemBase::initialSetup().
|
protectedinherited |
Type of variable coupling.
Definition at line 2604 of file FEProblemBase.h.
Referenced by FEProblemBase::coupling(), FEProblemBase::init(), FEProblemBase::setCoupling(), and FEProblemBase::trustUserCouplingMatrix().
|
protectedinherited |
Definition at line 2886 of file FEProblemBase.h.
Referenced by FEProblemBase::getCurrentAlgebraicBndNodeRange(), and FEProblemBase::setCurrentAlgebraicBndNodeRange().
|
protectedinherited |
Definition at line 2884 of file FEProblemBase.h.
Referenced by FEProblemBase::getCurrentAlgebraicElementRange(), and FEProblemBase::setCurrentAlgebraicElementRange().
|
protectedinherited |
Definition at line 2885 of file FEProblemBase.h.
Referenced by FEProblemBase::getCurrentAlgebraicNodeRange(), and FEProblemBase::setCurrentAlgebraicNodeRange().
|
protectedinherited |
Current execute_on flag.
Definition at line 2864 of file FEProblemBase.h.
Referenced by FEProblemBase::checkExceptionAndStopSolve(), FEProblemBase::computeJacobianTags(), FEProblemBase::computeLinearSystemTags(), FEProblemBase::computePostCheck(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualTags(), FEProblemBase::computeUserObjectByName(), FEProblemBase::getCurrentExecuteOnFlag(), FEProblemBase::joinAndFinalize(), FEProblemBase::resetState(), FEProblemBase::setCurrentExecuteOnFlag(), and FEProblemBase::shouldPrintExecution().
|
protectedinherited |
Definition at line 2893 of file FEProblemBase.h.
Referenced by FEProblemBase::getCurrentICState(), and FEProblemBase::initialSetup().
|
protectedinherited |
The current linear system that we are solving.
Definition at line 2566 of file FEProblemBase.h.
Referenced by FEProblemBase::checkExceptionAndStopSolve(), FEProblemBase::computeLinearSystemSys(), FEProblemBase::computeLinearSystemTags(), FEProblemBase::computeResidualL2Norm(), FEProblemBase::currentLinearSystem(), FEProblemBase::setCurrentLinearSystem(), and FEProblemBase::solveLinearSystem().
|
protectedinherited |
The current nonlinear system that we are solving.
Definition at line 2584 of file FEProblemBase.h.
Referenced by FEProblemBase::addCachedResidualDirectly(), FEProblemBase::addJacobian(), FEProblemBase::addJacobianBlockTags(), FEProblemBase::addJacobianLowerD(), FEProblemBase::addJacobianNeighbor(), FEProblemBase::addJacobianNeighborLowerD(), FEProblemBase::addJacobianOffDiagScalar(), FEProblemBase::addJacobianScalar(), FEProblemBase::addResidual(), FEProblemBase::addResidualLower(), FEProblemBase::addResidualNeighbor(), FEProblemBase::addResidualScalar(), FEProblemBase::checkExceptionAndStopSolve(), FEProblemBase::computeBounds(), FEProblemBase::computeDamping(), FEProblemBase::computeJacobianBlock(), EigenProblem::computeJacobianBlocks(), FEProblemBase::computeJacobianBlocks(), FEProblemBase::computeJacobianInternal(), FEProblemBase::computeJacobianTag(), FEProblemBase::computeJacobianTags(), FEProblemBase::computeNearNullSpace(), FEProblemBase::computeNullSpace(), FEProblemBase::computePostCheck(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualInternal(), FEProblemBase::computeResidualL2Norm(), FEProblemBase::computeResidualTag(), FEProblemBase::computeResidualTags(), FEProblemBase::computeResidualType(), FEProblemBase::computeTransposeNullSpace(), FEProblemBase::currentNonlinearSystem(), EigenProblem::doFreeNonlinearPowerIterations(), EigenProblem::EigenProblem(), FEProblemBase::prepareAssembly(), FEProblemBase::prepareFaceShapes(), FEProblemBase::prepareNeighborShapes(), FEProblemBase::prepareShapes(), FEProblemBase::reinitDirac(), FEProblemBase::reinitOffDiagScalars(), FEProblemBase::setCurrentNonlinearSystem(), FEProblemBase::setResidual(), FEProblemBase::setResidualNeighbor(), EigenProblem::solve(), and FEProblemBase::solve().
|
protectedinherited |
The current solver system.
Definition at line 2587 of file FEProblemBase.h.
Referenced by FEProblemBase::setCurrentLinearSystem(), and FEProblemBase::setCurrentNonlinearSystem().
|
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 |
Definition at line 2748 of file FEProblemBase.h.
Referenced by FEProblemBase::adaptMesh(), FEProblemBase::getNumCyclesCompleted(), and FEProblemBase::initialAdaptMesh().
|
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 DisplacedProblem::clearDiracInfo(), FEProblemBase::clearDiracInfo(), SubProblem::diracKernelInfo(), DisplacedProblem::getDiracElements(), FEProblemBase::getDiracElements(), FEProblemBase::meshChanged(), DisplacedProblem::reinitDirac(), FEProblemBase::reinitDirac(), and DisplacedProblem::updateMesh().
|
protectedinherited |
Definition at line 2648 of file FEProblemBase.h.
Referenced by FEProblemBase::addMaterialHelper(), FEProblemBase::getDiscreteMaterialWarehouse(), FEProblemBase::initialSetup(), FEProblemBase::reinitMaterials(), FEProblemBase::reinitMaterialsBoundary(), FEProblemBase::reinitMaterialsFace(), FEProblemBase::reinitMaterialsNeighbor(), and FEProblemBase::updateActiveObjects().
|
protectedinherited |
Definition at line 2755 of file FEProblemBase.h.
Referenced by FEProblemBase::addDisplacedProblem(), FEProblemBase::addGhostedBoundary(), FEProblemBase::checkDisplacementOrders(), FEProblemBase::ghostGhostedBoundaries(), FEProblemBase::init(), FEProblemBase::initialSetup(), FEProblemBase::initXFEM(), FEProblemBase::meshChanged(), FEProblemBase::possiblyRebuildGeomSearchPatches(), FEProblemBase::prepareFace(), FEProblemBase::reinitBecauseOfGhostingOrNewGeomObjects(), FEProblemBase::reinitDirac(), FEProblemBase::reinitElem(), FEProblemBase::reinitElemFaceRef(), FEProblemBase::reinitElemNeighborAndLowerD(), FEProblemBase::reinitLowerDElem(), FEProblemBase::reinitNeighbor(), FEProblemBase::reinitNeighborFaceRef(), FEProblemBase::reinitNode(), FEProblemBase::reinitNodeFace(), FEProblemBase::setCurrentLowerDElem(), and FEProblemBase::timestepSetup().
|
protectedinherited |
Definition at line 2756 of file FEProblemBase.h.
Referenced by FEProblemBase::adaptMesh(), FEProblemBase::addAnyRedistributers(), FEProblemBase::addAuxArrayVariable(), FEProblemBase::addAuxKernel(), FEProblemBase::addAuxScalarKernel(), FEProblemBase::addAuxScalarVariable(), FEProblemBase::addAuxVariable(), FEProblemBase::addCachedJacobian(), FEProblemBase::addCachedResidual(), FEProblemBase::addCachedResidualDirectly(), FEProblemBase::addConstraint(), FEProblemBase::addDGKernel(), FEProblemBase::addDiracKernel(), FEProblemBase::addDisplacedProblem(), FEProblemBase::addFunction(), FEProblemBase::addFunctorMaterial(), FEProblemBase::addFVKernel(), FEProblemBase::addGhostedBoundary(), FEProblemBase::addIndicator(), FEProblemBase::addInterfaceKernel(), FEProblemBase::addJacobian(), FEProblemBase::addJacobianBlockTags(), FEProblemBase::addJacobianLowerD(), FEProblemBase::addJacobianNeighbor(), FEProblemBase::addJacobianNeighborLowerD(), FEProblemBase::addMarker(), FEProblemBase::addMaterialHelper(), FEProblemBase::addMultiApp(), FEProblemBase::addNodalKernel(), FEProblemBase::addObjectParamsHelper(), FEProblemBase::addResidual(), FEProblemBase::addResidualLower(), FEProblemBase::addResidualNeighbor(), FEProblemBase::addScalarKernel(), FEProblemBase::addTimeIntegrator(), FEProblemBase::addTransfer(), FEProblemBase::addUserObject(), FEProblemBase::addVariable(), FEProblemBase::advanceState(), FEProblemBase::automaticScaling(), FEProblemBase::bumpAllQRuleOrder(), FEProblemBase::bumpVolumeQRuleOrder(), FEProblemBase::cacheJacobian(), FEProblemBase::cacheJacobianNeighbor(), FEProblemBase::cacheResidual(), FEProblemBase::cacheResidualNeighbor(), FEProblemBase::checkDisplacementOrders(), FEProblemBase::clearActiveElementalMooseVariables(), FEProblemBase::clearActiveFEVariableCoupleableMatrixTags(), FEProblemBase::clearActiveFEVariableCoupleableVectorTags(), FEProblemBase::clearActiveScalarVariableCoupleableMatrixTags(), FEProblemBase::clearActiveScalarVariableCoupleableVectorTags(), FEProblemBase::clearDiracInfo(), EigenProblem::computeJacobianBlocks(), FEProblemBase::computeJacobianBlocks(), FEProblemBase::computeJacobianTags(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualTags(), FEProblemBase::computeUserObjectsInternal(), FEProblemBase::computingNonlinearResid(), FEProblemBase::createMortarInterface(), FEProblemBase::createQRules(), FEProblemBase::customSetup(), FEProblemBase::execute(), FEProblemBase::getDiracElements(), FEProblemBase::getDisplacedProblem(), FEProblemBase::getMortarUserObjects(), FEProblemBase::ghostGhostedBoundaries(), FEProblemBase::haveADObjects(), FEProblemBase::haveDisplaced(), FEProblemBase::init(), FEProblemBase::initialSetup(), FEProblemBase::initXFEM(), FEProblemBase::jacobianSetup(), FEProblemBase::mesh(), FEProblemBase::meshChanged(), FEProblemBase::outputStep(), FEProblemBase::possiblyRebuildGeomSearchPatches(), FEProblemBase::prepareAssembly(), FEProblemBase::prepareFace(), FEProblemBase::reinitBecauseOfGhostingOrNewGeomObjects(), FEProblemBase::reinitDirac(), FEProblemBase::reinitElem(), FEProblemBase::reinitElemFaceRef(), FEProblemBase::reinitElemNeighborAndLowerD(), FEProblemBase::reinitLowerDElem(), FEProblemBase::reinitNeighbor(), FEProblemBase::reinitNeighborFaceRef(), FEProblemBase::reinitNode(), FEProblemBase::reinitNodeFace(), FEProblemBase::reinitNodes(), FEProblemBase::reinitNodesNeighbor(), FEProblemBase::reinitOffDiagScalars(), FEProblemBase::reinitScalars(), FEProblemBase::resetState(), FEProblemBase::residualSetup(), FEProblemBase::restoreSolutions(), FEProblemBase::setActiveElementalMooseVariables(), FEProblemBase::setActiveFEVariableCoupleableMatrixTags(), FEProblemBase::setActiveFEVariableCoupleableVectorTags(), FEProblemBase::setActiveScalarVariableCoupleableMatrixTags(), FEProblemBase::setActiveScalarVariableCoupleableVectorTags(), FEProblemBase::setCurrentBoundaryID(), FEProblemBase::setCurrentLowerDElem(), FEProblemBase::setCurrentlyComputingResidual(), FEProblemBase::setCurrentSubdomainID(), FEProblemBase::setResidual(), FEProblemBase::setResidualNeighbor(), FEProblemBase::setResidualObjectParamsAndLog(), EigenProblem::solve(), FEProblemBase::solve(), FEProblemBase::timestepSetup(), FEProblemBase::uniformRefine(), and FEProblemBase::updateGeomSearch().
|
protectedinherited |
Definition at line 2545 of file FEProblemBase.h.
Referenced by FEProblemBase::dt(), FEProblemBase::execMultiApps(), and FEProblemBase::FEProblemBase().
|
protectedinherited |
Definition at line 2546 of file FEProblemBase.h.
Referenced by FEProblemBase::dtOld(), and FEProblemBase::FEProblemBase().
|
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().
|
protectedinherited |
Definition at line 2880 of file FEProblemBase.h.
Referenced by FEProblemBase::getEvaluableElementRange(), and FEProblemBase::meshChanged().
|
protectedinherited |
The error message to go with an exception.
Definition at line 2861 of file FEProblemBase.h.
Referenced by FEProblemBase::checkExceptionAndStopSolve(), and FEProblemBase::setException().
|
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(), addDefaultNonlinearConvergence(), FEProblemBase::addDefaultNonlinearConvergence(), 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().
|
protectedinherited |
Definition at line 2530 of file FEProblemBase.h.
Referenced by FEProblemBase::computeJacobian(), EigenProblem::computeJacobianAB(), EigenProblem::computeJacobianTag(), EigenProblem::computeMatricesTags(), and FEProblemBase::computeResidualAndJacobian().
|
protectedinherited |
Definition at line 2528 of file FEProblemBase.h.
Referenced by FEProblemBase::checkExceptionAndStopSolve(), EigenProblem::computeResidualAB(), FEProblemBase::computeResidualAndJacobian(), and EigenProblem::computeResidualTag().
|
protectedinherited |
Transfers executed just after MultiApps to transfer data from them.
Definition at line 2680 of file FEProblemBase.h.
Referenced by FEProblemBase::addTransfer(), FEProblemBase::execMultiAppTransfers(), FEProblemBase::getMultiAppTransferWarehouse(), FEProblemBase::getTransfers(), FEProblemBase::initialSetup(), and FEProblemBase::updateActiveObjects().
|
protectedinherited |
functions
Definition at line 2620 of file FEProblemBase.h.
Referenced by FEProblemBase::addFunction(), FEProblemBase::computeJacobianTags(), FEProblemBase::computeLinearSystemTags(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualTags(), FEProblemBase::customSetup(), FEProblemBase::getFunction(), FEProblemBase::hasFunction(), DumpObjectsProblem::initialSetup(), FEProblemBase::initialSetup(), and FEProblemBase::timestepSetup().
|
protectedinherited |
Whether to check overlapping Dirichlet and Flux BCs and/or multiple DirichletBCs per sideset.
Definition at line 2828 of file FEProblemBase.h.
Referenced by FEProblemBase::fvBCsIntegrityCheck().
|
protectedinherited |
Definition at line 2634 of file FEProblemBase.h.
Referenced by FEProblemBase::addFVInitialCondition(), FEProblemBase::getFVInitialConditionWarehouse(), and FEProblemBase::initialSetup().
|
protectedinherited |
Definition at line 2757 of file FEProblemBase.h.
Referenced by FEProblemBase::geomSearchData(), FEProblemBase::meshChanged(), FEProblemBase::possiblyRebuildGeomSearchPatches(), FEProblemBase::reinitBecauseOfGhostingOrNewGeomObjects(), and FEProblemBase::updateGeomSearch().
|
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().
|
inherited |
Definition at line 2031 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::initialSetup(), and FEProblemBase::~FEProblemBase().
|
inherited |
Definition at line 2029 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::reinitDirac(), FEProblemBase::updateMaxQps(), and FEProblemBase::~FEProblemBase().
|
protectedinherited |
Name of variables that are grouped together to check convergence.
Definition at line 40 of file ReferenceResidualInterface.h.
Referenced by ReferenceResidualInterface::addGroupVariables(), ReferenceResidualConvergence::initialSetup(), and ReferenceResidualInterface::ReferenceResidualInterface().
|
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 |
Whether there are active material properties on each thread.
Definition at line 2807 of file FEProblemBase.h.
Referenced by FEProblemBase::clearActiveMaterialProperties(), FEProblemBase::FEProblemBase(), FEProblemBase::hasActiveMaterialProperties(), and FEProblemBase::setActiveMaterialProperties().
|
protectedinherited |
Whether or not this system has any Constraints.
Definition at line 2774 of file FEProblemBase.h.
Referenced by FEProblemBase::addConstraint(), NonlinearSystemBase::computeJacobianInternal(), and NonlinearSystemBase::computeResidualInternal().
|
protectedinherited |
Whether or not this system has any Dampers associated with it.
Definition at line 2771 of file FEProblemBase.h.
Referenced by FEProblemBase::addDamper(), FEProblemBase::computeDamping(), FEProblemBase::computePostCheck(), and FEProblemBase::hasDampers().
|
protectedinherited |
Whether or not an exception has occurred.
Definition at line 2846 of file FEProblemBase.h.
Referenced by FEProblemBase::checkExceptionAndStopSolve(), FEProblemBase::hasException(), and FEProblemBase::setException().
|
protectedinherited |
Whether nor not stateful materials have been initialized.
Definition at line 2786 of file FEProblemBase.h.
Referenced by FEProblemBase::initialSetup(), and FEProblemBase::meshChanged().
|
protectedinherited |
Indicates if the Jacobian was computed.
Definition at line 2792 of file FEProblemBase.h.
Referenced by FEProblemBase::computeJacobianTags(), FEProblemBase::hasJacobian(), and FEProblemBase::meshChanged().
|
protectedinherited |
Indicates if nonlocal coupling is required/exists.
Definition at line 2801 of file FEProblemBase.h.
Referenced by FEProblemBase::addJacobian(), FEProblemBase::addJacobianBlockTags(), FEProblemBase::hasNonlocalCoupling(), FEProblemBase::prepareAssembly(), FEProblemBase::reinitDirac(), FEProblemBase::reinitElemPhys(), and FEProblemBase::timestepSetup().
|
protectedinherited |
Indicates whether or not this executioner has a time integrator (during setup)
Definition at line 2843 of file FEProblemBase.h.
Referenced by FEProblemBase::addTimeIntegrator(), and FEProblemBase::hasTimeIntegrator().
|
protectedinherited |
AD flag indicating whether any AD objects have been added.
Definition at line 1114 of file SubProblem.h.
Referenced by DisplacedProblem::haveADObjects(), SubProblem::haveADObjects(), and FEProblemBase::haveADObjects().
|
protectedinherited |
Initial condition storage
Definition at line 2633 of file FEProblemBase.h.
Referenced by FEProblemBase::addInitialCondition(), FEProblemBase::getInitialConditionWarehouse(), and FEProblemBase::initialSetup().
|
protectedinherited |
Definition at line 2654 of file FEProblemBase.h.
Referenced by FEProblemBase::addIndicator(), FEProblemBase::computeIndicators(), FEProblemBase::customSetup(), FEProblemBase::initialSetup(), FEProblemBase::timestepSetup(), and FEProblemBase::updateActiveObjects().
|
protectedinherited |
Definition at line 2519 of file FEProblemBase.h.
Referenced by FEProblemBase::init().
|
protectedinherited |
whether input file has been written
Definition at line 2768 of file FEProblemBase.h.
|
protectedinherited |
Cache for calculating materials on interface.
Definition at line 2695 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), and FEProblemBase::needInterfaceMaterialOnSide().
|
protectedinherited |
Definition at line 2647 of file FEProblemBase.h.
Referenced by FEProblemBase::addInterfaceMaterial(), FEProblemBase::getInterfaceMaterialsWarehouse(), FEProblemBase::initialSetup(), FEProblemBase::needInterfaceMaterialOnSide(), and FEProblemBase::reinitMaterialsInterface().
|
protectedinherited |
Definition at line 2655 of file FEProblemBase.h.
Referenced by FEProblemBase::addIndicator(), FEProblemBase::computeIndicators(), FEProblemBase::customSetup(), FEProblemBase::getInternalSideIndicatorWarehouse(), FEProblemBase::initialSetup(), FEProblemBase::timestepSetup(), and FEProblemBase::updateActiveObjects().
|
protectedinherited |
If or not PETSc options have been added to database.
Definition at line 2876 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::petscOptionsInserted(), FEProblemBase::solve(), and FEProblemBase::solveLinearSystem().
|
protectedinherited |
Definition at line 2813 of file FEProblemBase.h.
Referenced by FEProblemBase::checkProblemIntegrity().
|
protectedinherited |
Determines whether and which subdomains are to be checked to ensure that they have an active kernel.
Definition at line 2812 of file FEProblemBase.h.
Referenced by FEProblemBase::checkProblemIntegrity(), and FEProblemBase::setKernelCoverageCheck().
|
protectedinherited |
Definition at line 2878 of file FEProblemBase.h.
Referenced by FEProblem::addLineSearch(), FEProblemBase::customSetup(), FEProblemBase::getLineSearch(), FEProblemBase::initialSetup(), FEProblemBase::lineSearch(), and FEProblemBase::timestepSetup().
|
protectedinherited |
Linear system(s) convergence name(s) (if any)
Definition at line 2524 of file FEProblemBase.h.
Referenced by FEProblemBase::getLinearConvergenceNames(), FEProblemBase::hasLinearConvergenceObjects(), and FEProblemBase::setLinearConvergenceNames().
|
protectedinherited |
Temporary storage for filtered matrix tags for linear systems.
Definition at line 2536 of file FEProblemBase.h.
Referenced by FEProblemBase::computeLinearSystemSys().
|
protectedinherited |
Map from linear system name to number.
Definition at line 2563 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), and FEProblemBase::linearSysNum().
|
protectedinherited |
The linear system names.
Definition at line 2554 of file FEProblemBase.h.
Referenced by DumpObjectsProblem::DumpObjectsProblem(), EigenProblem::EigenProblem(), FEProblem::FEProblem(), FEProblemBase::FEProblemBase(), and FEProblemBase::getLinearSystemNames().
|
protectedinherited |
The vector of linear systems.
Definition at line 2560 of file FEProblemBase.h.
Referenced by FEProblemBase::computeResidualL2Norm(), FEProblemBase::currentLinearSysNum(), DumpObjectsProblem::DumpObjectsProblem(), FEProblem::FEProblem(), FEProblemBase::getLinearSystem(), FEProblem::init(), FEProblemBase::setCurrentLinearSystem(), and FEProblemBase::systemBaseLinear().
|
protectedinherited |
Temporary storage for filtered vector tags for linear systems.
Definition at line 2533 of file FEProblemBase.h.
Referenced by FEProblemBase::computeLinearSystemSys().
|
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 |
Definition at line 2659 of file FEProblemBase.h.
Referenced by FEProblemBase::addMarker(), FEProblemBase::computeMarkers(), FEProblemBase::customSetup(), FEProblemBase::getMarkerWarehouse(), FEProblemBase::initialSetup(), FEProblemBase::timestepSetup(), and FEProblemBase::updateActiveObjects().
|
protectedinherited |
Definition at line 2825 of file FEProblemBase.h.
Referenced by FEProblemBase::checkProblemIntegrity().
|
protectedinherited |
Determines whether and which subdomains are to be checked to ensure that they have an active material.
Definition at line 2824 of file FEProblemBase.h.
Referenced by FEProblemBase::checkProblemIntegrity(), and FEProblemBase::setMaterialCoverageCheck().
|
protectedinherited |
Determines whether a check to verify material dependencies on every subdomain.
Definition at line 2831 of file FEProblemBase.h.
Referenced by FEProblemBase::checkProblemIntegrity().
|
protectedinherited |
Definition at line 2639 of file FEProblemBase.h.
Referenced by FEProblemBase::getMaterialPropertyRegistry().
|
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 |
Definition at line 2640 of file FEProblemBase.h.
Referenced by FEProblemBase::addAnyRedistributers(), FEProblemBase::advanceState(), FEProblemBase::checkDependMaterialsHelper(), FEProblemBase::checkProblemIntegrity(), FEProblemBase::getMaterialData(), FEProblemBase::initElementStatefulProps(), FEProblemBase::initialSetup(), FEProblemBase::initXFEM(), FEProblemBase::meshChanged(), FEProblemBase::reinitMaterials(), and FEProblemBase::swapBackMaterials().
|
protectedinherited |
Definition at line 2646 of file FEProblemBase.h.
Referenced by FEProblemBase::addFunctorMaterial(), FEProblemBase::addMaterial(), FEProblemBase::getFVMatsAndDependencies(), FEProblemBase::getRegularMaterialsWarehouse(), FEProblemBase::initialSetup(), FEProblemBase::prepareMaterials(), FEProblemBase::reinitMaterials(), FEProblemBase::reinitMaterialsBoundary(), FEProblemBase::reinitMaterialsFace(), FEProblemBase::reinitMaterialsNeighbor(), and FEProblemBase::updateActiveObjects().
|
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().
|
protectedinherited |
Maximum number of quadrature points used in the problem.
Definition at line 2837 of file FEProblemBase.h.
Referenced by FEProblemBase::getMaxQps(), FEProblemBase::reinitDirac(), and FEProblemBase::updateMaxQps().
|
protectedinherited |
Maximum scalar variable order.
Definition at line 2840 of file FEProblemBase.h.
Referenced by FEProblemBase::addAuxScalarVariable(), and FEProblemBase::getMaxScalarOrder().
|
protectedinherited |
Definition at line 2489 of file FEProblemBase.h.
Referenced by FEProblemBase::adaptMesh(), FEProblemBase::addAnyRedistributers(), FEProblemBase::addAuxVariable(), FEProblemBase::addGhostedBoundary(), FEProblemBase::addGhostedElem(), FEProblemBase::addVariable(), FEProblemBase::checkCoordinateSystems(), FEProblemBase::checkDependMaterialsHelper(), FEProblemBase::checkProblemIntegrity(), FEProblemBase::checkUserObjects(), FEProblemBase::computeIndicators(), FEProblemBase::computeMarkers(), FEProblemBase::computeUserObjectsInternal(), DumpObjectsProblem::dumpVariableHelper(), FEProblemBase::duplicateVariableCheck(), FEProblemBase::getCurrentAlgebraicBndNodeRange(), FEProblemBase::getCurrentAlgebraicElementRange(), FEProblemBase::getCurrentAlgebraicNodeRange(), FEProblemBase::getDiracElements(), FEProblemBase::getEvaluableElementRange(), FEProblemBase::getNonlinearEvaluableElementRange(), FEProblemBase::ghostGhostedBoundaries(), FEProblemBase::init(), FEProblemBase::initialAdaptMesh(), FEProblemBase::initialSetup(), FEProblemBase::initXFEM(), MFEMProblem::mesh(), FEProblemBase::mesh(), FEProblemBase::meshChanged(), FEProblemBase::possiblyRebuildGeomSearchPatches(), FEProblemBase::prepareMaterials(), FEProblemBase::projectSolution(), FEProblemBase::reinitElemNeighborAndLowerD(), FEProblemBase::reinitElemPhys(), FEProblemBase::setAxisymmetricCoordAxis(), FEProblemBase::setCoordSystem(), FEProblemBase::timestepSetup(), FEProblemBase::uniformRefine(), and FEProblemBase::updateMaxQps().
|
protectedinherited |
Warehouse to store mesh divisions NOTE: this could probably be moved to the MooseMesh instead of the Problem Time (and people's uses) will tell where this fits best.
Definition at line 2617 of file FEProblemBase.h.
Referenced by FEProblemBase::addMeshDivision(), and FEProblemBase::getMeshDivision().
|
protectedinherited |
Definition at line 2758 of file FEProblemBase.h.
Referenced by FEProblemBase::checkProblemIntegrity(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualTags(), FEProblemBase::createMortarInterface(), FEProblemBase::getMortarInterface(), FEProblemBase::getMortarInterfaces(), FEProblemBase::init(), FEProblemBase::initialSetup(), FEProblemBase::mortarData(), FEProblemBase::reinitBecauseOfGhostingOrNewGeomObjects(), and FEProblemBase::updateMortarMesh().
|
protectedinherited |
MultiApp Warehouse.
Definition at line 2668 of file FEProblemBase.h.
Referenced by FEProblemBase::addMultiApp(), FEProblemBase::backupMultiApps(), FEProblemBase::execMultiApps(), FEProblemBase::execMultiAppTransfers(), FEProblemBase::finalizeMultiApps(), FEProblemBase::finishMultiAppStep(), FEProblemBase::getMultiApp(), FEProblemBase::getMultiAppWarehouse(), FEProblemBase::hasMultiApp(), FEProblemBase::hasMultiApps(), FEProblemBase::incrementMultiAppTStep(), FEProblemBase::initialSetup(), FEProblemBase::parentOutputPositionChanged(), FEProblemBase::postExecute(), FEProblemBase::restoreMultiApps(), and FEProblemBase::updateActiveObjects().
|
protectedinherited |
MultiApp fixed point convergence name.
Definition at line 2526 of file FEProblemBase.h.
Referenced by FEProblemBase::getMultiAppFixedPointConvergenceName(), FEProblemBase::hasSetMultiAppFixedPointConvergenceName(), and FEProblemBase::setMultiAppFixedPointConvergenceName().
|
protectedinherited |
The name of this class.
Definition at line 90 of file MooseBase.h.
Referenced by AddBCAction::act(), AddConstraintAction::act(), PartitionerAction::act(), AddFVInterfaceKernelAction::act(), AddUserObjectAction::act(), AddFVInitialConditionAction::act(), AddInitialConditionAction::act(), AddKernelAction::act(), AddFunctorMaterialAction::act(), AddMeshGeneratorAction::act(), AddVectorPostprocessorAction::act(), AddInterfaceKernelAction::act(), AddMarkerAction::act(), AddNodalKernelAction::act(), AddScalarKernelAction::act(), AddIndicatorAction::act(), AddPostprocessorAction::act(), AddDamperAction::act(), AddMultiAppAction::act(), AddMaterialAction::act(), AddTransferAction::act(), ReadExecutorParamsAction::act(), AddDiracKernelAction::act(), AddDGKernelAction::act(), AddPositionsAction::act(), AddReporterAction::act(), AddTimesAction::act(), AddFieldSplitAction::act(), AddFVKernelAction::act(), AddFVBCAction::act(), SetupPreconditionerAction::act(), SetupTimeIntegratorAction::act(), AddFunctionAction::act(), AddConvergenceAction::act(), AddMeshDivisionAction::act(), AddHDGKernelAction::act(), AddTimeStepperAction::act(), AddDistributionAction::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(), FillBetweenCurvesGenerator::generate(), FillBetweenPointVectorsGenerator::generate(), FillBetweenSidesetsGenerator::generate(), NearestPointBase< LayeredSideDiffusiveFluxAverage, SideIntegralVariableUserObject >::name(), ParsedFunctorMaterialTempl< is_ad >::ParsedFunctorMaterialTempl(), PiecewiseBilinear::PiecewiseBilinear(), PiecewiseLinearInterpolationMaterial::PiecewiseLinearInterpolationMaterial(), PiecewiseBase::setData(), and AddVariableAction::varName().
|
protectedinherited |
Flag that the problem needs to add the default fixed point convergence.
Definition at line 2551 of file FEProblemBase.h.
Referenced by FEProblemBase::needToAddDefaultMultiAppFixedPointConvergence(), and FEProblemBase::setNeedToAddDefaultMultiAppFixedPointConvergence().
|
protectedinherited |
Flag that the problem needs to add the default nonlinear convergence.
Definition at line 2549 of file FEProblemBase.h.
Referenced by FEProblemBase::needToAddDefaultNonlinearConvergence(), and FEProblemBase::setNeedToAddDefaultNonlinearConvergence().
|
protectedinherited |
Indicates that we need to compute variable values for previous Newton iteration.
Definition at line 2795 of file FEProblemBase.h.
|
protectedinherited |
Definition at line 2642 of file FEProblemBase.h.
Referenced by FEProblemBase::addAnyRedistributers(), FEProblemBase::advanceState(), FEProblemBase::checkProblemIntegrity(), FEProblemBase::getMaterialData(), FEProblemBase::getNeighborMaterialPropertyStorage(), FEProblemBase::initElementStatefulProps(), FEProblemBase::initialSetup(), FEProblemBase::meshChanged(), FEProblemBase::reinitMaterialsNeighbor(), and FEProblemBase::swapBackMaterialsNeighbor().
|
protectedinherited |
Definition at line 2881 of file FEProblemBase.h.
Referenced by FEProblemBase::getNonlinearEvaluableElementRange(), and FEProblemBase::meshChanged().
|
protectedinherited |
Definition at line 39 of file FEProblem.h.
Referenced by FEProblem::FEProblem(), FEProblem::getNonlinearSystem(), and FEProblem::init().
|
protectedinherited |
Map from nonlinear system name to number.
Definition at line 2581 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), and FEProblemBase::nlSysNum().
|
protectedinherited |
The nonlinear system names.
Definition at line 2572 of file FEProblemBase.h.
Referenced by DumpObjectsProblem::DumpObjectsProblem(), EigenProblem::EigenProblem(), FEProblem::FEProblem(), FEProblemBase::FEProblemBase(), and FEProblemBase::getNonlinearSystemNames().
|
protectedinherited |
Nonlinear system(s) convergence name(s)
Definition at line 2522 of file FEProblemBase.h.
Referenced by FEProblemBase::getNonlinearConvergenceNames(), and FEProblemBase::setNonlinearConvergenceNames().
|
protectedinherited |
nonlocal integrated_bcs
Definition at line 2629 of file FEProblemBase.h.
Referenced by FEProblemBase::checkNonlocalCoupling(), FEProblemBase::setNonlocalCouplingMatrix(), and FEProblemBase::timestepSetup().
|
protectedinherited |
nonlocal kernels
Definition at line 2626 of file FEProblemBase.h.
Referenced by FEProblemBase::checkNonlocalCoupling(), FEProblemBase::setNonlocalCouplingMatrix(), and FEProblemBase::timestepSetup().
|
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(), and SubProblem::vectorTagNotZeroed().
|
protectedinherited |
Objects to be notified when the mesh changes.
Definition at line 2698 of file FEProblemBase.h.
Referenced by FEProblemBase::meshChanged(), and FEProblemBase::notifyWhenMeshChanges().
|
protectedinherited |
Objects to be notified when the mesh displaces.
Definition at line 2701 of file FEProblemBase.h.
Referenced by FEProblemBase::meshDisplaced(), and FEProblemBase::notifyWhenMeshDisplaces().
|
protectedinherited |
The number of linear systems.
Definition at line 2557 of file FEProblemBase.h.
Referenced by FEProblem::FEProblem(), FEProblemBase::FEProblemBase(), FEProblem::init(), FEProblemBase::numLinearSystems(), and FEProblemBase::numSolverSystems().
|
protectedinherited |
The number of nonlinear systems.
Definition at line 2575 of file FEProblemBase.h.
Referenced by ExternalProblem::ExternalProblem(), FEProblem::FEProblem(), FEProblemBase::FEProblemBase(), FEProblem::init(), FEProblemBase::isSolverSystemNonlinear(), FEProblemBase::numNonlinearSystems(), and FEProblemBase::numSolverSystems().
|
protectedinherited |
Whether or not information about how many transfers have completed is printed.
Definition at line 2849 of file FEProblemBase.h.
Referenced by FEProblemBase::backupMultiApps(), FEProblemBase::execMultiApps(), FEProblemBase::execMultiAppTransfers(), FEProblemBase::finishMultiAppStep(), FEProblemBase::restoreMultiApps(), and FEProblemBase::setParallelBarrierMessaging().
|
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 |
Definition at line 2872 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::petscOptionsDatabase(), EigenProblem::solve(), FEProblemBase::solve(), FEProblemBase::solveLinearSystem(), and FEProblemBase::~FEProblemBase().
|
protectedinherited |
PETSc option storage.
Definition at line 2870 of file FEProblemBase.h.
Referenced by FEProblemBase::getPetscOptions(), FEProblemBase::solve(), and FEProblemBase::solveLinearSystem().
|
protectedinherited |
The MooseApp that owns the PerfGraph.
Definition at line 124 of file PerfGraphInterface.h.
Referenced by PerfGraphInterface::perfGraph().
|
inherited |
Definition at line 2027 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::initialSetup(), and FEProblemBase::~FEProblemBase().
|
inherited |
Definition at line 2035 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase().
|
protectedinherited |
A prefix to use for all sections.
Definition at line 127 of file PerfGraphInterface.h.
Referenced by PerfGraphInterface::timedSectionName().
|
protectedinherited |
Indicates we need to save the previous NL iteration variable values.
Definition at line 2798 of file FEProblemBase.h.
Referenced by FEProblemBase::createTagSolutions().
|
protectedinherited |
A map of objects that consume random numbers.
Definition at line 2686 of file FEProblemBase.h.
Referenced by FEProblemBase::computeJacobianTags(), FEProblemBase::computeLinearSystemTags(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualTags(), FEProblemBase::initialSetup(), FEProblemBase::registerRandomInterface(), and FEProblemBase::timestepSetup().
|
inherited |
Convenience zeros.
Definition at line 2024 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase().
|
protectedinherited |
Whether to call DisplacedProblem::reinitElem when this->reinitElem is called.
Definition at line 2761 of file FEProblemBase.h.
Referenced by FEProblemBase::addAuxKernel(), FEProblemBase::addDiracKernel(), FEProblemBase::addFVKernel(), FEProblemBase::addHDGKernel(), FEProblemBase::addIndicator(), FEProblemBase::addKernel(), FEProblemBase::addMarker(), FEProblemBase::addMaterialHelper(), FEProblemBase::addMultiApp(), FEProblemBase::addNodalKernel(), FEProblemBase::addTransfer(), FEProblemBase::addUserObject(), FEProblemBase::prepareAssembly(), FEProblemBase::prepareFace(), FEProblemBase::reinitDirac(), FEProblemBase::reinitElem(), FEProblemBase::reinitElemNeighborAndLowerD(), FEProblemBase::reinitNode(), FEProblemBase::reinitNodes(), FEProblemBase::reinitNodesNeighbor(), FEProblemBase::reinitScalars(), and FEProblemBase::setCurrentSubdomainID().
|
protectedinherited |
Whether to call DisplacedProblem::reinitElemFace when this->reinitElemFace is called.
Definition at line 2763 of file FEProblemBase.h.
Referenced by FEProblemBase::addAuxKernel(), FEProblemBase::addBoundaryCondition(), FEProblemBase::addConstraint(), FEProblemBase::addMaterialHelper(), FEProblemBase::addUserObject(), FEProblemBase::prepareAssembly(), FEProblemBase::prepareFace(), FEProblemBase::reinitElemNeighborAndLowerD(), FEProblemBase::reinitNodeFace(), and FEProblemBase::setCurrentSubdomainID().
|
protectedinherited |
Whether to call DisplacedProblem::reinitNeighbor when this->reinitNeighbor is called.
Definition at line 2765 of file FEProblemBase.h.
Referenced by FEProblemBase::addDGKernel(), FEProblemBase::addInterfaceKernel(), FEProblemBase::addMaterialHelper(), FEProblemBase::addUserObject(), FEProblemBase::reinitElemNeighborAndLowerD(), FEProblemBase::reinitNeighbor(), and FEProblemBase::setCurrentSubdomainID().
|
protectedinherited |
Definition at line 2662 of file FEProblemBase.h.
Referenced by FEProblemBase::advanceState(), FEProblemBase::checkDuplicatePostprocessorVariableNames(), FEProblemBase::getPostprocessorValueByName(), FEProblemBase::getReporterData(), FEProblemBase::getVectorPostprocessorValueByName(), FEProblemBase::hasPostprocessorValueByName(), FEProblemBase::initialSetup(), FEProblemBase::joinAndFinalize(), FEProblemBase::restoreSolutions(), FEProblemBase::setPostprocessorValueByName(), and FEProblemBase::setVectorPostprocessorValueByName().
|
protectedinherited |
Reference to the application.
Definition at line 227 of file Restartable.h.
Referenced by Restartable::registerRestartableDataOnApp(), and Restartable::registerRestartableNameWithFilterOnApp().
|
protectedinherited |
Flag for toggling read only status (see ReporterData)
Definition at line 236 of file Restartable.h.
Referenced by Restartable::registerRestartableDataOnApp().
|
protectedinherited |
The system name this object is in.
Definition at line 230 of file Restartable.h.
Referenced by Restartable::restartableName().
|
protectedinherited |
The thread ID for this object.
Definition at line 233 of file Restartable.h.
Referenced by Restartable::declareRestartableDataHelper().
|
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 |
Definition at line 2635 of file FEProblemBase.h.
Referenced by FEProblemBase::addInitialCondition(), FEProblemBase::initialSetup(), FEProblemBase::projectInitialConditionOnCustomRange(), and FEProblemBase::projectSolution().
|
inherited |
Definition at line 2025 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::reinitDirac(), FEProblemBase::updateMaxQps(), and FEProblemBase::~FEProblemBase().
|
inherited |
Definition at line 2034 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::initialSetup(), and FEProblemBase::~FEProblemBase().
|
inherited |
Definition at line 2032 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::reinitDirac(), FEProblemBase::updateMaxQps(), and FEProblemBase::~FEProblemBase().
|
protectedinherited |
If or not skip 'exception and stop solve'.
Definition at line 2780 of file FEProblemBase.h.
Referenced by FEProblemBase::checkExceptionAndStopSolve(), FEProblemBase::initialSetup(), and FEProblemBase::skipExceptionCheck().
|
protectedinherited |
If or not to resuse the base vector for matrix-free calculation.
Definition at line 2777 of file FEProblemBase.h.
Referenced by FEProblemBase::setSNESMFReuseBase(), and FEProblemBase::useSNESMFReuseBase().
|
protectedinherited |
If or not _snesmf_reuse_base is set by user.
Definition at line 2783 of file FEProblemBase.h.
Referenced by FEProblemBase::isSNESMFReuseBaseSetbyUser(), and FEProblemBase::setSNESMFReuseBase().
|
protectedinherited |
Whether or not to actually solve the nonlinear system.
Definition at line 2539 of file FEProblemBase.h.
Referenced by FEProblemBase::checkProblemIntegrity(), FEProblemBase::FEProblemBase(), FEProblemBase::init(), FEProblemBase::shouldSolve(), EigenProblem::solve(), FEProblemBase::solve(), FEProblemBase::solveLinearSystem(), EigenProblem::solverSystemConverged(), and FEProblemBase::solverSystemConverged().
|
protectedinherited |
Definition at line 2809 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::solve(), FEProblemBase::solveLinearSystem(), and FEProblemBase::solverParams().
|
protectedinherited |
Map connecting solver system names with their respective systems.
Definition at line 2596 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), and FEProblemBase::solverSysNum().
|
protectedinherited |
The union of nonlinear and linear system names.
Definition at line 2599 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::getSolverSystemNames(), Moose::PetscSupport::setSinglePetscOption(), and FEProblemBase::solverSysNum().
|
protectedinherited |
Combined container to base pointer of every solver system.
Definition at line 2590 of file FEProblemBase.h.
Referenced by FEProblemBase::addAuxKernel(), FEProblemBase::addObjectParamsHelper(), FEProblemBase::addTimeIntegrator(), FEProblemBase::addVariable(), FEProblemBase::advanceState(), FEProblemBase::computeSystems(), FEProblemBase::copySolutionsBackwards(), FEProblemBase::createQRules(), FEProblemBase::createTagSolutions(), FEProblemBase::createTagVectors(), FEProblemBase::determineSolverSystem(), DumpObjectsProblem::DumpObjectsProblem(), FEProblemBase::duplicateVariableCheck(), EigenProblem::EigenProblem(), ExternalProblem::ExternalProblem(), FEProblem::FEProblem(), FEProblemBase::getActualFieldVariable(), FEProblemBase::getArrayVariable(), FEProblemBase::getScalarVariable(), FEProblemBase::getSolverSystem(), FEProblemBase::getStandardVariable(), FEProblemBase::getSystem(), FEProblemBase::getSystemBase(), FEProblemBase::getVariable(), FEProblemBase::getVariableNames(), FEProblemBase::getVectorVariable(), FEProblemBase::hasScalarVariable(), FEProblemBase::hasSolverVariable(), FEProblemBase::hasVariable(), FEProblemBase::init(), FEProblemBase::initialSetup(), FEProblemBase::meshChanged(), FEProblemBase::needSolutionState(), FEProblemBase::outputStep(), FEProblemBase::projectSolution(), FEProblemBase::reinitElem(), FEProblemBase::reinitElemPhys(), FEProblemBase::restoreOldSolutions(), FEProblemBase::restoreSolutions(), FEProblemBase::saveOldSolutions(), FEProblemBase::setCurrentSubdomainID(), Moose::PetscSupport::setSinglePetscOption(), FEProblemBase::setVariableAllDoFMap(), FEProblemBase::solverSystemConverged(), FEProblemBase::systemBaseSolver(), FEProblemBase::systemNumForVariable(), and FEProblemBase::timestepSetup().
|
protectedinherited |
Map connecting variable names with their respective solver systems.
Definition at line 2593 of file FEProblemBase.h.
Referenced by FEProblemBase::addVariable(), and FEProblemBase::determineSolverSystem().
|
protectedinherited |
Dimension of the subspace spanned by the vectors with a given prefix.
Definition at line 2608 of file FEProblemBase.h.
Referenced by FEProblemBase::initNullSpaceVectors(), and FEProblemBase::subspaceDim().
|
protectedinherited |
Definition at line 2544 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::timeStep(), and FEProblemBase::timestepSetup().
|
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 |
Definition at line 2542 of file FEProblemBase.h.
Referenced by FEProblemBase::execMultiApps(), FEProblemBase::FEProblemBase(), FEProblemBase::incrementMultiAppTStep(), FEProblemBase::initialSetup(), FEProblemBase::time(), and FEProblemBase::updateMeshXFEM().
|
protectedinherited |
Definition at line 2543 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::initialSetup(), and FEProblemBase::timeOld().
|
protectedinherited |
Transfers executed just before MultiApps to transfer data to them.
Definition at line 2677 of file FEProblemBase.h.
Referenced by FEProblemBase::addTransfer(), FEProblemBase::execMultiAppTransfers(), FEProblemBase::getMultiAppTransferWarehouse(), FEProblemBase::getTransfers(), FEProblemBase::initialSetup(), and FEProblemBase::updateActiveObjects().
|
protectedinherited |
Normal Transfers.
Definition at line 2674 of file FEProblemBase.h.
Referenced by FEProblemBase::addTransfer(), FEProblemBase::execTransfers(), FEProblemBase::initialSetup(), and FEProblemBase::updateActiveObjects().
|
protectedinherited |
Definition at line 2541 of file FEProblemBase.h.
Referenced by FEProblemBase::isTransient(), and FEProblemBase::transient().
|
protectedinherited |
Storage for TransientMultiApps (only needed for calling 'computeDT')
Definition at line 2671 of file FEProblemBase.h.
Referenced by FEProblemBase::addMultiApp(), FEProblemBase::computeMultiAppsDT(), and FEProblemBase::updateActiveObjects().
|
protectedinherited |
The type of this class.
Definition at line 87 of file MooseBase.h.
Referenced by ExplicitTimeIntegrator::ExplicitTimeIntegrator(), FEProblemSolve::FEProblemSolve(), FillBetweenSidesetsGenerator::generate(), FillBetweenCurvesGenerator::generate(), FillBetweenPointVectorsGenerator::generate(), ExplicitTimeIntegrator::init(), FEProblemBase::init(), MooseStaticCondensationPreconditioner::MooseStaticCondensationPreconditioner(), PhysicsBasedPreconditioner::PhysicsBasedPreconditioner(), FEProblemBase::solverTypeString(), and MooseBase::type().
|
protectedinherited |
Whether or not checking the state of uo/aux evaluation.
Definition at line 2834 of file FEProblemBase.h.
Referenced by FEProblemBase::execute(), and FEProblemBase::hasUOAuxStateCheck().
|
protectedinherited |
Definition at line 2804 of file FEProblemBase.h.
Referenced by FEProblemBase::checkUserObjectJacobianRequirement(), FEProblemBase::FEProblemBase(), FEProblemBase::getUserObjectJacobianVariables(), FEProblemBase::initialSetup(), and FEProblemBase::meshChanged().
|
protectedinherited |
True if any variables are grouped.
Definition at line 43 of file ReferenceResidualInterface.h.
Referenced by ReferenceResidualInterface::addGroupVariables(), ReferenceResidualConvergence::initialSetup(), and ReferenceResidualInterface::ReferenceResidualInterface().
|
protectedinherited |
Whether to assemble matrices using hash tables instead of preallocating matrix memory.
This can be a good option if the sparsity pattern changes throughout the course of the simulation
Definition at line 2897 of file FEProblemBase.h.
Referenced by EigenProblem::EigenProblem(), and FEProblem::FEProblem().
|
protectedinherited |
Definition at line 38 of file FEProblem.h.
Referenced by FEProblem::FEProblem(), FEProblem::getUseNonlinear(), and FEProblem::setUseNonlinear().
|
protectedinherited |
Automatic differentiaion (AD) flag which indicates whether any consumer has requested an AD material property or whether any suppier has declared an AD material property.
Definition at line 2890 of file FEProblemBase.h.
|
protectedinherited |
Boolean to check if we have the default nonlinear system.
Definition at line 2569 of file FEProblemBase.h.
|
inherited |
Definition at line 674 of file SubProblem.h.
Referenced by MooseVariableBase::allDofIndices(), FEProblemBase::setNonlocalCouplingMatrix(), and FEProblemBase::setVariableAllDoFMap().
|
inherited |
Definition at line 2037 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::reinitDirac(), FEProblemBase::updateMaxQps(), and FEProblemBase::~FEProblemBase().
|
inherited |
Definition at line 2036 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::reinitDirac(), FEProblemBase::updateMaxQps(), and FEProblemBase::~FEProblemBase().
|
protectedinherited |
Whether or not to be verbose with multiapps.
Definition at line 2855 of file FEProblemBase.h.
Referenced by FEProblemBase::backupMultiApps(), FEProblemBase::execMultiApps(), FEProblemBase::execMultiAppTransfers(), FEProblemBase::finishMultiAppStep(), FEProblemBase::restoreMultiApps(), FEProblemBase::setVerboseProblem(), and FEProblemBase::verboseMultiApps().
|
protectedinherited |
Whether or not to be verbose on solution restoration post a failed time step.
Definition at line 2858 of file FEProblemBase.h.
Referenced by FEProblemBase::restoreSolutions(), and FEProblemBase::setVerboseProblem().
|
protectedinherited |
Whether or not to be verbose during setup.
Definition at line 2852 of file FEProblemBase.h.
Referenced by FEProblemBase::logAdd(), and FEProblemBase::setVerboseProblem().
|
protectedinherited |
Pointer to XFEM controller.
Definition at line 2752 of file FEProblemBase.h.
Referenced by FEProblemBase::getXFEM(), FEProblemBase::haveXFEM(), FEProblemBase::initXFEM(), and FEProblemBase::updateMeshXFEM().
|
inherited |
Definition at line 2026 of file FEProblemBase.h.
Referenced by FEProblemBase::FEProblemBase(), FEProblemBase::reinitDirac(), FEProblemBase::updateMaxQps(), and FEProblemBase::~FEProblemBase().
|
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().