#include <MooseVariableFEBase.h>
Public Member Functions | |
MooseVariableFEBase (const InputParameters ¶meters) | |
virtual void | clearDofIndices ()=0 |
Clear out the dof indices. More... | |
virtual void | prepare ()=0 |
Prepare the elemental degrees of freedom. More... | |
virtual void | prepareNeighbor ()=0 |
Prepare the neighbor element degrees of freedom. More... | |
virtual void | prepareLowerD ()=0 |
Prepare a lower dimensional element's degrees of freedom. More... | |
virtual void | prepareAux ()=0 |
virtual void | reinitNode ()=0 |
virtual void | reinitAux ()=0 |
virtual void | reinitAuxNeighbor ()=0 |
virtual void | reinitNodes (const std::vector< dof_id_type > &nodes)=0 |
virtual void | reinitNodesNeighbor (const std::vector< dof_id_type > &nodes)=0 |
virtual Moose::VarFieldType | fieldType () const =0 |
Filed type of this variable. More... | |
virtual bool | isVector () const =0 |
virtual bool | isNodalDefined () const =0 |
Is this variable defined at nodes. More... | |
virtual const dof_id_type & | nodalDofIndex () const =0 |
virtual const dof_id_type & | nodalDofIndexNeighbor () const =0 |
virtual const Elem *const & | currentElem () const =0 |
Current element this variable is evaluated at. More... | |
virtual const std::set< SubdomainID > & | activeSubdomains () const =0 |
The subdomains the variable is active on. More... | |
virtual bool | activeOnSubdomain (SubdomainID subdomain) const =0 |
Is the variable active on the subdomain? More... | |
virtual void | prepareIC ()=0 |
Prepare the initial condition. More... | |
virtual void | computeElemValues ()=0 |
Compute values at interior quadrature points. More... | |
virtual void | computeElemValuesFace ()=0 |
Compute values at facial quadrature points. More... | |
virtual void | computeNeighborValuesFace ()=0 |
Compute values at facial quadrature points for the neighbor. More... | |
virtual void | computeNeighborValues ()=0 |
Compute values at quadrature points for the neighbor. More... | |
virtual void | computeLowerDValues ()=0 |
compute values at quadrature points on the lower dimensional element More... | |
virtual void | computeNodalNeighborValues ()=0 |
Compute nodal values of this variable in the neighbor. More... | |
virtual void | computeNodalValues ()=0 |
Compute nodal values of this variable. More... | |
virtual void | getDofIndices (const Elem *elem, std::vector< dof_id_type > &dof_indices) const =0 |
virtual const std::vector< dof_id_type > & | dofIndicesNeighbor () const =0 |
Get neighbor DOF indices for currently selected element. More... | |
virtual const std::vector< dof_id_type > & | dofIndicesLower () const =0 |
Get dof indices for the current lower dimensional element (this is meaningful when performing mortar FEM) More... | |
virtual unsigned int | numberOfDofsNeighbor ()=0 |
virtual void | insert (NumericVector< Number > &residual)=0 |
virtual void | add (NumericVector< Number > &residual)=0 |
virtual size_t | phiSize () const =0 |
Return phi size. More... | |
virtual size_t | phiFaceSize () const =0 |
Return phiFace size. More... | |
virtual size_t | phiNeighborSize () const =0 |
Return phiNeighbor size. More... | |
virtual size_t | phiFaceNeighborSize () const =0 |
Return phiFaceNeighbor size. More... | |
virtual size_t | phiLowerSize () const =0 |
Return the number of shape functions on the lower dimensional element for this variable. More... | |
unsigned int | number () const |
Get variable number coming from libMesh. More... | |
const FEType & | feType () const |
Get the type of finite element object. More... | |
SystemBase & | sys () |
Get the system this variable is part of. More... | |
const std::string & | name () const override |
Get the variable name. More... | |
const std::vector< dof_id_type > & | allDofIndices () const |
Get all global dofindices for the variable. More... | |
unsigned int | totalVarDofs () |
Moose::VarKindType | kind () const |
Kind of the variable (Nonlinear, Auxiliary, ...) More... | |
void | scalingFactor (Real factor) |
Set the scaling factor for this variable. More... | |
void | scalingFactor (const std::vector< Real > &factor) |
Real | scalingFactor () const |
Get the scaling factor for this variable. More... | |
const std::vector< Real > & | arrayScalingFactor () const |
Order | order () const |
Get the order of this variable Note: Order enum can be implicitly converted to unsigned int. More... | |
unsigned int | count () const |
Get the number of components Note: For standard and vector variables, the number is one. More... | |
virtual bool | isNodal () const |
Is this variable nodal. More... | |
const DofMap & | dofMap () const |
The DofMap associated with the system this variable is in. More... | |
virtual const std::vector< dof_id_type > & | dofIndices () const |
Get local DoF indices. More... | |
std::vector< dof_id_type > | componentDofIndices (const std::vector< dof_id_type > &dof_indices, unsigned int component) const |
Obtain DoF indices of a component with the indices of the 0th component. More... | |
virtual unsigned int | numberOfDofs () const |
Get the number of local DoFs. More... | |
const std::string & | type () const |
Get the type of this object. More... | |
const InputParameters & | parameters () const |
Get the parameters of the object. More... | |
template<typename T > | |
const T & | getParamTempl (const std::string &name) const |
Retrieve a 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... | |
MooseApp & | getMooseApp () const |
Get the MooseApp this object is associated with. More... | |
virtual bool | enabled () const |
Return the enabled status of the object. More... | |
template<typename... Args> | |
void | paramError (const std::string ¶m, Args... args) const |
Emits an error prefixed with the file and line number of the given param (from the input file) along with the full parameter path+name followed by the given args as the message. More... | |
template<typename... Args> | |
void | paramWarning (const std::string ¶m, Args... args) const |
Emits a warning prefixed with the file and line number of the given param (from the input file) along with the full parameter path+name followed by the given args as the message. More... | |
template<typename... Args> | |
void | paramInfo (const std::string ¶m, Args... args) const |
Emits an informational message prefixed with the file and line number of the given param (from the input file) along with the full parameter path+name followed by the given args as the message. More... | |
template<typename... Args> | |
void | mooseError (Args &&... args) const |
template<typename... Args> | |
void | mooseWarning (Args &&... args) const |
template<typename... Args> | |
void | mooseDeprecated (Args &&... args) const |
template<typename... Args> | |
void | mooseInfo (Args &&... args) const |
const std::vector< SubdomainName > & | blocks () const |
Return the block names for this object. More... | |
unsigned int | numBlocks () const |
Return the number of blocks for this object. More... | |
const virtual std::set< SubdomainID > & | blockIDs () const |
Return the block subdomain ids for this object. More... | |
bool | hasBlocks (const SubdomainName &name) const |
Test if the supplied block name is valid for this object. More... | |
bool | hasBlocks (const std::vector< SubdomainName > &names) const |
Test if the supplied vector of block names are valid for this object. More... | |
bool | hasBlocks (const SubdomainID &id) const |
Test if the supplied block ids are valid for this object. More... | |
bool | hasBlocks (const std::vector< SubdomainID > &ids) const |
Test if the supplied vector block ids are valid for this object. More... | |
bool | hasBlocks (const std::set< SubdomainID > &ids) const |
Test if the supplied set of block ids are valid for this object. More... | |
bool | isBlockSubset (const std::set< SubdomainID > &ids) const |
Test if the class block ids are a subset of the supplied objects. More... | |
bool | isBlockSubset (const std::vector< SubdomainID > &ids) const |
Test if the class block ids are a subset of the supplied objects. More... | |
template<typename T > | |
bool | hasBlockMaterialProperty (const std::string &prop_name) |
Check if a material property is valid for all blocks of this object. More... | |
const std::set< SubdomainID > & | meshBlockIDs () const |
Return all of the SubdomainIDs for the mesh. More... | |
virtual bool | blockRestricted () const |
Returns true if this object has been restricted to a boundary. More... | |
void | checkVariable (const MooseVariableFEBase &variable) const |
Helper for checking that the ids for this object are in agreement with the variables on the supplied variable. More... | |
void | buildOutputHideVariableList (std::set< std::string > variable_names) |
Builds hide lists for output objects NOT listed in the 'outputs' parameter. More... | |
const std::set< OutputName > & | getOutputs () |
Get the list of output objects that this class is restricted. More... | |
Static Public Member Functions | |
static InputParameters | validParams () |
Public Attributes | |
const ConsoleStream | _console |
An instance of helper class to write streams to the Console objects. More... | |
Protected Member Functions | |
virtual bool | hasBlockMaterialPropertyHelper (const std::string &prop_name) |
A helper method to allow the Material object to specialize the behavior of hasBlockMaterialProperty. More... | |
void | initializeBlockRestrictable (const MooseObject *moose_object) |
An initialization routine needed for dual constructors. More... | |
Moose::CoordinateSystemType | getBlockCoordSystem () |
Check if the blocks this object operates on all have the same coordinate system, and if so return it. More... | |
Protected Attributes | |
SystemBase & | _sys |
System this variable is part of. More... | |
FEType | _fe_type |
The FEType associated with this variable. More... | |
unsigned int | _var_num |
variable number (from libMesh) More... | |
unsigned int | _index |
variable number within MOOSE More... | |
Moose::VarKindType | _var_kind |
Variable type (see MooseTypes.h) More... | |
SubProblem & | _subproblem |
Problem this variable is part of. More... | |
const Variable & | _variable |
libMesh variable object for this variable More... | |
Assembly & | _assembly |
Assembly data. More... | |
const DofMap & | _dof_map |
DOF map. More... | |
std::vector< dof_id_type > | _dof_indices |
DOF indices. More... | |
MooseMesh & | _mesh |
mesh the variable is active in More... | |
THREAD_ID | _tid |
Thread ID. More... | |
const unsigned int | _count |
Number of variables in the array. More... | |
std::vector< Real > | _scaling_factor |
scaling factor for this variable More... | |
std::string | _var_name |
Variable name. More... | |
const InputParameters & | _pars |
Parameters of this object, references the InputParameters stored in the InputParametersWarehouse. More... | |
MooseApp & | _app |
The MooseApp this object is associated with. More... | |
const std::string & | _type |
The type of this object (the Class name) More... | |
const std::string & | _name |
The name of this object, reference to value stored in InputParameters. More... | |
const bool & | _enabled |
Reference to the "enable" InputParaemters, used by Controls for toggling on/off MooseObjects. More... | |
std::shared_ptr< MaterialData > | _blk_material_data |
Pointer to the MaterialData class for this object. More... | |
Private Member Functions | |
template<typename... Args> | |
std::string | paramErrorMsg (const std::string ¶m, Args... args) const |
Private Attributes | |
std::set< SubdomainID > | _blk_ids |
Set of block ids supplied by the user via the input file (for error reporting) More... | |
std::vector< SubdomainName > | _blocks |
Vector the block names supplied by the user via the input file. More... | |
const bool | _blk_dual_restrictable |
Flag for allowing dual restriction. More... | |
FEProblemBase * | _blk_feproblem |
Pointer to FEProblemBase. More... | |
MooseMesh * | _blk_mesh |
Pointer to Mesh. More... | |
const std::set< BoundaryID > | _empty_boundary_ids |
An empty set for referencing when boundary_ids is not included. More... | |
const std::set< BoundaryID > & | _boundary_ids |
Reference to the boundary_ids, defaults to an empty set if not provided. More... | |
THREAD_ID | _blk_tid |
Thread id for this object. More... | |
const std::string & | _blk_name |
Name of the object. More... | |
MooseApp & | _oi_moose_app |
Reference the the MooseApp; neede for access to the OutputWarehouse. More... | |
OutputWarehouse & | _oi_output_warehouse |
Reference to the OutputWarehouse for populating the Output object hide lists. More... | |
std::set< OutputName > | _oi_outputs |
The set of Output object names listed in the 'outputs' parameter. More... | |
Definition at line 27 of file MooseVariableFEBase.h.
MooseVariableFEBase::MooseVariableFEBase | ( | const InputParameters & | parameters | ) |
Definition at line 20 of file MooseVariableFEBase.C.
|
pure virtual |
Is the variable active on the subdomain?
subdomain | The subdomain id in question |
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
Referenced by ComputeFullJacobianThread::computeFaceJacobian(), ComputeFullJacobianThread::computeInternalFaceJacobian(), ComputeFullJacobianThread::computeJacobian(), FlagElementsThread::onElement(), and ComputeDiracThread::onElement().
|
pure virtual |
The subdomains the variable is active on.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
Referenced by SetupResidualDebugAction::act(), BlockRestrictable::checkVariable(), and ConstraintWarehouse::subdomainsCovered().
|
pure virtual |
|
inherited |
Get all global dofindices for the variable.
Definition at line 111 of file MooseVariableBase.C.
Referenced by FEProblemBase::addJacobianBlock(), NonlocalIntegratedBC::computeNonlocalJacobian(), NonlocalKernel::computeNonlocalJacobian(), NonlocalIntegratedBC::computeNonlocalOffDiagJacobian(), NonlocalKernel::computeNonlocalOffDiagJacobian(), FEProblemBase::prepare(), Assembly::prepareNonlocal(), Assembly::prepareVariableNonlocal(), and MooseVariableBase::totalVarDofs().
|
inlineinherited |
Definition at line 86 of file MooseVariableBase.h.
Referenced by Assembly::addJacobianBlock(), Assembly::addJacobianBlockNonlocal(), Assembly::addJacobianNeighbor(), Assembly::cacheJacobianBlock(), and Assembly::cacheJacobianBlockNonzero().
|
virtualinherited |
Return the block subdomain ids for this object.
Definition at line 174 of file BlockRestrictable.C.
Referenced by BlockRestrictable::getBlockCoordSystem(), MaterialBase::getZeroMaterialProperty(), BlockRestrictable::hasBlockMaterialPropertyHelper(), and MaterialBase::registerPropName().
|
virtualinherited |
Returns true if this object has been restricted to a boundary.
Definition at line 162 of file BlockRestrictable.C.
Referenced by BlockRestrictable::checkVariable(), BlockRestrictable::getBlockCoordSystem(), and BlockRestrictable::hasBlockMaterialPropertyHelper().
|
inherited |
Return the block names for this object.
Note, if the 'blocks' input parameter was not utilized this will return an empty vector.
Definition at line 168 of file BlockRestrictable.C.
Referenced by MaterialOutputAction::getParams().
|
inherited |
Builds hide lists for output objects NOT listed in the 'outputs' parameter.
variable_names | A set of variables for which the 'outputs' parameter controls |
By default this is called by the constructor and passes the block name as the list of variables. This needs to be called explicitly if the build_list flag is set to False in the constructor. The latter cases is needed by the Material object to work correctly with the automatic material output capability.
Definition at line 64 of file OutputInterface.C.
Referenced by OutputInterface::OutputInterface().
|
inherited |
Helper for checking that the ids for this object are in agreement with the variables on the supplied variable.
variable | The variable to check against. |
Definition at line 314 of file BlockRestrictable.C.
|
pure virtual |
Clear out the dof indices.
We do this in case this variable is not going to be prepared at all...
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
|
inherited |
Obtain DoF indices of a component with the indices of the 0th component.
Definition at line 129 of file MooseVariableBase.C.
Referenced by Assembly::addJacobianBlock(), Assembly::cacheJacobianBlock(), and Assembly::cacheJacobianBlockNonzero().
|
pure virtual |
Compute values at interior quadrature points.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, MooseVariableFE< Real >, and MooseVariableConstMonomial.
|
pure virtual |
Compute values at facial quadrature points.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, MooseVariableFE< Real >, and MooseVariableConstMonomial.
|
pure virtual |
compute values at quadrature points on the lower dimensional element
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
|
pure virtual |
Compute values at quadrature points for the neighbor.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, MooseVariableFE< Real >, and MooseVariableConstMonomial.
|
pure virtual |
Compute values at facial quadrature points for the neighbor.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, MooseVariableFE< Real >, and MooseVariableConstMonomial.
|
pure virtual |
Compute nodal values of this variable in the neighbor.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
|
pure virtual |
Compute nodal values of this variable.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
|
inlineinherited |
Get the number of components Note: For standard and vector variables, the number is one.
Definition at line 98 of file MooseVariableBase.h.
Referenced by Assembly::addJacobianBlock(), SystemBase::addVariableToZeroOnJacobian(), SystemBase::addVariableToZeroOnResidual(), ArrayConstantIC::ArrayConstantIC(), ArrayFunctionIC::ArrayFunctionIC(), Assembly::cacheJacobianBlock(), Assembly::cacheJacobianBlockNonzero(), ArrayNodalBC::computeJacobian(), Kernel::computeOffDiagJacobian(), ArrayNodalBC::computeOffDiagJacobian(), ArrayDiffusion::computeQpJacobian(), ArrayReaction::computeQpJacobian(), ArrayTimeDerivative::computeQpJacobian(), ArrayKernel::computeQpJacobian(), ArrayIntegratedBC::computeQpJacobian(), ArrayNodalBC::computeQpJacobian(), ArrayIntegratedBC::computeQpOffDiagJacobian(), ArrayKernel::computeQpOffDiagJacobian(), ArrayNodalBC::computeQpOffDiagJacobian(), ArrayDGKernel::computeQpOffDiagJacobian(), Kernel::computeQpOffDiagJacobianArray(), ArrayKernel::computeQpOffDiagJacobianScalar(), ArrayIntegratedBC::computeQpOffDiagJacobianScalar(), ArrayDiffusion::computeQpResidual(), ArrayReaction::computeQpResidual(), ArrayTimeDerivative::computeQpResidual(), ArrayFunctionIC::gradient(), AdvancedOutput::initAvailableLists(), AdvancedOutput::initShowHideLists(), Assembly::prepareBlock(), Assembly::prepareBlockNonlocal(), Assembly::prepareJacobianBlock(), Assembly::prepareLowerD(), Assembly::prepareNeighbor(), Assembly::prepareNonlocal(), Assembly::prepareVariable(), Assembly::prepareVariableNonlocal(), EigenProblem::scaleEigenvector(), MultiAppFieldTransfer::transfer(), MultiAppFieldTransfer::transferDofObject(), and ArrayFunctionIC::value().
|
pure virtual |
Current element this variable is evaluated at.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
|
inlinevirtualinherited |
Get local DoF indices.
Reimplemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
Definition at line 114 of file MooseVariableBase.h.
Referenced by Assembly::addJacobianCoupledVarPair(), Assembly::cacheJacobianCoupledVarPair(), AuxScalarKernel::compute(), ADMortarConstraint< compute_stage >::computeJacobian(), MortarConstraint::computeJacobian(), VectorIntegratedBC::computeJacobianBlock(), ArrayIntegratedBC::computeJacobianBlock(), NonlocalIntegratedBC::computeJacobianBlock(), NonlocalKernel::computeNonlocalOffDiagJacobian(), NonlocalIntegratedBC::computeNonlocalOffDiagJacobian(), NonlocalKernel::computeOffDiagJacobian(), MultiAppPostprocessorToAuxScalarTransfer::execute(), MultiAppScalarToAuxScalarTransfer::execute(), ScalarVariable::getValue(), TableOutput::outputScalarVariables(), Nemesis::outputScalarVariables(), Exodus::outputScalarVariables(), Assembly::prepareJacobianBlock(), Assembly::prepareLowerD(), Assembly::prepareNeighbor(), Assembly::prepareNonlocal(), Assembly::prepareVariable(), Assembly::prepareVariableNonlocal(), and FEProblemBase::projectSolution().
|
pure virtual |
Get dof indices for the current lower dimensional element (this is meaningful when performing mortar FEM)
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
Referenced by ADMortarConstraint< compute_stage >::computeJacobian(), MortarConstraint::computeJacobian(), and Assembly::prepareLowerD().
|
pure virtual |
Get neighbor DOF indices for currently selected element.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
Referenced by ADMortarConstraint< compute_stage >::computeJacobian(), MortarConstraint::computeJacobian(), NodeFaceConstraint::computeOffDiagJacobian(), Assembly::prepareLowerD(), and Assembly::prepareNeighbor().
|
inlineinherited |
The DofMap associated with the system this variable is in.
Definition at line 109 of file MooseVariableBase.h.
Referenced by AuxScalarKernel::compute(), and ScalarVariable::getValue().
|
inlinevirtualinherited |
Return the enabled status of the object.
Reimplemented in EigenKernel.
Definition at line 110 of file MooseObject.h.
Referenced by EigenKernel::enabled().
|
inlineinherited |
Get the type of finite element object.
Definition at line 53 of file MooseVariableBase.h.
Referenced by ADDGKernel< compute_stage >::ADDGKernel(), AuxiliarySystem::addVariable(), ADIntegratedBCTempl< T, compute_stage >::ADIntegratedBCTempl(), ADKernelTempl< T, compute_stage >::ADKernelTempl(), ArrayDGKernel::ArrayDGKernel(), ArrayIntegratedBC::ArrayIntegratedBC(), ArrayKernel::ArrayKernel(), Assembly::adGradPhi< Real, ComputeStage::JACOBIAN >(), Assembly::adGradPhi< RealVectorValue, ComputeStage::JACOBIAN >(), GapValueAux::computeValue(), DGKernel::DGKernel(), MultiAppNearestNodeTransfer::execute(), moose::internal::incompatVarMsg(), AdvancedOutput::initAvailableLists(), MultiAppProjectionTransfer::initialSetup(), AdvancedOutput::initShowHideLists(), IntegratedBC::IntegratedBC(), InterfaceKernelTempl< T >::InterfaceKernelTempl(), Kernel::Kernel(), NodalBC::NodalBC(), NodalKernel::NodalKernel(), SolutionUserObject::pointValueWrapper(), MultiAppFieldTransfer::transfer(), and VectorNodalBC::VectorNodalBC().
|
pure virtual |
Filed type of this variable.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
Referenced by ArrayDGKernel::computeOffDiagElemNeighJacobian(), Assembly::copyFaceShapes(), Assembly::copyNeighborShapes(), Assembly::copyShapes(), SubProblem::getVariableHelper(), and MultiAppFieldTransfer::transfer().
|
protectedinherited |
Check if the blocks this object operates on all have the same coordinate system, and if so return it.
Definition at line 292 of file BlockRestrictable.C.
|
inlineinherited |
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 91 of file MooseObject.h.
|
pure virtual |
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
Referenced by NodeElemConstraint::getConnectedDofIndices(), and NodeFaceConstraint::getConnectedDofIndices().
|
inlineinherited |
Get the MooseApp this object is associated with.
Definition at line 105 of file MooseObject.h.
Referenced by MortarData::createMortarInterface(), Executioner::Executioner(), and ConsoleUtils::outputMeshInformation().
|
inherited |
Get the list of output objects that this class is restricted.
Definition at line 97 of file OutputInterface.C.
|
inherited |
Retrieve a parameter for the object.
name | The name of the parameter |
Definition at line 208 of file MooseObject.h.
Referenced by FEProblemBase::addMaterialHelper(), ConstraintWarehouse::addObject(), EigenKernel::EigenKernel(), AttribThread::initFrom(), BlockRestrictable::initializeBlockRestrictable(), BoundaryRestrictable::initializeBoundaryRestrictable(), Console::initialSetup(), ConsoleUtils::outputExecutionInformation(), and TimePeriod::TimePeriod().
|
inherited |
Check if a material property is valid for all blocks of this object.
This method returns true if the supplied property name has been declared in a Material object on the block ids for this object.
T | The type of material property |
prop_name | the name of the property to query |
Definition at line 256 of file BlockRestrictable.h.
|
protectedvirtualinherited |
A helper method to allow the Material object to specialize the behavior of hasBlockMaterialProperty.
It also avoid circular #include problems.
Definition at line 256 of file BlockRestrictable.C.
Referenced by BlockRestrictable::hasBlockMaterialProperty().
|
inherited |
Test if the supplied set of block ids are valid for this object.
ids | A std::set of SubdomainIDs to check |
Definition at line 218 of file BlockRestrictable.C.
|
inherited |
Test if the supplied vector block ids are valid for this object.
ids | A vector of SubdomainIDs ids to check |
Definition at line 211 of file BlockRestrictable.C.
|
inherited |
Test if the supplied vector of block names are valid for this object.
names | A vector of SubdomainNames to check |
Definition at line 196 of file BlockRestrictable.C.
|
inherited |
Test if the supplied block ids are valid for this object.
id | A SubdomainID to check |
Definition at line 202 of file BlockRestrictable.C.
|
inherited |
Test if the supplied block name is valid for this object.
name | A SubdomainName to check |
Definition at line 186 of file BlockRestrictable.C.
Referenced by CentroidMultiApp::fillPositions(), and BlockRestrictable::hasBlocks().
|
protectedinherited |
An initialization routine needed for dual constructors.
Definition at line 79 of file BlockRestrictable.C.
Referenced by BlockRestrictable::BlockRestrictable().
|
pure virtual |
|
inherited |
Test if the class block ids are a subset of the supplied objects.
ids | A std::set of Subdomains to check |
Definition at line 227 of file BlockRestrictable.C.
Referenced by BlockRestrictable::checkVariable(), and BlockRestrictable::isBlockSubset().
|
inherited |
Test if the class block ids are a subset of the supplied objects.
ids | A std::vector of Subdomains to check |
Definition at line 243 of file BlockRestrictable.C.
|
inlinevirtualinherited |
Is this variable nodal.
Reimplemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
Definition at line 104 of file MooseVariableBase.h.
Referenced by InitialConditionWarehouse::addObject(), MooseVariableBase::componentDofIndices(), and SystemBase::copyVars().
|
pure virtual |
Is this variable defined at nodes.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
|
inlineinherited |
Test if the supplied parameter is valid.
name | The name of the parameter to test |
Definition at line 100 of file MooseObject.h.
Referenced by AdvancedOutput::AdvancedOutput(), BicubicSplineFunction::BicubicSplineFunction(), GeneratedMesh::buildMesh(), DistributedGeneratedMesh::buildMesh(), CartesianMeshGenerator::CartesianMeshGenerator(), LibmeshPartitioner::clone(), OversampleOutput::cloneMesh(), ConstantVectorPostprocessor::ConstantVectorPostprocessor(), CSVReader::CSVReader(), DGKernelBase::DGKernelBase(), MultiAppNearestNodeTransfer::execute(), Executioner::Executioner(), Exodus::Exodus(), FEProblemBase::FEProblemBase(), FileOutput::FileOutput(), MultiApp::fillPositions(), FunctionDT::FunctionDT(), ExtraNodesetGenerator::generate(), RenameBoundaryGenerator::generate(), RenameBlockGenerator::generate(), BreakBoundaryOnSubdomainGenerator::generate(), ElementSubdomainIDGenerator::generate(), LowerDBlockFromSidesetGenerator::generate(), MeshSideSetGenerator::generate(), GeneratedMeshGenerator::generate(), ParsedSubdomainMeshGenerator::generate(), MeshExtruderGenerator::generate(), SubdomainBoundingBoxGenerator::generate(), MultiAppNearestNodeTransfer::getLocalEntities(), MultiAppNearestNodeTransfer::getLocalEntitiesAndComponents(), MeshGenerator::getMesh(), MultiAppNearestNodeTransfer::getNearestNode(), EigenExecutionerBase::init(), IterationAdaptiveDT::init(), AdvancedOutput::initExecutionTypes(), BlockRestrictable::initializeBlockRestrictable(), BoundaryRestrictable::initializeBoundaryRestrictable(), SolutionScalarAux::initialSetup(), SolutionAux::initialSetup(), MooseParsedVectorFunction::initialSetup(), Console::initialSetup(), Receiver::initialSetup(), SolutionFunction::initialSetup(), MooseParsedGradFunction::initialSetup(), MooseParsedFunction::initialSetup(), AdvancedOutput::initialSetup(), AdvancedOutput::initPostprocessorOrVectorPostprocessorLists(), IterationAdaptiveDT::IterationAdaptiveDT(), LeastSquaresFit::LeastSquaresFit(), LibmeshPartitioner::LibmeshPartitioner(), MatDiffusionBase< Real >::MatDiffusionBase(), MeshGeneratorMesh::MeshGeneratorMesh(), BreakBoundaryOnSubdomain::modify(), MeshExtruder::modify(), MeshSideSet::modify(), LowerDBlockFromSideset::modify(), AssignElementSubdomainID::modify(), ParsedSubdomainMeshModifier::modify(), RenameBlock::modify(), SubdomainBoundingBox::modify(), MooseMesh::MooseMesh(), EigenExecutionerBase::normalizeSolution(), Output::Output(), PetscOutput::PetscOutput(), PiecewiseBase::PiecewiseBase(), SolutionUserObject::readExodusII(), RenameBlock::RenameBlock(), RenameBlockGenerator::RenameBlockGenerator(), RenameBoundaryGenerator::RenameBoundaryGenerator(), SolutionUserObject::SolutionUserObject(), and TimePeriod::TimePeriod().
|
pure virtual |
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
Referenced by MortarConstraint::computeJacobian().
|
inlineinherited |
Kind of the variable (Nonlinear, Auxiliary, ...)
Definition at line 74 of file MooseVariableBase.h.
Referenced by ShapeUserObject< SideUserObject >::coupled(), Coupleable::coupled(), AuxKernelTempl< ComputeValueType >::coupledDot(), and AuxKernelTempl< ComputeValueType >::coupledDotDu().
|
inherited |
Return all of the SubdomainIDs for the mesh.
Definition at line 250 of file BlockRestrictable.C.
Referenced by BlockRestrictable::checkVariable(), BlockRestrictable::getBlockCoordSystem(), and BlockRestrictable::hasBlockMaterialPropertyHelper().
|
inlineinherited |
Definition at line 156 of file MooseObject.h.
Referenced by FEProblemBase::addArrayVariable(), FEProblemBase::addAuxArrayVariable(), FEProblemBase::addAuxScalarVariable(), FEProblemBase::addAuxVariable(), FEProblemBase::addScalarVariable(), FEProblemBase::addVariable(), ADFunctionPresetBC< compute_stage >::ADFunctionPresetBC(), ADPresetBC< compute_stage >::ADPresetBC(), ADPresetNodalBC< compute_stage >::ADPresetNodalBC(), FEProblemBase::advanceMultiApps(), MultiApp::appProblem(), MooseMesh::buildSideList(), ChangeOverTimestepPostprocessor::ChangeOverTimestepPostprocessor(), FEProblemBase::computeResidual(), MaterialBase::declarePropertyOlderTempl(), MaterialBase::declarePropertyOldTempl(), MooseMesh::elem(), MultiAppTransfer::execFlags(), UserForcingFunction::f(), FaceFaceConstraint< compute_stage >::FaceFaceConstraint(), FunctionDT::FunctionDT(), FunctionPresetBC::FunctionPresetBC(), RandomICBase::generateRandom(), Control::getExecuteOptions(), FEProblemBase::getNonlinearSystem(), Sampler::getSamples(), FEProblemBase::getUserObjects(), FEProblemBase::getVectorPostprocessorValue(), FEProblemBase::getVectorPostprocessorValueOld(), MatDiffusionBase< Real >::MatDiffusionBase(), NodalScalarKernel::NodalScalarKernel(), MooseMesh::node(), PercentChangePostprocessor::PercentChangePostprocessor(), PresetBC::PresetBC(), PresetNodalBC::PresetNodalBC(), Sampler::rand(), ReferenceResidualProblem::ReferenceResidualProblem(), MooseMesh::setBoundaryToNormalMap(), Exodus::setOutputDimension(), and UserForcingFunction::UserForcingFunction().
|
inlineinherited |
Definition at line 141 of file MooseObject.h.
Referenced by GridPartitioner::_do_partition(), PetscExternalPartitioner::_do_partition(), FEProblemBase::addConstraint(), ADDGKernel< compute_stage >::ADDGKernel(), FEProblemBase::addInitialCondition(), FEProblem::addLineSearch(), FEProblemBase::addLineSearch(), FEProblemBase::addOutput(), DiracKernel::addPointWithValidId(), FEProblemBase::addPostprocessor(), MooseMesh::addQuadratureNode(), FEProblemBase::addVectorPostprocessor(), MultiAppConservativeTransfer::adjustTransferedSolution(), MultiAppConservativeTransfer::adjustTransferedSolutionNearestPoint(), ADKernelTempl< T, compute_stage >::ADKernelTempl(), ADPiecewiseLinearInterpolationMaterial< compute_stage >::ADPiecewiseLinearInterpolationMaterial(), Output::advancedExecuteOn(), MooseVariableBase::allDofIndices(), MultiApp::appPostprocessorValue(), MultiApp::appProblem(), MultiApp::appProblemBase(), MultiApp::appUserObjectBase(), ArrayConstantIC::ArrayConstantIC(), ArrayDGKernel::ArrayDGKernel(), ArrayDiffusion::ArrayDiffusion(), ArrayFunctionIC::ArrayFunctionIC(), ArrayReaction::ArrayReaction(), ArrayTimeDerivative::ArrayTimeDerivative(), Function::average(), Axisymmetric2D3DSolutionFunction::Axisymmetric2D3DSolutionFunction(), BicubicSplineFunction::BicubicSplineFunction(), BoundingValueElementDamper::BoundingValueElementDamper(), BoundingValueNodalDamper::BoundingValueNodalDamper(), BoundsAux::BoundsAux(), BreakMeshByBlockGenerator::BreakMeshByBlockGenerator(), BreakMeshByBlockGeneratorBase::BreakMeshByBlockGeneratorBase(), MooseMesh::buildCoarseningMap(), PiecewiseBase::buildFromFile(), PiecewiseBase::buildFromXY(), PiecewiseLinearBase::buildInterpolation(), TiledMesh::buildMesh(), FileMesh::buildMesh(), DistributedGeneratedMesh::buildMesh(), GeneratedMesh::buildMesh(), SpiralAnnularMesh::buildMesh(), ImageMeshGenerator::buildMesh3D(), ImageMesh::buildMesh3D(), MooseMesh::buildMeshBaseObject(), MooseMesh::buildRefinementMap(), MooseMesh::buildSideList(), CartesianMeshGenerator::CartesianMeshGenerator(), ChangeOverTimePostprocessor::ChangeOverTimePostprocessor(), EigenExecutionerBase::chebyshev(), SubProblem::checkBlockMatProps(), SubProblem::checkBoundaryMatProps(), FEProblemBase::checkCoordinateSystems(), FEProblemBase::checkDependMaterialsHelper(), FEProblemBase::checkDisplacementOrders(), MaterialBase::checkExecutionStage(), BreakMeshByBlockBase::checkInputParameter(), Steady::checkIntegrity(), EigenExecutionerBase::checkIntegrity(), ExplicitTimeIntegrator::checkLinearConvergence(), FEProblemBase::checkProblemIntegrity(), MaterialBase::checkStatefulSanity(), FEProblemBase::checkUserObjects(), MultiAppTransfer::checkVariable(), LibmeshPartitioner::clone(), MooseMesh::clone(), ComparisonPostprocessor::comparisonIsTrue(), CompositeFunction::CompositeFunction(), ElementLpNormAux::compute(), ElementH1ErrorFunctionAux::compute(), NodalPatchRecovery::compute(), KernelBase::computeADOffDiagJacobian(), BlockWeightedPartitioner::computeElementWeight(), ArrayDGKernel::computeElemNeighJacobian(), ArrayDGKernel::computeElemNeighResidual(), TimeSequenceStepperBase::computeFailedDT(), IterationAdaptiveDT::computeFailedDT(), TimeStepper::computeFailedDT(), HistogramVectorPostprocessor::computeHistogram(), ArrayKernel::computeJacobian(), ArrayIntegratedBC::computeJacobian(), ArrayIntegratedBC::computeJacobianBlock(), ArrayDGKernel::computeOffDiagElemNeighJacobian(), ArrayKernel::computeOffDiagJacobian(), MaterialBase::computeProperties(), CoupledTiedValueConstraint::computeQpJacobian(), TiedValueConstraint::computeQpJacobian(), LinearNodalConstraint::computeQpJacobian(), EqualValueBoundaryConstraint::computeQpJacobian(), EqualValueEmbeddedConstraint::computeQpJacobian(), CoupledTiedValueConstraint::computeQpOffDiagJacobian(), EqualValueEmbeddedConstraint::computeQpOffDiagJacobian(), KernelValue::computeQpResidual(), ArrayKernel::computeResidual(), ArrayIntegratedBC::computeResidual(), FEProblemBase::computeResidualInternal(), FEProblemBase::computeResidualTag(), FEProblemBase::computeResidualType(), StatisticsVectorPostprocessor::computeStatValue(), MaterialBase::computeSubdomainProperties(), ActuallyExplicitEuler::computeTimeDerivatives(), ExplicitEuler::computeTimeDerivatives(), ImplicitEuler::computeTimeDerivatives(), BDF2::computeTimeDerivatives(), NewmarkBeta::computeTimeDerivatives(), CrankNicolson::computeTimeDerivatives(), LStableDirk2::computeTimeDerivatives(), LStableDirk3::computeTimeDerivatives(), ImplicitMidpoint::computeTimeDerivatives(), ExplicitTVDRK2::computeTimeDerivatives(), AStableDirk4::computeTimeDerivatives(), LStableDirk4::computeTimeDerivatives(), ExplicitRK2::computeTimeDerivatives(), PenetrationAux::computeValue(), ConcentricCircleMesh::ConcentricCircleMesh(), ConditionalEnableControl::ConditionalEnableControl(), TimeStepper::constrainStep(), CoupledForce::CoupledForce(), CoupledForceNodalKernel::CoupledForceNodalKernel(), SidesetInfoVectorPostprocessor::dataHelper(), DebugResidualAux::DebugResidualAux(), FunctorRelationshipManager::delete_remote_elements(), BicubicSplineFunction::derivative(), DerivativeSumMaterial::DerivativeSumMaterial(), DGKernel::DGKernel(), FunctorRelationshipManager::dofmap_reinit(), FEProblemBase::duplicateVariableCheck(), EigenProblem::EigenProblem(), Eigenvalues::Eigenvalues(), ElementalVariableValue::ElementalVariableValue(), ElementIntegerAux::ElementIntegerAux(), ElementQualityAux::ElementQualityAux(), MooseMesh::errorIfDistributedMesh(), SolutionUserObject::evalMeshFunction(), SolutionUserObject::evalMeshFunctionGradient(), SolutionUserObject::evalMultiValuedMeshFunction(), SolutionUserObject::evalMultiValuedMeshFunctionGradient(), MultiAppPostprocessorTransfer::execute(), DiscreteElementUserObject::execute(), MultiAppPostprocessorInterpolationTransfer::execute(), MultiAppVariableValueSamplePostprocessorTransfer::execute(), ElementQualityChecker::execute(), NodalValueSampler::execute(), GreaterThanLessThanPostprocessor::execute(), MultiAppInterpolationTransfer::execute(), MultiAppUserObjectTransfer::execute(), InterfaceQpValueUserObject::execute(), PointValue::execute(), MultiAppPostprocessorToAuxScalarTransfer::execute(), MultiAppScalarToAuxScalarTransfer::execute(), MultiAppVariableValueSampleTransfer::execute(), FindValueOnLine::execute(), MultiAppNearestNodeTransfer::execute(), TimeExtremeValue::execute(), VectorPostprocessorComparison::execute(), LeastSquaresFit::execute(), LeastSquaresFitHistory::execute(), FEProblemBase::executeControls(), MultiAppVectorPostprocessorTransfer::executeFromMultiapp(), MultiAppVectorPostprocessorTransfer::executeToMultiapp(), Exodus::Exodus(), ExplicitSSPRungeKutta::ExplicitSSPRungeKutta(), FileOutput::FileOutput(), CentroidMultiApp::fillPositions(), MultiApp::fillPositions(), VerifyElementUniqueID::finalize(), VerifyNodalUniqueID::finalize(), DiscreteElementUserObject::finalize(), ElementQualityChecker::finalize(), MemoryUsage::finalize(), PointSamplerBase::finalize(), NearestPointIntegralVariablePostprocessor::finalize(), Transfer::find_sys(), BreakMeshByBlockBase::findFreeBoundaryId(), BreakMeshByBlockGeneratorBase::findFreeBoundaryId(), FunctionDT::FunctionDT(), FunctionMaterialBase::FunctionMaterialBase(), ParsedMaterialHelper::functionParse(), FunctionScalarAux::FunctionScalarAux(), FunctionScalarIC::FunctionScalarIC(), GapValueAux::GapValueAux(), WorkBalance::gather(), ExtraNodesetGenerator::generate(), RenameBoundaryGenerator::generate(), RenameBlockGenerator::generate(), ElementSubdomainIDGenerator::generate(), GeneratedMeshGenerator::generate(), CombinerGenerator::generate(), SideSetsFromBoundingBoxGenerator::generate(), MeshExtruderGenerator::generate(), StackGenerator::generate(), SpiralAnnularMeshGenerator::generate(), PatternedMeshGenerator::generate(), SubdomainBoundingBoxGenerator::generate(), BoundingBoxNodeSetGenerator::generate(), GeneratedMesh::GeneratedMesh(), GeneratedMeshGenerator::GeneratedMeshGenerator(), RandomICBase::generateRandom(), GenericConstantMaterial::GenericConstantMaterial(), GenericFunctionMaterial::GenericFunctionMaterial(), DisplacedProblem::getArrayVariable(), FEProblemBase::getArrayVariable(), MooseMesh::getBoundaryID(), MultiApp::getBoundingBox(), MooseMesh::getCoarseningMap(), Control::getControllableParameterByName(), FEProblemBase::getCoordSystem(), PiecewiseConstant::getDirection(), FEProblemBase::getDistribution(), GhostingUserObject::getElementalValue(), ElementGenerator::getElemType(), MultiApp::getExecutioner(), FEProblemBase::getFunction(), SolutionUserObject::getLocalVarIndex(), SubProblem::getMatrixTagID(), AnnularMesh::getMaxInDimension(), DistributedGeneratedMesh::getMaxInDimension(), GeneratedMesh::getMaxInDimension(), FEProblemBase::getMaxQps(), FEProblemBase::getMaxShapeFunctions(), AnnularMesh::getMinInDimension(), DistributedGeneratedMesh::getMinInDimension(), GeneratedMesh::getMinInDimension(), MooseMesh::getNodeBlockIds(), MooseMesh::getNodeList(), FEProblemBase::getNonlinearSystem(), MooseMesh::getPairedBoundaryMapping(), ImageMesh::GetPixelInfo(), ImageMeshGenerator::GetPixelInfo(), InterfaceQpValueUserObject::getQpValue(), MaterialStdVectorAux::getRealValue(), MooseMesh::getRefinementMap(), FEProblemBase::getSampler(), DisplacedProblem::getScalarVariable(), FEProblemBase::getScalarVariable(), DisplacedProblem::getStandardVariable(), FEProblemBase::getStandardVariable(), MooseMesh::getSubdomainBoundaryIds(), MooseMesh::getSubdomainID(), DisplacedProblem::getSystem(), FEProblemBase::getSystem(), FEProblemBase::getUserObjectBase(), FEProblemBase::getUserObjectTempl(), NumRelationshipManagers::getValue(), PerformanceData::getValue(), Residual::getValue(), PerfGraphData::getValue(), LineValueSampler::getValue(), FindValueOnLine::getValueAtPoint(), SubProblem::getVariableHelper(), SubProblem::getVectorTagID(), DisplacedProblem::getVectorVariable(), FEProblemBase::getVectorVariable(), GhostingAux::GhostingAux(), MultiApp::globalAppToLocal(), MooseParsedVectorFunction::gradient(), AdvancedOutput::hasOutputHelper(), CrankNicolson::init(), CSVTimeSequenceStepper::init(), EigenExecutionerBase::init(), IterationAdaptiveDT::init(), Transient::init(), MooseMesh::init(), Sampler::init(), FEProblemBase::init(), NumPicardIterations::initialize(), PiecewiseLinearBase::initialSetup(), MultiAppConservativeTransfer::initialSetup(), FullSolveMultiApp::initialSetup(), ReferenceResidualProblem::initialSetup(), SolutionScalarAux::initialSetup(), SolutionAux::initialSetup(), Axisymmetric2D3DSolutionFunction::initialSetup(), Exodus::initialSetup(), SolutionFunction::initialSetup(), SolutionUserObject::initialSetup(), FEProblemBase::initialSetup(), AdvancedOutput::initOutputList(), AdvancedOutput::initShowHideLists(), MaterialBase::initStatefulProperties(), Function::integral(), InterfaceKernelTempl< T >::InterfaceKernelTempl(), InterfaceTimeKernel::InterfaceTimeKernel(), AugmentSparsityOnInterface::internalInit(), EigenExecutionerBase::inversePowerIteration(), InversePowerMethod::InversePowerMethod(), IterationAdaptiveDT::IterationAdaptiveDT(), LayeredSideIntegral::LayeredSideIntegral(), LeastSquaresFit::LeastSquaresFit(), LibmeshPartitioner::LibmeshPartitioner(), LinearCombinationFunction::LinearCombinationFunction(), LinearCombinationPostprocessor::LinearCombinationPostprocessor(), LinearNodalConstraint::LinearNodalConstraint(), LineMaterialSamplerBase< Real >::LineMaterialSamplerBase(), LineSearch::lineSearch(), LineValueSampler::LineValueSampler(), LowerBoundNodalKernel::LowerBoundNodalKernel(), PNGOutput::makePNG(), MaterialRealTensorValueAux::MaterialRealTensorValueAux(), MaterialRealVectorValueAux::MaterialRealVectorValueAux(), MaterialStdVectorRealGradientAux::MaterialStdVectorRealGradientAux(), MaterialVectorPostprocessor::MaterialVectorPostprocessor(), Distribution::median(), FunctorRelationshipManager::mesh_reinit(), SubProblem::meshChanged(), MeshExtruder::MeshExtruder(), MeshExtruderGenerator::MeshExtruderGenerator(), MeshSideSetGenerator::MeshSideSetGenerator(), SideSetsFromNormals::modify(), SideSetsFromPoints::modify(), AddExtraNodeset::modify(), BreakMeshByBlockBase::modify(), MeshExtruder::modify(), AssignElementSubdomainID::modify(), SmoothMesh::modify(), AddAllSideSetsByNormals::modify(), ElementDeleterBase::modify(), ParsedSubdomainMeshModifier::modify(), RenameBlock::modify(), ImageSubdomain::modify(), OrientedSubdomainBoundingBox::modify(), BoundingBoxNodeSet::modify(), AddSideSetsFromBoundingBox::modify(), SubdomainBoundingBox::modify(), MooseGhostPointNeighbors::MooseGhostPointNeighbors(), MooseMesh::MooseMesh(), MooseVariableBase::MooseVariableBase(), MortarConstraintBase::MortarConstraintBase(), MultiAppPostprocessorTransfer::MultiAppPostprocessorTransfer(), NearestNodeDistanceAux::NearestNodeDistanceAux(), NearestNodeValueAux::NearestNodeValueAux(), RenameBlockGenerator::newBlockID(), RenameBlock::newBlockID(), RenameBlockGenerator::newBlockName(), RenameBlock::newBlockName(), NewmarkBeta::NewmarkBeta(), NodalConstraint::NodalConstraint(), NodalScalarKernel::NodalScalarKernel(), NodalVariableValue::NodalVariableValue(), NumDOFs::NumDOFs(), NumNonlinearIterations::NumNonlinearIterations(), NumVars::NumVars(), FunctorRelationshipManager::operator()(), RelationshipManager::operator==(), XDA::output(), SolutionHistory::output(), Exodus::output(), AdvancedOutput::outputElementalVariables(), AdvancedOutput::outputInput(), AdvancedOutput::outputNodalVariables(), AdvancedOutput::outputPostprocessors(), AdvancedOutput::outputScalarVariables(), AdvancedOutput::outputSystemInformation(), Console::outputVectorPostprocessors(), AdvancedOutput::outputVectorPostprocessors(), MooseObject::paramError(), PiecewiseBilinear::parse(), ParsedAddSideset::ParsedAddSideset(), ParsedAux::ParsedAux(), ParsedGenerateSideset::ParsedGenerateSideset(), ParsedODEKernel::ParsedODEKernel(), ParsedSubdomainMeshGenerator::ParsedSubdomainMeshGenerator(), ParsedSubdomainMeshModifier::ParsedSubdomainMeshModifier(), ExplicitTimeIntegrator::performExplicitSolve(), PetscExternalPartitioner::PetscExternalPartitioner(), PhysicsBasedPreconditioner::PhysicsBasedPreconditioner(), PiecewiseBase::PiecewiseBase(), PiecewiseBilinear::PiecewiseBilinear(), PiecewiseLinearInterpolationMaterial::PiecewiseLinearInterpolationMaterial(), PiecewiseMulticonstant::PiecewiseMulticonstant(), PiecewiseMultiInterpolation::PiecewiseMultiInterpolation(), SolutionUserObject::pointValueGradientWrapper(), SolutionUserObject::pointValueWrapper(), LStableDirk2::postResidual(), LStableDirk3::postResidual(), ImplicitMidpoint::postResidual(), ExplicitTVDRK2::postResidual(), AStableDirk4::postResidual(), LStableDirk4::postResidual(), ExplicitRK2::postResidual(), Eigenvalue::postSolve(), Predictor::Predictor(), Transient::preExecute(), SolutionUserObject::readExodusII(), SolutionUserObject::readXda(), DerivativeParsedMaterialHelper::recurseDerivative(), FunctorRelationshipManager::redistribute(), ReferenceResidualProblem::ReferenceResidualProblem(), EqualValueEmbeddedConstraint::reinitConstraint(), RelativeSolutionDifferenceNorm::RelativeSolutionDifferenceNorm(), RenameBlock::RenameBlock(), RenameBlockGenerator::RenameBlockGenerator(), RenameBoundaryGenerator::RenameBoundaryGenerator(), RinglebMesh::RinglebMesh(), RinglebMeshGenerator::RinglebMeshGenerator(), ScalarComponentIC::ScalarComponentIC(), BicubicSplineFunction::secondDerivative(), FEProblemBase::setCoordSystem(), PiecewiseBase::setData(), EigenProblem::setEigenproblemType(), FEProblemSolve::setInnerSolve(), Sampler::setNumberOfCols(), Sampler::setNumberOfRandomSeeds(), Sampler::setNumberOfRows(), Exodus::setOutputDimensionInExodusWriter(), Split::setup(), TransientMultiApp::setupApp(), TimeSequenceStepperBase::setupSequence(), Transient::setupTimeIntegrator(), SideSetsFromBoundingBoxGenerator::SideSetsFromBoundingBoxGenerator(), SideSetsFromNormals::SideSetsFromNormals(), SideSetsFromNormalsGenerator::SideSetsFromNormalsGenerator(), SideSetsFromPoints::SideSetsFromPoints(), SideSetsFromPointsGenerator::SideSetsFromPointsGenerator(), SolutionTimeAdaptiveDT::SolutionTimeAdaptiveDT(), SolutionUserObject::SolutionUserObject(), PicardSolve::solve(), FullSolveMultiApp::solveStep(), SpatialAverageBase::SpatialAverageBase(), NearestPointIntegralVariablePostprocessor::spatialValue(), UserObject::spatialValue(), SpiralAnnularMesh::SpiralAnnularMesh(), SpiralAnnularMeshGenerator::SpiralAnnularMeshGenerator(), StitchedMesh::StitchedMesh(), NodalUserObject::subdomainSetup(), GeneralUserObject::subdomainSetup(), Constraint::subdomainSetup(), MaterialBase::subdomainSetup(), Console::systemInfoFlags(), TagMatrixAux::TagMatrixAux(), TagVectorAux::TagVectorAux(), Terminator::Terminator(), TestSetupPostprocessorDataActionFunction::TestSetupPostprocessorDataActionFunction(), ThreadedGeneralUserObject::ThreadedGeneralUserObject(), ThreadedGeneralUserObject::threadJoin(), DiscreteElementUserObject::threadJoin(), GeneralUserObject::threadJoin(), TiledMeshGenerator::TiledMeshGenerator(), Function::timeDerivative(), TimeExtremeValue::TimeExtremeValue(), TimePeriod::TimePeriod(), VectorPostprocessorVisualizationAux::timestepSetup(), MultiAppFieldTransfer::transfer(), MultiAppMeshFunctionTransfer::transferVariable(), MooseVariableScalar::uDot(), MooseVariableScalar::uDotDot(), MooseVariableScalar::uDotDotOld(), FEProblemBase::uDotDotOldRequested(), MooseVariableScalar::uDotOld(), FEProblemBase::uDotOldRequested(), EqualValueBoundaryConstraint::updateConstrainedNodes(), SolutionUserObject::updateExodusBracketingTimeIndices(), UpperBoundNodalKernel::UpperBoundNodalKernel(), NearestPointIntegralVariablePostprocessor::userObjectValue(), BoundingBoxIC::value(), Axisymmetric2D3DSolutionFunction::value(), ValueRangeMarker::ValueRangeMarker(), ValueThresholdMarker::ValueThresholdMarker(), MultiAppTransfer::variableIntegrityCheck(), VariableTimeIntegrationAux::VariableTimeIntegrationAux(), VectorNodalBC::VectorNodalBC(), VectorOfPostprocessors::VectorOfPostprocessors(), VectorPostprocessorFunction::VectorPostprocessorFunction(), MooseParsedGradFunction::vectorValue(), MooseParsedFunction::vectorValue(), VolumeHistogram::VolumeHistogram(), VTKOutput::VTKOutput(), DOFMapOutput::writeStreamToFile(), and Console::writeStreamToFile().
|
inlineinherited |
Definition at line 162 of file MooseObject.h.
Referenced by AStableDirk4::AStableDirk4(), ExplicitRK2::ExplicitRK2(), ExplicitTVDRK2::ExplicitTVDRK2(), ParsedMaterialHelper::functionsOptimize(), ImplicitMidpoint::ImplicitMidpoint(), LStableDirk2::LStableDirk2(), LStableDirk3::LStableDirk3(), LStableDirk4::LStableDirk4(), PNGOutput::makeMeshFunc(), MooseObject::paramInfo(), DerivativeParsedMaterialHelper::recurseDerivative(), ReferenceResidualProblem::ReferenceResidualProblem(), and FEProblemBase::setRestartFile().
|
inlineinherited |
Definition at line 150 of file MooseObject.h.
Referenced by CartesianMeshGenerator::CartesianMeshGenerator(), MultiAppTransfer::checkMultiAppExecuteOn(), OversampleOutput::cloneMesh(), GapValueAux::computeValue(), ElementQualityChecker::finalize(), FiniteDifferencePreconditioner::FiniteDifferencePreconditioner(), ElementSubdomainIDGenerator::generate(), MooseMesh::getBoundaryIDs(), FEProblemBase::getInterfaceMaterial(), FEProblemBase::getMaterial(), MooseMesh::getSubdomainIDs(), ReferenceResidualProblem::initialSetup(), DerivativeFunctionMaterialBase::initialSetup(), FEProblemBase::initialSetup(), AdvancedOutput::initPostprocessorOrVectorPostprocessorLists(), LeastSquaresFit::LeastSquaresFit(), MaterialVectorPostprocessor::MaterialVectorPostprocessor(), AssignElementSubdomainID::modify(), NewmarkBeta::NewmarkBeta(), NodalPatchRecovery::NodalPatchRecovery(), NonlocalIntegratedBC::NonlocalIntegratedBC(), NonlocalKernel::NonlocalKernel(), Output::Output(), MooseObject::paramWarning(), Executioner::problem(), MaterialBase::resetQpProperties(), FEProblemBase::sizeZeroes(), TransientMultiApp::solveStep(), Tecplot::Tecplot(), and Checkpoint::updateCheckpointFiles().
|
inlineoverridevirtualinherited |
Get the variable name.
Reimplemented from MooseObject.
Definition at line 63 of file MooseVariableBase.h.
Referenced by SetupResidualDebugAction::act(), InitialConditionWarehouse::addObject(), MooseVariableBase::allDofIndices(), BlockRestrictable::checkVariable(), Coupleable::coupledNodalValue(), Coupleable::coupledNodalValueOld(), Coupleable::coupledNodalValueOlder(), MultiAppUserObjectTransfer::execute(), GreaterThanLessThanPostprocessor::execute(), MultiAppInterpolationTransfer::execute(), MultiAppNearestNodeTransfer::execute(), MultiAppProjectionTransfer::execute(), GapValueAux::GapValueAux(), DerivativeMaterialInterface< Material >::isNotObjectVariable(), ParsedAux::ParsedAux(), ParsedODEKernel::ParsedODEKernel(), ConstraintWarehouse::subdomainsCovered(), and MultiAppMeshFunctionTransfer::transferVariable().
|
pure virtual |
|
pure virtual |
|
inlineinherited |
Get variable number coming from libMesh.
Definition at line 48 of file MooseVariableBase.h.
Referenced by Assembly::addJacobianBlock(), Assembly::addJacobianCoupledVarPair(), Assembly::cacheJacobianBlock(), Assembly::cacheJacobianBlockNonzero(), Assembly::cacheJacobianCoupledVarPair(), ADKernelGradTempl< T, compute_stage >::computeADOffDiagJacobian(), ADKernelStabilizedTempl< T, compute_stage >::computeADOffDiagJacobian(), ADKernelValueTempl< T, compute_stage >::computeADOffDiagJacobian(), ADKernelTempl< T, compute_stage >::computeADOffDiagJacobian(), DGKernel::computeElemNeighJacobian(), ArrayDGKernel::computeElemNeighJacobian(), ElemElemConstraint::computeElemNeighJacobian(), DGKernel::computeElemNeighResidual(), ElemElemConstraint::computeElemNeighResidual(), ArrayDGKernel::computeElemNeighResidual(), ComputeFullJacobianThread::computeFaceJacobian(), ComputeFullJacobianThread::computeInternalFaceJacobian(), MassLumpedTimeDerivative::computeJacobian(), TimeDerivative::computeJacobian(), VectorTimeDerivative::computeJacobian(), Kernel::computeJacobian(), VectorKernel::computeJacobian(), ArrayKernel::computeJacobian(), ODEKernel::computeJacobian(), ComputeFullJacobianThread::computeJacobian(), VectorIntegratedBC::computeJacobian(), EigenKernel::computeJacobian(), IntegratedBC::computeJacobian(), ArrayIntegratedBC::computeJacobian(), NodalEqualValueConstraint::computeJacobian(), EqualValueEmbeddedConstraint::computeJacobian(), NonlocalKernel::computeJacobian(), NonlocalIntegratedBC::computeJacobian(), KernelGrad::computeJacobian(), KernelValue::computeJacobian(), ADMortarConstraint< compute_stage >::computeJacobian(), MortarConstraint::computeJacobian(), NodeElemConstraint::computeJacobian(), NodeFaceConstraint::computeJacobian(), DiracKernel::computeJacobian(), ADIntegratedBCTempl< T, compute_stage >::computeJacobianBlock(), VectorIntegratedBC::computeJacobianBlock(), IntegratedBC::computeJacobianBlock(), ArrayIntegratedBC::computeJacobianBlock(), NonlocalIntegratedBC::computeJacobianBlock(), JvarMapIntegratedBCInterface< T >::computeJacobianBlock(), VectorIntegratedBC::computeJacobianBlockScalar(), ArrayIntegratedBC::computeJacobianBlockScalar(), IntegratedBC::computeJacobianBlockScalar(), NonlocalIntegratedBC::computeNonlocalJacobian(), NonlocalKernel::computeNonlocalJacobian(), NonlocalIntegratedBC::computeNonlocalOffDiagJacobian(), NonlocalKernel::computeNonlocalOffDiagJacobian(), DGKernel::computeOffDiagElemNeighJacobian(), ArrayDGKernel::computeOffDiagElemNeighJacobian(), ODEKernel::computeOffDiagJacobian(), JvarMapKernelInterface< Kernel >::computeOffDiagJacobian(), Kernel::computeOffDiagJacobian(), NodalScalarKernel::computeOffDiagJacobian(), VectorKernel::computeOffDiagJacobian(), ArrayKernel::computeOffDiagJacobian(), EigenKernel::computeOffDiagJacobian(), EqualValueEmbeddedConstraint::computeOffDiagJacobian(), VectorNodalBC::computeOffDiagJacobian(), NodalBC::computeOffDiagJacobian(), NonlocalKernel::computeOffDiagJacobian(), KernelGrad::computeOffDiagJacobian(), KernelValue::computeOffDiagJacobian(), NodeElemConstraint::computeOffDiagJacobian(), NodeFaceConstraint::computeOffDiagJacobian(), DiracKernel::computeOffDiagJacobian(), NodalKernel::computeOffDiagJacobian(), VectorKernel::computeOffDiagJacobianScalar(), ArrayKernel::computeOffDiagJacobianScalar(), Kernel::computeOffDiagJacobianScalar(), OldEqualValueConstraint::computeQpJacobian(), CoupledTiedValueConstraint::computeQpJacobian(), TiedValueConstraint::computeQpJacobian(), EqualValueEmbeddedConstraint::computeQpJacobian(), ArrayDiffusion::computeQpOffDiagJacobian(), ArrayReaction::computeQpOffDiagJacobian(), ArrayTimeDerivative::computeQpOffDiagJacobian(), EqualValueEmbeddedConstraint::computeQpOffDiagJacobian(), ArrayIntegratedBC::computeQpOffDiagJacobian(), ArrayKernel::computeQpOffDiagJacobian(), ArrayNodalBC::computeQpOffDiagJacobian(), ArrayDGKernel::computeQpOffDiagJacobian(), CoupledTiedValueConstraint::computeQpResidual(), TiedValueConstraint::computeQpResidual(), Kernel::computeResidual(), VectorKernel::computeResidual(), ArrayKernel::computeResidual(), ODETimeKernel::computeResidual(), VectorTimeKernel::computeResidual(), TimeKernel::computeResidual(), ODEKernel::computeResidual(), VectorIntegratedBC::computeResidual(), EigenKernel::computeResidual(), IntegratedBC::computeResidual(), ArrayIntegratedBC::computeResidual(), NodalEqualValueConstraint::computeResidual(), KernelValue::computeResidual(), KernelGrad::computeResidual(), MortarConstraint::computeResidual(), NodeElemConstraint::computeResidual(), NodeFaceConstraint::computeResidual(), DiracKernel::computeResidual(), DebugResidualAux::computeValue(), Coupleable::coupled(), CoupledForce::CoupledForce(), CoupledForceNodalKernel::CoupledForceNodalKernel(), ScalarCoupleable::coupledScalar(), VariableResidual::execute(), NodalNormalsCorner::execute(), NodalNormalsEvaluator::execute(), NodalNormalsPreprocessor::execute(), FieldSplitPreconditioner::FieldSplitPreconditioner(), FiniteDifferencePreconditioner::FiniteDifferencePreconditioner(), ConservativeAdvection::fullUpwind(), LazyCoupleable::init(), NodalNormalsPreprocessor::initialize(), LowerBoundNodalKernel::LowerBoundNodalKernel(), PNGOutput::makeMeshFunc(), ComputeDiracThread::onElement(), ComputeNodalKernelBCJacobiansThread::onNode(), ComputeNodalKernelJacobiansThread::onNode(), PhysicsBasedPreconditioner::PhysicsBasedPreconditioner(), Assembly::prepareJacobianBlock(), Assembly::prepareLowerD(), Assembly::prepareNeighbor(), Assembly::prepareNonlocal(), Assembly::prepareVariable(), Assembly::prepareVariableNonlocal(), MultiAppProjectionTransfer::projectSolution(), EqualValueEmbeddedConstraint::reinitConstraint(), EigenProblem::scaleEigenvector(), AddPeriodicBCAction::setPeriodicVars(), SingleMatrixPreconditioner::SingleMatrixPreconditioner(), MultiAppFieldTransfer::transferDofObject(), UpdateErrorVectorsThread::UpdateErrorVectorsThread(), and UpperBoundNodalKernel::UpperBoundNodalKernel().
|
inlinevirtualinherited |
Get the number of local DoFs.
Reimplemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
Definition at line 125 of file MooseVariableBase.h.
Referenced by ComputeDiracThread::onElement().
|
pure virtual |
|
inherited |
Return the number of blocks for this object.
Definition at line 180 of file BlockRestrictable.C.
|
inherited |
Get the order of this variable Note: Order enum can be implicitly converted to unsigned int.
Definition at line 123 of file MooseVariableBase.C.
Referenced by FEProblemBase::checkDisplacementOrders(), AuxScalarKernel::compute(), ScalarInitialCondition::compute(), ODEKernel::computeJacobian(), ODEKernel::computeOffDiagJacobian(), VectorKernel::computeOffDiagJacobianScalar(), Kernel::computeOffDiagJacobianScalar(), ArrayDGDiffusion::computeQpJacobian(), DGDiffusion::computeQpJacobian(), DGFunctionDiffusionDirichletBC::computeQpJacobian(), ArrayKernel::computeQpOffDiagJacobianScalar(), ArrayIntegratedBC::computeQpOffDiagJacobianScalar(), ArrayDGDiffusion::computeQpResidual(), DGDiffusion::computeQpResidual(), DGFunctionDiffusionDirichletBC::computeQpResidual(), ODEKernel::computeResidual(), ODETimeKernel::computeResidual(), ScalarCoupleable::coupledScalarOrder(), MultiAppPostprocessorToAuxScalarTransfer::execute(), FunctionScalarAux::FunctionScalarAux(), GapValueAux::GapValueAux(), NodalPatchRecovery::NodalPatchRecovery(), FEProblemBase::projectSolution(), ScalarComponentIC::ScalarComponentIC(), and MooseVariableBase::validParams().
|
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 215 of file MooseObject.h.
Referenced by ADDGKernel< compute_stage >::ADDGKernel(), ADIntegratedBCTempl< T, compute_stage >::ADIntegratedBCTempl(), ADKernelTempl< T, compute_stage >::ADKernelTempl(), ADVectorFunctionDirichletBC< compute_stage >::ADVectorFunctionDirichletBC(), AnnularMesh::AnnularMesh(), AnnularMeshGenerator::AnnularMeshGenerator(), ArrayDGKernel::ArrayDGKernel(), ArrayIntegratedBC::ArrayIntegratedBC(), ArrayKernel::ArrayKernel(), BlockWeightedPartitioner::BlockWeightedPartitioner(), checkComponent(), Coupleable::checkVar(), MultiAppTransfer::checkVariable(), CombinerGenerator::CombinerGenerator(), ConcentricCircleMeshGenerator::ConcentricCircleMeshGenerator(), ConstantVectorPostprocessor::ConstantVectorPostprocessor(), Coupleable::Coupleable(), DGKernel::DGKernel(), DGKernelBase::DGKernelBase(), Eigenvalue::Eigenvalue(), ElementValueSampler::ElementValueSampler(), Executioner::Executioner(), FancyExtruderGenerator::FancyExtruderGenerator(), RenameBoundaryGenerator::generate(), MeshCollectionGenerator::generate(), StackGenerator::generate(), StitchedMeshGenerator::generate(), CombinerGenerator::generate(), Sampler::getGlobalSamples(), Sampler::getLocalSamples(), Sampler::getNextLocalRow(), MultiApp::init(), BlockRestrictable::initializeBlockRestrictable(), BoundaryRestrictable::initializeBoundaryRestrictable(), IntegratedBC::IntegratedBC(), InversePowerMethod::InversePowerMethod(), Kernel::Kernel(), PNGOutput::makeMeshFunc(), MeshCollectionGenerator::MeshCollectionGenerator(), MultiAppConservativeTransfer::MultiAppConservativeTransfer(), MultiAppInterpolationTransfer::MultiAppInterpolationTransfer(), MultiAppMeshFunctionTransfer::MultiAppMeshFunctionTransfer(), MultiAppNearestNodeTransfer::MultiAppNearestNodeTransfer(), MultiAppPostprocessorInterpolationTransfer::MultiAppPostprocessorInterpolationTransfer(), MultiAppPostprocessorToAuxScalarTransfer::MultiAppPostprocessorToAuxScalarTransfer(), MultiAppPostprocessorTransfer::MultiAppPostprocessorTransfer(), MultiAppProjectionTransfer::MultiAppProjectionTransfer(), MultiAppScalarToAuxScalarTransfer::MultiAppScalarToAuxScalarTransfer(), MultiAppTransfer::MultiAppTransfer(), MultiAppUserObjectTransfer::MultiAppUserObjectTransfer(), MultiAppVariableValueSamplePostprocessorTransfer::MultiAppVariableValueSamplePostprocessorTransfer(), MultiAppVariableValueSampleTransfer::MultiAppVariableValueSampleTransfer(), MultiAppVectorPostprocessorTransfer::MultiAppVectorPostprocessorTransfer(), NodalBC::NodalBC(), NodalEqualValueConstraint::NodalEqualValueConstraint(), NodalKernel::NodalKernel(), NodalValueSampler::NodalValueSampler(), PatchMeshGenerator::PatchMeshGenerator(), PatternedMeshGenerator::PatternedMeshGenerator(), PiecewiseFunctionTabulate::PiecewiseFunctionTabulate(), PlaneDeletionGenerator::PlaneDeletionGenerator(), RandomIC::RandomIC(), MooseMesh::setPartitioner(), MultiAppFieldTransfer::transfer(), Transfer::Transfer(), TransientMultiApp::TransientMultiApp(), VectorBodyForce::VectorBodyForce(), VectorFunctionDirichletBC::VectorFunctionDirichletBC(), and VectorFunctionIC::VectorFunctionIC().
|
inlineprivateinherited |
Definition at line 185 of file MooseObject.h.
Referenced by MooseObject::paramError(), MooseObject::paramInfo(), and MooseObject::paramWarning().
|
inlineinherited |
Get the parameters of the object.
Definition at line 76 of file MooseObject.h.
Referenced by FEProblemBase::addADJacobianInterfaceMaterial(), FEProblemBase::addADJacobianMaterial(), FEProblemBase::addADKernel(), FEProblemBase::addADResidualInterfaceMaterial(), FEProblemBase::addADResidualMaterial(), DumpObjectsProblem::addAuxKernel(), FEProblemBase::addAuxKernel(), DumpObjectsProblem::addAuxScalarKernel(), FEProblemBase::addAuxScalarKernel(), DisplacedProblem::addAuxVariable(), DumpObjectsProblem::addBoundaryCondition(), FEProblemBase::addBoundaryCondition(), DumpObjectsProblem::addConstraint(), FEProblemBase::addConstraint(), FEProblemBase::addDamper(), DumpObjectsProblem::addDGKernel(), FEProblemBase::addDGKernel(), DumpObjectsProblem::addDiracKernel(), FEProblemBase::addDiracKernel(), FEProblemBase::addDistribution(), DumpObjectsProblem::addFunction(), FEProblemBase::addFunction(), FEProblemBase::addIndicator(), DumpObjectsProblem::addInitialCondition(), FEProblemBase::addInitialCondition(), DumpObjectsProblem::addInterfaceKernel(), FEProblemBase::addInterfaceKernel(), FEProblemBase::addInterfaceMaterial(), DumpObjectsProblem::addKernel(), FEProblemBase::addKernel(), FEProblem::addLineSearch(), FEProblemBase::addMarker(), DumpObjectsProblem::addMaterial(), FEProblemBase::addMaterial(), FEProblemBase::addMaterialHelper(), FEProblemBase::addMultiApp(), DumpObjectsProblem::addNodalKernel(), FEProblemBase::addNodalKernel(), FEProblemBase::addOutput(), FEProblemBase::addPostprocessor(), FEProblemBase::addPredictor(), FEProblemBase::addSampler(), DumpObjectsProblem::addScalarKernel(), FEProblemBase::addScalarKernel(), FEProblemBase::addTimeIntegrator(), FEProblemBase::addTransfer(), FEProblemBase::addUserObject(), DisplacedProblem::addVariable(), FEProblemBase::addVectorPostprocessor(), ADPiecewiseLinearInterpolationMaterial< compute_stage >::ADPiecewiseLinearInterpolationMaterial(), AdvancedOutput::AdvancedOutput(), ADVectorFunctionDirichletBC< compute_stage >::ADVectorFunctionDirichletBC(), AnnularMesh::AnnularMesh(), AnnularMeshGenerator::AnnularMeshGenerator(), assemble_l2(), Moose::assemble_matrix(), AuxKernelTempl< ComputeValueType >::AuxKernelTempl(), AuxScalarKernel::AuxScalarKernel(), BoundsAux::BoundsAux(), LibmeshPartitioner::clone(), OversampleOutput::cloneMesh(), Moose::compute_bounds(), Moose::compute_jacobian(), Moose::compute_nearnullspace(), Moose::compute_nullspace(), Moose::compute_postcheck(), Moose::compute_transpose_nullspace(), Console::Console(), DumpObjectsProblem::deduceNecessaryParameters(), DumpObjectsProblem::dumpObjectHelper(), EigenProblem::EigenProblem(), Eigenvalue::Eigenvalue(), Exodus::Exodus(), FEProblem::FEProblem(), GapValueAux::GapValueAux(), MooseObject::getCheckedPointerParam(), GhostingUserObject::GhostingUserObject(), MooseMesh::init(), BlockRestrictable::initializeBlockRestrictable(), FEProblemBase::initNullSpaceVectors(), InterfaceKernelTempl< T >::InterfaceKernelTempl(), isValid(), LayeredSideIntegral::LayeredSideIntegral(), MooseVariableInterface< Real >::MooseVariableInterface(), NodeFaceConstraint::NodeFaceConstraint(), PatchMeshGenerator::PatchMeshGenerator(), PenetrationAux::PenetrationAux(), PiecewiseBilinear::PiecewiseBilinear(), PiecewiseLinearInterpolationMaterial::PiecewiseLinearInterpolationMaterial(), MultiAppProjectionTransfer::projectSolution(), RandomIC::RandomIC(), InputParameterWarehouse::removeInputParameters(), EigenProblem::scaleEigenvector(), FEProblem::setInputParametersFEProblem(), FEProblemBase::setInputParametersFEProblem(), DumpObjectsProblem::stringifyParameters(), Transient::Transient(), VectorBodyForce::VectorBodyForce(), VectorFunctionDirichletBC::VectorFunctionDirichletBC(), and VectorFunctionIC::VectorFunctionIC().
|
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 231 of file MooseObject.h.
Referenced by TransientMultiApp::TransientMultiApp().
|
inherited |
Emits a warning prefixed with the file and line number of the given param (from the input file) along with the full parameter path+name followed by the given args as the message.
If this object's parameters were not created directly by the Parser, then this function falls back to the normal behavior of mooseWarning - only printing a message using the given args.
Definition at line 224 of file MooseObject.h.
Referenced by Executioner::Executioner().
|
pure virtual |
Return phiFaceNeighbor size.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
|
pure virtual |
Return phiFace size.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
|
pure virtual |
Return the number of shape functions on the lower dimensional element for this variable.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
|
pure virtual |
Return phiNeighbor size.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
|
pure virtual |
Return phi size.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
Referenced by ADKernelGradTempl< T, compute_stage >::computeADOffDiagJacobian(), ADKernelStabilizedTempl< T, compute_stage >::computeADOffDiagJacobian(), ADKernelValueTempl< T, compute_stage >::computeADOffDiagJacobian(), ADKernelTempl< T, compute_stage >::computeADOffDiagJacobian(), and ArrayIntegratedBC::computeJacobianBlock().
|
pure virtual |
Prepare the elemental degrees of freedom.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
|
pure virtual |
|
pure virtual |
Prepare the initial condition.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
|
pure virtual |
Prepare a lower dimensional element's degrees of freedom.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
|
pure virtual |
Prepare the neighbor element degrees of freedom.
Implemented in MooseVariableFE< OutputType >, MooseVariableFE< ComputeValueType >, MooseVariableFE< T >, MooseVariableFE< RealEigenVector >, MooseVariableFE< RealVectorValue >, and MooseVariableFE< Real >.
|
pure virtual |
|
pure virtual |
|
pure virtual |
|
pure virtual |
|
pure virtual |
|
inlineinherited |
|
inlineinherited |
Definition at line 80 of file MooseVariableBase.h.
|
inlineinherited |
Set the scaling factor for this variable.
Definition at line 79 of file MooseVariableBase.h.
Referenced by NodalConstraint::computeJacobian(), NodalKernel::computeJacobian(), NodalKernel::computeOffDiagJacobian(), CoupledTiedValueConstraint::computeQpJacobian(), TiedValueConstraint::computeQpJacobian(), TiedValueConstraint::computeQpResidual(), CoupledTiedValueConstraint::computeQpResidual(), TimeNodalKernel::computeResidual(), NodalConstraint::computeResidual(), NodalKernel::computeResidual(), and ReferenceResidualProblem::initialSetup().
|
inlineinherited |
Get the system this variable is part of.
Definition at line 58 of file MooseVariableBase.h.
Referenced by ADDGKernel< compute_stage >::ADDGKernel(), FEProblemBase::addInitialCondition(), ADIntegratedBCTempl< T, compute_stage >::ADIntegratedBCTempl(), MultiAppConservativeTransfer::adjustTransferedSolution(), MultiAppConservativeTransfer::adjustTransferedSolutionNearestPoint(), ADKernelTempl< T, compute_stage >::ADKernelTempl(), ArrayDGKernel::ArrayDGKernel(), ArrayIntegratedBC::ArrayIntegratedBC(), ArrayKernel::ArrayKernel(), DGKernel::DGKernel(), MultiAppVariableValueSamplePostprocessorTransfer::execute(), MultiAppInterpolationTransfer::execute(), MultiAppUserObjectTransfer::execute(), MultiAppScalarToAuxScalarTransfer::execute(), MultiAppVariableValueSampleTransfer::execute(), MultiAppPostprocessorToAuxScalarTransfer::execute(), MultiAppNearestNodeTransfer::execute(), MultiAppProjectionTransfer::execute(), IntegratedBC::IntegratedBC(), InterfaceKernelTempl< T >::InterfaceKernelTempl(), Kernel::Kernel(), NodalBC::NodalBC(), NodalKernel::NodalKernel(), TableOutput::outputScalarVariables(), Nemesis::outputScalarVariables(), Exodus::outputScalarVariables(), MultiAppProjectionTransfer::projectSolution(), FEProblemBase::projectSolution(), MultiAppFieldTransfer::transfer(), MultiAppFieldTransfer::transferDofObject(), and MultiAppMeshFunctionTransfer::transferVariable().
|
inlineinherited |
Definition at line 69 of file MooseVariableBase.h.
|
inlineinherited |
Get the type of this object.
Definition at line 63 of file MooseObject.h.
Referenced by FEProblemBase::addArrayVariable(), FEProblemBase::addAuxArrayVariable(), DumpObjectsProblem::addAuxKernel(), DumpObjectsProblem::addAuxScalarKernel(), FEProblemBase::addAuxScalarVariable(), FEProblemBase::addAuxVariable(), DumpObjectsProblem::addBoundaryCondition(), DumpObjectsProblem::addConstraint(), DumpObjectsProblem::addDGKernel(), DumpObjectsProblem::addDiracKernel(), FEProblemBase::addDistribution(), DumpObjectsProblem::addFunction(), FEProblemBase::addFunction(), DumpObjectsProblem::addInitialCondition(), DumpObjectsProblem::addInterfaceKernel(), DumpObjectsProblem::addKernel(), DumpObjectsProblem::addMaterial(), DumpObjectsProblem::addNodalKernel(), FEProblemBase::addPredictor(), FEProblemBase::addSampler(), DumpObjectsProblem::addScalarKernel(), FEProblemBase::addScalarVariable(), PhysicsBasedPreconditioner::addSystem(), FEProblemBase::addTimeIntegrator(), FEProblemBase::addVariable(), FEProblemBase::advanceMultiApps(), FEProblemBase::backupMultiApps(), MooseMesh::buildRefinementAndCoarseningMaps(), FEProblemBase::computeAuxiliaryKernels(), DGKernel::computeElemNeighJacobian(), ArrayDGKernel::computeElemNeighJacobian(), ElemElemConstraint::computeElemNeighJacobian(), DGKernel::computeElemNeighResidual(), ElemElemConstraint::computeElemNeighResidual(), ArrayDGKernel::computeElemNeighResidual(), FEProblemBase::computeMultiAppsDT(), DGKernel::computeOffDiagElemNeighJacobian(), ArrayDGKernel::computeOffDiagElemNeighJacobian(), DGConvection::computeQpJacobian(), ArrayDGDiffusion::computeQpJacobian(), InterfaceReaction::computeQpJacobian(), TiedValueConstraint::computeQpJacobian(), CoupledTiedValueConstraint::computeQpJacobian(), DGDiffusion::computeQpJacobian(), LinearNodalConstraint::computeQpJacobian(), EqualValueBoundaryConstraint::computeQpJacobian(), EqualValueEmbeddedConstraint::computeQpJacobian(), CoupledTiedValueConstraint::computeQpOffDiagJacobian(), EqualValueEmbeddedConstraint::computeQpOffDiagJacobian(), ArrayDGKernel::computeQpOffDiagJacobian(), DGConvection::computeQpResidual(), ArrayDGDiffusion::computeQpResidual(), InterfaceReaction::computeQpResidual(), TiedValueConstraint::computeQpResidual(), CoupledTiedValueConstraint::computeQpResidual(), LinearNodalConstraint::computeQpResidual(), DGDiffusion::computeQpResidual(), EqualValueBoundaryConstraint::computeQpResidual(), EqualValueEmbeddedConstraint::computeQpResidual(), FEProblemBase::computeUserObjectByName(), FEProblemBase::computeUserObjects(), FEProblemBase::computeUserObjectsInternal(), DisplacedProblem::createQRules(), FEProblemBase::createQRules(), DumpObjectsProblem::deduceNecessaryParameters(), DumpObjectsProblem::dumpObjectHelper(), FEProblemBase::duplicateVariableCheck(), FEProblemBase::execMultiApps(), FEProblemBase::execMultiAppTransfers(), FEProblemBase::execTransfers(), FEProblemBase::finishMultiAppStep(), ElementSubdomainIDGenerator::generate(), ElementGenerator::getElemType(), FEProblemBase::getInterfaceMaterial(), FEProblemBase::getMaterial(), FEProblemBase::getMaterialData(), FEProblemBase::getTransfers(), FEProblemBase::hasMultiApps(), AdvancedOutput::hasOutput(), FEProblemBase::incrementMultiAppTStep(), AdvancedOutput::initAvailableLists(), AdvancedOutput::initShowHideLists(), RelationshipManager::isType(), AssignElementSubdomainID::modify(), ControlOutput::output(), Gnuplot::output(), CSV::output(), Exodus::output(), Console::output(), Nemesis::output(), AdvancedOutput::output(), OversampleOutput::outputStep(), Output::outputStep(), FEProblemBase::outputStep(), FEProblemBase::restoreMultiApps(), FEProblemBase::setCoupling(), PerfGraphOutput::shouldOutput(), FileOutput::shouldOutput(), Output::shouldOutput(), AdvancedOutput::shouldOutput(), DisplacedProblem::updateGeomSearch(), FEProblemBase::updateGeomSearch(), and AdvancedOutput::wantOutput().
|
static |
Definition at line 15 of file MooseVariableFEBase.C.
|
protectedinherited |
The MooseApp this object is associated with.
Definition at line 172 of file MooseObject.h.
Referenced by GridPartitioner::_do_partition(), AB2PredictorCorrector::AB2PredictorCorrector(), Executioner::addAttributeReporter(), FEProblemBase::addMaterialHelper(), FEProblemBase::addMultiApp(), FEProblemBase::addOutput(), FEProblemBase::allowOutput(), AStableDirk4::AStableDirk4(), FileMesh::buildMesh(), MeshGeneratorMesh::buildMesh(), MooseMesh::buildMeshBaseObject(), FEProblemBase::checkNonlinearConvergence(), OversampleOutput::cloneMesh(), FEProblemBase::computeJacobianTags(), FEProblemBase::computeResidualTags(), Console::Console(), TimeStepper::constrainStep(), MultiApp::createApp(), MeshGenerator::declareMeshProperty(), DumpObjectsProblem::dumpObjectHelper(), DumpObjectsProblem::dumpVariableHelper(), EigenExecutionerBase::EigenExecutionerBase(), EigenKernel::EigenKernel(), NonlinearEigen::execute(), InversePowerMethod::execute(), Transient::execute(), Steady::execute(), FileOutput::FileOutput(), FEProblemBase::forceOutput(), MeshGenerator::getMesh(), MeshGenerator::getMeshByName(), MooseObject::getMooseApp(), NumRelationshipManagers::getValue(), GhostingUserObject::GhostingUserObject(), NonlinearEigen::init(), InversePowerMethod::init(), Transient::init(), Steady::init(), MooseMesh::init(), NumPicardIterations::initialize(), TimePeriod::initialSetup(), Console::initialSetup(), MultiApp::initialSetup(), FEProblemBase::initialSetup(), AdvancedOutput::initOutputList(), FEProblemBase::initPetscOutput(), AdvancedOutput::initPostprocessorOrVectorPostprocessorLists(), ElementSideNeighborLayers::internalInit(), MeshGeneratorMesh::MeshGeneratorMesh(), MooseObject::mooseError(), EigenExecutionerBase::normalizeSolution(), AugmentSparsityOnInterface::operator()(), PerfGraphOutput::output(), Tecplot::output(), Exodus::output(), Nemesis::output(), ControlOutput::outputActiveObjects(), ControlOutput::outputChangedControls(), ControlOutput::outputControls(), Exodus::outputEmptyTimestep(), Console::outputInput(), Exodus::outputInput(), Exodus::outputNodalVariables(), OversampleOutput::outputStep(), Output::outputStep(), FEProblemBase::outputStep(), Console::outputSystemInformation(), MultiApp::parentOutputPositionChanged(), PerformanceData::PerformanceData(), PetscOutput::petscLinearOutput(), PetscOutput::petscNonlinearOutput(), Eigenvalue::postSolve(), Transient::preExecute(), FEProblemBase::projectSolution(), FEProblemBase::setRestartFile(), TransientMultiApp::setupApp(), TimeSequenceStepperBase::setupSequence(), Transient::setupTimeIntegrator(), TransientMultiApp::solveStep(), FEProblemBase::subdomainSetup(), FEProblemBase::theWarehouse(), TimeExtremeValue::TimeExtremeValue(), TimePeriod::TimePeriod(), FEProblemBase::timestepSetup(), Transient::Transient(), and Console::write().
|
protectedinherited |
Assembly data.
Definition at line 150 of file MooseVariableBase.h.
Referenced by MooseVariableFE< Real >::MooseVariableFE().
|
privateinherited |
Flag for allowing dual restriction.
Definition at line 233 of file BlockRestrictable.h.
Referenced by BlockRestrictable::initializeBlockRestrictable().
|
privateinherited |
Pointer to FEProblemBase.
Definition at line 236 of file BlockRestrictable.h.
Referenced by BlockRestrictable::getBlockCoordSystem(), BlockRestrictable::hasBlockMaterialPropertyHelper(), and BlockRestrictable::initializeBlockRestrictable().
|
privateinherited |
Set of block ids supplied by the user via the input file (for error reporting)
Definition at line 227 of file BlockRestrictable.h.
Referenced by BlockRestrictable::blockIDs(), BlockRestrictable::blockRestricted(), BlockRestrictable::checkVariable(), BlockRestrictable::hasBlocks(), BlockRestrictable::initializeBlockRestrictable(), BlockRestrictable::isBlockSubset(), and BlockRestrictable::numBlocks().
|
protectedinherited |
Pointer to the MaterialData class for this object.
Definition at line 205 of file BlockRestrictable.h.
Referenced by BlockRestrictable::hasBlockMaterialProperty(), and BlockRestrictable::initializeBlockRestrictable().
|
privateinherited |
Pointer to Mesh.
Definition at line 239 of file BlockRestrictable.h.
Referenced by BlockRestrictable::getBlockCoordSystem(), BlockRestrictable::hasBlocks(), BlockRestrictable::initializeBlockRestrictable(), BlockRestrictable::isBlockSubset(), and BlockRestrictable::meshBlockIDs().
|
privateinherited |
Name of the object.
Definition at line 251 of file BlockRestrictable.h.
Referenced by BlockRestrictable::checkVariable(), and BlockRestrictable::initializeBlockRestrictable().
|
privateinherited |
Thread id for this object.
Definition at line 248 of file BlockRestrictable.h.
Referenced by BlockRestrictable::initializeBlockRestrictable().
|
privateinherited |
Vector the block names supplied by the user via the input file.
Definition at line 230 of file BlockRestrictable.h.
Referenced by BlockRestrictable::blocks(), and BlockRestrictable::initializeBlockRestrictable().
|
privateinherited |
Reference to the boundary_ids, defaults to an empty set if not provided.
Definition at line 245 of file BlockRestrictable.h.
Referenced by BlockRestrictable::initializeBlockRestrictable().
|
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(), Adaptivity::adaptMesh(), FEProblemBase::adaptMesh(), SimplePredictor::apply(), MultiApp::backup(), FEProblemBase::backupMultiApps(), ReferenceResidualProblem::checkNonlinearConvergence(), FEProblemBase::checkProblemIntegrity(), CoarsenedPiecewiseLinear::CoarsenedPiecewiseLinear(), IterationAdaptiveDT::computeAdaptiveDT(), Transient::computeConstrainedDT(), NonlinearSystemBase::computeDamping(), IterationAdaptiveDT::computeDT(), IterationAdaptiveDT::computeFailedDT(), IterationAdaptiveDT::computeInterpolationDT(), FEProblemBase::computeResidualTags(), NonlinearSystem::computeScaling(), IterationAdaptiveDT::constrainStep(), TimeStepper::constrainStep(), MultiApp::createApp(), FEProblemBase::execMultiApps(), FEProblemBase::execMultiAppTransfers(), MultiAppPostprocessorTransfer::execute(), MultiAppPostprocessorInterpolationTransfer::execute(), MultiAppVariableValueSamplePostprocessorTransfer::execute(), MultiAppVectorPostprocessorTransfer::execute(), MultiAppMeshFunctionTransfer::execute(), MultiAppCopyTransfer::execute(), MultiAppInterpolationTransfer::execute(), MultiAppUserObjectTransfer::execute(), MultiAppScalarToAuxScalarTransfer::execute(), MultiAppPostprocessorToAuxScalarTransfer::execute(), MultiAppVariableValueSampleTransfer::execute(), MultiAppNearestNodeTransfer::execute(), MultiAppProjectionTransfer::execute(), Steady::execute(), ActionWarehouse::executeActionsWithAction(), ActionWarehouse::executeAllActions(), ElementQualityChecker::finalize(), FEProblemBase::finishMultiAppStep(), MultiApp::globalAppToLocal(), InversePowerMethod::init(), NonlinearEigen::init(), Steady::init(), FEProblemBase::initialAdaptMesh(), FEProblemBase::initialSetup(), EigenExecutionerBase::inversePowerIteration(), Transient::keepGoing(), IterationAdaptiveDT::limitDTByFunction(), IterationAdaptiveDT::limitDTToPostprocessorValue(), EigenExecutionerBase::makeBXConsistent(), Console::meshChanged(), MooseObject::mooseDeprecated(), MooseObject::mooseInfo(), MooseObject::mooseWarning(), PerfGraphOutput::output(), DOFMapOutput::output(), VariableResidualNormsDebugOutput::output(), Console::output(), ControlOutput::outputActiveObjects(), ControlOutput::outputChangedControls(), ControlOutput::outputControls(), Console::outputInput(), Console::outputPostprocessors(), Console::outputScalarVariables(), Console::outputSystemInformation(), FEProblemBase::possiblyRebuildGeomSearchPatches(), MultiAppConservativeTransfer::postExecute(), EigenExecutionerBase::postExecute(), AB2PredictorCorrector::postSolve(), ActionWarehouse::printActionDependencySets(), EigenExecutionerBase::printEigenvalue(), MaterialPropertyDebugOutput::printMaterialMap(), AutomaticMortarGeneration::projectMasterNodesSinglePair(), AutomaticMortarGeneration::projectSlaveNodesSinglePair(), SolutionTimeAdaptiveDT::rejectStep(), DT2::rejectStep(), MultiApp::restore(), FEProblemBase::restoreMultiApps(), SimplePredictor::shouldApply(), PicardSolve::solve(), NonlinearSystem::solve(), LStableDirk2::solve(), LStableDirk3::solve(), ImplicitMidpoint::solve(), ExplicitTVDRK2::solve(), AStableDirk4::solve(), LStableDirk4::solve(), ExplicitRK2::solve(), TransientMultiApp::solveStep(), PicardSolve::solveStep(), DT2::step(), AB2PredictorCorrector::step(), NonlinearEigen::takeStep(), Transient::takeStep(), Console::writeTimestepInformation(), Console::writeVariableNorms(), and FEProblemBase::~FEProblemBase().
|
protectedinherited |
Number of variables in the array.
Definition at line 165 of file MooseVariableBase.h.
Referenced by MooseVariableBase::count(), MooseVariableBase::MooseVariableBase(), and MooseVariableBase::scalingFactor().
|
protectedinherited |
DOF indices.
Definition at line 156 of file MooseVariableBase.h.
Referenced by MooseVariableScalar::computeAD(), MooseVariableBase::dofIndices(), MooseVariableScalar::insert(), MooseVariableBase::numberOfDofs(), MooseVariableScalar::reinit(), MooseVariableScalar::setValue(), and MooseVariableScalar::setValues().
|
protectedinherited |
DOF map.
Definition at line 153 of file MooseVariableBase.h.
Referenced by MooseVariableBase::dofMap(), MooseVariableScalar::insert(), and MooseVariableScalar::reinit().
|
privateinherited |
An empty set for referencing when boundary_ids is not included.
Definition at line 242 of file BlockRestrictable.h.
|
protectedinherited |
Reference to the "enable" InputParaemters, used by Controls for toggling on/off MooseObjects.
Definition at line 181 of file MooseObject.h.
Referenced by MooseObject::enabled().
|
protectedinherited |
The FEType associated with this variable.
Definition at line 132 of file MooseVariableBase.h.
Referenced by MooseVariableBase::feType(), and MooseVariableBase::order().
|
protectedinherited |
variable number within MOOSE
Definition at line 138 of file MooseVariableBase.h.
|
protectedinherited |
mesh the variable is active in
Definition at line 159 of file MooseVariableBase.h.
|
protectedinherited |
The name of this object, reference to value stored in InputParameters.
Definition at line 178 of file MooseObject.h.
Referenced by ADPiecewiseLinearInterpolationMaterial< compute_stage >::ADPiecewiseLinearInterpolationMaterial(), PiecewiseBase::buildFromFile(), PiecewiseBase::buildFromXY(), PiecewiseLinearBase::buildInterpolation(), CentroidMultiApp::fillPositions(), MultiApp::fillPositions(), FunctionDT::FunctionDT(), MooseObject::name(), PiecewiseBilinear::parse(), PiecewiseBase::PiecewiseBase(), PiecewiseBilinear::PiecewiseBilinear(), PiecewiseLinearInterpolationMaterial::PiecewiseLinearInterpolationMaterial(), DerivativeParsedMaterialHelper::recurseDerivative(), PiecewiseBase::setData(), Split::setup(), and VectorPostprocessorFunction::VectorPostprocessorFunction().
|
privateinherited |
Reference the the MooseApp; neede for access to the OutputWarehouse.
Definition at line 70 of file OutputInterface.h.
|
privateinherited |
Reference to the OutputWarehouse for populating the Output object hide lists.
Definition at line 73 of file OutputInterface.h.
Referenced by OutputInterface::buildOutputHideVariableList().
|
privateinherited |
The set of Output object names listed in the 'outputs' parameter.
Definition at line 76 of file OutputInterface.h.
Referenced by OutputInterface::buildOutputHideVariableList(), and OutputInterface::getOutputs().
|
protectedinherited |
Parameters of this object, references the InputParameters stored in the InputParametersWarehouse.
Definition at line 169 of file MooseObject.h.
Referenced by GridPartitioner::_do_partition(), BreakMeshByBlockGeneratorBase::BreakMeshByBlockGeneratorBase(), PNGOutput::calculateRescalingValues(), BreakMeshByBlockBase::checkInputParameter(), RandomPartitioner::clone(), PetscExternalPartitioner::clone(), BlockWeightedPartitioner::clone(), GridPartitioner::clone(), Console::Console(), Eigenvalue::execute(), Executioner::Executioner(), FEProblemSolve::FEProblemSolve(), FunctionMaterialBase::FunctionMaterialBase(), ParsedMaterialHelper::functionParse(), ExtraNodesetGenerator::generate(), MooseObject::getParamTempl(), GeneralUserObject::getPostprocessorValue(), InitialConditionBase::getUserObjectBase(), InitialConditionBase::getUserObjectTempl(), GeneralUserObject::getVectorPostprocessorValue(), Transient::init(), AdvancedOutput::initExecutionTypes(), Console::initialSetup(), MooseObject::isParamValid(), AddExtraNodeset::modify(), MooseObject::paramErrorMsg(), MooseObject::parameters(), MooseMesh::setPartitionerHelper(), and Transient::setupTimeIntegrator().
|
protectedinherited |
scaling factor for this variable
Definition at line 168 of file MooseVariableBase.h.
Referenced by MooseVariableBase::arrayScalingFactor(), and MooseVariableBase::scalingFactor().
|
protectedinherited |
Problem this variable is part of.
Definition at line 144 of file MooseVariableBase.h.
Referenced by MooseVariableConstMonomial::computeElemValues(), MooseVariableConstMonomial::computeElemValuesFace(), MooseVariableConstMonomial::computeNeighborValues(), MooseVariableConstMonomial::computeNeighborValuesFace(), and MooseVariableScalar::reinit().
|
protectedinherited |
System this variable is part of.
Definition at line 129 of file MooseVariableBase.h.
Referenced by MooseVariableBase::allDofIndices(), MooseVariableScalar::computeAD(), MooseVariableBase::MooseVariableBase(), MooseVariableFE< Real >::MooseVariableFE(), MooseVariableScalar::MooseVariableScalar(), MooseVariableScalar::reinit(), MooseVariableBase::sys(), MooseVariableScalar::uDot(), MooseVariableScalar::uDotDot(), MooseVariableScalar::uDotDotOld(), and MooseVariableScalar::uDotOld().
|
protectedinherited |
Thread ID.
Definition at line 162 of file MooseVariableBase.h.
Referenced by MooseVariableFE< Real >::MooseVariableFE(), and MooseVariableScalar::reinit().
|
protectedinherited |
The type of this object (the Class name)
Definition at line 175 of file MooseObject.h.
Referenced by FEProblemBase::init(), and MooseObject::type().
|
protectedinherited |
Variable type (see MooseTypes.h)
Definition at line 141 of file MooseVariableBase.h.
Referenced by MooseVariableBase::kind().
|
protectedinherited |
Variable name.
Definition at line 171 of file MooseVariableBase.h.
Referenced by MooseVariableBase::MooseVariableBase(), and MooseVariableBase::name().
|
protectedinherited |
variable number (from libMesh)
Definition at line 135 of file MooseVariableBase.h.
Referenced by MooseVariableScalar::computeAD(), MooseVariableBase::MooseVariableBase(), MooseVariableBase::number(), and MooseVariableScalar::reinit().
|
protectedinherited |
libMesh variable object for this variable
Definition at line 147 of file MooseVariableBase.h.