#include <FileMesh.h>
| Public Types | |
| enum | ParallelType { ParallelType::DEFAULT, ParallelType::REPLICATED, ParallelType::DISTRIBUTED } | 
| using | PeriodicNodeInfo = std::pair< const Node *, BoundaryID > | 
| Helper type for building periodic node maps.  More... | |
| using | DataFileParameterType = DataFileName | 
| The parameter type this interface expects for a data file name.  More... | |
| Public Member Functions | |
| FileMesh (const InputParameters ¶meters) | |
| FileMesh (const FileMesh &other_mesh) | |
| virtual | ~FileMesh () | 
| virtual std::unique_ptr< MooseMesh > | safeClone () const override | 
| A safer version of the clone() method that hands back an allocated object wrapped in a smart pointer.  More... | |
| virtual void | buildMesh () override | 
| Must be overridden by child classes.  More... | |
| void | read (const std::string &file_name) | 
| void | setFileName (const std::string &file_name) | 
| virtual std::string | getFileName () const override | 
| Returns the name of the mesh file read to produce this mesh if any or an empty string otherwise.  More... | |
| virtual MooseMesh & | clone () const | 
| Clone method.  More... | |
| void | determineUseDistributedMesh () | 
| Determine whether to use a distributed mesh.  More... | |
| std::unique_ptr< MeshBase > | buildMeshBaseObject (unsigned int dim=libMesh::invalid_uint) | 
| Method to construct a libMesh::MeshBase object that is normally set and used by the MooseMesh object during the "init()" phase.  More... | |
| template<typename T > | |
| std::unique_ptr< T > | buildTypedMesh (unsigned int dim=libMesh::invalid_uint) | 
| Shortcut method to construct a unique pointer to a libMesh mesh instance.  More... | |
| void | setMeshBase (std::unique_ptr< MeshBase > mesh_base) | 
| Method to set the mesh_base object.  More... | |
| virtual void | init () | 
| Initialize the Mesh object.  More... | |
| virtual unsigned int | dimension () const | 
| Returns MeshBase::mesh_dimension(), (not MeshBase::spatial_dimension()!) of the underlying libMesh mesh object.  More... | |
| virtual unsigned int | spatialDimension () const | 
| Returns MeshBase::spatial_dimension.  More... | |
| virtual unsigned int | effectiveSpatialDimension () const | 
| Returns the effective spatial dimension determined by the coordinates actually used by the mesh.  More... | |
| unsigned int | getBlocksMaxDimension (const std::vector< SubdomainName > &blocks) const | 
| Returns the maximum element dimension on the given blocks.  More... | |
| std::vector< BoundaryID > | getBoundaryIDs (const Elem *const elem, const unsigned short int side) const | 
| Returns a vector of boundary IDs for the requested element on the requested side.  More... | |
| const std::set< BoundaryID > & | getBoundaryIDs () const | 
| Returns a const reference to a set of all user-specified boundary IDs.  More... | |
| std::vector< BoundaryID > | getBoundaryIDs (const std::vector< BoundaryName > &boundary_name, bool generate_unknown=false) const | 
| Get the associated BoundaryID for the boundary names that are passed in.  More... | |
| const Elem * | getLowerDElem (const Elem *, unsigned short int) const | 
| Returns a const pointer to a lower dimensional element that corresponds to a side of a higher dimensional element.  More... | |
| unsigned int | getHigherDSide (const Elem *elem) const | 
| Returns the local side ID of the interior parent aligned with the lower dimensional element.  More... | |
| void | buildNodeList () | 
| Calls BoundaryInfo::build_node_list()/build_side_list() and makes separate copies of Nodes/Elems in those lists.  More... | |
| void | buildBndElemList () | 
| const std::map< dof_id_type, std::vector< dof_id_type > > & | nodeToElemMap () | 
| If not already created, creates a map from every node to all elements to which they are connected.  More... | |
| const std::map< dof_id_type, std::vector< dof_id_type > > & | nodeToActiveSemilocalElemMap () | 
| If not already created, creates a map from every node to all active semilocal elements to which they are connected.  More... | |
| virtual bnd_node_iterator | bndNodesBegin () | 
| Return iterators to the beginning/end of the boundary nodes list.  More... | |
| virtual bnd_node_iterator | bndNodesEnd () | 
| virtual bnd_elem_iterator | bndElemsBegin () | 
| Return iterators to the beginning/end of the boundary elements list.  More... | |
| virtual bnd_elem_iterator | bndElemsEnd () | 
| void | buildNodeListFromSideList () | 
| Calls BoundaryInfo::build_node_list_from_side_list().  More... | |
| std::vector< std::tuple< dof_id_type, unsigned short int, boundary_id_type > > | buildSideList () | 
| Calls BoundaryInfo::build_side_list(), returns a std::vector of (elem-id, side-id, bc-id) tuples.  More... | |
| std::vector< std::tuple< dof_id_type, unsigned short int, boundary_id_type > > | buildActiveSideList () const | 
| Calls BoundaryInfo::build_active_side_list.  More... | |
| unsigned int | sideWithBoundaryID (const Elem *const elem, const BoundaryID boundary_id) const | 
| Calls BoundaryInfo::side_with_boundary_id().  More... | |
| MeshBase::node_iterator | localNodesBegin () | 
| Calls local_nodes_begin/end() on the underlying libMesh mesh object.  More... | |
| MeshBase::const_node_iterator | localNodesBegin () const | 
| MeshBase::node_iterator | localNodesEnd () | 
| MeshBase::const_node_iterator | localNodesEnd () const | 
| MeshBase::element_iterator | activeLocalElementsBegin () | 
| Calls active_local_nodes_begin/end() on the underlying libMesh mesh object.  More... | |
| MeshBase::const_element_iterator | activeLocalElementsBegin () const | 
| const MeshBase::element_iterator | activeLocalElementsEnd () | 
| const MeshBase::const_element_iterator | activeLocalElementsEnd () const | 
| virtual dof_id_type | nNodes () const | 
| Calls n_nodes/elem() on the underlying libMesh mesh object.  More... | |
| virtual dof_id_type | nElem () const | 
| virtual dof_id_type | nLocalNodes () const | 
| virtual dof_id_type | nActiveElem () const | 
| virtual dof_id_type | nActiveLocalElem () const | 
| virtual SubdomainID | nSubdomains () const | 
| virtual unsigned int | nPartitions () const | 
| virtual bool | skipPartitioning () const | 
| virtual bool | skipNoncriticalPartitioning () const | 
| virtual dof_id_type | maxNodeId () const | 
| Calls max_node/elem_id() on the underlying libMesh mesh object.  More... | |
| virtual dof_id_type | maxElemId () const | 
| virtual const Node & | node (const dof_id_type i) const | 
| Various accessors (pointers/references) for Node "i".  More... | |
| virtual Node & | node (const dof_id_type i) | 
| virtual const Node & | nodeRef (const dof_id_type i) const | 
| virtual Node & | nodeRef (const dof_id_type i) | 
| virtual const Node * | nodePtr (const dof_id_type i) const | 
| virtual Node * | nodePtr (const dof_id_type i) | 
| virtual const Node * | queryNodePtr (const dof_id_type i) const | 
| virtual Node * | queryNodePtr (const dof_id_type i) | 
| virtual Elem * | elem (const dof_id_type i) | 
| Various accessors (pointers/references) for Elem "i".  More... | |
| virtual const Elem * | elem (const dof_id_type i) const | 
| virtual Elem * | elemPtr (const dof_id_type i) | 
| virtual const Elem * | elemPtr (const dof_id_type i) const | 
| virtual Elem * | queryElemPtr (const dof_id_type i) | 
| virtual const Elem * | queryElemPtr (const dof_id_type i) const | 
| bool | prepared () const | 
| Setter/getter for whether the mesh is prepared.  More... | |
| virtual void | prepared (bool state) | 
| void | needsPrepareForUse () | 
| If this method is called, we will call libMesh's prepare_for_use method when we call Moose's prepare method.  More... | |
| void | meshChanged () | 
| Declares that the MooseMesh has changed, invalidates cached data and rebuilds caches.  More... | |
| virtual void | onMeshChanged () | 
| Declares a callback function that is executed at the conclusion of meshChanged().  More... | |
| void | cacheChangedLists () | 
| Cache information about what elements were refined and coarsened in the previous step.  More... | |
| ConstElemPointerRange * | refinedElementRange () const | 
| Return a range that is suitable for threaded execution over elements that were just refined.  More... | |
| ConstElemPointerRange * | coarsenedElementRange () const | 
| Return a range that is suitable for threaded execution over elements that were just coarsened.  More... | |
| const std::vector< const Elem * > & | coarsenedElementChildren (const Elem *elem) const | 
| Get the newly removed children element ids for an element that was just coarsened.  More... | |
| void | updateActiveSemiLocalNodeRange (std::set< dof_id_type > &ghosted_elems) | 
| Clears the "semi-local" node list and rebuilds it.  More... | |
| bool | isSemiLocal (Node *const node) const | 
| Returns true if the node is semi-local.  More... | |
| const std::unordered_map< boundary_id_type, std::unordered_set< dof_id_type > > & | getBoundariesToElems () const | 
| Returns a map of boundaries to ids of elements on the boundary.  More... | |
| const std::unordered_map< boundary_id_type, std::unordered_set< dof_id_type > > & | getBoundariesToActiveSemiLocalElemIds () const | 
| Returns a map of boundaries to ids of elements on the boundary.  More... | |
| std::unordered_set< dof_id_type > | getBoundaryActiveSemiLocalElemIds (BoundaryID bid) const | 
| Return all ids of elements which have a side which is part of a sideset.  More... | |
| std::unordered_set< dof_id_type > | getBoundaryActiveNeighborElemIds (BoundaryID bid) const | 
| Return all ids of neighbors of elements which have a side which is part of a sideset.  More... | |
| bool | isBoundaryFullyExternalToSubdomains (BoundaryID bid, const std::set< SubdomainID > &blk_group) const | 
| Returns whether a boundary (given by its id) is not crossing through a group of blocks, by which we mean that elements on both sides of the boundary are in those blocks.  More... | |
| const std::set< SubdomainID > & | meshSubdomains () const | 
| Returns a read-only reference to the set of subdomains currently present in the Mesh.  More... | |
| const std::set< BoundaryID > & | meshBoundaryIds () const | 
| Returns a read-only reference to the set of boundary IDs currently present in the Mesh.  More... | |
| const std::set< BoundaryID > & | meshSidesetIds () const | 
| Returns a read-only reference to the set of sidesets currently present in the Mesh.  More... | |
| const std::set< BoundaryID > & | meshNodesetIds () const | 
| Returns a read-only reference to the set of nodesets currently present in the Mesh.  More... | |
| void | setBoundaryToNormalMap (std::unique_ptr< std::map< BoundaryID, RealVectorValue >> boundary_map) | 
| Sets the mapping between BoundaryID and normal vector Is called by AddAllSideSetsByNormals.  More... | |
| void | setBoundaryToNormalMap (std::map< BoundaryID, RealVectorValue > *boundary_map) | 
| void | setMeshBoundaryIDs (std::set< BoundaryID > boundary_IDs) | 
| Sets the set of BoundaryIDs Is called by AddAllSideSetsByNormals.  More... | |
| const RealVectorValue & | getNormalByBoundaryID (BoundaryID id) const | 
| Returns the normal vector associated with a given BoundaryID.  More... | |
| bool | prepare (const MeshBase *mesh_to_clone) | 
| Calls prepare_for_use() if the underlying MeshBase object isn't prepared, then communicates various boundary information on parallel meshes.  More... | |
| void | update () | 
| Calls buildNodeListFromSideList(), buildNodeList(), and buildBndElemList().  More... | |
| unsigned int | uniformRefineLevel () const | 
| Returns the level of uniform refinement requested (zero if AMR is disabled).  More... | |
| void | setUniformRefineLevel (unsigned int, bool deletion=true) | 
| Set uniform refinement level.  More... | |
| bool | skipDeletionRepartitionAfterRefine () const | 
| Return a flag indicating whether or not we should skip remote deletion and repartition after uniform refinements.  More... | |
| bool | skipRefineWhenUseSplit () const | 
| Whether or not skip uniform refinements when using a pre-split mesh.  More... | |
| void | addGhostedBoundary (BoundaryID boundary_id) | 
| This will add the boundary ids to be ghosted to this processor.  More... | |
| void | setGhostedBoundaryInflation (const std::vector< Real > &inflation) | 
| This sets the inflation amount for the bounding box for each partition for use in ghosting boundaries.  More... | |
| const std::set< unsigned int > & | getGhostedBoundaries () const | 
| Return a writable reference to the set of ghosted boundary IDs.  More... | |
| const std::vector< Real > & | getGhostedBoundaryInflation () const | 
| Return a writable reference to the _ghosted_boundaries_inflation vector.  More... | |
| void | ghostGhostedBoundaries () | 
| Actually do the ghosting of boundaries that need to be ghosted to this processor.  More... | |
| void | needGhostGhostedBoundaries (bool needghost) | 
| Whether or not we want to ghost ghosted boundaries.  More... | |
| unsigned int | getPatchSize () const | 
| Getter for the patch_size parameter.  More... | |
| unsigned int | getGhostingPatchSize () const | 
| Getter for the ghosting_patch_size parameter.  More... | |
| unsigned int | getMaxLeafSize () const | 
| Getter for the maximum leaf size parameter.  More... | |
| void | setPatchUpdateStrategy (Moose::PatchUpdateType patch_update_strategy) | 
| Set the patch size update strategy.  More... | |
| const Moose::PatchUpdateType & | getPatchUpdateStrategy () const | 
| Get the current patch update strategy.  More... | |
| libMesh::BoundingBox | getInflatedProcessorBoundingBox (Real inflation_multiplier=0.01) const | 
| Get a (slightly inflated) processor bounding box.  More... | |
| operator libMesh::MeshBase & () | |
| Implicit conversion operator from MooseMesh -> libMesh::MeshBase.  More... | |
| operator const libMesh::MeshBase & () const | |
| MeshBase & | getMesh () | 
| Accessor for the underlying libMesh Mesh object.  More... | |
| MeshBase & | getMesh (const std::string &name) | 
| const MeshBase & | getMesh () const | 
| const MeshBase & | getMesh (const std::string &name) const | 
| const MeshBase * | getMeshPtr () const | 
| const Moose::Kokkos::Mesh * | getKokkosMesh () const | 
| Accessor for Kokkos mesh object.  More... | |
| void | printInfo (std::ostream &os=libMesh::out, const unsigned int verbosity=0) const | 
| Calls print_info() on the underlying Mesh.  More... | |
| const std::set< SubdomainID > & | getNodeBlockIds (const Node &node) const | 
| Return list of blocks to which the given node belongs.  More... | |
| const std::vector< dof_id_type > & | getNodeList (boundary_id_type nodeset_id) const | 
| Return a writable reference to a vector of node IDs that belong to nodeset_id.  More... | |
| const Node * | addUniqueNode (const Point &p, Real tol=1e-6) | 
| Add a new node to the mesh.  More... | |
| Node * | addQuadratureNode (const Elem *elem, const unsigned short int side, const unsigned int qp, BoundaryID bid, const Point &point) | 
| Adds a fictitious "QuadratureNode".  More... | |
| Node * | getQuadratureNode (const Elem *elem, const unsigned short int side, const unsigned int qp) | 
| Get a specified quadrature node.  More... | |
| void | clearQuadratureNodes () | 
| Clear out any existing quadrature nodes.  More... | |
| BoundaryID | getBoundaryID (const BoundaryName &boundary_name) const | 
| Get the associated BoundaryID for the boundary name.  More... | |
| SubdomainID | getSubdomainID (const SubdomainName &subdomain_name) const | 
| Get the associated subdomain ID for the subdomain name.  More... | |
| std::vector< SubdomainID > | getSubdomainIDs (const std::vector< SubdomainName > &subdomain_names) const | 
| Get the associated subdomainIDs for the subdomain names that are passed in.  More... | |
| std::set< SubdomainID > | getSubdomainIDs (const std::set< SubdomainName > &subdomain_names) const | 
| void | setSubdomainName (SubdomainID subdomain_id, const SubdomainName &name) | 
| This method sets the name for subdomain_idtoname.  More... | |
| const std::string & | getSubdomainName (SubdomainID subdomain_id) const | 
| Return the name of a block given an id.  More... | |
| std::vector< SubdomainName > | getSubdomainNames (const std::vector< SubdomainID > &subdomain_ids) const | 
| Get the associated subdomainNames for the subdomain ids that are passed in.  More... | |
| void | setBoundaryName (BoundaryID boundary_id, BoundaryName name) | 
| This method sets the boundary name of the boundary based on the id parameter.  More... | |
| const std::string & | getBoundaryName (BoundaryID boundary_id) const | 
| Return the name of the boundary given the id.  More... | |
| void | buildPeriodicNodeMap (std::multimap< dof_id_type, dof_id_type > &periodic_node_map, unsigned int var_number, libMesh::PeriodicBoundaries *pbs) const | 
| This routine builds a multimap of boundary ids to matching boundary ids across all periodic boundaries in the system.  More... | |
| void | buildPeriodicNodeSets (std::map< BoundaryID, std::set< dof_id_type >> &periodic_node_sets, unsigned int var_number, libMesh::PeriodicBoundaries *pbs) const | 
| This routine builds a datastructure of node ids organized by periodic boundary ids.  More... | |
| Real | dimensionWidth (unsigned int component) const | 
| Returns the width of the requested dimension.  More... | |
| bool | detectOrthogonalDimRanges (Real tol=1e-6) | 
| This routine determines whether the Mesh is a regular orthogonal mesh (i.e.  More... | |
| void | addPeriodicVariable (unsigned int var_num, BoundaryID primary, BoundaryID secondary) | 
| For "regular orthogonal" meshes, determine if variable var_num is periodic with respect to the primary and secondary BoundaryIDs, record this fact in the _periodic_dim data structure.  More... | |
| bool | isTranslatedPeriodic (unsigned int nonlinear_var_num, unsigned int component) const | 
| Returns whether this generated mesh is periodic in the given dimension for the given variable.  More... | |
| RealVectorValue | minPeriodicVector (unsigned int nonlinear_var_num, Point p, Point q) const | 
| This function returns the minimum vector between two points on the mesh taking into account periodicity for the given variable number.  More... | |
| Real | minPeriodicDistance (unsigned int nonlinear_var_num, Point p, Point q) const | 
| This function returns the distance between two points on the mesh taking into account periodicity for the given variable number.  More... | |
| const std::pair< BoundaryID, BoundaryID > * | getPairedBoundaryMapping (unsigned int component) | 
| This function attempts to return the paired boundary ids for the given component.  More... | |
| void | buildRefinementAndCoarseningMaps (Assembly *assembly) | 
| Create the refinement and coarsening maps necessary for projection of stateful material properties when using adaptivity.  More... | |
| const std::vector< std::vector< QpMap > > & | getRefinementMap (const Elem &elem, int parent_side, int child, int child_side) | 
| Get the refinement map for a given element type.  More... | |
| const std::vector< std::pair< unsigned int, QpMap > > & | getCoarseningMap (const Elem &elem, int input_side) | 
| Get the coarsening map for a given element type.  More... | |
| void | changeBoundaryId (const boundary_id_type old_id, const boundary_id_type new_id, bool delete_prev) | 
| Change all the boundary IDs for a given side from old_id to new_id.  More... | |
| const std::set< BoundaryID > & | getSubdomainBoundaryIds (const SubdomainID subdomain_id) const | 
| Get the list of boundary ids associated with the given subdomain id.  More... | |
| std::set< BoundaryID > | getSubdomainInterfaceBoundaryIds (const SubdomainID subdomain_id) const | 
| Get the list of boundaries that contact the given subdomain.  More... | |
| std::set< SubdomainID > | getBoundaryConnectedBlocks (const BoundaryID bid) const | 
| Get the list of subdomains associated with the given boundary.  More... | |
| std::set< SubdomainID > | getBoundaryConnectedSecondaryBlocks (const BoundaryID bid) const | 
| Get the list of subdomains associated with the given boundary of its secondary side.  More... | |
| std::set< SubdomainID > | getInterfaceConnectedBlocks (const BoundaryID bid) const | 
| Get the list of subdomains contacting the given boundary.  More... | |
| const std::set< SubdomainID > & | getBlockConnectedBlocks (const SubdomainID subdomain_id) const | 
| Get the list of subdomains neighboring a given subdomain.  More... | |
| bool | isBoundaryNode (dof_id_type node_id) const | 
| Returns true if the requested node is in the list of boundary nodes, false otherwise.  More... | |
| bool | isBoundaryNode (dof_id_type node_id, BoundaryID bnd_id) const | 
| Returns true if the requested node is in the list of boundary nodes for the specified boundary, false otherwise.  More... | |
| bool | isBoundaryElem (dof_id_type elem_id) const | 
| Returns true if the requested element is in the list of boundary elements, false otherwise.  More... | |
| bool | isBoundaryElem (dof_id_type elem_id, BoundaryID bnd_id) const | 
| Returns true if the requested element is in the list of boundary elements for the specified boundary, false otherwise.  More... | |
| void | errorIfDistributedMesh (std::string name) const | 
| Generate a unified error message if the underlying libMesh mesh is a DistributedMesh.  More... | |
| virtual bool | isDistributedMesh () const | 
| Returns the final Mesh distribution type.  More... | |
| bool | isParallelTypeForced () const | 
| Tell the user if the distribution was overriden for any reason.  More... | |
| void | setParallelType (ParallelType parallel_type) | 
| Allow to change parallel type.  More... | |
| ParallelType | getParallelType () const | 
| const MooseEnum & | partitionerName () const | 
| bool | isPartitionerForced () const | 
| Tell the user if the partitioner was overriden for any reason.  More... | |
| void | allowRecovery (bool allow) | 
| Set whether or not this mesh is allowed to read a recovery file.  More... | |
| void | setCustomPartitioner (libMesh::Partitioner *partitioner) | 
| Setter for custom partitioner.  More... | |
| bool | isRegularOrthogonal () | 
| Getter to query if the mesh was detected to be regular and orthogonal.  More... | |
| bool | hasSecondOrderElements () | 
| check if the mesh has SECOND order elements  More... | |
| virtual std::unique_ptr< libMesh::PointLocatorBase > | getPointLocator () const | 
| Proxy function to get a (sub)PointLocator from either the underlying libMesh mesh (default), or to allow derived meshes to return a custom point locator.  More... | |
| void | needsRemoteElemDeletion (bool need_delete) | 
| Set whether we need to delete remote elements.  More... | |
| bool | needsRemoteElemDeletion () const | 
| Whether we need to delete remote elements.  More... | |
| void | allowRemoteElementRemoval (bool allow_removal) | 
| Set whether to allow remote element removal.  More... | |
| bool | allowRemoteElementRemoval () const | 
| Whether we are allow remote element removal.  More... | |
| void | deleteRemoteElements () | 
| Delete remote elements.  More... | |
| bool | hasMeshBase () const | 
| Whether mesh base object was constructed or not.  More... | |
| bool | hasElementID (const std::string &id_name) const | 
| Whether mesh has an extra element integer with a given name.  More... | |
| unsigned int | getElementIDIndex (const std::string &id_name) const | 
| Return the accessing integer for an extra element integer with its name.  More... | |
| dof_id_type | maxElementID (unsigned int elem_id_index) const | 
| Return the maximum element ID for an extra element integer with its accessing index.  More... | |
| dof_id_type | minElementID (unsigned int elem_id_index) const | 
| Return the minimum element ID for an extra element integer with its accessing index.  More... | |
| bool | areElemIDsIdentical (const std::string &id_name1, const std::string &id_name2) const | 
| Whether or not two extra element integers are identical.  More... | |
| std::set< dof_id_type > | getAllElemIDs (unsigned int elem_id_index) const | 
| Return all the unique element IDs for an extra element integer with its index.  More... | |
| std::set< dof_id_type > | getElemIDsOnBlocks (unsigned int elem_id_index, const std::set< SubdomainID > &blks) const | 
| Return all the unique element IDs for an extra element integer with its index on a set of subdomains.  More... | |
| unsigned int | getMaxSidesPerElem () const | 
| Get the maximum number of sides per element.  More... | |
| unsigned int | getMaxNodesPerElem () const | 
| Get the maximum number of nodes per element.  More... | |
| unsigned int | getMaxNodesPerSide () const | 
| Get the maximum number of nodes per side.  More... | |
| std::unordered_map< dof_id_type, std::set< dof_id_type > > | getElemIDMapping (const std::string &from_id_name, const std::string &to_id_name) const | 
| void | cacheFaceInfoVariableOwnership () const | 
| Cache if variables live on the elements connected by the FaceInfo objects.  More... | |
| void | cacheFVElementalDoFs () const | 
| Cache the DoF indices for FV variables on each element.  More... | |
| void | computeFiniteVolumeCoords () const | 
| Compute the face coordinate value for all FaceInfoandElemInfoobjects.  More... | |
| void | isDisplaced (bool is_displaced) | 
| Set whether this mesh is a displaced mesh.  More... | |
| bool | isDisplaced () const | 
| whether this mesh is a displaced mesh  More... | |
| const std::map< boundary_id_type, std::vector< dof_id_type > > & | nodeSetNodes () const | 
| Moose::CoordinateSystemType | getCoordSystem (SubdomainID sid) const | 
| Get the coordinate system type, e.g.  More... | |
| const std::map< SubdomainID, Moose::CoordinateSystemType > & | getCoordSystem () const | 
| Get the map from subdomain ID to coordinate system type, e.g.  More... | |
| Moose::CoordinateSystemType | getUniqueCoordSystem () const | 
| Get the coordinate system from the mesh, it must be the same in all subdomains otherwise this will error.  More... | |
| void | setCoordSystem (const std::vector< SubdomainName > &blocks, const MultiMooseEnum &coord_sys) | 
| Set the coordinate system for the provided blocks to coord_sys.  More... | |
| void | setAxisymmetricCoordAxis (const MooseEnum &rz_coord_axis) | 
| For axisymmetric simulations, set the symmetry coordinate axis.  More... | |
| void | setGeneralAxisymmetricCoordAxes (const std::vector< SubdomainName > &blocks, const std::vector< std::pair< Point, RealVectorValue >> &axes) | 
| Sets the general coordinate axes for axisymmetric blocks.  More... | |
| const std::pair< Point, RealVectorValue > & | getGeneralAxisymmetricCoordAxis (SubdomainID subdomain_id) const | 
| Gets the general axisymmetric coordinate axis for a block.  More... | |
| bool | usingGeneralAxisymmetricCoordAxes () const | 
| Returns true if general axisymmetric coordinate axes are being used.  More... | |
| unsigned int | getAxisymmetricRadialCoord () const | 
| Returns the desired radial direction for RZ coordinate transformation.  More... | |
| void | checkCoordinateSystems () | 
| Performs a sanity check for every element in the mesh.  More... | |
| void | setCoordData (const MooseMesh &other_mesh) | 
| Set the coordinate system data to that of other_mesh.  More... | |
| void | markFiniteVolumeInfoDirty () | 
| Mark the finite volume information as dirty.  More... | |
| bool | isFiniteVolumeInfoDirty () const | 
| MooseAppCoordTransform & | coordTransform () | 
| const MooseUnits & | lengthUnit () const | 
| const std::unordered_map< std::pair< const Elem *, unsigned short int >, const Elem * > & | getLowerDElemMap () const | 
| This function attempts to return the map from a high-order element side to its corresponding lower-d element.  More... | |
| bool | isSplit () const | 
| void | buildFiniteVolumeInfo () const | 
| Builds the face and elem info vectors that store meta-data needed for looping over and doing calculations based on mesh faces and elements in a finite volume setting.  More... | |
| void | setupFiniteVolumeMeshData () const | 
| Sets up the additional data needed for finite volume computations.  More... | |
| void | doingPRefinement (bool doing_p_refinement) | 
| Indicate whether the kind of adaptivity we're doing is p-refinement.  More... | |
| bool | doingPRefinement () const | 
| Query whether we have p-refinement.  More... | |
| unsigned int | maxPLevel () const | 
| Returns the maximum p-refinement level of all elements.  More... | |
| unsigned int | maxHLevel () const | 
| Returns the maximum h-refinement level of all elements.  More... | |
| const std::vector< QpMap > & | getPRefinementMap (const Elem &elem) const | 
| Get the map describing for each volumetric quadrature point (qp) on the refined level which qp on the previous coarser level the fine qp is closest to.  More... | |
| const std::vector< QpMap > & | getPRefinementSideMap (const Elem &elem) const | 
| Get the map describing for each side quadrature point (qp) on the refined level which qp on the previous coarser level the fine qp is closest to.  More... | |
| const std::vector< QpMap > & | getPCoarseningMap (const Elem &elem) const | 
| Get the map describing for each volumetric quadrature point (qp) on the coarse level which qp on the previous finer level the coarse qp is closest to.  More... | |
| const std::vector< QpMap > & | getPCoarseningSideMap (const Elem &elem) const | 
| Get the map describing for each side quadrature point (qp) on the coarse level which qp on the previous finer level the coarse qp is closest to.  More... | |
| void | buildPRefinementAndCoarseningMaps (Assembly *assembly) | 
| bool | isLowerD (const SubdomainID subdomain_id) const | 
| bool | hasLowerD () const | 
| const std::set< SubdomainID > & | interiorLowerDBlocks () const | 
| const std::set< SubdomainID > & | boundaryLowerDBlocks () const | 
| bool | getConstructNodeListFromSideList () | 
| Return construct node list from side list boolean.  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 | 
| bool | isKokkosObject (IsKokkosObjectKey &&) const | 
| Get whether this object is a Kokkos functor The parameter is set by the Kokkos base classes:  More... | |
| MooseApp & | getMooseApp () const | 
| Get the MooseApp this class is associated with.  More... | |
| const std::string & | type () const | 
| Get the type of this class.  More... | |
| 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... | |
| MooseObjectParameterName | uniqueParameterName (const std::string ¶meter_name) const | 
| MooseObjectName | uniqueName () const | 
| const InputParameters & | parameters () const | 
| Get the parameters of the object.  More... | |
| const hit::Node * | getHitNode () const | 
| bool | hasBase () const | 
| const std::string & | getBase () const | 
| 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 &name) const | 
| Test if the supplied parameter is set by a user, as opposed to not set or set to default.  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 | 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 | paramWarning (const std::string ¶m, Args... args) const | 
| 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... | |
| std::string | messagePrefix (const bool hit_prefix=true) const | 
| std::string | errorPrefix (const std::string &) const | 
| Deprecated message prefix; the error type is no longer used.  More... | |
| template<typename... Args> | |
| void | mooseError (Args &&... args) const | 
| Emits an error prefixed with object name and type and optionally a file path to the top-level block parameter if available.  More... | |
| template<typename... Args> | |
| void | mooseDocumentedError (const std::string &repo_name, const unsigned int issue_num, Args &&... args) const | 
| template<typename... Args> | |
| void | mooseErrorNonPrefixed (Args &&... args) const | 
| Emits an error without the prefixing included in mooseError().  More... | |
| template<typename... Args> | |
| void | mooseWarning (Args &&... args) const | 
| Emits a warning prefixed with object name and type.  More... | |
| template<typename... Args> | |
| void | mooseWarning (Args &&... args) const | 
| template<typename... Args> | |
| void | mooseWarningNonPrefixed (Args &&... args) const | 
| Emits a warning without the prefixing included in mooseWarning().  More... | |
| template<typename... Args> | |
| void | mooseWarningNonPrefixed (Args &&... args) const | 
| template<typename... Args> | |
| void | mooseDeprecated (Args &&... args) const | 
| template<typename... Args> | |
| void | mooseDeprecated (Args &&... args) const | 
| template<typename... Args> | |
| void | mooseInfo (Args &&... args) const | 
| void | callMooseError (std::string msg, const bool with_prefix, const hit::Node *node=nullptr) const | 
| External method for calling moose error with added object context.  More... | |
| 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... | |
| libMesh::ConstElemRange * | getActiveLocalElementRange () | 
| Return pointers to range objects for various types of ranges (local nodes, boundary elems, etc.).  More... | |
| libMesh::NodeRange * | getActiveNodeRange () | 
| SemiLocalNodeRange * | getActiveSemiLocalNodeRange () const | 
| libMesh::ConstNodeRange * | getLocalNodeRange () | 
| libMesh::StoredRange< MooseMesh::const_bnd_node_iterator, const BndNode * > * | getBoundaryNodeRange () | 
| libMesh::StoredRange< MooseMesh::const_bnd_elem_iterator, const BndElement * > * | getBoundaryElementRange () | 
| virtual Real | getMinInDimension (unsigned int component) const | 
| Returns the min or max of the requested dimension respectively.  More... | |
| virtual Real | getMaxInDimension (unsigned int component) const | 
| bool | isCustomPartitionerRequested () const | 
| Setter and getter for _custom_partitioner_requested.  More... | |
| void | setIsCustomPartitionerRequested (bool cpr) | 
| unsigned int | nFace () const | 
| accessors for the FaceInfo objects  More... | |
| const std::vector< const FaceInfo * > & | faceInfo () const | 
| Accessor for local FaceInfoobjects.  More... | |
| const FaceInfo * | faceInfo (const Elem *elem, unsigned int side) const | 
| Accessor for the local FaceInfo object on the side of one element. Returns null if ghosted.  More... | |
| face_info_iterator | ownedFaceInfoBegin () | 
| Iterators to owned faceInfo objects.  More... | |
| face_info_iterator | ownedFaceInfoEnd () | 
| elem_info_iterator | ownedElemInfoBegin () | 
| Iterators to owned faceInfo objects.  More... | |
| elem_info_iterator | ownedElemInfoEnd () | 
| const ElemInfo & | elemInfo (const dof_id_type id) const | 
| Accessor for the elemInfo object for a given element ID.  More... | |
| const std::vector< const ElemInfo * > & | elemInfoVector () const | 
| Accessor for the element info objects owned by this process.  More... | |
| const std::vector< FaceInfo > & | allFaceInfo () const | 
| Accessor for all FaceInfoobjects.  More... | |
| Static Public Member Functions | |
| static InputParameters | validParams () | 
| static MooseEnum | partitioning () | 
| returns MooseMesh partitioning options so other classes can use it  More... | |
| static MooseEnum | elemTypes () | 
| returns MooseMesh element type options  More... | |
| static void | setSubdomainName (MeshBase &mesh, SubdomainID subdomain_id, const SubdomainName &name) | 
| This method sets the name for subdomain_idon the providedmeshtoname.  More... | |
| static void | changeBoundaryId (MeshBase &mesh, const boundary_id_type old_id, const boundary_id_type new_id, bool delete_prev) | 
| Change all the boundary IDs for a given side from old_id to new_id for the given mesh.  More... | |
| static void | setPartitioner (MeshBase &mesh_base, MooseEnum &partitioner, bool use_distributed_mesh, const InputParameters ¶ms, MooseObject &context_obj) | 
| Method for setting the partitioner on the passed in mesh_base object.  More... | |
| static void | callMooseError (MooseApp *const app, const InputParameters ¶ms, std::string msg, const bool with_prefix, const hit::Node *node) | 
| External method for calling moose error with added object context.  More... | |
| Public Attributes | |
| usingCombinedWarningSolutionWarnings | |
| const ConsoleStream | _console | 
| An instance of helper class to write streams to the Console objects.  More... | |
| Static Public Attributes | |
| static const std::string | type_param = "_type" | 
| The name of the parameter that contains the object type.  More... | |
| static const std::string | name_param = "_object_name" | 
| The name of the parameter that contains the object name.  More... | |
| static const std::string | unique_name_param = "_unique_name" | 
| The name of the parameter that contains the unique object name.  More... | |
| static const std::string | app_param = "_moose_app" | 
| The name of the parameter that contains the MooseApp.  More... | |
| static const std::string | moose_base_param = "_moose_base" | 
| The name of the parameter that contains the moose system base.  More... | |
| static const std::string | kokkos_object_param = "_kokkos_object" | 
| The name of the parameter that indicates an object is a Kokkos functor.  More... | |
| Protected Types | |
| enum | { X = 0, Y, Z } | 
| Convenience enums.  More... | |
| enum | { MIN = 0, MAX } | 
| typedef std::vector< BndNode * >::iterator | bnd_node_iterator_imp | 
| typedef std::vector< BndNode * >::const_iterator | const_bnd_node_iterator_imp | 
| typedef std::vector< BndElement * >::iterator | bnd_elem_iterator_imp | 
| typedef std::vector< BndElement * >::const_iterator | const_bnd_elem_iterator_imp | 
| Protected Member Functions | |
| void | cacheInfo () | 
| void | freeBndNodes () | 
| void | freeBndElems () | 
| void | setPartitionerHelper (MeshBase *mesh=nullptr) | 
| template<bool warning> | |
| void | flagInvalidSolutionInternal (const InvalidSolutionID invalid_solution_id) const | 
| Set solution invalid mark for the given solution ID.  More... | |
| InvalidSolutionID | registerInvalidSolutionInternal (const std::string &message, const bool warning) 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 declareRestartableDatabut 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... | |
| PerfID | registerTimedSection (const std::string §ion_name, const unsigned int level) const | 
| Call to register a named section for timing.  More... | |
| PerfID | registerTimedSection (const std::string §ion_name, const unsigned int level, const std::string &live_message, const bool print_dots=true) const | 
| Call to register a named section for timing.  More... | |
| std::string | timedSectionName (const std::string §ion_name) const | 
| Protected Attributes | |
| std::string | _file_name | 
| the file_name from whence this mesh came  More... | |
| std::unique_ptr< libMesh::ExodusII_IO > | _exreader | 
| Auxiliary object for restart.  More... | |
| std::vector< std::unique_ptr< libMesh::GhostingFunctor > > | _ghosting_functors | 
| Deprecated (DO NOT USE)  More... | |
| std::vector< std::shared_ptr< RelationshipManager > > | _relationship_managers | 
| The list of active geometric relationship managers (bound to the underlying MeshBase object).  More... | |
| bool | _built_from_other_mesh = false | 
| Whether or not this mesh was built from another mesh.  More... | |
| ParallelType | _parallel_type | 
| Can be set to DISTRIBUTED, REPLICATED, or DEFAULT.  More... | |
| bool | _use_distributed_mesh | 
| False by default.  More... | |
| bool | _distribution_overridden | 
| bool | _parallel_type_overridden | 
| std::unique_ptr< libMesh::MeshBase > | _mesh | 
| Pointer to underlying libMesh mesh object.  More... | |
| std::unique_ptr< Moose::Kokkos::Mesh > | _kokkos_mesh | 
| Pointer to Kokkos mesh object.  More... | |
| MooseEnum | _partitioner_name | 
| The partitioner used on this mesh.  More... | |
| bool | _partitioner_overridden | 
| std::unique_ptr< libMesh::Partitioner > | _custom_partitioner | 
| The custom partitioner.  More... | |
| bool | _custom_partitioner_requested | 
| unsigned int | _uniform_refine_level | 
| The level of uniform refinement requested (set to zero if AMR is disabled)  More... | |
| bool | _skip_refine_when_use_split | 
| Whether or not to skip uniform refinements when using a pre-split mesh.  More... | |
| bool | _skip_deletion_repartition_after_refine | 
| Whether or not skip remote deletion and repartition after uniform refinements.  More... | |
| bool | _is_changed | 
| true if mesh is changed (i.e. after adaptivity step)  More... | |
| bool | _is_nemesis | 
| True if a Nemesis Mesh was read in.  More... | |
| bool | _moose_mesh_prepared = false | 
| True if prepare has been called on the mesh.  More... | |
| std::unique_ptr< ConstElemPointerRange > | _refined_elements | 
| The elements that were just refined.  More... | |
| std::unique_ptr< ConstElemPointerRange > | _coarsened_elements | 
| The elements that were just coarsened.  More... | |
| std::map< const Elem *, std::vector< const Elem * > > | _coarsened_element_children | 
| Map of Parent elements to child elements for elements that were just coarsened.  More... | |
| std::set< Node * > | _semilocal_node_list | 
| Used for generating the semilocal node range.  More... | |
| std::unique_ptr< libMesh::ConstElemRange > | _active_local_elem_range | 
| A range for use with threading.  More... | |
| std::unique_ptr< SemiLocalNodeRange > | _active_semilocal_node_range | 
| std::unique_ptr< libMesh::NodeRange > | _active_node_range | 
| std::unique_ptr< libMesh::ConstNodeRange > | _local_node_range | 
| std::unique_ptr< libMesh::StoredRange< MooseMesh::const_bnd_node_iterator, const BndNode * > > | _bnd_node_range | 
| std::unique_ptr< libMesh::StoredRange< MooseMesh::const_bnd_elem_iterator, const BndElement * > > | _bnd_elem_range | 
| std::map< dof_id_type, std::vector< dof_id_type > > | _node_to_elem_map | 
| A map of all of the current nodes to the elements that they are connected to.  More... | |
| bool | _node_to_elem_map_built | 
| std::map< dof_id_type, std::vector< dof_id_type > > | _node_to_active_semilocal_elem_map | 
| A map of all of the current nodes to the active elements that they are connected to.  More... | |
| bool | _node_to_active_semilocal_elem_map_built | 
| std::set< SubdomainID > | _mesh_subdomains | 
| A set of subdomain IDs currently present in the mesh.  More... | |
| std::unique_ptr< std::map< BoundaryID, RealVectorValue > > | _boundary_to_normal_map | 
| The boundary to normal map - valid only when AddAllSideSetsByNormals is active.  More... | |
| std::vector< BndNode * > | _bnd_nodes | 
| array of boundary nodes  More... | |
| std::map< boundary_id_type, std::set< dof_id_type > > | _bnd_node_ids | 
| Map of sets of node IDs in each boundary.  More... | |
| std::vector< BndElement * > | _bnd_elems | 
| array of boundary elems  More... | |
| std::unordered_map< boundary_id_type, std::unordered_set< dof_id_type > > | _bnd_elem_ids | 
| Map of set of elem IDs connected to each boundary.  More... | |
| std::map< dof_id_type, Node * > | _quadrature_nodes | 
| std::map< dof_id_type, std::map< unsigned int, std::map< dof_id_type, Node * > > > | _elem_to_side_to_qp_to_quadrature_nodes | 
| std::vector< BndNode > | _extra_bnd_nodes | 
| std::map< dof_id_type, std::set< SubdomainID > > | _block_node_list | 
| list of nodes that belongs to a specified block (domain)  More... | |
| std::map< boundary_id_type, std::vector< dof_id_type > > | _node_set_nodes | 
| list of nodes that belongs to a specified nodeset: indexing [nodeset_id] -> [array of node ids]  More... | |
| std::set< unsigned int > | _ghosted_boundaries | 
| std::vector< Real > | _ghosted_boundaries_inflation | 
| unsigned int | _patch_size | 
| The number of nodes to consider in the NearestNode neighborhood.  More... | |
| unsigned int | _ghosting_patch_size | 
| The number of nearest neighbors to consider for ghosting purposes when iteration patch update strategy is used.  More... | |
| unsigned int | _max_leaf_size | 
| Moose::PatchUpdateType | _patch_update_strategy | 
| The patch update strategy.  More... | |
| std::vector< Node * > | _node_map | 
| Vector of all the Nodes in the mesh for determining when to add a new point.  More... | |
| bool | _regular_orthogonal_mesh | 
| Boolean indicating whether this mesh was detected to be regular and orthogonal.  More... | |
| std::vector< std::vector< Real > > | _bounds | 
| The bounds in each dimension of the mesh for regular orthogonal meshes.  More... | |
| std::vector< std::pair< BoundaryID, BoundaryID > > | _paired_boundary | 
| A vector holding the paired boundaries for a regular orthogonal mesh.  More... | |
| const bool | _is_split | 
| Whether or not we are using a (pre-)split mesh (automatically DistributedMesh)  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... | |
| Factory & | _factory | 
| The Factory associated with the MooseApp.  More... | |
| ActionFactory & | _action_factory | 
| Builds Actions.  More... | |
| const std::string & | _type | 
| The type of this class.  More... | |
| const std::string & | _name | 
| The name of this class.  More... | |
| const InputParameters & | _pars | 
| The object's parameters.  More... | |
| const Parallel::Communicator & | _communicator | 
| 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... | |
| MooseApp & | _pg_moose_app | 
| The MooseApp that owns the PerfGraph.  More... | |
| const std::string | _prefix | 
| A prefix to use for all sections.  More... | |
| std::set< BoundaryID > | _mesh_boundary_ids | 
| A set of boundary IDs currently present in the mesh.  More... | |
| std::set< BoundaryID > | _mesh_sideset_ids | 
| std::set< BoundaryID > | _mesh_nodeset_ids | 
Definition at line 14 of file FileMesh.h.
| 
 | protectedinherited | 
Definition at line 1564 of file MooseMesh.h.
| 
 | protectedinherited | 
Definition at line 1557 of file MooseMesh.h.
| 
 | protectedinherited | 
Definition at line 1565 of file MooseMesh.h.
| 
 | protectedinherited | 
Definition at line 1558 of file MooseMesh.h.
| 
 | inherited | 
The parameter type this interface expects for a data file name.
Definition at line 27 of file DataFileInterface.h.
| 
 | inherited | 
Helper type for building periodic node maps.
Definition at line 1077 of file MooseMesh.h.
| 
 | protectedinherited | 
Convenience enums.
| Enumerator | |
|---|---|
| X | |
| Y | |
| Z | |
Definition at line 1467 of file MooseMesh.h.
| 
 | protectedinherited | 
| Enumerator | |
|---|---|
| MIN | |
| MAX | |
Definition at line 1473 of file MooseMesh.h.
| 
 | stronginherited | 
| Enumerator | |
|---|---|
| DEFAULT | |
| REPLICATED | |
| DISTRIBUTED | |
Definition at line 108 of file MooseMesh.h.
| FileMesh::FileMesh | ( | const InputParameters & | parameters | ) | 
Definition at line 48 of file FileMesh.C.
| FileMesh::FileMesh | ( | const FileMesh & | other_mesh | ) | 
Definition at line 53 of file FileMesh.C.
| 
 | virtual | 
Definition at line 58 of file FileMesh.C.
| 
 | inherited | 
Calls active_local_nodes_begin/end() on the underlying libMesh mesh object.
Definition at line 3072 of file MooseMesh.C.
Referenced by FEProblemBase::checkDisplacementOrders(), and MooseMesh::hasSecondOrderElements().
| 
 | inherited | 
Definition at line 3084 of file MooseMesh.C.
| 
 | inherited | 
Definition at line 3078 of file MooseMesh.C.
Referenced by FEProblemBase::checkDisplacementOrders(), and MooseMesh::hasSecondOrderElements().
| 
 | inherited | 
Definition at line 3090 of file MooseMesh.C.
| 
 | inherited | 
This will add the boundary ids to be ghosted to this processor.
Definition at line 3250 of file MooseMesh.C.
Referenced by FEProblemBase::addGhostedBoundary().
| 
 | inherited | 
For "regular orthogonal" meshes, determine if variable var_num is periodic with respect to the primary and secondary BoundaryIDs, record this fact in the _periodic_dim data structure.
Definition at line 2255 of file MooseMesh.C.
Referenced by AddPeriodicBCAction::setPeriodicVars().
| 
 | inherited | 
Adds a fictitious "QuadratureNode".
This doesn't actually add it to the libMesh mesh... we just keep track of these here in MooseMesh.
QuadratureNodes are fictitious "Nodes" that are located at quadrature points. This is useful for using the geometric search system to do searches based on quadrature point locations....
| elem | The element | 
| side | The side number on which we want to add a quadrature node | 
| qp | The number of the quadrature point | 
| bid | The boundary ID for the point to be added with | 
| point | The physical location of the point | 
Definition at line 1648 of file MooseMesh.C.
Referenced by GeometricSearchData::generateQuadratureNodes().
Add a new node to the mesh.
If there is already a node located at the point passed then the node will not be added. In either case a reference to the node at that location will be returned
Looping through the mesh nodes each time we add a point is very slow. To speed things up we keep a local data structure
Definition at line 1614 of file MooseMesh.C.
| 
 | inlineinherited | 
Accessor for all FaceInfo objects. 
Definition at line 2214 of file MooseMesh.h.
| 
 | inlineinherited | 
Set whether or not this mesh is allowed to read a recovery file.
Definition at line 1034 of file MooseMesh.h.
| 
 | inherited | 
Set whether to allow remote element removal.
Definition at line 3936 of file MooseMesh.C.
| 
 | inlineinherited | 
Whether we are allow remote element removal.
Definition at line 1097 of file MooseMesh.h.
Referenced by MooseMesh::MooseMesh().
| 
 | inlineinherited | 
Whether or not two extra element integers are identical.
Definition at line 2200 of file MooseMesh.h.
| 
 | virtualinherited | 
Return iterators to the beginning/end of the boundary elements list.
Definition at line 1599 of file MooseMesh.C.
Referenced by MooseMesh::getBoundaryElementRange(), and MeshInfo::possiblyAddSidesetInfo().
| 
 | virtualinherited | 
Definition at line 1607 of file MooseMesh.C.
Referenced by MooseMesh::getBoundaryElementRange(), and MeshInfo::possiblyAddSidesetInfo().
| 
 | virtualinherited | 
Return iterators to the beginning/end of the boundary nodes list.
Definition at line 1583 of file MooseMesh.C.
Referenced by MooseMesh::getBoundaryNodeRange().
| 
 | virtualinherited | 
Definition at line 1591 of file MooseMesh.C.
Referenced by MooseMesh::getBoundaryNodeRange().
| 
 | inlineinherited | 
Definition at line 1425 of file MooseMesh.h.
Referenced by FEProblemBase::adaptMesh(), ArrayHFEMDirichletBC::ArrayHFEMDirichletBC(), ArrayLowerDIntegratedBC::ArrayLowerDIntegratedBC(), NonlinearSystemBase::checkKernelCoverage(), HFEMDirichletBC::HFEMDirichletBC(), FEProblemBase::initialAdaptMesh(), and LowerDIntegratedBC::LowerDIntegratedBC().
| 
 | inherited | 
Calls BoundaryInfo::build_active_side_list.
Definition at line 3036 of file MooseMesh.C.
Referenced by MooseMesh::buildFiniteVolumeInfo().
| 
 | inherited | 
Definition at line 1193 of file MooseMesh.C.
Referenced by MooseMesh::update().
| 
 | inherited | 
Builds the face and elem info vectors that store meta-data needed for looping over and doing calculations based on mesh faces and elements in a finite volume setting.
This should only be called when finite volume variables are used in the problem or when the face and elem info objects are necessary for functor-based evaluations.
Definition at line 3760 of file MooseMesh.C.
Referenced by MooseMesh::setupFiniteVolumeMeshData().
| 
 | overridevirtual | 
Must be overridden by child classes.
This is where the Mesh object is actually created and filled in.
Implements MooseMesh.
Reimplemented in MFEMMesh.
Definition at line 67 of file FileMesh.C.
| 
 | inherited | 
Method to construct a libMesh::MeshBase object that is normally set and used by the MooseMesh object during the "init()" phase.
If the parameter dim is not provided, then its value will be taken from the input file mesh block. 
Definition at line 2894 of file MooseMesh.C.
Referenced by MeshGenerator::buildMeshBaseObject(), and MooseMesh::init().
| 
 | inherited | 
Calls BoundaryInfo::build_node_list()/build_side_list() and makes separate copies of Nodes/Elems in those lists.
Allocates memory which is cleaned up in the freeBndNodes()/freeBndElems() functions.
Definition at line 1040 of file MooseMesh.C.
Referenced by MooseMesh::update().
| 
 | inherited | 
Calls BoundaryInfo::build_node_list_from_side_list().
Definition at line 3023 of file MooseMesh.C.
Referenced by MooseMesh::prepare(), and MooseMesh::update().
| 
 | inherited | 
This routine builds a multimap of boundary ids to matching boundary ids across all periodic boundaries in the system.
Definition at line 1851 of file MooseMesh.C.
| 
 | inherited | 
This routine builds a datastructure of node ids organized by periodic boundary ids.
Definition at line 1936 of file MooseMesh.C.
Definition at line 2406 of file MooseMesh.C.
Referenced by MooseMesh::buildRefinementAndCoarseningMaps(), and FEProblemBase::meshChanged().
Create the refinement and coarsening maps necessary for projection of stateful material properties when using adaptivity.
| assembly | Pointer to the Assembly object for this Mesh. | 
Definition at line 2500 of file MooseMesh.C.
Referenced by FEProblemBase::initialSetup().
| 
 | inherited | 
Calls BoundaryInfo::build_side_list(), returns a std::vector of (elem-id, side-id, bc-id) tuples.
Definition at line 3030 of file MooseMesh.C.
Referenced by InterfaceQpUserObjectBase::initialSetup().
| 
 | inherited | 
Shortcut method to construct a unique pointer to a libMesh mesh instance.
The created derived-from-MeshBase object will have its allow_remote_element_removal flag set to whatever our value is. We will also attach any geometric RelationshipManagers that have been requested by our simulation objects to the MeshBase object. If the parameter dim is not provided, then its value will be taken from the input file mesh block. 
Definition at line 2125 of file MooseMesh.h.
Referenced by MeshGenerator::buildDistributedMesh(), and MeshGenerator::buildReplicatedMesh().
| 
 | inherited | 
Cache information about what elements were refined and coarsened in the previous step.
Definition at line 928 of file MooseMesh.C.
Referenced by FEProblemBase::meshChanged().
| 
 | inherited | 
Cache if variables live on the elements connected by the FaceInfo objects.
The following paragraph of code assigns the VarFaceNeighbors
Definition at line 3962 of file MooseMesh.C.
Referenced by MooseMesh::setupFiniteVolumeMeshData().
| 
 | inherited | 
Cache the DoF indices for FV variables on each element.
These indices are used to speed up the setup loops of finite volume systems.
Definition at line 4040 of file MooseMesh.C.
Referenced by MooseMesh::setupFiniteVolumeMeshData().
| 
 | protectedinherited | 
Definition at line 1445 of file MooseMesh.C.
Referenced by MooseMesh::update().
| 
 | inherited | 
External method for calling moose error with added object context.
| msg | The message | 
| with_prefix | If true, add the prefix from messagePrefix(), which is the object information (type, name, etc) | 
| node | Optional hit node to add file path context as a prefix | 
Definition at line 105 of file MooseBase.C.
Referenced by InputParameters::callMooseError(), MooseBase::mooseDocumentedError(), MooseBase::mooseError(), and MooseBase::mooseErrorNonPrefixed().
| 
 | staticinherited | 
External method for calling moose error with added object context.
Needed so that objects without the MooseBase context (InputParameters) can call errors with context
| app | The app pointer (if available); adds multiapp context and clears the console | 
| params | The parameters, needed to obtain object information | 
| msg | The message | 
| with_prefix | If true, add the prefix from messagePrefix(), which is the object information (type, name, etc) | 
| node | Optional hit node to add file path context as a prefix | 
Definition at line 113 of file MooseBase.C.
| 
 | inherited | 
Change all the boundary IDs for a given side from old_id to new_id.
If delete_prev is true, also actually remove the side with old_id from the BoundaryInfo object.
Definition at line 2800 of file MooseMesh.C.
| 
 | staticinherited | 
Change all the boundary IDs for a given side from old_id to new_id for the given mesh. 
If delete_prev is true, also actually remove the side with old_id from the BoundaryInfo object.
| 
 | inherited | 
Performs a sanity check for every element in the mesh.
If an element dimension is 3 and the corresponding coordinate system is RZ, then this will error. If an element dimension is greater than 1 and the corresponding system is RPSHERICAL then this will error
Definition at line 4328 of file MooseMesh.C.
Referenced by FEProblemBase::checkCoordinateSystems().
| 
 | inherited | 
Clear out any existing quadrature nodes.
Most likely called before re-adding them.
Definition at line 1718 of file MooseMesh.C.
Referenced by DisplacedProblem::meshChanged(), GeometricSearchData::reinit(), and MooseMesh::~MooseMesh().
| 
 | virtualinherited | 
Clone method.
Allocates memory you are responsible to clean up.
Definition at line 2860 of file MooseMesh.C.
Referenced by TiledMesh::buildMesh().
| 
 | inherited | 
Get the newly removed children element ids for an element that was just coarsened.
| elem | Pointer to the parent element that was coarsened to. | 
Definition at line 958 of file MooseMesh.C.
Referenced by FEProblemBase::meshChanged(), ProjectMaterialProperties::onBoundary(), and ProjectMaterialProperties::onElement().
| 
 | inherited | 
Return a range that is suitable for threaded execution over elements that were just coarsened.
Note that these are the Parent elements that are now set to be INACTIVE. Their children are the elements that were just removed. Use coarsenedElementChildren() to get the element IDs for the children that were just removed for a particular parent element.
Definition at line 952 of file MooseMesh.C.
Referenced by FEProblemBase::meshChanged().
| 
 | inherited | 
Compute the face coordinate value for all FaceInfo and ElemInfo objects. 
'Coordinate' here means a coordinate value associated with the coordinate system. For Cartesian coordinate systems, 'coordinate' is simply '1'; in RZ, '2*pi*r', and in spherical, '4*pi*r^2'
Definition at line 3898 of file MooseMesh.C.
Referenced by MooseMesh::setupFiniteVolumeMeshData().
| 
 | 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 77 of file MooseBase.C.
| 
 | inlineinherited | 
Definition at line 1923 of file MooseMesh.h.
Referenced by FEProblemBase::checkProblemIntegrity(), and FEProblemBase::coordTransform().
| 
 | 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 283 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 358 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 276 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 301 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 330 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 340 of file Restartable.h.
| 
 | inherited | 
Delete remote elements.
Definition at line 3950 of file MooseMesh.C.
| 
 | inherited | 
This routine determines whether the Mesh is a regular orthogonal mesh (i.e.
square in 2D, cubic in 3D). If it is, then we can use a number of convenience functions when periodic boundary conditions are applied. This routine populates the _range vector which is necessary for these convenience functions.
Note: This routine can potentially identify meshes with concave faces that still "fit" in the convex hull of the corresponding regular orthogonal mesh. This case is highly unlikely in practice and if a user does this, well.... release the kicker!
Definition at line 1963 of file MooseMesh.C.
Referenced by AddPeriodicBCAction::autoTranslationBoundaries(), and MooseMesh::prepare().
| 
 | inherited | 
Determine whether to use a distributed mesh.
Should be called during construction
Definition at line 2866 of file MooseMesh.C.
Referenced by MooseMesh::MooseMesh(), and MooseMesh::setParallelType().
| 
 | virtualinherited | 
Returns MeshBase::mesh_dimension(), (not MeshBase::spatial_dimension()!) of the underlying libMesh mesh object.
Reimplemented in MFEMMesh.
Definition at line 2968 of file MooseMesh.C.
Referenced by MooseMesh::addPeriodicVariable(), AddPeriodicBCAction::autoTranslationBoundaries(), ProjectionAux::elemOnNodeVariableIsDefinedOn(), NodalPatchRecoveryBase::evaluateBasisFunctions(), ElementSubdomainModifierBase::extrapolatePolynomial(), FunctionPeriodicBoundary::FunctionPeriodicBoundary(), MooseMesh::getPairedBoundaryMapping(), PointVariableSamplerBase::initialize(), BlockRestrictable::initializeBlockRestrictable(), SystemBase::initialSetup(), MooseMesh::isTranslatedPeriodic(), MooseMesh::minPeriodicVector(), PenetrationLocator::PenetrationLocator(), PiecewiseConstantFromCSV::PiecewiseConstantFromCSV(), SidesetInfoVectorPostprocessor::SidesetInfoVectorPostprocessor(), and Moose::PetscSupport::storePetscOptions().
Returns the width of the requested dimension.
Definition at line 2231 of file MooseMesh.C.
Referenced by MooseMesh::addPeriodicVariable(), AddPeriodicBCAction::autoTranslationBoundaries(), and MooseMesh::effectiveSpatialDimension().
| 
 | inlineinherited | 
Indicate whether the kind of adaptivity we're doing is p-refinement.
Definition at line 1365 of file MooseMesh.h.
Referenced by SubProblem::doingPRefinement(), Adaptivity::init(), FEProblemBase::init(), ProjectMaterialProperties::onBoundary(), CacheChangedListsThread::onElement(), and ProjectMaterialProperties::onElement().
| 
 | inlineinherited | 
Query whether we have p-refinement.
Definition at line 1370 of file MooseMesh.h.
Referenced by MooseMesh::buildRefinementAndCoarseningMaps().
| 
 | virtualinherited | 
Returns the effective spatial dimension determined by the coordinates actually used by the mesh.
This means that a 1D mesh that has non-zero z or y coordinates is actually a 2D or 3D mesh, respectively. Likewise a 2D mesh that has non-zero z coordinates is actually 3D mesh.
Definition at line 2974 of file MooseMesh.C.
| 
 | virtualinherited | 
Various accessors (pointers/references) for Elem "i".
If the requested elem is a remote element on a distributed mesh, only the query accessors are valid to call, and they return NULL.
Definition at line 3120 of file MooseMesh.C.
Referenced by MooseMesh::addQuadratureNode(), MooseMesh::buildCoarseningMap(), MooseMesh::buildElemIDInfo(), MooseMesh::buildFiniteVolumeInfo(), MooseMesh::buildHRefinementAndCoarseningMaps(), MooseMesh::buildLowerDMesh(), SpiralAnnularMesh::buildMesh(), ConcentricCircleMesh::buildMesh(), AnnularMesh::buildMesh(), RinglebMesh::buildMesh(), MooseMesh::buildPRefinementAndCoarseningMaps(), MooseMesh::buildRefinementMap(), MooseMesh::cacheInfo(), MooseMesh::checkCoordinateSystems(), MooseMesh::coarsenedElementChildren(), MooseMesh::computeMaxPerElemAndSide(), MooseMesh::detectPairedSidesets(), MooseMesh::findAdaptivityQpMaps(), MooseMesh::getBlocksMaxDimension(), MooseMesh::getCoarseningMap(), MooseMesh::getElemIDMapping(), MooseMesh::getHigherDSide(), MooseMesh::getLowerDElem(), MooseMesh::getPCoarseningMap(), MooseMesh::getPCoarseningMapHelper(), MooseMesh::getPCoarseningSideMap(), MooseMesh::getPRefinementMap(), MooseMesh::getPRefinementMapHelper(), MooseMesh::getPRefinementSideMap(), MooseMesh::getQuadratureNode(), MooseMesh::getRefinementMap(), MooseMesh::ghostGhostedBoundaries(), MooseMesh::nodeToActiveSemilocalElemMap(), MooseMesh::nodeToElemMap(), MooseMesh::prepare(), MooseMesh::sideWithBoundaryID(), MooseMesh::update(), and MooseMesh::updateActiveSemiLocalNodeRange().
| 
 | virtualinherited | 
Definition at line 3127 of file MooseMesh.C.
| 
 | inherited | 
Accessor for the elemInfo object for a given element ID.
Definition at line 3892 of file MooseMesh.C.
Referenced by MooseLinearVariableFV< Real >::evaluate(), and MooseLinearVariableFV< Real >::evaluateGradient().
| 
 | inlineinherited | 
Accessor for the element info objects owned by this process.
Definition at line 1199 of file MooseMesh.h.
| 
 | virtualinherited | 
Definition at line 3134 of file MooseMesh.C.
Referenced by FEProblemBase::addGhostedElem(), SystemBase::augmentSendList(), NodalPatchRecoveryAuxBase::blockRestrictElements(), NodalPatchRecovery::compute(), BoundaryMarker::computeElementMarker(), ProjectionAux::computeValue(), NodalPatchRecoveryAuxBase::computeValue(), MooseMesh::elem(), ProjectionAux::elemOnNodeVariableIsDefinedOn(), ActivateElementsUserObjectBase::execute(), NonlinearSystemBase::findImplicitGeometricCouplingEntries(), NearestNodeLocator::findNodes(), ElementSubdomainModifierBase::findReinitializedElemsAndNodes(), ElementSubdomainModifierBase::gatherMovingBoundaryChanges(), ElementSubdomainModifierBase::gatherPatchElements(), NodalPatchRecoveryBase::gatherRequestList(), NodalPatchRecoveryBase::getCoefficients(), NodeElemConstraint::getConnectedDofIndices(), NodeFaceConstraint::getConnectedDofIndices(), FEProblemBase::getDiracElements(), PenetrationThread::getInfoForFacesWithCommonNodes(), ActivateElementsUserObjectBase::getNewlyActivatedElementRange(), ActivateElementsUserObjectBase::getNewlyActivatedNodeRange(), DiracKernelBase::hasPointsOnElem(), ActivateElementsUserObjectBase::isNewlyActivated(), Moose::Mortar::loopOverMortarSegments(), ElementSubdomainModifierBase::nodeIsNewlyReinitialized(), SecondaryNeighborhoodThread::operator()(), PenetrationThread::operator()(), FEProblemBase::prepareFace(), FEProblemBase::reinitDirac(), FEProblemBase::reinitElem(), FEProblemBase::reinitElemFaceRef(), FEProblemBase::reinitElemNeighborAndLowerD(), ElementSubdomainModifierBase::reinitializedElemRange(), FEProblemBase::reinitLowerDElem(), FEProblemBase::reinitNeighbor(), FEProblemBase::reinitNeighborFaceRef(), NonlinearSystemBase::reinitNodeFace(), FEProblemBase::setCurrentLowerDElem(), ElementSubdomainModifierBase::storeOverriddenDofValues(), and NearestNodeLocator::updatePatch().
| 
 | virtualinherited | 
Definition at line 3140 of file MooseMesh.C.
| 
 | staticinherited | 
returns MooseMesh element type options
Definition at line 3927 of file MooseMesh.C.
| 
 | inlinevirtualinherited | 
Return the enabled status of the object.
Reimplemented in EigenKernel.
Definition at line 49 of file MooseObject.h.
Referenced by EigenKernel::enabled().
| 
 | inherited | 
Generate a unified error message if the underlying libMesh mesh is a DistributedMesh.
Clients of MooseMesh can use this function to throw an error if they know they don't work with DistributedMesh.
See, for example, the NodalVariableValue class.
Definition at line 3638 of file MooseMesh.C.
Referenced by BoundaryPreservedMarker::BoundaryPreservedMarker(), ElementsAlongLine::ElementsAlongLine(), ElementsAlongPlane::ElementsAlongPlane(), FunctorPositions::initialize(), FunctorTimes::initialize(), IntersectionPointsAlongLine::IntersectionPointsAlongLine(), LineMaterialSamplerBase< Real >::LineMaterialSamplerBase(), MultiAppGeometricInterpolationTransfer::MultiAppGeometricInterpolationTransfer(), MultiAppUserObjectTransfer::MultiAppUserObjectTransfer(), NodeElemConstraintBase::NodeElemConstraintBase(), NonlocalIntegratedBC::NonlocalIntegratedBC(), NonlocalKernel::NonlocalKernel(), PatternedMesh::PatternedMesh(), StitchedMesh::StitchedMesh(), and TiledMesh::TiledMesh().
| 
 | inlineinherited | 
Deprecated message prefix; the error type is no longer used.
Definition at line 264 of file MooseBase.h.
| 
 | inlineinherited | 
Accessor for local FaceInfo objects. 
Definition at line 2208 of file MooseMesh.h.
Referenced by LayeredSideDiffusiveFluxAverage::computeQpIntegral(), SideIntegralVariableUserObject::computeQpIntegral(), ParsedAux::computeValue(), InterfaceUserObject::execute(), FunctorSmootherTempl< T >::FunctorSmootherTempl(), SideUserObject::getFaceInfos(), and InternalSideUserObject::getFaceInfos().
Accessor for the local FaceInfo object on the side of one element. Returns null if ghosted.
| 
 | protectedinherited | 
Set solution invalid mark for the given solution ID.
Definition at line 41 of file SolutionInvalidInterface.C.
| 
 | protectedinherited | 
Definition at line 405 of file MooseMesh.C.
Referenced by MooseMesh::buildBndElemList(), and MooseMesh::~MooseMesh().
| 
 | protectedinherited | 
Definition at line 386 of file MooseMesh.C.
Referenced by MooseMesh::buildNodeList(), and MooseMesh::~MooseMesh().
| 
 | inherited | 
Return pointers to range objects for various types of ranges (local nodes, boundary elems, etc.).
Definition at line 1276 of file MooseMesh.C.
Referenced by AuxiliarySystem::computeElementalVarsHelper(), FEProblemBase::computeIndicators(), FEProblemBase::computeMarkers(), FEProblemBase::computeUserObjectsInternal(), PointwiseRenormalizeVector::execute(), ElementSubdomainModifierBase::gatherPatchElements(), FEProblemBase::getCurrentAlgebraicElementRange(), FEProblemBase::initialSetup(), MooseMesh::meshChanged(), DOFMapOutput::output(), MeshInfo::possiblyAddSubdomainInfo(), FEProblemBase::projectSolution(), SystemBase::setVariableGlobalDoFs(), FixedPointSolve::solve(), TransientMultiApp::solveStep(), ElementSubdomainModifierBase::storeOverriddenDofValues(), MooseMesh::updateActiveSemiLocalNodeRange(), Adaptivity::updateErrorVectors(), FEProblemBase::updateMaxQps(), and SystemBase::zeroVariables().
| 
 | inherited | 
Definition at line 1290 of file MooseMesh.C.
Referenced by VariableCondensationPreconditioner::getDofToCondense(), and MooseMesh::meshChanged().
| 
 | inherited | 
Definition at line 1304 of file MooseMesh.C.
| 
 | inherited | 
Return all the unique element IDs for an extra element integer with its index.
Definition at line 1167 of file MooseMesh.C.
Referenced by MooseMesh::getElemIDMapping().
| 
 | inherited | 
Returns the desired radial direction for RZ coordinate transformation.
Definition at line 4315 of file MooseMesh.C.
Referenced by SubProblem::getAxisymmetricRadialCoord(), and ComputeLinearFVGreenGaussGradientVolumeThread::operator()().
| 
 | inlineinherited | 
Definition at line 147 of file MooseBase.h.
Referenced by Factory::copyConstruct(), and MooseBase::uniqueParameterName().
| 
 | inherited | 
Get the list of subdomains neighboring a given subdomain.
| subdomain_id | The boundary ID you want to get the subdomain IDs for. | 
Definition at line 3575 of file MooseMesh.C.
| 
 | inherited | 
Returns the maximum element dimension on the given blocks.
Definition at line 2989 of file MooseMesh.C.
Referenced by BlockRestrictable::initializeBlockRestrictable().
| 
 | inherited | 
Returns a map of boundaries to ids of elements on the boundary.
Definition at line 1363 of file MooseMesh.C.
Referenced by MooseMesh::getBoundariesToElems().
| 
 | inherited | 
Returns a map of boundaries to ids of elements on the boundary.
Definition at line 1355 of file MooseMesh.C.
| 
 | inherited | 
Return all ids of neighbors of elements which have a side which is part of a sideset.
Note that boundaries are sided, this is on the neighbor side. For the sideset side, use getBoundariesActiveLocalElemIds. Note that while the element is local and active, the neighbor is not guaranteed to be local, it could be ghosted. Note that if the neighbor is not ghosted, is a remote_elem, then it will not be included
| bid | the id of the sideset of interest | 
Definition at line 1380 of file MooseMesh.C.
| 
 | inherited | 
Return all ids of elements which have a side which is part of a sideset.
Note that boundaries are sided.
| bid | the id of the sideset of interest | 
Definition at line 1369 of file MooseMesh.C.
| 
 | inherited | 
Get the list of subdomains associated with the given boundary.
| bid | The boundary ID you want to get the subdomain IDs for. | 
Definition at line 3542 of file MooseMesh.C.
Referenced by DomainUserObject::DomainUserObject(), MooseMesh::getInterfaceConnectedBlocks(), and NodeFaceConstraint::getSecondaryConnectedBlocks().
| 
 | inherited | 
Get the list of subdomains associated with the given boundary of its secondary side.
| bid | The boundary ID you want to get the subdomain IDs for. | 
Definition at line 3553 of file MooseMesh.C.
Referenced by DomainUserObject::DomainUserObject().
| 
 | inherited | 
Definition at line 1341 of file MooseMesh.C.
Referenced by AuxiliarySystem::computeElementalVarsHelper(), DMMooseGetEmbedding_Private(), GeometricSearchData::generateQuadratureNodes(), FEProblemBase::initialSetup(), MooseMesh::meshChanged(), and GeometricSearchData::updateQuadratureNodes().
| 
 | inherited | 
Get the associated BoundaryID for the boundary name.
Definition at line 1730 of file MooseMesh.C.
Referenced by AddPeriodicBCAction::act(), TiledMesh::buildMesh(), StitchedMesh::buildMesh(), PatternedMesh::buildMesh(), DMSetUp_Moose_Pre(), GeometricSearchData::getNearestNodeLocator(), GeometricSearchData::getPenetrationLocator(), GeometricSearchData::getQuadratureNearestNodeLocator(), GeometricSearchData::getQuadraturePenetrationLocator(), LinearNodalConstraint::LinearNodalConstraint(), LowerBoundNodalKernel::LowerBoundNodalKernel(), NodalScalarKernel::NodalScalarKernel(), MooseMesh::prepare(), EqualValueBoundaryConstraint::updateConstrainedNodes(), and UpperBoundNodalKernel::UpperBoundNodalKernel().
| 
 | inherited | 
Returns a vector of boundary IDs for the requested element on the requested side.
Referenced by NonlinearSystemBase::computeJacobianInternal(), DGKernelBase::DGKernelBase(), DGKernelBase::excludeBoundary(), MultiAppUserObjectTransfer::execute(), BoundaryRestrictable::hasBoundary(), BoundaryRestrictable::initializeBoundaryRestrictable(), ElementSubdomainModifierBase::initialSetup(), KokkosBoundNodalKernel< KokkosUpperBoundNodalKernel >::KokkosBoundNodalKernel(), BoundaryRestrictable::meshBoundaryIDs(), GhostBoundary::operator()(), and ActivateElementsUserObjectBase::setNewBoundayName().
| 
 | inherited | 
Returns a const reference to a set of all user-specified boundary IDs.
On a distributed mesh this will only include boundary IDs which exist on local or ghosted elements; a copy and a call to _communicator.set_union() will be necessary to get the global ID set.
Definition at line 3017 of file MooseMesh.C.
Referenced by MooseMesh::cacheInfo().
| 
 | inherited | 
Get the associated BoundaryID for the boundary names that are passed in.
Definition at line 1761 of file MooseMesh.C.
| 
 | inherited | 
Return the name of the boundary given the id.
Definition at line 1830 of file MooseMesh.C.
Referenced by MooseMesh::addPeriodicVariable(), FEProblemBase::initialSetup(), and NonlinearThread::printBoundaryExecutionInformation().
| 
 | inherited | 
Definition at line 1327 of file MooseMesh.C.
Referenced by AuxiliarySystem::computeMortarNodalVars(), AuxiliarySystem::computeNodalVarsHelper(), DMMooseGetEmbedding_Private(), NearestNodeLocator::findNodes(), FEProblemBase::getCurrentAlgebraicBndNodeRange(), ActivateElementsUserObjectBase::getNewlyActivatedBndNodeRange(), FEProblemBase::initialSetup(), MooseMesh::meshChanged(), FEProblemBase::projectSolution(), ElementSubdomainModifierBase::reinitializedBndNodeRange(), and NearestNodeLocator::updatePatch().
| 
 | 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 432 of file MooseBase.h.
| 
 | inherited | 
Get the coarsening map for a given element type.
This will tell you what quadrature points to copy from and to for stateful material properties on newly created elements from Adaptivity.
| elem | The element that represents the element type you need the coarsening map for. | 
| input_side | The side to map | 
Definition at line 2617 of file MooseMesh.C.
Referenced by ProjectMaterialProperties::onBoundary(), and ProjectMaterialProperties::onElement().
| 
 | inlineinherited | 
Return construct node list from side list boolean.
Definition at line 1427 of file MooseMesh.h.
Referenced by SidesetAroundSubdomainUpdater::SidesetAroundSubdomainUpdater().
| 
 | inherited | 
Get the coordinate system type, e.g.
xyz, rz, or r-spherical, for the provided subdomain id sid 
Definition at line 4196 of file MooseMesh.C.
Referenced by SubProblem::getCoordSystem(), and ComputeLinearFVGreenGaussGradientVolumeThread::operator()().
| 
 | inherited | 
Get the map from subdomain ID to coordinate system type, e.g.
xyz, rz, or r-spherical
Definition at line 4228 of file MooseMesh.C.
Referenced by MooseMesh::setGeneralAxisymmetricCoordAxes().
| 
 | 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().
| 
 | inlineinherited | 
Return the accessing integer for an extra element integer with its name.
Definition at line 2192 of file MooseMesh.h.
Referenced by MooseMesh::areElemIDsIdentical().
| 
 | inherited | 
Definition at line 1138 of file MooseMesh.C.
| 
 | inherited | 
Return all the unique element IDs for an extra element integer with its index on a set of subdomains.
Definition at line 1177 of file MooseMesh.C.
| 
 | inlineoverridevirtual | 
Returns the name of the mesh file read to produce this mesh if any or an empty string otherwise.
Reimplemented from MooseMesh.
Definition at line 31 of file FileMesh.h.
Referenced by MFEMMesh::buildMesh().
| 
 | inherited | 
Gets the general axisymmetric coordinate axis for a block.
| [in] | subdomain_id | Subdomain ID for which to get axisymmetric coordinate axis | 
Definition at line 4290 of file MooseMesh.C.
| 
 | inherited | 
Return a writable reference to the set of ghosted boundary IDs.
Definition at line 3262 of file MooseMesh.C.
| 
 | inherited | 
Return a writable reference to the _ghosted_boundaries_inflation vector.
Definition at line 3268 of file MooseMesh.C.
Referenced by NearestNodeLocator::findNodes(), and NearestNodeLocator::updatePatch().
| 
 | inlineinherited | 
Getter for the ghosting_patch_size parameter.
Definition at line 622 of file MooseMesh.h.
Referenced by NearestNodeLocator::findNodes(), and NearestNodeLocator::updatePatch().
Returns the local side ID of the interior parent aligned with the lower dimensional element.
Definition at line 1750 of file MooseMesh.C.
| 
 | inlineinherited | 
Definition at line 136 of file MooseBase.h.
Referenced by FEProblemBase::addAnyRedistributers(), MooseBase::callMooseError(), MooseBase::getHitNode(), and MooseBase::messagePrefix().
| 
 | inherited | 
Get a (slightly inflated) processor bounding box.
| inflation_multiplier | This amount will be multiplied by the length of the diagonal of the bounding box to find the amount to inflate the bounding box by in all directions. | 
Definition at line 3440 of file MooseMesh.C.
Referenced by PositionsFunctorValueSampler::execute(), PointVariableSamplerBase::execute(), CartesianGridDivision::initialize(), and RadialAverage::updateCommunicationLists().
| 
 | inherited | 
Get the list of subdomains contacting the given boundary.
| bid | The boundary ID you want to get the subdomain IDs for. | 
Definition at line 3564 of file MooseMesh.C.
| 
 | inlineinherited | 
Accessor for Kokkos mesh object.
Definition at line 666 of file MooseMesh.h.
Referenced by BlockRestrictable::initializeBlockRestrictable().
| 
 | inherited | 
Definition at line 1313 of file MooseMesh.C.
Referenced by AuxiliarySystem::computeNodalVarsHelper(), FEProblemBase::computeUserObjectsInternal(), FEProblemBase::getCurrentAlgebraicNodeRange(), FEProblemBase::initialSetup(), and MooseMesh::meshChanged().
Returns a const pointer to a lower dimensional element that corresponds to a side of a higher dimensional element.
This relationship is established through an internal_parent; if there is no lowerDElem, nullptr is returned.
Definition at line 1739 of file MooseMesh.C.
Referenced by GhostLowerDElems::operator()(), DisplacedProblem::reinitElemNeighborAndLowerD(), and FEProblemBase::reinitElemNeighborAndLowerD().
| 
 | inlineinherited | 
This function attempts to return the map from a high-order element side to its corresponding lower-d element.
Definition at line 2226 of file MooseMesh.h.
Reimplemented in AnnularMesh, and GeneratedMesh.
Definition at line 2246 of file MooseMesh.C.
Referenced by MooseMesh::dimensionWidth(), GeneratedMesh::getMaxInDimension(), AnnularMesh::getMaxInDimension(), and PropertyReadFile::PropertyReadFile().
| 
 | inlineinherited | 
Getter for the maximum leaf size parameter.
Definition at line 627 of file MooseMesh.h.
Referenced by NearestNodeLocator::findNodes(), and NearestNodeLocator::updatePatch().
| 
 | inlineinherited | 
Get the maximum number of nodes per element.
Definition at line 1154 of file MooseMesh.h.
| 
 | inlineinherited | 
Get the maximum number of nodes per side.
Definition at line 1159 of file MooseMesh.h.
| 
 | inlineinherited | 
Get the maximum number of sides per element.
Definition at line 1149 of file MooseMesh.h.
| 
 | inherited | 
Accessor for the underlying libMesh Mesh object.
Definition at line 3469 of file MooseMesh.C.
Referenced by CopyMeshPartitioner::_do_partition(), AddPeriodicBCAction::act(), MooseMesh::activeLocalElementsBegin(), MooseMesh::activeLocalElementsEnd(), Adaptivity::adaptMesh(), FEProblemBase::addAnyRedistributers(), MooseMesh::addQuadratureNode(), MooseMesh::addUniqueNode(), MultiAppConservativeTransfer::adjustTransferredSolution(), MultiAppConservativeTransfer::adjustTransferredSolutionNearestPoint(), NonlinearSystemBase::assembleScalingVector(), Assembly::Assembly(), AuxKernelBase::AuxKernelBase(), MooseMesh::buildActiveSideList(), MooseMesh::buildBndElemList(), MFEMMesh::buildDummyMooseMesh(), MooseMesh::buildElemIDInfo(), MooseMesh::buildFiniteVolumeInfo(), MooseMesh::buildHRefinementAndCoarseningMaps(), MooseMesh::buildLowerDMesh(), TiledMesh::buildMesh(), buildMesh(), AnnularMesh::buildMesh(), RinglebMesh::buildMesh(), SpiralAnnularMesh::buildMesh(), ConcentricCircleMesh::buildMesh(), GeneratedMesh::buildMesh(), StitchedMesh::buildMesh(), PatternedMesh::buildMesh(), ImageMesh::buildMesh2D(), ImageMesh::buildMesh3D(), MooseMesh::buildNodeList(), MooseMesh::buildNodeListFromSideList(), MooseMesh::buildPeriodicNodeMap(), MooseMesh::buildPeriodicNodeSets(), MooseMesh::buildPRefinementAndCoarseningMaps(), MooseMesh::buildSideList(), MooseMesh::cacheChangedLists(), MultiAppVariableValueSamplePostprocessorTransfer::cacheElemToPostprocessorData(), MooseMesh::cacheInfo(), MooseMesh::changeBoundaryId(), MooseMesh::checkCoordinateSystems(), MooseMesh::computeMaxPerElemAndSide(), NonlinearSystemBase::constraintJacobians(), NonlinearSystemBase::constraintResiduals(), PenetrationThread::createInfoForElem(), MortarData::createMortarInterface(), MooseMesh::detectOrthogonalDimRanges(), MooseMesh::detectPairedSidesets(), MooseMesh::dimension(), ExtraElementIntegerDivision::divisionIndex(), FunctorBinnedValuesDivision::divisionIndex(), SubdomainsDivision::divisionIndex(), DumpObjectsProblem::dumpVariableHelper(), ElementalVariableValue::ElementalVariableValue(), ElementGroupCentroidPositions::ElementGroupCentroidPositions(), ElementMaterialSampler::ElementMaterialSampler(), MooseMesh::elemPtr(), ElemSideNeighborLayersTester::execute(), NodalNormalsCorner::execute(), MultiAppVariableValueSamplePostprocessorTransfer::execute(), MultiAppUserObjectTransfer::execute(), NodalNormalsPreprocessor::execute(), ExtraElementIntegerDivision::ExtraElementIntegerDivision(), ExtraIDIntegralVectorPostprocessor::ExtraIDIntegralVectorPostprocessor(), QuadraturePointMultiApp::fillPositions(), CentroidMultiApp::fillPositions(), MultiAppGeometricInterpolationTransfer::fillSourceInterpolationPoints(), SidesetAroundSubdomainUpdater::finalize(), ActivateElementsUserObjectBase::finalize(), ElementSubdomainModifierBase::gatherMovingBoundaryChanges(), ElementSubdomainModifierBase::gatherMovingBoundaryChangesHelper(), MooseMesh::getActiveLocalElementRange(), MooseMesh::getActiveNodeRange(), MooseMesh::getBlocksMaxDimension(), MooseMesh::getBoundaryID(), MooseMesh::getBoundaryIDs(), MooseMesh::getBoundaryName(), MooseMesh::getElementIDIndex(), MooseMesh::getElemIDMapping(), FEProblemBase::getEvaluableElementRange(), MooseMesh::getInflatedProcessorBoundingBox(), MooseMesh::getLocalNodeRange(), SubProblem::getMaterialPropertyBlockNames(), SubProblem::getMaterialPropertyBoundaryNames(), MooseMesh::getNodeList(), FEProblemBase::getNonlinearEvaluableElementRange(), MooseMesh::getPointLocator(), MooseMesh::getSubdomainID(), MooseMesh::getSubdomainIDs(), MooseMesh::getSubdomainName(), MooseMesh::ghostGhostedBoundaries(), Exodus::handleExodusIOMeshRenumbering(), MooseMesh::hasElementID(), MooseMesh::init(), DisplacedProblem::UpdateDisplacedMeshThread::init(), VerifyElementUniqueID::initialize(), VerifyNodalUniqueID::initialize(), ExtraElementIntegerDivision::initialize(), ElementCentroidPositions::initialize(), ElementGroupCentroidPositions::initialize(), FunctorPositions::initialize(), FunctorTimes::initialize(), NodePositions::initialize(), QuadraturePointsPositions::initialize(), FunctorExtremaPositions::initialize(), ParsedDownSelectionPositions::initialize(), MultiAppDofCopyTransfer::initialSetup(), NodalVariableValue::initialSetup(), FEProblemBase::initialSetup(), SampledOutput::initSample(), MultiAppGeometricInterpolationTransfer::interpolateTargetPoints(), LinearNodalConstraint::LinearNodalConstraint(), MooseMesh::localNodesBegin(), MooseMesh::localNodesEnd(), Moose::Mortar::loopOverMortarSegments(), MooseMesh::maxElemId(), MooseMesh::maxNodeId(), GhostingUserObject::meshChanged(), RadialAverage::meshChanged(), DisplacedProblem::meshChanged(), FEProblemBase::meshChanged(), MooseMesh::MooseMesh(), NearestNodeLocator::nearestNode(), MooseMesh::nElem(), MooseMesh::nNodes(), NodalPatchRecovery::NodalPatchRecovery(), NodalVariableValue::NodalVariableValue(), MooseMesh::nodeToActiveSemilocalElemMap(), MooseMesh::nodeToElemMap(), ComputeNodalUserObjectsThread::onNode(), ProxyRelationshipManager::operator()(), MortarUserObjectThread::operator()(), PenetrationThread::operator()(), ComputeMortarFunctor::operator()(), XDA::output(), Exodus::outputEmptyTimestep(), Exodus::outputNodalVariables(), MooseMesh::prepare(), BoundaryPreservedMarker::preserveBoundary(), MooseMesh::printInfo(), MooseMesh::queryElemPtr(), MooseMesh::queryNodePtr(), read(), PropertyReadFile::readData(), RedistributeProperties::redistribute(), SubProblem::restrictionBoundaryCheckName(), SubProblem::restrictionSubdomainCheckName(), MooseMesh::setBoundaryName(), NonlinearSystemBase::setConstraintSecondaryValues(), XFEMInterface::setDisplacedMesh(), ActivateElementsUserObjectBase::setNewBoundayName(), MooseMesh::setPartitionerHelper(), MooseMesh::setSubdomainName(), SidesetAroundSubdomainUpdater::SidesetAroundSubdomainUpdater(), MooseMesh::sideWithBoundaryID(), MoveNodesToGeometryModifierBase::snapNodes(), MultiAppDofCopyTransfer::transfer(), DisplacedProblem::undisplaceMesh(), MooseMesh::update(), MooseMesh::updateActiveSemiLocalNodeRange(), EqualValueBoundaryConstraint::updateConstrainedNodes(), Adaptivity::updateErrorVectors(), RandomData::updateGenerators(), DisplacedProblem::updateMesh(), SampledOutput::updateSample(), and VariableCondensationPreconditioner::VariableCondensationPreconditioner().
| 
 | inherited | 
| 
 | inherited | 
Definition at line 3476 of file MooseMesh.C.
| 
 | inherited | 
| 
 | inherited | 
Definition at line 3463 of file MooseMesh.C.
Referenced by MooseMesh::buildTypedMesh(), RelationshipManager::init(), and GhostBoundary::operator()().
Returns the min or max of the requested dimension respectively.
Reimplemented in AnnularMesh, and GeneratedMesh.
Definition at line 2237 of file MooseMesh.C.
Referenced by MooseMesh::dimensionWidth(), GeneratedMesh::getMinInDimension(), AnnularMesh::getMinInDimension(), and PropertyReadFile::PropertyReadFile().
| 
 | inlineinherited | 
Get the MooseApp this class is associated with.
Definition at line 87 of file MooseBase.h.
Referenced by ChainControlSetupAction::act(), AddDefaultConvergenceAction::addDefaultMultiAppFixedPointConvergence(), AddDefaultConvergenceAction::addDefaultNonlinearConvergence(), AddDefaultConvergenceAction::addDefaultSteadyStateConvergence(), FEProblemBase::advanceState(), ParsedChainControl::buildFunction(), ReporterTransferInterface::checkHasReporterValue(), AddDefaultConvergenceAction::checkUnusedMultiAppFixedPointConvergenceParameters(), AddDefaultConvergenceAction::checkUnusedNonlinearConvergenceParameters(), AddDefaultConvergenceAction::checkUnusedSteadyStateConvergenceParameters(), Coupleable::checkWritableVar(), ComponentPhysicsInterface::ComponentPhysicsInterface(), Coupleable::Coupleable(), MortarData::createMortarInterface(), EigenProblem::doFreeNonlinearPowerIterations(), Terminator::execute(), FEProblemSolve::FEProblemSolve(), SolutionInvalidInterface::flagInvalidSolutionInternal(), ChainControl::getChainControlDataSystem(), DefaultConvergenceBase::getSharedExecutionerParam(), ChainControlDataPostprocessor::initialSetup(), MooseVariableDataFV< OutputType >::MooseVariableDataFV(), ProgressOutput::output(), PetscOutputInterface::petscLinearOutput(), PetscOutputInterface::petscNonlinearOutput(), PetscOutputInterface::PetscOutputInterface(), PostprocessorInterface::postprocessorsAdded(), MultiApp::preTransfer(), Reporter::Reporter(), ReporterInterface::reportersAdded(), MultiApp::restore(), and VectorPostprocessorInterface::vectorPostprocessorsAdded().
| 
 | inherited | 
Return list of blocks to which the given node belongs.
Definition at line 1537 of file MooseMesh.C.
Referenced by ComputeNodalUserObjectsThread::onNode(), ComputeNodalKernelsThread::onNode(), ComputeNodalKernelJacobiansThread::onNode(), ComputeInitialConditionThread::operator()(), and MoveNodesToGeometryModifierBase::snapNodes().
| 
 | inherited | 
Return a writable reference to a vector of node IDs that belong to nodeset_id.
Definition at line 3491 of file MooseMesh.C.
Referenced by LinearNodalConstraint::LinearNodalConstraint(), NodalScalarKernel::NodalScalarKernel(), MoveNodesToGeometryModifierBase::snapNodes(), and EqualValueBoundaryConstraint::updateConstrainedNodes().
| 
 | inherited | 
Returns the normal vector associated with a given BoundaryID.
It's only valid to call this when AddAllSideSetsByNormals is active.
Definition at line 2850 of file MooseMesh.C.
| 
 | inherited | 
This function attempts to return the paired boundary ids for the given component.
For example, in a generated 2D mesh, passing 0 for the "x" component will return (3, 1).
| component | - An integer representing the desired component (dimension) | 
Definition at line 2331 of file MooseMesh.C.
Referenced by MooseMesh::addPeriodicVariable(), and AddPeriodicBCAction::autoTranslationBoundaries().
| 
 | inlineinherited | 
Definition at line 1019 of file MooseMesh.h.
Referenced by MultiAppDofCopyTransfer::initialSetup().
| 
 | inherited | 
Retrieve a parameter for the object.
| name | The name of the parameter | 
Definition at line 388 of file MooseBase.h.
Referenced by CreateDisplacedProblemAction::act(), AddPeriodicBCAction::act(), CommonOutputAction::act(), FEProblemBase::addOutput(), DiffusionPhysicsBase::addPostprocessors(), ADNodalKernel::ADNodalKernel(), ArrayParsedAux::ArrayParsedAux(), AddPeriodicBCAction::autoTranslationBoundaries(), BicubicSplineFunction::BicubicSplineFunction(), Boundary2DDelaunayGenerator::Boundary2DDelaunayGenerator(), ComponentPhysicsInterface::ComponentPhysicsInterface(), FunctorAux::computeValue(), Console::Console(), FEProblemBase::createTagSolutions(), CutMeshByLevelSetGenerator::CutMeshByLevelSetGenerator(), DebugResidualAux::DebugResidualAux(), AccumulateReporter::declareLateValues(), DerivativeParsedMaterialTempl< is_ad >::DerivativeParsedMaterialTempl(), DynamicObjectRegistrationAction::DynamicObjectRegistrationAction(), EigenKernel::EigenKernel(), ElementGroupCentroidPositions::ElementGroupCentroidPositions(), FEProblemSolve::FEProblemSolve(), ParsedVectorReporter::finalize(), FiniteDifferencePreconditioner::FiniteDifferencePreconditioner(), ParsedSubdomainGeneratorBase::functionInitialize(), FVInterfaceKernel::FVInterfaceKernel(), BoundaryLayerSubdomainGenerator::generate(), ExtraNodesetGenerator::generate(), FileMeshGenerator::generate(), CoarsenBlockGenerator::generate(), GeneratedMeshGenerator::generate(), RefineBlockGenerator::generate(), RefineSidesetGenerator::generate(), BlockDeletionGenerator::generate(), BreakMeshByBlockGenerator::generate(), MeshExtruderGenerator::generate(), GenericConstantRankTwoTensorTempl< is_ad >::GenericConstantRankTwoTensorTempl(), GenericConstantSymmetricRankTwoTensorTempl< is_ad >::GenericConstantSymmetricRankTwoTensorTempl(), GeometricSearchInterface::GeometricSearchInterface(), MooseApp::getCheckpointDirectories(), DataFileInterface::getDataFileName(), ExecutorInterface::getExecutor(), GhostingUserObject::GhostingUserObject(), FixedPointIterationAdaptiveDT::init(), TimeSequenceStepper::init(), IterationAdaptiveDT::init(), AdvancedOutput::init(), AttribThread::initFrom(), AttribSysNum::initFrom(), AttribResidualObject::initFrom(), AttribDisplaced::initFrom(), BlockRestrictable::initializeBlockRestrictable(), BoundaryRestrictable::initializeBoundaryRestrictable(), Console::initialSetup(), SampledOutput::initSample(), IterationAdaptiveDT::limitDTToPostprocessorValue(), MooseMesh::MooseMesh(), MooseStaticCondensationPreconditioner::MooseStaticCondensationPreconditioner(), MooseVariableBase::MooseVariableBase(), MultiSystemSolveObject::MultiSystemSolveObject(), NEML2ModelExecutor::NEML2ModelExecutor(), NestedDivision::NestedDivision(), PerfGraphOutput::output(), Console::outputSystemInformation(), ParsedCurveGenerator::ParsedCurveGenerator(), ParsedElementDeletionGenerator::ParsedElementDeletionGenerator(), ParsedGenerateNodeset::ParsedGenerateNodeset(), ParsedGenerateSideset::ParsedGenerateSideset(), ParsedMaterialTempl< is_ad >::ParsedMaterialTempl(), ParsedNodeTransformGenerator::ParsedNodeTransformGenerator(), ParsedODEKernel::ParsedODEKernel(), ParsedPostprocessor::ParsedPostprocessor(), ParsedReporterBase::ParsedReporterBase(), ParsedVectorReporter::ParsedVectorReporter(), PiecewiseByBlockFunctorMaterialTempl< T >::PiecewiseByBlockFunctorMaterialTempl(), PiecewiseConstantByBlockMaterialTempl< is_ad >::PiecewiseConstantByBlockMaterialTempl(), ReferenceResidualInterface::ReferenceResidualInterface(), RenameBlockGenerator::RenameBlockGenerator(), Moose::FV::setInterpolationMethod(), SetupMeshAction::setupMesh(), Output::setWallTimeIntervalFromCommandLineParam(), 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 425 of file MooseBase.h.
| 
 | inherited | 
Getter for the patch_size parameter.
Definition at line 3422 of file MooseMesh.C.
Referenced by NearestNodeLocator::findNodes(), and NearestNodeLocator::updatePatch().
| 
 | inherited | 
Get the current patch update strategy.
Definition at line 3434 of file MooseMesh.C.
Referenced by FEProblemBase::possiblyRebuildGeomSearchPatches().
Get the map describing for each volumetric quadrature point (qp) on the coarse level which qp on the previous finer level the coarse qp is closest to.
Definition at line 4411 of file MooseMesh.C.
Referenced by ProjectMaterialProperties::onElement().
Get the map describing for each side quadrature point (qp) on the coarse level which qp on the previous finer level the coarse qp is closest to.
Definition at line 4417 of file MooseMesh.C.
Referenced by ProjectMaterialProperties::onBoundary().
| 
 | virtualinherited | 
Proxy function to get a (sub)PointLocator from either the underlying libMesh mesh (default), or to allow derived meshes to return a custom point locator.
Definition at line 3754 of file MooseMesh.C.
Referenced by CopyMeshPartitioner::_do_partition(), PenetrationLocator::detectPenetration(), MultiAppVariableValueSampleTransfer::execute(), PointValue::execute(), IntersectionPointsAlongLine::execute(), MultiAppVariableValueSamplePostprocessorTransfer::execute(), ElementsAlongLine::execute(), FindValueOnLine::initialize(), PointSamplerBase::initialize(), PiecewiseConstantFromCSV::initialSetup(), ReporterPointMarker::markerSetup(), and PenetrationThread::operator()().
Get the map describing for each volumetric quadrature point (qp) on the refined level which qp on the previous coarser level the fine qp is closest to.
Definition at line 4399 of file MooseMesh.C.
Referenced by ProjectMaterialProperties::onElement().
Get the map describing for each side quadrature point (qp) on the refined level which qp on the previous coarser level the fine qp is closest to.
Definition at line 4405 of file MooseMesh.C.
Referenced by ProjectMaterialProperties::onBoundary().
| 
 | inherited | 
Get a specified quadrature node.
| elem | The element the quadrature point is on | 
| side | The side the quadrature point is on | 
| qp | The quadrature point number associated with the point | 
Definition at line 1700 of file MooseMesh.C.
Referenced by GapValueAux::computeValue(), NearestNodeDistanceAux::computeValue(), PenetrationAux::computeValue(), and GeometricSearchData::updateQuadratureNodes().
| 
 | inherited | 
Get the refinement map for a given element type.
This will tell you what quadrature points to copy from and to for stateful material properties on newly created elements from Adaptivity.
| elem | The element that represents the element type you need the refinement map for. | 
| parent_side | The side of the parent to map (-1 if not mapping parent sides) | 
| child | The child number (-1 if not mapping child internal sides) | 
| child_side | The side number of the child (-1 if not mapping sides) | 
TODO: When running with parallel mesh + stateful adaptivty we will need to make sure that each processor has a complete map. This may require parallel communication. This is likely to happen when running on a mixed element mesh.
Definition at line 2553 of file MooseMesh.C.
Referenced by ProjectMaterialProperties::onBoundary(), ProjectMaterialProperties::onElement(), and ProjectMaterialProperties::onInternalSide().
| 
 | 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 402 of file MooseBase.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 294 of file Restartable.h.
| 
 | inherited | 
Get another shared pointer to this object that has the same ownership group.
Wrapper around shared_from_this().
Definition at line 72 of file MooseObject.C.
Referenced by MFEMProblem::addBoundaryCondition(), MFEMProblem::addKernel(), and MFEMProblem::addMFEMSolver().
| 
 | inherited | 
Definition at line 85 of file MooseObject.C.
| 
 | inherited | 
Get the list of boundary ids associated with the given subdomain id.
| subdomain_id | The subdomain ID you want to get the boundary ids for. | 
Definition at line 3518 of file MooseMesh.C.
Referenced by MooseMesh::getSubdomainInterfaceBoundaryIds(), and FEProblemBase::prepareMaterials().
| 
 | inherited | 
Get the associated subdomain ID for the subdomain name.
| subdomain_name | The name of the subdomain | 
Definition at line 1769 of file MooseMesh.C.
Referenced by SystemBase::addVariable(), FEProblemBase::checkProblemIntegrity(), FVInterfaceKernel::FVInterfaceKernel(), TimedSubdomainModifier::getSubdomainIDAndCheck(), SolutionIC::initialSetup(), ElementSubdomainModifierBase::initialSetup(), PiecewiseByBlockFunctorMaterialTempl< T >::PiecewiseByBlockFunctorMaterialTempl(), PiecewiseConstantByBlockMaterialTempl< is_ad >::PiecewiseConstantByBlockMaterialTempl(), MooseMesh::prepare(), MooseMesh::setCoordSystem(), and MooseMesh::setGeneralAxisymmetricCoordAxes().
| 
 | inherited | 
Get the associated subdomainIDs for the subdomain names that are passed in.
| subdomain_names | The names of the subdomains | 
Definition at line 1775 of file MooseMesh.C.
Referenced by FEProblemBase::addAuxVariable(), FEProblemBase::addVariable(), MultiAppUserObjectTransfer::execute(), MooseMesh::getBlocksMaxDimension(), BlockRestrictable::hasBlocks(), SubdomainsDivision::initialize(), BlockRestrictable::initializeBlockRestrictable(), MultiAppDofCopyTransfer::initialSetup(), ElementSubdomainModifierBase::initialSetup(), MultiAppGeometricInterpolationTransfer::interpolateTargetPoints(), and LayeredBase::LayeredBase().
| 
 | inherited | 
Definition at line 1781 of file MooseMesh.C.
| 
 | inherited | 
Get the list of boundaries that contact the given subdomain.
| subdomain_id | The subdomain ID you want to get the boundary ids for. | 
Definition at line 3529 of file MooseMesh.C.
| 
 | inherited | 
Return the name of a block given an id.
Definition at line 1801 of file MooseMesh.C.
Referenced by ArrayDGLowerDKernel::ArrayDGLowerDKernel(), ArrayHFEMDirichletBC::ArrayHFEMDirichletBC(), ArrayLowerDIntegratedBC::ArrayLowerDIntegratedBC(), FEProblemBase::checkDependMaterialsHelper(), MooseMesh::checkDuplicateSubdomainNames(), DomainUserObject::checkVariable(), DGLowerDKernel::DGLowerDKernel(), FEProblemBase::duplicateVariableCheck(), MooseMesh::getSubdomainNames(), HFEMDirichletBC::HFEMDirichletBC(), LowerDIntegratedBC::LowerDIntegratedBC(), MooseVariableBase::MooseVariableBase(), ComputeLinearFVElementalThread::printBlockExecutionInformation(), ComputeLinearFVFaceThread::printBlockExecutionInformation(), NonlinearThread::printBlockExecutionInformation(), and MooseMesh::setGeneralAxisymmetricCoordAxes().
| 
 | inherited | 
Get the associated subdomainNames for the subdomain ids that are passed in.
| subdomain_ids | The ids of the subdomains | 
Definition at line 1807 of file MooseMesh.C.
Referenced by NonlinearSystemBase::checkKernelCoverage(), FEProblemBase::checkProblemIntegrity(), SampledOutput::cloneMesh(), BlockRestrictable::initializeBlockRestrictable(), and SolutionIC::initialSetup().
| 
 | inherited | 
Get the coordinate system from the mesh, it must be the same in all subdomains otherwise this will error.
Definition at line 4206 of file MooseMesh.C.
Referenced by HDGKernel::HDGKernel().
| 
 | inherited | 
Actually do the ghosting of boundaries that need to be ghosted to this processor.
Definition at line 3335 of file MooseMesh.C.
Referenced by FEProblemBase::ghostGhostedBoundaries().
| 
 | inlineinherited | 
Definition at line 142 of file MooseBase.h.
| 
 | inlineinherited | 
Whether mesh has an extra element integer with a given name.
Definition at line 2186 of file MooseMesh.h.
Referenced by MooseMesh::getElementIDIndex().
| 
 | inlineinherited | 
Definition at line 1416 of file MooseMesh.h.
Referenced by GhostLowerDElems::operator()().
| 
 | inlineinherited | 
Whether mesh base object was constructed or not.
Definition at line 1107 of file MooseMesh.h.
Referenced by MeshGeneratorMesh::buildMesh().
| 
 | inherited | 
check if the mesh has SECOND order elements
Definition at line 3732 of file MooseMesh.C.
Referenced by Assembly::adCurvatures(), Assembly::Assembly(), Assembly::havePRefinement(), MultiAppGeneralFieldNearestLocationTransfer::initialSetup(), and SolutionUserObjectBase::SolutionUserObjectBase().
| 
 | virtualinherited | 
Initialize the Mesh object.
Most of the time this will turn around and call build_mesh so the child class can build the Mesh object.
However, during Recovery this will read the CPA file...
If the mesh base hasn't been constructed by the time init is called, just do it here. This can happen if somebody builds a mesh outside of the normal Action system. Forcing developers to create, construct the MeshBase, and then init separately is a bit much for casual use but it gives us the ability to run MeshGenerators in-between.
Definition at line 2913 of file MooseMesh.C.
| 
 | inlineinherited | 
Definition at line 1421 of file MooseMesh.h.
Referenced by FEProblemBase::adaptMesh(), ArrayDGLowerDKernel::ArrayDGLowerDKernel(), NonlinearSystemBase::checkKernelCoverage(), BlockRestrictable::checkVariable(), ComputeFullJacobianThread::computeOnInternalFace(), DGLowerDKernel::DGLowerDKernel(), FEProblemBase::initialAdaptMesh(), DisplacedProblem::reinitElemNeighborAndLowerD(), and FEProblemBase::reinitElemNeighborAndLowerD().
| 
 | inherited | 
Returns true if the requested element is in the list of boundary elements, false otherwise.
Definition at line 3612 of file MooseMesh.C.
Referenced by BoundaryMarker::computeElementMarker().
| 
 | inherited | 
Returns true if the requested element is in the list of boundary elements for the specified boundary, false otherwise.
Definition at line 3627 of file MooseMesh.C.
| 
 | inherited | 
Returns whether a boundary (given by its id) is not crossing through a group of blocks, by which we mean that elements on both sides of the boundary are in those blocks.
| bid | the id of the boundary of interest | 
| blk_group | the group of blocks potentially traversed | 
Definition at line 1411 of file MooseMesh.C.
| 
 | inherited | 
Returns true if the requested node is in the list of boundary nodes, false otherwise.
Definition at line 3586 of file MooseMesh.C.
Referenced by LowerBoundNodalKernel::computeQpJacobian(), UpperBoundNodalKernel::computeQpJacobian(), UpperBoundNodalKernel::computeQpOffDiagJacobian(), LowerBoundNodalKernel::computeQpOffDiagJacobian(), UpperBoundNodalKernel::computeQpResidual(), LowerBoundNodalKernel::computeQpResidual(), and NodalNormalsPreprocessor::execute().
| 
 | inherited | 
Returns true if the requested node is in the list of boundary nodes for the specified boundary, false otherwise.
Definition at line 3601 of file MooseMesh.C.
| 
 | inherited | 
Setter and getter for _custom_partitioner_requested.
Definition at line 3726 of file MooseMesh.C.
| 
 | inlineinherited | 
Set whether this mesh is a displaced mesh.
Definition at line 1226 of file MooseMesh.h.
| 
 | inlineinherited | 
whether this mesh is a displaced mesh
Definition at line 1231 of file MooseMesh.h.
| 
 | inlinevirtualinherited | 
Returns the final Mesh distribution type.
Reimplemented in MFEMMesh.
Definition at line 1004 of file MooseMesh.h.
Referenced by AddPeriodicBCAction::autoTranslationBoundaries(), BoundaryMarker::BoundaryMarker(), VerifyElementUniqueID::finalize(), VerifyNodalUniqueID::finalize(), ElementSubdomainModifierBase::gatherPatchElements(), Checkpoint::updateCheckpointFiles(), and RandomData::updateGenerators().
| 
 | inlineinherited | 
Definition at line 1322 of file MooseMesh.h.
Referenced by SideIntegralPostprocessor::initialSetup(), and FEProblemBase::meshChanged().
| 
 | inlineinherited | 
Get whether this object is a Kokkos functor The parameter is set by the Kokkos base classes:
Definition at line 75 of file MooseObject.h.
Referenced by BlockRestrictable::initializeBlockRestrictable(), and BoundaryRestrictable::initializeBoundaryRestrictable().
| 
 | inlineinherited | 
subdomain_id is a lower-dimensional manifold of some higher-dimensional subdomain, or in implementation speak, whether the elements of this subdomain have non-null interior parents Definition at line 2232 of file MooseMesh.h.
Referenced by ProjectionAux::computeValue(), ProjectionAux::elemOnNodeVariableIsDefinedOn(), MooseVariableBase::MooseVariableBase(), and ProjectionAux::ProjectionAux().
| 
 | inlineinherited | 
Tell the user if the distribution was overriden for any reason.
Definition at line 1009 of file MooseMesh.h.
| 
 | inlineinherited | 
Test if the supplied parameter is set by a user, as opposed to not set or set to default.
| name | The name of the parameter to test | 
Definition at line 205 of file MooseBase.h.
Referenced by SetupDebugAction::act(), DiffusionCG::addFEBCs(), DiffusionPhysicsBase::addInitialConditions(), MFEMMesh::buildMesh(), MFEMDomainSubMesh::buildSubMesh(), LibtorchNeuralNetControl::conditionalParameterError(), ConservativeAdvectionBCTempl< false >::ConservativeAdvectionBCTempl(), MooseApp::copyInputs(), DiffusionPhysicsBase::DiffusionPhysicsBase(), MooseApp::errorCheck(), MFEMVectorFESpace::getFECName(), MooseBase::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(), MooseApp::runInputFile(), MooseApp::runInputs(), MFEMSolverBase::setPreconditioner(), SetupMeshAction::setupMesh(), MooseApp::setupOptions(), SideSetsFromBoundingBoxGenerator::SideSetsFromBoundingBoxGenerator(), TagVectorAux::TagVectorAux(), TimedSubdomainModifier::TimedSubdomainModifier(), and XYDelaunayGenerator::XYDelaunayGenerator().
| 
 | inlineinherited | 
Test if the supplied parameter is valid.
| name | The name of the parameter to test | 
Definition at line 199 of file MooseBase.h.
Referenced by HierarchicalGridPartitioner::_do_partition(), GridPartitioner::_do_partition(), CopyNodalVarsAction::act(), SetupMeshAction::act(), SetupDebugAction::act(), ComposeTimeStepperAction::act(), AddVariableAction::act(), CreateDisplacedProblemAction::act(), SetAdaptivityOptionsAction::act(), CommonOutputAction::act(), 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(), Boundary2DDelaunayGenerator::Boundary2DDelaunayGenerator(), TimedSubdomainModifier::buildFromFile(), PiecewiseTabularBase::buildFromFile(), PiecewiseTabularBase::buildFromJSON(), ParsedChainControl::buildFunction(), GeneratedMesh::buildMesh(), MooseMesh::buildTypedMesh(), CartesianGridDivision::CartesianGridDivision(), CartesianMeshGenerator::CartesianMeshGenerator(), MultiAppTransfer::checkParentAppUserObjectExecuteOn(), LibmeshPartitioner::clone(), SampledOutput::cloneMesh(), CombinerGenerator::CombinerGenerator(), FunctorAux::computeValue(), ConservativeAdvectionBCTempl< false >::ConservativeAdvectionBCTempl(), ConservativeAdvectionTempl< is_ad >::ConservativeAdvectionTempl(), FEProblemSolve::convergenceSetup(), CopyMeshPartitioner::CopyMeshPartitioner(), CSVReaderVectorPostprocessor::CSVReaderVectorPostprocessor(), CutMeshByLevelSetGeneratorBase::CutMeshByLevelSetGeneratorBase(), ConstantReporter::declareConstantReporterValue(), 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(), FileOutput::FileOutput(), SpatialUserObjectVectorPostprocessor::fillPoints(), CombinerGenerator::fillPositions(), MultiApp::fillPositions(), FiniteDifferencePreconditioner::FiniteDifferencePreconditioner(), FixedPointSolve::FixedPointSolve(), FunctionDT::FunctionDT(), FunctionValuePostprocessor::FunctionValuePostprocessor(), FVInterfaceKernel::FVInterfaceKernel(), FVMassMatrix::FVMassMatrix(), AddMetaDataGenerator::generate(), ExtraNodesetGenerator::generate(), FileMeshGenerator::generate(), BreakBoundaryOnSubdomainGenerator::generate(), ElementGenerator::generate(), LowerDBlockFromSidesetGenerator::generate(), SubdomainPerElementGenerator::generate(), BlockDeletionGenerator::generate(), GeneratedMeshGenerator::generate(), ParsedSubdomainGeneratorBase::generate(), SideSetsFromNodeSetsGenerator::generate(), MeshExtruderGenerator::generate(), ParsedExtraElementIDGenerator::generate(), XYZDelaunayGenerator::generate(), XYMeshLineCutter::generate(), XYDelaunayGenerator::generate(), SubdomainBoundingBoxGenerator::generate(), DistributedRectilinearMeshGenerator::generate(), PropertyReadFile::getFileNames(), MultiAppNearestNodeTransfer::getLocalEntitiesAndComponents(), MeshGenerator::getMeshGeneratorNameFromParam(), MeshGenerator::getMeshGeneratorNamesFromParam(), MooseBase::getRenamedParam(), MultiAppNearestNodeTransfer::getTargetLocalNodes(), Terminator::handleMessage(), HFEMDirichletBC::HFEMDirichletBC(), EigenExecutionerBase::init(), IterationAdaptiveDT::init(), Eigenvalue::init(), AdvancedOutput::initExecutionTypes(), BlockRestrictable::initializeBlockRestrictable(), BoundaryRestrictable::initializeBoundaryRestrictable(), MultiAppCloneReporterTransfer::initialSetup(), SolutionIC::initialSetup(), MultiAppVariableValueSampleTransfer::initialSetup(), PiecewiseTabularBase::initialSetup(), SolutionScalarAux::initialSetup(), ParsedConvergence::initialSetup(), SolutionAux::initialSetup(), Console::initialSetup(), MooseParsedVectorFunction::initialSetup(), MultiAppGeneralFieldTransfer::initialSetup(), MooseParsedGradFunction::initialSetup(), MooseParsedFunction::initialSetup(), SampledOutput::initSample(), IterationAdaptiveDT::IterationAdaptiveDT(), LeastSquaresFit::LeastSquaresFit(), LibmeshPartitioner::LibmeshPartitioner(), LibtorchNeuralNetControl::LibtorchNeuralNetControl(), MassMatrix::MassMatrix(), MatCoupledForce::MatCoupledForce(), MatDiffusionBase< Real >::MatDiffusionBase(), MeshGeneratorComponent::MeshGeneratorComponent(), MFEMProblemSolve::MFEMProblemSolve(), 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(), MooseBase::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(), MooseApp::setupOptions(), Output::setWallTimeIntervalFromCommandLineParam(), SideDiffusiveFluxIntegralTempl< is_ad, Real >::SideDiffusiveFluxIntegralTempl(), SideSetsGeneratorBase::SideSetsGeneratorBase(), SolutionUserObjectBase::SolutionUserObjectBase(), WebServerControl::startServer(), Terminator::Terminator(), TimeIntervalTimes::TimeIntervalTimes(), TimePeriod::TimePeriod(), MultiAppDofCopyTransfer::transfer(), TransformGenerator::TransformGenerator(), TransientBase::TransientBase(), FunctorIC::value(), VariableCondensationPreconditioner::VariableCondensationPreconditioner(), VectorMagnitudeFunctorMaterialTempl< is_ad >::VectorMagnitudeFunctorMaterialTempl(), WebServerControl::WebServerControl(), XYDelaunayGenerator::XYDelaunayGenerator(), and XYZDelaunayGenerator::XYZDelaunayGenerator().
| 
 | inlineinherited | 
Tell the user if the partitioner was overriden for any reason.
Definition at line 1029 of file MooseMesh.h.
| 
 | inlineinherited | 
Getter to query if the mesh was detected to be regular and orthogonal.
Definition at line 1059 of file MooseMesh.h.
Referenced by AddPeriodicBCAction::setPeriodicVars().
| 
 | inherited | 
Returns true if the node is semi-local.
| node | Node pointer | 
Definition at line 1007 of file MooseMesh.C.
| 
 | inlineinherited | 
Definition at line 1345 of file MooseMesh.h.
| 
 | inherited | 
Returns whether this generated mesh is periodic in the given dimension for the given variable.
| nonlinear_var_num | - The nonlinear variable number | 
| component | - An integer representing the desired component (dimension) | 
Definition at line 2289 of file MooseMesh.C.
Referenced by MooseMesh::minPeriodicVector().
| 
 | inherited | 
Definition at line 4351 of file MooseMesh.C.
| 
 | inherited | 
Calls local_nodes_begin/end() on the underlying libMesh mesh object.
Definition at line 3048 of file MooseMesh.C.
| 
 | inherited | 
Definition at line 3060 of file MooseMesh.C.
| 
 | inherited | 
Definition at line 3054 of file MooseMesh.C.
| 
 | inherited | 
Definition at line 3066 of file MooseMesh.C.
| 
 | inlineinherited | 
| 
 | inlineinherited | 
Return the maximum element ID for an extra element integer with its accessing index.
Definition at line 1122 of file MooseMesh.h.
| 
 | virtualinherited | 
Definition at line 3114 of file MooseMesh.C.
Referenced by SolutionUserObjectBase::pointValueGradientWrapper(), and SolutionUserObjectBase::pointValueWrapper().
| 
 | inlineinherited | 
Returns the maximum h-refinement level of all elements.
Definition at line 1380 of file MooseMesh.h.
| 
 | virtualinherited | 
Calls max_node/elem_id() on the underlying libMesh mesh object.
This may be larger than n_nodes/elem() in cases where the id numbering is not contiguous.
Definition at line 3108 of file MooseMesh.C.
| 
 | inlineinherited | 
Returns the maximum p-refinement level of all elements.
Definition at line 1375 of file MooseMesh.h.
| 
 | inherited | 
Returns a read-only reference to the set of boundary IDs currently present in the Mesh.
Definition at line 3198 of file MooseMesh.C.
Referenced by BoundaryRestrictable::isBoundarySubset().
| 
 | inherited | 
Declares that the MooseMesh has changed, invalidates cached data and rebuilds caches.
Sets a flag so that clients of the MooseMesh also know when it has changed.
Definition at line 897 of file MooseMesh.C.
Referenced by DisplacedProblem::init(), FEProblemBase::init(), DisplacedProblem::meshChanged(), and FEProblemBase::meshChanged().
| 
 | inherited | 
Returns a read-only reference to the set of nodesets currently present in the Mesh.
Definition at line 3210 of file MooseMesh.C.
Referenced by GeometricSearchData::GeometricSearchData(), and BoundaryRestrictable::initializeBoundaryRestrictable().
| 
 | inherited | 
Returns a read-only reference to the set of sidesets currently present in the Mesh.
Definition at line 3204 of file MooseMesh.C.
Referenced by DGKernelBase::DGKernelBase(), and BoundaryRestrictable::initializeBoundaryRestrictable().
| 
 | inherited | 
Returns a read-only reference to the set of subdomains currently present in the Mesh.
Definition at line 3192 of file MooseMesh.C.
Referenced by BlockRestrictable::blockIDs(), MooseMesh::buildElemIDInfo(), FEProblemBase::checkUserObjects(), SampledOutput::cloneMesh(), VariableValueElementSubdomainModifier::computeSubdomainID(), NonlinearSystemBase::constraintJacobians(), NonlinearSystemBase::constraintResiduals(), FEProblemBase::duplicateVariableCheck(), MooseMesh::getUniqueCoordSystem(), BlockRestrictable::initializeBlockRestrictable(), MultiAppDofCopyTransfer::initialSetup(), ElementSubdomainModifierBase::initialSetup(), BlockRestrictable::isBlockSubset(), BlockRestrictable::meshBlockIDs(), MooseMesh::MooseMesh(), DOFMapOutput::output(), NonlinearSystemBase::setConstraintSecondaryValues(), MooseMesh::setCoordSystem(), MooseMesh::setGeneralAxisymmetricCoordAxes(), and SidesetAroundSubdomainUpdater::SidesetAroundSubdomainUpdater().
| 
 | inlineinherited | 
Definition at line 256 of file MooseBase.h.
Referenced by MooseBase::callMooseError(), MooseBase::errorPrefix(), MooseBase::mooseDeprecated(), MooseBase::mooseInfo(), and MooseBase::mooseWarning().
| 
 | inlineinherited | 
Return the minimum element ID for an extra element integer with its accessing index.
Definition at line 1127 of file MooseMesh.h.
| 
 | inherited | 
This function returns the distance between two points on the mesh taking into account periodicity for the given variable number.
| nonlinear_var_num | - The nonlinear variable number | 
| p,q | - The points for which to compute a minimum distance | 
Definition at line 2325 of file MooseMesh.C.
| 
 | inherited | 
This function returns the minimum vector between two points on the mesh taking into account periodicity for the given variable number.
| nonlinear_var_num | - The nonlinear variable number | 
| p,q | - The points between which to compute a minimum vector | 
Definition at line 2300 of file MooseMesh.C.
Referenced by MooseMesh::minPeriodicDistance().
| 
 | inlineinherited | 
Definition at line 87 of file SolutionInvalidInterface.h.
Referenced by FEProblemBase::addAuxArrayVariable(), FEProblemBase::addAuxScalarVariable(), FEProblemBase::addAuxVariable(), FEProblemBase::advanceMultiApps(), MultiApp::appProblem(), ChangeOverTimestepPostprocessor::ChangeOverTimestepPostprocessor(), AddVariableAction::determineType(), EigenProblem::EigenProblem(), Eigenvalue::Eigenvalue(), MooseMesh::elem(), UserForcingFunction::f(), FaceFaceConstraint::FaceFaceConstraint(), FunctionDT::FunctionDT(), RandomICBase::generateRandom(), MooseMesh::getBoundariesToElems(), 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(), TagVectorAux::TagVectorAux(), UserForcingFunction::UserForcingFunction(), and VariableResidual::VariableResidual().
| 
 | inlineinherited | 
Definition at line 314 of file MooseBase.h.
Referenced by DataFileInterface::getDataFileName(), DataFileInterface::getDataFileNameByName(), MooseApp::getRecoverFileBase(), MooseApp::hasRecoverFileBase(), and MooseApp::setupOptions().
| 
 | inlineinherited | 
Definition at line 277 of file MooseBase.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 and optionally a file path to the top-level block parameter if available.
Definition at line 271 of file MooseBase.h.
Referenced by CopyMeshPartitioner::_do_partition(), HierarchicalGridPartitioner::_do_partition(), GridPartitioner::_do_partition(), PetscExternalPartitioner::_do_partition(), MultiAppGeneralFieldTransfer::acceptPointInOriginMesh(), AddBoundsVectorsAction::act(), AddMeshGeneratorAction::act(), AddVectorPostprocessorAction::act(), AutoCheckpointAction::act(), CheckFVBCAction::act(), InitProblemAction::act(), SetupMeshCompleteAction::act(), CreateExecutionerAction::act(), CheckIntegrityAction::act(), AddFVICAction::act(), AddICAction::act(), CreateProblemAction::act(), CreateProblemDefaultAction::act(), CombineComponentsMeshes::act(), SetupMeshAction::act(), SplitMeshAction::act(), AdaptivityAction::act(), ChainControlSetupAction::act(), AddTimeStepperAction::act(), CSGOnlyAction::act(), DeprecatedBlockAction::act(), SetupPredictorAction::act(), SetupTimeStepperAction::act(), CreateDisplacedProblemAction::act(), SetAdaptivityOptionsAction::act(), MaterialDerivativeTestAction::act(), MaterialOutputAction::act(), AddMFEMSubMeshAction::act(), AddPeriodicBCAction::act(), CommonOutputAction::act(), Action::Action(), FEProblemBase::adaptMesh(), 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(), MooseApp::addExecutor(), 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::addObjectParamsHelper(), 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(), MooseApp::appNameToLibName(), MultiApp::appPostprocessorValue(), MultiApp::appProblem(), MultiApp::appProblemBase(), MultiApp::appUserObjectBase(), ArrayConstantIC::ArrayConstantIC(), ArrayDGKernel::ArrayDGKernel(), ArrayDiffusion::ArrayDiffusion(), ArrayFunctionIC::ArrayFunctionIC(), ArrayReaction::ArrayReaction(), ArrayTimeDerivative::ArrayTimeDerivative(), MooseApp::attachRelationshipManagers(), AddPeriodicBCAction::autoTranslationBoundaries(), AuxKernelBase::AuxKernelBase(), Function::average(), Axisymmetric2D3DSolutionFunction::Axisymmetric2D3DSolutionFunction(), BatchMeshGeneratorAction::BatchMeshGeneratorAction(), BicubicSplineFunction::BicubicSplineFunction(), BlockDeletionGenerator::BlockDeletionGenerator(), Boundary2DDelaunayGenerator::Boundary2DDelaunayGenerator(), 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::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(), DefaultSteadyStateConvergence::checkIterationType(), DefaultMultiAppFixedPointConvergence::checkIterationType(), DefaultNonlinearConvergence::checkIterationType(), ExplicitTimeIntegrator::checkLinearConvergence(), MooseApp::checkMetaDataIntegrity(), MeshDiagnosticsGenerator::checkNonConformalMeshFromAdaptivity(), MeshDiagnosticsGenerator::checkNonMatchingEdges(), PostprocessorInterface::checkParam(), FEProblemBase::checkProblemIntegrity(), Sampler::checkReinitStatus(), MooseApp::checkReservedCapability(), MultiAppGeneralFieldNearestLocationTransfer::checkRestrictionsForSource(), MultiAppPostprocessorToAuxScalarTransfer::checkSiblingsTransferSupported(), MultiAppScalarToAuxScalarTransfer::checkSiblingsTransferSupported(), MultiAppPostprocessorTransfer::checkSiblingsTransferSupported(), MultiAppReporterTransfer::checkSiblingsTransferSupported(), MultiAppMFEMCopyTransfer::checkSiblingsTransferSupported(), MultiAppCopyTransfer::checkSiblingsTransferSupported(), MultiAppTransfer::checkSiblingsTransferSupported(), MFEMSolverBase::checkSpectralEquivalence(), MaterialBase::checkStatefulSanity(), AddDefaultConvergenceAction::checkUnusedMultiAppFixedPointConvergenceParameters(), AddDefaultConvergenceAction::checkUnusedNonlinearConvergenceParameters(), AddDefaultConvergenceAction::checkUnusedSteadyStateConvergenceParameters(), FEProblemBase::checkUserObjects(), Moose::PetscSupport::checkUserProvidedPetscOption(), DomainUserObject::checkVariable(), MultiAppTransfer::checkVariable(), MeshDiagnosticsGenerator::checkWatertightNodesets(), MeshDiagnosticsGenerator::checkWatertightSidesets(), LibmeshPartitioner::clone(), MooseMesh::clone(), CombinerGenerator::CombinerGenerator(), ComparisonPostprocessor::comparisonIsTrue(), MooseVariableFieldBase::componentName(), CompositeFunction::CompositeFunction(), ElementH1ErrorFunctionAux::compute(), NodalPatchRecovery::compute(), FEProblemBase::computeBounds(), VariableCondensationPreconditioner::computeDInverseDiag(), CompositionDT::computeDT(), ArrayDGKernel::computeElemNeighJacobian(), ArrayDGKernel::computeElemNeighResidual(), InternalSideIntegralPostprocessor::computeFaceInfoIntegral(), SideIntegralPostprocessor::computeFaceInfoIntegral(), MooseVariableFieldBase::computeFaceValues(), TimeSequenceStepperBase::computeFailedDT(), IterationAdaptiveDT::computeFailedDT(), TimeStepper::computeFailedDT(), MooseMesh::computeFiniteVolumeCoords(), HistogramVectorPostprocessor::computeHistogram(), ArrayKernel::computeJacobian(), ArrayIntegratedBC::computeJacobian(), FVFluxKernel::computeJacobian(), NodalConstraint::computeJacobian(), FEProblemBase::computeJacobianTags(), LowerDIntegratedBC::computeLowerDOffDiagJacobian(), ArrayLowerDIntegratedBC::computeLowerDOffDiagJacobian(), EigenProblem::computeMatricesTags(), ArrayDGKernel::computeOffDiagElemNeighJacobian(), ArrayKernel::computeOffDiagJacobian(), ArrayIntegratedBC::computeOffDiagJacobian(), FVElementalKernel::computeOffDiagJacobian(), Moose::Kokkos::ResidualObject::computeOffDiagJacobian(), MortarScalarBase::computeOffDiagJacobianScalar(), DGLowerDKernel::computeOffDiagLowerDJacobian(), ArrayDGLowerDKernel::computeOffDiagLowerDJacobian(), MaterialBase::computeProperties(), SideFVFluxBCIntegral::computeQpIntegral(), ScalarKernel::computeQpJacobian(), CoupledTiedValueConstraint::computeQpJacobian(), TiedValueConstraint::computeQpJacobian(), NodalEqualValueConstraint::computeQpJacobian(), LinearNodalConstraint::computeQpJacobian(), EqualValueBoundaryConstraint::computeQpJacobian(), NodeElemConstraint::computeQpJacobian(), CoupledTiedValueConstraint::computeQpOffDiagJacobian(), ScalarKernel::computeQpResidual(), MassMatrix::computeQpResidual(), HDGKernel::computeQpResidual(), DiffusionLHDGDirichletBC::computeQpResidual(), NodalEqualValueConstraint::computeQpResidual(), DiffusionLHDGPrescribedGradientBC::computeQpResidual(), IPHDGBC::computeQpResidual(), KernelValue::computeQpResidual(), TorchScriptMaterial::computeQpValues(), InterfaceQpValueUserObject::computeRealValue(), ArrayKernel::computeResidual(), ArrayIntegratedBC::computeResidual(), FVFluxBC::computeResidual(), FVFluxKernel::computeResidual(), NodalConstraint::computeResidual(), FVFluxKernel::computeResidualAndJacobian(), ResidualObject::computeResidualAndJacobian(), FEProblemBase::computeResidualAndJacobian(), HDGKernel::computeResidualAndJacobianOnSide(), FEProblemBase::computeResidualInternal(), FEProblemBase::computeResidualTag(), FEProblemBase::computeResidualTags(), FEProblemBase::computeResidualType(), KernelScalarBase::computeScalarOffDiagJacobian(), ADKernelScalarBase::computeScalarQpResidual(), ADMortarScalarBase::computeScalarQpResidual(), MortarScalarBase::computeScalarQpResidual(), KernelScalarBase::computeScalarQpResidual(), TimeStepper::computeStep(), ActuallyExplicitEuler::computeTimeDerivatives(), ExplicitEuler::computeTimeDerivatives(), ImplicitEuler::computeTimeDerivatives(), BDF2::computeTimeDerivatives(), NewmarkBeta::computeTimeDerivatives(), CentralDifference::computeTimeDerivatives(), CrankNicolson::computeTimeDerivatives(), LStableDirk2::computeTimeDerivatives(), LStableDirk3::computeTimeDerivatives(), ImplicitMidpoint::computeTimeDerivatives(), ExplicitTVDRK2::computeTimeDerivatives(), AStableDirk4::computeTimeDerivatives(), LStableDirk4::computeTimeDerivatives(), ExplicitRK2::computeTimeDerivatives(), MultiAppGeometricInterpolationTransfer::computeTransformation(), BuildArrayVariableAux::computeValue(), TagVectorArrayVariableAux::computeValue(), NearestNodeValueAux::computeValue(), ProjectionAux::computeValue(), PenetrationAux::computeValue(), ConcentricCircleMesh::ConcentricCircleMesh(), ConditionalEnableControl::ConditionalEnableControl(), ConservativeAdvectionBCTempl< false >::ConservativeAdvectionBCTempl(), TimeStepper::constrainStep(), LibtorchNeuralNetControl::controlNeuralNet(), TransientBase::convergedToSteadyState(), ParsedConvergence::convertRealToBool(), MooseApp::copyInputs(), CopyMeshPartitioner::CopyMeshPartitioner(), CoupledForceNodalKernel::CoupledForceNodalKernel(), MultiApp::createApp(), MooseApp::createExecutors(), AddVariableAction::createInitialConditionAction(), MooseApp::createRMFromTemplateAndInit(), Function::curl(), MooseVariableFV< Real >::curlPhi(), CutMeshByPlaneGenerator::CutMeshByPlaneGenerator(), SidesetInfoVectorPostprocessor::dataHelper(), ReporterTransferInterface::declareClone(), Moose::Kokkos::MaterialBase::declareKokkosPropertyByName(), MeshGenerator::declareMeshProperty(), ReporterTransferInterface::declareVectorClone(), DefaultSteadyStateConvergence::DefaultSteadyStateConvergence(), FunctorRelationshipManager::delete_remote_elements(), MooseMesh::deleteRemoteElements(), BicubicSplineFunction::derivative(), DerivativeSumMaterialTempl< is_ad >::DerivativeSumMaterialTempl(), MooseMesh::detectPairedSidesets(), MooseApp::determineLibtorchDeviceType(), FEProblemBase::determineSolverSystem(), DGKernel::DGKernel(), MeshDiagnosticsGenerator::diagnosticsLog(), DistributedPositions::DistributedPositions(), Function::div(), FunctorBinnedValuesDivision::divisionIndex(), MooseVariableFV< Real >::divPhi(), FunctorRelationshipManager::dofmap_reinit(), EigenProblem::doFreeNonlinearPowerIterations(), FEProblemBase::duplicateVariableCheck(), MooseApp::dynamicAllRegistration(), MooseApp::dynamicAppRegistration(), EigenProblem::EigenProblem(), Eigenvalue::Eigenvalue(), Eigenvalues::Eigenvalues(), ElementalVariableValue::ElementalVariableValue(), ElementGroupCentroidPositions::ElementGroupCentroidPositions(), ElementIntegerAux::ElementIntegerAux(), ElementMaterialSampler::ElementMaterialSampler(), ElementQualityAux::ElementQualityAux(), ElementUOAux::ElementUOAux(), ExtraIDIntegralVectorPostprocessor::elementValue(), DistributedRectilinearMeshGenerator::elemId(), ProjectionAux::elemOnNodeVariableIsDefinedOn(), EigenKernel::enabled(), MooseApp::errorCheck(), 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(), MultiAppScalarToAuxScalarTransfer::execute(), NodalValueSampler::execute(), PositionsFunctorValueSampler::execute(), MultiAppPostprocessorInterpolationTransfer::execute(), ElementQualityChecker::execute(), MultiAppPostprocessorTransfer::execute(), GreaterThanLessThanPostprocessor::execute(), PointValue::execute(), MultiAppVariableValueSampleTransfer::execute(), MultiAppVariableValueSamplePostprocessorTransfer::execute(), FindValueOnLine::execute(), MultiAppNearestNodeTransfer::execute(), MultiAppMFEMCopyTransfer::execute(), MultiAppCopyTransfer::execute(), MultiAppGeometricInterpolationTransfer::execute(), MultiAppUserObjectTransfer::execute(), InterfaceQpUserObjectBase::execute(), WebServerControl::execute(), TransientBase::execute(), LeastSquaresFit::execute(), LeastSquaresFitHistory::execute(), VectorPostprocessorComparison::execute(), Eigenvalue::execute(), TimeExtremeValue::execute(), DomainUserObject::execute(), FEProblemBase::execute(), FEProblemBase::executeControls(), MooseApp::executeExecutioner(), 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(), VerifyNodalUniqueID::finalize(), VerifyElementUniqueID::finalize(), ParsedVectorReporter::finalize(), ParsedVectorVectorRealReductionReporter::finalize(), DiscreteElementUserObject::finalize(), ElementQualityChecker::finalize(), MemoryUsage::finalize(), PointSamplerBase::finalize(), DiscreteVariableResidualNorm::finalize(), NearestPointAverage::finalize(), NearestPointIntegralVariablePostprocessor::finalize(), MooseApp::finalizeRestore(), 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(), ElementSubdomainModifierBase::gatherPatchElements(), Boundary2DDelaunayGenerator::General2DDelaunay(), ElementOrderConversionGenerator::generate(), PlaneIDMeshGenerator::generate(), RenameBlockGenerator::generate(), RenameBoundaryGenerator::generate(), SideSetsFromNormalsGenerator::generate(), SmoothMeshGenerator::generate(), SubdomainPerElementGenerator::generate(), TiledMeshGenerator::generate(), ExtraNodesetGenerator::generate(), FileMeshGenerator::generate(), LowerDBlockFromSidesetGenerator::generate(), MoveNodeGenerator::generate(), SideSetsFromPointsGenerator::generate(), StitchMeshGenerator::generate(), MeshDiagnosticsGenerator::generate(), Boundary2DDelaunayGenerator::generate(), BreakMeshByBlockGenerator::generate(), CoarsenBlockGenerator::generate(), FlipSidesetGenerator::generate(), GeneratedMeshGenerator::generate(), MeshRepairGenerator::generate(), ParsedGenerateNodeset::generate(), SideSetsFromBoundingBoxGenerator::generate(), StackGenerator::generate(), XYZDelaunayGenerator::generate(), CombinerGenerator::generate(), AllSideSetsByNormalsGenerator::generate(), AdvancedExtruderGenerator::generate(), MeshCollectionGenerator::generate(), MeshExtruderGenerator::generate(), SpiralAnnularMeshGenerator::generate(), XYDelaunayGenerator::generate(), XYMeshLineCutter::generate(), CutMeshByLevelSetGeneratorBase::generate(), PatternedMeshGenerator::generate(), SubdomainBoundingBoxGenerator::generate(), DistributedRectilinearMeshGenerator::generate(), BoundingBoxNodeSetGenerator::generate(), MeshGenerator::generateCSG(), MeshGenerator::generateData(), GeneratedMesh::GeneratedMesh(), GeneratedMeshGenerator::GeneratedMeshGenerator(), MeshGenerator::generateInternal(), MeshGenerator::generateInternalCSG(), 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(), NEML2BatchIndexGenerator::getBatchIndex(), MooseMesh::getBlockConnectedBlocks(), VariableOldValueBounds::getBound(), MooseMesh::getBoundaryID(), MultiApp::getBoundingBox(), ChainControl::getChainControlDataByName(), MooseMesh::getCoarseningMap(), NodalPatchRecoveryBase::getCoefficients(), MultiApp::getCommandLineArgs(), MooseVariableBase::getContinuity(), Control::getControllableParameterByName(), FEProblemBase::getConvergence(), MooseMesh::getCoordSystem(), PhysicsBase::getCoupledPhysics(), MeshGenerator::getCSGBaseByName(), 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(), MooseApp::getExecutor(), 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(), FEProblemBase::getMaterialPropertyStorageConsumers(), SubProblem::getMatrixTagID(), GeneratedMesh::getMaxInDimension(), AnnularMesh::getMaxInDimension(), FEProblemBase::getMaxQps(), FEProblemBase::getMeshDivision(), MeshGenerator::getMeshGeneratorNameFromParam(), MeshGenerator::getMeshGeneratorNamesFromParam(), AnnularMesh::getMinInDimension(), GeneratedMesh::getMinInDimension(), MultiAppTransfer::getMultiApp(), FEProblemBase::getMultiAppFixedPointConvergenceName(), DistributedRectilinearMeshGenerator::getNeighbors(), Times::getNextTime(), MooseMesh::getNodeBlockIds(), PropertyReadFile::getNodeData(), MooseMesh::getNodeList(), FEProblemBase::getNonlinearConvergenceNames(), EigenProblem::getNonlinearEigenSystem(), FEProblemBase::getNonlinearSystem(), NEML2ModelExecutor::getOutput(), NEML2ModelExecutor::getOutputDerivative(), NEML2ModelExecutor::getOutputParameterDerivative(), MooseMesh::getPairedBoundaryMapping(), MaterialOutputAction::getParams(), ImageMeshGenerator::GetPixelInfo(), ImageMesh::GetPixelInfo(), PlaneIDMeshGenerator::getPlaneID(), Positions::getPosition(), Positions::getPositions(), FEProblemBase::getPositionsObject(), Positions::getPositionsVector2D(), Positions::getPositionsVector3D(), Positions::getPositionsVector4D(), PostprocessorInterface::getPostprocessorValueByNameInternal(), Times::getPreviousTime(), ComponentMaterialPropertyInterface::getPropertyValue(), InterfaceQpUserObjectBase::getQpValue(), MooseMesh::getRefinementMap(), MooseBase::getRenamedParam(), ReporterInterface::getReporterContextBaseByName(), ReporterInterface::getReporterName(), Reporter::getReporterValueName(), MooseApp::getRestartableDataMap(), MooseApp::getRestartableDataMapName(), MooseApp::getRestartableMetaData(), MooseApp::getRMClone(), FEProblemBase::getSampler(), WebServerControl::getScalarJSONValue(), DisplacedProblem::getScalarVariable(), FEProblemBase::getScalarVariable(), MooseObject::getSharedPtr(), InterfaceQpUserObjectBase::getSideAverageValue(), PhysicsBase::getSolverSystem(), DisplacedProblem::getStandardVariable(), FEProblemBase::getStandardVariable(), FEProblemBase::getSteadyStateConvergenceName(), MooseMesh::getSubdomainBoundaryIds(), TimedSubdomainModifier::getSubdomainIDAndCheck(), DisplacedProblem::getSystem(), FEProblemBase::getSystem(), FEProblemBase::getSystemBase(), Times::getTimeAtIndex(), FEProblemBase::getTimeFromStateArg(), TransientBase::getTimeIntegratorNames(), Times::getTimes(), MultiAppTransfer::getToMultiApp(), MultiAppTransfer::getToMultiAppInfo(), MooseMesh::getUniqueCoordSystem(), FEProblemBase::getUserObject(), FEProblemBase::getUserObjectBase(), UserObjectInterface::getUserObjectBaseByName(), UserObjectInterface::getUserObjectName(), VectorPostprocessorComponent::getValue(), NumRelationshipManagers::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(), DistributedPositions::initialize(), ReporterPositions::initialize(), TransformedPositions::initialize(), ElementGroupCentroidPositions::initialize(), FunctorPositions::initialize(), ReporterTimes::initialize(), FunctorTimes::initialize(), ParsedDownSelectionPositions::initialize(), ParsedConvergence::initializeConstantSymbol(), PhysicsBase::initializePhysics(), SteffensenSolve::initialSetup(), MultiAppCloneReporterTransfer::initialSetup(), SolutionIC::initialSetup(), ChainControlDataPostprocessor::initialSetup(), MultiAppConservativeTransfer::initialSetup(), PiecewiseLinearBase::initialSetup(), IntegralPreservingFunctionIC::initialSetup(), FullSolveMultiApp::initialSetup(), PiecewiseLinear::initialSetup(), MultiAppGeneralFieldNearestLocationTransfer::initialSetup(), CoarsenedPiecewiseLinear::initialSetup(), SolutionScalarAux::initialSetup(), LinearFVDiffusion::initialSetup(), LinearFVAdvection::initialSetup(), LinearFVAnisotropicDiffusion::initialSetup(), MultiAppDofCopyTransfer::initialSetup(), SolutionAux::initialSetup(), ExplicitTimeIntegrator::initialSetup(), ReferenceResidualConvergence::initialSetup(), NodalVariableValue::initialSetup(), Axisymmetric2D3DSolutionFunction::initialSetup(), ElementSubdomainModifierBase::initialSetup(), Exodus::initialSetup(), CSV::initialSetup(), MooseParsedFunction::initialSetup(), SolutionUserObjectBase::initialSetup(), FEProblemBase::initialSetup(), SubProblem::initialSetup(), AdvancedOutput::initOutputList(), 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(), MooseApp::libNameToAppName(), LibtorchNeuralNetControl::LibtorchNeuralNetControl(), LinearCombinationPostprocessor::LinearCombinationPostprocessor(), LinearNodalConstraint::LinearNodalConstraint(), LineMaterialSamplerBase< Real >::LineMaterialSamplerBase(), LineSearch::lineSearch(), LineValueSampler::LineValueSampler(), MooseApp::loadLibraryAndDependencies(), 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(), FEProblemBase::needsPreviousNewtonIteration(), NewmarkBeta::NewmarkBeta(), NodalConstraint::NodalConstraint(), MooseVariableFV< Real >::nodalDofIndex(), MooseVariableFV< Real >::nodalDofIndexNeighbor(), MooseLinearVariableFV< Real >::nodalError(), MooseVariableFV< Real >::nodalMatrixTagValue(), 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(), MooseApp::outputMachineReadableData(), 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(), LStableDirk4::postResidual(), AStableDirk4::postResidual(), ExplicitRK2::postResidual(), EigenProblem::postScaleEigenVector(), VariableCondensationPreconditioner::preallocateCondensedJacobian(), ADKernelValueTempl< T >::precomputeQpJacobian(), FunctorKernel::precomputeQpResidual(), Predictor::Predictor(), TransientBase::preExecute(), MooseMesh::prepare(), MooseMesh::prepared(), ElementSubdomainModifierBase::prepareVariableForReinitialization(), FixedPointSolve::printFixedPointConvergenceReason(), PseudoTimestep::PseudoTimestep(), MultiApp::readCommandLineArguments(), PropertyReadFile::readData(), SolutionUserObjectBase::readExodusII(), SolutionUserObjectBase::readXda(), CoarsenBlockGenerator::recursiveCoarsen(), MooseApp::recursivelyCreateExecutors(), FunctorRelationshipManager::redistribute(), ReferenceResidualConvergence::ReferenceResidualConvergence(), MooseApp::registerRestartableData(), MooseApp::registerRestartableNameWithFilter(), Sampler::reinit(), RelativeSolutionDifferenceNorm::RelativeSolutionDifferenceNorm(), MFEMTransient::relativeSolutionDifferenceNorm(), MooseApp::removeRelationshipManager(), PhysicsBase::reportPotentiallyMissedParameters(), MooseApp::restore(), RinglebMesh::RinglebMesh(), RinglebMeshGenerator::RinglebMeshGenerator(), MooseApp::run(), MooseApp::runInputs(), 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(), MooseApp::setMFEMDevice(), FVPointValueConstraint::setMyElem(), FEProblemBase::setNonlocalCouplingMatrix(), Sampler::setNumberOfCols(), Sampler::setNumberOfRandomSeeds(), Sampler::setNumberOfRows(), Exodus::setOutputDimensionInExodusWriter(), AddPeriodicBCAction::setPeriodicVars(), MFEMSolverBase::setPreconditioner(), MultiAppGeneralFieldTransfer::setSolutionVectorValues(), Split::setup(), TransientMultiApp::setupApp(), SetupMeshAction::setupMesh(), MooseApp::setupOptions(), 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(), MooseVariableBase::sizeMatrixTagData(), SolutionTimeAdaptiveDT::SolutionTimeAdaptiveDT(), SolutionUserObjectBase::SolutionUserObjectBase(), ExplicitTVDRK2::solve(), ExplicitRK2::solve(), TimeIntegrator::solve(), FEProblemBase::solverSysNum(), FullSolveMultiApp::solveStep(), SpatialAverageBase::SpatialAverageBase(), UserObject::spatialPoints(), NearestPointIntegralVariablePostprocessor::spatialValue(), NearestPointAverage::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(), WebServerControl::toMiniJson(), MultiAppDofCopyTransfer::transfer(), MultiAppMFEMCopyTransfer::transfer(), MultiAppShapeEvaluationTransfer::transferVariable(), TransformedPositions::TransformedPositions(), FEProblemBase::trustUserCouplingMatrix(), MooseVariableScalar::uDot(), MooseVariableScalar::uDotDot(), MooseVariableScalar::uDotDotOld(), FEProblemBase::uDotDotOldRequested(), MooseVariableScalar::uDotOld(), FEProblemBase::uDotOldRequested(), MooseBase::uniqueName(), Positions::unrollMultiDPositions(), ScalarKernelBase::uOld(), AuxScalarKernel::uOld(), Checkpoint::updateCheckpointFiles(), EqualValueBoundaryConstraint::updateConstrainedNodes(), SolutionUserObjectBase::updateExodusBracketingTimeIndices(), FEProblemBase::updateMaxQps(), MFEMHypreAMS::updateSolver(), MFEMHypreADS::updateSolver(), MFEMGMRESSolver::updateSolver(), MFEMCGSolver::updateSolver(), MFEMHypreFGMRES::updateSolver(), MFEMHyprePCG::updateSolver(), MFEMHypreGMRES::updateSolver(), MFEMSuperLU::updateSolver(), UpperBoundNodalKernel::UpperBoundNodalKernel(), NearestPointIntegralVariablePostprocessor::userObjectValue(), NearestPointAverage::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(), MooseApp::writeRestartableMetaData(), DOFMapOutput::writeStreamToFile(), and Console::writeStreamToFile().
| 
 | inlineinherited | 
Emits an error without the prefixing included in mooseError().
Definition at line 290 of file MooseBase.h.
| 
 | inlineinherited | 
Definition at line 321 of file MooseBase.h.
Referenced by SetupRecoverFileBaseAction::act(), AStableDirk4::AStableDirk4(), MeshDiagnosticsGenerator::checkNonConformalMeshFromAdaptivity(), MultiAppGeneralFieldNearestLocationTransfer::evaluateInterpValuesNearestNode(), PIDTransientControl::execute(), Executioner::Executioner(), ExplicitRK2::ExplicitRK2(), ExplicitTVDRK2::ExplicitTVDRK2(), DataFileInterface::getDataFilePath(), 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(), MooseBase::paramInfo(), ProjectionAux::ProjectionAux(), ReferenceResidualConvergence::ReferenceResidualConvergence(), MFEMDataCollection::registerFields(), FEProblemBase::setRestartFile(), MooseApp::setupOptions(), SolutionUserObjectBase::SolutionUserObjectBase(), SymmetryTransformGenerator::SymmetryTransformGenerator(), TransientBase::takeStep(), and TransientBase::TransientBase().
| 
 | inlineinherited | 
Definition at line 73 of file SolutionInvalidInterface.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(), StitchMeshGenerator::generate(), ParsedGenerateSideset::generate(), MultiAppTransfer::getAppInfo(), FunctorBinnedValuesDivision::getBinIndex(), MFEMVectorFESpace::getFECName(), PointSamplerBase::getLocalElemContainingPoint(), FEProblemBase::getMaterial(), LineValueSampler::getValue(), Terminator::handleMessage(), IndicatorMarker::IndicatorMarker(), SphericalGridDivision::initialize(), CylindricalGridDivision::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(), MaterialOutputAction::outputHelper(), 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 prefixed with object name and type.
Definition at line 299 of file MooseBase.h.
Referenced by DataFileInterface::getDataFilePath(), MooseApp::loadLibraryAndDependencies(), and MooseBase::paramWarning().
| 
 | inlineinherited | 
Definition at line 80 of file SolutionInvalidInterface.h.
| 
 | inlineinherited | 
Emits a warning without the prefixing included in mooseWarning().
Definition at line 308 of file MooseBase.h.
| 
 | inlinevirtualinherited | 
Reimplemented in MFEMMesh.
Definition at line 321 of file MooseMesh.h.
| 
 | inlinevirtualinherited | 
Reimplemented in MFEMMesh.
Definition at line 322 of file MooseMesh.h.
| 
 | inlineinherited | 
Get the name of the class.
Definition at line 103 of file MooseBase.h.
Referenced by AddElementalFieldAction::act(), CopyNodalVarsAction::act(), AdaptivityAction::act(), AddTimeStepperAction::act(), CSGOnlyAction::act(), DeprecatedBlockAction::act(), SetupTimeIntegratorAction::act(), AddActionComponentAction::act(), SetupResidualDebugAction::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(), DiffusionLHDGKernel::additionalROVariables(), IPHDGAssemblyHelper::additionalROVariables(), 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(), InitialConditionWarehouse::addObject(), FEProblemBase::addObject(), ComponentPhysicsInterface::addPhysics(), SubProblem::addPiecewiseByBlockLambdaFunctor(), MFEMProblem::addPostprocessor(), FEProblemBase::addPostprocessor(), InitialConditionBase::addPostprocessorDependencyHelper(), AuxKernelBase::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(), AuxKernelBase::addUserObjectDependencyHelper(), UserObject::addUserObjectDependencyHelper(), DisplacedProblem::addVariable(), FEProblemBase::addVectorPostprocessor(), AuxKernelBase::addVectorPostprocessorDependencyHelper(), UserObject::addVectorPostprocessorDependencyHelper(), MooseLinearVariableFV< Real >::adError(), Output::advancedExecuteOn(), AdvancedExtruderGenerator::AdvancedExtruderGenerator(), MooseVariableBase::allDofIndices(), MooseApp::appBinaryName(), MooseApp::appendMeshGenerator(), Registry::appNameFromAppPath(), MultiApp::appPostprocessorValue(), MultiApp::appProblem(), MultiApp::appProblemBase(), MultiApp::appUserObjectBase(), ArrayDGKernel::ArrayDGKernel(), ArrayParsedAux::ArrayParsedAux(), PhysicsBase::assignBlocks(), AStableDirk4::AStableDirk4(), AuxKernelBase::AuxKernelBase(), Function::average(), MultiApp::backup(), Boundary2DDelaunayGenerator::Boundary2DDelaunayGenerator(), CoarsenedPiecewiseLinear::buildCoarsenedGrid(), MFEMFESpace::buildFEC(), PiecewiseTabularBase::buildFromFile(), MultiAppVariableValueSamplePostprocessorTransfer::cacheElemToPostprocessorData(), MooseBase::callMooseError(), ChangeOverFixedPointPostprocessor::ChangeOverFixedPointPostprocessor(), ChangeOverTimePostprocessor::ChangeOverTimePostprocessor(), PhysicsBase::checkBlockRestrictionIdentical(), PhysicsBase::checkComponentType(), ParsedConvergence::checkConvergence(), DefaultNonlinearConvergence::checkConvergence(), FEProblemBase::checkDependMaterialsHelper(), SamplerBase::checkForStandardFieldVariableType(), ReporterTransferInterface::checkHasReporterValue(), FEProblemBase::checkICRestartError(), Moose::Kokkos::Material::checkMaterialProperty(), Material::checkMaterialProperty(), MooseApp::checkMetaDataIntegrity(), Damper::checkMinDamping(), MultiAppTransfer::checkParentAppUserObjectExecuteOn(), Checkpoint::checkpointInfo(), DomainUserObject::checkVariable(), BlockRestrictable::checkVariable(), Coupleable::checkWritableVar(), MooseVariableFieldBase::componentName(), CompositeFunction::CompositeFunction(), MaterialBase::computeProperties(), FEProblemBase::computeUserObjectByName(), VectorPostprocessorVisualizationAux::computeValue(), MooseBase::connectControllableParams(), ConstantPostprocessor::ConstantPostprocessor(), Coupleable::coupledName(), CommonOutputAction::create(), MultiApp::createApp(), MooseApp::createExecutors(), MeshGeneratorSystem::createMeshGeneratorOrder(), MooseApp::createRecoverablePerfGraph(), CutMeshByPlaneGenerator::CutMeshByPlaneGenerator(), DebugResidualAux::DebugResidualAux(), 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(), SolutionUserObjectBase::evalMeshFunction(), SolutionUserObjectBase::evalMeshFunctionGradient(), SolutionUserObjectBase::evalMultiValuedMeshFunction(), SolutionUserObjectBase::evalMultiValuedMeshFunctionGradient(), SideValueSampler::execute(), RestartableDataReporter::execute(), GreaterThanLessThanPostprocessor::execute(), PointValue::execute(), MultiAppNearestNodeTransfer::execute(), MultiAppProjectionTransfer::execute(), MultiAppUserObjectTransfer::execute(), WebServerControl::execute(), MultiAppGeneralFieldTransfer::execute(), ActionWarehouse::executeActionsWithAction(), Exodus::Exodus(), ExtraIDIntegralVectorPostprocessor::ExtraIDIntegralVectorPostprocessor(), FEProblemBase::FEProblemBase(), MultiApp::fillPositions(), MultiAppGeometricInterpolationTransfer::fillSourceInterpolationPoints(), PointSamplerBase::finalize(), ChainControl::fullControlDataName(), FunctionArrayAux::FunctionArrayAux(), FunctionDT::FunctionDT(), FunctionIC::functionName(), FVFunctionIC::functionName(), FunctorPositions::FunctorPositions(), FunctorSmootherTempl< T >::FunctorSmootherTempl(), FVInitialConditionTempl< T >::FVInitialConditionTempl(), FVOneVarDiffusionInterface::FVOneVarDiffusionInterface(), GapValueAux::GapValueAux(), MooseServer::gatherDocumentSymbols(), BoundaryDeletionGenerator::generate(), UniqueExtraIDMeshGenerator::generate(), RenameBlockGenerator::generate(), RenameBoundaryGenerator::generate(), BreakMeshByBlockGenerator::generate(), GeneratedMeshGenerator::generate(), ParsedSubdomainGeneratorBase::generate(), SideSetsFromNodeSetsGenerator::generate(), StitchBoundaryMeshGenerator::generate(), StitchMeshGenerator::generate(), ParsedExtraElementIDGenerator::generate(), XYDelaunayGenerator::generate(), SubdomainBoundingBoxGenerator::generate(), MeshGenerator::generateInternal(), MeshGenerator::generateInternalCSG(), InterfaceMaterial::getADMaterialProperty(), Material::getADMaterialProperty(), MultiAppTransfer::getAppInfo(), MultiApp::getBoundingBox(), MooseBase::getCheckedPointerParam(), MooseApp::getCheckpointDirectories(), Control::getControllableParameterByName(), Control::getControllableValue(), Control::getControllableValueByName(), FEProblemBase::getConvergence(), MeshGenerator::getCSGBase(), MeshGenerator::getCSGBasesByName(), 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(), AuxKernelTempl< Real >::getGenericMaterialProperty(), Material::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(), AuxKernelTempl< Real >::getMaterialProperty(), Material::getMaterialProperty(), SubProblem::getMaterialPropertyBlockNames(), SubProblem::getMaterialPropertyBoundaryNames(), NodalPatchRecovery::getMaterialPropertyOld(), AuxKernelTempl< Real >::getMaterialPropertyOld(), InterfaceMaterial::getMaterialPropertyOld(), Material::getMaterialPropertyOld(), NodalPatchRecovery::getMaterialPropertyOlder(), AuxKernelTempl< Real >::getMaterialPropertyOlder(), InterfaceMaterial::getMaterialPropertyOlder(), Material::getMaterialPropertyOlder(), MFEMGeneralUserObject::getMatrixCoefficient(), MFEMGeneralUserObject::getMatrixCoefficientByName(), MeshGenerator::getMesh(), FEProblemBase::getMeshDivision(), MeshGenerator::getMeshesByName(), MooseApp::getMeshGenerator(), MeshGenerator::getMeshGeneratorNameFromParam(), MeshGenerator::getMeshGeneratorNamesFromParam(), ActionWarehouse::getMooseAppName(), MultiAppTransfer::getMultiApp(), InterfaceMaterial::getNeighborADMaterialProperty(), InterfaceMaterial::getNeighborMaterialProperty(), InterfaceMaterial::getNeighborMaterialPropertyOld(), InterfaceMaterial::getNeighborMaterialPropertyOlder(), MooseServer::getObjectParameters(), Material::getOptionalADMaterialProperty(), Material::getOptionalMaterialProperty(), Material::getOptionalMaterialPropertyOld(), Material::getOptionalMaterialPropertyOlder(), OutputWarehouse::getOutput(), MooseBase::getParam(), FEProblemBase::getPositionsObject(), FEProblemBase::getPostprocessorValueByName(), ComponentMaterialPropertyInterface::getPropertyValue(), ReporterData::getReporterInfo(), MooseApp::getRestartableDataMap(), MooseApp::getRestartableDataMapName(), MooseApp::getRestartableMetaData(), FEProblemBase::getSampler(), MFEMGeneralUserObject::getScalarCoefficient(), MFEMGeneralUserObject::getScalarCoefficientByName(), TimedSubdomainModifier::getSubdomainIDAndCheck(), TransientBase::getTimeStepperName(), ProjectedStatefulMaterialStorageAction::getTypeEnum(), FEProblemBase::getUserObject(), FEProblemBase::getUserObjectBase(), MFEMGeneralUserObject::getVectorCoefficient(), MFEMGeneralUserObject::getVectorCoefficientByName(), Terminator::handleMessage(), Control::hasControllableParameterByName(), FEProblemBase::hasConvergence(), FEProblemBase::hasFunction(), SubProblem::hasFunctor(), SubProblem::hasFunctorWithType(), MooseApp::hasMeshGenerator(), AdvancedOutput::hasOutputHelper(), FEProblemBase::hasPostprocessor(), FEProblemBase::hasPostprocessorValueByName(), MooseApp::hasRelationshipManager(), MooseApp::hasRestartableDataMap(), MooseApp::hasRestartableMetaData(), FEProblemBase::hasUserObject(), IterationAdaptiveDT::init(), AddVariableAction::init(), AdvancedOutput::init(), AdvancedOutput::initExecutionTypes(), AttribName::initFrom(), NestedDivision::initialize(), TransformedPositions::initialize(), BoundaryRestrictable::initializeBoundaryRestrictable(), 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(), MultiAppGeometricInterpolationTransfer::interpolateTargetPoints(), MeshGenerator::isChildMeshGenerator(), DerivativeMaterialInterface< MortarScalarBase >::isNotObjectVariable(), MeshGenerator::isNullMeshName(), MooseBase::isParamSetByUser(), MooseBase::isParamValid(), MeshGenerator::isParentMeshGenerator(), LinearCombinationFunction::LinearCombinationFunction(), FEProblemBase::logAdd(), MooseLinearVariableFV< Real >::lowerDError(), Marker::Marker(), MaterialBase::markMatPropRequested(), MatDiffusionBase< Real >::MatDiffusionBase(), Material::Material(), MaterialDerivativeTestKernelBase< Real >::MaterialDerivativeTestKernelBase(), Distribution::median(), MemoryUsageReporter::MemoryUsageReporter(), MeshGenerator::meshPropertyPrefix(), MooseBase::messagePrefix(), OutputWarehouse::mooseConsole(), SolutionInvalidInterface::mooseDeprecated(), MooseVariableBase::MooseVariableBase(), MooseVariableInterface< Real >::MooseVariableInterface(), SolutionInvalidInterface::mooseWarning(), SolutionInvalidInterface::mooseWarningNonPrefixed(), MultiAppGeneralFieldTransfer::MultiAppGeneralFieldTransfer(), MultiAppUserObjectTransfer::MultiAppUserObjectTransfer(), MooseLinearVariableFV< Real >::nodalError(), 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(), SolutionInvalidInterface::paramWarning(), ParsedCurveGenerator::ParsedCurveGenerator(), ParsedODEKernel::ParsedODEKernel(), ComponentPhysicsInterface::physicsExists(), PiecewiseBilinear::PiecewiseBilinear(), PiecewiseByBlockFunctorMaterialTempl< T >::PiecewiseByBlockFunctorMaterialTempl(), MooseApp::possiblyLoadRestartableMetaData(), PhysicsBase::prefix(), MooseMesh::prepare(), BlockRestrictionDebugOutput::printBlockRestrictionMap(), PerfGraphLivePrint::printStats(), FEProblemBase::projectInitialConditionOnCustomRange(), MooseBase::queryParam(), MultiApp::readCommandLineArguments(), Receiver::Receiver(), Executor::Result::record(), AppFactory::reg(), Registry::registerObjectsTo(), FEProblemBase::registerRandomInterface(), MooseApp::registerRestartableDataMapName(), MooseApp::registerRestartableNameWithFilter(), MaterialBase::resetQpProperties(), MultiApp::restore(), ScalarComponentIC::ScalarComponentIC(), MultiApp::setAppOutputFileBase(), FEProblemBase::setAuxKernelParamsAndLog(), MooseMesh::setBoundaryName(), Control::setControllableValue(), Control::setControllableValueByName(), OutputWarehouse::setFileNumbers(), FEProblemBase::setPostprocessorValueByName(), FEProblemBase::setResidualObjectParamsAndLog(), MooseMesh::setSubdomainName(), NodeSetsGeneratorBase::setup(), Split::setup(), SideSetsGeneratorBase::setup(), TransientMultiApp::setupApp(), 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(), ConstraintWarehouse::subdomainsCovered(), MaterialBase::subdomainSetup(), TaggingInterface::TaggingInterface(), MooseLinearVariableFV< Real >::timeIntegratorError(), VectorPostprocessorVisualizationAux::timestepSetup(), ElementSubdomainModifierBase::timestepSetup(), to_json(), MultiAppDofCopyTransfer::transfer(), MultiAppShapeEvaluationTransfer::transferVariable(), TransientMultiApp::TransientMultiApp(), MooseServer::traverseParseTreeAndFillSymbols(), MooseBase::typeAndName(), MooseBase::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().
| 
 | inlineinherited | 
Whether or not we want to ghost ghosted boundaries.
Definition at line 612 of file MooseMesh.h.
Referenced by DistributedRectilinearMeshGenerator::generate().
| 
 | inherited | 
If this method is called, we will call libMesh's prepare_for_use method when we call Moose's prepare method.
This should only be set when the mesh structure is changed by MeshGenerators (i.e. Element deletion).
Definition at line 3186 of file MooseMesh.C.
| 
 | inlineinherited | 
Set whether we need to delete remote elements.
Definition at line 1082 of file MooseMesh.h.
| 
 | inlineinherited | 
Whether we need to delete remote elements.
Definition at line 1087 of file MooseMesh.h.
| 
 | virtualinherited | 
Definition at line 3102 of file MooseMesh.C.
Referenced by PropertyReadFile::getElementData(), and PropertyReadFile::readData().
| 
 | inlineinherited | 
accessors for the FaceInfo objects
Definition at line 1165 of file MooseMesh.h.
| 
 | inlinevirtualinherited | 
Definition at line 320 of file MooseMesh.h.
| 
 | virtualinherited | 
Calls n_nodes/elem() on the underlying libMesh mesh object.
Definition at line 3096 of file MooseMesh.C.
Referenced by PropertyReadFile::getNodeData(), and PropertyReadFile::readData().
| 
 | virtualinherited | 
Various accessors (pointers/references) for Node "i".
If the requested node is a remote node on a distributed mesh, only the query accessors are valid to call, and they return NULL.
Definition at line 835 of file MooseMesh.C.
Referenced by MooseMesh::addUniqueNode(), GeneratedMesh::buildMesh(), MooseMesh::buildPeriodicNodeMap(), MooseMesh::cacheInfo(), MooseMesh::detectOrthogonalDimRanges(), MooseMesh::getNodeBlockIds(), MooseMesh::isSemiLocal(), and MooseMesh::updateActiveSemiLocalNodeRange().
| 
 | virtualinherited | 
Definition at line 842 of file MooseMesh.C.
| 
 | virtualinherited | 
Definition at line 863 of file MooseMesh.C.
Referenced by ElementSubdomainModifierBase::reinitializedNodeRange().
| 
 | virtualinherited | 
Definition at line 869 of file MooseMesh.C.
| 
 | virtualinherited | 
Definition at line 849 of file MooseMesh.C.
Referenced by NonlinearSystemBase::constraintJacobians(), NonlinearSystemBase::constraintResiduals(), NearestNodeLocator::findNodes(), NonlinearSystemBase::getNodeDofs(), NodePositions::initialize(), MooseMesh::node(), MooseMesh::nodePtr(), MooseMesh::nodeRef(), ResetDisplacedMeshThread::onNode(), DisplacedProblem::UpdateDisplacedMeshThread::onNode(), NearestNodeThread::operator()(), SecondaryNeighborhoodThread::operator()(), PenetrationThread::operator()(), NonlinearSystemBase::overwriteNodeFace(), FEProblemBase::reinitNode(), FEProblemBase::reinitNodeFace(), NonlinearSystemBase::setConstraintSecondaryValues(), EqualValueBoundaryConstraint::updateConstrainedNodes(), and NearestNodeLocator::updatePatch().
| 
 | virtualinherited | 
Definition at line 857 of file MooseMesh.C.
| 
 | inlineinherited | 
Definition at line 2220 of file MooseMesh.h.
| 
 | inherited | 
If not already created, creates a map from every node to all active semilocal elements to which they are connected.
Semilocal elements include local elements and elements that share at least one node with a local element.
Definition at line 1244 of file MooseMesh.C.
Referenced by FEProblemBase::initialSetup().
| 
 | inherited | 
If not already created, creates a map from every node to all elements to which they are connected.
Definition at line 1216 of file MooseMesh.C.
Referenced by NodalPatchRecovery::compute(), NodalPatchRecoveryAuxBase::computeValue(), ProjectionAux::computeValue(), PenetrationLocator::detectPenetration(), DMMooseGetEmbedding_Private(), ProjectionAux::elemOnNodeVariableIsDefinedOn(), NonlinearSystemBase::findImplicitGeometricCouplingEntries(), NearestNodeLocator::findNodes(), ElementSubdomainModifierBase::findReinitializedElemsAndNodes(), ElementSubdomainModifierBase::gatherPatchElements(), NodePositions::initialize(), ActivateElementsUserObjectBase::isNewlyActivated(), LinearNodalConstraint::LinearNodalConstraint(), ElementSubdomainModifierBase::nodeIsNewlyReinitialized(), GhostHigherDLowerDPointNeighbors::operator()(), EqualValueBoundaryConstraint::updateConstrainedNodes(), RandomData::updateGenerators(), and NearestNodeLocator::updatePatch().
| 
 | inlinevirtualinherited | 
Definition at line 324 of file MooseMesh.h.
| 
 | inlinevirtualinherited | 
Reimplemented in MFEMMesh.
Definition at line 323 of file MooseMesh.h.
| 
 | virtualinherited | 
Declares a callback function that is executed at the conclusion of meshChanged().
Ther user can implement actions required after changing the mesh here.
Definition at line 923 of file MooseMesh.C.
Referenced by MooseMesh::meshChanged().
| 
 | inherited | 
Definition at line 3460 of file MooseMesh.C.
| 
 | inherited | 
Implicit conversion operator from MooseMesh -> libMesh::MeshBase.
Definition at line 3458 of file MooseMesh.C.
| 
 | inherited | 
Iterators to owned faceInfo objects.
These faceInfo-s are required for the face loops and to filter out the faceInfo-s that are not owned by this processor in case we have a distributed mesh and we included FaceInfo objects that are on processor boundaries
Definition at line 1566 of file MooseMesh.C.
Referenced by LinearSystem::computeGradients(), LinearSystem::computeLinearSystemInternal(), and FEProblemBase::projectSolution().
| 
 | inherited | 
Definition at line 1574 of file MooseMesh.C.
Referenced by LinearSystem::computeGradients(), LinearSystem::computeLinearSystemInternal(), and FEProblemBase::projectSolution().
| 
 | inherited | 
Iterators to owned faceInfo objects.
These faceInfo-s are required for the face loops and to filter out the faceInfo-s that are not owned by this processor in case we have a distributed mesh and we included FaceInfo objects that are on processor boundaries
Definition at line 1548 of file MooseMesh.C.
Referenced by LinearSystem::computeGradients(), NonlinearSystemBase::computeJacobianInternal(), LinearSystem::computeLinearSystemInternal(), NonlinearSystemBase::computeResidualAndJacobianInternal(), and NonlinearSystemBase::computeResidualInternal().
| 
 | inherited | 
Definition at line 1557 of file MooseMesh.C.
Referenced by LinearSystem::computeGradients(), NonlinearSystemBase::computeJacobianInternal(), LinearSystem::computeLinearSystemInternal(), NonlinearSystemBase::computeResidualAndJacobianInternal(), and NonlinearSystemBase::computeResidualInternal().
| 
 | 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 439 of file MooseBase.h.
Referenced by HierarchicalGridPartitioner::_do_partition(), AutoCheckpointAction::act(), SetupDebugAction::act(), AddPeriodicBCAction::act(), CommonOutputAction::act(), 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(), AuxKernelBase::AuxKernelBase(), 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(), ConservativeAdvectionBCTempl< false >::ConservativeAdvectionBCTempl(), 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(), DebugResidualAux::DebugResidualAux(), ConstantReporter::declareConstantReporterValue(), ConstantReporter::declareConstantReporterValues(), AccumulateReporter::declareLateValues(), DefaultMultiAppFixedPointConvergence::DefaultMultiAppFixedPointConvergence(), DGKernel::DGKernel(), DGKernelBase::DGKernelBase(), DGLowerDKernel::DGLowerDKernel(), DiffusionFluxAux::DiffusionFluxAux(), DomainUserObject::DomainUserObject(), EigenProblem::EigenProblem(), Eigenvalue::Eigenvalue(), ElementAdaptivityLevelAux::ElementAdaptivityLevelAux(), ElementGroupCentroidPositions::ElementGroupCentroidPositions(), ElementLengthAux::ElementLengthAux(), ElementLpNormAux::ElementLpNormAux(), ExtraIDIntegralVectorPostprocessor::elementValue(), ElementValueSampler::ElementValueSampler(), ElementVectorL2Error::ElementVectorL2Error(), EqualValueEmbeddedConstraintTempl< is_ad >::EqualValueEmbeddedConstraintTempl(), ReporterPointSource::errorCheck(), StitchMeshGeneratorBase::errorMissingBoundary(), ExamplePatchMeshGenerator::ExamplePatchMeshGenerator(), MultiAppNearestNodeTransfer::execute(), MultiAppUserObjectTransfer::execute(), ExtraElementIDAux::ExtraElementIDAux(), ExtraElementIntegerDivision::ExtraElementIntegerDivision(), ExtraIDIntegralVectorPostprocessor::ExtraIDIntegralVectorPostprocessor(), FEProblemBase::FEProblemBase(), 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(), Boundary2DDelaunayGenerator::General2DDelaunay(), BoundaryDeletionGenerator::generate(), UniqueExtraIDMeshGenerator::generate(), AddMetaDataGenerator::generate(), BlockToMeshConverterGenerator::generate(), BreakBoundaryOnSubdomainGenerator::generate(), ElementsToTetrahedronsConverter::generate(), ExtraNodesetGenerator::generate(), FillBetweenCurvesGenerator::generate(), FillBetweenSidesetsGenerator::generate(), LowerDBlockFromSidesetGenerator::generate(), PlaneIDMeshGenerator::generate(), RenameBlockGenerator::generate(), RenameBoundaryGenerator::generate(), BlockDeletionGenerator::generate(), Boundary2DDelaunayGenerator::generate(), BoundaryElementConversionGenerator::generate(), BreakMeshByBlockGenerator::generate(), CoarsenBlockGenerator::generate(), FlipSidesetGenerator::generate(), GeneratedMeshGenerator::generate(), ParsedSubdomainGeneratorBase::generate(), RefineBlockGenerator::generate(), RefineSidesetGenerator::generate(), SideSetsFromNodeSetsGenerator::generate(), AdvancedExtruderGenerator::generate(), BreakMeshByElementGenerator::generate(), CombinerGenerator::generate(), MeshCollectionGenerator::generate(), MeshExtruderGenerator::generate(), ParsedCurveGenerator::generate(), ParsedExtraElementIDGenerator::generate(), StackGenerator::generate(), XYZDelaunayGenerator::generate(), CircularBoundaryCorrectionGenerator::generate(), CutMeshByLevelSetGeneratorBase::generate(), XYDelaunayGenerator::generate(), XYMeshLineCutter::generate(), PatternedMeshGenerator::generate(), SubdomainBoundingBoxGenerator::generate(), GeneratedMeshGenerator::GeneratedMeshGenerator(), GenericConstantStdVectorMaterialTempl< is_ad >::GenericConstantStdVectorMaterialTempl(), 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(), MultiAppVariableValueSamplePostprocessorTransfer::initialSetup(), MultiAppGeneralFieldNearestLocationTransfer::initialSetup(), MultiAppDofCopyTransfer::initialSetup(), HistogramVectorPostprocessor::initialSetup(), ReferenceResidualConvergence::initialSetup(), PiecewiseConstantFromCSV::initialSetup(), LibtorchControlValuePostprocessor::initialSetup(), MultiAppGeneralFieldTransfer::initialSetup(), ElementSubdomainModifierBase::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(), KokkosBoundNodalKernel< KokkosUpperBoundNodalKernel >::KokkosBoundNodalKernel(), LibtorchNeuralNetControl::LibtorchNeuralNetControl(), LinearCombinationFunction::LinearCombinationFunction(), LinearFVAdvectionDiffusionFunctorRobinBC::LinearFVAdvectionDiffusionFunctorRobinBC(), LowerDIntegratedBC::LowerDIntegratedBC(), PNGOutput::makeMeshFunc(), MatCoupledForce::MatCoupledForce(), MaterialADConverterTempl< T >::MaterialADConverterTempl(), MaterialFunctorConverterTempl< T >::MaterialFunctorConverterTempl(), MatrixSymmetryCheck::MatrixSymmetryCheck(), PatternedMeshGenerator::mergeSubdomainNameMaps(), MeshCollectionGenerator::MeshCollectionGenerator(), MeshDiagnosticsGenerator::MeshDiagnosticsGenerator(), MeshDivisionAux::MeshDivisionAux(), MeshGenerator::MeshGenerator(), MeshGeneratorComponent::MeshGeneratorComponent(), MFEMGenericFunctorMaterial::MFEMGenericFunctorMaterial(), MFEMGenericFunctorVectorMaterial::MFEMGenericFunctorVectorMaterial(), MFEMSumAux::MFEMSumAux(), 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(), ParsedReporterBase::ParsedReporterBase(), ParsedScalarReporter::ParsedScalarReporter(), ParsedVectorRealReductionReporter::ParsedVectorRealReductionReporter(), ParsedVectorReporter::ParsedVectorReporter(), ParsedVectorVectorRealReductionReporter::ParsedVectorVectorRealReductionReporter(), PatternedMeshGenerator::PatternedMeshGenerator(), PenaltyPeriodicSegmentalConstraint::PenaltyPeriodicSegmentalConstraint(), PeriodicSegmentalConstraint::PeriodicSegmentalConstraint(), PIDTransientControl::PIDTransientControl(), PlaneDeletionGenerator::PlaneDeletionGenerator(), PlaneIDMeshGenerator::PlaneIDMeshGenerator(), PointwiseRenormalizeVector::PointwiseRenormalizeVector(), PolyLineMeshGenerator::PolyLineMeshGenerator(), ReporterInterface::possiblyCheckHasReporter(), VectorPostprocessorInterface::possiblyCheckHasVectorPostprocessor(), LibmeshPartitioner::prepareBlocksForSubdomainPartitioner(), ProjectedMaterialPropertyNodalPatchRecoveryAux::ProjectedMaterialPropertyNodalPatchRecoveryAux(), ProjectionAux::ProjectionAux(), PropertyReadFile::PropertyReadFile(), RandomIC::RandomIC(), MultiApp::readCommandLineArguments(), PropertyReadFile::readData(), SolutionUserObjectBase::readXda(), ReferenceResidualConvergence::ReferenceResidualConvergence(), RefineBlockGenerator::RefineBlockGenerator(), RefineSidesetGenerator::RefineSidesetGenerator(), RenameBlockGenerator::RenameBlockGenerator(), RenameBoundaryGenerator::RenameBoundaryGenerator(), ReporterPointSource::ReporterPointSource(), FEProblemBase::restoreSolutions(), SecondTimeDerivativeAux::SecondTimeDerivativeAux(), FEProblemBase::setLinearConvergenceNames(), FEProblemBase::setNonlinearConvergenceNames(), MooseMesh::setPartitioner(), NodeSetsGeneratorBase::setup(), SideSetsGeneratorBase::setup(), NEML2Action::setupDerivativeMappings(), NEML2Action::setupParameterDerivativeMappings(), SidesetAroundSubdomainUpdater::SidesetAroundSubdomainUpdater(), SideSetsFromBoundingBoxGenerator::SideSetsFromBoundingBoxGenerator(), SideValueSampler::SideValueSampler(), SingleRankPartitioner::SingleRankPartitioner(), SphericalGridDivision::SphericalGridDivision(), StitchBoundaryMeshGenerator::StitchBoundaryMeshGenerator(), StitchMeshGenerator::StitchMeshGenerator(), SymmetryTransformGenerator::SymmetryTransformGenerator(), TagVectorAux::TagVectorAux(), Terminator::Terminator(), TimeDerivativeAux::TimeDerivativeAux(), Transfer::Transfer(), TransformGenerator::TransformGenerator(), TransientMultiApp::TransientMultiApp(), ParsedCurveGenerator::tSectionSpaceDefiner(), UniqueExtraIDMeshGenerator::UniqueExtraIDMeshGenerator(), TimeSequenceStepperBase::updateSequence(), 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 131 of file MooseBase.h.
Referenced by MeshOnlyAction::act(), SplitMeshAction::act(), SetupDebugAction::act(), CSGOnlyAction::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(), ReferenceResidualProblem::addDefaultNonlinearConvergence(), AddDefaultConvergenceAction::addDefaultNonlinearConvergence(), FEProblemBase::addDefaultNonlinearConvergence(), AddDefaultConvergenceAction::addDefaultSteadyStateConvergence(), FEProblemBase::addDefaultSteadyStateConvergence(), FEProblemBase::addDGKernel(), FEProblemBase::addDiracKernel(), FEProblemBase::addDistribution(), MFEMProblem::addFESpace(), MFEMProblem::addFunction(), FEProblemBase::addFunction(), MFEMProblem::addFunctorMaterial(), FEProblemBase::addFunctorMaterial(), FEProblemBase::addFVBC(), FEProblemBase::addFVInitialCondition(), FEProblemBase::addFVInterfaceKernel(), FEProblemBase::addFVKernel(), MFEMProblem::addGridFunction(), FEProblemBase::addHDGKernel(), FEProblemBase::addIndicator(), MFEMProblem::addInitialCondition(), FEProblemBase::addInitialCondition(), DiffusionPhysicsBase::addInitialConditions(), FEProblemBase::addInterfaceKernel(), FEProblemBase::addInterfaceMaterial(), MFEMProblem::addKernel(), FEProblemBase::addKernel(), FEProblemBase::addLinearFVBC(), FEProblemBase::addLinearFVKernel(), FEProblem::addLineSearch(), FEProblemBase::addMarker(), FEProblemBase::addMaterial(), FEProblemBase::addMaterialHelper(), FEProblemBase::addMeshDivision(), MFEMProblem::addMFEMFESpaceFromMOOSEVariable(), MFEMProblem::addMFEMPreconditioner(), MFEMProblem::addMFEMSolver(), FEProblemBase::addMultiApp(), FEProblemBase::addNodalKernel(), FEProblemBase::addObject(), FEProblemBase::addObjectParamsHelper(), FEProblemBase::addOutput(), MFEMProblem::addPostprocessor(), FEProblemBase::addPostprocessor(), FEProblemBase::addPredictor(), FEProblemBase::addReporter(), FEProblemBase::addSampler(), FEProblemBase::addScalarKernel(), MFEMProblem::addSubMesh(), FEProblemBase::addTimeIntegrator(), MFEMProblem::addTransfer(), FEProblemBase::addTransfer(), FEProblemBase::addUserObject(), MFEMProblem::addVariable(), DisplacedProblem::addVariable(), FEProblemBase::addVectorPostprocessor(), ADPiecewiseLinearInterpolationMaterial::ADPiecewiseLinearInterpolationMaterial(), AdvancedOutput::AdvancedOutput(), ADVectorFunctionDirichletBC::ADVectorFunctionDirichletBC(), AnnularMesh::AnnularMesh(), AnnularMeshGenerator::AnnularMeshGenerator(), Action::associateWithParameter(), AuxKernelBase::AuxKernelBase(), AuxScalarKernel::AuxScalarKernel(), BoundsBase::BoundsBase(), MooseMesh::buildTypedMesh(), PostprocessorInterface::checkParam(), AddDefaultConvergenceAction::checkUnusedMultiAppFixedPointConvergenceParameters(), AddDefaultConvergenceAction::checkUnusedNonlinearConvergenceParameters(), AddDefaultConvergenceAction::checkUnusedSteadyStateConvergenceParameters(), SampledOutput::cloneMesh(), LibtorchNeuralNetControl::conditionalParameterError(), Console::Console(), CommonOutputAction::create(), MultiApp::createApp(), Postprocessor::declareValue(), DumpObjectsProblem::deduceNecessaryParameters(), DefaultMultiAppFixedPointConvergence::DefaultMultiAppFixedPointConvergence(), DumpObjectsProblem::dumpObjectHelper(), DumpObjectsProblem::DumpObjectsProblem(), EigenProblem::EigenProblem(), Eigenvalue::Eigenvalue(), ElementMaterialSampler::ElementMaterialSampler(), ExamplePatchMeshGenerator::ExamplePatchMeshGenerator(), Executor::Executor(), Exodus::Exodus(), ElementSubdomainModifierBase::extrapolatePolynomial(), FEProblem::FEProblem(), FixedPointSolve::FixedPointSolve(), FunctorSmootherTempl< T >::FunctorSmootherTempl(), GapValueAux::GapValueAux(), ParsedSubdomainGeneratorBase::generate(), ActionWarehouse::getCurrentActionName(), ExecutorInterface::getExecutor(), Material::getMaterial(), ReporterInterface::getReporterName(), Reporter::getReporterValueName(), UserObjectInterface::getUserObjectName(), AuxKernelBase::getVariableHelper(), VectorPostprocessorInterface::getVectorPostprocessorName(), GhostingUserObject::GhostingUserObject(), MeshGeneratorSystem::hasDataDrivenAllowed(), AttribSystem::initFrom(), AttribDisplaced::initFrom(), BlockRestrictable::initializeBlockRestrictable(), FullSolveMultiApp::initialSetup(), FEProblemBase::initNullSpaceVectors(), InterfaceDiffusiveFluxIntegralTempl< is_ad >::InterfaceDiffusiveFluxIntegralTempl(), InterfaceIntegralVariableValuePostprocessor::InterfaceIntegralVariableValuePostprocessor(), InterfaceKernelTempl< T >::InterfaceKernelTempl(), MooseObject::isKokkosObject(), 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(), ConsoleUtils::outputLegacyInformation(), OverlayMeshGenerator::OverlayMeshGenerator(), MooseServer::parseDocumentForDiagnostics(), ParsedReporterBase::ParsedReporterBase(), ParsedScalarReporter::ParsedScalarReporter(), PenetrationAux::PenetrationAux(), PiecewiseBilinear::PiecewiseBilinear(), PiecewiseLinearInterpolationMaterial::PiecewiseLinearInterpolationMaterial(), NEML2Action::printSummary(), ProjectedStatefulMaterialStorageAction::processProperty(), PropertyReadFile::PropertyReadFile(), PseudoTimestep::PseudoTimestep(), RandomIC::RandomIC(), ReferenceResidualConvergence::ReferenceResidualConvergence(), InputParameterWarehouse::removeInputParameters(), FEProblemBase::setAuxKernelParamsAndLog(), FEProblem::setInputParametersFEProblem(), FEProblemBase::setInputParametersFEProblem(), FEProblemBase::setResidualObjectParamsAndLog(), SideSetsGeneratorBase::setup(), NonlinearSystemBase::shouldEvaluatePreSMOResidual(), SideSetsFromBoundingBoxGenerator::SideSetsFromBoundingBoxGenerator(), Moose::PetscSupport::storePetscOptions(), DumpObjectsProblem::stringifyParameters(), TaggingInterface::TaggingInterface(), Transfer::Transfer(), TransientBase::TransientBase(), VectorBodyForce::VectorBodyForce(), VectorFunctionDirichletBC::VectorFunctionDirichletBC(), VectorFunctionIC::VectorFunctionIC(), VectorMagnitudeFunctorMaterialTempl< is_ad >::VectorMagnitudeFunctorMaterialTempl(), and MooseApp::~MooseApp().
| 
 | 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 453 of file MooseBase.h.
Referenced by GridPartitioner::_do_partition(), ComboMarker::ComboMarker(), Control::Control(), FunctorIC::FunctorIC(), and TransientMultiApp::TransientMultiApp().
| 
 | inlineinherited | 
Definition at line 94 of file SolutionInvalidInterface.h.
Referenced by GridPartitioner::_do_partition(), MultiAppTransfer::checkParentAppUserObjectExecuteOn(), 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 | 
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 446 of file MooseBase.h.
| 
 | inlineinherited | 
Definition at line 1024 of file MooseMesh.h.
| 
 | staticinherited | 
returns MooseMesh partitioning options so other classes can use it
Definition at line 3919 of file MooseMesh.C.
| 
 | inherited | 
Get the PerfGraph.
Definition at line 78 of file PerfGraphInterface.C.
Referenced by CommonOutputAction::act(), PerfGraphData::finalize(), and PerfGraphOutput::output().
| 
 | inherited | 
Calls prepare_for_use() if the underlying MeshBase object isn't prepared, then communicates various boundary information on parallel meshes.
Also calls update() internally. Instead of calling prepare_for_use on the currently held MeshBase object, a mesh_to_clone can be provided. If it is provided (e.g. this method is given a non-null argument), then _mesh will be assigned a clone of the mesh_to_clone. The provided mesh_to_clone must already be prepared 
| mesh_to_clone | If nonnull, we will clone this mesh instead of preparing our current one | 
prepare_for_use called (e.g. this method returns true when called for the reference mesh), then we must pass the reference mesh base object into this method when we call this for the displaced mesh. This is because the displaced mesh  must be an exact clone of the reference mesh. We have seen that prepare_for_use called on two previously identical meshes can result in two different meshes even with Metis partitioning Definition at line 419 of file MooseMesh.C.
| 
 | inherited | 
Setter/getter for whether the mesh is prepared.
Definition at line 3158 of file MooseMesh.C.
Referenced by MooseMesh::needsPrepareForUse(), AnnularMesh::prepared(), and GeneratedMesh::prepared().
| 
 | virtualinherited | 
If we are explicitly setting the mesh to not prepared, then we've likely modified the mesh and can no longer make assumptions about orthogonality. We really should recheck.
Reimplemented in AnnularMesh, and GeneratedMesh.
Definition at line 3164 of file MooseMesh.C.
| 
 | inherited | 
Calls print_info() on the underlying Mesh.
Definition at line 3483 of file MooseMesh.C.
Referenced by Adaptivity::adaptMesh().
| 
 | virtualinherited | 
Definition at line 3146 of file MooseMesh.C.
Referenced by PointSamplerBase::getLocalElemContainingPoint(), NodePositions::initialize(), ElementalVariableValue::initialSetup(), DisplacedProblem::reinitElemPhys(), FEProblemBase::reinitElemPhys(), and EqualValueBoundaryConstraint::updateConstrainedNodes().
| 
 | virtualinherited | 
Definition at line 3152 of file MooseMesh.C.
| 
 | virtualinherited | 
Definition at line 875 of file MooseMesh.C.
Referenced by NonlinearSystemBase::findImplicitGeometricCouplingEntries(), NodePositions::initialize(), MooseMesh::nodeRef(), MooseMesh::queryNodePtr(), and EqualValueBoundaryConstraint::updateConstrainedNodes().
| 
 | virtualinherited | 
Definition at line 891 of file MooseMesh.C.
| 
 | inherited | 
Query a parameter for the object.
If the parameter is not valid, nullptr will be returned
| name | The name of the parameter | 
Definition at line 395 of file MooseBase.h.
| void FileMesh::read | ( | const std::string & | file_name | ) | 
Definition at line 145 of file FileMesh.C.
| 
 | inherited | 
Return a range that is suitable for threaded execution over elements that were just refined.
Definition at line 946 of file MooseMesh.C.
Referenced by FEProblemBase::meshChanged().
| 
 | protectedinherited | 
Definition at line 55 of file SolutionInvalidInterface.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) | 
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.
| 
 | 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 78 of file Restartable.C.
Referenced by Restartable::declareRecoverableData(), and Restartable::declareRestartableDataHelper().
| 
 | overridevirtual | 
A safer version of the clone() method that hands back an allocated object wrapped in a smart pointer.
This makes it much less likely that the caller will leak the memory in question.
Implements MooseMesh.
Reimplemented in MFEMMesh.
Definition at line 61 of file FileMesh.C.
For axisymmetric simulations, set the symmetry coordinate axis.
For r in the x-direction, z in the y-direction the coordinate axis would be y
Definition at line 4234 of file MooseMesh.C.
Referenced by FEProblemBase::setAxisymmetricCoordAxis().
| 
 | inherited | 
This method sets the boundary name of the boundary based on the id parameter.
Definition at line 1818 of file MooseMesh.C.
Referenced by MooseMesh::prepare(), and ActivateElementsUserObjectBase::setNewBoundayName().
| 
 | inherited | 
Sets the mapping between BoundaryID and normal vector Is called by AddAllSideSetsByNormals.
Definition at line 3222 of file MooseMesh.C.
| 
 | inherited | 
Definition at line 3229 of file MooseMesh.C.
Set the coordinate system data to that of other_mesh. 
Definition at line 4343 of file MooseMesh.C.
Referenced by DisplacedProblem::DisplacedProblem().
| 
 | inherited | 
Set the coordinate system for the provided blocks to coord_sys. 
Definition at line 4102 of file MooseMesh.C.
Referenced by MooseMesh::prepare(), and FEProblemBase::setCoordSystem().
| 
 | inherited | 
Setter for custom partitioner.
Definition at line 3720 of file MooseMesh.C.
| 
 | inline | 
Definition at line 30 of file FileMesh.h.
| 
 | inherited | 
Sets the general coordinate axes for axisymmetric blocks.
This method must be used if any of the following are true:
| [in] | blocks | Subdomain names | 
| [in] | axes | Pair of values defining the axisymmetric coordinate axis for each subdomain. The first value is the point on the axis corresponding to the origin. The second value is the direction vector of the axis (normalization not necessary). | 
Definition at line 4242 of file MooseMesh.C.
Referenced by MooseMesh::prepare().
This sets the inflation amount for the bounding box for each partition for use in ghosting boundaries.
Definition at line 3256 of file MooseMesh.C.
| 
 | inherited | 
Definition at line 3748 of file MooseMesh.C.
Method to set the mesh_base object.
If this method is NOT called prior to calling init(), a MeshBase object will be automatically constructed and set.
Definition at line 2906 of file MooseMesh.C.
| 
 | inherited | 
Sets the set of BoundaryIDs Is called by AddAllSideSetsByNormals.
Definition at line 3216 of file MooseMesh.C.
| 
 | inlineinherited | 
Allow to change parallel type.
Definition at line 2179 of file MooseMesh.h.
Referenced by MooseMesh::buildTypedMesh().
| 
 | staticinherited | 
Method for setting the partitioner on the passed in mesh_base object.
Definition at line 3661 of file MooseMesh.C.
Referenced by MooseMesh::setPartitionerHelper().
Definition at line 3649 of file MooseMesh.C.
Referenced by MooseMesh::buildTypedMesh().
| 
 | inherited | 
Set the patch size update strategy.
Definition at line 3428 of file MooseMesh.C.
| 
 | inherited | 
This method sets the name for subdomain_id to name. 
Definition at line 1787 of file MooseMesh.C.
Referenced by MooseMesh::MooseMesh(), and MooseMesh::prepare().
| 
 | staticinherited | 
This method sets the name for subdomain_id on the provided mesh to name. 
Set uniform refinement level.
Definition at line 3243 of file MooseMesh.C.
| 
 | inherited | 
Sets up the additional data needed for finite volume computations.
This involves building FaceInfo and ElemInfo objects, caching variable associations and elemental DoF indices for FV variables.
Definition at line 4093 of file MooseMesh.C.
Referenced by DisplacedProblem::init(), FEProblemBase::init(), FEProblemBase::meshChanged(), and DisplacedProblem::updateMesh().
| 
 | inherited | 
Calls BoundaryInfo::side_with_boundary_id().
Definition at line 3042 of file MooseMesh.C.
| 
 | inlineinherited | 
Return a flag indicating whether or not we should skip remote deletion and repartition after uniform refinements.
If the flag is true, uniform refinements will run more efficiently, but at the same time, there might be extra ghosting elements. The number of layers of additional ghosting elements depends on the number of uniform refinement levels. This flag should be used only when you have a "fine enough" coarse mesh and want to refine the mesh by a few levels. Otherwise, it might introduce an unbalanced workload and too large ghosting domain.
Definition at line 2173 of file MooseMesh.h.
| 
 | virtualinherited | 
Definition at line 4423 of file MooseMesh.C.
| 
 | inlinevirtualinherited | 
Definition at line 325 of file MooseMesh.h.
| 
 | inlineinherited | 
Whether or not skip uniform refinements when using a pre-split mesh.
Definition at line 581 of file MooseMesh.h.
| 
 | inlinevirtualinherited | 
Returns MeshBase::spatial_dimension.
Reimplemented in MFEMMesh.
Definition at line 186 of file MooseMesh.h.
| 
 | protectedinherited | 
section_name.Optionally adds a prefix if one is defined.
Definition at line 47 of file PerfGraphInterface.C.
Referenced by PerfGraphInterface::registerTimedSection().
| 
 | inlineinherited | 
Get the type of this class.
Definition at line 93 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(), AuxKernelBase::AuxKernelBase(), 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(), InterfaceReaction::computeQpJacobian(), ArrayDGDiffusion::computeQpJacobian(), CoupledTiedValueConstraint::computeQpJacobian(), TiedValueConstraint::computeQpJacobian(), DGDiffusion::computeQpJacobian(), LinearNodalConstraint::computeQpJacobian(), EqualValueBoundaryConstraint::computeQpJacobian(), CoupledTiedValueConstraint::computeQpOffDiagJacobian(), HFEMTestJump::computeQpOffDiagJacobian(), HFEMTrialJump::computeQpOffDiagJacobian(), ArrayDGKernel::computeQpOffDiagJacobian(), ArrayHFEMDiffusion::computeQpResidual(), DGConvection::computeQpResidual(), HFEMDiffusion::computeQpResidual(), ScalarKernel::computeQpResidual(), InterfaceDiffusion::computeQpResidual(), ADMatInterfaceReaction::computeQpResidual(), InterfaceReaction::computeQpResidual(), ADDGAdvection::computeQpResidual(), ArrayDGDiffusion::computeQpResidual(), CoupledTiedValueConstraint::computeQpResidual(), TiedValueConstraint::computeQpResidual(), DGDiffusion::computeQpResidual(), LinearNodalConstraint::computeQpResidual(), ADDGDiffusion::computeQpResidual(), HFEMTrialJump::computeQpResidual(), EqualValueBoundaryConstraint::computeQpResidual(), HFEMTestJump::computeQpResidual(), FEProblemBase::computeSystems(), FEProblemBase::computeUserObjectByName(), FEProblemBase::computeUserObjects(), FEProblemBase::computeUserObjectsInternal(), DisplacedProblem::createQRules(), FEProblemBase::createQRules(), MooseApp::createRecoverablePerfGraph(), DumpObjectsProblem::deduceNecessaryParameters(), DumpObjectsProblem::dumpObjectHelper(), FEProblemBase::duplicateVariableCheck(), FEProblemBase::execMultiApps(), FEProblemBase::execMultiAppTransfers(), FEProblemBase::execTransfers(), WebServerControl::execute(), SteadyBase::execute(), ActionWarehouse::executeActionsWithAction(), FEProblemBase::finishMultiAppStep(), FVScalarLagrangeMultiplierInterface::FVScalarLagrangeMultiplierInterface(), MooseServer::gatherDocumentReferencesLocations(), Boundary2DDelaunayGenerator::General2DDelaunay(), LowerDBlockFromSidesetGenerator::generate(), SubdomainPerElementGenerator::generate(), Boundary2DDelaunayGenerator::generate(), PatternedMeshGenerator::generate(), MeshGenerator::generateInternal(), MeshGenerator::generateInternalCSG(), MultiAppTransfer::getAppInfo(), TransfiniteMeshGenerator::getEdge(), ElementGenerator::getElemType(), MooseServer::getInputLookupDefinitionNodes(), FEProblemBase::getMaterial(), FEProblemBase::getMaterialData(), FEProblemBase::getMaterialPropertyStorageConsumers(), 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(), LinearFVAdvection::initialSetup(), LinearFVAnisotropicDiffusion::initialSetup(), LinearFVDiffusion::initialSetup(), ArrayDGDiffusion::initQpResidual(), AdvancedOutput::initShowHideLists(), RelationshipManager::isType(), FEProblemBase::logAdd(), MaterialFunctorConverterTempl< T >::MaterialFunctorConverterTempl(), MFEMProblem::mesh(), 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(), ExplicitTVDRK2::solve(), ExplicitRK2::solve(), WebServerControl::startServer(), Reporter::store(), 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 57 of file MooseBase.C.
Referenced by FEProblemBase::addPostprocessor(), MaterialPropertyStorage::addProperty(), FEProblemBase::addReporter(), FEProblemBase::addVectorPostprocessor(), MeshGeneratorSystem::dataDrivenError(), ReporterContext< std::vector< T > >::finalize(), and ReporterData::getReporterInfo().
| 
 | inherited | 
Returns the level of uniform refinement requested (zero if AMR is disabled).
Definition at line 3237 of file MooseMesh.C.
Referenced by FEProblemBase::initialSetup(), and Adaptivity::uniformRefineWithProjection().
| 
 | inherited | 
Definition at line 69 of file MooseBase.C.
Referenced by MooseBase::connectControllableParams(), and Action::uniqueActionName().
| 
 | inherited | 
Definition at line 63 of file MooseBase.C.
| 
 | inherited | 
Calls buildNodeListFromSideList(), buildNodeList(), and buildBndElemList().
Definition at line 629 of file MooseMesh.C.
Referenced by MooseMesh::meshChanged(), MooseMesh::prepare(), and EqualValueBoundaryConstraint::updateConstrainedNodes().
| 
 | inherited | 
Clears the "semi-local" node list and rebuilds it.
Semi-local nodes consist of all nodes that belong to local and ghost elements.
Definition at line 966 of file MooseMesh.C.
Referenced by FEProblemBase::initialSetup(), FEProblemBase::meshChanged(), and FEProblemBase::possiblyRebuildGeomSearchPatches().
| 
 | inherited | 
Returns true if general axisymmetric coordinate axes are being used.
Definition at line 4300 of file MooseMesh.C.
Referenced by MooseMesh::getAxisymmetricRadialCoord(), and MooseMesh::getUniqueCoordSystem().
| 
 | static | 
Definition at line 28 of file FileMesh.C.
Referenced by SetupMeshAction::modifyParamsForUseSplit(), and MFEMMesh::validParams().
| 
 | protectedinherited | 
Builds Actions.
Definition at line 40 of file ParallelParamObject.h.
Referenced by AddActionComponentAction::act(), CreateMeshSetupActionsForComponents::act(), ActionComponent::checkRequiredTasks(), PhysicsBase::checkRequiredTasks(), CommonOutputAction::create(), AddVariableAction::createInitialConditionAction(), DynamicObjectRegistrationAction::DynamicObjectRegistrationAction(), CreateExecutionerAction::setupAutoPreconditioning(), and ReadExecutorParamsAction::setupAutoPreconditioning().
| 
 | protectedinherited | 
A range for use with threading.
We do this so that it doesn't have to get rebuilt all the time (which takes time).
Definition at line 1517 of file MooseMesh.h.
Referenced by MooseMesh::getActiveLocalElementRange(), and MooseMesh::meshChanged().
| 
 | protectedinherited | 
Definition at line 1520 of file MooseMesh.h.
Referenced by MooseMesh::getActiveNodeRange(), and MooseMesh::meshChanged().
| 
 | protectedinherited | 
Definition at line 1519 of file MooseMesh.h.
Referenced by MooseMesh::getActiveSemiLocalNodeRange(), MooseMesh::meshChanged(), and MooseMesh::updateActiveSemiLocalNodeRange().
| 
 | protectedinherited | 
The MOOSE application this is associated with.
Definition at line 357 of file MooseBase.h.
| 
 | protectedinherited | 
list of nodes that belongs to a specified block (domain)
Definition at line 1576 of file MooseMesh.h.
Referenced by MooseMesh::cacheInfo(), and MooseMesh::getNodeBlockIds().
| 
 | protectedinherited | 
Map of set of elem IDs connected to each boundary.
Definition at line 1568 of file MooseMesh.h.
Referenced by MooseMesh::buildBndElemList(), MooseMesh::freeBndElems(), MooseMesh::getBoundariesToActiveSemiLocalElemIds(), MooseMesh::getBoundaryActiveSemiLocalElemIds(), and MooseMesh::isBoundaryElem().
| 
 | protectedinherited | 
Definition at line 1525 of file MooseMesh.h.
Referenced by MooseMesh::freeBndElems(), MooseMesh::getBoundaryElementRange(), MooseMesh::isBoundaryFullyExternalToSubdomains(), and MooseMesh::meshChanged().
| 
 | protectedinherited | 
array of boundary elems
Definition at line 1563 of file MooseMesh.h.
Referenced by MooseMesh::bndElemsBegin(), MooseMesh::bndElemsEnd(), MooseMesh::buildBndElemList(), MooseMesh::freeBndElems(), and MooseMesh::getBoundaryActiveNeighborElemIds().
| 
 | protectedinherited | 
Map of sets of node IDs in each boundary.
Definition at line 1560 of file MooseMesh.h.
Referenced by MooseMesh::addQuadratureNode(), MooseMesh::buildNodeList(), MooseMesh::freeBndNodes(), and MooseMesh::isBoundaryNode().
| 
 | protectedinherited | 
Definition at line 1523 of file MooseMesh.h.
Referenced by MooseMesh::addQuadratureNode(), MooseMesh::freeBndNodes(), MooseMesh::getBoundaryNodeRange(), and MooseMesh::meshChanged().
| 
 | protectedinherited | 
array of boundary nodes
Definition at line 1556 of file MooseMesh.h.
Referenced by MooseMesh::addQuadratureNode(), MooseMesh::bndNodesBegin(), MooseMesh::bndNodesEnd(), MooseMesh::buildNodeList(), and MooseMesh::freeBndNodes().
| 
 | protectedinherited | 
The boundary to normal map - valid only when AddAllSideSetsByNormals is active.
Definition at line 1553 of file MooseMesh.h.
Referenced by MooseMesh::getNormalByBoundaryID(), and MooseMesh::setBoundaryToNormalMap().
| 
 | protectedinherited | 
The bounds in each dimension of the mesh for regular orthogonal meshes.
Definition at line 1603 of file MooseMesh.h.
Referenced by MooseMesh::detectOrthogonalDimRanges(), MooseMesh::getMaxInDimension(), MooseMesh::getMinInDimension(), and MooseMesh::MooseMesh().
| 
 | protectedinherited | 
Whether or not this mesh was built from another mesh.
Definition at line 1437 of file MooseMesh.h.
Referenced by MooseMesh::prepare().
| 
 | protectedinherited | 
Map of Parent elements to child elements for elements that were just coarsened.
NOTE: the child element pointers ARE PROBABLY INVALID. Only use them for indexing!
Definition at line 1508 of file MooseMesh.h.
Referenced by MooseMesh::cacheChangedLists(), and MooseMesh::coarsenedElementChildren().
| 
 | protectedinherited | 
The elements that were just coarsened.
Definition at line 1501 of file MooseMesh.h.
Referenced by MooseMesh::cacheChangedLists(), and MooseMesh::coarsenedElementRange().
| 
 | inherited | 
An instance of helper class to write streams to the Console objects.
Definition at line 31 of file ConsoleStreamInterface.h.
Referenced by IterationAdaptiveDT::acceptStep(), MeshOnlyAction::act(), SetupDebugAction::act(), MaterialOutputAction::act(), Adaptivity::adaptMesh(), FEProblemBase::adaptMesh(), PerfGraph::addToExecutionList(), SimplePredictor::apply(), SystemBase::applyScalingFactors(), MultiApp::backup(), FEProblemBase::backupMultiApps(), CoarsenedPiecewiseLinear::buildCoarsenedGrid(), DefaultSteadyStateConvergence::checkConvergence(), MeshDiagnosticsGenerator::checkElementOverlap(), MeshDiagnosticsGenerator::checkElementTypes(), MeshDiagnosticsGenerator::checkElementVolumes(), FEProblemBase::checkExceptionAndStopSolve(), SolverSystem::checkInvalidSolution(), MeshDiagnosticsGenerator::checkLocalJacobians(), MeshDiagnosticsGenerator::checkNonConformalMesh(), MeshDiagnosticsGenerator::checkNonConformalMeshFromAdaptivity(), MeshDiagnosticsGenerator::checkNonMatchingEdges(), MeshDiagnosticsGenerator::checkNonPlanarSides(), FEProblemBase::checkProblemIntegrity(), ReferenceResidualConvergence::checkRelativeConvergence(), MeshDiagnosticsGenerator::checkSidesetsOrientation(), MeshDiagnosticsGenerator::checkWatertightNodesets(), MeshDiagnosticsGenerator::checkWatertightSidesets(), IterationAdaptiveDT::computeAdaptiveDT(), TransientBase::computeConstrainedDT(), DefaultMultiAppFixedPointConvergence::computeCustomConvergencePostprocessor(), NonlinearSystemBase::computeDamping(), FixedPointIterationAdaptiveDT::computeDT(), IterationAdaptiveDT::computeDT(), IterationAdaptiveDT::computeFailedDT(), IterationAdaptiveDT::computeInitialDT(), IterationAdaptiveDT::computeInterpolationDT(), LinearSystem::computeLinearSystemTags(), FEProblemBase::computeLinearSystemTags(), NonlinearSystemBase::computeScaling(), Problem::console(), IterationAdaptiveDT::constrainStep(), TimeStepper::constrainStep(), MultiApp::createApp(), FEProblemBase::execMultiApps(), FEProblemBase::execMultiAppTransfers(), MFEMSteady::execute(), MessageFromInput::execute(), SteadyBase::execute(), Eigenvalue::execute(), ActionWarehouse::executeActionsWithAction(), ActionWarehouse::executeAllActions(), MeshGeneratorSystem::executeMeshGenerators(), ElementQualityChecker::finalize(), SidesetAroundSubdomainUpdater::finalize(), FEProblemBase::finishMultiAppStep(), MeshRepairGenerator::fixOverlappingNodes(), CoarsenBlockGenerator::generate(), MeshGenerator::generateInternal(), VariableCondensationPreconditioner::getDofToCondense(), NonlinearEigen::init(), InversePowerMethod::init(), FEProblemBase::initialAdaptMesh(), DefaultMultiAppFixedPointConvergence::initialize(), SubProblem::initialSetup(), EigenExecutionerBase::inversePowerIteration(), FEProblemBase::joinAndFinalize(), TransientBase::keepGoing(), IterationAdaptiveDT::limitDTByFunction(), IterationAdaptiveDT::limitDTToPostprocessorValue(), FEProblemBase::logAdd(), EigenExecutionerBase::makeBXConsistent(), Console::meshChanged(), MooseBase::mooseDeprecated(), MooseBase::mooseInfo(), MooseBase::mooseWarning(), MooseBase::mooseWarningNonPrefixed(), ReferenceResidualConvergence::nonlinearConvergenceSetup(), ReporterDebugOutput::output(), PerfGraphOutput::output(), SolutionInvalidityOutput::output(), MaterialPropertyDebugOutput::output(), DOFMapOutput::output(), VariableResidualNormsDebugOutput::output(), Console::output(), ControlOutput::outputActiveObjects(), ControlOutput::outputChangedControls(), ControlOutput::outputControls(), Console::outputInput(), Console::outputPostprocessors(), PseudoTimestep::outputPseudoTimestep(), Console::outputReporters(), DefaultMultiAppFixedPointConvergence::outputResidualNorm(), Console::outputScalarVariables(), Console::outputSystemInformation(), FEProblemBase::possiblyRebuildGeomSearchPatches(), EigenExecutionerBase::postExecute(), AB2PredictorCorrector::postSolve(), ActionWarehouse::printActionDependencySets(), BlockRestrictionDebugOutput::printBlockRestrictionMap(), SolutionInvalidity::printDebug(), EigenExecutionerBase::printEigenvalue(), SecantSolve::printFixedPointConvergenceHistory(), SteffensenSolve::printFixedPointConvergenceHistory(), PicardSolve::printFixedPointConvergenceHistory(), FixedPointSolve::printFixedPointConvergenceReason(), PerfGraphLivePrint::printLiveMessage(), MaterialPropertyDebugOutput::printMaterialMap(), PerfGraphLivePrint::printStats(), NEML2Action::printSummary(), AutomaticMortarGeneration::projectPrimaryNodesSinglePair(), AutomaticMortarGeneration::projectSecondaryNodesSinglePair(), CoarsenBlockGenerator::recursiveCoarsen(), SolutionTimeAdaptiveDT::rejectStep(), MultiApp::restore(), FEProblemBase::restoreMultiApps(), FEProblemBase::restoreSolutions(), NonlinearSystemBase::setInitialSolution(), MooseApp::setupOptions(), Checkpoint::shouldOutput(), SubProblem::showFunctorRequestors(), SubProblem::showFunctors(), FullSolveMultiApp::showStatusMessage(), EigenProblem::solve(), FEProblemSolve::solve(), NonlinearSystem::solve(), FixedPointSolve::solve(), LinearSystem::solve(), LStableDirk2::solve(), LStableDirk3::solve(), ImplicitMidpoint::solve(), ExplicitTVDRK2::solve(), AStableDirk4::solve(), LStableDirk4::solve(), ExplicitRK2::solve(), TransientMultiApp::solveStep(), FixedPointSolve::solveStep(), PerfGraphLivePrint::start(), AB2PredictorCorrector::step(), NonlinearEigen::takeStep(), MFEMTransient::takeStep(), TransientBase::takeStep(), TerminateChainControl::terminate(), SubProblem::timestepSetup(), FEProblemBase::updateMeshXFEM(), Convergence::verboseOutput(), Console::writeTimestepInformation(), Console::writeVariableNorms(), and FEProblemBase::~FEProblemBase().
| 
 | protectedinherited | 
The custom partitioner.
Definition at line 1463 of file MooseMesh.h.
Referenced by MooseMesh::buildTypedMesh(), and MooseMesh::setCustomPartitioner().
| 
 | protectedinherited | 
Definition at line 1464 of file MooseMesh.h.
Referenced by MooseMesh::buildTypedMesh(), MooseMesh::isCustomPartitionerRequested(), and MooseMesh::setIsCustomPartitionerRequested().
| 
 | protectedinherited | 
Definition at line 1447 of file MooseMesh.h.
| 
 | protectedinherited | 
Definition at line 1572 of file MooseMesh.h.
Referenced by MooseMesh::addQuadratureNode(), MooseMesh::clearQuadratureNodes(), and MooseMesh::getQuadratureNode().
| 
 | protectedinherited | 
Reference to the "enable" InputParameters, used by Controls for toggling on/off MooseObjects.
Definition at line 86 of file MooseObject.h.
Referenced by MooseObject::enabled().
| 
 | protected | 
Auxiliary object for restart.
Definition at line 38 of file FileMesh.h.
| 
 | protectedinherited | 
Definition at line 1573 of file MooseMesh.h.
Referenced by MooseMesh::addQuadratureNode(), MooseMesh::buildNodeList(), and MooseMesh::clearQuadratureNodes().
| 
 | protectedinherited | 
The Factory associated with the MooseApp.
Definition at line 37 of file ParallelParamObject.h.
Referenced by ElementIDOutputAction::act(), AutoCheckpointAction::act(), PartitionerAction::act(), CreateExecutionerAction::act(), CreateProblemAction::act(), CreateProblemDefaultAction::act(), CombineComponentsMeshes::act(), SetupMeshAction::act(), AdaptivityAction::act(), SetupPredictorAction::act(), SetupTimeStepperAction::act(), SetupDebugAction::act(), ComposeTimeStepperAction::act(), SetupPreconditionerAction::act(), SetupResidualDebugAction::act(), MaterialDerivativeTestAction::act(), CreateDisplacedProblemAction::act(), SetAdaptivityOptionsAction::act(), DisplayGhostingAction::act(), AddControlAction::act(), MaterialOutputAction::act(), AddPeriodicBCAction::act(), CommonOutputAction::act(), AddNodalNormalsAction::act(), ComponentMeshTransformHelper::addMeshGenerators(), CylinderComponent::addMeshGenerators(), DiffusionPhysicsBase::addPostprocessors(), CreateDisplacedProblemAction::addProxyRelationshipManagers(), Action::addRelationshipManager(), SampledOutput::cloneMesh(), DynamicObjectRegistrationAction::DynamicObjectRegistrationAction(), ActionComponent::getFactory(), PhysicsBase::getFactory(), MaterialOutputAction::getParams(), and ProjectedStatefulMaterialStorageAction::processProperty().
| 
 | protected | 
the file_name from whence this mesh came
Definition at line 35 of file FileMesh.h.
Referenced by buildMesh(), getFileName(), and setFileName().
| 
 | protectedinherited | 
Definition at line 1581 of file MooseMesh.h.
Referenced by MooseMesh::addGhostedBoundary(), MooseMesh::getGhostedBoundaries(), and MooseMesh::ghostGhostedBoundaries().
| 
 | protectedinherited | 
Definition at line 1582 of file MooseMesh.h.
Referenced by MooseMesh::getGhostedBoundaryInflation(), and MooseMesh::setGhostedBoundaryInflation().
| 
 | protectedinherited | 
Deprecated (DO NOT USE)
Definition at line 1431 of file MooseMesh.h.
| 
 | protectedinherited | 
The number of nearest neighbors to consider for ghosting purposes when iteration patch update strategy is used.
Definition at line 1588 of file MooseMesh.h.
Referenced by MooseMesh::getGhostingPatchSize().
| 
 | protectedinherited | 
true if mesh is changed (i.e. after adaptivity step)
Definition at line 1489 of file MooseMesh.h.
| 
 | protectedinherited | 
True if a Nemesis Mesh was read in.
Definition at line 1492 of file MooseMesh.h.
Referenced by buildMesh(), MooseMesh::determineUseDistributedMesh(), MooseMesh::prepare(), and read().
| 
 | protectedinherited | 
Whether or not we are using a (pre-)split mesh (automatically DistributedMesh)
Definition at line 1609 of file MooseMesh.h.
Referenced by MooseMesh::determineUseDistributedMesh(), and MooseMesh::isSplit().
| 
 | protectedinherited | 
Pointer to Kokkos mesh object.
Definition at line 1455 of file MooseMesh.h.
Referenced by MooseMesh::getKokkosMesh(), MooseMesh::MooseMesh(), and MooseMesh::update().
| 
 | protectedinherited | 
Definition at line 1521 of file MooseMesh.h.
Referenced by MooseMesh::getLocalNodeRange(), and MooseMesh::meshChanged().
| 
 | protectedinherited | 
Definition at line 1591 of file MooseMesh.h.
Referenced by MooseMesh::getMaxLeafSize().
| 
 | protectedinherited | 
Pointer to underlying libMesh mesh object.
Definition at line 1451 of file MooseMesh.h.
Referenced by MooseMesh::allowRemoteElementRemoval(), MooseMesh::buildFiniteVolumeInfo(), MooseMesh::buildPeriodicNodeMap(), MooseMesh::deleteRemoteElements(), MooseMesh::detectPairedSidesets(), MooseMesh::getMaxInDimension(), MooseMesh::getMesh(), MooseMesh::getMeshPtr(), MooseMesh::getMinInDimension(), MooseMesh::hasMeshBase(), MooseMesh::init(), MooseMesh::nActiveElem(), MooseMesh::nActiveLocalElem(), MooseMesh::nLocalNodes(), MooseMesh::nPartitions(), MooseMesh::nSubdomains(), MooseMesh::prepare(), MooseMesh::prepared(), MooseMesh::setCoordSystem(), MooseMesh::setMeshBase(), MooseMesh::skipNoncriticalPartitioning(), MooseMesh::skipPartitioning(), and MooseMesh::spatialDimension().
| 
 | protectedinherited | 
A set of boundary IDs currently present in the mesh.
In serial, this is equivalent to the values returned by _mesh.get_boundary_info().get_boundary_ids(). In parallel, it will contain off-processor boundary IDs as well.
Definition at line 1547 of file MooseMesh.h.
Referenced by MooseMesh::getBoundaryIDs(), MooseMesh::meshBoundaryIds(), MooseMesh::prepare(), and MooseMesh::setMeshBoundaryIDs().
| 
 | protectedinherited | 
Definition at line 1549 of file MooseMesh.h.
Referenced by MooseMesh::meshNodesetIds(), and MooseMesh::prepare().
| 
 | protectedinherited | 
Definition at line 1548 of file MooseMesh.h.
Referenced by MooseMesh::meshSidesetIds(), and MooseMesh::prepare().
| 
 | protectedinherited | 
A set of subdomain IDs currently present in the mesh.
For parallel meshes, includes subdomains defined on other processors as well.
Definition at line 1539 of file MooseMesh.h.
Referenced by MooseMesh::buildLowerDMesh(), MooseMesh::cacheInfo(), MooseMesh::checkDuplicateSubdomainNames(), MooseMesh::meshSubdomains(), and MooseMesh::prepare().
| 
 | protectedinherited | 
True if prepare has been called on the mesh.
Definition at line 1495 of file MooseMesh.h.
Referenced by MooseMesh::prepare(), and MooseMesh::prepared().
| 
 | protectedinherited | 
The name of this class.
Definition at line 363 of file MooseBase.h.
Referenced by AddBCAction::act(), AddConstraintAction::act(), AddFVInitialConditionAction::act(), AddPostprocessorAction::act(), AddVectorPostprocessorAction::act(), AddKernelAction::act(), AddScalarKernelAction::act(), PartitionerAction::act(), ReadExecutorParamsAction::act(), AddNodalKernelAction::act(), AddDiracKernelAction::act(), AddFunctorMaterialAction::act(), AddMarkerAction::act(), AddIndicatorAction::act(), AddMaterialAction::act(), AddMeshGeneratorAction::act(), AddDamperAction::act(), AddFVInterfaceKernelAction::act(), AddInitialConditionAction::act(), AddMultiAppAction::act(), AddTransferAction::act(), AddDGKernelAction::act(), AddUserObjectAction::act(), AddInterfaceKernelAction::act(), AddPositionsAction::act(), AddReporterAction::act(), AddTimesAction::act(), AddFieldSplitAction::act(), AddFVKernelAction::act(), AddFVBCAction::act(), AddTimeStepperAction::act(), AddDistributionAction::act(), SetupPreconditionerAction::act(), SetupTimeIntegratorAction::act(), AddFunctionAction::act(), AddConvergenceAction::act(), AddMeshDivisionAction::act(), AddHDGKernelAction::act(), AddOutputAction::act(), AddLinearFVBCAction::act(), AddLinearFVKernelAction::act(), AddMeshModifiersAction::act(), AddCorrectorAction::act(), AddSamplerAction::act(), AddControlAction::act(), AddMFEMFESpaceAction::act(), AddMFEMSolverAction::act(), AddMFEMSubMeshAction::act(), AddMFEMPreconditionerAction::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(), MooseBase::MooseBase(), NearestPointBase< LayeredSideDiffusiveFluxAverage, SideIntegralVariableUserObject >::name(), ParsedFunctorMaterialTempl< is_ad >::ParsedFunctorMaterialTempl(), PiecewiseBilinear::PiecewiseBilinear(), PiecewiseLinearInterpolationMaterial::PiecewiseLinearInterpolationMaterial(), PiecewiseBase::setData(), and AddVariableAction::varName().
| 
 | protectedinherited | 
Vector of all the Nodes in the mesh for determining when to add a new point.
Definition at line 1597 of file MooseMesh.h.
Referenced by MooseMesh::addUniqueNode().
| 
 | protectedinherited | 
list of nodes that belongs to a specified nodeset: indexing [nodeset_id] -> [array of node ids]
Definition at line 1579 of file MooseMesh.h.
Referenced by MooseMesh::buildNodeList(), MooseMesh::freeBndNodes(), MooseMesh::getNodeList(), and MooseMesh::nodeSetNodes().
| 
 | protectedinherited | 
A map of all of the current nodes to the active elements that they are connected to.
Definition at line 1532 of file MooseMesh.h.
Referenced by MooseMesh::addQuadratureNode(), MooseMesh::nodeToActiveSemilocalElemMap(), and MooseMesh::update().
| 
 | protectedinherited | 
Definition at line 1533 of file MooseMesh.h.
Referenced by MooseMesh::nodeToActiveSemilocalElemMap(), and MooseMesh::update().
| 
 | protectedinherited | 
A map of all of the current nodes to the elements that they are connected to.
Definition at line 1528 of file MooseMesh.h.
Referenced by MooseMesh::addQuadratureNode(), MooseMesh::nodeToElemMap(), and MooseMesh::update().
| 
 | protectedinherited | 
Definition at line 1529 of file MooseMesh.h.
Referenced by MooseMesh::nodeToElemMap(), and MooseMesh::update().
| 
 | protectedinherited | 
A vector holding the paired boundaries for a regular orthogonal mesh.
Definition at line 1606 of file MooseMesh.h.
Referenced by MooseMesh::detectPairedSidesets(), and MooseMesh::getPairedBoundaryMapping().
| 
 | protectedinherited | 
Can be set to DISTRIBUTED, REPLICATED, or DEFAULT.
Determines whether the underlying libMesh mesh is a ReplicatedMesh or DistributedMesh.
Definition at line 1441 of file MooseMesh.h.
Referenced by MooseMesh::determineUseDistributedMesh(), MooseMesh::getParallelType(), and MooseMesh::setParallelType().
| 
 | protectedinherited | 
Definition at line 1448 of file MooseMesh.h.
Referenced by MooseMesh::determineUseDistributedMesh(), and MooseMesh::isParallelTypeForced().
| 
 | protectedinherited | 
The object's parameters.
Definition at line 366 of file MooseBase.h.
Referenced by AddFVICAction::act(), AddICAction::act(), CreateProblemDefaultAction::act(), CreateProblemAction::act(), SetupMeshAction::act(), ComposeTimeStepperAction::act(), SetupDebugAction::act(), AddAuxKernelAction::act(), AddPeriodicBCAction::act(), CommonOutputAction::act(), FunctorMaterial::addFunctorPropertyByBlocks(), BreakMeshByBlockGeneratorBase::BreakMeshByBlockGeneratorBase(), PiecewiseTabularBase::buildFromFile(), PNGOutput::calculateRescalingValues(), MooseBase::callMooseError(), MooseBase::connectControllableParams(), Console::Console(), MooseApp::copyInputs(), MaterialBase::declareADProperty(), MaterialBase::declareProperty(), FEProblemSolve::FEProblemSolve(), FunctionMaterialBase< is_ad >::FunctionMaterialBase(), FileMeshGenerator::generate(), MooseBase::getBase(), MooseBase::getCheckedPointerParam(), MaterialBase::getGenericZeroMaterialProperty(), MooseBase::getHitNode(), MeshGenerator::getMeshGeneratorNameFromParam(), MeshGenerator::getMeshGeneratorNamesFromParam(), MooseBase::getParam(), MooseBase::hasBase(), MeshGenerator::hasGenerateCSG(), MeshGenerator::hasGenerateData(), AddVariableAction::init(), AdvancedOutput::initExecutionTypes(), Console::initialSetup(), MooseBase::isParamSetByUser(), MooseBase::isParamValid(), MultiApp::keepSolutionDuringRestore(), MooseBase::messagePrefix(), MooseBase::MooseBase(), MooseApp::outputMachineReadableData(), MooseBase::paramError(), MooseBase::parameters(), MooseBase::paramInfo(), MooseBase::paramWarning(), MooseMesh::prepare(), Eigenvalue::prepareSolverOptions(), MooseMesh::setCoordSystem(), MooseMesh::setPartitionerHelper(), SetupMeshAction::setupMesh(), TransientBase::setupTimeIntegrator(), MooseApp::showInputs(), and MooseBase::uniqueName().
| 
 | protectedinherited | 
The partitioner used on this mesh.
Definition at line 1459 of file MooseMesh.h.
Referenced by MooseMesh::partitionerName(), and MooseMesh::setPartitionerHelper().
| 
 | protectedinherited | 
Definition at line 1460 of file MooseMesh.h.
Referenced by MooseMesh::isPartitionerForced(), and MooseMesh::setPartitionerHelper().
| 
 | protectedinherited | 
The number of nodes to consider in the NearestNode neighborhood.
Definition at line 1585 of file MooseMesh.h.
Referenced by MooseMesh::getPatchSize().
| 
 | protectedinherited | 
The patch update strategy.
Definition at line 1594 of file MooseMesh.h.
Referenced by MooseMesh::getPatchUpdateStrategy(), MooseMesh::MooseMesh(), and MooseMesh::setPatchUpdateStrategy().
| 
 | protectedinherited | 
The MooseApp that owns the PerfGraph.
Definition at line 124 of file PerfGraphInterface.h.
Referenced by PerfGraphInterface::perfGraph().
| 
 | protectedinherited | 
A prefix to use for all sections.
Definition at line 127 of file PerfGraphInterface.h.
Referenced by PerfGraphInterface::timedSectionName().
| 
 | protectedinherited | 
Definition at line 1570 of file MooseMesh.h.
Referenced by MooseMesh::addQuadratureNode(), MooseMesh::clearQuadratureNodes(), and MooseMesh::queryNodePtr().
| 
 | protectedinherited | 
The elements that were just refined.
Definition at line 1498 of file MooseMesh.h.
Referenced by MooseMesh::cacheChangedLists(), and MooseMesh::refinedElementRange().
| 
 | protectedinherited | 
Boolean indicating whether this mesh was detected to be regular and orthogonal.
Definition at line 1600 of file MooseMesh.h.
Referenced by MooseMesh::addPeriodicVariable(), MooseMesh::detectOrthogonalDimRanges(), GeneratedMesh::GeneratedMesh(), MooseMesh::getPairedBoundaryMapping(), MooseMesh::isRegularOrthogonal(), and MooseMesh::prepared().
| 
 | protectedinherited | 
The list of active geometric relationship managers (bound to the underlying MeshBase object).
Definition at line 1434 of file MooseMesh.h.
| 
 | protectedinherited | 
Reference to the application.
Definition at line 234 of file Restartable.h.
Referenced by Restartable::registerRestartableDataOnApp(), and Restartable::registerRestartableNameWithFilterOnApp().
| 
 | protectedinherited | 
Flag for toggling read only status (see ReporterData)
Definition at line 243 of file Restartable.h.
Referenced by Restartable::registerRestartableDataOnApp().
| 
 | protectedinherited | 
The system name this object is in.
Definition at line 237 of file Restartable.h.
Referenced by Restartable::restartableName().
| 
 | protectedinherited | 
The thread ID for this object.
Definition at line 240 of file Restartable.h.
Referenced by Restartable::declareRestartableDataHelper().
| 
 | protectedinherited | 
Used for generating the semilocal node range.
Definition at line 1511 of file MooseMesh.h.
Referenced by MooseMesh::isSemiLocal(), and MooseMesh::updateActiveSemiLocalNodeRange().
| 
 | protectedinherited | 
Whether or not skip remote deletion and repartition after uniform refinements.
Definition at line 1486 of file MooseMesh.h.
Referenced by MooseMesh::setUniformRefineLevel(), and MooseMesh::skipDeletionRepartitionAfterRefine().
| 
 | protectedinherited | 
Whether or not to skip uniform refinements when using a pre-split mesh.
Definition at line 1483 of file MooseMesh.h.
Referenced by MooseMesh::skipRefineWhenUseSplit().
| 
 | protectedinherited | 
The type of this class.
Definition at line 360 of file MooseBase.h.
Referenced by ExplicitTimeIntegrator::ExplicitTimeIntegrator(), FEProblemSolve::FEProblemSolve(), FillBetweenSidesetsGenerator::generate(), FillBetweenCurvesGenerator::generate(), FillBetweenPointVectorsGenerator::generate(), ExplicitTimeIntegrator::init(), FEProblemBase::init(), MooseBase::MooseBase(), MooseStaticCondensationPreconditioner::MooseStaticCondensationPreconditioner(), PhysicsBasedPreconditioner::PhysicsBasedPreconditioner(), FEProblemBase::solverTypeString(), and MooseBase::type().
| 
 | protectedinherited | 
The level of uniform refinement requested (set to zero if AMR is disabled)
Definition at line 1480 of file MooseMesh.h.
Referenced by MooseMesh::setUniformRefineLevel(), and MooseMesh::uniformRefineLevel().
| 
 | protectedinherited | 
False by default.
Final value is determined by several factors including the 'distribution' setting in the input file, and whether or not the Mesh file is a Nemesis file.
Definition at line 1446 of file MooseMesh.h.
Referenced by MooseMesh::buildMeshBaseObject(), MooseMesh::buildTypedMesh(), MooseMesh::detectPairedSidesets(), MooseMesh::determineUseDistributedMesh(), MooseMesh::errorIfDistributedMesh(), MooseMesh::ghostGhostedBoundaries(), MooseMesh::init(), MooseMesh::isDistributedMesh(), and MooseMesh::setPartitionerHelper().
| 
 | staticinherited | 
The name of the parameter that contains the MooseApp.
Definition at line 59 of file MooseBase.h.
Referenced by FEProblemBase::addAnyRedistributers(), MeshGenerator::addMeshSubgenerator(), InputParameters::callMooseError(), ActionFactory::create(), Factory::getValidParams(), ActionFactory::getValidParams(), AutomaticMortarGeneration::initOutput(), SetupMeshAction::modifyParamsForUseSplit(), and MortarNodalGeometryOutput::validParams().
| 
 | staticinherited | 
The name of the parameter that indicates an object is a Kokkos functor.
Definition at line 64 of file MooseBase.h.
Referenced by MooseObject::isKokkosObject().
| 
 | staticinherited | 
The name of the parameter that contains the moose system base.
Definition at line 61 of file MooseBase.h.
Referenced by InputParameters::getBase(), InputParameters::hasBase(), and InputParameters::registerBase().
| 
 | staticinherited | 
The name of the parameter that contains the object name.
Definition at line 55 of file MooseBase.h.
Referenced by InputParameterWarehouse::addInputParameters(), MooseObjectUnitTest::buildObjects(), ActionFactory::create(), AppFactory::create(), InputParameters::getObjectName(), AutomaticMortarGeneration::initOutput(), InputParameters::isMooseBaseObject(), MooseMesh::prepare(), CouplingFunctorCheckAction::validParams(), and MooseBase::validParams().
| 
 | staticinherited | 
The name of the parameter that contains the object type.
Definition at line 53 of file MooseBase.h.
Referenced by ActionFactory::create(), AppFactory::create(), InputParameters::getObjectType(), Factory::initialize(), InputParameters::isMooseBaseObject(), InputParameters::queryObjectType(), MooseBase::validParams(), and MortarNodalGeometryOutput::validParams().
| 
 | staticinherited | 
The name of the parameter that contains the unique object name.
Definition at line 57 of file MooseBase.h.
Referenced by InputParameterWarehouse::addInputParameters(), AppFactory::create(), InputParameterWarehouse::removeInputParameters(), MooseBase::uniqueName(), and MooseBase::validParams().
| 
 | inherited | 
Definition at line 82 of file MooseObject.h.
 1.8.14
 1.8.14