www.mooseframework.org
Public Types | Public Member Functions | Static Public Member Functions | Public Attributes | Protected Member Functions | Protected Attributes | Private Types | Private Member Functions | Private Attributes | List of all members
VectorConstantIC Class Reference

VectorConstantIC just returns a constant value. More...

#include <VectorConstantIC.h>

Inheritance diagram for VectorConstantIC:
[legend]

Public Types

typedef OutputTools< T >::OutputShape ValueType
 
typedef OutputTools< T >::OutputGradient GradientType
 
typedef OutputTools< T >::OutputShapeGradient GradientShapeType
 
typedef OutputTools< T >::OutputData DataType
 
typedef FEGenericBase< ValueTypeFEBaseType
 
enum  TEST_TYPE { ALL, ANY }
 A flag changing the behavior of hasBoundary. More...
 

Public Member Functions

 VectorConstantIC (const InputParameters &parameters)
 
virtual RealVectorValue value (const Point &p) override
 The value of the variable at a point. More...
 
virtual MooseVariableFEBasevariable () override
 retrieves the MOOSE variable that this initial condition acts upon More...
 
virtual void compute () override
 Workhorse method for projecting the initial conditions for block initial conditions. More...
 
virtual void computeNodal (const Point &p) override
 Workhorse method for projecting the initial conditions for boundary restricted initial conditions. More...
 
virtual GradientType gradient (const Point &)
 The gradient of the variable at a point. More...
 
gradientComponent (GradientType grad, unsigned int i)
 
template<>
RealVectorValue gradientComponent (GradientType grad, unsigned int i)
 
template<>
RealEigenVector gradientComponent (GradientType grad, unsigned int i)
 
void setCZeroVertices ()
 set the temporary solution vector for node projections of C0 variables More...
 
template<>
void setCZeroVertices ()
 
void setHermiteVertices ()
 set the temporary solution vector for node projections of Hermite variables More...
 
template<>
void setHermiteVertices ()
 
void setOtherCOneVertices ()
 set the temporary solution vector for node projections of non-Hermitian C1 variables More...
 
template<>
void setOtherCOneVertices ()
 
Real dotHelper (const RealGradient &op1, const RealGradient &op2)
 Helps perform multiplication of GradientTypes: a normal dot product for vectors and a contraction for tensors. More...
 
Real dotHelper (const RealTensor &op1, const RealTensor &op2)
 
RealEigenVector dotHelper (const RealVectorArrayValue &op1, const RealGradient &op2)
 
void choleskySolve (bool is_volume)
 Perform the cholesky solves for edge, side, and interior projections. More...
 
template<>
void choleskySolve (bool is_volume)
 
void choleskyAssembly (bool is_volume)
 Assemble a small local system for cholesky solve. More...
 
const std::set< std::string > & getDependObjects () const
 getter method for dependent user objects More...
 
virtual void initialSetup ()
 Gets called at the beginning of the simulation before this object is asked to do its job. More...
 
virtual const std::set< std::string > & getRequestedItems () override
 Return a set containing the names of items requested by the object. More...
 
virtual const std::set< std::string > & getSuppliedItems () override
 Return a set containing the names of items owned by the object. More...
 
template<typename T2 >
const T2 & getUserObjectTempl (const std::string &name)
 reimplements the getUserObject method from UserObjectInterface More...
 
template<typename T >
const T & getUserObjectTempl (const std::string &name)
 
template<typename T2 >
const T2 & getUserObjectByNameTempl (const UserObjectName &name)
 reimplements the getUserObjectByName method from UserObjectInterface More...
 
template<typename T >
const T & getUserObjectByNameTempl (const UserObjectName &name)
 
template<class T >
const T & getUserObjectByNameTempl (const std::string &name)
 Get an user object with a given name. More...
 
const UserObjectgetUserObjectBase (const std::string &name)
 reimplements the getUserObjectBase method from UserObjectInterface More...
 
const std::string & type () const
 Get the type of this object. More...
 
virtual const std::string & name () const
 Get the name of the object. More...
 
const InputParametersparameters () 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 >
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...
 
MooseAppgetMooseApp () 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 &param, 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 &param, 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 &param, 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...
 
const std::unordered_map< std::string, std::vector< MooseVariableFEBase * > > & getCoupledVars ()
 Get the list of coupled variables. More...
 
const std::vector< MooseVariableFEBase * > & getCoupledMooseVars () const
 Get the list of all coupled variables. More...
 
const std::vector< MooseVariable * > & getCoupledStandardMooseVars () const
 Get the list of standard coupled variables. More...
 
const std::vector< VectorMooseVariable * > & getCoupledVectorMooseVars () const
 Get the list of vector coupled variables. More...
 
const std::vector< ArrayMooseVariable * > & getCoupledArratMooseVars () const
 Get the list of array coupled variables. More...
 
void addFEVariableCoupleableVectorTag (TagID tag)
 
void addFEVariableCoupleableMatrixTag (TagID tag)
 
std::set< TagID > & getFEVariableCoupleableVectorTags ()
 
std::set< TagID > & getFEVariableCoupleableMatrixTags ()
 
template<ComputeStage compute_stage>
ADVariableValue * getADDefaultValue (const std::string &var_name)
 Helper method to return (and insert if necessary) the default value for Automatic Differentiation for an uncoupled variable. More...
 
template<>
VariableValuegetADDefaultValue (const std::string &var_name)
 
template<>
VariableValuegetADDefaultValue (const std::string &var_name)
 
template<ComputeStage compute_stage>
ADVectorVariableValue * getADDefaultVectorValue (const std::string &var_name)
 Helper method to return (and insert if necessary) the default vector value for Automatic Differentiation for an uncoupled variable. More...
 
template<>
VectorVariableValuegetADDefaultVectorValue (const std::string &var_name)
 
template<>
VectorVariableValuegetADDefaultVectorValue (const std::string &var_name)
 
template<ComputeStage compute_stage>
ADVariableGradient & getADDefaultGradient ()
 Helper method to return (and insert if necessary) the default gradient for Automatic Differentiation for an uncoupled variable. More...
 
template<>
VariableGradientgetADDefaultGradient ()
 
template<>
VariableGradientgetADDefaultGradient ()
 
template<ComputeStage compute_stage>
ADVectorVariableGradient & getADDefaultVectorGradient ()
 Helper method to return (and insert if necessary) the default gradient for Automatic Differentiation for an uncoupled vector variable. More...
 
template<>
VectorVariableGradientgetADDefaultVectorGradient ()
 
template<>
VectorVariableGradientgetADDefaultVectorGradient ()
 
template<ComputeStage compute_stage>
ADVariableSecond & getADDefaultSecond ()
 Helper method to return (and insert if necessary) the default second derivatives for Automatic Differentiation for an uncoupled variable. More...
 
template<>
VariableSecondgetADDefaultSecond ()
 
template<>
VariableSecondgetADDefaultSecond ()
 
const FunctiongetFunction (const std::string &name) const
 Get a function with a given name. More...
 
const FunctiongetFunctionByName (const FunctionName &name) const
 Get a function with a given name. More...
 
const UserObjectgetUserObjectBaseByName (const std::string &name)
 Get an user object with a given name. More...
 
const virtual std::set< BoundaryID > & boundaryIDs () const
 Return the boundary IDs for this object. More...
 
const std::vector< BoundaryName > & boundaryNames () const
 Return the boundary names for this object. More...
 
unsigned int numBoundaryIDs () const
 Return the number of boundaries for this object. More...
 
bool hasBoundary (const BoundaryName &name) const
 Test if the supplied boundary name is valid for this object. More...
 
bool hasBoundary (const std::vector< BoundaryName > &names) const
 Test if the supplied vector of boundary names are valid for this object. More...
 
bool hasBoundary (const BoundaryID &id) const
 Test if the supplied boundary ids are valid for this object. More...
 
bool hasBoundary (const std::vector< BoundaryID > &ids, TEST_TYPE type=ALL) const
 Test if the supplied vector boundary ids are valid for this object. More...
 
bool hasBoundary (const std::set< BoundaryID > &ids, TEST_TYPE type=ALL) const
 Test if the supplied set of boundary ids are valid for this object. More...
 
bool isBoundarySubset (const std::set< BoundaryID > &ids) const
 Test if the class boundary ids are a subset of the supplied objects. More...
 
bool isBoundarySubset (const std::vector< BoundaryID > &ids) const
 
template<typename T >
bool hasBoundaryMaterialProperty (const std::string &prop_name) const
 Check if a material property is valid for all boundaries of this object. More...
 
virtual bool boundaryRestricted () const
 Returns true if this object has been restricted to a boundary. More...
 
const std::set< BoundaryID > & meshBoundaryIDs () const
 Returns the set of all boundary ids for the entire mesh. More...
 
virtual unsigned int getElementIDIndex (const std::string &id_parameter_name, unsigned int comp=0) const
 Gets index of an element integer with a parameter of the object derived from this interface. More...
 
virtual const dof_id_type & getElementID (const std::string &id_parameter_name, unsigned int comp=0) const
 Gets an element integer with a parameter of the object derived from this interface. More...
 

Static Public Member Functions

static InputParameters validParams ()
 
static bool restricted (const std::set< BoundaryID > &ids)
 Helper for determining if the object is boundary restricted. More...
 
template<typename T >
static void sort (typename std::vector< T > &vector)
 Given a vector, sort using the getRequested/SuppliedItems sets. More...
 
template<typename T >
static void cyclicDependencyError (CyclicDependencyException< T > &e, const std::string &header)
 A helper method for cyclic errors. More...
 

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...
 
virtual void coupledCallback (const std::string &, bool)
 A call-back function provided by the derived object for actions before coupling a variable with functions such as coupledValue. More...
 
virtual bool isCoupled (const std::string &var_name, unsigned int i=0)
 Returns true if a variables has been coupled as name. More...
 
unsigned int coupledComponents (const std::string &var_name)
 Number of coupled components. More...
 
virtual unsigned int coupled (const std::string &var_name, unsigned int comp=0)
 Returns the index for a coupled variable by name. More...
 
virtual const VariableValuecoupledValue (const std::string &var_name, unsigned int comp=0)
 Returns value of a coupled variable. More...
 
template<ComputeStage compute_stage>
const ADVariableValue & adCoupledValueTemplate (const std::string &var_name, unsigned int comp=0)
 Returns value of a coupled variable for use in Automatic Differentiation. More...
 
template<ComputeStage compute_stage>
const ADVectorVariableValue & adCoupledVectorValueTemplate (const std::string &var_name, unsigned int comp=0)
 Returns value of a coupled vector variable for use in Automatic Differentiation. More...
 
virtual const VariableValuecoupledVectorTagValue (const std::string &var_name, TagID tag, unsigned int comp=0)
 Returns value of a coupled variable for a given tag. More...
 
virtual const VariableValuecoupledMatrixTagValue (const std::string &var_name, TagID tag, unsigned int comp=0)
 Returns value of a coupled variable for a given tag. More...
 
virtual const VectorVariableValuecoupledVectorValue (const std::string &var_name, unsigned int comp=0)
 Returns value of a coupled vector variable. More...
 
virtual const ArrayVariableValuecoupledArrayValue (const std::string &var_name, unsigned int comp=0)
 Returns value of a coupled array variable. More...
 
virtual VariableValuewritableCoupledValue (const std::string &var_name, unsigned int comp=0)
 Returns a writable reference to a coupled variable. More...
 
virtual const VariableValuecoupledValueOld (const std::string &var_name, unsigned int comp=0)
 Returns an old value from previous time step of a coupled variable. More...
 
virtual const VariableValuecoupledValueOlder (const std::string &var_name, unsigned int comp=0)
 Returns an old value from two time steps previous of a coupled variable. More...
 
virtual const VariableValuecoupledValuePreviousNL (const std::string &var_name, unsigned int comp=0)
 Returns value of previous Newton iterate of a coupled variable. More...
 
virtual const VectorVariableValuecoupledVectorValueOld (const std::string &var_name, unsigned int comp=0)
 Returns an old value from previous time step of a coupled vector variable. More...
 
virtual const VectorVariableValuecoupledVectorValueOlder (const std::string &var_name, unsigned int comp=0)
 Returns an old value from two time steps previous of a coupled vector variable. More...
 
virtual const ArrayVariableValuecoupledArrayValueOld (const std::string &var_name, unsigned int comp=0)
 Returns an old value from previous time step of a coupled array variable. More...
 
virtual const ArrayVariableValuecoupledArrayValueOlder (const std::string &var_name, unsigned int comp=0)
 Returns an old value from two time steps previous of a coupled array variable. More...
 
virtual const VariableGradientcoupledGradient (const std::string &var_name, unsigned int comp=0)
 Returns gradient of a coupled variable. More...
 
template<ComputeStage compute_stage>
const ADVariableGradient & adCoupledGradientTemplate (const std::string &var_name, unsigned int comp=0)
 Returns gradient of a coupled variable for use in Automatic Differentation. More...
 
template<ComputeStage compute_stage>
const ADVectorVariableGradient & adCoupledVectorGradientTemplate (const std::string &var_name, unsigned int comp=0)
 Returns gradient of a coupled vector variable for use in Automatic Differentation. More...
 
template<ComputeStage compute_stage>
const ADVariableSecond & adCoupledSecondTemplate (const std::string &var_name, unsigned int comp=0)
 Returns second derivatives of a coupled variable for use in Automatic Differentation. More...
 
template<ComputeStage compute_stage>
const ADVectorVariableSecond & adCoupledVectorSecondTemplate (const std::string &var_name, unsigned int comp=0)
 Returns second derivatives of a coupled vector variable for use in Automatic Differentation. More...
 
virtual const VariableGradientcoupledGradientOld (const std::string &var_name, unsigned int comp=0)
 Returns an old gradient from previous time step of a coupled variable. More...
 
virtual const VariableGradientcoupledGradientOlder (const std::string &var_name, unsigned int comp=0)
 Returns an old gradient from two time steps previous of a coupled variable. More...
 
virtual const VariableGradientcoupledGradientPreviousNL (const std::string &var_name, unsigned int comp=0)
 Returns gradient of a coupled variable for previous Newton iterate. More...
 
virtual const VariableGradientcoupledGradientDot (const std::string &var_name, unsigned int comp=0)
 Time derivative of the gradient of a coupled variable. More...
 
virtual const VariableGradientcoupledGradientDotDot (const std::string &var_name, unsigned int comp=0)
 Second time derivative of the gradient of a coupled variable. More...
 
virtual const VectorVariableGradientcoupledVectorGradient (const std::string &var_name, unsigned int comp=0)
 Returns gradient of a coupled vector variable. More...
 
virtual const VectorVariableGradientcoupledVectorGradientOld (const std::string &var_name, unsigned int comp=0)
 Returns an old gradient from previous time step of a coupled vector variable. More...
 
virtual const VectorVariableGradientcoupledVectorGradientOlder (const std::string &var_name, unsigned int comp=0)
 Returns an old gradient from two time steps previous of a coupled vector variable. More...
 
virtual const ArrayVariableGradientcoupledArrayGradient (const std::string &var_name, unsigned int comp=0)
 Returns gradient of a coupled array variable. More...
 
virtual const ArrayVariableGradientcoupledArrayGradientOld (const std::string &var_name, unsigned int comp=0)
 Returns an old gradient from previous time step of a coupled array variable. More...
 
virtual const ArrayVariableGradientcoupledArrayGradientOlder (const std::string &var_name, unsigned int comp=0)
 Returns an old gradient from two time steps previous of a coupled array variable. More...
 
virtual const VectorVariableCurlcoupledCurl (const std::string &var_name, unsigned int comp=0)
 Returns curl of a coupled variable. More...
 
virtual const VectorVariableCurlcoupledCurlOld (const std::string &var_name, unsigned int comp=0)
 Returns an old curl from previous time step of a coupled variable. More...
 
virtual const VectorVariableCurlcoupledCurlOlder (const std::string &var_name, unsigned int comp=0)
 Returns an old curl from two time steps previous of a coupled variable. More...
 
virtual const VariableSecondcoupledSecond (const std::string &var_name, unsigned int comp=0)
 Returns second derivative of a coupled variable. More...
 
virtual const VariableSecondcoupledSecondOld (const std::string &var_name, unsigned int comp=0)
 Returns an old second derivative from previous time step of a coupled variable. More...
 
virtual const VariableSecondcoupledSecondOlder (const std::string &var_name, unsigned int comp=0)
 Returns an old second derivative from two time steps previous of a coupled variable. More...
 
virtual const VariableSecondcoupledSecondPreviousNL (const std::string &var_name, unsigned int comp=0)
 Returns second derivative of a coupled variable for the previous Newton iterate. More...
 
virtual const VariableValuecoupledDot (const std::string &var_name, unsigned int comp=0)
 Time derivative of a coupled variable. More...
 
virtual const VariableValuecoupledDotDot (const std::string &var_name, unsigned int comp=0)
 Second time derivative of a coupled variable. More...
 
virtual const VariableValuecoupledDotOld (const std::string &var_name, unsigned int comp=0)
 Old time derivative of a coupled variable. More...
 
virtual const VariableValuecoupledDotDotOld (const std::string &var_name, unsigned int comp=0)
 Old second time derivative of a coupled variable. More...
 
template<ComputeStage compute_stage>
const ADVariableValue & adCoupledDotTemplate (const std::string &var_name, unsigned int comp=0)
 Time derivative of a coupled variable for ad simulations. More...
 
template<ComputeStage compute_stage>
const ADVectorVariableValue & adCoupledVectorDotTemplate (const std::string &var_name, unsigned int comp=0)
 Time derivative of a vector coupled variable for ad simulations. More...
 
virtual const VectorVariableValuecoupledVectorDot (const std::string &var_name, unsigned int comp=0)
 Time derivative of a coupled vector variable. More...
 
virtual const VectorVariableValuecoupledVectorDotDot (const std::string &var_name, unsigned int comp=0)
 Second time derivative of a coupled vector variable. More...
 
virtual const VectorVariableValuecoupledVectorDotOld (const std::string &var_name, unsigned int comp=0)
 Old time derivative of a coupled vector variable. More...
 
virtual const VectorVariableValuecoupledVectorDotDotOld (const std::string &var_name, unsigned int comp=0)
 Old second time derivative of a coupled vector variable. More...
 
virtual const VariableValuecoupledVectorDotDu (const std::string &var_name, unsigned int comp=0)
 Time derivative of a coupled vector variable with respect to the coefficients. More...
 
virtual const VariableValuecoupledVectorDotDotDu (const std::string &var_name, unsigned int comp=0)
 Second time derivative of a coupled vector variable with respect to the coefficients. More...
 
virtual const ArrayVariableValuecoupledArrayDot (const std::string &var_name, unsigned int comp=0)
 Time derivative of a coupled array variable. More...
 
virtual const ArrayVariableValuecoupledArrayDotDot (const std::string &var_name, unsigned int comp=0)
 Second time derivative of a coupled array variable. More...
 
virtual const ArrayVariableValuecoupledArrayDotOld (const std::string &var_name, unsigned int comp=0)
 Old time derivative of a coupled array variable. More...
 
virtual const ArrayVariableValuecoupledArrayDotDotOld (const std::string &var_name, unsigned int comp=0)
 Old second time derivative of a coupled array variable. More...
 
virtual const VariableValuecoupledDotDu (const std::string &var_name, unsigned int comp=0)
 Time derivative of a coupled variable with respect to the coefficients. More...
 
virtual const VariableValuecoupledDotDotDu (const std::string &var_name, unsigned int comp=0)
 Second time derivative of a coupled variable with respect to the coefficients. More...
 
template<typename T >
const T & coupledNodalValue (const std::string &var_name, unsigned int comp=0)
 Returns nodal values of a coupled variable. More...
 
template<typename T , ComputeStage compute_stage>
const Moose::ValueType< T, compute_stage >::typeadCoupledNodalValueTemplate (const std::string &var_name, unsigned int comp=0)
 Returns AD nodal values of a coupled variable. More...
 
template<typename T >
const T & coupledNodalValueOld (const std::string &var_name, unsigned int comp=0)
 Returns an old nodal value from previous time step of a coupled variable. More...
 
template<typename T >
const T & coupledNodalValueOlder (const std::string &var_name, unsigned int comp=0)
 Returns an old nodal value from two time steps previous of a coupled variable. More...
 
template<typename T >
const T & coupledNodalValuePreviousNL (const std::string &var_name, unsigned int comp=0)
 Returns nodal values of a coupled variable for previous Newton iterate. More...
 
template<typename T >
const T & coupledNodalDot (const std::string &var_name, unsigned int comp=0)
 Nodal values of time derivative of a coupled variable. More...
 
virtual const VariableValuecoupledNodalDotDot (const std::string &var_name, unsigned int comp=0)
 Nodal values of second time derivative of a coupled variable. More...
 
virtual const VariableValuecoupledNodalDotOld (const std::string &var_name, unsigned int comp=0)
 Nodal values of old time derivative of a coupled variable. More...
 
virtual const VariableValuecoupledNodalDotDotOld (const std::string &var_name, unsigned int comp=0)
 Nodal values of old second time derivative of a coupled variable. More...
 
virtual const VariableValuecoupledDofValues (const std::string &var_name, unsigned int comp=0)
 Returns DoFs in the current solution vector of a coupled variable for the local element. More...
 
virtual const VariableValuecoupledDofValuesOld (const std::string &var_name, unsigned int comp=0)
 Returns DoFs in the old solution vector of a coupled variable for the local element. More...
 
virtual const VariableValuecoupledDofValuesOlder (const std::string &var_name, unsigned int comp=0)
 Returns DoFs in the older solution vector of a coupled variable for the local element. More...
 
template<ComputeStage compute_stage>
const ADVariableValue & adZeroValueTemplate ()
 Template method that returns _zero to RESIDUAL computing objects and _ad_zero to JACOBIAN computing objects. More...
 
template<>
const VariableValueadZeroValueTemplate ()
 
template<>
const VariableValueadZeroValueTemplate ()
 
template<ComputeStage compute_stage>
const ADVariableGradient & adZeroGradientTemplate ()
 Template method that returns _grad_zero to RESIDUAL computing objects and _ad_grad_zero to JACOBIAN computing objects. More...
 
template<>
const VariableGradientadZeroGradientTemplate ()
 
template<>
const VariableGradientadZeroGradientTemplate ()
 
template<ComputeStage compute_stage>
const ADVariableSecond & adZeroSecondTemplate ()
 Retrieve a zero second for automatic differentiation. More...
 
template<>
const VariableSecondadZeroSecondTemplate ()
 
template<>
const VariableSecondadZeroSecondTemplate ()
 
bool checkVar (const std::string &var_name, unsigned int comp=0, unsigned int comp_bound=0)
 Check that the right kind of variable is being coupled in. More...
 
MooseVariableFEBasegetFEVar (const std::string &var_name, unsigned int comp)
 Extract pointer to a base finite element coupled variable. More...
 
template<typename T >
MooseVariableFE< T > * getVarHelper (const std::string &var_name, unsigned int comp)
 Helper that segues off to either getVar of getVectorVar depending on template paramter. More...
 
MooseVariablegetVar (const std::string &var_name, unsigned int comp)
 Extract pointer to a coupled variable. More...
 
VectorMooseVariablegetVectorVar (const std::string &var_name, unsigned int comp)
 Extract pointer to a coupled vector variable. More...
 
ArrayMooseVariablegetArrayVar (const std::string &var_name, unsigned int comp)
 Extract pointer to a coupled array variable. More...
 
void validateExecutionerType (const std::string &name, const std::string &fn_name) const
 Checks to make sure that the current Executioner has set "_is_transient" when old/older values are coupled in. More...
 
bool hasBoundaryMaterialPropertyHelper (const std::string &prop_name) const
 A helper method to avoid circular #include problems. More...
 
template<typename T >
T & declareRestartableDataTempl (const std::string &data_name)
 Declare a piece of data as "restartable". More...
 
template<typename T >
T & declareRestartableDataTempl (const std::string &data_name, const T &init_value)
 Declare a piece of data as "restartable" and initialize it. More...
 
template<typename T >
T & declareRestartableDataWithContext (const std::string &data_name, void *context)
 Declare a piece of data as "restartable". More...
 
template<typename T >
T & declareRestartableDataWithContext (const std::string &data_name, const T &init_value, void *context)
 Declare a piece of data as "restartable" and initialize it. More...
 
template<typename T >
T & declareRestartableDataWithPrefixOverrideAndContext (const std::string &data_name, const std::string &prefix, void *context)
 Declare a piece of data as "restartable". More...
 
template<typename T >
T & declareRecoverableData (const std::string &data_name)
 Declare a piece of data as "recoverable". More...
 
template<typename T >
T & declareRecoverableData (const std::string &data_name, const T &init_value)
 Declare a piece of data as "restartable" and initialize it. More...
 
template<typename T >
T & declareRestartableDataWithObjectName (const std::string &data_name, const std::string &object_name)
 Declare a piece of data as "restartable". More...
 
template<typename T >
T & declareRestartableDataWithObjectNameWithContext (const std::string &data_name, const std::string &object_name, void *context)
 Declare a piece of data as "restartable". More...
 

Protected Attributes

const Real _x_value
 
const Real _y_value
 
const Real _z_value
 
FEProblemBase_fe_problem
 
THREAD_ID _tid
 
Assembly_assembly
 
Real & _t
 Time. More...
 
const Moose::CoordinateSystemType_coord_sys
 The coordinate system type for this problem, references the value in Assembly. More...
 
MooseVariableFE< T > & _var
 The variable that this initial condition is acting upon. More...
 
const Elem *const & _current_elem
 The current element we are on will retrieving values at specific points in the domain. More...
 
const Node * _current_node
 The current node if the point we are evaluating at also happens to be a node. More...
 
unsigned int _qp
 The current quadrature point, contains the "nth" node number when visiting nodes. More...
 
DenseMatrix< Real > _Ke
 Matrix storage member. More...
 
DenseVector< DataType_Fe
 Linear b vector. More...
 
DenseVector< DataType_Ue
 Linear solution vector. More...
 
const FEType & _fe_type
 The finite element type for the IC variable. More...
 
FEContinuity _cont
 The type of continuity, e.g. C0, C1. More...
 
std::vector< dof_id_type > _dof_indices
 The global DOF indices. More...
 
std::vector< unsigned int > _side_dofs
 Side/edge DOF indices. More...
 
unsigned int _n_qp
 The number of quadrature points for a given element. More...
 
unsigned int _n_nodes
 The number of nodes for a given element. More...
 
std::vector< char > _dof_is_fixed
 Whether the degree of freedom is fixed (true/false) More...
 
std::vector< int > _free_dof
 Stores the ids of the free dofs. More...
 
dof_id_type _free_dofs
 The number of free dofs. More...
 
dof_id_type _current_dof
 The current dof being operated on. More...
 
dof_id_type _nc
 number of dofs per node per variable More...
 
const std::vector< std::vector< ValueType > > * _phi
 pointers to shape functions More...
 
const std::vector< std::vector< GradientShapeType > > * _dphi
 pointers to shape function gradients More...
 
const std::vector< Real > * _JxW
 pointers to the Jacobian * quadrature weights for current element More...
 
const std::vector< Point > * _xyz_values
 pointers to the xyz coordinates of the quadrature points for the current element More...
 
unsigned int _n
 node counter More...
 
unsigned int _dim
 the mesh dimension More...
 
SystemBase_sys
 The system object. More...
 
std::set< std::string > _depend_vars
 Dependent variables. More...
 
std::set< std::string > _supplied_vars
 Supplied variables. More...
 
std::set< std::string > _depend_uo
 Depend UserObjects. More...
 
const bool _ignore_uo_dependency
 If set, UOs retrieved by this IC will not be executed before this IC. 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...
 
const InputParameters_c_parameters
 
const std::string & _c_name
 The name of the object this interface is part of. More...
 
FEProblemBase_c_fe_problem
 
std::unordered_map< std::string, std::vector< MooseVariableFEBase * > > _coupled_vars
 Coupled vars whose values we provide. More...
 
std::vector< MooseVariableFEBase * > _coupled_moose_vars
 Vector of all coupled variables. More...
 
std::vector< MooseVariable * > _coupled_standard_moose_vars
 Vector of standard coupled variables. More...
 
std::vector< VectorMooseVariable * > _coupled_vector_moose_vars
 Vector of vector coupled variables. More...
 
std::vector< ArrayMooseVariable * > _coupled_array_moose_vars
 Vector of array coupled variables. More...
 
bool _c_nodal
 True if we provide coupling to nodal values. More...
 
bool _c_is_implicit
 True if implicit value is required. More...
 
THREAD_ID _c_tid
 Thread ID of the thread using this object. More...
 
std::unordered_map< std::string, std::vector< std::unique_ptr< VariableValue > > > _default_value
 Will hold the default value for optional coupled variables. More...
 
std::unordered_map< std::string, std::unique_ptr< MooseArray< DualReal > > > _ad_default_value
 Will hold the default value for optional coupled variables for automatic differentiation. More...
 
std::unordered_map< std::string, std::unique_ptr< VectorVariableValue > > _default_vector_value
 Will hold the default value for optional vector coupled variables. More...
 
std::map< std::string, ArrayVariableValue * > _default_array_value
 Will hold the default value for optional array coupled variables. More...
 
std::unordered_map< std::string, std::unique_ptr< MooseArray< DualRealVectorValue > > > _ad_default_vector_value
 Will hold the default value for optional vector coupled variables for automatic differentiation. More...
 
VariableValue _default_value_zero
 This will always be zero because the default values for optionally coupled variables is always constant and this is used for time derivative info. More...
 
VariableGradient _default_gradient
 This will always be zero because the default values for optionally coupled variables is always constant. More...
 
MooseArray< DualRealVectorValue_ad_default_gradient
 This will always be zero because the default values for optionally coupled variables is always constant. More...
 
MooseArray< DualRealTensorValue_ad_default_vector_gradient
 This will always be zero because the default values for optionally coupled vector variables is always constant. More...
 
VariableSecond _default_second
 This will always be zero because the default values for optionally coupled variables is always constant. More...
 
MooseArray< DualRealTensorValue_ad_default_second
 This will always be zero because the default values for optionally coupled variables is always constant. More...
 
const VariableValue_zero
 Zero value of a variable. More...
 
const MooseArray< DualReal > & _ad_zero
 
const VariableGradient_grad_zero
 Zero gradient of a variable. More...
 
const MooseArray< DualRealVectorValue > & _ad_grad_zero
 
const VariableSecond_second_zero
 Zero second derivative of a variable. More...
 
const MooseArray< DualRealTensorValue > & _ad_second_zero
 
const VariablePhiSecond_second_phi_zero
 Zero second derivative of a test function. More...
 
const VectorVariableValue_vector_zero
 Zero value of a vector variable. More...
 
const VectorVariableCurl_vector_curl_zero
 Zero value of the curl of a vector variable. More...
 
VectorVariableValue _default_vector_value_zero
 This will always be zero because the default values for optionally coupled variables is always constant and this is used for time derivative info. More...
 
VectorVariableGradient _default_vector_gradient
 This will always be zero because the default values for optionally coupled variables is always constant. More...
 
VectorVariableCurl _default_vector_curl
 This will always be zero because the default values for optionally coupled variables is always constant. More...
 
ArrayVariableValue _default_array_value_zero
 This will always be zero because the default values for optionally coupled variables is always constant and this is used for time derivative info. More...
 
ArrayVariableGradient _default_array_gradient
 This will always be zero because the default values for optionally coupled variables is always constant. More...
 
ArrayVariableCurl _default_array_curl
 This will always be zero because the default values for optionally coupled variables is always constant. More...
 
bool _coupleable_neighbor
 Whether or not this object is a "neighbor" object: ie all of it's coupled values should be neighbor values. More...
 

Private Types

enum  FuncAge { FuncAge::Curr, FuncAge::Old, FuncAge::Older }
 
enum  VarType { VarType::Ignore, VarType::Gradient, VarType::GradientDot, VarType::Dot }
 

Private Member Functions

template<typename... Args>
std::string paramErrorMsg (const std::string &param, Args... args) const
 
void checkFuncType (const std::string var_name, VarType t, FuncAge age)
 
VariableValuegetDefaultValue (const std::string &var_name, unsigned int comp)
 Helper method to return (and insert if necessary) the default value for an uncoupled variable. More...
 
VectorVariableValuegetDefaultVectorValue (const std::string &var_name)
 Helper method to return (and insert if necessary) the default value for an uncoupled vector variable. More...
 
ArrayVariableValuegetDefaultArrayValue (const std::string &var_name)
 Helper method to return (and insert if necessary) the default value for an uncoupled array variable. More...
 
template<typename T >
const T & getDefaultNodalValue (const std::string &var_name, unsigned int comp=0)
 Get nodal default value. More...
 
template<>
const RealVectorValue & getDefaultNodalValue (const std::string &var_name, unsigned int)
 
template<>
const RealEigenVector & getDefaultNodalValue (const std::string &var_name, unsigned int)
 
bool needThreadedCopy (const UserObject &uo) const
 Check if the threaded copy of the user object is needed. More...
 
void initializeBoundaryRestrictable (const MooseObject *moose_object)
 An initialization routine needed for dual constructors. More...
 
RestartableDataValueregisterRestartableDataOnApp (const std::string &name, std::unique_ptr< RestartableDataValue > data, THREAD_ID tid)
 Helper function for actually registering the restartable data. More...
 
void registerRestartableNameWithFilterOnApp (const std::string &name, Moose::RESTARTABLE_FILTER filter)
 Helper function for actually registering the restartable data. More...
 

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...
 
unsigned int _coupleable_max_qps
 Maximum qps for any element in this system. More...
 
std::unordered_map< std::string, std::vector< unsigned int > > _optional_var_index
 Unique indices for optionally coupled vars that weren't provided. More...
 
std::unordered_map< std::string, std::vector< MooseVariableScalar * > > _c_coupled_scalar_vars
 Scalar variables coupled into this object (for error checking) More...
 
std::set< TagID_fe_coupleable_vector_tags
 
std::set< TagID_fe_coupleable_matrix_tags
 
const MooseObject_obj
 
const InputParameters_fni_params
 Parameters of the object with this interface. More...
 
FEProblemBase_fni_feproblem
 Reference to FEProblemBase instance. More...
 
const THREAD_ID _fni_tid
 Thread ID. More...
 
const InputParameters_uoi_params
 Parameters of the object with this interface. More...
 
FEProblemBase_uoi_feproblem
 Reference to the FEProblemBase instance. More...
 
THREAD_ID _uoi_tid
 Thread ID. More...
 
FEProblemBase_bnd_feproblem
 Pointer to FEProblemBase. More...
 
MooseMesh_bnd_mesh
 Point to mesh. More...
 
std::set< BoundaryID_bnd_ids
 Set of the boundary ids. More...
 
std::vector< BoundaryName > _boundary_names
 Vector the the boundary names. More...
 
const bool _bnd_dual_restrictable
 Flag for allowing dual restriction with BlockRestrictable. More...
 
const std::set< SubdomainID_empty_block_ids
 An empty set for referencing when block_ids is not included. More...
 
const std::set< SubdomainID > & _block_ids
 Reference to the block_ids, defaults to an empty set if not provided. More...
 
THREAD_ID _bnd_tid
 Thread id for this object. More...
 
std::shared_ptr< MaterialData_bnd_material_data
 Pointer to MaterialData for boundary (. More...
 
bool _bnd_nodal
 Whether or not this object is restricted to nodesets. More...
 
MooseApp_restartable_app
 Reference to the application. More...
 
std::string _restartable_name
 The name of the object. More...
 
std::string _restartable_system_name
 The system name this object is in. More...
 
THREAD_ID _restartable_tid
 The thread ID for this object. More...
 
const InputParameters_obj_parameters
 Reference to the object's input parameters. More...
 
std::shared_ptr< MooseMesh > & _mesh
 References to the mesh and displaced mesh (currently in the ActionWarehouse) More...
 

Detailed Description

VectorConstantIC just returns a constant value.

Definition at line 32 of file VectorConstantIC.h.

Member Typedef Documentation

◆ DataType

template<typename T >
typedef OutputTools<T>::OutputData InitialConditionTempl< T >::DataType
inherited

Definition at line 45 of file InitialConditionTempl.h.

◆ FEBaseType

template<typename T >
typedef FEGenericBase<ValueType> InitialConditionTempl< T >::FEBaseType
inherited

Definition at line 46 of file InitialConditionTempl.h.

◆ GradientShapeType

template<typename T >
typedef OutputTools<T>::OutputShapeGradient InitialConditionTempl< T >::GradientShapeType
inherited

Definition at line 44 of file InitialConditionTempl.h.

◆ GradientType

template<typename T >
typedef OutputTools<T>::OutputGradient InitialConditionTempl< T >::GradientType
inherited

Definition at line 43 of file InitialConditionTempl.h.

◆ ValueType

template<typename T >
typedef OutputTools<T>::OutputShape InitialConditionTempl< T >::ValueType
inherited

Definition at line 42 of file InitialConditionTempl.h.

Member Enumeration Documentation

◆ FuncAge

enum Coupleable::FuncAge
strongprivateinherited
Enumerator
Curr 
Old 
Older 

Definition at line 971 of file Coupleable.h.

972  {
973  Curr,
974  Old,
975  Older,
976  };

◆ TEST_TYPE

A flag changing the behavior of hasBoundary.

Enumerator
ALL 
ANY 

Definition at line 34 of file BoundaryRestrictable.h.

35  {
36  ALL,
37  ANY
38  };

◆ VarType

enum Coupleable::VarType
strongprivateinherited
Enumerator
Ignore 
Gradient 
GradientDot 
Dot 

Definition at line 978 of file Coupleable.h.

979  {
980  Ignore,
981  Gradient,
982  GradientDot,
983  Dot,
984  };

Constructor & Destructor Documentation

◆ VectorConstantIC()

VectorConstantIC::VectorConstantIC ( const InputParameters parameters)

Definition at line 29 of file VectorConstantIC.C.

31  _x_value(getParam<Real>("x_value")),
32  _y_value(getParam<Real>("y_value")),
33  _z_value(getParam<Real>("z_value"))
34 {
35 }

Member Function Documentation

◆ adCoupledDotTemplate()

template<ComputeStage compute_stage>
const ADVariableValue & Coupleable::adCoupledDotTemplate ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedinherited

Time derivative of a coupled variable for ad simulations.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the time derivative of the coupled variable
See also
Kernel::dot

Definition at line 1196 of file Coupleable.h.

1197 {
1198  MooseVariable * var = getVar(var_name, comp);
1199  if (!var)
1200  return *getADDefaultValue<compute_stage>(var_name);
1202 
1203  if (_c_nodal)
1204  mooseError("Not implemented");
1205 
1206  if (!_coupleable_neighbor)
1207  return var->adUDot<compute_stage>();
1208  return var->adUDotNeighbor<compute_stage>();
1209 }

◆ adCoupledGradientTemplate()

template<ComputeStage compute_stage>
const ADVariableGradient & Coupleable::adCoupledGradientTemplate ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedinherited

Returns gradient of a coupled variable for use in Automatic Differentation.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableGradient containing the gradient of the coupled variable
See also
Kernel::gradient

Definition at line 1153 of file Coupleable.h.

1154 {
1155  MooseVariable * var = getVar(var_name, comp);
1156  if (!var)
1157  return getADDefaultGradient<compute_stage>();
1159 
1160  if (!_c_is_implicit)
1161  mooseError("Not implemented");
1162 
1163  if (!_coupleable_neighbor)
1164  return var->adGradSln<compute_stage>();
1165  return var->adGradSlnNeighbor<compute_stage>();
1166 }

◆ adCoupledNodalValueTemplate()

template<typename T , ComputeStage compute_stage>
const template libMesh::VectorValue< DualReal > & Coupleable::adCoupledNodalValueTemplate< RealVectorValue, JACOBIAN > ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedinherited

Returns AD nodal values of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue for the coupled variable

Definition at line 1406 of file Coupleable.C.

1407 {
1408  static const typename Moose::ValueType<T, compute_stage>::type zero = 0;
1409  if (!isCoupled(var_name))
1410  return zero;
1411 
1412  if (!_c_nodal)
1413  mooseError("The adCoupledNodalValue method should only be called for nodal computing objects");
1415  mooseError(
1416  "The adCoupledNodalValue method shouldn't be called for neighbor computing objects. I "
1417  "don't even know what that would mean, although maybe someone could explain it to me.");
1418  if (!_c_is_implicit)
1419  mooseError("If you're going to use an explicit scheme, then use coupledNodalValue instead of "
1420  "adCoupledNodalValue");
1421 
1422  coupledCallback(var_name, false);
1423  MooseVariableFE<T> * var = getVarHelper<T>(var_name, comp);
1424 
1425  return var->template adNodalValue<compute_stage>();
1426 }

◆ adCoupledSecondTemplate()

template<ComputeStage compute_stage>
const ADVariableSecond & Coupleable::adCoupledSecondTemplate ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedinherited

Returns second derivatives of a coupled variable for use in Automatic Differentation.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableSecond containing the second derivatives of the coupled variable

Definition at line 1170 of file Coupleable.h.

1171 {
1172  MooseVariable * var = getVar(var_name, comp);
1173  if (!var)
1174  return getADDefaultSecond<compute_stage>();
1176 
1177  if (!_c_is_implicit)
1178  mooseError("Not implemented");
1179 
1180  if (!_coupleable_neighbor)
1181  return var->adSecondSln<compute_stage>();
1182  else
1183  return var->adSecondSlnNeighbor<compute_stage>();
1184 }

◆ adCoupledValueTemplate()

template<ComputeStage compute_stage>
const ADVariableValue & Coupleable::adCoupledValueTemplate ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedinherited

Returns value of a coupled variable for use in Automatic Differentiation.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue for the coupled variable
See also
Kernel::value

Definition at line 1134 of file Coupleable.h.

1135 {
1136  MooseVariable * var = getVar(var_name, comp);
1137  if (!var)
1138  return *getADDefaultValue<compute_stage>(var_name);
1140 
1141  if (_c_nodal)
1142  mooseError("Not implemented");
1143  if (!_c_is_implicit)
1144  mooseError("Not implemented");
1145 
1146  if (!_coupleable_neighbor)
1147  return var->adSln<compute_stage>();
1148  return var->adSlnNeighbor<compute_stage>();
1149 }

◆ adCoupledVectorDotTemplate()

template<ComputeStage compute_stage>
const ADVectorVariableValue & Coupleable::adCoupledVectorDotTemplate ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedinherited

Time derivative of a vector coupled variable for ad simulations.

Parameters
var_nameName of vector coupled variable
compComponent number
Returns
Reference to a VectorVariableValue containing the time derivative of the coupled variable
See also
Kernel::dot

Definition at line 1213 of file Coupleable.h.

1214 {
1215  VectorMooseVariable * var = getVectorVar(var_name, comp);
1216  if (!var)
1217  return *getADDefaultVectorValue<compute_stage>(var_name);
1219 
1220  if (_c_nodal)
1221  mooseError("Not implemented");
1222 
1223  if (!_coupleable_neighbor)
1224  return var->adUDot<compute_stage>();
1225  return var->adUDotNeighbor<compute_stage>();
1226 }

◆ adCoupledVectorGradientTemplate()

template<ComputeStage compute_stage>
const ADVectorVariableGradient & Coupleable::adCoupledVectorGradientTemplate ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedinherited

Returns gradient of a coupled vector variable for use in Automatic Differentation.

Parameters
var_nameName of coupled vector variable
compComponent number for vector of coupled vector variables
Returns
Reference to a VectorVariableGradient containing the gradient of the coupled variable
See also
Kernel::gradient

Definition at line 1249 of file Coupleable.h.

1250 {
1251  VectorMooseVariable * var = getVectorVar(var_name, comp);
1252  if (!var)
1253  return getADDefaultVectorGradient<compute_stage>();
1255 
1256  if (!_c_is_implicit)
1257  mooseError("Not implemented");
1258 
1259  if (!_coupleable_neighbor)
1260  return var->adGradSln<compute_stage>();
1261  return var->adGradSlnNeighbor<compute_stage>();
1262 }

◆ adCoupledVectorSecondTemplate()

template<ComputeStage compute_stage>
const ADVectorVariableSecond& Coupleable::adCoupledVectorSecondTemplate ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedinherited

Returns second derivatives of a coupled vector variable for use in Automatic Differentation.

Parameters
var_nameName of coupled vector variable
compComponent number for vector of coupled vector variables
Returns
Reference to a VectorVariableSecond containing the second derivatives of the coupled variable

◆ adCoupledVectorValueTemplate()

template<ComputeStage compute_stage>
const ADVectorVariableValue & Coupleable::adCoupledVectorValueTemplate ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedinherited

Returns value of a coupled vector variable for use in Automatic Differentiation.

Parameters
var_nameName of coupled vector variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue for the coupled variable
See also
Kernel::value

Definition at line 1230 of file Coupleable.h.

1231 {
1232  VectorMooseVariable * var = getVectorVar(var_name, comp);
1233  if (!var)
1234  return *getADDefaultVectorValue<compute_stage>(var_name);
1236 
1237  if (_c_nodal)
1238  mooseError("Not implemented");
1239  if (!_c_is_implicit)
1240  mooseError("Not implemented");
1241 
1242  if (!_coupleable_neighbor)
1243  return var->adSln<compute_stage>();
1244  return var->adSlnNeighbor<compute_stage>();
1245 }

◆ addFEVariableCoupleableMatrixTag()

void Coupleable::addFEVariableCoupleableMatrixTag ( TagID  tag)
inlineinherited

Definition at line 119 of file Coupleable.h.

119 { _fe_coupleable_matrix_tags.insert(tag); }

Referenced by Coupleable::coupledMatrixTagValue().

◆ addFEVariableCoupleableVectorTag()

void Coupleable::addFEVariableCoupleableVectorTag ( TagID  tag)
inlineinherited

Definition at line 117 of file Coupleable.h.

117 { _fe_coupleable_vector_tags.insert(tag); }

Referenced by Coupleable::coupledVectorTagValue().

◆ adZeroGradientTemplate() [1/3]

template<ComputeStage compute_stage>
const ADVariableGradient & Coupleable::adZeroGradientTemplate ( )
protectedinherited

Template method that returns _grad_zero to RESIDUAL computing objects and _ad_grad_zero to JACOBIAN computing objects.

Definition at line 1342 of file Coupleable.h.

1343 {
1344  return _ad_grad_zero;
1345 }

◆ adZeroGradientTemplate() [2/3]

template<>
const VariableGradient& Coupleable::adZeroGradientTemplate ( )
protectedinherited

◆ adZeroGradientTemplate() [3/3]

template<>
const VariableGradient& Coupleable::adZeroGradientTemplate ( )
protectedinherited

Definition at line 1392 of file Coupleable.C.

1393 {
1394  return _grad_zero;
1395 }

◆ adZeroSecondTemplate() [1/3]

template<ComputeStage compute_stage>
const ADVariableSecond & Coupleable::adZeroSecondTemplate ( )
protectedinherited

Retrieve a zero second for automatic differentiation.

Definition at line 1349 of file Coupleable.h.

1350 {
1351  return _ad_second_zero;
1352 }

◆ adZeroSecondTemplate() [2/3]

template<>
const VariableSecond& Coupleable::adZeroSecondTemplate ( )
protectedinherited

◆ adZeroSecondTemplate() [3/3]

template<>
const VariableSecond& Coupleable::adZeroSecondTemplate ( )
protectedinherited

Definition at line 1399 of file Coupleable.C.

1400 {
1401  return _second_zero;
1402 }

◆ adZeroValueTemplate() [1/3]

template<ComputeStage compute_stage>
const ADVariableValue & Coupleable::adZeroValueTemplate ( )
protectedinherited

Template method that returns _zero to RESIDUAL computing objects and _ad_zero to JACOBIAN computing objects.

Definition at line 1335 of file Coupleable.h.

1336 {
1337  return _ad_zero;
1338 }

◆ adZeroValueTemplate() [2/3]

template<>
const VariableValue& Coupleable::adZeroValueTemplate ( )
protectedinherited

◆ adZeroValueTemplate() [3/3]

template<>
const VariableValue& Coupleable::adZeroValueTemplate ( )
protectedinherited

Definition at line 1385 of file Coupleable.C.

1386 {
1387  return _zero;
1388 }

◆ blockIDs()

const std::set< SubdomainID > & BlockRestrictable::blockIDs ( ) const
virtualinherited

Return the block subdomain ids for this object.

Returns
a set of SudomainIDs that are valid for this object

Definition at line 174 of file BlockRestrictable.C.

175 {
176  return _blk_ids;
177 }

Referenced by BlockRestrictable::getBlockCoordSystem(), MaterialBase::getZeroMaterialProperty(), BlockRestrictable::hasBlockMaterialPropertyHelper(), and MaterialBase::registerPropName().

◆ blockRestricted()

bool BlockRestrictable::blockRestricted ( ) const
virtualinherited

Returns true if this object has been restricted to a boundary.

See also
MooseObject

Definition at line 162 of file BlockRestrictable.C.

163 {
164  return _blk_ids.find(Moose::ANY_BLOCK_ID) == _blk_ids.end();
165 }

Referenced by BlockRestrictable::checkVariable(), BlockRestrictable::getBlockCoordSystem(), and BlockRestrictable::hasBlockMaterialPropertyHelper().

◆ blocks()

const std::vector< SubdomainName > & BlockRestrictable::blocks ( ) const
inherited

Return the block names for this object.

Note, if the 'blocks' input parameter was not utilized this will return an empty vector.

Returns
vector of SubdomainNames that are valid for this object

Definition at line 168 of file BlockRestrictable.C.

169 {
170  return _blocks;
171 }

Referenced by MaterialOutputAction::getParams().

◆ boundaryIDs()

const std::set< BoundaryID > & BoundaryRestrictable::boundaryIDs ( ) const
virtualinherited

◆ boundaryNames()

const std::vector< BoundaryName > & BoundaryRestrictable::boundaryNames ( ) const
inherited

Return the boundary names for this object.

Returns
A set of all boundary names for which the object is restricted

Definition at line 176 of file BoundaryRestrictable.C.

177 {
178  return _boundary_names;
179 }

Referenced by MaterialOutputAction::getParams(), NearestNodeDistanceAux::NearestNodeDistanceAux(), and NearestNodeValueAux::NearestNodeValueAux().

◆ boundaryRestricted()

bool BoundaryRestrictable::boundaryRestricted ( ) const
virtualinherited

Returns true if this object has been restricted to a boundary.

See also
MooseObject

Definition at line 188 of file BoundaryRestrictable.C.

189 {
191 }

Referenced by MaterialOutputAction::getParams(), and DerivativeMaterialInterface< Material >::haveMaterialProperty().

◆ checkFuncType()

void Coupleable::checkFuncType ( const std::string  var_name,
VarType  t,
FuncAge  age 
)
privateinherited

Definition at line 156 of file Coupleable.C.

157 {
158  if (t == VarType::Gradient && _c_nodal)
159  mooseError(_c_name, ": nodal variables do not have gradients");
160 
161  if (age == FuncAge::Old || age == FuncAge::Older || t == VarType::GradientDot ||
162  t == VarType::Dot)
163  validateExecutionerType(var_name, "coupled[Vector][Gradient/Dot]Old[er]");
164  if (age == FuncAge::Older && !_c_is_implicit)
165  mooseError("object '",
166  _c_name,
167  "' uses older variable values that are unavailable with explicit schemes");
168 
169  // this goes at end after all error checks
170  coupledCallback(var_name, age == FuncAge::Old || age == FuncAge::Older);
171 }

Referenced by Coupleable::adCoupledDotTemplate(), Coupleable::adCoupledGradientTemplate(), Coupleable::adCoupledSecondTemplate(), Coupleable::adCoupledValueTemplate(), Coupleable::adCoupledVectorDotTemplate(), Coupleable::adCoupledVectorGradientTemplate(), Coupleable::adCoupledVectorValueTemplate(), Coupleable::coupled(), Coupleable::coupledArrayDot(), Coupleable::coupledArrayDotDot(), Coupleable::coupledArrayDotDotOld(), Coupleable::coupledArrayDotOld(), Coupleable::coupledArrayGradient(), Coupleable::coupledArrayGradientOld(), Coupleable::coupledArrayGradientOlder(), Coupleable::coupledArrayValue(), Coupleable::coupledArrayValueOld(), Coupleable::coupledArrayValueOlder(), Coupleable::coupledCurl(), Coupleable::coupledCurlOld(), Coupleable::coupledCurlOlder(), Coupleable::coupledDofValues(), Coupleable::coupledDofValuesOld(), Coupleable::coupledDofValuesOlder(), Coupleable::coupledDot(), Coupleable::coupledDotDot(), Coupleable::coupledDotDotDu(), Coupleable::coupledDotDotOld(), Coupleable::coupledDotDu(), Coupleable::coupledDotOld(), Coupleable::coupledGradient(), Coupleable::coupledGradientDot(), Coupleable::coupledGradientDotDot(), Coupleable::coupledGradientOld(), Coupleable::coupledGradientOlder(), Coupleable::coupledGradientPreviousNL(), Coupleable::coupledMatrixTagValue(), Coupleable::coupledNodalDot(), Coupleable::coupledNodalDotDot(), Coupleable::coupledNodalDotDotOld(), Coupleable::coupledNodalDotOld(), Coupleable::coupledNodalValue(), Coupleable::coupledNodalValueOld(), Coupleable::coupledNodalValueOlder(), Coupleable::coupledNodalValuePreviousNL(), Coupleable::coupledSecond(), Coupleable::coupledSecondOld(), Coupleable::coupledSecondOlder(), Coupleable::coupledSecondPreviousNL(), Coupleable::coupledValue(), Coupleable::coupledValueOld(), Coupleable::coupledValueOlder(), Coupleable::coupledValuePreviousNL(), Coupleable::coupledVectorDot(), Coupleable::coupledVectorDotDot(), Coupleable::coupledVectorDotDotDu(), Coupleable::coupledVectorDotDotOld(), Coupleable::coupledVectorDotDu(), Coupleable::coupledVectorDotOld(), Coupleable::coupledVectorGradient(), Coupleable::coupledVectorGradientOld(), Coupleable::coupledVectorGradientOlder(), Coupleable::coupledVectorTagValue(), Coupleable::coupledVectorValue(), Coupleable::coupledVectorValueOld(), and Coupleable::coupledVectorValueOlder().

◆ checkVar()

bool Coupleable::checkVar ( const std::string &  var_name,
unsigned int  comp = 0,
unsigned int  comp_bound = 0 
)
protectedinherited

Check that the right kind of variable is being coupled in.

Parameters
var_nameThe name of the coupled variable

Definition at line 174 of file Coupleable.C.

175 {
176  auto it = _c_coupled_scalar_vars.find(var_name);
177  if (it != _c_coupled_scalar_vars.end())
178  {
179  std::string cvars;
180  for (auto jt : it->second)
181  cvars += " " + jt->name();
182 
183  _obj->paramError(var_name,
184  "cannot couple '",
185  var_name,
186  "' to a scalar variable (",
187  cvars,
188  ") where field variable is expected");
189  }
190 
191  if (!isCoupled(var_name, comp))
192  return false; // return false since variable is *not* coupled
193 
194  auto bound = comp_bound ? comp_bound : _coupled_vars[var_name].size();
195  checkComponent(_obj, comp, bound, var_name);
196 
197  if (!(_coupled_vars[var_name][comp])->isNodal() && _c_nodal)
198  mooseError(_c_name, ": cannot couple elemental variables into nodal objects");
199 
200  return true;
201 }

Referenced by Coupleable::getFEVar(), and Coupleable::getVarHelper().

◆ checkVariable()

void BlockRestrictable::checkVariable ( const MooseVariableFEBase variable) const
inherited

Helper for checking that the ids for this object are in agreement with the variables on the supplied variable.

Parameters
variableThe variable to check against.

Definition at line 314 of file BlockRestrictable.C.

315 {
316  if (!isBlockSubset(variable.activeSubdomains()))
317  {
318  std::string var_ids = Moose::stringify(variable.activeSubdomains(), ", ");
319  std::string obj_ids = Moose::stringify(blockRestricted() ? _blk_ids : meshBlockIDs(), ", ");
320  mooseError("The 'block' parameter of the object '",
321  _blk_name,
322  "' must be a subset of the 'block' parameter of the variable '",
323  variable.name(),
324  "':\n Object '",
325  _blk_name,
326  "': ",
327  obj_ids,
328  "\n Variable '",
329  variable.name(),
330  "': ",
331  var_ids);
332  }
333 }

◆ choleskyAssembly()

template<typename T >
void InitialConditionTempl< T >::choleskyAssembly ( bool  is_volume)
inherited

Assemble a small local system for cholesky solve.

Definition at line 449 of file InitialConditionTempl.C.

450 {
451  // Loop over the quadrature points
452  for (_qp = 0; _qp < _n_qp; _qp++)
453  {
454  // solution at the quadrature point
455  auto fineval = value((*_xyz_values)[_qp]);
456  // solution grad at the quadrature point
457  GradientType finegrad;
458  if (_cont == C_ONE)
459  finegrad = gradient((*_xyz_values)[_qp]);
460 
461  auto dofs_size = is_volume ? _dof_indices.size() : _side_dofs.size();
462 
463  // Form edge projection matrix
464  for (decltype(dofs_size) geomi = 0, freei = 0; geomi != dofs_size; ++geomi)
465  {
466  auto i = is_volume ? geomi : _side_dofs[geomi];
467 
468  // fixed DoFs aren't test functions
469  if (_dof_is_fixed[i])
470  continue;
471  for (decltype(dofs_size) geomj = 0, freej = 0; geomj != dofs_size; ++geomj)
472  {
473  auto j = is_volume ? geomj : _side_dofs[geomj];
474  if (_dof_is_fixed[j])
475  _Fe(freei) -= (*_phi)[i][_qp] * (*_phi)[j][_qp] * (*_JxW)[_qp] * _Ue(j);
476  else
477  _Ke(freei, freej) += (*_phi)[i][_qp] * (*_phi)[j][_qp] * (*_JxW)[_qp];
478  if (_cont == C_ONE)
479  {
480  if (_dof_is_fixed[j])
481  _Fe(freei) -= dotHelper((*_dphi)[i][_qp], (*_dphi)[j][_qp]) * (*_JxW)[_qp] * _Ue(j);
482  else
483  _Ke(freei, freej) += dotHelper((*_dphi)[i][_qp], (*_dphi)[j][_qp]) * (*_JxW)[_qp];
484  }
485  if (!_dof_is_fixed[j])
486  freej++;
487  }
488  _Fe(freei) += (*_phi)[i][_qp] * fineval * (*_JxW)[_qp];
489  if (_cont == C_ONE)
490  _Fe(freei) += dotHelper(finegrad, (*_dphi)[i][_qp]) * (*_JxW)[_qp];
491  freei++;
492  }
493  }
494 }

◆ choleskySolve() [1/2]

template<typename T >
void InitialConditionTempl< T >::choleskySolve ( bool  is_volume)
inherited

Perform the cholesky solves for edge, side, and interior projections.

Definition at line 498 of file InitialConditionTempl.C.

499 {
500  _Ke.resize(_free_dofs, _free_dofs);
501  _Ke.zero();
502  _Fe.resize(_free_dofs);
503  _Fe.zero();
504 
505  choleskyAssembly(is_volume);
506 
507  // The new edge coefficients
508  DenseVector<DataType> U(_free_dofs);
509 
510  _Ke.cholesky_solve(_Fe, U);
511 
512  // Transfer new edge solutions to element
513  for (unsigned int i = 0; i != _free_dofs; ++i)
514  {
515  auto the_dof = is_volume ? _free_dof[i] : _side_dofs[_free_dof[i]];
516  DataType & ui = _Ue(the_dof);
517  libmesh_assert(std::abs(ui) < TOLERANCE || std::abs(ui - U(i)) < TOLERANCE);
518  ui = U(i);
519  _dof_is_fixed[the_dof] = true;
520  }
521 }

◆ choleskySolve() [2/2]

template<>
void InitialConditionTempl< RealEigenVector >::choleskySolve ( bool  is_volume)
inherited

Definition at line 525 of file InitialConditionTempl.C.

526 {
527  _Ke.resize(_free_dofs, _free_dofs);
528  _Ke.zero();
529  _Fe.resize(_free_dofs);
530  for (unsigned int i = 0; i < _free_dofs; ++i)
531  _Fe(i).setZero(_var.count());
532 
533  choleskyAssembly(is_volume);
534 
535  // The new edge coefficients
536  DenseVector<DataType> U = _Fe;
537 
538  for (unsigned int i = 0; i < _var.count(); ++i)
539  {
540  DenseVector<Real> v(_free_dofs), x(_free_dofs);
541  for (unsigned int j = 0; j < _free_dofs; ++j)
542  v(j) = _Fe(j)(i);
543 
544  _Ke.cholesky_solve(v, x);
545 
546  for (unsigned int j = 0; j < _free_dofs; ++j)
547  U(j)(i) = x(j);
548  }
549 
550  // Transfer new edge solutions to element
551  for (unsigned int i = 0; i != _free_dofs; ++i)
552  {
553  auto the_dof = is_volume ? _free_dof[i] : _side_dofs[_free_dof[i]];
554  DataType & ui = _Ue(the_dof);
555  libmesh_assert(ui.matrix().norm() < TOLERANCE || (ui - U(i)).matrix().norm() < TOLERANCE);
556  ui = U(i);
557  _dof_is_fixed[the_dof] = true;
558  }
559 }

◆ compute()

template<typename T >
void InitialConditionTempl< T >::compute ( )
overridevirtualinherited

Workhorse method for projecting the initial conditions for block initial conditions.

Implements InitialConditionBase.

Definition at line 71 of file InitialConditionTempl.C.

72 {
73  // -- NOTE ----
74  // The following code is a copy from libMesh project_vector.C plus it adds some features, so we
75  // can couple variable values
76  // and we also do not call any callbacks, but we use our initial condition system directly.
77  // ------------
78 
79  // The dimension of the current element
80  _dim = _current_elem->dim();
81  // The element type
82  const ElemType elem_type = _current_elem->type();
83  // The number of nodes on the new element
84  const unsigned int n_nodes = _current_elem->n_nodes();
85 
86  // Get FE objects of the appropriate type
87  // We cannot use the FE object in Assembly, since the following code is messing with the
88  // quadrature rules
89  // for projections and would screw it up. However, if we implement projections from one mesh to
90  // another,
91  // this code should use that implementation.
92  std::unique_ptr<FEBaseType> fe(FEBaseType::build(_dim, _fe_type));
93 
94  // Prepare variables for projection
95  std::unique_ptr<QBase> qrule(_fe_type.default_quadrature_rule(_dim));
96  std::unique_ptr<QBase> qedgerule(_fe_type.default_quadrature_rule(1));
97  std::unique_ptr<QBase> qsiderule(_fe_type.default_quadrature_rule(_dim - 1));
98 
99  // The values of the shape functions at the quadrature points
100  _phi = &fe->get_phi();
101 
102  // The gradients of the shape functions at the quadrature points on the child element.
103  _dphi = nullptr;
104 
105  _cont = fe->get_continuity();
106 
107  if (_cont == C_ONE)
108  {
109  const std::vector<std::vector<GradientShapeType>> & ref_dphi = fe->get_dphi();
110  _dphi = &ref_dphi;
111  }
112 
113  // The Jacobian * quadrature weight at the quadrature points
114  _JxW = &fe->get_JxW();
115  // The XYZ locations of the quadrature points
116  _xyz_values = &fe->get_xyz();
117 
118  // Update the DOF indices for this element based on the current mesh
119  _var.prepareIC();
121 
122  // The number of DOFs on the element
123  const unsigned int n_dofs = _dof_indices.size();
124  if (n_dofs == 0)
125  return;
126 
127  // Fixed vs. free DoFs on edge/face projections
128  _dof_is_fixed.clear();
129  _dof_is_fixed.resize(n_dofs, false);
130  _free_dof.clear();
131  _free_dof.resize(n_dofs, 0);
132 
133  // Zero the interpolated values
134  _Ue.resize(n_dofs);
135  _Ue.zero();
136 
137  DenseVector<char> mask(n_dofs, true);
138 
139  // In general, we need a series of
140  // projections to ensure a unique and continuous
141  // solution. We start by interpolating nodes, then
142  // hold those fixed and project edges, then
143  // hold those fixed and project faces, then
144  // hold those fixed and project interiors
145 
146  // Interpolate node values first
147  _current_dof = 0;
148 
149  for (_n = 0; _n != n_nodes; ++_n)
150  {
151  _nc = FEInterface::n_dofs_at_node(_dim, _fe_type, elem_type, _n);
152 
153  // for nodes that are in more than one subdomain, only compute the initial
154  // condition once on the lowest numbered block
155  auto curr_node = _current_elem->node_ptr(_n);
156  const auto & block_ids = _sys.mesh().getNodeBlockIds(*curr_node);
157 
158  auto priority_block = *(block_ids.begin());
159  for (auto id : block_ids)
160  if (_var.hasBlocks(id))
161  {
162  priority_block = id;
163  break;
164  }
165 
166  if (!hasBlocks(priority_block) && _var.isNodal())
167  {
168  for (decltype(_nc) i = 0; i < _nc; ++i)
169  {
170  mask(_current_dof) = false;
171  _current_dof++;
172  }
173  continue;
174  }
175 
176  // FIXME: this should go through the DofMap,
177  // not duplicate _dof_indices code badly!
178  if (!_current_elem->is_vertex(_n))
179  {
180  _current_dof += _nc;
181  continue;
182  }
183 
184  if (_cont == DISCONTINUOUS)
185  libmesh_assert(_nc == 0);
186  else if (_cont == C_ZERO)
188  else if (_fe_type.family == HERMITE)
190  else if (_cont == C_ONE)
192  else
193  libmesh_error();
194  } // loop over nodes
195 
196  // From here on out we won't be sampling at nodes anymore
197  _current_node = nullptr;
198 
199  // In 3D, project any edge values next
200  if (_dim > 2 && _cont != DISCONTINUOUS)
201  for (unsigned int e = 0; e != _current_elem->n_edges(); ++e)
202  {
203  FEInterface::dofs_on_edge(_current_elem, _dim, _fe_type, e, _side_dofs);
204 
205  // Some edge dofs are on nodes and already
206  // fixed, others are free to calculate
207  _free_dofs = 0;
208  for (unsigned int i = 0; i != _side_dofs.size(); ++i)
209  if (!_dof_is_fixed[_side_dofs[i]])
210  _free_dof[_free_dofs++] = i;
211 
212  // There may be nothing to project
213  if (!_free_dofs)
214  continue;
215 
216  // Initialize FE data on the edge
217  fe->attach_quadrature_rule(qedgerule.get());
218  fe->edge_reinit(_current_elem, e);
219  _n_qp = qedgerule->n_points();
220 
221  choleskySolve(false);
222  }
223 
224  // Project any side values (edges in 2D, faces in 3D)
225  if (_dim > 1 && _cont != DISCONTINUOUS)
226  for (unsigned int s = 0; s != _current_elem->n_sides(); ++s)
227  {
228  FEInterface::dofs_on_side(_current_elem, _dim, _fe_type, s, _side_dofs);
229 
230  // Some side dofs are on nodes/edges and already
231  // fixed, others are free to calculate
232  _free_dofs = 0;
233  for (unsigned int i = 0; i != _side_dofs.size(); ++i)
234  if (!_dof_is_fixed[_side_dofs[i]])
235  _free_dof[_free_dofs++] = i;
236 
237  // There may be nothing to project
238  if (!_free_dofs)
239  continue;
240 
241  // Initialize FE data on the side
242  fe->attach_quadrature_rule(qsiderule.get());
243  fe->reinit(_current_elem, s);
244  _n_qp = qsiderule->n_points();
245 
246  choleskySolve(false);
247  }
248 
249  // Project the interior values, finally
250 
251  // Some interior dofs are on nodes/edges/sides and
252  // already fixed, others are free to calculate
253  _free_dofs = 0;
254  for (unsigned int i = 0; i != n_dofs; ++i)
255  if (!_dof_is_fixed[i])
256  _free_dof[_free_dofs++] = i;
257 
258  // There may be nothing to project
259  if (_free_dofs)
260  {
261  // Initialize FE data
262  fe->attach_quadrature_rule(qrule.get());
263  fe->reinit(_current_elem);
264  _n_qp = qrule->n_points();
265 
266  choleskySolve(true);
267  } // if there are free interior dofs
268 
269  // Make sure every DoF got reached!
270  for (unsigned int i = 0; i != n_dofs; ++i)
271  libmesh_assert(_dof_is_fixed[i]);
272 
273  // Lock the new_vector since it is shared among threads.
274  {
275  Threads::spin_mutex::scoped_lock lock(Threads::spin_mtx);
276  for (size_t i = 0; i < mask.size(); i++)
277  if (mask(i))
278  _var.setDofValue(_Ue(i), i);
279  }
280 }

◆ computeNodal()

template<typename T >
void InitialConditionTempl< T >::computeNodal ( const Point &  p)
overridevirtualinherited

Workhorse method for projecting the initial conditions for boundary restricted initial conditions.

Implements InitialConditionBase.

Definition at line 563 of file InitialConditionTempl.C.

564 {
565  _var.reinitNode();
566  _var.computeNodalValues(); // has to call this to resize the internal array
567  auto return_value = value(p);
568 
569  _var.setNodalValue(return_value); // update variable data, which is referenced by others, so the
570  // value is up-to-date
571 
572  // We are done, so update the solution vector
573  {
574  Threads::spin_mutex::scoped_lock lock(Threads::spin_mtx);
575  _var.insert(_var.sys().solution());
576  }
577 }

◆ coupled()

unsigned int Coupleable::coupled ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns the index for a coupled variable by name.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Index of coupled variable, if this is an optionally coupled variable that wasn't provided this will return a unique "invalid" index.

Reimplemented in ShapeUserObject< ElementUserObject >, and ShapeUserObject< SideUserObject >.

Definition at line 364 of file Coupleable.C.

365 {
366  MooseVariableFEBase * var = getFEVar(var_name, comp);
367  if (!var)
368  {
369  // make sure we don't try to access default var ids that were not provided
370  checkComponent(_obj, comp, _optional_var_index[var_name].size(), var_name);
371  return _optional_var_index[var_name][comp];
372  }
374 
375  switch (var->kind())
376  {
378  return var->number();
380  return std::numeric_limits<unsigned int>::max() - var->number();
381  default:
382  mooseError(_c_name, ": Unknown variable kind. Corrupted binary?");
383  }
384 }

Referenced by FunctionMaterialBase::FunctionMaterialBase(), KernelBase::KernelBase(), and NodalEqualValueConstraint::NodalEqualValueConstraint().

◆ coupledArrayDot()

const ArrayVariableValue & Coupleable::coupledArrayDot ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Time derivative of a coupled array variable.

Parameters
var_nameName of coupled array variable
compComponent number for vector of coupled array variables
Returns
Reference to a ArrayVariableValue containing the time derivative of the coupled variable

Definition at line 786 of file Coupleable.C.

787 {
788  ArrayMooseVariable * var = getArrayVar(var_name, comp);
789  if (!var)
792 
794  {
795  if (_c_nodal)
796  return var->dofValuesDot();
797  return var->uDot();
798  }
799  else
800  {
801  if (_c_nodal)
802  return var->dofValuesDotNeighbor();
803  return var->uDotNeighbor();
804  }
805 }

◆ coupledArrayDotDot()

const ArrayVariableValue & Coupleable::coupledArrayDotDot ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Second time derivative of a coupled array variable.

Parameters
var_nameName of coupled array variable
compComponent number for vector of coupled array variables
Returns
Reference to a ArrayVariableValue containing the time derivative of the coupled variable

Definition at line 808 of file Coupleable.C.

809 {
810  ArrayMooseVariable * var = getArrayVar(var_name, comp);
811  if (!var)
814 
816  {
817  if (_c_nodal)
818  return var->dofValuesDotDot();
819  return var->uDotDot();
820  }
821  else
822  {
823  if (_c_nodal)
824  return var->dofValuesDotDotNeighbor();
825  return var->uDotDotNeighbor();
826  }
827 }

◆ coupledArrayDotDotOld()

const ArrayVariableValue & Coupleable::coupledArrayDotDotOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Old second time derivative of a coupled array variable.

Parameters
var_nameName of coupled array variable
compComponent number for vector of coupled array variables
Returns
Reference to a ArrayVariableValue containing the time derivative of the coupled variable

Definition at line 852 of file Coupleable.C.

853 {
854  ArrayMooseVariable * var = getArrayVar(var_name, comp);
855  if (!var)
858 
860  {
861  if (_c_nodal)
862  return var->dofValuesDotDotOld();
863  return var->uDotDotOld();
864  }
865  else
866  {
867  if (_c_nodal)
868  return var->dofValuesDotDotOldNeighbor();
869  return var->uDotDotOldNeighbor();
870  }
871 }

◆ coupledArrayDotOld()

const ArrayVariableValue & Coupleable::coupledArrayDotOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Old time derivative of a coupled array variable.

Parameters
var_nameName of coupled array variable
compComponent number for vector of coupled array variables
Returns
Reference to a ArrayVariableValue containing the time derivative of the coupled variable

Definition at line 830 of file Coupleable.C.

831 {
832  ArrayMooseVariable * var = getArrayVar(var_name, comp);
833  if (!var)
836 
838  {
839  if (_c_nodal)
840  return var->dofValuesDotOld();
841  return var->uDotOld();
842  }
843  else
844  {
845  if (_c_nodal)
846  return var->dofValuesDotOldNeighbor();
847  return var->uDotOldNeighbor();
848  }
849 }

◆ coupledArrayGradient()

const ArrayVariableGradient & Coupleable::coupledArrayGradient ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns gradient of a coupled array variable.

Parameters
var_nameName of coupled array variable
compComponent number for vector of coupled array variables
Returns
Reference to a VectorVariableGradient containing the gradient of the coupled array variable

Definition at line 1036 of file Coupleable.C.

1037 {
1038  ArrayMooseVariable * var = getArrayVar(var_name, comp);
1039  if (!var)
1040  return _default_array_gradient;
1042 
1043  if (!_coupleable_neighbor)
1044  return (_c_is_implicit) ? var->gradSln() : var->gradSlnOld();
1045  return (_c_is_implicit) ? var->gradSlnNeighbor() : var->gradSlnOldNeighbor();
1046 }

◆ coupledArrayGradientOld()

const ArrayVariableGradient & Coupleable::coupledArrayGradientOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old gradient from previous time step of a coupled array variable.

Parameters
var_nameName of coupled array variable
compComponent number for vector of coupled array variables
Returns
Reference to a VectorVariableGradient containing the old gradient of the coupled array variable

Definition at line 1049 of file Coupleable.C.

1050 {
1051  ArrayMooseVariable * var = getArrayVar(var_name, comp);
1052  if (!var)
1053  return _default_array_gradient;
1055 
1056  if (!_coupleable_neighbor)
1057  return (_c_is_implicit) ? var->gradSlnOld() : var->gradSlnOlder();
1058  return (_c_is_implicit) ? var->gradSlnOldNeighbor() : var->gradSlnOlderNeighbor();
1059 }

◆ coupledArrayGradientOlder()

const ArrayVariableGradient & Coupleable::coupledArrayGradientOlder ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old gradient from two time steps previous of a coupled array variable.

Parameters
var_nameName of coupled array variable
compComponent number for vector of coupled array variables
Returns
Reference to a ArrayVariableGradient containing the older gradient of the coupled array variable

Definition at line 1062 of file Coupleable.C.

1063 {
1064  ArrayMooseVariable * var = getArrayVar(var_name, comp);
1065  if (!var)
1066  return _default_array_gradient;
1068 
1069  if (!_coupleable_neighbor)
1070  return var->gradSlnOlder();
1071  return var->gradSlnOlderNeighbor();
1072 }

◆ coupledArrayValue()

const ArrayVariableValue & Coupleable::coupledArrayValue ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns value of a coupled array variable.

Parameters
var_nameName of coupled vector variable
compComponent number for vector of coupled vector variables
Returns
Reference to a ArrayVariableValue for the coupled vector variable
See also
ArrayKernel::_u

Definition at line 455 of file Coupleable.C.

456 {
457  ArrayMooseVariable * var = getArrayVar(var_name, comp);
458  if (!var)
459  return *getDefaultArrayValue(var_name);
461 
463  {
464  if (_c_nodal)
465  return (_c_is_implicit) ? var->dofValues() : var->dofValuesOld();
466  return (_c_is_implicit) ? var->sln() : var->slnOld();
467  }
468  else
469  {
470  if (_c_nodal)
471  return (_c_is_implicit) ? var->dofValuesNeighbor() : var->dofValuesOldNeighbor();
472  return (_c_is_implicit) ? var->slnNeighbor() : var->slnOldNeighbor();
473  }
474 }

◆ coupledArrayValueOld()

const ArrayVariableValue & Coupleable::coupledArrayValueOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old value from previous time step of a coupled array variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a ArrayVariableValue containing the old value of the coupled variable
See also
ArrayKernel::_u_old

Definition at line 576 of file Coupleable.C.

577 {
578  ArrayMooseVariable * var = getArrayVar(var_name, comp);
579  if (!var)
580  return *getDefaultArrayValue(var_name);
582 
584  {
585  if (_c_nodal)
586  return (_c_is_implicit) ? var->dofValuesOld() : var->dofValuesOlder();
587  return (_c_is_implicit) ? var->slnOld() : var->slnOlder();
588  }
589  else
590  {
591  if (_c_nodal)
593  return (_c_is_implicit) ? var->slnOldNeighbor() : var->slnOlderNeighbor();
594  }
595 }

◆ coupledArrayValueOlder()

const ArrayVariableValue & Coupleable::coupledArrayValueOlder ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old value from two time steps previous of a coupled array variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a ArrayVariableValue containing the older value of the coupled variable
See also
ArrayKernel::_u_older

Definition at line 598 of file Coupleable.C.

599 {
600  ArrayMooseVariable * var = getArrayVar(var_name, comp);
601  if (!var)
602  return *getDefaultArrayValue(var_name);
604 
606  {
607  if (_c_nodal)
608  return var->dofValuesOlder();
609  return var->slnOlder();
610  }
611  else
612  {
613  if (_c_nodal)
614  return var->dofValuesOlderNeighbor();
615  return var->slnOlderNeighbor();
616  }
617 }

◆ coupledCallback()

virtual void Coupleable::coupledCallback ( const std::string &  ,
bool   
)
inlineprotectedvirtualinherited

A call-back function provided by the derived object for actions before coupling a variable with functions such as coupledValue.

Reimplemented in AuxKernelTempl< ComputeValueType >.

Definition at line 130 of file Coupleable.h.

130 {}

Referenced by Coupleable::adCoupledNodalValueTemplate(), and Coupleable::checkFuncType().

◆ coupledComponents()

unsigned int Coupleable::coupledComponents ( const std::string &  var_name)
protectedinherited

Number of coupled components.

Parameters
var_nameName of the variable
Returns
number of components this variable has (usually 1)

Definition at line 128 of file Coupleable.C.

129 {
130  if (isCoupled(var_name))
131  return _coupled_vars[var_name].size();
132  else
133  {
135  return _c_parameters.numberDefaultCoupledValues(var_name);
136  else
137  return 0;
138  }
139 }

Referenced by KernelBase::KernelBase(), NodalEqualValueConstraint::NodalEqualValueConstraint(), SpatialAverageBase::SpatialAverageBase(), and VolumeHistogram::VolumeHistogram().

◆ coupledCurl()

const VectorVariableCurl & Coupleable::coupledCurl ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns curl of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VectorVariableCurl containing the curl of the coupled variable
See also
Kernel::_curl_u

Definition at line 1075 of file Coupleable.C.

1076 {
1077  VectorMooseVariable * var = getVectorVar(var_name, comp);
1078  if (!var)
1079  return _default_vector_curl;
1081 
1082  if (!_coupleable_neighbor)
1083  return (_c_is_implicit) ? var->curlSln() : var->curlSlnOld();
1084  return (_c_is_implicit) ? var->curlSlnNeighbor() : var->curlSlnOldNeighbor();
1085 }

◆ coupledCurlOld()

const VectorVariableCurl & Coupleable::coupledCurlOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old curl from previous time step of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VectorVariableCurl containing the old curl of the coupled variable
See also
Kernel::_curl_u_old

Definition at line 1088 of file Coupleable.C.

1089 {
1090  VectorMooseVariable * var = getVectorVar(var_name, comp);
1091  if (!var)
1092  return _default_vector_curl;
1094 
1095  if (!_coupleable_neighbor)
1096  return (_c_is_implicit) ? var->curlSlnOld() : var->curlSlnOlder();
1097  return (_c_is_implicit) ? var->curlSlnOldNeighbor() : var->curlSlnOlderNeighbor();
1098 }

◆ coupledCurlOlder()

const VectorVariableCurl & Coupleable::coupledCurlOlder ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old curl from two time steps previous of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VectorVariableCurl containing the older curl of the coupled variable
See also
Kernel::_curl_u_older

Definition at line 1101 of file Coupleable.C.

1102 {
1103  VectorMooseVariable * var = getVectorVar(var_name, comp);
1104  if (!var)
1105  return _default_vector_curl;
1107 
1108  if (!_coupleable_neighbor)
1109  return var->curlSlnOlder();
1110  return var->curlSlnOlderNeighbor();
1111 }

◆ coupledDofValues()

const VariableValue & Coupleable::coupledDofValues ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns DoFs in the current solution vector of a coupled variable for the local element.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue for the DoFs of the coupled variable

Definition at line 1297 of file Coupleable.C.

1298 {
1299  MooseVariable * var = getVar(var_name, comp);
1300  if (!var)
1301  return *getDefaultValue(var_name, comp);
1303 
1304  if (!_coupleable_neighbor)
1305  return (_c_is_implicit) ? var->dofValues() : var->dofValuesOld();
1306  return (_c_is_implicit) ? var->dofValuesNeighbor() : var->dofValuesOldNeighbor();
1307 }

◆ coupledDofValuesOld()

const VariableValue & Coupleable::coupledDofValuesOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns DoFs in the old solution vector of a coupled variable for the local element.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue for the old DoFs of the coupled variable

Definition at line 1310 of file Coupleable.C.

1311 {
1312  MooseVariable * var = getVar(var_name, comp);
1313  if (!var)
1314  return *getDefaultValue(var_name, comp);
1316 
1317  if (!_coupleable_neighbor)
1318  return (_c_is_implicit) ? var->dofValuesOld() : var->dofValuesOlder();
1319  return (_c_is_implicit) ? var->dofValuesOldNeighbor() : var->dofValuesOlderNeighbor();
1320 }

◆ coupledDofValuesOlder()

const VariableValue & Coupleable::coupledDofValuesOlder ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns DoFs in the older solution vector of a coupled variable for the local element.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue for the older DoFs of the coupled variable

Definition at line 1323 of file Coupleable.C.

1324 {
1325  MooseVariable * var = getVar(var_name, comp);
1326  if (!var)
1327  return *getDefaultValue(var_name, comp);
1329 
1330  if (!_coupleable_neighbor)
1331  return var->dofValuesOlder();
1332  return var->dofValuesOlderNeighbor();
1333 }

◆ coupledDot()

const VariableValue & Coupleable::coupledDot ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Time derivative of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the time derivative of the coupled variable

Reimplemented in AuxKernelTempl< ComputeValueType >.

Definition at line 620 of file Coupleable.C.

621 {
622  MooseVariable * var = getVar(var_name, comp);
623  if (!var)
624  return _default_value_zero;
626 
628  {
629  if (_c_nodal)
630  return var->dofValuesDot();
631  return var->uDot();
632  }
633  else
634  {
635  if (_c_nodal)
636  return var->dofValuesDotNeighbor();
637  return var->uDotNeighbor();
638  }
639 }

Referenced by AuxKernelTempl< ComputeValueType >::coupledDot().

◆ coupledDotDot()

const VariableValue & Coupleable::coupledDotDot ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Second time derivative of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the time derivative of the coupled variable

Definition at line 642 of file Coupleable.C.

643 {
644  MooseVariable * var = getVar(var_name, comp);
645  if (!var)
646  return _default_value_zero;
648 
650  {
651  if (_c_nodal)
652  return var->dofValuesDotDot();
653  return var->uDotDot();
654  }
655  else
656  {
657  if (_c_nodal)
658  return var->dofValuesDotDotNeighbor();
659  return var->uDotDotNeighbor();
660  }
661 }

◆ coupledDotDotDu()

const VariableValue & Coupleable::coupledDotDotDu ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Second time derivative of a coupled variable with respect to the coefficients.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the time derivative of the coupled variable with respect to the coefficients

Definition at line 896 of file Coupleable.C.

897 {
898  MooseVariable * var = getVar(var_name, comp);
899  if (!var)
900  return _default_value_zero;
902 
904  {
905  if (_c_nodal)
906  return var->dofValuesDuDotDotDu();
907  return var->duDotDotDu();
908  }
909  else
910  {
911  if (_c_nodal)
912  return var->dofValuesDuDotDotDuNeighbor();
913  return var->duDotDotDuNeighbor();
914  }
915 }

◆ coupledDotDotOld()

const VariableValue & Coupleable::coupledDotDotOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Old second time derivative of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the time derivative of the coupled variable

Definition at line 686 of file Coupleable.C.

687 {
688  MooseVariable * var = getVar(var_name, comp);
689  if (!var)
690  return _default_value_zero;
692 
694  {
695  if (_c_nodal)
696  return var->dofValuesDotDotOld();
697  return var->uDotDotOld();
698  }
699  else
700  {
701  if (_c_nodal)
702  return var->dofValuesDotDotOldNeighbor();
703  return var->uDotDotOldNeighbor();
704  }
705 }

◆ coupledDotDu()

const VariableValue & Coupleable::coupledDotDu ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Time derivative of a coupled variable with respect to the coefficients.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the time derivative of the coupled variable with respect to the coefficients

Reimplemented in AuxKernelTempl< ComputeValueType >.

Definition at line 874 of file Coupleable.C.

875 {
876  MooseVariable * var = getVar(var_name, comp);
877  if (!var)
878  return _default_value_zero;
880 
882  {
883  if (_c_nodal)
884  return var->dofValuesDuDotDu();
885  return var->duDotDu();
886  }
887  else
888  {
889  if (_c_nodal)
890  return var->dofValuesDuDotDuNeighbor();
891  return var->duDotDuNeighbor();
892  }
893 }

Referenced by AuxKernelTempl< ComputeValueType >::coupledDotDu().

◆ coupledDotOld()

const VariableValue & Coupleable::coupledDotOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Old time derivative of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the time derivative of the coupled variable

Definition at line 664 of file Coupleable.C.

665 {
666  MooseVariable * var = getVar(var_name, comp);
667  if (!var)
668  return _default_value_zero;
670 
672  {
673  if (_c_nodal)
674  return var->dofValuesDotOld();
675  return var->uDotOld();
676  }
677  else
678  {
679  if (_c_nodal)
680  return var->dofValuesDotOldNeighbor();
681  return var->uDotOldNeighbor();
682  }
683 }

◆ coupledGradient()

const VariableGradient & Coupleable::coupledGradient ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns gradient of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableGradient containing the gradient of the coupled variable
See also
Kernel::gradient

Definition at line 918 of file Coupleable.C.

919 {
920  MooseVariable * var = getVar(var_name, comp);
921  if (!var)
922  return _default_gradient;
924 
926  return (_c_is_implicit) ? var->gradSln() : var->gradSlnOld();
927  return (_c_is_implicit) ? var->gradSlnNeighbor() : var->gradSlnOldNeighbor();
928 }

Referenced by NodeElemConstraint::coupledSlaveGradient(), and NodeFaceConstraint::coupledSlaveGradient().

◆ coupledGradientDot()

const VariableGradient & Coupleable::coupledGradientDot ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Time derivative of the gradient of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableGradient containing the time derivative of the gradient of a coupled variable

Definition at line 971 of file Coupleable.C.

972 {
973  MooseVariable * var = getVar(var_name, comp);
974  if (!var)
975  return _default_gradient;
977 
979  return var->gradSlnDot();
980  return var->gradSlnNeighborDot();
981 }

◆ coupledGradientDotDot()

const VariableGradient & Coupleable::coupledGradientDotDot ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Second time derivative of the gradient of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableGradient containing the time derivative of the gradient of a coupled variable

Definition at line 984 of file Coupleable.C.

985 {
986  MooseVariable * var = getVar(var_name, comp);
987  if (!var)
988  return _default_gradient;
990 
992  return var->gradSlnDotDot();
993  return var->gradSlnNeighborDotDot();
994 }

◆ coupledGradientOld()

const VariableGradient & Coupleable::coupledGradientOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old gradient from previous time step of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableGradient containing the old gradient of the coupled variable
See also
Kernel::gradientOld

Definition at line 931 of file Coupleable.C.

932 {
933  MooseVariable * var = getVar(var_name, comp);
934  if (!var)
935  return _default_gradient;
937 
939  return (_c_is_implicit) ? var->gradSlnOld() : var->gradSlnOlder();
940  return (_c_is_implicit) ? var->gradSlnOldNeighbor() : var->gradSlnOlderNeighbor();
941 }

Referenced by NodeElemConstraint::coupledSlaveGradientOld(), and NodeFaceConstraint::coupledSlaveGradientOld().

◆ coupledGradientOlder()

const VariableGradient & Coupleable::coupledGradientOlder ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old gradient from two time steps previous of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableGradient containing the older gradient of the coupled variable
See also
Kernel::gradientOlder

Definition at line 944 of file Coupleable.C.

945 {
946  MooseVariable * var = getVar(var_name, comp);
947  if (!var)
948  return _default_gradient;
950 
952  return var->gradSlnOlder();
953  return var->gradSlnOlderNeighbor();
954 }

Referenced by NodeElemConstraint::coupledSlaveGradientOlder(), and NodeFaceConstraint::coupledSlaveGradientOlder().

◆ coupledGradientPreviousNL()

const VariableGradient & Coupleable::coupledGradientPreviousNL ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns gradient of a coupled variable for previous Newton iterate.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableGradient containing the gradient of the coupled variable

Definition at line 957 of file Coupleable.C.

958 {
959  MooseVariable * var = getVar(var_name, comp);
961  if (!var)
962  return _default_gradient;
964 
966  return var->gradSlnPreviousNL();
967  return var->gradSlnPreviousNLNeighbor();
968 }

◆ coupledMatrixTagValue()

const VariableValue & Coupleable::coupledMatrixTagValue ( const std::string &  var_name,
TagID  tag,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns value of a coupled variable for a given tag.

This couples the diag vector of matrix

Parameters
var_nameName of coupled variable
tagmatrix tag ID
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue for the coupled variable
See also
Kernel::_u

Definition at line 427 of file Coupleable.C.

428 {
429  MooseVariable * var = getVar(var_name, comp);
430  if (!var)
431  mooseError(var_name, ": invalid variable name for coupledMatrixTagValue");
433 
435 
436  if (_c_nodal)
437  return var->nodalMatrixTagValue(tag);
438  return var->matrixTagValue(tag);
439 }

◆ coupledNodalDot()

template<typename T >
const template RealVectorValue & Coupleable::coupledNodalDot< RealVectorValue > ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedinherited

Nodal values of time derivative of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the nodal values of time derivative of the coupled variable

Definition at line 1244 of file Coupleable.C.

1245 {
1246  static const T zero = 0;
1247  MooseVariableFE<T> * var = getVarHelper<T>(var_name, comp);
1248  if (!var)
1249  return zero;
1251 
1252  if (!_coupleable_neighbor)
1253  return var->nodalValueDot();
1254  mooseError("Neighbor version not implemented");
1255 }

◆ coupledNodalDotDot()

const VariableValue & Coupleable::coupledNodalDotDot ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Nodal values of second time derivative of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the nodal values of second time derivative of the coupled variable

Definition at line 1258 of file Coupleable.C.

1259 {
1260  MooseVariable * var = getVar(var_name, comp);
1261  if (!var)
1262  return _default_value_zero;
1264 
1265  if (!_coupleable_neighbor)
1266  return var->dofValuesDotDot();
1267  return var->dofValuesDotDotNeighbor();
1268 }

◆ coupledNodalDotDotOld()

const VariableValue & Coupleable::coupledNodalDotDotOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Nodal values of old second time derivative of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the nodal values of second time derivative of the coupled variable

Definition at line 1284 of file Coupleable.C.

1285 {
1286  MooseVariable * var = getVar(var_name, comp);
1287  if (!var)
1288  return _default_value_zero;
1290 
1291  if (!_coupleable_neighbor)
1292  return var->dofValuesDotDotOld();
1293  return var->dofValuesDotDotOldNeighbor();
1294 }

◆ coupledNodalDotOld()

const VariableValue & Coupleable::coupledNodalDotOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Nodal values of old time derivative of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the nodal values of time derivative of the coupled variable

Definition at line 1271 of file Coupleable.C.

1272 {
1273  MooseVariable * var = getVar(var_name, comp);
1274  if (!var)
1275  return _default_value_zero;
1277 
1278  if (!_coupleable_neighbor)
1279  return var->dofValuesDotOld();
1280  return var->dofValuesDotOldNeighbor();
1281 }

◆ coupledNodalValue()

template<typename T >
const template RealVectorValue & Coupleable::coupledNodalValue< RealVectorValue > ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedinherited

Returns nodal values of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue for the coupled variable

Definition at line 1168 of file Coupleable.C.

1169 {
1170  MooseVariableFE<T> * var = getVarHelper<T>(var_name, comp);
1171  if (!var)
1172  return getDefaultNodalValue<T>(var_name, comp);
1174 
1175  if (!var->isNodal())
1177  ": Trying to get nodal values of variable '",
1178  var->name(),
1179  "', but it is not nodal.");
1180 
1181  if (!_coupleable_neighbor)
1182  return (_c_is_implicit) ? var->nodalValue() : var->nodalValueOld();
1183  return (_c_is_implicit) ? var->nodalValueNeighbor() : var->nodalValueOldNeighbor();
1184 }

◆ coupledNodalValueOld()

template<typename T >
const template RealVectorValue & Coupleable::coupledNodalValueOld< RealVectorValue > ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedinherited

Returns an old nodal value from previous time step of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the old value of the coupled variable

Definition at line 1188 of file Coupleable.C.

1189 {
1190  MooseVariableFE<T> * var = getVarHelper<T>(var_name, comp);
1191  if (!var)
1192  return getDefaultNodalValue<T>(var_name, comp);
1194 
1195  if (!var->isNodal())
1197  ": Trying to get old nodal values of variable '",
1198  var->name(),
1199  "', but it is not nodal.");
1200 
1201  if (!_coupleable_neighbor)
1202  return (_c_is_implicit) ? var->nodalValueOld() : var->nodalValueOlder();
1204 }

◆ coupledNodalValueOlder()

template<typename T >
const template RealVectorValue & Coupleable::coupledNodalValueOlder< RealVectorValue > ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedinherited

Returns an old nodal value from two time steps previous of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the older value of the coupled variable

Definition at line 1208 of file Coupleable.C.

1209 {
1210  MooseVariableFE<T> * var = getVarHelper<T>(var_name, comp);
1211  if (!var)
1212  return getDefaultNodalValue<T>(var_name, comp);
1214 
1215  if (!var->isNodal())
1217  ": Trying to get older nodal values of variable '",
1218  var->name(),
1219  "', but it is not nodal.");
1220 
1221  if (!_coupleable_neighbor)
1222  return var->nodalValueOlder();
1223  return var->nodalValueOlderNeighbor();
1224 }

◆ coupledNodalValuePreviousNL()

template<typename T >
const template RealVectorValue & Coupleable::coupledNodalValuePreviousNL< RealVectorValue > ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedinherited

Returns nodal values of a coupled variable for previous Newton iterate.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue for the coupled variable

Definition at line 1228 of file Coupleable.C.

1229 {
1230  MooseVariableFE<T> * var = getVarHelper<T>(var_name, comp);
1231  if (!var)
1232  return getDefaultNodalValue<T>(var_name, comp);
1234 
1236 
1237  if (!_coupleable_neighbor)
1238  return var->nodalValuePreviousNL();
1239  return var->nodalValuePreviousNLNeighbor();
1240 }

◆ coupledSecond()

const VariableSecond & Coupleable::coupledSecond ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns second derivative of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableSecond containing the second derivative of the coupled variable
See also
Kernel::second

Definition at line 1114 of file Coupleable.C.

1115 {
1116  MooseVariable * var = getVar(var_name, comp);
1117  if (!var)
1118  return _default_second;
1120 
1121  if (!_coupleable_neighbor)
1122  return (_c_is_implicit) ? var->secondSln() : var->secondSlnOlder();
1123  return (_c_is_implicit) ? var->secondSlnNeighbor() : var->secondSlnOlderNeighbor();
1124 }

Referenced by NodeElemConstraint::coupledSlaveSecond(), and NodeFaceConstraint::coupledSlaveSecond().

◆ coupledSecondOld()

const VariableSecond & Coupleable::coupledSecondOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old second derivative from previous time step of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableSecond containing the old second derivative of the coupled variable
See also
Kernel::secondOld

Definition at line 1127 of file Coupleable.C.

1128 {
1129  MooseVariable * var = getVar(var_name, comp);
1130  if (!var)
1131  return _default_second;
1133 
1134  if (!_coupleable_neighbor)
1135  return (_c_is_implicit) ? var->secondSlnOld() : var->secondSlnOlder();
1136  return (_c_is_implicit) ? var->secondSlnOldNeighbor() : var->secondSlnOlderNeighbor();
1137 }

◆ coupledSecondOlder()

const VariableSecond & Coupleable::coupledSecondOlder ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old second derivative from two time steps previous of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableSecond containing the older second derivative of the coupled variable
See also
Kernel::secondOlder

Definition at line 1140 of file Coupleable.C.

1141 {
1142  MooseVariable * var = getVar(var_name, comp);
1143  if (!var)
1144  return _default_second;
1146 
1147  if (!_coupleable_neighbor)
1148  return var->secondSlnOlder();
1149  return var->secondSlnOlderNeighbor();
1150 }

◆ coupledSecondPreviousNL()

const VariableSecond & Coupleable::coupledSecondPreviousNL ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns second derivative of a coupled variable for the previous Newton iterate.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableSecond containing the second derivative of the coupled variable

Definition at line 1153 of file Coupleable.C.

1154 {
1155  MooseVariable * var = getVar(var_name, comp);
1157  if (!var)
1158  return _default_second;
1160 
1161  if (!_coupleable_neighbor)
1162  return var->secondSlnPreviousNL();
1163  return var->secondSlnPreviousNLNeighbor();
1164 }

◆ coupledValue()

const VariableValue & Coupleable::coupledValue ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns value of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue for the coupled variable
See also
Kernel::_u

Definition at line 387 of file Coupleable.C.

388 {
389  MooseVariable * var = getVar(var_name, comp);
390  if (!var)
391  return *getDefaultValue(var_name, comp);
393 
395  {
396  if (_c_nodal)
397  return (_c_is_implicit) ? var->dofValues() : var->dofValuesOld();
398  else
399  return (_c_is_implicit) ? var->sln() : var->slnOld();
400  }
401  else
402  {
403  if (_c_nodal)
404  return (_c_is_implicit) ? var->dofValuesNeighbor() : var->dofValuesOldNeighbor();
405  else
406  return (_c_is_implicit) ? var->slnNeighbor() : var->slnOldNeighbor();
407  }
408 }

Referenced by NodeElemConstraint::coupledSlaveValue(), NodeFaceConstraint::coupledSlaveValue(), FunctionMaterialBase::FunctionMaterialBase(), NodalEqualValueConstraint::NodalEqualValueConstraint(), ParsedAux::ParsedAux(), SpatialAverageBase::SpatialAverageBase(), VariableTimeIntegrationAux::VariableTimeIntegrationAux(), and Coupleable::writableCoupledValue().

◆ coupledValueOld()

const VariableValue & Coupleable::coupledValueOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old value from previous time step of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the old value of the coupled variable
See also
Kernel::valueOld

Definition at line 483 of file Coupleable.C.

484 {
485  MooseVariable * var = getVar(var_name, comp);
486  if (!var)
487  return *getDefaultValue(var_name, comp);
489 
491  {
492  if (_c_nodal)
493  return (_c_is_implicit) ? var->dofValuesOld() : var->dofValuesOlder();
494  return (_c_is_implicit) ? var->slnOld() : var->slnOlder();
495  }
496  else
497  {
498  if (_c_nodal)
500  return (_c_is_implicit) ? var->slnOldNeighbor() : var->slnOlderNeighbor();
501  }
502 }

Referenced by NodeElemConstraint::coupledSlaveValueOld(), NodeFaceConstraint::coupledSlaveValueOld(), and VariableTimeIntegrationAux::VariableTimeIntegrationAux().

◆ coupledValueOlder()

const VariableValue & Coupleable::coupledValueOlder ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old value from two time steps previous of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the older value of the coupled variable
See also
Kernel::valueOlder

Definition at line 505 of file Coupleable.C.

506 {
507  MooseVariable * var = getVar(var_name, comp);
508  if (!var)
509  return *getDefaultValue(var_name, comp);
511 
513  {
514  if (_c_nodal)
515  return var->dofValuesOlder();
516  return var->slnOlder();
517  }
518  else
519  {
520  if (_c_nodal)
521  return var->dofValuesOlderNeighbor();
522  return var->slnOlderNeighbor();
523  }
524 }

Referenced by NodeElemConstraint::coupledSlaveValueOlder(), NodeFaceConstraint::coupledSlaveValueOlder(), and VariableTimeIntegrationAux::VariableTimeIntegrationAux().

◆ coupledValuePreviousNL()

const VariableValue & Coupleable::coupledValuePreviousNL ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns value of previous Newton iterate of a coupled variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue containing the older value of the coupled variable

Definition at line 527 of file Coupleable.C.

528 {
529  MooseVariable * var = getVar(var_name, comp);
530  if (!var)
531  return *getDefaultValue(var_name, comp);
533 
536  {
537  if (_c_nodal)
538  return var->dofValuesPreviousNL();
539  return var->slnPreviousNL();
540  }
541  else
542  {
543  if (_c_nodal)
544  return var->dofValuesPreviousNLNeighbor();
545  return var->slnPreviousNLNeighbor();
546  }
547 }

◆ coupledVectorDot()

const VectorVariableValue & Coupleable::coupledVectorDot ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Time derivative of a coupled vector variable.

Parameters
var_nameName of coupled vector variable
compComponent number for vector of coupled vector variables
Returns
Reference to a VectorVariableValue containing the time derivative of the coupled variable

Definition at line 708 of file Coupleable.C.

709 {
710  VectorMooseVariable * var = getVectorVar(var_name, comp);
711  if (!var)
714 
716  return var->uDot();
717  return var->uDotNeighbor();
718 }

◆ coupledVectorDotDot()

const VectorVariableValue & Coupleable::coupledVectorDotDot ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Second time derivative of a coupled vector variable.

Parameters
var_nameName of coupled vector variable
compComponent number for vector of coupled vector variables
Returns
Reference to a VectorVariableValue containing the time derivative of the coupled variable

Definition at line 721 of file Coupleable.C.

722 {
723  VectorMooseVariable * var = getVectorVar(var_name, comp);
724  if (!var)
727 
729  return var->uDotDot();
730  return var->uDotDotNeighbor();
731 }

◆ coupledVectorDotDotDu()

const VariableValue & Coupleable::coupledVectorDotDotDu ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Second time derivative of a coupled vector variable with respect to the coefficients.

Parameters
var_nameName of coupled vector variable
compComponent number for vector of coupled vector variables
Returns
Reference to a VariableValue containing the time derivative of the coupled vector variable with respect to the coefficients

Definition at line 773 of file Coupleable.C.

774 {
775  VectorMooseVariable * var = getVectorVar(var_name, comp);
776  if (!var)
777  return _default_value_zero;
779 
781  return var->duDotDotDu();
782  return var->duDotDotDuNeighbor();
783 }

◆ coupledVectorDotDotOld()

const VectorVariableValue & Coupleable::coupledVectorDotDotOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Old second time derivative of a coupled vector variable.

Parameters
var_nameName of coupled vector variable
compComponent number for vector of coupled vector variables
Returns
Reference to a VectorVariableValue containing the time derivative of the coupled variable

Definition at line 747 of file Coupleable.C.

748 {
749  VectorMooseVariable * var = getVectorVar(var_name, comp);
750  if (!var)
753 
755  return var->uDotDotOld();
756  return var->uDotDotOldNeighbor();
757 }

◆ coupledVectorDotDu()

const VariableValue & Coupleable::coupledVectorDotDu ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Time derivative of a coupled vector variable with respect to the coefficients.

Parameters
var_nameName of coupled vector variable
compComponent number for vector of coupled vector variables
Returns
Reference to a VariableValue containing the time derivative of the coupled vector variable with respect to the coefficients

Definition at line 760 of file Coupleable.C.

761 {
762  VectorMooseVariable * var = getVectorVar(var_name, comp);
763  if (!var)
764  return _default_value_zero;
766 
768  return var->duDotDu();
769  return var->duDotDuNeighbor();
770 }

◆ coupledVectorDotOld()

const VectorVariableValue & Coupleable::coupledVectorDotOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Old time derivative of a coupled vector variable.

Parameters
var_nameName of coupled vector variable
compComponent number for vector of coupled vector variables
Returns
Reference to a VectorVariableValue containing the time derivative of the coupled variable

Definition at line 734 of file Coupleable.C.

735 {
736  VectorMooseVariable * var = getVectorVar(var_name, comp);
737  if (!var)
740 
742  return var->uDotOld();
743  return var->uDotOldNeighbor();
744 }

◆ coupledVectorGradient()

const VectorVariableGradient & Coupleable::coupledVectorGradient ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns gradient of a coupled vector variable.

Parameters
var_nameName of coupled vector variable
compComponent number for vector of coupled vector variables
Returns
Reference to a VectorVariableGradient containing the gradient of the coupled vector variable

Definition at line 997 of file Coupleable.C.

998 {
999  VectorMooseVariable * var = getVectorVar(var_name, comp);
1000  if (!var)
1001  return _default_vector_gradient;
1003 
1004  if (!_coupleable_neighbor)
1005  return (_c_is_implicit) ? var->gradSln() : var->gradSlnOld();
1006  return (_c_is_implicit) ? var->gradSlnNeighbor() : var->gradSlnOldNeighbor();
1007 }

◆ coupledVectorGradientOld()

const VectorVariableGradient & Coupleable::coupledVectorGradientOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old gradient from previous time step of a coupled vector variable.

Parameters
var_nameName of coupled vector variable
compComponent number for vector of coupled vector variables
Returns
Reference to a VectorVariableGradient containing the old gradient of the coupled vector variable

Definition at line 1010 of file Coupleable.C.

1011 {
1012  VectorMooseVariable * var = getVectorVar(var_name, comp);
1013  if (!var)
1014  return _default_vector_gradient;
1016 
1017  if (!_coupleable_neighbor)
1018  return (_c_is_implicit) ? var->gradSlnOld() : var->gradSlnOlder();
1019  return (_c_is_implicit) ? var->gradSlnOldNeighbor() : var->gradSlnOlderNeighbor();
1020 }

◆ coupledVectorGradientOlder()

const VectorVariableGradient & Coupleable::coupledVectorGradientOlder ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old gradient from two time steps previous of a coupled vector variable.

Parameters
var_nameName of coupled vector variable
compComponent number for vector of coupled vector variables
Returns
Reference to a VectorVariableGradient containing the older gradient of the coupled vector variable

Definition at line 1023 of file Coupleable.C.

1024 {
1025  VectorMooseVariable * var = getVectorVar(var_name, comp);
1026  if (!var)
1027  return _default_vector_gradient;
1029 
1030  if (!_coupleable_neighbor)
1031  return var->gradSlnOlder();
1032  return var->gradSlnOlderNeighbor();
1033 }

◆ coupledVectorTagValue()

const VariableValue & Coupleable::coupledVectorTagValue ( const std::string &  var_name,
TagID  tag,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns value of a coupled variable for a given tag.

Parameters
var_nameName of coupled variable
tagvector tag ID
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue for the coupled variable
See also
Kernel::_u

Definition at line 411 of file Coupleable.C.

412 {
413  MooseVariable * var = getVar(var_name, comp);
414  if (!var)
415  mooseError(var_name, ": invalid variable name for coupledVectorTagValue");
417 
419 
420  if (_c_nodal)
421  return var->nodalVectorTagValue(tag);
422  else
423  return var->vectorTagValue(tag);
424 }

◆ coupledVectorValue()

const VectorVariableValue & Coupleable::coupledVectorValue ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns value of a coupled vector variable.

Parameters
var_nameName of coupled vector variable
compComponent number for vector of coupled vector variables
Returns
Reference to a VectorVariableValue for the coupled vector variable
See also
VectorKernel::_u

Definition at line 442 of file Coupleable.C.

443 {
444  VectorMooseVariable * var = getVectorVar(var_name, comp);
445  if (!var)
446  return *getDefaultVectorValue(var_name);
448 
450  return (_c_is_implicit) ? var->sln() : var->slnOld();
451  return (_c_is_implicit) ? var->slnNeighbor() : var->slnOldNeighbor();
452 }

◆ coupledVectorValueOld()

const VectorVariableValue & Coupleable::coupledVectorValueOld ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old value from previous time step of a coupled vector variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VectorVariableValue containing the old value of the coupled variable
See also
VectorKernel::_u_old

Definition at line 550 of file Coupleable.C.

551 {
552  VectorMooseVariable * var = getVectorVar(var_name, comp);
553  if (!var)
554  return *getDefaultVectorValue(var_name);
556 
558  return (_c_is_implicit) ? var->slnOld() : var->slnOlder();
559  return (_c_is_implicit) ? var->slnOldNeighbor() : var->slnOlderNeighbor();
560 }

◆ coupledVectorValueOlder()

const VectorVariableValue & Coupleable::coupledVectorValueOlder ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns an old value from two time steps previous of a coupled vector variable.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VectorVariableValue containing the older value of the coupled variable
See also
VectorKernel::_u_older

Definition at line 563 of file Coupleable.C.

564 {
565  VectorMooseVariable * var = getVectorVar(var_name, comp);
566  if (!var)
567  return *getDefaultVectorValue(var_name);
569 
571  return var->slnOlder();
572  return var->slnOlderNeighbor();
573 }

◆ cyclicDependencyError()

template<typename T >
void DependencyResolverInterface::cyclicDependencyError ( CyclicDependencyException< T > &  e,
const std::string &  header 
)
staticinherited

A helper method for cyclic errors.

Definition at line 94 of file DependencyResolverInterface.h.

96 {
97  std::ostringstream oss;
98 
99  oss << header << ":\n";
100  const typename std::multimap<T, T> & depends = e.getCyclicDependencies();
101  for (typename std::multimap<T, T>::const_iterator it = depends.begin(); it != depends.end(); ++it)
102  oss << (static_cast<T>(it->first))->name() << " -> " << (static_cast<T>(it->second))->name()
103  << "\n";
104  mooseError(oss.str());
105 }

◆ declareRecoverableData() [1/2]

template<typename T >
T & Restartable::declareRecoverableData ( const std::string &  data_name)
protectedinherited

Declare a piece of data as "recoverable".

This means that in the event of a recovery this piece of data will be restored back to its previous value.

Note - this data will NOT be restored on Restart!

NOTE: This returns a reference! Make sure you store it in a reference!

Parameters
data_nameThe name of the data (usually just use the same name as the member variable)

Definition at line 295 of file Restartable.h.

296 {
297  std::string full_name = _restartable_system_name + "/" + _restartable_name + "/" + data_name;
298 
300 
301  return declareRestartableDataWithContext<T>(data_name, nullptr);
302 }

◆ declareRecoverableData() [2/2]

template<typename T >
T & Restartable::declareRecoverableData ( const std::string &  data_name,
const T &  init_value 
)
protectedinherited

Declare a piece of data as "restartable" and initialize it.

This means that in the event of a restart this piece of data will be restored back to its previous value.

Note - this data will NOT be restored on Restart!

NOTE: This returns a reference! Make sure you store it in a reference!

Parameters
data_nameThe name of the data (usually just use the same name as the member variable)
init_valueThe initial value of the data

Definition at line 306 of file Restartable.h.

307 {
308  std::string full_name = _restartable_system_name + "/" + _restartable_name + "/" + data_name;
309 
311 
312  return declareRestartableDataWithContext<T>(data_name, init_value, nullptr);
313 }

◆ declareRestartableDataTempl() [1/2]

template<typename T >
T & Restartable::declareRestartableDataTempl ( const std::string &  data_name)
protectedinherited

Declare a piece of data as "restartable".

This means that in the event of a restart this piece of data will be restored back to its previous value.

NOTE: This returns a reference! Make sure you store it in a reference!

Parameters
data_nameThe name of the data (usually just use the same name as the member variable)

Definition at line 222 of file Restartable.h.

223 {
224  return declareRestartableDataWithContext<T>(data_name, nullptr);
225 }

◆ declareRestartableDataTempl() [2/2]

template<typename T >
T & Restartable::declareRestartableDataTempl ( const std::string &  data_name,
const T &  init_value 
)
protectedinherited

Declare a piece of data as "restartable" and initialize it.

This means that in the event of a restart this piece of data will be restored back to its previous value.

NOTE: This returns a reference! Make sure you store it in a reference!

Parameters
data_nameThe name of the data (usually just use the same name as the member variable)
init_valueThe initial value of the data

Definition at line 229 of file Restartable.h.

230 {
231  return declareRestartableDataWithContext<T>(data_name, init_value, nullptr);
232 }

◆ declareRestartableDataWithContext() [1/2]

template<typename T >
T & Restartable::declareRestartableDataWithContext ( const std::string &  data_name,
const T &  init_value,
void *  context 
)
protectedinherited

Declare a piece of data as "restartable" and initialize it.

This means that in the event of a restart this piece of data will be restored back to its previous value.

NOTE: This returns a reference! Make sure you store it in a reference!

Parameters
data_nameThe name of the data (usually just use the same name as the member variable)
init_valueThe initial value of the data
contextContext pointer that will be passed to the load and store functions

Definition at line 250 of file Restartable.h.

253 {
254  std::string full_name = _restartable_system_name + "/" + _restartable_name + "/" + data_name;
255 
256  // Here we will create the RestartableData even though we may not use this instance.
257  // If it's already in use, the App will return a reference to the existing instance and we'll
258  // return that one instead. We might refactor this to have the app create the RestartableData
259  // at a later date.
260  auto data_ptr = libmesh_make_unique<RestartableData<T>>(full_name, context);
261  auto & restartable_data_ref = static_cast<RestartableData<T> &>(
262  registerRestartableDataOnApp(full_name, std::move(data_ptr), _restartable_tid));
263 
264  restartable_data_ref.set() = init_value;
265  return restartable_data_ref.get();
266 }

◆ declareRestartableDataWithContext() [2/2]

template<typename T >
T & Restartable::declareRestartableDataWithContext ( const std::string &  data_name,
void *  context 
)
protectedinherited

Declare a piece of data as "restartable".

This means that in the event of a restart this piece of data will be restored back to its previous value.

NOTE: This returns a reference! Make sure you store it in a reference!

Parameters
data_nameThe name of the data (usually just use the same name as the member variable)
contextContext pointer that will be passed to the load and store functions

Definition at line 236 of file Restartable.h.

237 {
238  std::string full_name = _restartable_system_name + "/" + _restartable_name + "/" + data_name;
239  auto data_ptr = libmesh_make_unique<RestartableData<T>>(full_name, context);
240 
241  // See comment in overloaded version of this function with "init_value"
242  auto & restartable_data_ref = static_cast<RestartableData<T> &>(
243  registerRestartableDataOnApp(full_name, std::move(data_ptr), _restartable_tid));
244 
245  return restartable_data_ref.get();
246 }

◆ declareRestartableDataWithObjectName()

template<typename T >
T & Restartable::declareRestartableDataWithObjectName ( const std::string &  data_name,
const std::string &  object_name 
)
protectedinherited

Declare a piece of data as "restartable".

This means that in the event of a restart this piece of data will be restored back to its previous value.

NOTE: This returns a reference! Make sure you store it in a reference!

Parameters
data_nameThe name of the data (usually just use the same name as the member variable)
object_nameA supplied name for the object that is declaring this data.

Definition at line 270 of file Restartable.h.

272 {
273  return declareRestartableDataWithObjectNameWithContext<T>(data_name, object_name, nullptr);
274 }

◆ declareRestartableDataWithObjectNameWithContext()

template<typename T >
T & Restartable::declareRestartableDataWithObjectNameWithContext ( const std::string &  data_name,
const std::string &  object_name,
void *  context 
)
protectedinherited

Declare a piece of data as "restartable".

This means that in the event of a restart this piece of data will be restored back to its previous value.

NOTE: This returns a reference! Make sure you store it in a reference!

Parameters
data_nameThe name of the data (usually just use the same name as the member variable)
object_nameA supplied name for the object that is declaring this data.
contextContext pointer that will be passed to the load and store functions

Definition at line 278 of file Restartable.h.

281 {
282  std::string old_name = _restartable_name;
283 
284  _restartable_name = object_name;
285 
286  T & value = declareRestartableDataWithContext<T>(data_name, context);
287 
288  _restartable_name = old_name;
289 
290  return value;
291 }

◆ declareRestartableDataWithPrefixOverrideAndContext()

template<typename T >
T& Restartable::declareRestartableDataWithPrefixOverrideAndContext ( const std::string &  data_name,
const std::string &  prefix,
void *  context 
)
protectedinherited

Declare a piece of data as "restartable".

This means that in the event of a restart this piece of data will be restored back to its previous value.

NOTE: This returns a reference! Make sure you store it in a reference!

Parameters
data_nameThe name of the data (usually just use the same name as the member variable)
prefixThe prefix to prepend to the data_name, to retrieve data from another object.
contextContext pointer that will be passed to the load and store functions

◆ dotHelper() [1/3]

template<typename T >
Real InitialConditionTempl< T >::dotHelper ( const RealGradient &  op1,
const RealGradient &  op2 
)
inlineinherited

Helps perform multiplication of GradientTypes: a normal dot product for vectors and a contraction for tensors.

Definition at line 99 of file InitialConditionTempl.h.

99 { return op1 * op2; }

◆ dotHelper() [2/3]

template<typename T >
Real InitialConditionTempl< T >::dotHelper ( const RealTensor &  op1,
const RealTensor &  op2 
)
inlineinherited

Definition at line 100 of file InitialConditionTempl.h.

100 { return op1.contract(op2); }

◆ dotHelper() [3/3]

template<typename T >
RealEigenVector InitialConditionTempl< T >::dotHelper ( const RealVectorArrayValue &  op1,
const RealGradient &  op2 
)
inlineinherited

Definition at line 101 of file InitialConditionTempl.h.

102  {
103  RealEigenVector v = op1.col(0) * op2(0);
104  for (unsigned int i = 1; i < LIBMESH_DIM; ++i)
105  v += op1.col(i) * op2(i);
106  return v;
107  }

◆ enabled()

virtual bool MooseObject::enabled ( ) const
inlinevirtualinherited

Return the enabled status of the object.

Reimplemented in EigenKernel.

Definition at line 110 of file MooseObject.h.

110 { return _enabled; }

Referenced by EigenKernel::enabled().

◆ getADDefaultGradient() [1/3]

template<ComputeStage compute_stage>
ADVariableGradient & Coupleable::getADDefaultGradient ( )
inherited

Helper method to return (and insert if necessary) the default gradient for Automatic Differentiation for an uncoupled variable.

Parameters
var_namethe name of the variable for which to retrieve a default gradient
Returns
VariableGradient * a pointer to the associated VariableGradient.

Definition at line 1305 of file Coupleable.h.

1306 {
1307  return _ad_default_gradient;
1308 }

◆ getADDefaultGradient() [2/3]

template<>
VariableGradient& Coupleable::getADDefaultGradient ( )
inherited

◆ getADDefaultGradient() [3/3]

template<>
VariableGradient& Coupleable::getADDefaultGradient ( )
inherited

Definition at line 1364 of file Coupleable.C.

1365 {
1366  return _default_gradient;
1367 }

◆ getADDefaultSecond() [1/3]

template<ComputeStage compute_stage>
ADVariableSecond & Coupleable::getADDefaultSecond ( )
inherited

Helper method to return (and insert if necessary) the default second derivatives for Automatic Differentiation for an uncoupled variable.

Parameters
var_namethe name of the variable for which to retrieve a default second derivative
Returns
VariableSecond * a pointer to the associated VariableSecond.

Definition at line 1325 of file Coupleable.h.

1326 {
1327  return _ad_default_second;
1328 }

◆ getADDefaultSecond() [2/3]

template<>
VariableSecond& Coupleable::getADDefaultSecond ( )
inherited

◆ getADDefaultSecond() [3/3]

template<>
VariableSecond& Coupleable::getADDefaultSecond ( )
inherited

Definition at line 1378 of file Coupleable.C.

1379 {
1380  return _default_second;
1381 }

◆ getADDefaultValue() [1/3]

template<ComputeStage compute_stage>
ADVariableValue * Coupleable::getADDefaultValue ( const std::string &  var_name)
inherited

Helper method to return (and insert if necessary) the default value for Automatic Differentiation for an uncoupled variable.

Parameters
var_namethe name of the variable for which to retrieve a default value
Returns
VariableValue * a pointer to the associated VarirableValue.

Definition at line 1266 of file Coupleable.h.

1267 {
1268  auto default_value_it = _ad_default_value.find(var_name);
1269  if (default_value_it == _ad_default_value.end())
1270  {
1271  auto value = libmesh_make_unique<ADVariableValue>(_coupleable_max_qps,
1273  default_value_it = _ad_default_value.insert(std::make_pair(var_name, std::move(value))).first;
1274  }
1275 
1276  return default_value_it->second.get();
1277 }

◆ getADDefaultValue() [2/3]

template<>
VariableValue* Coupleable::getADDefaultValue ( const std::string &  var_name)
inherited

◆ getADDefaultValue() [3/3]

template<>
VariableValue* Coupleable::getADDefaultValue ( const std::string &  var_name)
inherited

Definition at line 1350 of file Coupleable.C.

1351 {
1352  return getDefaultValue(var_name, 0);
1353 }

◆ getADDefaultVectorGradient() [1/3]

template<ComputeStage compute_stage>
ADVectorVariableGradient & Coupleable::getADDefaultVectorGradient ( )
inherited

Helper method to return (and insert if necessary) the default gradient for Automatic Differentiation for an uncoupled vector variable.

Parameters
var_namethe name of the vector variable for which to retrieve a default gradient
Returns
VariableGradient * a pointer to the associated VectorVariableGradient.

Definition at line 1315 of file Coupleable.h.

1316 {
1318 }

◆ getADDefaultVectorGradient() [2/3]

template<>
VectorVariableGradient& Coupleable::getADDefaultVectorGradient ( )
inherited

◆ getADDefaultVectorGradient() [3/3]

template<>
VectorVariableGradient& Coupleable::getADDefaultVectorGradient ( )
inherited

Definition at line 1371 of file Coupleable.C.

1372 {
1373  return _default_vector_gradient;
1374 }

◆ getADDefaultVectorValue() [1/3]

template<ComputeStage compute_stage>
ADVectorVariableValue * Coupleable::getADDefaultVectorValue ( const std::string &  var_name)
inherited

Helper method to return (and insert if necessary) the default vector value for Automatic Differentiation for an uncoupled variable.

Parameters
var_namethe name of the vector variable for which to retrieve a default value
Returns
VariableVectorValue * a pointer to the associated VarirableVectorValue.

Definition at line 1284 of file Coupleable.h.

1285 {
1286  auto default_value_it = _ad_default_vector_value.find(var_name);
1287  if (default_value_it == _ad_default_vector_value.end())
1288  {
1289  RealVectorValue default_vec;
1290  for (unsigned int i = 0; i < _c_parameters.numberDefaultCoupledValues(var_name); ++i)
1291  default_vec(i) = _c_parameters.defaultCoupledValue(var_name, i);
1292  auto value = libmesh_make_unique<ADVectorVariableValue>(_coupleable_max_qps, default_vec);
1293  default_value_it =
1294  _ad_default_vector_value.insert(std::make_pair(var_name, std::move(value))).first;
1295  }
1296 
1297  return default_value_it->second.get();
1298 }

◆ getADDefaultVectorValue() [2/3]

template<>
VectorVariableValue* Coupleable::getADDefaultVectorValue ( const std::string &  var_name)
inherited

◆ getADDefaultVectorValue() [3/3]

template<>
VectorVariableValue* Coupleable::getADDefaultVectorValue ( const std::string &  var_name)
inherited

Definition at line 1357 of file Coupleable.C.

1358 {
1359  return getDefaultVectorValue(var_name);
1360 }

◆ getArrayVar()

ArrayMooseVariable * Coupleable::getArrayVar ( const std::string &  var_name,
unsigned int  comp 
)
protectedinherited

◆ getBlockCoordSystem()

Moose::CoordinateSystemType BlockRestrictable::getBlockCoordSystem ( )
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.

293 {
294  if (!_blk_mesh)
295  mooseError("No mesh available in BlockRestrictable::checkCoordSystem()");
296  if (!_blk_feproblem)
297  mooseError("No problem available in BlockRestrictable::checkCoordSystem()");
298 
299  const auto & subdomains = blockRestricted() ? blockIDs() : meshBlockIDs();
300 
301  if (subdomains.empty())
302  mooseError("No subdomains found in the problem.");
303 
304  // make sure all subdomains are using the same coordinate system
305  auto coord_system = _blk_feproblem->getCoordSystem(*subdomains.begin());
306  for (auto subdomain : subdomains)
307  if (_blk_feproblem->getCoordSystem(subdomain) != coord_system)
308  mooseError("This object requires all subdomains to have the same coordinate system.");
309 
310  return coord_system;
311 }

◆ getCheckedPointerParam()

template<typename T >
T MooseObject::getCheckedPointerParam ( const std::string &  name,
const std::string &  error_string = "" 
) const
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.

92  {
93  return parameters().getCheckedPointerParam<T>(name, error_string);
94  }

◆ getCoupledArratMooseVars()

const std::vector<ArrayMooseVariable *>& Coupleable::getCoupledArratMooseVars ( ) const
inlineinherited

Get the list of array coupled variables.

Returns
The list of array coupled variables

Definition at line 112 of file Coupleable.h.

113  {
115  }

◆ getCoupledMooseVars()

const std::vector<MooseVariableFEBase *>& Coupleable::getCoupledMooseVars ( ) const
inlineinherited

◆ getCoupledStandardMooseVars()

const std::vector<MooseVariable *>& Coupleable::getCoupledStandardMooseVars ( ) const
inlineinherited

Get the list of standard coupled variables.

Returns
The list of standard coupled variables

Definition at line 94 of file Coupleable.h.

95  {
97  }

◆ getCoupledVars()

const std::unordered_map<std::string, std::vector<MooseVariableFEBase *> >& Coupleable::getCoupledVars ( )
inlineinherited

Get the list of coupled variables.

Returns
The list of coupled variables

Definition at line 76 of file Coupleable.h.

77  {
78  return _coupled_vars;
79  }

Referenced by AuxKernelTempl< ComputeValueType >::AuxKernelTempl(), and InitialConditionBase::InitialConditionBase().

◆ getCoupledVectorMooseVars()

const std::vector<VectorMooseVariable *>& Coupleable::getCoupledVectorMooseVars ( ) const
inlineinherited

Get the list of vector coupled variables.

Returns
The list of vector coupled variables

Definition at line 103 of file Coupleable.h.

104  {
106  }

◆ getDefaultArrayValue()

ArrayVariableValue * Coupleable::getDefaultArrayValue ( const std::string &  var_name)
privateinherited

Helper method to return (and insert if necessary) the default value for an uncoupled array variable.

Parameters
var_namethe name of the vector variable for which to retrieve a default value
Returns
a pointer to the associated VectorVariableValue.

Definition at line 319 of file Coupleable.C.

320 {
321  std::map<std::string, ArrayVariableValue *>::iterator default_value_it =
322  _default_array_value.find(var_name);
323  if (default_value_it == _default_array_value.end())
324  {
326  for (unsigned int qp = 0; qp < _coupleable_max_qps; ++qp)
327  {
328  auto n = _c_parameters.numberDefaultCoupledValues(var_name);
329  (*value)[qp].resize(n);
330  for (unsigned int i = 0; i < n; ++i)
331  (*value)[qp](i) = _c_parameters.defaultCoupledValue(var_name, i);
332  }
333  default_value_it = _default_array_value.insert(std::make_pair(var_name, value)).first;
334  }
335 
336  return default_value_it->second;
337 }

Referenced by Coupleable::coupledArrayValue(), Coupleable::coupledArrayValueOld(), Coupleable::coupledArrayValueOlder(), and Coupleable::getDefaultNodalValue().

◆ getDefaultNodalValue() [1/3]

template<typename T >
const T & Coupleable::getDefaultNodalValue ( const std::string &  var_name,
unsigned int  comp = 0 
)
privateinherited

Get nodal default value.

Definition at line 341 of file Coupleable.C.

342 {
343  auto && default_variable_value = getDefaultValue(var_name, comp);
344  return *default_variable_value->data();
345 }

◆ getDefaultNodalValue() [2/3]

template<>
const RealVectorValue& Coupleable::getDefaultNodalValue ( const std::string &  var_name,
unsigned int   
)
privateinherited

Definition at line 349 of file Coupleable.C.

350 {
351  auto && default_variable_value = getDefaultVectorValue(var_name);
352  return *default_variable_value->data();
353 }

◆ getDefaultNodalValue() [3/3]

template<>
const RealEigenVector& Coupleable::getDefaultNodalValue ( const std::string &  var_name,
unsigned int   
)
privateinherited

Definition at line 357 of file Coupleable.C.

358 {
359  auto && default_variable_value = getDefaultArrayValue(var_name);
360  return *default_variable_value->data();
361 }

◆ getDefaultValue()

VariableValue * Coupleable::getDefaultValue ( const std::string &  var_name,
unsigned int  comp 
)
privateinherited

Helper method to return (and insert if necessary) the default value for an uncoupled variable.

Parameters
var_namethe name of the variable for which to retrieve a default value
Returns
a pointer to the associated VariableValue.

Definition at line 264 of file Coupleable.C.

265 {
266  // make sure we don't access values that were not provided
267  checkComponent(_obj, comp, _c_parameters.numberDefaultCoupledValues(var_name), var_name);
268 
269  auto default_value_it = _default_value.find(var_name);
270  if (default_value_it == _default_value.end())
271  {
272  _default_value[var_name].emplace_back(libmesh_make_unique<VariableValue>(
274  for (unsigned int j = 1; j < _c_parameters.numberDefaultCoupledValues(var_name); ++j)
275  _default_value[var_name].emplace_back(libmesh_make_unique<VariableValue>(
277  default_value_it = _default_value.find(var_name);
278  }
279 
280  return default_value_it->second[comp].get();
281 }

Referenced by Coupleable::coupledDofValues(), Coupleable::coupledDofValuesOld(), Coupleable::coupledDofValuesOlder(), Coupleable::coupledValue(), Coupleable::coupledValueOld(), Coupleable::coupledValueOlder(), Coupleable::coupledValuePreviousNL(), Coupleable::getADDefaultValue(), and Coupleable::getDefaultNodalValue().

◆ getDefaultVectorValue()

VectorVariableValue * Coupleable::getDefaultVectorValue ( const std::string &  var_name)
privateinherited

Helper method to return (and insert if necessary) the default value for an uncoupled vector variable.

Parameters
var_namethe name of the vector variable for which to retrieve a default value
Returns
a pointer to the associated VectorVariableValue.

Definition at line 284 of file Coupleable.C.

285 {
286  auto default_value_it = _default_vector_value.find(var_name);
287  if (default_value_it == _default_vector_value.end())
288  {
289  auto value = libmesh_make_unique<VectorVariableValue>(_coupleable_max_qps, 0);
290  bool already_warned = false;
291  for (unsigned int qp = 0; qp < _coupleable_max_qps; ++qp)
292  for (unsigned int i = 0; i < LIBMESH_DIM; ++i)
293  {
294  try
295  {
296  (*value)[qp](i) = _c_parameters.defaultCoupledValue(var_name, i);
297  }
298  catch (const std::out_of_range &)
299  {
300  if (!already_warned)
301  mooseWarning(
302  "You supplied less than 3 arguments for the default vector value for variable ",
303  var_name,
304  ". Did you accidently leave something off? We are going to assign 0s, assuming "
305  "this "
306  "was intentional.");
307  already_warned = true;
308  (*value)[qp](i) = 0;
309  }
310  }
311  default_value_it =
312  _default_vector_value.insert(std::make_pair(var_name, std::move(value))).first;
313  }
314 
315  return default_value_it->second.get();
316 }

Referenced by Coupleable::coupledVectorValue(), Coupleable::coupledVectorValueOld(), Coupleable::coupledVectorValueOlder(), Coupleable::getADDefaultVectorValue(), and Coupleable::getDefaultNodalValue().

◆ getDependObjects()

const std::set<std::string>& InitialConditionBase::getDependObjects ( ) const
inlineinherited

getter method for dependent user objects

Definition at line 72 of file InitialConditionBase.h.

72 { return _depend_uo; }

◆ getElementID()

const dof_id_type & ElementIDInterface::getElementID ( const std::string &  id_parameter_name,
unsigned int  comp = 0 
) const
virtualinherited

Gets an element integer with a parameter of the object derived from this interface.

Parameters
id_nameName of object parameter
compComponent number for vector of integer names
Returns
Integer for the current element

Definition at line 50 of file ElementIDInterface.C.

51 {
52  auto id = getElementIDIndex(id_parameter_name, comp);
53 
54  auto & _subproblem = *_obj_parameters.getCheckedPointerParam<SubProblem *>("_subproblem");
55 
56  auto tid = _obj_parameters.get<THREAD_ID>("_tid");
57 
58  auto & assembly = _subproblem.assembly(tid);
59 
60  return assembly.extraElemID(id);
61 }

◆ getElementIDIndex()

unsigned int ElementIDInterface::getElementIDIndex ( const std::string &  id_parameter_name,
unsigned int  comp = 0 
) const
virtualinherited

Gets index of an element integer with a parameter of the object derived from this interface.

Parameters
id_nameName of object parameter
compComponent number for vector of integer names
Returns
Index of the element integer

Definition at line 29 of file ElementIDInterface.C.

31 {
32  auto & p = _obj_parameters.get<std::vector<ExtraElementIDName>>(id_parameter_name);
33  if (comp >= p.size())
34  mooseError(id_parameter_name, " does not have enough integer names");
35 
36  if (!_mesh.get())
37  mooseError("Mesh is not available for getting element integers");
38 
39  auto & mesh_base = _mesh->getMesh();
40 
41  if (!mesh_base.has_elem_integer(p[comp]))
42  mooseError("Mesh does not have an element integer names as ", p[comp]);
43 
44  auto id = mesh_base.get_elem_integer_index(p[comp]);
45 
46  return id;
47 }

Referenced by ElementIDInterface::getElementID().

◆ getFEVar()

MooseVariableFEBase * Coupleable::getFEVar ( const std::string &  var_name,
unsigned int  comp 
)
protectedinherited

Extract pointer to a base finite element coupled variable.

Parameters
var_nameName of parameter desired
compComponent number of multiple coupled variables
Returns
Pointer to the desired variable

Definition at line 204 of file Coupleable.C.

205 {
206  if (!checkVar(var_name, comp, 0))
207  return nullptr;
208  return _coupled_vars[var_name][comp];
209 }

Referenced by Coupleable::coupled().

◆ getFEVariableCoupleableMatrixTags()

std::set<TagID>& Coupleable::getFEVariableCoupleableMatrixTags ( )
inlineinherited

Definition at line 123 of file Coupleable.h.

123 { return _fe_coupleable_matrix_tags; }

◆ getFEVariableCoupleableVectorTags()

std::set<TagID>& Coupleable::getFEVariableCoupleableVectorTags ( )
inlineinherited

Definition at line 121 of file Coupleable.h.

121 { return _fe_coupleable_vector_tags; }

◆ getFunction()

const Function & FunctionInterface::getFunction ( const std::string &  name) const
inherited

Get a function with a given name.

Parameters
nameThe name of the parameter key of the function to retrieve
Returns
The function with name associated with the parameter 'name'

Definition at line 31 of file FunctionInterface.C.

32 {
33  return _fni_feproblem.getFunction(_fni_params.get<FunctionName>(name), _fni_tid);
34 }

Referenced by FunctionDT::FunctionDT().

◆ getFunctionByName()

const Function & FunctionInterface::getFunctionByName ( const FunctionName &  name) const
inherited

◆ getMooseApp()

MooseApp& MooseObject::getMooseApp ( ) const
inlineinherited

Get the MooseApp this object is associated with.

Definition at line 105 of file MooseObject.h.

105 { return _app; }

Referenced by MortarData::createMortarInterface(), Executioner::Executioner(), and ConsoleUtils::outputMeshInformation().

◆ getParamTempl()

template<typename T >
const T & MooseObject::getParamTempl ( const std::string &  name) const
inherited

◆ getRequestedItems()

const std::set< std::string > & InitialConditionBase::getRequestedItems ( )
overridevirtualinherited

Return a set containing the names of items requested by the object.

Implements DependencyResolverInterface.

Definition at line 67 of file InitialConditionBase.C.

68 {
69  return _depend_vars;
70 }

◆ getSuppliedItems()

const std::set< std::string > & InitialConditionBase::getSuppliedItems ( )
overridevirtualinherited

Return a set containing the names of items owned by the object.

Implements DependencyResolverInterface.

Definition at line 73 of file InitialConditionBase.C.

74 {
75  return _supplied_vars;
76 }

◆ getUserObjectBase()

const UserObject & InitialConditionBase::getUserObjectBase ( const std::string &  name)
inherited

reimplements the getUserObjectBase method from UserObjectInterface

Definition at line 79 of file InitialConditionBase.C.

80 {
82  _depend_uo.insert(_pars.get<UserObjectName>(name));
84 }

◆ getUserObjectBaseByName()

const UserObject & UserObjectInterface::getUserObjectBaseByName ( const std::string &  name)
inherited

Get an user object with a given name.

Parameters
nameThe name of the user object to retrieve
Returns
The user object with the name

Definition at line 30 of file UserObjectInterface.C.

31 {
32  return _uoi_feproblem.getUserObjectBase(name);
33 }

Referenced by UserObjectInterface::getUserObjectByNameTempl().

◆ getUserObjectByNameTempl() [1/3]

template<class T >
const T & UserObjectInterface::getUserObjectByNameTempl ( const std::string &  name)
inherited

Get an user object with a given name.

Parameters
nameThe name of the user object to retrieve
Returns
The user object with the name

Definition at line 93 of file UserObjectInterface.h.

94 {
95  unsigned int tid = needThreadedCopy(getUserObjectBaseByName(name)) ? _uoi_tid : 0;
96  return _uoi_feproblem.getUserObjectTempl<T>(name, tid);
97 }

◆ getUserObjectByNameTempl() [2/3]

template<typename T2 >
const T2& InitialConditionBase::getUserObjectByNameTempl ( const UserObjectName &  name)
inherited

reimplements the getUserObjectByName method from UserObjectInterface

◆ getUserObjectByNameTempl() [3/3]

template<typename T >
const T& InitialConditionBase::getUserObjectByNameTempl ( const UserObjectName &  name)
inherited

Definition at line 139 of file InitialConditionBase.h.

140 {
142  _depend_uo.insert(name);
143  return UserObjectInterface::getUserObjectByNameTempl<T>(name);
144 }

◆ getUserObjectTempl() [1/2]

template<typename T2 >
const T2& InitialConditionBase::getUserObjectTempl ( const std::string &  name)
inherited

reimplements the getUserObject method from UserObjectInterface

◆ getUserObjectTempl() [2/2]

template<typename T >
const T& InitialConditionBase::getUserObjectTempl ( const std::string &  name)
inherited

Definition at line 130 of file InitialConditionBase.h.

131 {
133  _depend_uo.insert(_pars.get<UserObjectName>(name));
134  return UserObjectInterface::getUserObjectTempl<T>(name);
135 }

◆ getVar()

MooseVariable * Coupleable::getVar ( const std::string &  var_name,
unsigned int  comp 
)
protectedinherited

Extract pointer to a coupled variable.

Parameters
var_nameName of parameter desired
compComponent number of multiple coupled variables
Returns
Pointer to the desired variable

Definition at line 240 of file Coupleable.C.

241 {
242  return getVarHelper<Real>(var_name, comp);
243 }

Referenced by Coupleable::adCoupledDotTemplate(), Coupleable::adCoupledGradientTemplate(), Coupleable::adCoupledSecondTemplate(), Coupleable::adCoupledValueTemplate(), ShapeUserObject< SideUserObject >::coupled(), Coupleable::coupledDofValues(), Coupleable::coupledDofValuesOld(), Coupleable::coupledDofValuesOlder(), Coupleable::coupledDot(), Coupleable::coupledDotDot(), Coupleable::coupledDotDotDu(), Coupleable::coupledDotDotOld(), Coupleable::coupledDotDu(), Coupleable::coupledDotOld(), Coupleable::coupledGradient(), Coupleable::coupledGradientDot(), Coupleable::coupledGradientDotDot(), Coupleable::coupledGradientOld(), Coupleable::coupledGradientOlder(), Coupleable::coupledGradientPreviousNL(), Coupleable::coupledMatrixTagValue(), NeighborCoupleable::coupledNeighborDofValues(), NeighborCoupleable::coupledNeighborDofValuesOld(), NeighborCoupleable::coupledNeighborDofValuesOlder(), NeighborCoupleable::coupledNeighborGradient(), NeighborCoupleable::coupledNeighborGradientOld(), NeighborCoupleable::coupledNeighborGradientOlder(), NeighborCoupleable::coupledNeighborSecond(), NeighborCoupleable::coupledNeighborValue(), NeighborCoupleable::coupledNeighborValueDot(), NeighborCoupleable::coupledNeighborValueDotDu(), NeighborCoupleable::coupledNeighborValueOld(), NeighborCoupleable::coupledNeighborValueOlder(), Coupleable::coupledNodalDotDot(), Coupleable::coupledNodalDotDotOld(), Coupleable::coupledNodalDotOld(), Coupleable::coupledSecond(), Coupleable::coupledSecondOld(), Coupleable::coupledSecondOlder(), Coupleable::coupledSecondPreviousNL(), Coupleable::coupledValue(), Coupleable::coupledValueOld(), Coupleable::coupledValueOlder(), Coupleable::coupledValuePreviousNL(), Coupleable::coupledVectorTagValue(), ParsedAux::ParsedAux(), and SpatialAverageBase::SpatialAverageBase().

◆ getVarHelper()

template<typename T >
template MooseVariableFE< RealVectorValue > * Coupleable::getVarHelper< RealVectorValue > ( const std::string &  var_name,
unsigned int  comp 
)
protectedinherited

Helper that segues off to either getVar of getVectorVar depending on template paramter.

Definition at line 213 of file Coupleable.C.

214 {
215  if (!checkVar(var_name, comp, 0))
216  return nullptr;
217 
218  if (auto * coupled_var = dynamic_cast<MooseVariableFE<T> *>(_coupled_vars[var_name][comp]))
219  return coupled_var;
220  else
221  {
222  for (auto & var : _coupled_standard_moose_vars)
223  if (var->name() == var_name)
224  mooseError("The named variable is a standard variable, try a "
225  "'coupled[Value/Gradient/Dot/etc]...' function instead");
226  for (auto & var : _coupled_vector_moose_vars)
227  if (var->name() == var_name)
228  mooseError("The named variable is a vector variable, try a "
229  "'coupledVector[Value/Gradient/Dot/etc]...' function instead");
230  for (auto & var : _coupled_array_moose_vars)
231  if (var->name() == var_name)
232  mooseError("The named variable is an array variable, try a "
233  "'coupledArray[Value/Gradient/Dot/etc]...' function instead");
234  mooseError(
235  "Variable '", var_name, "' is of a different C++ type than you tried to fetch it as.");
236  }
237 }

◆ getVectorVar()

VectorMooseVariable * Coupleable::getVectorVar ( const std::string &  var_name,
unsigned int  comp 
)
protectedinherited

◆ gradient()

template<typename T >
virtual GradientType InitialConditionTempl< T >::gradient ( const Point &  )
inlinevirtualinherited

The gradient of the variable at a point.

This is optional. Note that if you are using C1 continuous elements you will want to use an initial condition that defines this!

Reimplemented in FunctionIC, and ArrayFunctionIC.

Definition at line 78 of file InitialConditionTempl.h.

78 { return GradientType(); };

◆ gradientComponent() [1/3]

template<typename T >
T InitialConditionTempl< T >::gradientComponent ( GradientType  grad,
unsigned int  i 
)
inherited

Definition at line 313 of file InitialConditionTempl.C.

314 {
315  return grad(i);
316 }

◆ gradientComponent() [2/3]

template<>
RealVectorValue InitialConditionTempl< RealVectorValue >::gradientComponent ( GradientType  grad,
unsigned int  i 
)
inherited

Definition at line 320 of file InitialConditionTempl.C.

321 {
322  return grad.row(i);
323 }

◆ gradientComponent() [3/3]

template<>
RealEigenVector InitialConditionTempl< RealEigenVector >::gradientComponent ( GradientType  grad,
unsigned int  i 
)
inherited

Definition at line 327 of file InitialConditionTempl.C.

328 {
329  return grad.col(i);
330 }

◆ hasBlockMaterialProperty()

template<typename T >
bool BlockRestrictable::hasBlockMaterialProperty ( const std::string &  prop_name)
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.

Template Parameters
TThe type of material property
Parameters
prop_namethe name of the property to query
Returns
true if the property exists for all block ids of the object, otherwise false
See also
Material::hasBlockMaterialProperty

Definition at line 256 of file BlockRestrictable.h.

257 {
258  mooseAssert(_blk_material_data != NULL, "MaterialData pointer is not defined");
259  return hasBlockMaterialPropertyHelper(prop_name) &&
260  _blk_material_data->haveProperty<T>(prop_name);
261 }

◆ hasBlockMaterialPropertyHelper()

bool BlockRestrictable::hasBlockMaterialPropertyHelper ( const std::string &  prop_name)
protectedvirtualinherited

A helper method to allow the Material object to specialize the behavior of hasBlockMaterialProperty.

It also avoid circular #include problems.

See also
hasBlockMaterialProperty

Definition at line 256 of file BlockRestrictable.C.

257 {
258 
259  // Reference to MaterialWarehouse for testing and retrieving block ids
261 
262  // Complete set of ids that this object is active
263  const std::set<SubdomainID> & ids = blockRestricted() ? blockIDs() : meshBlockIDs();
264 
265  // Loop over each id for this object
266  for (const auto & id : ids)
267  {
268  // Storage of material properties that have been DECLARED on this id
269  std::set<std::string> declared_props;
270 
271  // If block materials exist, populated the set of properties that were declared
272  if (warehouse.hasActiveBlockObjects(id))
273  {
274  const std::vector<std::shared_ptr<MaterialBase>> & mats = warehouse.getActiveBlockObjects(id);
275  for (const auto & mat : mats)
276  {
277  const std::set<std::string> & mat_props = mat->getSuppliedItems();
278  declared_props.insert(mat_props.begin(), mat_props.end());
279  }
280  }
281 
282  // If the supplied property is not in the list of properties on the current id, return false
283  if (declared_props.find(prop_name) == declared_props.end())
284  return false;
285  }
286 
287  // If you get here the supplied property is defined on all blocks
288  return true;
289 }

Referenced by BlockRestrictable::hasBlockMaterialProperty().

◆ hasBlocks() [1/5]

bool BlockRestrictable::hasBlocks ( const std::set< SubdomainID > &  ids) const
inherited

Test if the supplied set of block ids are valid for this object.

Parameters
idsA std::set of SubdomainIDs to check
Returns
True if the all of the given ids are found within the ids for this object
See also
isSubset

Definition at line 218 of file BlockRestrictable.C.

219 {
220  if (_blk_ids.empty() || _blk_ids.find(Moose::ANY_BLOCK_ID) != _blk_ids.end())
221  return true;
222  else
223  return std::includes(_blk_ids.begin(), _blk_ids.end(), ids.begin(), ids.end());
224 }

◆ hasBlocks() [2/5]

bool BlockRestrictable::hasBlocks ( const std::vector< SubdomainID > &  ids) const
inherited

Test if the supplied vector block ids are valid for this object.

Parameters
idsA vector of SubdomainIDs ids to check
Returns
True if the all of the given ids are found within the ids for this object

Definition at line 211 of file BlockRestrictable.C.

212 {
213  std::set<SubdomainID> ids_set(ids.begin(), ids.end());
214  return hasBlocks(ids_set);
215 }

◆ hasBlocks() [3/5]

bool BlockRestrictable::hasBlocks ( const std::vector< SubdomainName > &  names) const
inherited

Test if the supplied vector of block names are valid for this object.

Parameters
namesA vector of SubdomainNames to check
Returns
True if the given ids are valid for this object

Definition at line 196 of file BlockRestrictable.C.

197 {
198  return hasBlocks(_blk_mesh->getSubdomainIDs(names));
199 }

◆ hasBlocks() [4/5]

bool BlockRestrictable::hasBlocks ( const SubdomainID id) const
inherited

Test if the supplied block ids are valid for this object.

Parameters
idA SubdomainID to check
Returns
True if the given id is valid for this object

Definition at line 202 of file BlockRestrictable.C.

203 {
204  if (_blk_ids.empty() || _blk_ids.find(Moose::ANY_BLOCK_ID) != _blk_ids.end())
205  return true;
206  else
207  return _blk_ids.find(id) != _blk_ids.end();
208 }

◆ hasBlocks() [5/5]

bool BlockRestrictable::hasBlocks ( const SubdomainName &  name) const
inherited

Test if the supplied block name is valid for this object.

Parameters
nameA SubdomainName to check
Returns
True if the given id is valid for this object

Definition at line 186 of file BlockRestrictable.C.

187 {
188  // Create a vector and utilize the getSubdomainIDs function, which
189  // handles the ANY_BLOCK_ID (getSubdomainID does not)
190  std::vector<SubdomainName> names(1);
191  names[0] = name;
192  return hasBlocks(_blk_mesh->getSubdomainIDs(names));
193 }

Referenced by CentroidMultiApp::fillPositions(), and BlockRestrictable::hasBlocks().

◆ hasBoundary() [1/5]

bool BoundaryRestrictable::hasBoundary ( const BoundaryID id) const
inherited

Test if the supplied boundary ids are valid for this object.

Parameters
idA BoundaryID to check
Returns
True if the given id is valid for this object

Definition at line 214 of file BoundaryRestrictable.C.

215 {
216  if (_bnd_ids.empty() || _bnd_ids.find(Moose::ANY_BOUNDARY_ID) != _bnd_ids.end())
217  return true;
218  else
219  return _bnd_ids.find(id) != _bnd_ids.end();
220 }

◆ hasBoundary() [2/5]

bool BoundaryRestrictable::hasBoundary ( const BoundaryName &  name) const
inherited

Test if the supplied boundary name is valid for this object.

Parameters
nameA BoundaryName to check
Returns
True if the given id is valid for this object

Definition at line 200 of file BoundaryRestrictable.C.

201 {
202  // Create a vector and utilize the getBoundaryIDs function, which
203  // handles the ANY_BOUNDARY_ID (getBoundaryID does not)
204  return hasBoundary(_bnd_mesh->getBoundaryIDs({name}));
205 }

Referenced by BoundaryRestrictable::hasBoundary(), and BoundaryRestrictable::hasBoundaryMaterialPropertyHelper().

◆ hasBoundary() [3/5]

bool BoundaryRestrictable::hasBoundary ( const std::set< BoundaryID > &  ids,
TEST_TYPE  type = ALL 
) const
inherited

Test if the supplied set of boundary ids are valid for this object.

Parameters
idsA std::set of BoundaryIDs to check
typeA flag for the type of matching to perform: ALL requires that all supplied ids must match those of the object; ANY requires that any one of the supplied ids must match those of the object
Returns
True if the all of the given ids are found within the ids for this object
See also
isSubset

Definition at line 230 of file BoundaryRestrictable.C.

231 {
232  // An empty input is assumed to be ANY_BOUNDARY_ID
233  if (ids.empty() || ids.find(Moose::ANY_BOUNDARY_ID) != ids.end())
234  return true;
235 
236  // All supplied IDs must match those of the object
237  else if (type == ALL)
238  {
239  if (_bnd_ids.find(Moose::ANY_BOUNDARY_ID) != _bnd_ids.end())
240  return true;
241  else
242  return std::includes(_bnd_ids.begin(), _bnd_ids.end(), ids.begin(), ids.end());
243  }
244  // Any of the supplied IDs must match those of the object
245  else
246  {
247  // Loop through the supplied ids
248  for (const auto & id : ids)
249  {
250  // Test the current supplied id
251  bool test = hasBoundary(id);
252 
253  // If the id exists in the stored ids, then return true, otherwise
254  if (test)
255  return true;
256  }
257  return false;
258  }
259 }

◆ hasBoundary() [4/5]

bool BoundaryRestrictable::hasBoundary ( const std::vector< BoundaryID > &  ids,
TEST_TYPE  type = ALL 
) const
inherited

Test if the supplied vector boundary ids are valid for this object.

Parameters
idsA vector of BoundaryIDs ids to check
typeA flag for the type of matching to perform: ALL requires that all supplied ids must match those of the object; ANY requires that any one of the supplied ids must match those of the object
Returns
True if the all of the given ids are found within the ids for this object

Definition at line 223 of file BoundaryRestrictable.C.

224 {
225  std::set<BoundaryID> ids_set(ids.begin(), ids.end());
226  return hasBoundary(ids_set, type);
227 }

◆ hasBoundary() [5/5]

bool BoundaryRestrictable::hasBoundary ( const std::vector< BoundaryName > &  names) const
inherited

Test if the supplied vector of boundary names are valid for this object.

Parameters
namesA vector of BoundaryNames to check
Returns
True if the given ids are valid for this object

Definition at line 208 of file BoundaryRestrictable.C.

209 {
210  return hasBoundary(_bnd_mesh->getBoundaryIDs(names));
211 }

◆ hasBoundaryMaterialProperty()

template<typename T >
bool BoundaryRestrictable::hasBoundaryMaterialProperty ( const std::string &  prop_name) const
inherited

Check if a material property is valid for all boundaries of this object.

This method returns true if the supplied property name has been declared in a Material object on the boundary ids for this object.

Template Parameters
TThe type of material property
Parameters
prop_namethe name of the property to query
Returns
true if the property exists for all boundary ids of the object, otherwise false

Definition at line 224 of file BoundaryRestrictable.h.

225 {
226  // If you get here the supplied property is defined on all boundaries, but is still subject
227  // existence in the MateialData class
228  return hasBoundaryMaterialPropertyHelper(prop_name) &&
229  _bnd_material_data->haveProperty<T>(prop_name);
230 }

◆ hasBoundaryMaterialPropertyHelper()

bool BoundaryRestrictable::hasBoundaryMaterialPropertyHelper ( const std::string &  prop_name) const
protectedinherited

A helper method to avoid circular #include problems.

See also
hasBoundaryMaterialProperty

Definition at line 291 of file BoundaryRestrictable.C.

292 {
293  // Reference to MaterialWarehouse for testing and retrieving boundary ids
295 
296  // Complete set of BoundaryIDs that this object is defined
297  const std::set<BoundaryID> & ids =
299 
300  // Loop over each BoundaryID for this object
301  for (const auto & id : ids)
302  {
303  // Storage of material properties that have been DECLARED on this BoundaryID
304  std::set<std::string> declared_props;
305 
306  // If boundary materials exist, populated the set of properties that were declared
307  if (warehouse.hasActiveBoundaryObjects(id))
308  {
309  const std::vector<std::shared_ptr<MaterialBase>> & mats =
310  warehouse.getActiveBoundaryObjects(id);
311  for (const auto & mat : mats)
312  {
313  const std::set<std::string> & mat_props = mat->getSuppliedItems();
314  declared_props.insert(mat_props.begin(), mat_props.end());
315  }
316  }
317 
318  // If the supplied property is not in the list of properties on the current id, return false
319  if (declared_props.find(prop_name) == declared_props.end())
320  return false;
321  }
322 
323  // If you get here the supplied property is defined on all boundaries
324  return true;
325 }

Referenced by BoundaryRestrictable::hasBoundaryMaterialProperty().

◆ initializeBlockRestrictable()

void BlockRestrictable::initializeBlockRestrictable ( const MooseObject moose_object)
protectedinherited

An initialization routine needed for dual constructors.

Definition at line 79 of file BlockRestrictable.C.

80 {
81  // If the mesh pointer is not defined, but FEProblemBase is, get it from there
82  if (_blk_feproblem != NULL && _blk_mesh == NULL)
84 
85  // Check that the mesh pointer was defined, it is required for this class to operate
86  if (_blk_mesh == NULL)
87  mooseError("The input parameters must contain a pointer to FEProblem via '_fe_problem' or a "
88  "pointer to the MooseMesh via '_mesh'");
89 
90  // Populate the MaterialData pointer
91  if (_blk_feproblem != NULL)
93 
94  // The 'block' input is defined
95  if (moose_object->isParamValid("block"))
96  {
97  // Extract the blocks from the input
98  _blocks = moose_object->getParamTempl<std::vector<SubdomainName>>("block");
99 
100  // Get the IDs from the supplied names
101  std::vector<SubdomainID> vec_ids = _blk_mesh->getSubdomainIDs(_blocks);
102 
103  // Store the IDs, handling ANY_BLOCK_ID if supplied
104  if (std::find(_blocks.begin(), _blocks.end(), "ANY_BLOCK_ID") != _blocks.end())
106  else
107  _blk_ids.insert(vec_ids.begin(), vec_ids.end());
108  }
109 
110  // When 'blocks' is not set and there is a "variable", use the blocks from the variable
111  else if (moose_object->isParamValid("variable"))
112  {
113  std::string variable_name = moose_object->parameters().getMooseType("variable");
114  if (!variable_name.empty())
116  ->getVariable(_blk_tid,
117  variable_name,
120  .activeSubdomains();
121  }
122 
123  // Produce error if the object is not allowed to be both block and boundary restricted
124  if (!_blk_dual_restrictable && !_boundary_ids.empty() && !_boundary_ids.empty())
125  if (!_boundary_ids.empty() && _boundary_ids.find(Moose::ANY_BOUNDARY_ID) == _boundary_ids.end())
126  moose_object->paramError("block",
127  "Attempted to restrict the object '",
128  _blk_name,
129  "' to a block, but the object is already restricted by boundary");
130 
131  // If no blocks were defined above, specify that it is valid on all blocks
132  if (_blk_ids.empty() && !moose_object->isParamValid("boundary"))
133  {
135  _blocks = {"ANY_BLOCK_ID"};
136  }
137 
138  // If this object is block restricted, check that defined blocks exist on the mesh
139  if (_blk_ids.find(Moose::ANY_BLOCK_ID) == _blk_ids.end())
140  {
141  const std::set<SubdomainID> & valid_ids = _blk_mesh->meshSubdomains();
142  std::vector<SubdomainID> diff;
143 
144  std::set_difference(_blk_ids.begin(),
145  _blk_ids.end(),
146  valid_ids.begin(),
147  valid_ids.end(),
148  std::back_inserter(diff));
149 
150  if (!diff.empty())
151  {
152  std::ostringstream msg;
153  msg << "the following block ids do not exist on the mesh:";
154  for (const auto & id : diff)
155  msg << " " << id;
156  moose_object->paramError("block", msg.str());
157  }
158  }
159 }

Referenced by BlockRestrictable::BlockRestrictable().

◆ initializeBoundaryRestrictable()

void BoundaryRestrictable::initializeBoundaryRestrictable ( const MooseObject moose_object)
privateinherited

An initialization routine needed for dual constructors.

Definition at line 76 of file BoundaryRestrictable.C.

77 {
78  // The name and id of the object
79  const std::string & name = moose_object->getParamTempl<std::string>("_object_name");
80 
81  // If the mesh pointer is not defined, but FEProblemBase is, get it from there
82  if (_bnd_feproblem != NULL && _bnd_mesh == NULL)
84 
85  // Check that the mesh pointer was defined, it is required for this class to operate
86  if (_bnd_mesh == NULL)
87  mooseError("The input parameters must contain a pointer to FEProblemBase via '_fe_problem' or "
88  "a pointer to the MooseMesh via '_mesh'");
89 
90  // If the user supplies boundary IDs
91  if (moose_object->isParamValid("boundary"))
92  {
93  // Extract the blocks from the input
94  _boundary_names = moose_object->getParamTempl<std::vector<BoundaryName>>("boundary");
95 
96  // Get the IDs from the supplied names
97  std::vector<BoundaryID> vec_ids = _bnd_mesh->getBoundaryIDs(_boundary_names, true);
98 
99  // Store the IDs, handling ANY_BOUNDARY_ID if supplied
100  if (std::find(_boundary_names.begin(), _boundary_names.end(), "ANY_BOUNDARY_ID") !=
101  _boundary_names.end())
103  else
104  _bnd_ids.insert(vec_ids.begin(), vec_ids.end());
105  }
106 
107  // Produce error if the object is not allowed to be both block and boundary restricted
108  if (!_bnd_dual_restrictable && !_bnd_ids.empty() && !_block_ids.empty())
109  if (!_block_ids.empty() && _block_ids.find(Moose::ANY_BLOCK_ID) == _block_ids.end())
110  moose_object->paramError("boundary",
111  "Attempted to restrict the object '",
112  name,
113  "' to a boundary, but the object is already restricted by block(s)");
114 
115  // Store ANY_BOUNDARY_ID if empty
116  if (_bnd_ids.empty())
117  {
119  _boundary_names = {"ANY_BOUNDARY_ID"};
120  }
121 
122  // If this object is block restricted, check that defined blocks exist on the mesh
123  if (_bnd_ids.find(Moose::ANY_BOUNDARY_ID) == _bnd_ids.end())
124  {
125  const std::set<BoundaryID> * valid_ids;
126  const char * message_ptr = nullptr;
127 
128  if (_bnd_nodal)
129  {
130  valid_ids = &_bnd_mesh->meshNodesetIds();
131  message_ptr = "node set";
132  }
133  else
134  {
135  valid_ids = &_bnd_mesh->meshSidesetIds();
136  message_ptr = "side set";
137  }
138 
139  std::vector<BoundaryID> diff;
140 
141  std::set_difference(_bnd_ids.begin(),
142  _bnd_ids.end(),
143  valid_ids->begin(),
144  valid_ids->end(),
145  std::back_inserter(diff));
146 
147  if (!diff.empty())
148  {
149  std::ostringstream msg;
150  msg << "the following " << message_ptr << " ids do not exist on the mesh:";
151  for (const auto & id : diff)
152  msg << " " << id;
153 
154  if (!_bnd_nodal)
155  // Diagnostic message
156  msg << "\n\nMOOSE distinguishes between \"node sets\" and \"side sets\" depending on "
157  "whether \nyou are using \"Nodal\" or \"Integrated\" BCs respectively. Node sets "
158  "corresponding \nto your side sets are constructed for you by default.\n\n"
159  "Try setting \"Mesh/construct_side_set_from_node_set=true\" if you see this error.\n"
160  "Note: If you are running with adaptivity you should prefer using side sets.";
161 
162  moose_object->paramError("boundary", msg.str());
163  }
164  }
165 }

Referenced by BoundaryRestrictable::BoundaryRestrictable().

◆ initialSetup()

virtual void InitialConditionBase::initialSetup ( )
inlinevirtualinherited

Gets called at the beginning of the simulation before this object is asked to do its job.

Note: This method is normally inherited from SetupInterface. However in this case it makes no sense to inherit the other virtuals available in that class so we are adding this virtual directly to this class with out the extra inheritance.

Reimplemented in RandomICBase.

Definition at line 90 of file InitialConditionBase.h.

90 {}

◆ isBlockSubset() [1/2]

bool BlockRestrictable::isBlockSubset ( const std::set< SubdomainID > &  ids) const
inherited

Test if the class block ids are a subset of the supplied objects.

Parameters
idsA std::set of Subdomains to check
Returns
True if all of the block ids for this class are found within the given ids (opposite of hasBlocks)
See also
hasBlocks

Definition at line 227 of file BlockRestrictable.C.

228 {
229  // An empty input is assumed to be ANY_BLOCK_ID
230  if (ids.empty() || ids.find(Moose::ANY_BLOCK_ID) != ids.end())
231  return true;
232 
233  if (_blk_ids.find(Moose::ANY_BLOCK_ID) != _blk_ids.end())
234  return std::includes(ids.begin(),
235  ids.end(),
236  _blk_mesh->meshSubdomains().begin(),
237  _blk_mesh->meshSubdomains().end());
238  else
239  return std::includes(ids.begin(), ids.end(), _blk_ids.begin(), _blk_ids.end());
240 }

Referenced by BlockRestrictable::checkVariable(), and BlockRestrictable::isBlockSubset().

◆ isBlockSubset() [2/2]

bool BlockRestrictable::isBlockSubset ( const std::vector< SubdomainID > &  ids) const
inherited

Test if the class block ids are a subset of the supplied objects.

Parameters
idsA std::vector of Subdomains to check
Returns
True if all of the block ids for this class are found within the given ids (opposite of hasBlocks)
See also
hasBlocks

Definition at line 243 of file BlockRestrictable.C.

244 {
245  std::set<SubdomainID> ids_set(ids.begin(), ids.end());
246  return isBlockSubset(ids_set);
247 }

◆ isBoundarySubset() [1/2]

bool BoundaryRestrictable::isBoundarySubset ( const std::set< BoundaryID > &  ids) const
inherited

Test if the class boundary ids are a subset of the supplied objects.

Parameters
idsA std::set of boundaries to check
Returns
True if all of the boundary ids for this class are found within the given ids (opposite of hasBoundary)
See also
hasBoundary

Definition at line 262 of file BoundaryRestrictable.C.

263 {
264  // An empty input is assumed to be ANY_BOUNDARY_ID
265  if (ids.empty() || ids.find(Moose::ANY_BOUNDARY_ID) != ids.end())
266  return true;
267 
268  if (_bnd_ids.find(Moose::ANY_BOUNDARY_ID) != _bnd_ids.end())
269  return std::includes(ids.begin(),
270  ids.end(),
271  _bnd_mesh->meshBoundaryIds().begin(),
272  _bnd_mesh->meshBoundaryIds().end());
273  else
274  return std::includes(ids.begin(), ids.end(), _bnd_ids.begin(), _bnd_ids.end());
275 }

Referenced by BoundaryRestrictable::isBoundarySubset().

◆ isBoundarySubset() [2/2]

bool BoundaryRestrictable::isBoundarySubset ( const std::vector< BoundaryID > &  ids) const
inherited

Definition at line 278 of file BoundaryRestrictable.C.

279 {
280  std::set<BoundaryID> ids_set(ids.begin(), ids.end());
281  return isBoundarySubset(ids_set);
282 }

◆ isCoupled()

bool Coupleable::isCoupled ( const std::string &  var_name,
unsigned int  i = 0 
)
protectedvirtualinherited

Returns true if a variables has been coupled as name.

Parameters
var_nameThe name the kernel wants to refer to the variable as.
iBy default 0, in general the index to test in a vector of MooseVariable pointers.
Returns
True if a coupled variable has the supplied name

Definition at line 107 of file Coupleable.C.

108 {
109  auto it = _coupled_vars.find(var_name);
110  if (it != _coupled_vars.end())
111  return (i < it->second.size());
112  else
113  {
114  // Make sure the user originally requested this value in the InputParameter syntax
115  if (!_c_parameters.hasCoupledValue(var_name))
117  ": The coupled variable \"",
118  var_name,
119  "\" was never added to this objects's "
120  "InputParameters, please double-check your "
121  "spelling");
122 
123  return false;
124  }
125 }

Referenced by Coupleable::adCoupledNodalValueTemplate(), Coupleable::checkVar(), Coupleable::coupledComponents(), and MatDiffusionBase< Real >::MatDiffusionBase().

◆ isParamValid()

bool MooseObject::isParamValid ( const std::string &  name) const
inlineinherited

Test if the supplied parameter is valid.

Parameters
nameThe name of the parameter to test

Definition at line 100 of file MooseObject.h.

100 { return _pars.isParamValid(name); }

Referenced by AdvancedOutput::AdvancedOutput(), BicubicSplineFunction::BicubicSplineFunction(), DistributedGeneratedMesh::buildMesh(), GeneratedMesh::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().

◆ meshBlockIDs()

const std::set< SubdomainID > & BlockRestrictable::meshBlockIDs ( ) const
inherited

Return all of the SubdomainIDs for the mesh.

Returns
A set of all subdomians for the entire mesh

Definition at line 250 of file BlockRestrictable.C.

251 {
252  return _blk_mesh->meshSubdomains();
253 }

Referenced by BlockRestrictable::checkVariable(), BlockRestrictable::getBlockCoordSystem(), and BlockRestrictable::hasBlockMaterialPropertyHelper().

◆ meshBoundaryIDs()

const std::set< BoundaryID > & BoundaryRestrictable::meshBoundaryIDs ( ) const
inherited

Returns the set of all boundary ids for the entire mesh.

Returns
A const reference the the boundary ids for the entire mesh

Definition at line 285 of file BoundaryRestrictable.C.

286 {
287  return _bnd_mesh->getBoundaryIDs();
288 }

Referenced by BoundaryRestrictable::hasBoundaryMaterialPropertyHelper().

◆ mooseDeprecated()

template<typename... Args>
void MooseObject::mooseDeprecated ( Args &&...  args) const
inlineinherited

Definition at line 156 of file MooseObject.h.

157  {
158  moose::internal::mooseDeprecatedStream(_console, false, std::forward<Args>(args)...);
159  }

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().

◆ mooseError()

template<typename... Args>
void MooseObject::mooseError ( Args &&...  args) const
inlineinherited

Definition at line 141 of file MooseObject.h.

142  {
143  std::ostringstream oss;
144  moose::internal::mooseStreamAll(oss, std::forward<Args>(args)...);
145  std::string msg = oss.str();
146  callMooseErrorRaw(msg, &_app);
147  }

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(), MeshExtruder::modify(), BreakMeshByBlockBase::modify(), AssignElementSubdomainID::modify(), SmoothMesh::modify(), AddAllSideSetsByNormals::modify(), ElementDeleterBase::modify(), ParsedSubdomainMeshModifier::modify(), RenameBlock::modify(), ImageSubdomain::modify(), OrientedSubdomainBoundingBox::modify(), BoundingBoxNodeSet::modify(), SubdomainBoundingBox::modify(), AddSideSetsFromBoundingBox::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().

◆ mooseInfo()

template<typename... Args>
void MooseObject::mooseInfo ( Args &&...  args) const
inlineinherited

◆ mooseWarning()

template<typename... Args>
void MooseObject::mooseWarning ( Args &&...  args) const
inlineinherited

◆ name()

virtual const std::string& MooseObject::name ( ) const
inlinevirtualinherited

Get the name of the object.

Returns
The name of the object TODO:MooseVariableToMooseObject (see #10601)

Reimplemented in MooseVariableBase.

Definition at line 70 of file MooseObject.h.

70 { return _name; }

Referenced by GridPartitioner::_do_partition(), FEProblemBase::addADJacobianInterfaceMaterial(), FEProblemBase::addADJacobianMaterial(), FEProblemBase::addADKernel(), FEProblemBase::addADResidualInterfaceMaterial(), FEProblemBase::addADResidualMaterial(), Executioner::addAttributeReporter(), 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(), ADDGKernel< compute_stage >::ADDGKernel(), FEProblemBase::addIndicator(), DumpObjectsProblem::addInitialCondition(), FEProblemBase::addInitialCondition(), DumpObjectsProblem::addInterfaceKernel(), FEProblemBase::addInterfaceKernel(), FEProblemBase::addInterfaceMaterial(), DumpObjectsProblem::addKernel(), FEProblemBase::addKernel(), FEProblemBase::addMarker(), DumpObjectsProblem::addMaterial(), FEProblemBase::addMaterial(), FEProblemBase::addMaterialHelper(), FEProblemBase::addMultiApp(), DumpObjectsProblem::addNodalKernel(), FEProblemBase::addNodalKernel(), FEProblemBase::addPostprocessor(), FEProblemBase::addPredictor(), CreateDisplacedProblemAction::addProxyRelationshipManagers(), FEProblemBase::addSampler(), DumpObjectsProblem::addScalarKernel(), FEProblemBase::addScalarKernel(), FEProblemBase::addTimeIntegrator(), FEProblemBase::addTransfer(), FEProblemBase::addUserObject(), DisplacedProblem::addVariable(), FEProblemBase::addVectorPostprocessor(), ADKernelTempl< T, compute_stage >::ADKernelTempl(), Output::advancedExecuteOn(), MultiApp::appPostprocessorValue(), MultiApp::appProblem(), MultiApp::appProblemBase(), MultiApp::appUserObjectBase(), ArrayDGKernel::ArrayDGKernel(), DerivativeParsedMaterialHelper::assembleDerivatives(), AStableDirk4::AStableDirk4(), Function::average(), MultiApp::backup(), BreakMeshByBlockGenerator::BreakMeshByBlockGenerator(), ChangeOverTimePostprocessor::ChangeOverTimePostprocessor(), FEProblemBase::checkDependMaterialsHelper(), Damper::checkMinDamping(), MaterialBase::checkStatefulSanity(), CoarsenedPiecewiseLinear::CoarsenedPiecewiseLinear(), CompositeFunction::CompositeFunction(), MaterialBase::computeProperties(), MaterialBase::computeSubdomainProperties(), FEProblemBase::computeUserObjectByName(), VectorPostprocessorVisualizationAux::computeValue(), MultiApp::createApp(), MeshGenerator::declareMeshProperty(), FEProblemBase::declareVectorPostprocessorVector(), DOFMapOutput::demangle(), DerivativeSumMaterial::DerivativeSumMaterial(), DGKernel::DGKernel(), DGKernelBase::DGKernelBase(), DumpObjectsProblem::dumpObjectHelper(), ElementValueSampler::ElementValueSampler(), MooseMesh::errorIfDistributedMesh(), AB2PredictorCorrector::estimateTimeError(), SolutionUserObject::evalMeshFunction(), SolutionUserObject::evalMeshFunctionGradient(), SolutionUserObject::evalMultiValuedMeshFunction(), SolutionUserObject::evalMultiValuedMeshFunctionGradient(), MultiAppPostprocessorTransfer::execute(), StatisticsVectorPostprocessor::execute(), MultiAppPostprocessorInterpolationTransfer::execute(), MultiAppVariableValueSamplePostprocessorTransfer::execute(), MultiAppVectorPostprocessorTransfer::execute(), MultiAppCopyTransfer::execute(), MultiAppMeshFunctionTransfer::execute(), MultiAppInterpolationTransfer::execute(), MultiAppUserObjectTransfer::execute(), PointValue::execute(), MultiAppScalarToAuxScalarTransfer::execute(), MultiAppPostprocessorToAuxScalarTransfer::execute(), MultiAppVariableValueSampleTransfer::execute(), MultiAppNearestNodeTransfer::execute(), HistogramVectorPostprocessor::execute(), MultiAppProjectionTransfer::execute(), Exodus::Exodus(), FancyExtruderGenerator::FancyExtruderGenerator(), MultiApp::fillPositions(), PointSamplerBase::finalize(), FunctionDT::FunctionDT(), FunctionPresetBC::FunctionPresetBC(), GeneralUserObject::GeneralUserObject(), LowerDBlockFromSidesetGenerator::generate(), GeneratedMeshGenerator::generate(), StitchedMeshGenerator::generate(), Material::getADMaterialPropertyTempl(), MultiApp::getBoundingBox(), MooseObject::getCheckedPointerParam(), Control::getControllableParameterByName(), Control::getControllableValue(), Control::getControllableValueByName(), DistributionInterface::getDistribution(), FEProblemBase::getDistribution(), DistributionInterface::getDistributionByName(), MultiApp::getExecutioner(), OutputWarehouse::getFileNumbers(), FEProblemBase::getFunction(), FEProblemBase::getInterfaceMaterial(), SolutionUserObject::getLocalVarIndex(), Marker::getMarkerValue(), FEProblemBase::getMaterial(), SubProblem::getMaterialPropertyBlockNames(), SubProblem::getMaterialPropertyBoundaryNames(), Material::getMaterialPropertyOlderTempl(), InterfaceMaterial::getMaterialPropertyOlderTempl(), NodalPatchRecovery::getMaterialPropertyOlderTempl(), AuxKernelTempl< ComputeValueType >::getMaterialPropertyOlderTempl(), Material::getMaterialPropertyOldTempl(), InterfaceMaterial::getMaterialPropertyOldTempl(), NodalPatchRecovery::getMaterialPropertyOldTempl(), AuxKernelTempl< ComputeValueType >::getMaterialPropertyOldTempl(), Material::getMaterialPropertyTempl(), InterfaceMaterial::getMaterialPropertyTempl(), NodalPatchRecovery::getMaterialPropertyTempl(), AuxKernelTempl< ComputeValueType >::getMaterialPropertyTempl(), MeshGenerator::getMesh(), InterfaceMaterial::getNeighborMaterialPropertyOld(), InterfaceMaterial::getNeighborMaterialPropertyOlder(), InterfaceMaterial::getNeighborMaterialPropertyTempl(), OutputWarehouse::getOutput(), MooseObject::getParamTempl(), GeneralUserObject::getPostprocessorValue(), FEProblemBase::getPostprocessorValue(), GeneralUserObject::getPostprocessorValueByName(), FEProblemBase::getPostprocessorValueOld(), FEProblemBase::getPostprocessorValueOlder(), FEProblemBase::getSampler(), FEProblemBase::getScatterVectorPostprocessorValue(), FEProblemBase::getScatterVectorPostprocessorValueOld(), Transient::getTimeStepperName(), InitialConditionBase::getUserObjectBase(), FEProblemBase::getUserObjectBase(), InitialConditionBase::getUserObjectByNameTempl(), InitialConditionBase::getUserObjectTempl(), FEProblemBase::getUserObjectTempl(), GeneralUserObject::getVectorPostprocessorValue(), FEProblemBase::getVectorPostprocessorValue(), GeneralUserObject::getVectorPostprocessorValueByName(), FEProblemBase::getVectorPostprocessorValueOld(), FEProblemBase::hasFunction(), AdvancedOutput::hasOutputHelper(), FEProblemBase::hasPostprocessor(), FEProblemBase::hasUserObject(), FEProblemBase::hasVectorPostprocessor(), FEProblemBase::init(), AdvancedOutput::initExecutionTypes(), AttribName::initFrom(), CSVReader::initialize(), StatisticsVectorPostprocessor::initialize(), HistogramVectorPostprocessor::initialize(), SolutionScalarAux::initialSetup(), MultiAppProjectionTransfer::initialSetup(), DerivativeFunctionMaterialBase::initialSetup(), MultiApp::initialSetup(), SolutionUserObject::initialSetup(), AdvancedOutput::initOutputList(), FEProblemBase::initPostprocessorData(), AdvancedOutput::initPostprocessorOrVectorPostprocessorLists(), MaterialBase::initStatefulProperties(), FEProblemBase::initVectorPostprocessorData(), Function::integral(), InterfaceKernelTempl< T >::InterfaceKernelTempl(), Registry::isADObj(), MooseObject::isParamValid(), Registry::isRegisteredObj(), LinearCombinationFunction::LinearCombinationFunction(), Marker::Marker(), MatDiffusionBase< Real >::MatDiffusionBase(), MaterialDerivativeTestKernelBase< Real >::MaterialDerivativeTestKernelBase(), MaterialOutputAction::materialOutputHelper(), MaterialVectorPostprocessor::MaterialVectorPostprocessor(), Distribution::median(), MemoryUsageReporter::MemoryUsageReporter(), MeshSideSetGenerator::MeshSideSetGenerator(), ElementDeleterBase::modify(), MooseVariableInterface< Real >::MooseVariableInterface(), NodalValueSampler::NodalValueSampler(), NodalVariableValue::NodalVariableValue(), Registry::objData(), DOFMapOutput::output(), Output::Output(), AdvancedOutput::outputElementalVariables(), ConsoleUtils::outputExecutionInformation(), AdvancedOutput::outputInput(), AdvancedOutput::outputNodalVariables(), ConsoleUtils::outputOutputInformation(), Nemesis::outputPostprocessors(), Exodus::outputPostprocessors(), AdvancedOutput::outputPostprocessors(), AdvancedOutput::outputScalarVariables(), OversampleOutput::outputStep(), Output::outputStep(), AdvancedOutput::outputSystemInformation(), AdvancedOutput::outputVectorPostprocessors(), ParsedAddSideset::ParsedAddSideset(), ParsedAux::ParsedAux(), ParsedGenerateSideset::ParsedGenerateSideset(), ParsedODEKernel::ParsedODEKernel(), ParsedSubdomainMeshGenerator::ParsedSubdomainMeshGenerator(), ParsedSubdomainMeshModifier::ParsedSubdomainMeshModifier(), PointSamplerBase::PointSamplerBase(), MultiAppConservativeTransfer::postExecute(), PresetBC::PresetBC(), PresetNodalBC::PresetNodalBC(), Registry::registerObjectsTo(), FEProblemBase::registerRandomInterface(), MaterialBase::resetQpProperties(), MultiApp::restore(), ScalarComponentIC::ScalarComponentIC(), MooseMesh::setBoundaryName(), Control::setControllableValue(), Control::setControllableValueByName(), OutputWarehouse::setFileNumbers(), MooseMesh::setSubdomainName(), Split::setup(), TransientMultiApp::setupApp(), SideSetsFromNormalsGenerator::SideSetsFromNormalsGenerator(), SideSetsFromPointsGenerator::SideSetsFromPointsGenerator(), SideValueSampler::SideValueSampler(), TransientMultiApp::solveStep(), SpatialAverageBase::SpatialAverageBase(), UserObject::spatialValue(), StitchedMesh::StitchedMesh(), SubProblem::storeBoundaryDelayedCheckMatProp(), SubProblem::storeBoundaryMatPropName(), SubProblem::storeBoundaryZeroMatProp(), SubProblem::storeSubdomainDelayedCheckMatProp(), SubProblem::storeSubdomainMatPropName(), SubProblem::storeSubdomainZeroMatProp(), MaterialBase::subdomainSetup(), TaggingInterface::TaggingInterface(), ThreadedGeneralUserObject::ThreadedGeneralUserObject(), Function::timeDerivative(), VectorPostprocessorVisualizationAux::timestepSetup(), TransientMultiApp::TransientMultiApp(), MultiAppTransfer::variableIntegrityCheck(), and AdvancedOutput::wantOutput().

◆ needThreadedCopy()

bool UserObjectInterface::needThreadedCopy ( const UserObject uo) const
privateinherited

Check if the threaded copy of the user object is needed.

Definition at line 36 of file UserObjectInterface.C.

37 {
38  return (dynamic_cast<const DiscreteElementUserObject *>(&uo) != NULL) ||
39  (dynamic_cast<const ThreadedGeneralUserObject *>(&uo) != NULL);
40 }

Referenced by UserObjectInterface::getUserObjectByNameTempl(), and UserObjectInterface::getUserObjectTempl().

◆ numBlocks()

unsigned int BlockRestrictable::numBlocks ( ) const
inherited

Return the number of blocks for this object.

Returns
The number of subdomains

Definition at line 180 of file BlockRestrictable.C.

181 {
182  return (unsigned int)_blk_ids.size();
183 }

◆ numBoundaryIDs()

unsigned int BoundaryRestrictable::numBoundaryIDs ( ) const
inherited

Return the number of boundaries for this object.

Returns
The number of boundary ids

Definition at line 182 of file BoundaryRestrictable.C.

183 {
184  return (unsigned int)_bnd_ids.size();
185 }

Referenced by SidesetInfoVectorPostprocessor::initialize().

◆ paramError()

template<typename... Args>
void MooseObject::paramError ( const std::string &  param,
Args...  args 
) const
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.

216 {
217  Moose::show_trace = false;
218  mooseError(paramErrorMsg(param, std::forward<Args>(args)...));
219  Moose::show_trace = true;
220 }

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().

◆ paramErrorMsg()

template<typename... Args>
std::string MooseObject::paramErrorMsg ( const std::string &  param,
Args...  args 
) const
inlineprivateinherited

Definition at line 185 of file MooseObject.h.

186  {
187  auto prefix = paramErrorPrefix(_pars, param);
188  std::ostringstream oss;
189  moose::internal::mooseStreamAll(oss, std::forward<Args>(args)...);
190  std::string msg = oss.str();
191 
192  // Wrap error message to a separate line from prefix if it is about to
193  // blow past 100 chars. But only wrap if the prefix is long enough (12
194  // chars) for the wrap to buy us much extra length.
195  if ((prefix.size() > 12 && msg.size() + prefix.size() > 99) ||
196  msg.find("\n") != std::string::npos)
197  {
198  if (prefix.size() > 0 && prefix[prefix.size() - 1] != ':')
199  prefix += ":";
200  return prefix + "\n " + MooseUtils::replaceAll(msg, "\n", "\n ");
201  }
202  return prefix + " " + msg;
203  }

Referenced by MooseObject::paramError(), MooseObject::paramInfo(), and MooseObject::paramWarning().

◆ parameters()

const InputParameters& MooseObject::parameters ( ) const
inlineinherited

Get the parameters of the object.

Returns
The parameters of the object

Definition at line 76 of file MooseObject.h.

76 { return _pars; }

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().

◆ paramInfo()

template<typename... Args>
void MooseObject::paramInfo ( const std::string &  param,
Args...  args 
) const
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.

232 {
233  mooseInfo(paramErrorMsg(param, std::forward<Args>(args)...));
234 }

Referenced by TransientMultiApp::TransientMultiApp().

◆ paramWarning()

template<typename... Args>
void MooseObject::paramWarning ( const std::string &  param,
Args...  args 
) const
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.

225 {
226  mooseWarning(paramErrorMsg(param, std::forward<Args>(args)...));
227 }

Referenced by Executioner::Executioner().

◆ registerRestartableDataOnApp()

RestartableDataValue & Restartable::registerRestartableDataOnApp ( const std::string &  name,
std::unique_ptr< RestartableDataValue data,
THREAD_ID  tid 
)
privateinherited

Helper function for actually registering the restartable data.

Definition at line 48 of file Restartable.C.

51 {
52  return _restartable_app.registerRestartableData(name, std::move(data), tid, false, false);
53 }

Referenced by Restartable::declareRestartableDataWithContext().

◆ registerRestartableNameWithFilterOnApp()

void Restartable::registerRestartableNameWithFilterOnApp ( const std::string &  name,
Moose::RESTARTABLE_FILTER  filter 
)
privateinherited

Helper function for actually registering the restartable data.

Definition at line 56 of file Restartable.C.

58 {
60 }

Referenced by Restartable::declareRecoverableData().

◆ restricted()

bool BoundaryRestrictable::restricted ( const std::set< BoundaryID > &  ids)
staticinherited

Helper for determining if the object is boundary restricted.

This is needed for the MaterialPropertyInterface.

Definition at line 194 of file BoundaryRestrictable.C.

195 {
196  return ids.find(Moose::ANY_BOUNDARY_ID) == ids.end();
197 }

Referenced by BoundaryRestrictable::boundaryRestricted().

◆ setCZeroVertices() [1/2]

template<typename T >
void InitialConditionTempl< T >::setCZeroVertices ( )
inherited

set the temporary solution vector for node projections of C0 variables

Definition at line 284 of file InitialConditionTempl.C.

285 {
286  // Assume that C_ZERO elements have a single nodal
287  // value shape function
288  libmesh_assert(_nc == 1);
289  _qp = _n;
290  _current_node = _current_elem->node_ptr(_n);
292  _dof_is_fixed[_current_dof] = true;
293  _current_dof++;
294 }

◆ setCZeroVertices() [2/2]

template<>
void InitialConditionTempl< RealVectorValue >::setCZeroVertices ( )
inherited

Definition at line 298 of file InitialConditionTempl.C.

299 {
300  _qp = _n;
301  _current_node = _current_elem->node_ptr(_n);
302  auto point_value = value(*_current_node);
303  for (decltype(_nc) i = 0; i < _nc; ++i)
304  {
305  _Ue(_current_dof) = point_value(i);
306  _dof_is_fixed[_current_dof] = true;
307  _current_dof++;
308  }
309 }

◆ setHermiteVertices() [1/2]

template<typename T >
void InitialConditionTempl< T >::setHermiteVertices ( )
inherited

set the temporary solution vector for node projections of Hermite variables

Definition at line 334 of file InitialConditionTempl.C.

335 {
336  // The hermite element vertex shape functions are weird
337  _qp = _n;
338  _current_node = _current_elem->node_ptr(_n);
340  _dof_is_fixed[_current_dof] = true;
341  _current_dof++;
343  // x derivative
344  _Ue(_current_dof) = gradientComponent(grad, 0);
345  _dof_is_fixed[_current_dof] = true;
346  _current_dof++;
347  if (_dim > 1)
348  {
349  // We'll finite difference mixed derivatives
350  Point nxminus = _current_elem->point(_n), nxplus = _current_elem->point(_n);
351  nxminus(0) -= TOLERANCE;
352  nxplus(0) += TOLERANCE;
353  GradientType gxminus = gradient(nxminus);
354  GradientType gxplus = gradient(nxplus);
355  // y derivative
356  _Ue(_current_dof) = gradientComponent(grad, 1);
357  _dof_is_fixed[_current_dof] = true;
358  _current_dof++;
359  // xy derivative
360  _Ue(_current_dof) =
361  (gradientComponent(gxplus, 1) - gradientComponent(gxminus, 1)) / 2. / TOLERANCE;
362  _dof_is_fixed[_current_dof] = true;
363  _current_dof++;
364 
365  if (_dim > 2)
366  {
367  // z derivative
368  _Ue(_current_dof) = gradientComponent(grad, 2);
369  _dof_is_fixed[_current_dof] = true;
370  _current_dof++;
371  // xz derivative
372  _Ue(_current_dof) =
373  (gradientComponent(gxplus, 2) - gradientComponent(gxminus, 2)) / 2. / TOLERANCE;
374  _dof_is_fixed[_current_dof] = true;
375  _current_dof++;
376  // We need new points for yz
377  Point nyminus = _current_elem->point(_n), nyplus = _current_elem->point(_n);
378  nyminus(1) -= TOLERANCE;
379  nyplus(1) += TOLERANCE;
380  GradientType gyminus = gradient(nyminus);
381  GradientType gyplus = gradient(nyplus);
382  // xz derivative
383  _Ue(_current_dof) =
384  (gradientComponent(gyplus, 2) - gradientComponent(gyminus, 2)) / 2. / TOLERANCE;
385  _dof_is_fixed[_current_dof] = true;
386  _current_dof++;
387  // Getting a 2nd order xyz is more tedious
388  Point nxmym = _current_elem->point(_n), nxmyp = _current_elem->point(_n),
389  nxpym = _current_elem->point(_n), nxpyp = _current_elem->point(_n);
390  nxmym(0) -= TOLERANCE;
391  nxmym(1) -= TOLERANCE;
392  nxmyp(0) -= TOLERANCE;
393  nxmyp(1) += TOLERANCE;
394  nxpym(0) += TOLERANCE;
395  nxpym(1) -= TOLERANCE;
396  nxpyp(0) += TOLERANCE;
397  nxpyp(1) += TOLERANCE;
398  GradientType gxmym = gradient(nxmym);
399  GradientType gxmyp = gradient(nxmyp);
400  GradientType gxpym = gradient(nxpym);
401  GradientType gxpyp = gradient(nxpyp);
402  DataType gxzplus =
403  (gradientComponent(gxpyp, 2) - gradientComponent(gxmyp, 2)) / 2. / TOLERANCE;
404  DataType gxzminus =
405  (gradientComponent(gxpym, 2) - gradientComponent(gxmym, 2)) / 2. / TOLERANCE;
406  // xyz derivative
407  _Ue(_current_dof) = (gxzplus - gxzminus) / 2. / TOLERANCE;
408  _dof_is_fixed[_current_dof] = true;
409  _current_dof++;
410  }
411  }
412 }

◆ setHermiteVertices() [2/2]

template<>
void InitialConditionTempl< RealVectorValue >::setHermiteVertices ( )
inherited

Definition at line 416 of file InitialConditionTempl.C.

417 {
418 }

◆ setOtherCOneVertices() [1/2]

template<typename T >
void InitialConditionTempl< T >::setOtherCOneVertices ( )
inherited

set the temporary solution vector for node projections of non-Hermitian C1 variables

Definition at line 422 of file InitialConditionTempl.C.

423 {
424  // Assume that other C_ONE elements have a single nodal
425  // value shape function and nodal gradient component
426  // shape functions
427  libmesh_assert(_nc == 1 + _dim);
428  _current_node = _current_elem->node_ptr(_n);
430  _dof_is_fixed[_current_dof] = true;
431  _current_dof++;
433  for (unsigned int i = 0; i != _dim; ++i)
434  {
435  _Ue(_current_dof) = gradientComponent(grad, i);
436  _dof_is_fixed[_current_dof] = true;
437  _current_dof++;
438  }
439 }

◆ setOtherCOneVertices() [2/2]

template<>
void InitialConditionTempl< RealVectorValue >::setOtherCOneVertices ( )
inherited

Definition at line 443 of file InitialConditionTempl.C.

444 {
445 }

◆ sort()

template<typename T >
void DependencyResolverInterface::sort ( typename std::vector< T > &  vector)
staticinherited

Given a vector, sort using the getRequested/SuppliedItems sets.

Definition at line 57 of file DependencyResolverInterface.h.

58 {
59  DependencyResolver<T> resolver;
60 
61  typename std::vector<T>::iterator start = vector.begin();
62  typename std::vector<T>::iterator end = vector.end();
63 
64  for (typename std::vector<T>::iterator iter = start; iter != end; ++iter)
65  {
66  const std::set<std::string> & requested_items = (*iter)->getRequestedItems();
67 
68  for (typename std::vector<T>::iterator iter2 = start; iter2 != end; ++iter2)
69  {
70  if (iter == iter2)
71  continue;
72 
73  const std::set<std::string> & supplied_items = (*iter2)->getSuppliedItems();
74 
75  std::set<std::string> intersect;
76  std::set_intersection(requested_items.begin(),
77  requested_items.end(),
78  supplied_items.begin(),
79  supplied_items.end(),
80  std::inserter(intersect, intersect.end()));
81 
82  // If the intersection isn't empty then there is a dependency here
83  if (!intersect.empty())
84  resolver.insertDependency(*iter, *iter2);
85  }
86  }
87 
88  // Sort based on dependencies
89  std::stable_sort(start, end, resolver);
90 }

Referenced by TheWarehouse::prepare().

◆ type()

const std::string& MooseObject::type ( ) const
inlineinherited

Get the type of this object.

Returns
the name of the type of this object

Definition at line 63 of file MooseObject.h.

63 { return _type; }

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(), CoupledTiedValueConstraint::computeQpResidual(), TiedValueConstraint::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().

◆ validateExecutionerType()

void Coupleable::validateExecutionerType ( const std::string &  name,
const std::string &  fn_name 
) const
protectedinherited

Checks to make sure that the current Executioner has set "_is_transient" when old/older values are coupled in.

Parameters
namethe name of the variable
fn_nameThe name of the function that called this method - used in the error message

Definition at line 1336 of file Coupleable.C.

1337 {
1338  if (!_c_fe_problem.isTransient())
1340  ": Calling \"",
1341  fn_name,
1342  "\" on variable \"",
1343  name,
1344  "\" when using a \"Steady\" executioner is not allowed. This value is available "
1345  "only in transient simulations.");
1346 }

Referenced by Coupleable::checkFuncType(), NeighborCoupleable::coupledArrayNeighborGradientOld(), NeighborCoupleable::coupledArrayNeighborGradientOlder(), NeighborCoupleable::coupledNeighborDofValuesOld(), NeighborCoupleable::coupledNeighborDofValuesOlder(), NeighborCoupleable::coupledNeighborGradientOld(), NeighborCoupleable::coupledNeighborGradientOlder(), NeighborCoupleable::coupledNeighborValueOld(), NeighborCoupleable::coupledNeighborValueOlder(), NeighborCoupleable::coupledVectorNeighborGradientOld(), and NeighborCoupleable::coupledVectorNeighborGradientOlder().

◆ validParams()

InputParameters VectorConstantIC::validParams ( )
static

Definition at line 18 of file VectorConstantIC.C.

19 {
21  params.addRequiredParam<Real>("x_value", "The x value to be set in IC");
22  params.addParam<Real>("y_value", 0, "The y value to be set in IC");
23  params.addParam<Real>("z_value", 0, "The z value to be set in IC");
24 
25  params.addClassDescription("Sets constant component values for a vector field variable.");
26  return params;
27 }

◆ value()

RealVectorValue VectorConstantIC::value ( const Point &  p)
overridevirtual

The value of the variable at a point.

This must be overridden by derived classes.

Implements InitialConditionTempl< T >.

Definition at line 38 of file VectorConstantIC.C.

39 {
40  return {_x_value, _y_value, _z_value};
41 }

◆ variable()

template<typename T >
virtual MooseVariableFEBase& InitialConditionTempl< T >::variable ( )
inlineoverridevirtualinherited

retrieves the MOOSE variable that this initial condition acts upon

Implements InitialConditionBase.

Definition at line 59 of file InitialConditionTempl.h.

59 { return _var; }

◆ writableCoupledValue()

VariableValue & Coupleable::writableCoupledValue ( const std::string &  var_name,
unsigned int  comp = 0 
)
protectedvirtualinherited

Returns a writable reference to a coupled variable.

Note: you should not have to use this very often (use coupledValue() instead) but there are situations, such as writing to multiple AuxVariables from a single AuxKernel, where it is required.

Parameters
var_nameName of coupled variable
compComponent number for vector of coupled variables
Returns
Reference to a VariableValue for the coupled variable
See also
Kernel::value

Definition at line 477 of file Coupleable.C.

478 {
479  return const_cast<VariableValue &>(coupledValue(var_name, comp));
480 }

Member Data Documentation

◆ _ad_default_gradient

MooseArray<DualRealVectorValue> Coupleable::_ad_default_gradient
protectedinherited

This will always be zero because the default values for optionally coupled variables is always constant.

Definition at line 910 of file Coupleable.h.

Referenced by Coupleable::Coupleable(), and Coupleable::getADDefaultGradient().

◆ _ad_default_second

MooseArray<DualRealTensorValue> Coupleable::_ad_default_second
protectedinherited

This will always be zero because the default values for optionally coupled variables is always constant.

Definition at line 919 of file Coupleable.h.

Referenced by Coupleable::Coupleable(), and Coupleable::getADDefaultSecond().

◆ _ad_default_value

std::unordered_map<std::string, std::unique_ptr<MooseArray<DualReal> > > Coupleable::_ad_default_value
protectedinherited

Will hold the default value for optional coupled variables for automatic differentiation.

Definition at line 888 of file Coupleable.h.

Referenced by Coupleable::getADDefaultValue().

◆ _ad_default_vector_gradient

MooseArray<DualRealTensorValue> Coupleable::_ad_default_vector_gradient
protectedinherited

This will always be zero because the default values for optionally coupled vector variables is always constant.

Definition at line 913 of file Coupleable.h.

Referenced by Coupleable::Coupleable(), and Coupleable::getADDefaultVectorGradient().

◆ _ad_default_vector_value

std::unordered_map<std::string, std::unique_ptr<MooseArray<DualRealVectorValue> > > Coupleable::_ad_default_vector_value
protectedinherited

Will hold the default value for optional vector coupled variables for automatic differentiation.

Definition at line 898 of file Coupleable.h.

Referenced by Coupleable::getADDefaultVectorValue().

◆ _ad_grad_zero

const MooseArray<DualRealVectorValue>& Coupleable::_ad_grad_zero
protectedinherited

Definition at line 927 of file Coupleable.h.

Referenced by Coupleable::adZeroGradientTemplate().

◆ _ad_second_zero

const MooseArray<DualRealTensorValue>& Coupleable::_ad_second_zero
protectedinherited

Definition at line 931 of file Coupleable.h.

Referenced by Coupleable::adZeroSecondTemplate().

◆ _ad_zero

const MooseArray<DualReal>& Coupleable::_ad_zero
protectedinherited

Definition at line 923 of file Coupleable.h.

Referenced by Coupleable::adZeroValueTemplate().

◆ _app

MooseApp& MooseObject::_app
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().

◆ _assembly

template<typename T >
Assembly& InitialConditionTempl< T >::_assembly
protectedinherited

Definition at line 123 of file InitialConditionTempl.h.

◆ _blk_dual_restrictable

const bool BlockRestrictable::_blk_dual_restrictable
privateinherited

Flag for allowing dual restriction.

Definition at line 233 of file BlockRestrictable.h.

Referenced by BlockRestrictable::initializeBlockRestrictable().

◆ _blk_feproblem

FEProblemBase* BlockRestrictable::_blk_feproblem
privateinherited

◆ _blk_ids

std::set<SubdomainID> BlockRestrictable::_blk_ids
privateinherited

◆ _blk_material_data

std::shared_ptr<MaterialData> BlockRestrictable::_blk_material_data
protectedinherited

Pointer to the MaterialData class for this object.

Definition at line 205 of file BlockRestrictable.h.

Referenced by BlockRestrictable::hasBlockMaterialProperty(), and BlockRestrictable::initializeBlockRestrictable().

◆ _blk_mesh

MooseMesh* BlockRestrictable::_blk_mesh
privateinherited

◆ _blk_name

const std::string& BlockRestrictable::_blk_name
privateinherited

Name of the object.

Definition at line 251 of file BlockRestrictable.h.

Referenced by BlockRestrictable::checkVariable(), and BlockRestrictable::initializeBlockRestrictable().

◆ _blk_tid

THREAD_ID BlockRestrictable::_blk_tid
privateinherited

Thread id for this object.

Definition at line 248 of file BlockRestrictable.h.

Referenced by BlockRestrictable::initializeBlockRestrictable().

◆ _block_ids

const std::set<SubdomainID>& BoundaryRestrictable::_block_ids
privateinherited

Reference to the block_ids, defaults to an empty set if not provided.

Definition at line 198 of file BoundaryRestrictable.h.

Referenced by BoundaryRestrictable::initializeBoundaryRestrictable().

◆ _blocks

std::vector<SubdomainName> BlockRestrictable::_blocks
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().

◆ _bnd_dual_restrictable

const bool BoundaryRestrictable::_bnd_dual_restrictable
privateinherited

Flag for allowing dual restriction with BlockRestrictable.

Definition at line 192 of file BoundaryRestrictable.h.

Referenced by BoundaryRestrictable::initializeBoundaryRestrictable().

◆ _bnd_feproblem

FEProblemBase* BoundaryRestrictable::_bnd_feproblem
privateinherited

◆ _bnd_ids

std::set<BoundaryID> BoundaryRestrictable::_bnd_ids
privateinherited

◆ _bnd_material_data

std::shared_ptr<MaterialData> BoundaryRestrictable::_bnd_material_data
privateinherited

Pointer to MaterialData for boundary (.

See also
hasBoundaryMaterialProperty)

Definition at line 204 of file BoundaryRestrictable.h.

Referenced by BoundaryRestrictable::hasBoundaryMaterialProperty().

◆ _bnd_mesh

MooseMesh* BoundaryRestrictable::_bnd_mesh
privateinherited

◆ _bnd_nodal

bool BoundaryRestrictable::_bnd_nodal
privateinherited

Whether or not this object is restricted to nodesets.

Definition at line 207 of file BoundaryRestrictable.h.

Referenced by BoundaryRestrictable::initializeBoundaryRestrictable().

◆ _bnd_tid

THREAD_ID BoundaryRestrictable::_bnd_tid
privateinherited

Thread id for this object.

Definition at line 201 of file BoundaryRestrictable.h.

◆ _boundary_ids

const std::set<BoundaryID>& BlockRestrictable::_boundary_ids
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().

◆ _boundary_names

std::vector<BoundaryName> BoundaryRestrictable::_boundary_names
privateinherited

Vector the the boundary names.

Definition at line 189 of file BoundaryRestrictable.h.

Referenced by BoundaryRestrictable::boundaryNames(), and BoundaryRestrictable::initializeBoundaryRestrictable().

◆ _c_coupled_scalar_vars

std::unordered_map<std::string, std::vector<MooseVariableScalar *> > Coupleable::_c_coupled_scalar_vars
privateinherited

Scalar variables coupled into this object (for error checking)

Definition at line 1122 of file Coupleable.h.

Referenced by Coupleable::checkVar(), and Coupleable::Coupleable().

◆ _c_fe_problem

FEProblemBase& Coupleable::_c_fe_problem
protectedinherited

◆ _c_is_implicit

bool Coupleable::_c_is_implicit
protectedinherited

True if implicit value is required.

Definition at line 879 of file Coupleable.h.

Referenced by Coupleable::adCoupledGradientTemplate(), Coupleable::adCoupledNodalValueTemplate(), Coupleable::adCoupledSecondTemplate(), Coupleable::adCoupledValueTemplate(), Coupleable::adCoupledVectorGradientTemplate(), Coupleable::adCoupledVectorValueTemplate(), Coupleable::checkFuncType(), Coupleable::coupledArrayGradient(), Coupleable::coupledArrayGradientOld(), NeighborCoupleable::coupledArrayNeighborGradient(), NeighborCoupleable::coupledArrayNeighborGradientOld(), NeighborCoupleable::coupledArrayNeighborGradientOlder(), NeighborCoupleable::coupledArrayNeighborValue(), Coupleable::coupledArrayValue(), Coupleable::coupledArrayValueOld(), Coupleable::coupledCurl(), Coupleable::coupledCurlOld(), Coupleable::coupledDofValues(), Coupleable::coupledDofValuesOld(), Coupleable::coupledGradient(), Coupleable::coupledGradientOld(), NeighborCoupleable::coupledNeighborDofValues(), NeighborCoupleable::coupledNeighborDofValuesOld(), NeighborCoupleable::coupledNeighborDofValuesOlder(), NeighborCoupleable::coupledNeighborGradient(), NeighborCoupleable::coupledNeighborGradientOld(), NeighborCoupleable::coupledNeighborGradientOlder(), NeighborCoupleable::coupledNeighborSecond(), NeighborCoupleable::coupledNeighborValue(), NeighborCoupleable::coupledNeighborValueOld(), NeighborCoupleable::coupledNeighborValueOlder(), Coupleable::coupledNodalValue(), Coupleable::coupledNodalValueOld(), Coupleable::coupledSecond(), Coupleable::coupledSecondOld(), Coupleable::coupledValue(), Coupleable::coupledValueOld(), Coupleable::coupledVectorGradient(), Coupleable::coupledVectorGradientOld(), NeighborCoupleable::coupledVectorNeighborGradient(), NeighborCoupleable::coupledVectorNeighborGradientOld(), NeighborCoupleable::coupledVectorNeighborGradientOlder(), Coupleable::coupledVectorValue(), and Coupleable::coupledVectorValueOld().

◆ _c_name

const std::string& Coupleable::_c_name
protectedinherited

◆ _c_nodal

bool Coupleable::_c_nodal
protectedinherited

◆ _c_parameters

const InputParameters& Coupleable::_c_parameters
protectedinherited

◆ _c_tid

THREAD_ID Coupleable::_c_tid
protectedinherited

Thread ID of the thread using this object.

Definition at line 882 of file Coupleable.h.

Referenced by Coupleable::Coupleable().

◆ _console

const ConsoleStream ConsoleStreamInterface::_console
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(), MultiAppPostprocessorToAuxScalarTransfer::execute(), MultiAppVariableValueSampleTransfer::execute(), MultiAppScalarToAuxScalarTransfer::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().

◆ _cont

template<typename T >
FEContinuity InitialConditionTempl< T >::_cont
protectedinherited

The type of continuity, e.g. C0, C1.

Definition at line 155 of file InitialConditionTempl.h.

◆ _coord_sys

template<typename T >
const Moose::CoordinateSystemType& InitialConditionTempl< T >::_coord_sys
protectedinherited

The coordinate system type for this problem, references the value in Assembly.

Definition at line 129 of file InitialConditionTempl.h.

◆ _coupleable_max_qps

unsigned int Coupleable::_coupleable_max_qps
privateinherited

◆ _coupleable_neighbor

bool Coupleable::_coupleable_neighbor
protectedinherited

Whether or not this object is a "neighbor" object: ie all of it's coupled values should be neighbor values.

Definition at line 1036 of file Coupleable.h.

Referenced by Coupleable::adCoupledDotTemplate(), Coupleable::adCoupledGradientTemplate(), Coupleable::adCoupledNodalValueTemplate(), Coupleable::adCoupledSecondTemplate(), Coupleable::adCoupledValueTemplate(), Coupleable::adCoupledVectorDotTemplate(), Coupleable::adCoupledVectorGradientTemplate(), Coupleable::adCoupledVectorValueTemplate(), Coupleable::coupledArrayDot(), Coupleable::coupledArrayDotDot(), Coupleable::coupledArrayDotDotOld(), Coupleable::coupledArrayDotOld(), Coupleable::coupledArrayGradient(), Coupleable::coupledArrayGradientOld(), Coupleable::coupledArrayGradientOlder(), Coupleable::coupledArrayValue(), Coupleable::coupledArrayValueOld(), Coupleable::coupledArrayValueOlder(), Coupleable::coupledCurl(), Coupleable::coupledCurlOld(), Coupleable::coupledCurlOlder(), Coupleable::coupledDofValues(), Coupleable::coupledDofValuesOld(), Coupleable::coupledDofValuesOlder(), Coupleable::coupledDot(), Coupleable::coupledDotDot(), Coupleable::coupledDotDotDu(), Coupleable::coupledDotDotOld(), Coupleable::coupledDotDu(), Coupleable::coupledDotOld(), Coupleable::coupledGradient(), Coupleable::coupledGradientDot(), Coupleable::coupledGradientDotDot(), Coupleable::coupledGradientOld(), Coupleable::coupledGradientOlder(), Coupleable::coupledGradientPreviousNL(), Coupleable::coupledNodalDot(), Coupleable::coupledNodalDotDot(), Coupleable::coupledNodalDotDotOld(), Coupleable::coupledNodalDotOld(), Coupleable::coupledNodalValue(), Coupleable::coupledNodalValueOld(), Coupleable::coupledNodalValueOlder(), Coupleable::coupledNodalValuePreviousNL(), Coupleable::coupledSecond(), Coupleable::coupledSecondOld(), Coupleable::coupledSecondOlder(), Coupleable::coupledSecondPreviousNL(), Coupleable::coupledValue(), Coupleable::coupledValueOld(), Coupleable::coupledValueOlder(), Coupleable::coupledValuePreviousNL(), Coupleable::coupledVectorDot(), Coupleable::coupledVectorDotDot(), Coupleable::coupledVectorDotDotDu(), Coupleable::coupledVectorDotDotOld(), Coupleable::coupledVectorDotDu(), Coupleable::coupledVectorDotOld(), Coupleable::coupledVectorGradient(), Coupleable::coupledVectorGradientOld(), Coupleable::coupledVectorGradientOlder(), Coupleable::coupledVectorValue(), Coupleable::coupledVectorValueOld(), and Coupleable::coupledVectorValueOlder().

◆ _coupled_array_moose_vars

std::vector<ArrayMooseVariable *> Coupleable::_coupled_array_moose_vars
protectedinherited

Vector of array coupled variables.

Definition at line 873 of file Coupleable.h.

Referenced by Coupleable::Coupleable(), Coupleable::getCoupledArratMooseVars(), and Coupleable::getVarHelper().

◆ _coupled_moose_vars

std::vector<MooseVariableFEBase *> Coupleable::_coupled_moose_vars
protectedinherited

◆ _coupled_standard_moose_vars

std::vector<MooseVariable *> Coupleable::_coupled_standard_moose_vars
protectedinherited

◆ _coupled_vars

std::unordered_map<std::string, std::vector<MooseVariableFEBase *> > Coupleable::_coupled_vars
protectedinherited

◆ _coupled_vector_moose_vars

std::vector<VectorMooseVariable *> Coupleable::_coupled_vector_moose_vars
protectedinherited

Vector of vector coupled variables.

Definition at line 870 of file Coupleable.h.

Referenced by Coupleable::Coupleable(), Coupleable::getCoupledVectorMooseVars(), and Coupleable::getVarHelper().

◆ _current_dof

template<typename T >
dof_id_type InitialConditionTempl< T >::_current_dof
protectedinherited

The current dof being operated on.

Definition at line 175 of file InitialConditionTempl.h.

◆ _current_elem

template<typename T >
const Elem* const & InitialConditionTempl< T >::_current_elem
protectedinherited

The current element we are on will retrieving values at specific points in the domain.

Note that this IS valid even for nodes shared among several elements.

Definition at line 136 of file InitialConditionTempl.h.

Referenced by RandomICBase::generateRandom().

◆ _current_node

template<typename T >
const Node* InitialConditionTempl< T >::_current_node
protectedinherited

The current node if the point we are evaluating at also happens to be a node.

Otherwise the pointer will be NULL.

Definition at line 140 of file InitialConditionTempl.h.

Referenced by RandomICBase::generateRandom().

◆ _default_array_curl

ArrayVariableCurl Coupleable::_default_array_curl
protectedinherited

This will always be zero because the default values for optionally coupled variables is always constant.

Definition at line 961 of file Coupleable.h.

◆ _default_array_gradient

ArrayVariableGradient Coupleable::_default_array_gradient
protectedinherited

This will always be zero because the default values for optionally coupled variables is always constant.

Definition at line 958 of file Coupleable.h.

Referenced by Coupleable::coupledArrayGradient(), Coupleable::coupledArrayGradientOld(), and Coupleable::coupledArrayGradientOlder().

◆ _default_array_value

std::map<std::string, ArrayVariableValue *> Coupleable::_default_array_value
protectedinherited

Will hold the default value for optional array coupled variables.

Definition at line 894 of file Coupleable.h.

Referenced by Coupleable::getDefaultArrayValue().

◆ _default_array_value_zero

ArrayVariableValue Coupleable::_default_array_value_zero
protectedinherited

This will always be zero because the default values for optionally coupled variables is always constant and this is used for time derivative info.

Definition at line 955 of file Coupleable.h.

Referenced by Coupleable::coupledArrayDot(), Coupleable::coupledArrayDotDot(), Coupleable::coupledArrayDotDotOld(), and Coupleable::coupledArrayDotOld().

◆ _default_gradient

VariableGradient Coupleable::_default_gradient
protectedinherited

◆ _default_second

VariableSecond Coupleable::_default_second
protectedinherited

This will always be zero because the default values for optionally coupled variables is always constant.

Definition at line 916 of file Coupleable.h.

Referenced by Coupleable::Coupleable(), Coupleable::coupledSecond(), Coupleable::coupledSecondOld(), Coupleable::coupledSecondOlder(), Coupleable::coupledSecondPreviousNL(), and Coupleable::getADDefaultSecond().

◆ _default_value

std::unordered_map<std::string, std::vector<std::unique_ptr<VariableValue> > > Coupleable::_default_value
protectedinherited

Will hold the default value for optional coupled variables.

Definition at line 885 of file Coupleable.h.

Referenced by Coupleable::getDefaultValue().

◆ _default_value_zero

VariableValue Coupleable::_default_value_zero
protectedinherited

◆ _default_vector_curl

VectorVariableCurl Coupleable::_default_vector_curl
protectedinherited

This will always be zero because the default values for optionally coupled variables is always constant.

Definition at line 949 of file Coupleable.h.

Referenced by Coupleable::Coupleable(), Coupleable::coupledCurl(), Coupleable::coupledCurlOld(), and Coupleable::coupledCurlOlder().

◆ _default_vector_gradient

VectorVariableGradient Coupleable::_default_vector_gradient
protectedinherited

This will always be zero because the default values for optionally coupled variables is always constant.

Definition at line 946 of file Coupleable.h.

Referenced by Coupleable::Coupleable(), Coupleable::coupledVectorGradient(), Coupleable::coupledVectorGradientOld(), Coupleable::coupledVectorGradientOlder(), and Coupleable::getADDefaultVectorGradient().

◆ _default_vector_value

std::unordered_map<std::string, std::unique_ptr<VectorVariableValue> > Coupleable::_default_vector_value
protectedinherited

Will hold the default value for optional vector coupled variables.

Definition at line 891 of file Coupleable.h.

Referenced by Coupleable::getDefaultVectorValue().

◆ _default_vector_value_zero

VectorVariableValue Coupleable::_default_vector_value_zero
protectedinherited

This will always be zero because the default values for optionally coupled variables is always constant and this is used for time derivative info.

Definition at line 943 of file Coupleable.h.

Referenced by Coupleable::Coupleable(), Coupleable::coupledVectorDot(), Coupleable::coupledVectorDotDot(), Coupleable::coupledVectorDotDotOld(), and Coupleable::coupledVectorDotOld().

◆ _depend_uo

std::set<std::string> InitialConditionBase::_depend_uo
protectedinherited

◆ _depend_vars

std::set<std::string> InitialConditionBase::_depend_vars
protectedinherited

Dependent variables.

Definition at line 117 of file InitialConditionBase.h.

Referenced by InitialConditionBase::getRequestedItems(), and InitialConditionBase::InitialConditionBase().

◆ _dim

template<typename T >
unsigned int InitialConditionTempl< T >::_dim
protectedinherited

the mesh dimension

Definition at line 191 of file InitialConditionTempl.h.

◆ _dof_indices

template<typename T >
std::vector<dof_id_type> InitialConditionTempl< T >::_dof_indices
protectedinherited

The global DOF indices.

Definition at line 158 of file InitialConditionTempl.h.

◆ _dof_is_fixed

template<typename T >
std::vector<char> InitialConditionTempl< T >::_dof_is_fixed
protectedinherited

Whether the degree of freedom is fixed (true/false)

Definition at line 168 of file InitialConditionTempl.h.

◆ _dphi

template<typename T >
const std::vector<std::vector<GradientShapeType> >* InitialConditionTempl< T >::_dphi
protectedinherited

pointers to shape function gradients

Definition at line 182 of file InitialConditionTempl.h.

◆ _empty_block_ids

const std::set<SubdomainID> BoundaryRestrictable::_empty_block_ids
privateinherited

An empty set for referencing when block_ids is not included.

Definition at line 195 of file BoundaryRestrictable.h.

◆ _empty_boundary_ids

const std::set<BoundaryID> BlockRestrictable::_empty_boundary_ids
privateinherited

An empty set for referencing when boundary_ids is not included.

Definition at line 242 of file BlockRestrictable.h.

◆ _enabled

const bool& MooseObject::_enabled
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().

◆ _Fe

template<typename T >
DenseVector<DataType> InitialConditionTempl< T >::_Fe
protectedinherited

Linear b vector.

Definition at line 148 of file InitialConditionTempl.h.

◆ _fe_coupleable_matrix_tags

std::set<TagID> Coupleable::_fe_coupleable_matrix_tags
privateinherited

◆ _fe_coupleable_vector_tags

std::set<TagID> Coupleable::_fe_coupleable_vector_tags
privateinherited

◆ _fe_problem

template<typename T >
FEProblemBase& InitialConditionTempl< T >::_fe_problem
protectedinherited

Definition at line 120 of file InitialConditionTempl.h.

Referenced by RandomICBase::RandomICBase().

◆ _fe_type

template<typename T >
const FEType& InitialConditionTempl< T >::_fe_type
protectedinherited

The finite element type for the IC variable.

Definition at line 153 of file InitialConditionTempl.h.

◆ _fni_feproblem

FEProblemBase& FunctionInterface::_fni_feproblem
privateinherited

Reference to FEProblemBase instance.

Definition at line 70 of file FunctionInterface.h.

Referenced by FunctionInterface::getFunction(), and FunctionInterface::getFunctionByName().

◆ _fni_params

const InputParameters& FunctionInterface::_fni_params
privateinherited

Parameters of the object with this interface.

Definition at line 67 of file FunctionInterface.h.

Referenced by FunctionInterface::getFunction().

◆ _fni_tid

const THREAD_ID FunctionInterface::_fni_tid
privateinherited

Thread ID.

Definition at line 73 of file FunctionInterface.h.

Referenced by FunctionInterface::getFunction(), and FunctionInterface::getFunctionByName().

◆ _free_dof

template<typename T >
std::vector<int> InitialConditionTempl< T >::_free_dof
protectedinherited

Stores the ids of the free dofs.

Definition at line 170 of file InitialConditionTempl.h.

◆ _free_dofs

template<typename T >
dof_id_type InitialConditionTempl< T >::_free_dofs
protectedinherited

The number of free dofs.

Definition at line 173 of file InitialConditionTempl.h.

◆ _grad_zero

const VariableGradient& Coupleable::_grad_zero
protectedinherited

Zero gradient of a variable.

Definition at line 926 of file Coupleable.h.

Referenced by Coupleable::adZeroGradientTemplate().

◆ _ignore_uo_dependency

const bool InitialConditionBase::_ignore_uo_dependency
protectedinherited

If set, UOs retrieved by this IC will not be executed before this IC.

Definition at line 125 of file InitialConditionBase.h.

Referenced by InitialConditionBase::getUserObjectBase(), InitialConditionBase::getUserObjectByNameTempl(), and InitialConditionBase::getUserObjectTempl().

◆ _JxW

template<typename T >
const std::vector<Real>* InitialConditionTempl< T >::_JxW
protectedinherited

pointers to the Jacobian * quadrature weights for current element

Definition at line 184 of file InitialConditionTempl.h.

◆ _Ke

template<typename T >
DenseMatrix<Real> InitialConditionTempl< T >::_Ke
protectedinherited

Matrix storage member.

Definition at line 146 of file InitialConditionTempl.h.

◆ _mesh

std::shared_ptr<MooseMesh>& ElementIDInterface::_mesh
privateinherited

References to the mesh and displaced mesh (currently in the ActionWarehouse)

Definition at line 50 of file ElementIDInterface.h.

Referenced by ElementIDInterface::getElementIDIndex().

◆ _n

template<typename T >
unsigned int InitialConditionTempl< T >::_n
protectedinherited

node counter

Definition at line 189 of file InitialConditionTempl.h.

◆ _n_nodes

template<typename T >
unsigned int InitialConditionTempl< T >::_n_nodes
protectedinherited

The number of nodes for a given element.

Definition at line 165 of file InitialConditionTempl.h.

◆ _n_qp

template<typename T >
unsigned int InitialConditionTempl< T >::_n_qp
protectedinherited

The number of quadrature points for a given element.

Definition at line 163 of file InitialConditionTempl.h.

◆ _name

const std::string& MooseObject::_name
protectedinherited

◆ _nc

template<typename T >
dof_id_type InitialConditionTempl< T >::_nc
protectedinherited

number of dofs per node per variable

Definition at line 177 of file InitialConditionTempl.h.

◆ _obj

const MooseObject* Coupleable::_obj
privateinherited

◆ _obj_parameters

const InputParameters& ElementIDInterface::_obj_parameters
privateinherited

Reference to the object's input parameters.

Definition at line 47 of file ElementIDInterface.h.

Referenced by ElementIDInterface::getElementID(), and ElementIDInterface::getElementIDIndex().

◆ _optional_var_index

std::unordered_map<std::string, std::vector<unsigned int> > Coupleable::_optional_var_index
privateinherited

Unique indices for optionally coupled vars that weren't provided.

Definition at line 1119 of file Coupleable.h.

Referenced by Coupleable::Coupleable(), and Coupleable::coupled().

◆ _pars

const InputParameters& MooseObject::_pars
protectedinherited

◆ _phi

template<typename T >
const std::vector<std::vector<ValueType> >* InitialConditionTempl< T >::_phi
protectedinherited

pointers to shape functions

Definition at line 180 of file InitialConditionTempl.h.

◆ _qp

template<typename T >
unsigned int InitialConditionTempl< T >::_qp
protectedinherited

The current quadrature point, contains the "nth" node number when visiting nodes.

Definition at line 143 of file InitialConditionTempl.h.

◆ _restartable_app

MooseApp& Restartable::_restartable_app
privateinherited

Reference to the application.

Definition at line 208 of file Restartable.h.

Referenced by Restartable::registerRestartableDataOnApp(), and Restartable::registerRestartableNameWithFilterOnApp().

◆ _restartable_name

std::string Restartable::_restartable_name
privateinherited

◆ _restartable_system_name

std::string Restartable::_restartable_system_name
privateinherited

The system name this object is in.

Definition at line 214 of file Restartable.h.

Referenced by Restartable::declareRecoverableData(), and Restartable::declareRestartableDataWithContext().

◆ _restartable_tid

THREAD_ID Restartable::_restartable_tid
privateinherited

The thread ID for this object.

Definition at line 217 of file Restartable.h.

Referenced by Restartable::declareRestartableDataWithContext().

◆ _second_phi_zero

const VariablePhiSecond& Coupleable::_second_phi_zero
protectedinherited

Zero second derivative of a test function.

Definition at line 933 of file Coupleable.h.

◆ _second_zero

const VariableSecond& Coupleable::_second_zero
protectedinherited

Zero second derivative of a variable.

Definition at line 930 of file Coupleable.h.

Referenced by Coupleable::adZeroSecondTemplate().

◆ _side_dofs

template<typename T >
std::vector<unsigned int> InitialConditionTempl< T >::_side_dofs
protectedinherited

Side/edge DOF indices.

Definition at line 160 of file InitialConditionTempl.h.

◆ _supplied_vars

std::set<std::string> InitialConditionBase::_supplied_vars
protectedinherited

Supplied variables.

Definition at line 119 of file InitialConditionBase.h.

Referenced by InitialConditionBase::getSuppliedItems(), and InitialConditionBase::InitialConditionBase().

◆ _sys

SystemBase& InitialConditionBase::_sys
protectedinherited

The system object.

Definition at line 114 of file InitialConditionBase.h.

◆ _t

template<typename T >
Real& InitialConditionTempl< T >::_t
protectedinherited

◆ _tid

template<typename T >
THREAD_ID InitialConditionTempl< T >::_tid
protectedinherited

Definition at line 121 of file InitialConditionTempl.h.

◆ _type

const std::string& MooseObject::_type
protectedinherited

The type of this object (the Class name)

Definition at line 175 of file MooseObject.h.

Referenced by FEProblemBase::init(), and MooseObject::type().

◆ _Ue

template<typename T >
DenseVector<DataType> InitialConditionTempl< T >::_Ue
protectedinherited

Linear solution vector.

Definition at line 150 of file InitialConditionTempl.h.

◆ _uoi_feproblem

FEProblemBase& UserObjectInterface::_uoi_feproblem
privateinherited

◆ _uoi_params

const InputParameters& UserObjectInterface::_uoi_params
privateinherited

Parameters of the object with this interface.

Definition at line 71 of file UserObjectInterface.h.

Referenced by UserObjectInterface::getUserObjectBase(), and UserObjectInterface::getUserObjectTempl().

◆ _uoi_tid

THREAD_ID UserObjectInterface::_uoi_tid
privateinherited

◆ _var

template<typename T >
MooseVariableFE<T>& InitialConditionTempl< T >::_var
protectedinherited

◆ _vector_curl_zero

const VectorVariableCurl& Coupleable::_vector_curl_zero
protectedinherited

Zero value of the curl of a vector variable.

Definition at line 937 of file Coupleable.h.

◆ _vector_zero

const VectorVariableValue& Coupleable::_vector_zero
protectedinherited

Zero value of a vector variable.

Definition at line 935 of file Coupleable.h.

◆ _x_value

const Real VectorConstantIC::_x_value
protected

Definition at line 42 of file VectorConstantIC.h.

Referenced by value().

◆ _xyz_values

template<typename T >
const std::vector<Point>* InitialConditionTempl< T >::_xyz_values
protectedinherited

pointers to the xyz coordinates of the quadrature points for the current element

Definition at line 186 of file InitialConditionTempl.h.

◆ _y_value

const Real VectorConstantIC::_y_value
protected

Definition at line 43 of file VectorConstantIC.h.

Referenced by value().

◆ _z_value

const Real VectorConstantIC::_z_value
protected

Definition at line 44 of file VectorConstantIC.h.

Referenced by value().

◆ _zero

const VariableValue& Coupleable::_zero
protectedinherited

Zero value of a variable.

Definition at line 922 of file Coupleable.h.

Referenced by Coupleable::adZeroValueTemplate().


The documentation for this class was generated from the following files:
MooseVariableFE::slnPreviousNL
const FieldVariableValue & slnPreviousNL() const
Definition: MooseVariableFE.h:270
InputParameters::getParamHelper
static const T & getParamHelper(const std::string &name, const InputParameters &pars, const T *the_type)
Definition: InputParameters.h:1517
ElementIDInterface::getElementIDIndex
virtual unsigned int getElementIDIndex(const std::string &id_parameter_name, unsigned int comp=0) const
Gets index of an element integer with a parameter of the object derived from this interface.
Definition: ElementIDInterface.C:29
MooseVariableFE::dofValuesDotOld
const DoFValue & dofValuesDotOld()
Definition: MooseVariableFE.C:308
MooseVariableFE::insert
void insert(NumericVector< Number > &residual) override
Set the current local DOF values to the input vector.
Definition: MooseVariableFE.C:202
BlockRestrictable::_blk_mesh
MooseMesh * _blk_mesh
Pointer to Mesh.
Definition: BlockRestrictable.h:239
Coupleable::_zero
const VariableValue & _zero
Zero value of a variable.
Definition: Coupleable.h:922
MooseVariableFEBase
Definition: MooseVariableFEBase.h:27
BoundaryRestrictable::_bnd_dual_restrictable
const bool _bnd_dual_restrictable
Flag for allowing dual restriction with BlockRestrictable.
Definition: BoundaryRestrictable.h:192
MooseObjectWarehouseBase::getActiveBoundaryObjects
const std::map< BoundaryID, std::vector< std::shared_ptr< T > > > & getActiveBoundaryObjects(THREAD_ID tid=0) const
Definition: MooseObjectWarehouseBase.h:368
MooseVariableFE::slnOld
const FieldVariableValue & slnOld() const
Definition: MooseVariableFE.h:268
FEProblemBase::getMaterialWarehouse
const MaterialWarehouse & getMaterialWarehouse() const
Definition: FEProblemBase.h:1454
Coupleable::_coupled_standard_moose_vars
std::vector< MooseVariable * > _coupled_standard_moose_vars
Vector of standard coupled variables.
Definition: Coupleable.h:867
InitialConditionTempl::_dof_indices
std::vector< dof_id_type > _dof_indices
The global DOF indices.
Definition: InitialConditionTempl.h:158
SystemBase::mesh
virtual MooseMesh & mesh()
Definition: SystemBase.h:106
Coupleable::getArrayVar
ArrayMooseVariable * getArrayVar(const std::string &var_name, unsigned int comp)
Extract pointer to a coupled array variable.
Definition: Coupleable.C:258
DependencyResolver::insertDependency
void insertDependency(const T &key, const T &value)
Insert a dependency pair - the first value or the "key" depends on the second value or the "value".
Definition: DependencyResolver.h:223
MooseObject::mooseInfo
void mooseInfo(Args &&... args) const
Definition: MooseObject.h:162
type
MatType type
Definition: PetscDMMoose.C:1477
MooseVariableFE::duDotDotDu
const VariableValue & duDotDotDu() const
Definition: MooseVariableFE.h:355
THREAD_ID
unsigned int THREAD_ID
Definition: MooseTypes.h:196
UserObjectInterface::needThreadedCopy
bool needThreadedCopy(const UserObject &uo) const
Check if the threaded copy of the user object is needed.
Definition: UserObjectInterface.C:36
MooseVariableFE::curlSlnOldNeighbor
const FieldVariableCurl & curlSlnOldNeighbor() const
Definition: MooseVariableFE.h:414
Coupleable::_coupled_vector_moose_vars
std::vector< VectorMooseVariable * > _coupled_vector_moose_vars
Vector of vector coupled variables.
Definition: Coupleable.h:870
moose::internal::mooseStreamAll
void mooseStreamAll(std::ostringstream &ss)
All of the following are not meant to be called directly - they are called by the normal macros (moos...
Definition: MooseError.C:88
Coupleable::_c_parameters
const InputParameters & _c_parameters
Definition: Coupleable.h:852
ElementIDInterface::_obj_parameters
const InputParameters & _obj_parameters
Reference to the object's input parameters.
Definition: ElementIDInterface.h:47
InitialConditionTempl::dotHelper
Real dotHelper(const RealGradient &op1, const RealGradient &op2)
Helps perform multiplication of GradientTypes: a normal dot product for vectors and a contraction for...
Definition: InitialConditionTempl.h:99
MooseVariableFE::curlSlnNeighbor
const FieldVariableCurl & curlSlnNeighbor() const
neighbor solution curls
Definition: MooseVariableFE.h:410
MooseVariableFE::gradSlnPreviousNLNeighbor
const FieldVariableGradient & gradSlnPreviousNLNeighbor() const
Definition: MooseVariableFE.h:379
MooseObject::mooseError
void mooseError(Args &&... args) const
Definition: MooseObject.h:141
InitialConditionBase::_supplied_vars
std::set< std::string > _supplied_vars
Supplied variables.
Definition: InitialConditionBase.h:119
MooseVariableFE::secondSlnOldNeighbor
const FieldVariableSecond & secondSlnOldNeighbor() const
Definition: MooseVariableFE.h:396
MooseObject::isParamValid
bool isParamValid(const std::string &name) const
Test if the supplied parameter is valid.
Definition: MooseObject.h:100
VectorConstantIC::_y_value
const Real _y_value
Definition: VectorConstantIC.h:43
MooseObject::_type
const std::string & _type
The type of this object (the Class name)
Definition: MooseObject.h:175
InputParameters::defaultCoupledValue
Real defaultCoupledValue(const std::string &coupling_name, unsigned int i=0) const
Get the default value for an optionally coupled variable.
Definition: InputParameters.C:479
BoundaryRestrictable::_block_ids
const std::set< SubdomainID > & _block_ids
Reference to the block_ids, defaults to an empty set if not provided.
Definition: BoundaryRestrictable.h:198
UserObjectInterface::_uoi_tid
THREAD_ID _uoi_tid
Thread ID.
Definition: UserObjectInterface.h:77
Restartable::_restartable_name
std::string _restartable_name
The name of the object.
Definition: Restartable.h:211
FunctionInterface::_fni_params
const InputParameters & _fni_params
Parameters of the object with this interface.
Definition: FunctionInterface.h:67
FunctionInterface::_fni_feproblem
FEProblemBase & _fni_feproblem
Reference to FEProblemBase instance.
Definition: FunctionInterface.h:70
MooseVariableFE::curlSln
const FieldVariableCurl & curlSln() const
element curls
Definition: MooseVariableFE.h:301
Coupleable::validateExecutionerType
void validateExecutionerType(const std::string &name, const std::string &fn_name) const
Checks to make sure that the current Executioner has set "_is_transient" when old/older values are co...
Definition: Coupleable.C:1336
Coupleable::_coupled_vars
std::unordered_map< std::string, std::vector< MooseVariableFEBase * > > _coupled_vars
Coupled vars whose values we provide.
Definition: Coupleable.h:861
MooseVariableFE::secondSlnOld
const FieldVariableSecond & secondSlnOld() const
Definition: MooseVariableFE.h:290
MooseVariableFEBase::activeSubdomains
virtual const std::set< SubdomainID > & activeSubdomains() const =0
The subdomains the variable is active on.
MooseVariableFE::dofValuesOlderNeighbor
const DoFValue & dofValuesOlderNeighbor()
Definition: MooseVariableFE.C:280
InitialConditionTempl::setHermiteVertices
void setHermiteVertices()
set the temporary solution vector for node projections of Hermite variables
Definition: InitialConditionTempl.C:334
Coupleable::_default_vector_curl
VectorVariableCurl _default_vector_curl
This will always be zero because the default values for optionally coupled variables is always consta...
Definition: Coupleable.h:949
MooseMesh::getSubdomainIDs
std::vector< SubdomainID > getSubdomainIDs(const std::vector< SubdomainName > &subdomain_name) const
Get the associated subdomainIDs for the subdomain names that are passed in.
Definition: MooseMesh.C:1133
MooseVariableFE::gradSlnDot
const FieldVariableGradient & gradSlnDot() const
element gradient dots
Definition: MooseVariableFE.h:285
Coupleable::VarType::Dot
Coupleable::_c_is_implicit
bool _c_is_implicit
True if implicit value is required.
Definition: Coupleable.h:879
Coupleable::checkFuncType
void checkFuncType(const std::string var_name, VarType t, FuncAge age)
Definition: Coupleable.C:156
MooseVariableFE::sln
const FieldVariableValue & sln() const
element solutions
Definition: MooseVariableFE.h:267
MooseVariableFE::secondSlnOlderNeighbor
const FieldVariableSecond & secondSlnOlderNeighbor() const
Definition: MooseVariableFE.h:400
MooseVariableFE::nodalVectorTagValue
const DoFValue & nodalVectorTagValue(TagID tag)
Definition: MooseVariableFE.C:566
std::abs
MetaPhysicL::DualNumber< T, D > abs(const MetaPhysicL::DualNumber< T, D > &in)
MooseVariableFE::dofValuesOlder
const DoFValue & dofValuesOlder()
Definition: MooseVariableFE.C:252
BlockRestrictable::_blk_dual_restrictable
const bool _blk_dual_restrictable
Flag for allowing dual restriction.
Definition: BlockRestrictable.h:233
MooseVariableFE::nodalValuePreviousNLNeighbor
const OutputType & nodalValuePreviousNLNeighbor()
Definition: MooseVariableFE.C:615
MooseVariableFE::dofValuesDotNeighbor
const DoFValue & dofValuesDotNeighbor()
Definition: MooseVariableFE.C:322
Coupleable::_coupled_array_moose_vars
std::vector< ArrayMooseVariable * > _coupled_array_moose_vars
Vector of array coupled variables.
Definition: Coupleable.h:873
InitialConditionTempl::choleskySolve
void choleskySolve(bool is_volume)
Perform the cholesky solves for edge, side, and interior projections.
Definition: InitialConditionTempl.C:498
FEProblemBase::needsPreviousNewtonIteration
void needsPreviousNewtonIteration(bool state)
Set a flag that indicated that user required values for the previous Newton iterate.
Definition: FEProblemBase.C:6383
InitialConditionTempl::_Ke
DenseMatrix< Real > _Ke
Matrix storage member.
Definition: InitialConditionTempl.h:146
InputParameters::getMooseType
std::string getMooseType(const std::string &name) const
Utility functions for retrieving one of the MooseTypes variables into the common "string" base class.
Definition: InputParameters.C:529
MooseVariableFE::secondSlnNeighbor
const FieldVariableSecond & secondSlnNeighbor() const
neighbor solution seconds
Definition: MooseVariableFE.h:392
Restartable::registerRestartableDataOnApp
RestartableDataValue & registerRestartableDataOnApp(const std::string &name, std::unique_ptr< RestartableDataValue > data, THREAD_ID tid)
Helper function for actually registering the restartable data.
Definition: Restartable.C:48
BlockRestrictable::blockIDs
const virtual std::set< SubdomainID > & blockIDs() const
Return the block subdomain ids for this object.
Definition: BlockRestrictable.C:174
BoundaryRestrictable::ANY
Definition: BoundaryRestrictable.h:37
BoundaryRestrictable::_bnd_ids
std::set< BoundaryID > _bnd_ids
Set of the boundary ids.
Definition: BoundaryRestrictable.h:186
InitialConditionTempl::_free_dofs
dof_id_type _free_dofs
The number of free dofs.
Definition: InitialConditionTempl.h:173
Coupleable::getFEVar
MooseVariableFEBase * getFEVar(const std::string &var_name, unsigned int comp)
Extract pointer to a base finite element coupled variable.
Definition: Coupleable.C:204
MaterialWarehouse
MaterialBase objects are special in that they have additional objects created automatically (see FEPr...
Definition: MaterialWarehouse.h:26
BlockRestrictable::blockRestricted
virtual bool blockRestricted() const
Returns true if this object has been restricted to a boundary.
Definition: BlockRestrictable.C:162
Coupleable::FuncAge::Older
MooseVariableFE::uDotDot
const FieldVariableValue & uDotDot() const
Definition: MooseVariableFE.h:351
MooseVariableFE::secondSlnOlder
const FieldVariableSecond & secondSlnOlder() const
Definition: MooseVariableFE.h:291
InitialConditionTempl::_dphi
const std::vector< std::vector< GradientShapeType > > * _dphi
pointers to shape function gradients
Definition: InitialConditionTempl.h:182
BlockRestrictable::_blk_material_data
std::shared_ptr< MaterialData > _blk_material_data
Pointer to the MaterialData class for this object.
Definition: BlockRestrictable.h:205
Moose::ANY_BLOCK_ID
const SubdomainID ANY_BLOCK_ID
Definition: MooseTypes.C:17
MooseVariableFE::prepareIC
virtual void prepareIC() override
Prepare the initial condition.
Definition: MooseVariableFE.C:378
InputParameters::addParam
void addParam(const std::string &name, const S &value, const std::string &doc_string)
These methods add an option parameter and a documentation string to the InputParameters object.
Definition: InputParameters.h:1198
MooseVariableFE::gradSlnNeighbor
const FieldVariableGradient & gradSlnNeighbor() const
neighbor solution gradients
Definition: MooseVariableFE.h:367
MooseObject::parameters
const InputParameters & parameters() const
Get the parameters of the object.
Definition: MooseObject.h:76
MooseVariableFE::uDot
const FieldVariableValue & uDot() const
element dots
Definition: MooseVariableFE.h:350
BoundaryRestrictable::restricted
static bool restricted(const std::set< BoundaryID > &ids)
Helper for determining if the object is boundary restricted.
Definition: BoundaryRestrictable.C:194
MooseObjectWarehouseBase::hasActiveBoundaryObjects
bool hasActiveBoundaryObjects(THREAD_ID tid=0) const
Definition: MooseObjectWarehouseBase.h:442
InitialConditionTempl::DataType
OutputTools< T >::OutputData DataType
Definition: InitialConditionTempl.h:45
Coupleable::_c_nodal
bool _c_nodal
True if we provide coupling to nodal values.
Definition: Coupleable.h:876
FEProblemBase::getUserObjectTempl
T & getUserObjectTempl(const std::string &name, unsigned int tid=0) const
Get the user object by its name.
Definition: FEProblemBase.h:755
BoundaryRestrictable::_bnd_nodal
bool _bnd_nodal
Whether or not this object is restricted to nodesets.
Definition: BoundaryRestrictable.h:207
MooseVariableFE::dofIndices
const std::vector< dof_id_type > & dofIndices() const final
Get local DoF indices.
Definition: MooseVariableFE.h:187
MooseObject::_enabled
const bool & _enabled
Reference to the "enable" InputParaemters, used by Controls for toggling on/off MooseObjects.
Definition: MooseObject.h:181
InitialConditionTempl::_cont
FEContinuity _cont
The type of continuity, e.g. C0, C1.
Definition: InitialConditionTempl.h:155
BlockRestrictable::_blk_feproblem
FEProblemBase * _blk_feproblem
Pointer to FEProblemBase.
Definition: BlockRestrictable.h:236
RestartableData::set
T & set()
Definition: RestartableData.h:97
moose::internal::mooseInfoStream
void mooseInfoStream(S &oss, Args &&... args)
Definition: MooseError.h:165
libMesh::RealVectorValue
VectorValue< Real > RealVectorValue
Definition: Assembly.h:30
InitialConditionTempl::value
virtual T value(const Point &p)=0
The value of the variable at a point.
MooseVariableFE::secondSlnPreviousNLNeighbor
const FieldVariableSecond & secondSlnPreviousNLNeighbor() const
Definition: MooseVariableFE.h:404
MooseVariableFE::computeNodalValues
virtual void computeNodalValues() override
Compute nodal values of this variable.
Definition: MooseVariableFE.C:650
MooseMesh::meshSidesetIds
const std::set< BoundaryID > & meshSidesetIds() const
Returns a read-only reference to the set of sidesets currently present in the Mesh.
Definition: MooseMesh.C:2350
Coupleable::_c_coupled_scalar_vars
std::unordered_map< std::string, std::vector< MooseVariableScalar * > > _c_coupled_scalar_vars
Scalar variables coupled into this object (for error checking)
Definition: Coupleable.h:1122
InitialConditionTempl::gradientComponent
T gradientComponent(GradientType grad, unsigned int i)
Definition: InitialConditionTempl.C:313
Coupleable::getVar
MooseVariable * getVar(const std::string &var_name, unsigned int comp)
Extract pointer to a coupled variable.
Definition: Coupleable.C:240
Coupleable::_fe_coupleable_vector_tags
std::set< TagID > _fe_coupleable_vector_tags
Definition: Coupleable.h:1124
Moose::Old
Definition: MooseVariableData.h:50
MooseVariableFE::dofValuesOld
const DoFValue & dofValuesOld()
Definition: MooseVariableFE.C:245
Coupleable::_ad_default_vector_value
std::unordered_map< std::string, std::unique_ptr< MooseArray< DualRealVectorValue > > > _ad_default_vector_value
Will hold the default value for optional vector coupled variables for automatic differentiation.
Definition: Coupleable.h:898
ArrayVariableValue
OutputTools< RealEigenVector >::VariableValue ArrayVariableValue
Definition: MooseTypes.h:328
MooseVariableFE::duDotDotDuNeighbor
const VariableValue & duDotDotDuNeighbor() const
Definition: MooseVariableFE.h:429
Coupleable::FuncAge::Old
MooseVariableFE::nodalValueDot
const OutputType & nodalValueDot()
Definition: MooseVariableFE.C:622
Moose::Older
Definition: MooseVariableData.h:51
BoundaryRestrictable::hasBoundaryMaterialPropertyHelper
bool hasBoundaryMaterialPropertyHelper(const std::string &prop_name) const
A helper method to avoid circular #include problems.
Definition: BoundaryRestrictable.C:291
InitialConditionTempl::_n
unsigned int _n
node counter
Definition: InitialConditionTempl.h:189
MooseVariableFE::gradSlnPreviousNL
const FieldVariableGradient & gradSlnPreviousNL() const
Definition: MooseVariableFE.h:279
Moose::stringify
std::string stringify(const T &t)
conversion to string
Definition: Conversion.h:61
MooseVariableFE::nodalValueNeighbor
const OutputType & nodalValueNeighbor()
Definition: MooseVariableFE.C:559
MooseObject::paramError
void paramError(const std::string &param, Args... args) const
Emits an error prefixed with the file and line number of the given param (from the input file) along ...
Definition: MooseObject.h:215
ConsoleStreamInterface::_console
const ConsoleStream _console
An instance of helper class to write streams to the Console objects.
Definition: ConsoleStreamInterface.h:31
InitialConditionTempl::_free_dof
std::vector< int > _free_dof
Stores the ids of the free dofs.
Definition: InitialConditionTempl.h:170
mooseError
void mooseError(Args &&... args)
Emit an error message with the given stringified, concatenated args and terminate the application.
Definition: MooseError.h:210
BoundaryRestrictable::boundaryIDs
const virtual std::set< BoundaryID > & boundaryIDs() const
Return the boundary IDs for this object.
Definition: BoundaryRestrictable.C:170
Coupleable::_grad_zero
const VariableGradient & _grad_zero
Zero gradient of a variable.
Definition: Coupleable.h:926
InitialConditionBase::_sys
SystemBase & _sys
The system object.
Definition: InitialConditionBase.h:114
InputParameters
The main MOOSE class responsible for handling user-defined parameters in almost every MOOSE system.
Definition: InputParameters.h:53
FEProblemBase::getUserObjectBase
const UserObject & getUserObjectBase(const std::string &name) const
Get the user object by its name.
Definition: FEProblemBase.C:3198
InitialConditionTempl::choleskyAssembly
void choleskyAssembly(bool is_volume)
Assemble a small local system for cholesky solve.
Definition: InitialConditionTempl.C:449
VectorConstantIC::_z_value
const Real _z_value
Definition: VectorConstantIC.h:44
MooseVariableFE::adUDotNeighbor
const VariableValueType< OutputType, compute_stage >::type & adUDotNeighbor() const
Definition: MooseVariableFE.h:344
ElementIDInterface::_mesh
std::shared_ptr< MooseMesh > & _mesh
References to the mesh and displaced mesh (currently in the ActionWarehouse)
Definition: ElementIDInterface.h:50
Coupleable::VarType::GradientDot
MooseVariableFE::gradSlnNeighborDotDot
const FieldVariableGradient & gradSlnNeighborDotDot() const
Definition: MooseVariableFE.h:386
Coupleable::getDefaultVectorValue
VectorVariableValue * getDefaultVectorValue(const std::string &var_name)
Helper method to return (and insert if necessary) the default value for an uncoupled vector variable.
Definition: Coupleable.C:284
Coupleable::_ad_default_vector_gradient
MooseArray< DualRealTensorValue > _ad_default_vector_gradient
This will always be zero because the default values for optionally coupled vector variables is always...
Definition: Coupleable.h:913
SystemBase::solution
virtual NumericVector< Number > & solution()=0
BlockRestrictable::_blk_tid
THREAD_ID _blk_tid
Thread id for this object.
Definition: BlockRestrictable.h:248
MooseVariableFE::adSecondSlnNeighbor
const VariableSecondType< OutputType, compute_stage >::type & adSecondSlnNeighbor() const
Definition: MooseVariableFE.h:339
MooseVariableFE::gradSlnOlderNeighbor
const FieldVariableGradient & gradSlnOlderNeighbor() const
Definition: MooseVariableFE.h:375
MooseVariableFE::dofValues
const DoFValue & dofValues()
Definition: MooseVariableFE.C:238
Moose::ANY_BOUNDARY_ID
const BoundaryID ANY_BOUNDARY_ID
Definition: MooseTypes.C:19
Moose::VAR_ANY
Definition: MooseTypes.h:610
moose::internal::mooseDeprecatedStream
void mooseDeprecatedStream(S &oss, bool expired, Args &&... args)
Definition: MooseError.h:177
Coupleable::_coupleable_neighbor
bool _coupleable_neighbor
Whether or not this object is a "neighbor" object: ie all of it's coupled values should be neighbor v...
Definition: Coupleable.h:1036
mooseWarning
void mooseWarning(Args &&... args)
Emit a warning message with the given stringified, concatenated args.
Definition: MooseError.h:222
x
static PetscErrorCode Vec x
Definition: PetscDMMoose.C:1263
InputParameters::hasCoupledValue
bool hasCoupledValue(const std::string &coupling_name) const
Return whether or not the coupled variable exists.
Definition: InputParameters.C:458
MooseVariableFE::gradSln
const FieldVariableGradient & gradSln() const
element gradients
Definition: MooseVariableFE.h:273
BoundaryRestrictable::_bnd_feproblem
FEProblemBase * _bnd_feproblem
Pointer to FEProblemBase.
Definition: BoundaryRestrictable.h:180
MooseVariableFE::gradSlnOldNeighbor
const FieldVariableGradient & gradSlnOldNeighbor() const
Definition: MooseVariableFE.h:371
Coupleable::_default_vector_value
std::unordered_map< std::string, std::unique_ptr< VectorVariableValue > > _default_vector_value
Will hold the default value for optional vector coupled variables.
Definition: Coupleable.h:891
FEProblemBase::getMaterialData
std::shared_ptr< MaterialData > getMaterialData(Moose::MaterialDataType type, THREAD_ID tid=0)
Definition: FEProblemBase.C:2729
SubProblem
Generic class for solving transient nonlinear problems.
Definition: SubProblem.h:62
MooseVariableFE::dofValuesDotDot
const DoFValue & dofValuesDotDot()
Definition: MooseVariableFE.C:301
InitialConditionBase::_depend_uo
std::set< std::string > _depend_uo
Depend UserObjects.
Definition: InitialConditionBase.h:122
FEProblemBase::isTransient
virtual bool isTransient() const override
Definition: FEProblemBase.h:447
MooseVariableFE::setDofValue
void setDofValue(const OutputData &value, unsigned int index)
Definition: MooseVariableFE.C:664
MooseVariableBase::count
unsigned int count() const
Get the number of components Note: For standard and vector variables, the number is one.
Definition: MooseVariableBase.h:98
paramErrorPrefix
std::string paramErrorPrefix(const InputParameters &params, const std::string &param)
Generates a canonical paramError prefix for param-related error/warning/info messages.
Definition: MooseObject.C:24
MooseVariableFE::dofValuesPreviousNL
const DoFValue & dofValuesPreviousNL()
Definition: MooseVariableFE.C:259
FEProblemBase::getCoordSystem
virtual Moose::CoordinateSystemType getCoordSystem(SubdomainID sid) override
Definition: FEProblemBase.C:491
Coupleable::_fe_coupleable_matrix_tags
std::set< TagID > _fe_coupleable_matrix_tags
Definition: Coupleable.h:1126
MooseVariableFE::vectorTagValue
const FieldVariableValue & vectorTagValue(TagID tag)
Definition: MooseVariableFE.h:257
BoundaryRestrictable::isBoundarySubset
bool isBoundarySubset(const std::set< BoundaryID > &ids) const
Test if the class boundary ids are a subset of the supplied objects.
Definition: BoundaryRestrictable.C:262
InputParameters::numberDefaultCoupledValues
unsigned int numberDefaultCoupledValues(const std::string &coupling_name) const
Get the number of defaulted coupled value entries.
Definition: InputParameters.C:496
Coupleable::addFEVariableCoupleableVectorTag
void addFEVariableCoupleableVectorTag(TagID tag)
Definition: Coupleable.h:117
Coupleable::_ad_grad_zero
const MooseArray< DualRealVectorValue > & _ad_grad_zero
Definition: Coupleable.h:927
BoundaryRestrictable::meshBoundaryIDs
const std::set< BoundaryID > & meshBoundaryIDs() const
Returns the set of all boundary ids for the entire mesh.
Definition: BoundaryRestrictable.C:285
InitialConditionTempl::setCZeroVertices
void setCZeroVertices()
set the temporary solution vector for node projections of C0 variables
Definition: InitialConditionTempl.C:284
MooseVariableFE::reinitNode
void reinitNode() override
Definition: MooseVariableFE.C:117
Coupleable::_coupled_moose_vars
std::vector< MooseVariableFEBase * > _coupled_moose_vars
Vector of all coupled variables.
Definition: Coupleable.h:864
InitialConditionTempl::_side_dofs
std::vector< unsigned int > _side_dofs
Side/edge DOF indices.
Definition: InitialConditionTempl.h:160
Coupleable::_default_second
VariableSecond _default_second
This will always be zero because the default values for optionally coupled variables is always consta...
Definition: Coupleable.h:916
Coupleable::_second_zero
const VariableSecond & _second_zero
Zero second derivative of a variable.
Definition: Coupleable.h:930
MooseVariableFE::dofValuesDuDotDu
const MooseArray< Number > & dofValuesDuDotDu()
Definition: MooseVariableFE.C:350
BlockRestrictable::isBlockSubset
bool isBlockSubset(const std::set< SubdomainID > &ids) const
Test if the class block ids are a subset of the supplied objects.
Definition: BlockRestrictable.C:227
MooseVariableFE::adSln
const VariableValueType< OutputType, compute_stage >::type & adSln() const
AD.
Definition: MooseVariableFE.h:307
Coupleable::_coupleable_max_qps
unsigned int _coupleable_max_qps
Maximum qps for any element in this system.
Definition: Coupleable.h:1116
MooseVariableFE::gradSlnOlder
const FieldVariableGradient & gradSlnOlder() const
Definition: MooseVariableFE.h:275
Coupleable::_c_fe_problem
FEProblemBase & _c_fe_problem
Definition: Coupleable.h:858
MooseVariableFE::secondSlnPreviousNL
const FieldVariableSecond & secondSlnPreviousNL() const
Definition: MooseVariableFE.h:295
Coupleable::_ad_zero
const MooseArray< DualReal > & _ad_zero
Definition: Coupleable.h:923
MooseVariableFE::setNodalValue
void setNodalValue(const OutputType &value, unsigned int idx=0)
Set nodal value.
Definition: MooseVariableFE.C:678
MooseMesh::getNodeBlockIds
const std::set< SubdomainID > & getNodeBlockIds(const Node &node) const
Return list of blocks to which the given node belongs.
Definition: MooseMesh.C:879
InputParameters::isParamValid
bool isParamValid(const std::string &name) const
This method returns parameters that have been initialized in one fashion or another,...
Definition: InputParameters.C:257
MooseVariableFE::dofValuesDot
const DoFValue & dofValuesDot()
Definition: MooseVariableFE.C:294
MooseVariableFE::adSlnNeighbor
const VariableValueType< OutputType, compute_stage >::type & adSlnNeighbor() const
neighbor AD
Definition: MooseVariableFE.h:329
MooseVariableFE::dofValuesNeighbor
const DoFValue & dofValuesNeighbor()
Definition: MooseVariableFE.C:266
MooseVariableFE::gradSlnDotDot
const FieldVariableGradient & gradSlnDotDot() const
Definition: MooseVariableFE.h:286
MooseVariableFE::nodalValuePreviousNL
const OutputType & nodalValuePreviousNL()
Definition: MooseVariableFE.C:608
Coupleable::coupledCallback
virtual void coupledCallback(const std::string &, bool)
A call-back function provided by the derived object for actions before coupling a variable with funct...
Definition: Coupleable.h:130
InputParameters::addClassDescription
void addClassDescription(const std::string &doc_string)
This method adds a description of the class that will be displayed in the input file syntax dump.
Definition: InputParameters.C:70
UserObjectInterface::getUserObjectBase
const UserObject & getUserObjectBase(const std::string &name)
Get an user object with a given parameter name.
Definition: UserObjectInterface.C:24
InitialConditionTempl::_dim
unsigned int _dim
the mesh dimension
Definition: InitialConditionTempl.h:191
MooseVariableFE::uDotOld
const FieldVariableValue & uDotOld() const
Definition: MooseVariableFE.h:352
MooseVariableFE::curlSlnOld
const FieldVariableCurl & curlSlnOld() const
Definition: MooseVariableFE.h:302
MooseVariableFE::uDotDotOldNeighbor
const FieldVariableValue & uDotDotOldNeighbor() const
Definition: MooseVariableFE.h:427
MooseVariableFE::curlSlnOlderNeighbor
const FieldVariableCurl & curlSlnOlderNeighbor() const
Definition: MooseVariableFE.h:418
MooseObject::getParamTempl
const T & getParamTempl(const std::string &name) const
Retrieve a parameter for the object.
Definition: MooseObject.h:208
Coupleable::coupledValue
virtual const VariableValue & coupledValue(const std::string &var_name, unsigned int comp=0)
Returns value of a coupled variable.
Definition: Coupleable.C:387
MooseApp::registerRestartableData
RestartableDataValue & registerRestartableData(const std::string &name, std::unique_ptr< RestartableDataValue > data, THREAD_ID tid, bool mesh_meta_data, bool read_only)
Definition: MooseApp.C:1156
MooseVariableFE::dofValuesDotDotOldNeighbor
const DoFValue & dofValuesDotDotOldNeighbor()
Definition: MooseVariableFE.C:343
InitialConditionTempl::_var
MooseVariableFE< T > & _var
The variable that this initial condition is acting upon.
Definition: InitialConditionTempl.h:132
Coupleable::getDefaultValue
VariableValue * getDefaultValue(const std::string &var_name, unsigned int comp)
Helper method to return (and insert if necessary) the default value for an uncoupled variable.
Definition: Coupleable.C:264
InitialConditionTempl::_JxW
const std::vector< Real > * _JxW
pointers to the Jacobian * quadrature weights for current element
Definition: InitialConditionTempl.h:184
InitialConditionTempl::validParams
static InputParameters validParams()
Definition: InitialConditionTempl.C:41
Coupleable::_default_value_zero
VariableValue _default_value_zero
This will always be zero because the default values for optionally coupled variables is always consta...
Definition: Coupleable.h:904
callMooseErrorRaw
void callMooseErrorRaw(std::string &msg, MooseApp *app)
Definition: MooseObject.C:70
MooseObjectWarehouseBase::getActiveBlockObjects
const std::map< SubdomainID, std::vector< std::shared_ptr< T > > > & getActiveBlockObjects(THREAD_ID tid=0) const
Definition: MooseObjectWarehouseBase.h:387
Coupleable::addFEVariableCoupleableMatrixTag
void addFEVariableCoupleableMatrixTag(TagID tag)
Definition: Coupleable.h:119
Coupleable::_default_gradient
VariableGradient _default_gradient
This will always be zero because the default values for optionally coupled variables is always consta...
Definition: Coupleable.h:907
Coupleable::_default_vector_gradient
VectorVariableGradient _default_vector_gradient
This will always be zero because the default values for optionally coupled variables is always consta...
Definition: Coupleable.h:946
MooseVariableFE::adGradSlnNeighbor
const VariableGradientType< OutputType, compute_stage >::type & adGradSlnNeighbor() const
Definition: MooseVariableFE.h:334
MooseMesh::meshBoundaryIds
const std::set< BoundaryID > & meshBoundaryIds() const
Returns a read-only reference to the set of boundary IDs currently present in the Mesh.
Definition: MooseMesh.C:2344
BlockRestrictable::_blocks
std::vector< SubdomainName > _blocks
Vector the block names supplied by the user via the input file.
Definition: BlockRestrictable.h:230
InitialConditionBase::_depend_vars
std::set< std::string > _depend_vars
Dependent variables.
Definition: InitialConditionBase.h:117
InitialConditionTempl::_qp
unsigned int _qp
The current quadrature point, contains the "nth" node number when visiting nodes.
Definition: InitialConditionTempl.h:143
MooseVariableFE::nodalValueOlder
const OutputType & nodalValueOlder()
Definition: MooseVariableFE.C:594
MooseVariableFE::gradSlnNeighborDot
const FieldVariableGradient & gradSlnNeighborDot() const
neighbor grad dots
Definition: MooseVariableFE.h:385
Coupleable::_ad_default_gradient
MooseArray< DualRealVectorValue > _ad_default_gradient
This will always be zero because the default values for optionally coupled variables is always consta...
Definition: Coupleable.h:910
InitialConditionTempl::gradient
virtual GradientType gradient(const Point &)
The gradient of the variable at a point.
Definition: InitialConditionTempl.h:78
InitialConditionTempl::_phi
const std::vector< std::vector< ValueType > > * _phi
pointers to shape functions
Definition: InitialConditionTempl.h:180
MooseMesh::meshSubdomains
const std::set< SubdomainID > & meshSubdomains() const
Returns a read-only reference to the set of subdomains currently present in the Mesh.
Definition: MooseMesh.C:2338
MooseObjectWarehouseBase::hasActiveBlockObjects
bool hasActiveBlockObjects(THREAD_ID tid=0) const
Definition: MooseObjectWarehouseBase.h:422
UserObjectInterface::_uoi_feproblem
FEProblemBase & _uoi_feproblem
Reference to the FEProblemBase instance.
Definition: UserObjectInterface.h:74
Moose::VAR_NONLINEAR
Definition: MooseTypes.h:608
MooseVariableFE::dofValuesDuDotDuNeighbor
const MooseArray< Number > & dofValuesDuDotDuNeighbor()
Definition: MooseVariableFE.C:364
Coupleable::isCoupled
virtual bool isCoupled(const std::string &var_name, unsigned int i=0)
Returns true if a variables has been coupled as name.
Definition: Coupleable.C:107
Coupleable::VarType::Ignore
InitialConditionTempl::_dof_is_fixed
std::vector< char > _dof_is_fixed
Whether the degree of freedom is fixed (true/false)
Definition: InitialConditionTempl.h:168
Moose::VAR_AUXILIARY
Definition: MooseTypes.h:609
VectorConstantIC::_x_value
const Real _x_value
Definition: VectorConstantIC.h:42
MooseUtils::replaceAll
std::string replaceAll(std::string str, const std::string &from, const std::string &to)
Replaces all occurences of from in str with to and returns the result.
Definition: MooseUtils.C:45
BoundaryRestrictable::_bnd_material_data
std::shared_ptr< MaterialData > _bnd_material_data
Pointer to MaterialData for boundary (.
Definition: BoundaryRestrictable.h:204
Coupleable::_default_value
std::unordered_map< std::string, std::vector< std::unique_ptr< VariableValue > > > _default_value
Will hold the default value for optional coupled variables.
Definition: Coupleable.h:885
MooseVariableFE::slnOlderNeighbor
const FieldVariableValue & slnOlderNeighbor() const
Definition: MooseVariableFE.h:360
Coupleable::_default_vector_value_zero
VectorVariableValue _default_vector_value_zero
This will always be zero because the default values for optionally coupled variables is always consta...
Definition: Coupleable.h:943
MooseVariableFE::duDotDu
const VariableValue & duDotDu() const
Definition: MooseVariableFE.h:354
MooseVariableFE::slnOldNeighbor
const FieldVariableValue & slnOldNeighbor() const
Definition: MooseVariableFE.h:359
VectorInitialCondition
InitialConditionTempl< RealVectorValue > VectorInitialCondition
Definition: InitialConditionTempl.h:195
InitialConditionTempl::_nc
dof_id_type _nc
number of dofs per node per variable
Definition: InitialConditionTempl.h:177
MooseVariableFE::isNodal
bool isNodal() const override
Is this variable nodal.
Definition: MooseVariableFE.h:160
MooseMesh::meshNodesetIds
const std::set< BoundaryID > & meshNodesetIds() const
Returns a read-only reference to the set of nodesets currently present in the Mesh.
Definition: MooseMesh.C:2356
BoundaryRestrictable::_boundary_names
std::vector< BoundaryName > _boundary_names
Vector the the boundary names.
Definition: BoundaryRestrictable.h:189
MooseVariableFE::nodalValue
const OutputType & nodalValue()
Methods for retrieving values of variables at the nodes.
Definition: MooseVariableFE.C:552
MooseVariableFE::gradSlnOld
const FieldVariableGradient & gradSlnOld() const
Definition: MooseVariableFE.h:274
Coupleable::FuncAge::Curr
MooseVariableFE::slnNeighbor
const FieldVariableValue & slnNeighbor() const
neighbor solutions
Definition: MooseVariableFE.h:358
Coupleable::_ad_default_value
std::unordered_map< std::string, std::unique_ptr< MooseArray< DualReal > > > _ad_default_value
Will hold the default value for optional coupled variables for automatic differentiation.
Definition: Coupleable.h:888
MooseVariableBase::sys
SystemBase & sys()
Get the system this variable is part of.
Definition: MooseVariableBase.h:58
FEProblemBase::getFunction
virtual Function & getFunction(const std::string &name, THREAD_ID tid=0)
Definition: FEProblemBase.C:1878
InputParameters::getCheckedPointerParam
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.
Definition: InputParameters.h:1162
Coupleable::checkVar
bool checkVar(const std::string &var_name, unsigned int comp=0, unsigned int comp_bound=0)
Check that the right kind of variable is being coupled in.
Definition: Coupleable.C:174
Coupleable::_default_array_value
std::map< std::string, ArrayVariableValue * > _default_array_value
Will hold the default value for optional array coupled variables.
Definition: Coupleable.h:894
MooseVariableFE::adSecondSln
const VariableSecondType< OutputType, compute_stage >::type & adSecondSln() const
Definition: MooseVariableFE.h:317
MooseVariableFE::nodalValueOldNeighbor
const OutputType & nodalValueOldNeighbor()
Definition: MooseVariableFE.C:587
CyclicDependencyException::getCyclicDependencies
const std::multimap< T, T > & getCyclicDependencies() const
Definition: DependencyResolver.h:183
Moose::ValueType::type
RealType< compute_stage >::type type
Definition: MooseTypes.h:225
MooseVariableFE::nodalMatrixTagValue
const DoFValue & nodalMatrixTagValue(TagID tag)
Definition: MooseVariableFE.C:573
BlockRestrictable::hasBlocks
bool hasBlocks(const SubdomainName &name) const
Test if the supplied block name is valid for this object.
Definition: BlockRestrictable.C:186
BlockRestrictable::_blk_ids
std::set< SubdomainID > _blk_ids
Set of block ids supplied by the user via the input file (for error reporting)
Definition: BlockRestrictable.h:227
InitialConditionTempl::GradientType
OutputTools< T >::OutputGradient GradientType
Definition: InitialConditionTempl.h:43
Coupleable::_ad_second_zero
const MooseArray< DualRealTensorValue > & _ad_second_zero
Definition: Coupleable.h:931
Coupleable::_optional_var_index
std::unordered_map< std::string, std::vector< unsigned int > > _optional_var_index
Unique indices for optionally coupled vars that weren't provided.
Definition: Coupleable.h:1119
Restartable::_restartable_app
MooseApp & _restartable_app
Reference to the application.
Definition: Restartable.h:208
Restartable::_restartable_tid
THREAD_ID _restartable_tid
The thread ID for this object.
Definition: Restartable.h:217
checkComponent
void checkComponent(const MooseObject *obj, unsigned int comp, unsigned int bound, const std::string &var_name)
Definition: Coupleable.C:142
Coupleable::VarType::Gradient
UserObjectInterface::getUserObjectBaseByName
const UserObject & getUserObjectBaseByName(const std::string &name)
Get an user object with a given name.
Definition: UserObjectInterface.C:30
MooseVariableFE::curlSlnOlder
const FieldVariableCurl & curlSlnOlder() const
Definition: MooseVariableFE.h:303
InitialConditionTempl::_xyz_values
const std::vector< Point > * _xyz_values
pointers to the xyz coordinates of the quadrature points for the current element
Definition: InitialConditionTempl.h:186
Moose::show_trace
bool show_trace
Set to true (the default) to print the stack trace with error and warning messages - false to omit it...
Definition: Moose.C:572
Moose::RESTARTABLE_FILTER::RECOVERABLE
MooseVariableFE::matrixTagValue
const FieldVariableValue & matrixTagValue(TagID tag)
Definition: MooseVariableFE.h:261
FunctionInterface::_fni_tid
const THREAD_ID _fni_tid
Thread ID.
Definition: FunctionInterface.h:73
InitialConditionTempl::_current_dof
dof_id_type _current_dof
The current dof being operated on.
Definition: InitialConditionTempl.h:175
DependencyResolver
Definition: DependencyResolver.h:55
BoundaryRestrictable::hasBoundary
bool hasBoundary(const BoundaryName &name) const
Test if the supplied boundary name is valid for this object.
Definition: BoundaryRestrictable.C:200
BoundaryRestrictable::ALL
Definition: BoundaryRestrictable.h:36
BlockRestrictable::_blk_name
const std::string & _blk_name
Name of the object.
Definition: BlockRestrictable.h:251
InitialConditionTempl::_current_node
const Node * _current_node
The current node if the point we are evaluating at also happens to be a node.
Definition: InitialConditionTempl.h:140
MooseApp::registerRestartableNameWithFilter
void registerRestartableNameWithFilter(const std::string &name, Moose::RESTARTABLE_FILTER filter)
NOTE: This is an internal function meant for MOOSE use only!
Definition: MooseApp.C:972
Coupleable::_ad_default_second
MooseArray< DualRealTensorValue > _ad_default_second
This will always be zero because the default values for optionally coupled variables is always consta...
Definition: Coupleable.h:919
Coupleable::_c_name
const std::string & _c_name
The name of the object this interface is part of.
Definition: Coupleable.h:855
Moose::VAR_FIELD_ANY
Definition: MooseTypes.h:619
Coupleable::_default_array_gradient
ArrayVariableGradient _default_array_gradient
This will always be zero because the default values for optionally coupled variables is always consta...
Definition: Coupleable.h:958
BlockRestrictable::meshBlockIDs
const std::set< SubdomainID > & meshBlockIDs() const
Return all of the SubdomainIDs for the mesh.
Definition: BlockRestrictable.C:250
InitialConditionBase::_ignore_uo_dependency
const bool _ignore_uo_dependency
If set, UOs retrieved by this IC will not be executed before this IC.
Definition: InitialConditionBase.h:125
MooseObject::_name
const std::string & _name
The name of this object, reference to value stored in InputParameters.
Definition: MooseObject.h:178
MooseObject::_pars
const InputParameters & _pars
Parameters of this object, references the InputParameters stored in the InputParametersWarehouse.
Definition: MooseObject.h:169
MooseVariableFE::dofValuesDuDotDotDu
const MooseArray< Number > & dofValuesDuDotDotDu()
Definition: MooseVariableFE.C:357
MooseVariableFE::nodalValueOlderNeighbor
const OutputType & nodalValueOlderNeighbor()
Definition: MooseVariableFE.C:601
MooseVariableFE::dofValuesDotOldNeighbor
const DoFValue & dofValuesDotOldNeighbor()
Definition: MooseVariableFE.C:336
moose::internal::mooseWarningStream
void mooseWarningStream(S &oss, Args &&... args)
Definition: MooseError.h:136
MooseVariableFE::adUDot
const VariableValueType< OutputType, compute_stage >::type & adUDot() const
Definition: MooseVariableFE.h:322
MooseVariableFE::dofValuesDuDotDotDuNeighbor
const MooseArray< Number > & dofValuesDuDotDotDuNeighbor()
Definition: MooseVariableFE.C:371
InitialConditionTempl::_fe_type
const FEType & _fe_type
The finite element type for the IC variable.
Definition: InitialConditionTempl.h:153
InputParameters::hasDefaultCoupledValue
bool hasDefaultCoupledValue(const std::string &coupling_name) const
Return whether or not the requested parameter has a default coupled value.
Definition: InputParameters.C:464
MooseVariableFE::dofValuesDotDotOld
const DoFValue & dofValuesDotDotOld()
Definition: MooseVariableFE.C:315
MooseVariableFE::slnPreviousNLNeighbor
const FieldVariableValue & slnPreviousNLNeighbor() const
Definition: MooseVariableFE.h:361
libMesh::RealEigenVector
Eigen::Matrix< Real, Eigen::Dynamic, 1 > RealEigenVector
Definition: MooseTypes.h:133
MooseVariableFE::dofValuesDotDotNeighbor
const DoFValue & dofValuesDotDotNeighbor()
Definition: MooseVariableFE.C:329
MooseVariableFE::adGradSln
const VariableGradientType< OutputType, compute_stage >::type & adGradSln() const
Definition: MooseVariableFE.h:312
MooseMesh::getBoundaryIDs
std::vector< BoundaryID > getBoundaryIDs(const Elem *const elem, const unsigned short int side) const
Returns a vector of boundary IDs for the requested element on the requested side.
Definition: MooseMesh.C:2169
BlockRestrictable::_boundary_ids
const std::set< BoundaryID > & _boundary_ids
Reference to the boundary_ids, defaults to an empty set if not provided.
Definition: BlockRestrictable.h:245
MooseVariableFE::uDotDotOld
const FieldVariableValue & uDotDotOld() const
Definition: MooseVariableFE.h:353
InitialConditionTempl::_n_qp
unsigned int _n_qp
The number of quadrature points for a given element.
Definition: InitialConditionTempl.h:163
InitialConditionTempl::_Ue
DenseVector< DataType > _Ue
Linear solution vector.
Definition: InitialConditionTempl.h:150
InitialConditionTempl::_Fe
DenseVector< DataType > _Fe
Linear b vector.
Definition: InitialConditionTempl.h:148
MooseVariableFE::slnOlder
const FieldVariableValue & slnOlder() const
Definition: MooseVariableFE.h:269
RestartableData
Concrete definition of a parameter value for a specified type.
Definition: RestartableData.h:76
MooseVariableBase::kind
Moose::VarKindType kind() const
Kind of the variable (Nonlinear, Auxiliary, ...)
Definition: MooseVariableBase.h:74
Coupleable::getDefaultArrayValue
ArrayVariableValue * getDefaultArrayValue(const std::string &var_name)
Helper method to return (and insert if necessary) the default value for an uncoupled array variable.
Definition: Coupleable.C:319
BlockRestrictable::hasBlockMaterialPropertyHelper
virtual bool hasBlockMaterialPropertyHelper(const std::string &prop_name)
A helper method to allow the Material object to specialize the behavior of hasBlockMaterialProperty.
Definition: BlockRestrictable.C:256
Coupleable::_obj
const MooseObject * _obj
Definition: Coupleable.h:1129
MooseVariableFE::duDotDuNeighbor
const VariableValue & duDotDuNeighbor() const
Definition: MooseVariableFE.h:428
MooseVariableFE::nodalValueOld
const OutputType & nodalValueOld()
Definition: MooseVariableFE.C:580
InputParameters::addRequiredParam
void addRequiredParam(const std::string &name, const std::string &doc_string)
This method adds a parameter and documentation string to the InputParameters object that will be extr...
Definition: InputParameters.h:1176
MooseObject::_app
MooseApp & _app
The MooseApp this object is associated with.
Definition: MooseObject.h:172
Coupleable::getVectorVar
VectorMooseVariable * getVectorVar(const std::string &var_name, unsigned int comp)
Extract pointer to a coupled vector variable.
Definition: Coupleable.C:246
MooseVariableFE::uDotOldNeighbor
const FieldVariableValue & uDotOldNeighbor() const
Definition: MooseVariableFE.h:426
BoundaryRestrictable::_bnd_mesh
MooseMesh * _bnd_mesh
Point to mesh.
Definition: BoundaryRestrictable.h:183
InitialConditionTempl::setOtherCOneVertices
void setOtherCOneVertices()
set the temporary solution vector for node projections of non-Hermitian C1 variables
Definition: InitialConditionTempl.C:422
MooseVariableFE::uDotNeighbor
const FieldVariableValue & uDotNeighbor() const
neighbor dots
Definition: MooseVariableFE.h:424
MooseVariableFE
Class for stuff related to variables.
Definition: Adaptivity.h:31
Restartable::_restartable_system_name
std::string _restartable_system_name
The system name this object is in.
Definition: Restartable.h:214
MooseVariableFE::dofValuesOldNeighbor
const DoFValue & dofValuesOldNeighbor()
Definition: MooseVariableFE.C:273
FEProblemBase::mesh
virtual MooseMesh & mesh() override
Definition: FEProblemBase.h:148
MooseVariableFE::uDotDotNeighbor
const FieldVariableValue & uDotDotNeighbor() const
Definition: MooseVariableFE.h:425
MooseObject::mooseWarning
void mooseWarning(Args &&... args) const
Definition: MooseObject.h:150
MooseObject::paramErrorMsg
std::string paramErrorMsg(const std::string &param, Args... args) const
Definition: MooseObject.h:185
MooseVariableFE::dofValuesPreviousNLNeighbor
const DoFValue & dofValuesPreviousNLNeighbor()
Definition: MooseVariableFE.C:287
MooseObject::name
virtual const std::string & name() const
Get the name of the object.
Definition: MooseObject.h:70
RestartableData::get
T & get()
Definition: RestartableData.h:92
Restartable::registerRestartableNameWithFilterOnApp
void registerRestartableNameWithFilterOnApp(const std::string &name, Moose::RESTARTABLE_FILTER filter)
Helper function for actually registering the restartable data.
Definition: Restartable.C:56
Moose::BLOCK_MATERIAL_DATA
Definition: MooseTypes.h:585
InitialConditionTempl::_current_elem
const Elem *const & _current_elem
The current element we are on will retrieving values at specific points in the domain.
Definition: InitialConditionTempl.h:136
MooseVariableBase::name
const std::string & name() const override
Get the variable name.
Definition: MooseVariableBase.h:63
MooseVariableFE::secondSln
const FieldVariableSecond & secondSln() const
element seconds
Definition: MooseVariableFE.h:289
MooseVariableBase::number
unsigned int number() const
Get variable number coming from libMesh.
Definition: MooseVariableBase.h:48
n
PetscInt n
Definition: PetscDMMoose.C:1504
Coupleable::_default_array_value_zero
ArrayVariableValue _default_array_value_zero
This will always be zero because the default values for optionally coupled variables is always consta...
Definition: Coupleable.h:955