VectorConstantIC just returns a constant value.
More...
#include <VectorConstantIC.h>
|
| VectorConstantIC (const InputParameters ¶meters) |
|
virtual RealVectorValue | value (const Point &p) override |
| The value of the variable at a point. More...
|
|
virtual MooseVariableFEBase & | variable () 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...
|
|
T | 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 UserObject & | getUserObjectBase (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 InputParameters & | parameters () const |
| Get the parameters of the object. More...
|
|
template<typename T > |
const T & | getParamTempl (const std::string &name) const |
| Retrieve a parameter for the object. More...
|
|
template<typename T > |
T | getCheckedPointerParam (const std::string &name, const std::string &error_string="") const |
| Verifies that the requested parameter exists and is not NULL and returns it to the caller. More...
|
|
bool | isParamValid (const std::string &name) const |
| Test if the supplied parameter is valid. More...
|
|
MooseApp & | getMooseApp () const |
| Get the MooseApp this object is associated with. More...
|
|
virtual bool | enabled () const |
| Return the enabled status of the object. More...
|
|
template<typename... Args> |
void | paramError (const std::string ¶m, Args... args) const |
| Emits an error prefixed with the file and line number of the given param (from the input file) along with the full parameter path+name followed by the given args as the message. More...
|
|
template<typename... Args> |
void | paramWarning (const std::string ¶m, Args... args) const |
| Emits a warning prefixed with the file and line number of the given param (from the input file) along with the full parameter path+name followed by the given args as the message. More...
|
|
template<typename... Args> |
void | paramInfo (const std::string ¶m, Args... args) const |
| Emits an informational message prefixed with the file and line number of the given param (from the input file) along with the full parameter path+name followed by the given args as the message. More...
|
|
template<typename... Args> |
void | mooseError (Args &&... args) const |
|
template<typename... Args> |
void | mooseWarning (Args &&... args) const |
|
template<typename... Args> |
void | mooseDeprecated (Args &&... args) const |
|
template<typename... Args> |
void | mooseInfo (Args &&... args) const |
|
const std::vector< SubdomainName > & | blocks () const |
| Return the block names for this object. More...
|
|
unsigned int | numBlocks () const |
| Return the number of blocks for this object. More...
|
|
const virtual std::set< SubdomainID > & | blockIDs () const |
| Return the block subdomain ids for this object. More...
|
|
bool | hasBlocks (const SubdomainName &name) const |
| Test if the supplied block name is valid for this object. More...
|
|
bool | hasBlocks (const std::vector< SubdomainName > &names) const |
| Test if the supplied vector of block names are valid for this object. More...
|
|
bool | hasBlocks (const SubdomainID &id) const |
| Test if the supplied block ids are valid for this object. More...
|
|
bool | hasBlocks (const std::vector< SubdomainID > &ids) const |
| Test if the supplied vector block ids are valid for this object. More...
|
|
bool | hasBlocks (const std::set< SubdomainID > &ids) const |
| Test if the supplied set of block ids are valid for this object. More...
|
|
bool | isBlockSubset (const std::set< SubdomainID > &ids) const |
| Test if the class block ids are a subset of the supplied objects. More...
|
|
bool | isBlockSubset (const std::vector< SubdomainID > &ids) const |
| Test if the class block ids are a subset of the supplied objects. More...
|
|
template<typename T > |
bool | hasBlockMaterialProperty (const std::string &prop_name) |
| Check if a material property is valid for all blocks of this object. More...
|
|
const std::set< SubdomainID > & | meshBlockIDs () const |
| Return all of the SubdomainIDs for the mesh. More...
|
|
virtual bool | blockRestricted () const |
| Returns true if this object has been restricted to a boundary. More...
|
|
void | checkVariable (const MooseVariableFEBase &variable) const |
| Helper for checking that the ids for this object are in agreement with the variables on the supplied variable. More...
|
|
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<> |
VariableValue * | getADDefaultValue (const std::string &var_name) |
|
template<> |
VariableValue * | getADDefaultValue (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<> |
VectorVariableValue * | getADDefaultVectorValue (const std::string &var_name) |
|
template<> |
VectorVariableValue * | getADDefaultVectorValue (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<> |
VariableGradient & | getADDefaultGradient () |
|
template<> |
VariableGradient & | getADDefaultGradient () |
|
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<> |
VectorVariableGradient & | getADDefaultVectorGradient () |
|
template<> |
VectorVariableGradient & | getADDefaultVectorGradient () |
|
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<> |
VariableSecond & | getADDefaultSecond () |
|
template<> |
VariableSecond & | getADDefaultSecond () |
|
const Function & | getFunction (const std::string &name) const |
| Get a function with a given name. More...
|
|
const Function & | getFunctionByName (const FunctionName &name) const |
| Get a function with a given name. More...
|
|
const UserObject & | getUserObjectBaseByName (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...
|
|
|
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 VariableValue & | coupledValue (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 VariableValue & | coupledVectorTagValue (const std::string &var_name, TagID tag, unsigned int comp=0) |
| Returns value of a coupled variable for a given tag. More...
|
|
virtual const VariableValue & | coupledMatrixTagValue (const std::string &var_name, TagID tag, unsigned int comp=0) |
| Returns value of a coupled variable for a given tag. More...
|
|
virtual const VectorVariableValue & | coupledVectorValue (const std::string &var_name, unsigned int comp=0) |
| Returns value of a coupled vector variable. More...
|
|
virtual const ArrayVariableValue & | coupledArrayValue (const std::string &var_name, unsigned int comp=0) |
| Returns value of a coupled array variable. More...
|
|
virtual VariableValue & | writableCoupledValue (const std::string &var_name, unsigned int comp=0) |
| Returns a writable reference to a coupled variable. More...
|
|
virtual const VariableValue & | coupledValueOld (const std::string &var_name, unsigned int comp=0) |
| Returns an old value from previous time step of a coupled variable. More...
|
|
virtual const VariableValue & | coupledValueOlder (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 VariableValue & | coupledValuePreviousNL (const std::string &var_name, unsigned int comp=0) |
| Returns value of previous Newton iterate of a coupled variable. More...
|
|
virtual const VectorVariableValue & | coupledVectorValueOld (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 VectorVariableValue & | coupledVectorValueOlder (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 ArrayVariableValue & | coupledArrayValueOld (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 ArrayVariableValue & | coupledArrayValueOlder (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 VariableGradient & | coupledGradient (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 VariableGradient & | coupledGradientOld (const std::string &var_name, unsigned int comp=0) |
| Returns an old gradient from previous time step of a coupled variable. More...
|
|
virtual const VariableGradient & | coupledGradientOlder (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 VariableGradient & | coupledGradientPreviousNL (const std::string &var_name, unsigned int comp=0) |
| Returns gradient of a coupled variable for previous Newton iterate. More...
|
|
virtual const VariableGradient & | coupledGradientDot (const std::string &var_name, unsigned int comp=0) |
| Time derivative of the gradient of a coupled variable. More...
|
|
virtual const VariableGradient & | coupledGradientDotDot (const std::string &var_name, unsigned int comp=0) |
| Second time derivative of the gradient of a coupled variable. More...
|
|
virtual const VectorVariableGradient & | coupledVectorGradient (const std::string &var_name, unsigned int comp=0) |
| Returns gradient of a coupled vector variable. More...
|
|
virtual const VectorVariableGradient & | coupledVectorGradientOld (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 VectorVariableGradient & | coupledVectorGradientOlder (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 ArrayVariableGradient & | coupledArrayGradient (const std::string &var_name, unsigned int comp=0) |
| Returns gradient of a coupled array variable. More...
|
|
virtual const ArrayVariableGradient & | coupledArrayGradientOld (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 ArrayVariableGradient & | coupledArrayGradientOlder (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 VectorVariableCurl & | coupledCurl (const std::string &var_name, unsigned int comp=0) |
| Returns curl of a coupled variable. More...
|
|
virtual const VectorVariableCurl & | coupledCurlOld (const std::string &var_name, unsigned int comp=0) |
| Returns an old curl from previous time step of a coupled variable. More...
|
|
virtual const VectorVariableCurl & | coupledCurlOlder (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 VariableSecond & | coupledSecond (const std::string &var_name, unsigned int comp=0) |
| Returns second derivative of a coupled variable. More...
|
|
virtual const VariableSecond & | coupledSecondOld (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 VariableSecond & | coupledSecondOlder (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 VariableSecond & | coupledSecondPreviousNL (const std::string &var_name, unsigned int comp=0) |
| Returns second derivative of a coupled variable for the previous Newton iterate. More...
|
|
virtual const VariableValue & | coupledDot (const std::string &var_name, unsigned int comp=0) |
| Time derivative of a coupled variable. More...
|
|
virtual const VariableValue & | coupledDotDot (const std::string &var_name, unsigned int comp=0) |
| Second time derivative of a coupled variable. More...
|
|
virtual const VariableValue & | coupledDotOld (const std::string &var_name, unsigned int comp=0) |
| Old time derivative of a coupled variable. More...
|
|
virtual const VariableValue & | coupledDotDotOld (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 VectorVariableValue & | coupledVectorDot (const std::string &var_name, unsigned int comp=0) |
| Time derivative of a coupled vector variable. More...
|
|
virtual const VectorVariableValue & | coupledVectorDotDot (const std::string &var_name, unsigned int comp=0) |
| Second time derivative of a coupled vector variable. More...
|
|
virtual const VectorVariableValue & | coupledVectorDotOld (const std::string &var_name, unsigned int comp=0) |
| Old time derivative of a coupled vector variable. More...
|
|
virtual const VectorVariableValue & | coupledVectorDotDotOld (const std::string &var_name, unsigned int comp=0) |
| Old second time derivative of a coupled vector variable. More...
|
|
virtual const VariableValue & | coupledVectorDotDu (const std::string &var_name, unsigned int comp=0) |
| Time derivative of a coupled vector variable with respect to the coefficients. More...
|
|
virtual const VariableValue & | coupledVectorDotDotDu (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 ArrayVariableValue & | coupledArrayDot (const std::string &var_name, unsigned int comp=0) |
| Time derivative of a coupled array variable. More...
|
|
virtual const ArrayVariableValue & | coupledArrayDotDot (const std::string &var_name, unsigned int comp=0) |
| Second time derivative of a coupled array variable. More...
|
|
virtual const ArrayVariableValue & | coupledArrayDotOld (const std::string &var_name, unsigned int comp=0) |
| Old time derivative of a coupled array variable. More...
|
|
virtual const ArrayVariableValue & | coupledArrayDotDotOld (const std::string &var_name, unsigned int comp=0) |
| Old second time derivative of a coupled array variable. More...
|
|
virtual const VariableValue & | coupledDotDu (const std::string &var_name, unsigned int comp=0) |
| Time derivative of a coupled variable with respect to the coefficients. More...
|
|
virtual const VariableValue & | coupledDotDotDu (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 >::type & | adCoupledNodalValueTemplate (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 VariableValue & | coupledNodalDotDot (const std::string &var_name, unsigned int comp=0) |
| Nodal values of second time derivative of a coupled variable. More...
|
|
virtual const VariableValue & | coupledNodalDotOld (const std::string &var_name, unsigned int comp=0) |
| Nodal values of old time derivative of a coupled variable. More...
|
|
virtual const VariableValue & | coupledNodalDotDotOld (const std::string &var_name, unsigned int comp=0) |
| Nodal values of old second time derivative of a coupled variable. More...
|
|
virtual const VariableValue & | coupledDofValues (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 VariableValue & | coupledDofValuesOld (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 VariableValue & | coupledDofValuesOlder (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 VariableValue & | adZeroValueTemplate () |
|
template<> |
const VariableValue & | adZeroValueTemplate () |
|
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 VariableGradient & | adZeroGradientTemplate () |
|
template<> |
const VariableGradient & | adZeroGradientTemplate () |
|
template<ComputeStage compute_stage> |
const ADVariableSecond & | adZeroSecondTemplate () |
| Retrieve a zero second for automatic differentiation. More...
|
|
template<> |
const VariableSecond & | adZeroSecondTemplate () |
|
template<> |
const VariableSecond & | adZeroSecondTemplate () |
|
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...
|
|
MooseVariableFEBase * | getFEVar (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...
|
|
MooseVariable * | getVar (const std::string &var_name, unsigned int comp) |
| Extract pointer to a coupled variable. More...
|
|
VectorMooseVariable * | getVectorVar (const std::string &var_name, unsigned int comp) |
| Extract pointer to a coupled vector variable. More...
|
|
ArrayMooseVariable * | getArrayVar (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...
|
|
|
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...
|
|
|
template<typename... Args> |
std::string | paramErrorMsg (const std::string ¶m, Args... args) const |
|
void | checkFuncType (const std::string var_name, VarType t, FuncAge age) |
|
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. More...
|
|
VectorVariableValue * | getDefaultVectorValue (const std::string &var_name) |
| Helper method to return (and insert if necessary) the default value for an uncoupled vector variable. More...
|
|
ArrayVariableValue * | getDefaultArrayValue (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...
|
|
RestartableDataValue & | registerRestartableDataOnApp (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...
|
|
VectorConstantIC just returns a constant value.
Definition at line 32 of file VectorConstantIC.h.
◆ DataType
◆ FEBaseType
◆ GradientShapeType
◆ GradientType
◆ ValueType
◆ FuncAge
◆ TEST_TYPE
◆ VarType
Enumerator |
---|
Ignore | |
Gradient | |
GradientDot | |
Dot | |
Definition at line 978 of file Coupleable.h.
◆ VectorConstantIC()
◆ 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_name | Name of coupled variable |
comp | Component 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.
1200 return *getADDefaultValue<compute_stage>(var_name);
1207 return var->
adUDot<compute_stage>();
◆ 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_name | Name of coupled variable |
comp | Component 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.
1157 return getADDefaultGradient<compute_stage>();
◆ adCoupledNodalValueTemplate()
template<typename T , ComputeStage compute_stage>
Returns AD nodal values of a coupled variable.
- Parameters
-
var_name | Name of coupled variable |
comp | Component number for vector of coupled variables |
- Returns
- Reference to a VariableValue for the coupled variable
Definition at line 1406 of file Coupleable.C.
1413 mooseError(
"The adCoupledNodalValue method should only be called for nodal computing objects");
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.");
1419 mooseError(
"If you're going to use an explicit scheme, then use coupledNodalValue instead of "
1420 "adCoupledNodalValue");
1425 return var->template adNodalValue<compute_stage>();
◆ 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_name | Name of coupled variable |
comp | Component 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.
1174 return getADDefaultSecond<compute_stage>();
◆ 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_name | Name of coupled variable |
comp | Component 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.
1138 return *getADDefaultValue<compute_stage>(var_name);
1147 return var->
adSln<compute_stage>();
◆ 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_name | Name of vector coupled variable |
comp | Component 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.
1217 return *getADDefaultVectorValue<compute_stage>(var_name);
1224 return var->
adUDot<compute_stage>();
◆ 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_name | Name of coupled vector variable |
comp | Component 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.
1253 return getADDefaultVectorGradient<compute_stage>();
◆ 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_name | Name of coupled vector variable |
comp | Component 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_name | Name of coupled vector variable |
comp | Component 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.
1234 return *getADDefaultVectorValue<compute_stage>(var_name);
1243 return var->
adSln<compute_stage>();
◆ addFEVariableCoupleableMatrixTag()
void Coupleable::addFEVariableCoupleableMatrixTag |
( |
TagID |
tag | ) |
|
|
inlineinherited |
◆ addFEVariableCoupleableVectorTag()
void Coupleable::addFEVariableCoupleableVectorTag |
( |
TagID |
tag | ) |
|
|
inlineinherited |
◆ 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.
◆ adZeroGradientTemplate() [2/3]
◆ adZeroGradientTemplate() [3/3]
◆ 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.
◆ adZeroSecondTemplate() [2/3]
◆ adZeroSecondTemplate() [3/3]
◆ 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.
◆ adZeroValueTemplate() [2/3]
◆ adZeroValueTemplate() [3/3]
◆ blockIDs()
const std::set< SubdomainID > & BlockRestrictable::blockIDs |
( |
| ) |
const |
|
virtualinherited |
◆ blockRestricted()
bool BlockRestrictable::blockRestricted |
( |
| ) |
const |
|
virtualinherited |
◆ 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.
Referenced by MaterialOutputAction::getParams().
◆ boundaryIDs()
const std::set< BoundaryID > & BoundaryRestrictable::boundaryIDs |
( |
| ) |
const |
|
virtualinherited |
◆ boundaryNames()
const std::vector< BoundaryName > & BoundaryRestrictable::boundaryNames |
( |
| ) |
const |
|
inherited |
◆ boundaryRestricted()
bool BoundaryRestrictable::boundaryRestricted |
( |
| ) |
const |
|
virtualinherited |
◆ checkFuncType()
void Coupleable::checkFuncType |
( |
const std::string |
var_name, |
|
|
VarType |
t, |
|
|
FuncAge |
age |
|
) |
| |
|
privateinherited |
Definition at line 156 of file Coupleable.C.
167 "' uses older variable values that are unavailable with explicit schemes");
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_name | The name of the coupled variable |
Definition at line 174 of file Coupleable.C.
180 for (
auto jt : it->second)
181 cvars +=
" " + jt->name();
186 "' to a scalar variable (",
188 ") where field variable is expected");
194 auto bound = comp_bound ? comp_bound :
_coupled_vars[var_name].size();
Referenced by Coupleable::getFEVar(), and Coupleable::getVarHelper().
◆ checkVariable()
Helper for checking that the ids for this object are in agreement with the variables on the supplied variable.
- Parameters
-
variable | The variable to check against. |
Definition at line 314 of file BlockRestrictable.C.
320 mooseError(
"The 'block' parameter of the object '",
322 "' must be a subset of the 'block' parameter of the variable '",
◆ choleskyAssembly()
Assemble a small local system for cholesky solve.
Definition at line 449 of file InitialConditionTempl.C.
464 for (decltype(dofs_size) geomi = 0, freei = 0; geomi != dofs_size; ++geomi)
466 auto i = is_volume ? geomi :
_side_dofs[geomi];
471 for (decltype(dofs_size) geomj = 0, freej = 0; geomj != dofs_size; ++geomj)
473 auto j = is_volume ? geomj :
_side_dofs[geomj];
475 _Fe(freei) -= (*_phi)[i][
_qp] * (*_phi)[j][
_qp] * (*_JxW)[
_qp] *
_Ue(j);
477 _Ke(freei, freej) += (*_phi)[i][
_qp] * (*_phi)[j][
_qp] * (*_JxW)[
_qp];
488 _Fe(freei) += (*_phi)[i][
_qp] * fineval * (*_JxW)[
_qp];
◆ choleskySolve() [1/2]
◆ choleskySolve() [2/2]
Definition at line 525 of file InitialConditionTempl.C.
536 DenseVector<DataType> U =
_Fe;
538 for (
unsigned int i = 0; i <
_var.
count(); ++i)
544 _Ke.cholesky_solve(v,
x);
551 for (
unsigned int i = 0; i !=
_free_dofs; ++i)
555 libmesh_assert(ui.matrix().norm() < TOLERANCE || (ui - U(i)).matrix().norm() < TOLERANCE);
◆ compute()
Workhorse method for projecting the initial conditions for block initial conditions.
Implements InitialConditionBase.
Definition at line 71 of file InitialConditionTempl.C.
92 std::unique_ptr<FEBaseType> fe(FEBaseType::build(
_dim,
_fe_type));
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));
100 _phi = &fe->get_phi();
105 _cont = fe->get_continuity();
109 const std::vector<std::vector<GradientShapeType>> & ref_dphi = fe->get_dphi();
114 _JxW = &fe->get_JxW();
137 DenseVector<char> mask(n_dofs,
true);
149 for (
_n = 0;
_n != n_nodes; ++
_n)
158 auto priority_block = *(block_ids.begin());
159 for (
auto id : block_ids)
168 for (decltype(
_nc) i = 0; i <
_nc; ++i)
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)
208 for (
unsigned int i = 0; i !=
_side_dofs.size(); ++i)
217 fe->attach_quadrature_rule(qedgerule.get());
219 _n_qp = qedgerule->n_points();
233 for (
unsigned int i = 0; i !=
_side_dofs.size(); ++i)
242 fe->attach_quadrature_rule(qsiderule.get());
244 _n_qp = qsiderule->n_points();
254 for (
unsigned int i = 0; i != n_dofs; ++i)
262 fe->attach_quadrature_rule(qrule.get());
264 _n_qp = qrule->n_points();
270 for (
unsigned int i = 0; i != n_dofs; ++i)
275 Threads::spin_mutex::scoped_lock lock(Threads::spin_mtx);
276 for (
size_t i = 0; i < mask.size(); i++)
◆ computeNodal()
Workhorse method for projecting the initial conditions for boundary restricted initial conditions.
Implements InitialConditionBase.
Definition at line 563 of file InitialConditionTempl.C.
567 auto return_value =
value(p);
574 Threads::spin_mutex::scoped_lock lock(Threads::spin_mtx);
◆ coupled()
unsigned int Coupleable::coupled |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
◆ coupledArrayDot()
const ArrayVariableValue & Coupleable::coupledArrayDot |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
Time derivative of a coupled array variable.
- Parameters
-
var_name | Name of coupled array variable |
comp | Component 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.
◆ 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_name | Name of coupled array variable |
comp | Component 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.
◆ 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_name | Name of coupled array variable |
comp | Component 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.
◆ 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_name | Name of coupled array variable |
comp | Component 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.
◆ coupledArrayGradient()
const ArrayVariableGradient & Coupleable::coupledArrayGradient |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
Returns gradient of a coupled array variable.
- Parameters
-
var_name | Name of coupled array variable |
comp | Component 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.
◆ 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_name | Name of coupled array variable |
comp | Component 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.
◆ 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_name | Name of coupled array variable |
comp | Component 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.
◆ coupledArrayValue()
const ArrayVariableValue & Coupleable::coupledArrayValue |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
Returns value of a coupled array variable.
- Parameters
-
var_name | Name of coupled vector variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ coupledCallback()
virtual void Coupleable::coupledCallback |
( |
const std::string & |
, |
|
|
bool |
|
|
) |
| |
|
inlineprotectedvirtualinherited |
◆ coupledComponents()
unsigned int Coupleable::coupledComponents |
( |
const std::string & |
var_name | ) |
|
|
protectedinherited |
◆ coupledCurl()
const VectorVariableCurl & Coupleable::coupledCurl |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
Returns curl of a coupled variable.
- Parameters
-
var_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ coupledDot()
const VariableValue & Coupleable::coupledDot |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
◆ coupledDotDot()
const VariableValue & Coupleable::coupledDotDot |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
Second time derivative of a coupled variable.
- Parameters
-
var_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ coupledDotDu()
const VariableValue & Coupleable::coupledDotDu |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
◆ coupledDotOld()
const VariableValue & Coupleable::coupledDotOld |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
Old time derivative of a coupled variable.
- Parameters
-
var_name | Name of coupled variable |
comp | Component 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.
◆ coupledGradient()
const VariableGradient & Coupleable::coupledGradient |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ coupledGradientOld()
const VariableGradient & Coupleable::coupledGradientOld |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
◆ coupledGradientOlder()
const VariableGradient & Coupleable::coupledGradientOlder |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
tag | matrix tag ID |
comp | Component 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.
431 mooseError(var_name,
": invalid variable name for coupledMatrixTagValue");
◆ 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_name | Name of coupled variable |
comp | Component 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.
1246 static const T zero = 0;
1254 mooseError(
"Neighbor version not implemented");
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component number for vector of coupled variables |
- Returns
- Reference to a VariableValue for the coupled variable
Definition at line 1168 of file Coupleable.C.
1172 return getDefaultNodalValue<T>(var_name, comp);
1177 ": Trying to get nodal values of variable '",
1179 "', but it is not nodal.");
◆ 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_name | Name of coupled variable |
comp | Component 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.
1192 return getDefaultNodalValue<T>(var_name, comp);
1197 ": Trying to get old nodal values of variable '",
1199 "', but it is not nodal.");
◆ 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_name | Name of coupled variable |
comp | Component 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.
1212 return getDefaultNodalValue<T>(var_name, comp);
1217 ": Trying to get older nodal values of variable '",
1219 "', but it is not nodal.");
◆ 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_name | Name of coupled variable |
comp | Component number for vector of coupled variables |
- Returns
- Reference to a VariableValue for the coupled variable
Definition at line 1228 of file Coupleable.C.
1232 return getDefaultNodalValue<T>(var_name, comp);
◆ coupledSecond()
const VariableSecond & Coupleable::coupledSecond |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ coupledValue()
const VariableValue & Coupleable::coupledValue |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
◆ coupledValueOld()
const VariableValue & Coupleable::coupledValueOld |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
◆ coupledValueOlder()
const VariableValue & Coupleable::coupledValueOlder |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ coupledVectorDot()
const VectorVariableValue & Coupleable::coupledVectorDot |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
Time derivative of a coupled vector variable.
- Parameters
-
var_name | Name of coupled vector variable |
comp | Component 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.
◆ 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_name | Name of coupled vector variable |
comp | Component 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.
◆ 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_name | Name of coupled vector variable |
comp | Component 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.
◆ 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_name | Name of coupled vector variable |
comp | Component 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.
◆ 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_name | Name of coupled vector variable |
comp | Component 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.
◆ 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_name | Name of coupled vector variable |
comp | Component 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.
◆ coupledVectorGradient()
const VectorVariableGradient & Coupleable::coupledVectorGradient |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
Returns gradient of a coupled vector variable.
- Parameters
-
var_name | Name of coupled vector variable |
comp | Component 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.
◆ 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_name | Name of coupled vector variable |
comp | Component 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.
◆ 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_name | Name of coupled vector variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
tag | vector tag ID |
comp | Component 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.
415 mooseError(var_name,
": invalid variable name for coupledVectorTagValue");
◆ coupledVectorValue()
const VectorVariableValue & Coupleable::coupledVectorValue |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp = 0 |
|
) |
| |
|
protectedvirtualinherited |
Returns value of a coupled vector variable.
- Parameters
-
var_name | Name of coupled vector variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ 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_name | Name of coupled variable |
comp | Component 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.
◆ cyclicDependencyError()
A helper method for cyclic errors.
Definition at line 94 of file DependencyResolverInterface.h.
97 std::ostringstream oss;
99 oss << header <<
":\n";
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()
◆ 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_name | The name of the data (usually just use the same name as the member variable) |
Definition at line 295 of file Restartable.h.
301 return declareRestartableDataWithContext<T>(data_name,
nullptr);
◆ 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_name | The name of the data (usually just use the same name as the member variable) |
init_value | The initial value of the data |
Definition at line 306 of file Restartable.h.
312 return declareRestartableDataWithContext<T>(data_name, init_value,
nullptr);
◆ 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_name | The name of the data (usually just use the same name as the member variable) |
Definition at line 222 of file Restartable.h.
224 return declareRestartableDataWithContext<T>(data_name,
nullptr);
◆ 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_name | The name of the data (usually just use the same name as the member variable) |
init_value | The initial value of the data |
Definition at line 229 of file Restartable.h.
231 return declareRestartableDataWithContext<T>(data_name, init_value,
nullptr);
◆ 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_name | The name of the data (usually just use the same name as the member variable) |
init_value | The initial value of the data |
context | Context pointer that will be passed to the load and store functions |
Definition at line 250 of file Restartable.h.
260 auto data_ptr = libmesh_make_unique<RestartableData<T>>(full_name, context);
264 restartable_data_ref.
set() = init_value;
265 return restartable_data_ref.get();
◆ 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_name | The name of the data (usually just use the same name as the member variable) |
context | Context pointer that will be passed to the load and store functions |
Definition at line 236 of file Restartable.h.
239 auto data_ptr = libmesh_make_unique<RestartableData<T>>(full_name, context);
245 return restartable_data_ref.
get();
◆ 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_name | The name of the data (usually just use the same name as the member variable) |
object_name | A supplied name for the object that is declaring this data. |
Definition at line 270 of file Restartable.h.
273 return declareRestartableDataWithObjectNameWithContext<T>(data_name, object_name,
nullptr);
◆ 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_name | The name of the data (usually just use the same name as the member variable) |
object_name | A supplied name for the object that is declaring this data. |
context | Context pointer that will be passed to the load and store functions |
Definition at line 278 of file Restartable.h.
286 T & value = declareRestartableDataWithContext<T>(data_name, context);
◆ 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_name | The name of the data (usually just use the same name as the member variable) |
prefix | The prefix to prepend to the data_name, to retrieve data from another object. |
context | Context pointer that will be passed to the load and store functions |
◆ dotHelper() [1/3]
Helps perform multiplication of GradientTypes: a normal dot product for vectors and a contraction for tensors.
Definition at line 99 of file InitialConditionTempl.h.
◆ dotHelper() [2/3]
◆ 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.
104 for (
unsigned int i = 1; i < LIBMESH_DIM; ++i)
105 v += op1.col(i) * op2(i);
◆ enabled()
virtual bool MooseObject::enabled |
( |
| ) |
const |
|
inlinevirtualinherited |
◆ 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_name | the 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.
◆ getADDefaultGradient() [2/3]
◆ getADDefaultGradient() [3/3]
◆ 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_name | the 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.
◆ getADDefaultSecond() [2/3]
◆ getADDefaultSecond() [3/3]
◆ 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_name | the 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.
1273 default_value_it =
_ad_default_value.insert(std::make_pair(var_name, std::move(value))).first;
1276 return default_value_it->second.get();
◆ 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 |
◆ 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_name | the 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.
◆ getADDefaultVectorGradient() [2/3]
◆ getADDefaultVectorGradient() [3/3]
◆ 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_name | the 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.
1292 auto value = libmesh_make_unique<ADVectorVariableValue>(
_coupleable_max_qps, default_vec);
1297 return default_value_it->second.get();
◆ getADDefaultVectorValue() [2/3]
◆ getADDefaultVectorValue() [3/3]
◆ getArrayVar()
ArrayMooseVariable * Coupleable::getArrayVar |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp |
|
) |
| |
|
protectedinherited |
Extract pointer to a coupled array variable.
- Parameters
-
var_name | Name of parameter desired |
comp | Component number of multiple coupled variables |
- Returns
- Pointer to the desired variable
Definition at line 258 of file Coupleable.C.
260 return getVarHelper<RealEigenVector>(var_name, comp);
Referenced by Coupleable::coupledArrayDot(), Coupleable::coupledArrayDotDot(), Coupleable::coupledArrayDotDotOld(), Coupleable::coupledArrayDotOld(), Coupleable::coupledArrayGradient(), Coupleable::coupledArrayGradientOld(), Coupleable::coupledArrayGradientOlder(), NeighborCoupleable::coupledArrayNeighborGradient(), NeighborCoupleable::coupledArrayNeighborGradientOld(), NeighborCoupleable::coupledArrayNeighborGradientOlder(), NeighborCoupleable::coupledArrayNeighborValue(), Coupleable::coupledArrayValue(), Coupleable::coupledArrayValueOld(), and Coupleable::coupledArrayValueOlder().
◆ getBlockCoordSystem()
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.
295 mooseError(
"No mesh available in BlockRestrictable::checkCoordSystem()");
297 mooseError(
"No problem available in BlockRestrictable::checkCoordSystem()");
301 if (subdomains.empty())
302 mooseError(
"No subdomains found in the problem.");
306 for (
auto subdomain : subdomains)
308 mooseError(
"This object requires all subdomains to have the same coordinate system.");
◆ 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.
◆ getCoupledArratMooseVars()
Get the list of array coupled variables.
- Returns
- The list of array coupled variables
Definition at line 112 of file Coupleable.h.
◆ getCoupledMooseVars()
Get the list of all coupled variables.
- Returns
- The list of all coupled variables
Definition at line 85 of file Coupleable.h.
Referenced by AuxNodalScalarKernel::AuxNodalScalarKernel(), CoupleableMooseVariableDependencyIntermediateInterface::CoupleableMooseVariableDependencyIntermediateInterface(), ElementIndicator::ElementIndicator(), ElementUserObject::ElementUserObject(), InterfaceMaterial::InterfaceMaterial(), InterfaceUserObject::InterfaceUserObject(), InternalSideIndicator::InternalSideIndicator(), InternalSideUserObject::InternalSideUserObject(), Material::Material(), NeighborCoupleableMooseVariableDependencyIntermediateInterface::NeighborCoupleableMooseVariableDependencyIntermediateInterface(), NodalScalarKernel::NodalScalarKernel(), NodalUserObject::NodalUserObject(), and SideUserObject::SideUserObject().
◆ 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.
◆ getCoupledVars()
const std::unordered_map<std::string, std::vector<MooseVariableFEBase *> >& Coupleable::getCoupledVars |
( |
| ) |
|
|
inlineinherited |
◆ getCoupledVectorMooseVars()
Get the list of vector coupled variables.
- Returns
- The list of vector coupled variables
Definition at line 103 of file Coupleable.h.
◆ getDefaultArrayValue()
◆ 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.
344 return *default_variable_value->data();
◆ getDefaultNodalValue() [2/3]
template<>
const RealVectorValue& Coupleable::getDefaultNodalValue |
( |
const std::string & |
var_name, |
|
|
unsigned int |
|
|
) |
| |
|
privateinherited |
Definition at line 349 of file Coupleable.C.
352 return *default_variable_value->data();
◆ getDefaultNodalValue() [3/3]
template<>
const RealEigenVector& Coupleable::getDefaultNodalValue |
( |
const std::string & |
var_name, |
|
|
unsigned int |
|
|
) |
| |
|
privateinherited |
Definition at line 357 of file Coupleable.C.
360 return *default_variable_value->data();
◆ getDefaultValue()
VariableValue * Coupleable::getDefaultValue |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp |
|
) |
| |
|
privateinherited |
◆ getDefaultVectorValue()
◆ getDependObjects()
const std::set<std::string>& InitialConditionBase::getDependObjects |
( |
| ) |
const |
|
inlineinherited |
◆ 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_name | Name of object parameter |
comp | Component number for vector of integer names |
- Returns
- Integer for the current element
Definition at line 50 of file ElementIDInterface.C.
58 auto & assembly = _subproblem.assembly(tid);
60 return assembly.extraElemID(
id);
◆ 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_name | Name of object parameter |
comp | Component number for vector of integer names |
- Returns
- Index of the element integer
Definition at line 29 of file ElementIDInterface.C.
32 auto & p =
_obj_parameters.get<std::vector<ExtraElementIDName>>(id_parameter_name);
34 mooseError(id_parameter_name,
" does not have enough integer names");
37 mooseError(
"Mesh is not available for getting element integers");
39 auto & mesh_base =
_mesh->getMesh();
41 if (!mesh_base.has_elem_integer(p[comp]))
42 mooseError(
"Mesh does not have an element integer names as ", p[comp]);
44 auto id = mesh_base.get_elem_integer_index(p[comp]);
Referenced by ElementIDInterface::getElementID().
◆ getFEVar()
Extract pointer to a base finite element coupled variable.
- Parameters
-
var_name | Name of parameter desired |
comp | Component number of multiple coupled variables |
- Returns
- Pointer to the desired variable
Definition at line 204 of file Coupleable.C.
Referenced by Coupleable::coupled().
◆ getFEVariableCoupleableMatrixTags()
std::set<TagID>& Coupleable::getFEVariableCoupleableMatrixTags |
( |
| ) |
|
|
inlineinherited |
◆ getFEVariableCoupleableVectorTags()
std::set<TagID>& Coupleable::getFEVariableCoupleableVectorTags |
( |
| ) |
|
|
inlineinherited |
◆ getFunction()
const Function & FunctionInterface::getFunction |
( |
const std::string & |
name | ) |
const |
|
inherited |
Get a function with a given name.
- Parameters
-
name | The 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.
Referenced by FunctionDT::FunctionDT().
◆ getFunctionByName()
const Function & FunctionInterface::getFunctionByName |
( |
const FunctionName & |
name | ) |
const |
|
inherited |
◆ getMooseApp()
MooseApp& MooseObject::getMooseApp |
( |
| ) |
const |
|
inlineinherited |
◆ getParamTempl()
template<typename T >
const T & MooseObject::getParamTempl |
( |
const std::string & |
name | ) |
const |
|
inherited |
◆ getRequestedItems()
const std::set< std::string > & InitialConditionBase::getRequestedItems |
( |
| ) |
|
|
overridevirtualinherited |
◆ getSuppliedItems()
const std::set< std::string > & InitialConditionBase::getSuppliedItems |
( |
| ) |
|
|
overridevirtualinherited |
◆ getUserObjectBase()
const UserObject & InitialConditionBase::getUserObjectBase |
( |
const std::string & |
name | ) |
|
|
inherited |
◆ getUserObjectBaseByName()
const UserObject & UserObjectInterface::getUserObjectBaseByName |
( |
const std::string & |
name | ) |
|
|
inherited |
◆ getUserObjectByNameTempl() [1/3]
template<class T >
const T & UserObjectInterface::getUserObjectByNameTempl |
( |
const std::string & |
name | ) |
|
|
inherited |
Get an user object with a given name.
- Parameters
-
name | The name of the user object to retrieve |
- Returns
- The user object with the name
Definition at line 93 of file UserObjectInterface.h.
◆ getUserObjectByNameTempl() [2/3]
template<typename T2 >
const T2& InitialConditionBase::getUserObjectByNameTempl |
( |
const UserObjectName & |
name | ) |
|
|
inherited |
◆ getUserObjectByNameTempl() [3/3]
template<typename T >
const T& InitialConditionBase::getUserObjectByNameTempl |
( |
const UserObjectName & |
name | ) |
|
|
inherited |
◆ getUserObjectTempl() [1/2]
template<typename T2 >
const T2& InitialConditionBase::getUserObjectTempl |
( |
const std::string & |
name | ) |
|
|
inherited |
◆ getUserObjectTempl() [2/2]
template<typename T >
const T& InitialConditionBase::getUserObjectTempl |
( |
const std::string & |
name | ) |
|
|
inherited |
◆ getVar()
MooseVariable * Coupleable::getVar |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp |
|
) |
| |
|
protectedinherited |
Extract pointer to a coupled variable.
- Parameters
-
var_name | Name of parameter desired |
comp | Component number of multiple coupled variables |
- Returns
- Pointer to the desired variable
Definition at line 240 of file Coupleable.C.
242 return getVarHelper<Real>(var_name, comp);
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.
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");
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");
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");
235 "Variable '", var_name,
"' is of a different C++ type than you tried to fetch it as.");
◆ getVectorVar()
VectorMooseVariable * Coupleable::getVectorVar |
( |
const std::string & |
var_name, |
|
|
unsigned int |
comp |
|
) |
| |
|
protectedinherited |
Extract pointer to a coupled vector variable.
- Parameters
-
var_name | Name of parameter desired |
comp | Component number of multiple coupled variables |
- Returns
- Pointer to the desired variable
Definition at line 246 of file Coupleable.C.
251 "' uses vector variables which are not required to be continuous. Don't use vector "
253 "with nodal compute objects.");
254 return getVarHelper<RealVectorValue>(var_name, comp);
Referenced by Coupleable::adCoupledVectorDotTemplate(), Coupleable::adCoupledVectorGradientTemplate(), Coupleable::adCoupledVectorValueTemplate(), Coupleable::coupledCurl(), Coupleable::coupledCurlOld(), Coupleable::coupledCurlOlder(), Coupleable::coupledVectorDot(), Coupleable::coupledVectorDotDot(), Coupleable::coupledVectorDotDotDu(), Coupleable::coupledVectorDotDotOld(), Coupleable::coupledVectorDotDu(), Coupleable::coupledVectorDotOld(), Coupleable::coupledVectorGradient(), Coupleable::coupledVectorGradientOld(), Coupleable::coupledVectorGradientOlder(), NeighborCoupleable::coupledVectorNeighborGradient(), NeighborCoupleable::coupledVectorNeighborGradientOld(), NeighborCoupleable::coupledVectorNeighborGradientOlder(), Coupleable::coupledVectorValue(), Coupleable::coupledVectorValueOld(), and Coupleable::coupledVectorValueOlder().
◆ gradient()
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.
◆ gradientComponent() [1/3]
◆ gradientComponent() [2/3]
◆ gradientComponent() [3/3]
◆ 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
-
T | The type of material property |
- Parameters
-
prop_name | the 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.
◆ 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.
266 for (
const auto &
id : ids)
269 std::set<std::string> declared_props;
275 for (
const auto & mat : mats)
277 const std::set<std::string> & mat_props = mat->getSuppliedItems();
278 declared_props.insert(mat_props.begin(), mat_props.end());
283 if (declared_props.find(prop_name) == declared_props.end())
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
-
ids | A 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.
223 return std::includes(
_blk_ids.begin(),
_blk_ids.end(), ids.begin(), ids.end());
◆ 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
-
ids | A 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.
213 std::set<SubdomainID> ids_set(ids.begin(), ids.end());
◆ 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
-
names | A vector of SubdomainNames to check |
- Returns
- True if the given ids are valid for this object
Definition at line 196 of file BlockRestrictable.C.
◆ hasBlocks() [4/5]
bool BlockRestrictable::hasBlocks |
( |
const SubdomainID & |
id | ) |
const |
|
inherited |
Test if the supplied block ids are valid for this object.
- Parameters
-
- Returns
- True if the given id is valid for this object
Definition at line 202 of file BlockRestrictable.C.
◆ hasBlocks() [5/5]
bool BlockRestrictable::hasBlocks |
( |
const SubdomainName & |
name | ) |
const |
|
inherited |
◆ hasBoundary() [1/5]
bool BoundaryRestrictable::hasBoundary |
( |
const BoundaryID & |
id | ) |
const |
|
inherited |
Test if the supplied boundary ids are valid for this object.
- Parameters
-
- Returns
- True if the given id is valid for this object
Definition at line 214 of file BoundaryRestrictable.C.
◆ hasBoundary() [2/5]
bool BoundaryRestrictable::hasBoundary |
( |
const BoundaryName & |
name | ) |
const |
|
inherited |
◆ hasBoundary() [3/5]
Test if the supplied set of boundary ids are valid for this object.
- Parameters
-
ids | A std::set of BoundaryIDs to check |
type | A 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.
242 return std::includes(
_bnd_ids.begin(),
_bnd_ids.end(), ids.begin(), ids.end());
248 for (
const auto &
id : ids)
◆ hasBoundary() [4/5]
Test if the supplied vector boundary ids are valid for this object.
- Parameters
-
ids | A vector of BoundaryIDs ids to check |
type | A 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.
225 std::set<BoundaryID> ids_set(ids.begin(), ids.end());
◆ 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
-
names | A vector of BoundaryNames to check |
- Returns
- True if the given ids are valid for this object
Definition at line 208 of file BoundaryRestrictable.C.
◆ 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
-
T | The type of material property |
- Parameters
-
prop_name | the 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.
◆ 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.
297 const std::set<BoundaryID> & ids =
301 for (
const auto &
id : ids)
304 std::set<std::string> declared_props;
309 const std::vector<std::shared_ptr<MaterialBase>> & mats =
311 for (
const auto & mat : mats)
313 const std::set<std::string> & mat_props = mat->getSuppliedItems();
314 declared_props.insert(mat_props.begin(), mat_props.end());
319 if (declared_props.find(prop_name) == declared_props.end())
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.
87 mooseError(
"The input parameters must contain a pointer to FEProblem via '_fe_problem' or a "
88 "pointer to the MooseMesh via '_mesh'");
107 _blk_ids.insert(vec_ids.begin(), vec_ids.end());
114 if (!variable_name.empty())
127 "Attempted to restrict the object '",
129 "' to a block, but the object is already restricted by boundary");
142 std::vector<SubdomainID> diff;
144 std::set_difference(
_blk_ids.begin(),
148 std::back_inserter(diff));
152 std::ostringstream msg;
153 msg <<
"the following block ids do not exist on the mesh:";
154 for (
const auto &
id : diff)
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.
79 const std::string & name = moose_object->
getParamTempl<std::string>(
"_object_name");
87 mooseError(
"The input parameters must contain a pointer to FEProblemBase via '_fe_problem' or "
88 "a pointer to the MooseMesh via '_mesh'");
104 _bnd_ids.insert(vec_ids.begin(), vec_ids.end());
111 "Attempted to restrict the object '",
113 "' to a boundary, but the object is already restricted by block(s)");
125 const std::set<BoundaryID> * valid_ids;
126 const char * message_ptr =
nullptr;
131 message_ptr =
"node set";
136 message_ptr =
"side set";
139 std::vector<BoundaryID> diff;
141 std::set_difference(
_bnd_ids.begin(),
145 std::back_inserter(diff));
149 std::ostringstream msg;
150 msg <<
"the following " << message_ptr <<
" ids do not exist on the mesh:";
151 for (
const auto &
id : diff)
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.";
162 moose_object->
paramError(
"boundary", msg.str());
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.
◆ isBlockSubset() [1/2]
bool BlockRestrictable::isBlockSubset |
( |
const std::set< SubdomainID > & |
ids | ) |
const |
|
inherited |
◆ 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
-
ids | A 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.
245 std::set<SubdomainID> ids_set(ids.begin(), ids.end());
◆ 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
-
ids | A 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.
269 return std::includes(ids.begin(),
274 return std::includes(ids.begin(), ids.end(),
_bnd_ids.begin(),
_bnd_ids.end());
Referenced by BoundaryRestrictable::isBoundarySubset().
◆ isBoundarySubset() [2/2]
bool BoundaryRestrictable::isBoundarySubset |
( |
const std::vector< BoundaryID > & |
ids | ) |
const |
|
inherited |
◆ isCoupled()
bool Coupleable::isCoupled |
( |
const std::string & |
var_name, |
|
|
unsigned int |
i = 0 |
|
) |
| |
|
protectedvirtualinherited |
◆ isParamValid()
bool MooseObject::isParamValid |
( |
const std::string & |
name | ) |
const |
|
inlineinherited |
Test if the supplied parameter is valid.
- Parameters
-
name | The name of the parameter to test |
Definition at line 100 of file MooseObject.h.
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 |
◆ meshBoundaryIDs()
const std::set< BoundaryID > & BoundaryRestrictable::meshBoundaryIDs |
( |
| ) |
const |
|
inherited |
◆ mooseDeprecated()
template<typename... Args>
void MooseObject::mooseDeprecated |
( |
Args &&... |
args | ) |
const |
|
inlineinherited |
Definition at line 156 of file MooseObject.h.
Referenced by FEProblemBase::addArrayVariable(), FEProblemBase::addAuxArrayVariable(), FEProblemBase::addAuxScalarVariable(), FEProblemBase::addAuxVariable(), FEProblemBase::addScalarVariable(), FEProblemBase::addVariable(), ADFunctionPresetBC< compute_stage >::ADFunctionPresetBC(), ADPresetBC< compute_stage >::ADPresetBC(), ADPresetNodalBC< compute_stage >::ADPresetNodalBC(), FEProblemBase::advanceMultiApps(), MultiApp::appProblem(), MooseMesh::buildSideList(), ChangeOverTimestepPostprocessor::ChangeOverTimestepPostprocessor(), FEProblemBase::computeResidual(), MaterialBase::declarePropertyOlderTempl(), MaterialBase::declarePropertyOldTempl(), MooseMesh::elem(), MultiAppTransfer::execFlags(), UserForcingFunction::f(), FaceFaceConstraint< compute_stage >::FaceFaceConstraint(), FunctionDT::FunctionDT(), FunctionPresetBC::FunctionPresetBC(), RandomICBase::generateRandom(), Control::getExecuteOptions(), FEProblemBase::getNonlinearSystem(), Sampler::getSamples(), FEProblemBase::getUserObjects(), FEProblemBase::getVectorPostprocessorValue(), FEProblemBase::getVectorPostprocessorValueOld(), MatDiffusionBase< Real >::MatDiffusionBase(), NodalScalarKernel::NodalScalarKernel(), MooseMesh::node(), PercentChangePostprocessor::PercentChangePostprocessor(), PresetBC::PresetBC(), PresetNodalBC::PresetNodalBC(), Sampler::rand(), ReferenceResidualProblem::ReferenceResidualProblem(), MooseMesh::setBoundaryToNormalMap(), Exodus::setOutputDimension(), and UserForcingFunction::UserForcingFunction().
◆ mooseError()
template<typename... Args>
void MooseObject::mooseError |
( |
Args &&... |
args | ) |
const |
|
inlineinherited |
Definition at line 141 of file MooseObject.h.
143 std::ostringstream oss;
145 std::string msg = oss.str();
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 |
Definition at line 162 of file MooseObject.h.
Referenced by AStableDirk4::AStableDirk4(), ExplicitRK2::ExplicitRK2(), ExplicitTVDRK2::ExplicitTVDRK2(), ParsedMaterialHelper::functionsOptimize(), ImplicitMidpoint::ImplicitMidpoint(), LStableDirk2::LStableDirk2(), LStableDirk3::LStableDirk3(), LStableDirk4::LStableDirk4(), PNGOutput::makeMeshFunc(), MooseObject::paramInfo(), DerivativeParsedMaterialHelper::recurseDerivative(), ReferenceResidualProblem::ReferenceResidualProblem(), and FEProblemBase::setRestartFile().
◆ mooseWarning()
template<typename... Args>
void MooseObject::mooseWarning |
( |
Args &&... |
args | ) |
const |
|
inlineinherited |
Definition at line 150 of file MooseObject.h.
Referenced by CartesianMeshGenerator::CartesianMeshGenerator(), MultiAppTransfer::checkMultiAppExecuteOn(), OversampleOutput::cloneMesh(), GapValueAux::computeValue(), ElementQualityChecker::finalize(), FiniteDifferencePreconditioner::FiniteDifferencePreconditioner(), ElementSubdomainIDGenerator::generate(), MooseMesh::getBoundaryIDs(), FEProblemBase::getInterfaceMaterial(), FEProblemBase::getMaterial(), MooseMesh::getSubdomainIDs(), ReferenceResidualProblem::initialSetup(), DerivativeFunctionMaterialBase::initialSetup(), FEProblemBase::initialSetup(), AdvancedOutput::initPostprocessorOrVectorPostprocessorLists(), LeastSquaresFit::LeastSquaresFit(), MaterialVectorPostprocessor::MaterialVectorPostprocessor(), AssignElementSubdomainID::modify(), NewmarkBeta::NewmarkBeta(), NodalPatchRecovery::NodalPatchRecovery(), NonlocalIntegratedBC::NonlocalIntegratedBC(), NonlocalKernel::NonlocalKernel(), Output::Output(), MooseObject::paramWarning(), Executioner::problem(), MaterialBase::resetQpProperties(), FEProblemBase::sizeZeroes(), TransientMultiApp::solveStep(), Tecplot::Tecplot(), and Checkpoint::updateCheckpointFiles().
◆ 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.
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 |
◆ 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.
182 return (
unsigned int)
_blk_ids.size();
◆ numBoundaryIDs()
unsigned int BoundaryRestrictable::numBoundaryIDs |
( |
| ) |
const |
|
inherited |
◆ 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.
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 |
◆ parameters()
Get the parameters of the object.
- Returns
- The parameters of the object
Definition at line 76 of file MooseObject.h.
Referenced by FEProblemBase::addADJacobianInterfaceMaterial(), FEProblemBase::addADJacobianMaterial(), FEProblemBase::addADKernel(), FEProblemBase::addADResidualInterfaceMaterial(), FEProblemBase::addADResidualMaterial(), DumpObjectsProblem::addAuxKernel(), FEProblemBase::addAuxKernel(), DumpObjectsProblem::addAuxScalarKernel(), FEProblemBase::addAuxScalarKernel(), DisplacedProblem::addAuxVariable(), DumpObjectsProblem::addBoundaryCondition(), FEProblemBase::addBoundaryCondition(), DumpObjectsProblem::addConstraint(), FEProblemBase::addConstraint(), FEProblemBase::addDamper(), DumpObjectsProblem::addDGKernel(), FEProblemBase::addDGKernel(), DumpObjectsProblem::addDiracKernel(), FEProblemBase::addDiracKernel(), FEProblemBase::addDistribution(), DumpObjectsProblem::addFunction(), FEProblemBase::addFunction(), FEProblemBase::addIndicator(), DumpObjectsProblem::addInitialCondition(), FEProblemBase::addInitialCondition(), DumpObjectsProblem::addInterfaceKernel(), FEProblemBase::addInterfaceKernel(), FEProblemBase::addInterfaceMaterial(), DumpObjectsProblem::addKernel(), FEProblemBase::addKernel(), FEProblem::addLineSearch(), FEProblemBase::addMarker(), DumpObjectsProblem::addMaterial(), FEProblemBase::addMaterial(), FEProblemBase::addMaterialHelper(), FEProblemBase::addMultiApp(), DumpObjectsProblem::addNodalKernel(), FEProblemBase::addNodalKernel(), FEProblemBase::addOutput(), FEProblemBase::addPostprocessor(), FEProblemBase::addPredictor(), FEProblemBase::addSampler(), DumpObjectsProblem::addScalarKernel(), FEProblemBase::addScalarKernel(), FEProblemBase::addTimeIntegrator(), FEProblemBase::addTransfer(), FEProblemBase::addUserObject(), DisplacedProblem::addVariable(), FEProblemBase::addVectorPostprocessor(), ADPiecewiseLinearInterpolationMaterial< compute_stage >::ADPiecewiseLinearInterpolationMaterial(), AdvancedOutput::AdvancedOutput(), ADVectorFunctionDirichletBC< compute_stage >::ADVectorFunctionDirichletBC(), AnnularMesh::AnnularMesh(), AnnularMeshGenerator::AnnularMeshGenerator(), assemble_l2(), Moose::assemble_matrix(), AuxKernelTempl< ComputeValueType >::AuxKernelTempl(), AuxScalarKernel::AuxScalarKernel(), BoundsAux::BoundsAux(), LibmeshPartitioner::clone(), OversampleOutput::cloneMesh(), Moose::compute_bounds(), Moose::compute_jacobian(), Moose::compute_nearnullspace(), Moose::compute_nullspace(), Moose::compute_postcheck(), Moose::compute_transpose_nullspace(), Console::Console(), DumpObjectsProblem::deduceNecessaryParameters(), DumpObjectsProblem::dumpObjectHelper(), EigenProblem::EigenProblem(), Eigenvalue::Eigenvalue(), Exodus::Exodus(), FEProblem::FEProblem(), GapValueAux::GapValueAux(), MooseObject::getCheckedPointerParam(), GhostingUserObject::GhostingUserObject(), MooseMesh::init(), BlockRestrictable::initializeBlockRestrictable(), FEProblemBase::initNullSpaceVectors(), InterfaceKernelTempl< T >::InterfaceKernelTempl(), isValid(), LayeredSideIntegral::LayeredSideIntegral(), MooseVariableInterface< Real >::MooseVariableInterface(), NodeFaceConstraint::NodeFaceConstraint(), PatchMeshGenerator::PatchMeshGenerator(), PenetrationAux::PenetrationAux(), PiecewiseBilinear::PiecewiseBilinear(), PiecewiseLinearInterpolationMaterial::PiecewiseLinearInterpolationMaterial(), MultiAppProjectionTransfer::projectSolution(), RandomIC::RandomIC(), InputParameterWarehouse::removeInputParameters(), EigenProblem::scaleEigenvector(), FEProblem::setInputParametersFEProblem(), FEProblemBase::setInputParametersFEProblem(), DumpObjectsProblem::stringifyParameters(), Transient::Transient(), VectorBodyForce::VectorBodyForce(), VectorFunctionDirichletBC::VectorFunctionDirichletBC(), and VectorFunctionIC::VectorFunctionIC().
◆ 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.
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.
Referenced by Executioner::Executioner().
◆ registerRestartableDataOnApp()
◆ registerRestartableNameWithFilterOnApp()
◆ restricted()
bool BoundaryRestrictable::restricted |
( |
const std::set< BoundaryID > & |
ids | ) |
|
|
staticinherited |
◆ setCZeroVertices() [1/2]
set the temporary solution vector for node projections of C0 variables
Definition at line 284 of file InitialConditionTempl.C.
288 libmesh_assert(
_nc == 1);
◆ setCZeroVertices() [2/2]
◆ setHermiteVertices() [1/2]
set the temporary solution vector for node projections of Hermite variables
Definition at line 334 of file InitialConditionTempl.C.
351 nxminus(0) -= TOLERANCE;
352 nxplus(0) += TOLERANCE;
378 nyminus(1) -= TOLERANCE;
379 nyplus(1) += TOLERANCE;
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;
◆ setHermiteVertices() [2/2]
◆ setOtherCOneVertices() [1/2]
set the temporary solution vector for node projections of non-Hermitian C1 variables
Definition at line 422 of file InitialConditionTempl.C.
427 libmesh_assert(
_nc == 1 +
_dim);
433 for (
unsigned int i = 0; i !=
_dim; ++i)
◆ setOtherCOneVertices() [2/2]
◆ 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.
61 typename std::vector<T>::iterator start = vector.begin();
62 typename std::vector<T>::iterator end = vector.end();
64 for (
typename std::vector<T>::iterator iter = start; iter != end; ++iter)
66 const std::set<std::string> & requested_items = (*iter)->getRequestedItems();
68 for (
typename std::vector<T>::iterator iter2 = start; iter2 != end; ++iter2)
73 const std::set<std::string> & supplied_items = (*iter2)->getSuppliedItems();
75 std::set<std::string> intersect;
76 std::set_intersection(requested_items.begin(),
77 requested_items.end(),
78 supplied_items.begin(),
80 std::inserter(intersect, intersect.end()));
83 if (!intersect.empty())
89 std::stable_sort(start, end, resolver);
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.
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
-
name | the name of the variable |
fn_name | The name of the function that called this method - used in the error message |
Definition at line 1336 of file Coupleable.C.
1342 "\" on variable \"",
1344 "\" when using a \"Steady\" executioner is not allowed. This value is available "
1345 "only in transient simulations.");
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()
Definition at line 18 of file VectorConstantIC.C.
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");
◆ value()
RealVectorValue VectorConstantIC::value |
( |
const Point & |
p | ) |
|
|
overridevirtual |
◆ variable()
template<typename T >
|
inlineoverridevirtualinherited |
◆ 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_name | Name of coupled variable |
comp | Component 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.
479 return const_cast<VariableValue &>(
coupledValue(var_name, comp));
◆ _ad_default_gradient
◆ _ad_default_second
◆ _ad_default_value
std::unordered_map<std::string, std::unique_ptr<MooseArray<DualReal> > > Coupleable::_ad_default_value |
|
protectedinherited |
◆ _ad_default_vector_gradient
◆ _ad_default_vector_value
◆ _ad_grad_zero
◆ _ad_second_zero
◆ _ad_zero
◆ _app
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
◆ _blk_dual_restrictable
const bool BlockRestrictable::_blk_dual_restrictable |
|
privateinherited |
◆ _blk_feproblem
◆ _blk_ids
◆ _blk_material_data
std::shared_ptr<MaterialData> BlockRestrictable::_blk_material_data |
|
protectedinherited |
◆ _blk_mesh
◆ _blk_name
const std::string& BlockRestrictable::_blk_name |
|
privateinherited |
◆ _blk_tid
◆ _block_ids
const std::set<SubdomainID>& BoundaryRestrictable::_block_ids |
|
privateinherited |
◆ _blocks
std::vector<SubdomainName> BlockRestrictable::_blocks |
|
privateinherited |
◆ _bnd_dual_restrictable
const bool BoundaryRestrictable::_bnd_dual_restrictable |
|
privateinherited |
◆ _bnd_feproblem
◆ _bnd_ids
std::set<BoundaryID> BoundaryRestrictable::_bnd_ids |
|
privateinherited |
◆ _bnd_material_data
std::shared_ptr<MaterialData> BoundaryRestrictable::_bnd_material_data |
|
privateinherited |
◆ _bnd_mesh
◆ _bnd_nodal
bool BoundaryRestrictable::_bnd_nodal |
|
privateinherited |
◆ _bnd_tid
◆ _boundary_ids
const std::set<BoundaryID>& BlockRestrictable::_boundary_ids |
|
privateinherited |
◆ _boundary_names
std::vector<BoundaryName> BoundaryRestrictable::_boundary_names |
|
privateinherited |
◆ _c_coupled_scalar_vars
std::unordered_map<std::string, std::vector<MooseVariableScalar *> > Coupleable::_c_coupled_scalar_vars |
|
privateinherited |
◆ _c_fe_problem
◆ _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 |
True if we provide coupling to nodal values.
Definition at line 876 of file Coupleable.h.
Referenced by Coupleable::adCoupledDotTemplate(), Coupleable::adCoupledNodalValueTemplate(), Coupleable::adCoupledValueTemplate(), Coupleable::adCoupledVectorDotTemplate(), Coupleable::adCoupledVectorValueTemplate(), Coupleable::checkFuncType(), Coupleable::checkVar(), Coupleable::coupledArrayDot(), Coupleable::coupledArrayDotDot(), Coupleable::coupledArrayDotDotOld(), Coupleable::coupledArrayDotOld(), Coupleable::coupledArrayValue(), Coupleable::coupledArrayValueOld(), Coupleable::coupledArrayValueOlder(), Coupleable::coupledDot(), Coupleable::coupledDotDot(), Coupleable::coupledDotDotDu(), Coupleable::coupledDotDotOld(), Coupleable::coupledDotDu(), Coupleable::coupledDotOld(), Coupleable::coupledMatrixTagValue(), Coupleable::coupledValue(), Coupleable::coupledValueOld(), Coupleable::coupledValueOlder(), Coupleable::coupledValuePreviousNL(), Coupleable::coupledVectorTagValue(), and Coupleable::getVectorVar().
◆ _c_parameters
◆ _c_tid
◆ _console
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
◆ _coord_sys
◆ _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
◆ _coupled_moose_vars
Vector of all coupled variables.
Definition at line 864 of file Coupleable.h.
Referenced by Coupleable::Coupleable(), ElementValueSampler::ElementValueSampler(), SideValueSampler::execute(), ElementValueSampler::execute(), PointSamplerBase::execute(), Coupleable::getCoupledMooseVars(), MatDiffusionBase< Real >::MatDiffusionBase(), MaterialDerivativeTestKernelBase< Real >::MaterialDerivativeTestKernelBase(), NodalValueSampler::NodalValueSampler(), PointSamplerBase::PointSamplerBase(), and SideValueSampler::SideValueSampler().
◆ _coupled_standard_moose_vars
std::vector<MooseVariable *> Coupleable::_coupled_standard_moose_vars |
|
protectedinherited |
◆ _coupled_vars
◆ _coupled_vector_moose_vars
◆ _current_dof
◆ _current_elem
◆ _current_node
◆ _default_array_curl
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
◆ _default_array_value
◆ _default_array_value_zero
◆ _default_gradient
◆ _default_second
◆ _default_value
std::unordered_map<std::string, std::vector<std::unique_ptr<VariableValue> > > Coupleable::_default_value |
|
protectedinherited |
◆ _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.
Definition at line 904 of file Coupleable.h.
Referenced by Coupleable::Coupleable(), Coupleable::coupledDot(), Coupleable::coupledDotDot(), Coupleable::coupledDotDotDu(), Coupleable::coupledDotDotOld(), Coupleable::coupledDotDu(), Coupleable::coupledDotOld(), Coupleable::coupledNodalDotDot(), Coupleable::coupledNodalDotDotOld(), Coupleable::coupledNodalDotOld(), Coupleable::coupledVectorDotDotDu(), and Coupleable::coupledVectorDotDu().
◆ _default_vector_curl
◆ _default_vector_gradient
◆ _default_vector_value
std::unordered_map<std::string, std::unique_ptr<VectorVariableValue> > Coupleable::_default_vector_value |
|
protectedinherited |
◆ _default_vector_value_zero
◆ _depend_uo
std::set<std::string> InitialConditionBase::_depend_uo |
|
protectedinherited |
◆ _depend_vars
std::set<std::string> InitialConditionBase::_depend_vars |
|
protectedinherited |
◆ _dim
◆ _dof_indices
◆ _dof_is_fixed
◆ _dphi
◆ _empty_block_ids
const std::set<SubdomainID> BoundaryRestrictable::_empty_block_ids |
|
privateinherited |
◆ _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 |
◆ _Fe
◆ _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
◆ _fe_type
◆ _fni_feproblem
◆ _fni_params
◆ _fni_tid
◆ _free_dof
◆ _free_dofs
◆ _grad_zero
◆ _ignore_uo_dependency
const bool InitialConditionBase::_ignore_uo_dependency |
|
protectedinherited |
◆ _JxW
◆ _Ke
◆ _mesh
std::shared_ptr<MooseMesh>& ElementIDInterface::_mesh |
|
privateinherited |
◆ _n
◆ _n_nodes
◆ _n_qp
◆ _name
const std::string& MooseObject::_name |
|
protectedinherited |
The name of this object, reference to value stored in InputParameters.
Definition at line 178 of file MooseObject.h.
Referenced by ADPiecewiseLinearInterpolationMaterial< compute_stage >::ADPiecewiseLinearInterpolationMaterial(), PiecewiseBase::buildFromFile(), PiecewiseBase::buildFromXY(), PiecewiseLinearBase::buildInterpolation(), CentroidMultiApp::fillPositions(), MultiApp::fillPositions(), FunctionDT::FunctionDT(), MooseObject::name(), PiecewiseBilinear::parse(), PiecewiseBase::PiecewiseBase(), PiecewiseBilinear::PiecewiseBilinear(), PiecewiseLinearInterpolationMaterial::PiecewiseLinearInterpolationMaterial(), DerivativeParsedMaterialHelper::recurseDerivative(), PiecewiseBase::setData(), Split::setup(), and VectorPostprocessorFunction::VectorPostprocessorFunction().
◆ _nc
◆ _obj
◆ _obj_parameters
◆ _optional_var_index
std::unordered_map<std::string, std::vector<unsigned int> > Coupleable::_optional_var_index |
|
privateinherited |
◆ _pars
Parameters of this object, references the InputParameters stored in the InputParametersWarehouse.
Definition at line 169 of file MooseObject.h.
Referenced by GridPartitioner::_do_partition(), BreakMeshByBlockGeneratorBase::BreakMeshByBlockGeneratorBase(), PNGOutput::calculateRescalingValues(), BreakMeshByBlockBase::checkInputParameter(), RandomPartitioner::clone(), PetscExternalPartitioner::clone(), BlockWeightedPartitioner::clone(), GridPartitioner::clone(), Console::Console(), Eigenvalue::execute(), Executioner::Executioner(), FEProblemSolve::FEProblemSolve(), FunctionMaterialBase::FunctionMaterialBase(), ParsedMaterialHelper::functionParse(), ExtraNodesetGenerator::generate(), MooseObject::getParamTempl(), GeneralUserObject::getPostprocessorValue(), InitialConditionBase::getUserObjectBase(), InitialConditionBase::getUserObjectTempl(), GeneralUserObject::getVectorPostprocessorValue(), Transient::init(), AdvancedOutput::initExecutionTypes(), Console::initialSetup(), MooseObject::isParamValid(), AddExtraNodeset::modify(), MooseObject::paramErrorMsg(), MooseObject::parameters(), MooseMesh::setPartitionerHelper(), and Transient::setupTimeIntegrator().
◆ _phi
◆ _qp
The current quadrature point, contains the "nth" node number when visiting nodes.
Definition at line 143 of file InitialConditionTempl.h.
◆ _restartable_app
◆ _restartable_name
std::string Restartable::_restartable_name |
|
privateinherited |
◆ _restartable_system_name
std::string Restartable::_restartable_system_name |
|
privateinherited |
◆ _restartable_tid
◆ _second_phi_zero
Zero second derivative of a test function.
Definition at line 933 of file Coupleable.h.
◆ _second_zero
◆ _side_dofs
◆ _supplied_vars
std::set<std::string> InitialConditionBase::_supplied_vars |
|
protectedinherited |
◆ _sys
◆ _t
◆ _tid
◆ _type
const std::string& MooseObject::_type |
|
protectedinherited |
◆ _Ue
◆ _uoi_feproblem
◆ _uoi_params
◆ _uoi_tid
◆ _var
◆ _vector_curl_zero
Zero value of the curl of a vector variable.
Definition at line 937 of file Coupleable.h.
◆ _vector_zero
Zero value of a vector variable.
Definition at line 935 of file Coupleable.h.
◆ _x_value
const Real VectorConstantIC::_x_value |
|
protected |
◆ _xyz_values
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 |
◆ _z_value
const Real VectorConstantIC::_z_value |
|
protected |
◆ _zero
The documentation for this class was generated from the following files:
const FieldVariableValue & slnPreviousNL() const
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.
const DoFValue & dofValuesDotOld()
void insert(NumericVector< Number > &residual) override
Set the current local DOF values to the input vector.
MooseMesh * _blk_mesh
Pointer to Mesh.
const VariableValue & _zero
Zero value of a variable.
const bool _bnd_dual_restrictable
Flag for allowing dual restriction with BlockRestrictable.
const std::map< BoundaryID, std::vector< std::shared_ptr< T > > > & getActiveBoundaryObjects(THREAD_ID tid=0) const
const FieldVariableValue & slnOld() const
const MaterialWarehouse & getMaterialWarehouse() const
std::vector< MooseVariable * > _coupled_standard_moose_vars
Vector of standard coupled variables.
std::vector< dof_id_type > _dof_indices
The global DOF indices.
virtual MooseMesh & mesh()
ArrayMooseVariable * getArrayVar(const std::string &var_name, unsigned int comp)
Extract pointer to a coupled array variable.
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".
void mooseInfo(Args &&... args) const
const VariableValue & duDotDotDu() const
bool needThreadedCopy(const UserObject &uo) const
Check if the threaded copy of the user object is needed.
const FieldVariableCurl & curlSlnOldNeighbor() const
std::vector< VectorMooseVariable * > _coupled_vector_moose_vars
Vector of vector coupled variables.
void mooseStreamAll(std::ostringstream &ss)
All of the following are not meant to be called directly - they are called by the normal macros (moos...
const InputParameters & _c_parameters
const InputParameters & _obj_parameters
Reference to the object's input parameters.
Real dotHelper(const RealGradient &op1, const RealGradient &op2)
Helps perform multiplication of GradientTypes: a normal dot product for vectors and a contraction for...
const FieldVariableCurl & curlSlnNeighbor() const
neighbor solution curls
const FieldVariableGradient & gradSlnPreviousNLNeighbor() const
void mooseError(Args &&... args) const
std::set< std::string > _supplied_vars
Supplied variables.
const FieldVariableSecond & secondSlnOldNeighbor() const
bool isParamValid(const std::string &name) const
Test if the supplied parameter is valid.
const std::string & _type
The type of this object (the Class name)
const std::set< SubdomainID > & _block_ids
Reference to the block_ids, defaults to an empty set if not provided.
THREAD_ID _uoi_tid
Thread ID.
std::string _restartable_name
The name of the object.
const InputParameters & _fni_params
Parameters of the object with this interface.
FEProblemBase & _fni_feproblem
Reference to FEProblemBase instance.
const FieldVariableCurl & curlSln() const
element curls
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...
std::unordered_map< std::string, std::vector< MooseVariableFEBase * > > _coupled_vars
Coupled vars whose values we provide.
const FieldVariableSecond & secondSlnOld() const
virtual const std::set< SubdomainID > & activeSubdomains() const =0
The subdomains the variable is active on.
const DoFValue & dofValuesOlderNeighbor()
void setHermiteVertices()
set the temporary solution vector for node projections of Hermite variables
VectorVariableCurl _default_vector_curl
This will always be zero because the default values for optionally coupled variables is always consta...
std::vector< SubdomainID > getSubdomainIDs(const std::vector< SubdomainName > &subdomain_name) const
Get the associated subdomainIDs for the subdomain names that are passed in.
const FieldVariableGradient & gradSlnDot() const
element gradient dots
bool _c_is_implicit
True if implicit value is required.
void checkFuncType(const std::string var_name, VarType t, FuncAge age)
const FieldVariableValue & sln() const
element solutions
const FieldVariableSecond & secondSlnOlderNeighbor() const
const DoFValue & nodalVectorTagValue(TagID tag)
MetaPhysicL::DualNumber< T, D > abs(const MetaPhysicL::DualNumber< T, D > &in)
const DoFValue & dofValuesOlder()
const bool _blk_dual_restrictable
Flag for allowing dual restriction.
const OutputType & nodalValuePreviousNLNeighbor()
const DoFValue & dofValuesDotNeighbor()
std::vector< ArrayMooseVariable * > _coupled_array_moose_vars
Vector of array coupled variables.
void choleskySolve(bool is_volume)
Perform the cholesky solves for edge, side, and interior projections.
void needsPreviousNewtonIteration(bool state)
Set a flag that indicated that user required values for the previous Newton iterate.
DenseMatrix< Real > _Ke
Matrix storage member.
const FieldVariableSecond & secondSlnNeighbor() const
neighbor solution seconds
RestartableDataValue & registerRestartableDataOnApp(const std::string &name, std::unique_ptr< RestartableDataValue > data, THREAD_ID tid)
Helper function for actually registering the restartable data.
const virtual std::set< SubdomainID > & blockIDs() const
Return the block subdomain ids for this object.
std::set< BoundaryID > _bnd_ids
Set of the boundary ids.
dof_id_type _free_dofs
The number of free dofs.
MooseVariableFEBase * getFEVar(const std::string &var_name, unsigned int comp)
Extract pointer to a base finite element coupled variable.
MaterialBase objects are special in that they have additional objects created automatically (see FEPr...
virtual bool blockRestricted() const
Returns true if this object has been restricted to a boundary.
const FieldVariableValue & uDotDot() const
const FieldVariableSecond & secondSlnOlder() const
const std::vector< std::vector< GradientShapeType > > * _dphi
pointers to shape function gradients
std::shared_ptr< MaterialData > _blk_material_data
Pointer to the MaterialData class for this object.
const SubdomainID ANY_BLOCK_ID
virtual void prepareIC() override
Prepare the initial condition.
const FieldVariableGradient & gradSlnNeighbor() const
neighbor solution gradients
const InputParameters & parameters() const
Get the parameters of the object.
const FieldVariableValue & uDot() const
element dots
static bool restricted(const std::set< BoundaryID > &ids)
Helper for determining if the object is boundary restricted.
bool hasActiveBoundaryObjects(THREAD_ID tid=0) const
OutputTools< T >::OutputData DataType
bool _c_nodal
True if we provide coupling to nodal values.
T & getUserObjectTempl(const std::string &name, unsigned int tid=0) const
Get the user object by its name.
bool _bnd_nodal
Whether or not this object is restricted to nodesets.
const std::vector< dof_id_type > & dofIndices() const final
Get local DoF indices.
const bool & _enabled
Reference to the "enable" InputParaemters, used by Controls for toggling on/off MooseObjects.
FEContinuity _cont
The type of continuity, e.g. C0, C1.
FEProblemBase * _blk_feproblem
Pointer to FEProblemBase.
void mooseInfoStream(S &oss, Args &&... args)
VectorValue< Real > RealVectorValue
virtual T value(const Point &p)=0
The value of the variable at a point.
const FieldVariableSecond & secondSlnPreviousNLNeighbor() const
virtual void computeNodalValues() override
Compute nodal values of this variable.
const std::set< BoundaryID > & meshSidesetIds() const
Returns a read-only reference to the set of sidesets currently present in the Mesh.
std::unordered_map< std::string, std::vector< MooseVariableScalar * > > _c_coupled_scalar_vars
Scalar variables coupled into this object (for error checking)
T gradientComponent(GradientType grad, unsigned int i)
MooseVariable * getVar(const std::string &var_name, unsigned int comp)
Extract pointer to a coupled variable.
std::set< TagID > _fe_coupleable_vector_tags
const DoFValue & dofValuesOld()
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.
OutputTools< RealEigenVector >::VariableValue ArrayVariableValue
const VariableValue & duDotDotDuNeighbor() const
const OutputType & nodalValueDot()
bool hasBoundaryMaterialPropertyHelper(const std::string &prop_name) const
A helper method to avoid circular #include problems.
unsigned int _n
node counter
const FieldVariableGradient & gradSlnPreviousNL() const
std::string stringify(const T &t)
conversion to string
const OutputType & nodalValueNeighbor()
void paramError(const std::string ¶m, Args... args) const
Emits an error prefixed with the file and line number of the given param (from the input file) along ...
const ConsoleStream _console
An instance of helper class to write streams to the Console objects.
std::vector< int > _free_dof
Stores the ids of the free dofs.
void mooseError(Args &&... args)
Emit an error message with the given stringified, concatenated args and terminate the application.
const virtual std::set< BoundaryID > & boundaryIDs() const
Return the boundary IDs for this object.
const VariableGradient & _grad_zero
Zero gradient of a variable.
SystemBase & _sys
The system object.
const UserObject & getUserObjectBase(const std::string &name) const
Get the user object by its name.
void choleskyAssembly(bool is_volume)
Assemble a small local system for cholesky solve.
const VariableValueType< OutputType, compute_stage >::type & adUDotNeighbor() const
std::shared_ptr< MooseMesh > & _mesh
References to the mesh and displaced mesh (currently in the ActionWarehouse)
const FieldVariableGradient & gradSlnNeighborDotDot() const
VectorVariableValue * getDefaultVectorValue(const std::string &var_name)
Helper method to return (and insert if necessary) the default value for an uncoupled vector variable.
MooseArray< DualRealTensorValue > _ad_default_vector_gradient
This will always be zero because the default values for optionally coupled vector variables is always...
virtual NumericVector< Number > & solution()=0
THREAD_ID _blk_tid
Thread id for this object.
const VariableSecondType< OutputType, compute_stage >::type & adSecondSlnNeighbor() const
const FieldVariableGradient & gradSlnOlderNeighbor() const
const DoFValue & dofValues()
const BoundaryID ANY_BOUNDARY_ID
void mooseDeprecatedStream(S &oss, bool expired, Args &&... args)
bool _coupleable_neighbor
Whether or not this object is a "neighbor" object: ie all of it's coupled values should be neighbor v...
void mooseWarning(Args &&... args)
Emit a warning message with the given stringified, concatenated args.
static PetscErrorCode Vec x
const FieldVariableGradient & gradSln() const
element gradients
FEProblemBase * _bnd_feproblem
Pointer to FEProblemBase.
const FieldVariableGradient & gradSlnOldNeighbor() const
std::unordered_map< std::string, std::unique_ptr< VectorVariableValue > > _default_vector_value
Will hold the default value for optional vector coupled variables.
std::shared_ptr< MaterialData > getMaterialData(Moose::MaterialDataType type, THREAD_ID tid=0)
Generic class for solving transient nonlinear problems.
const DoFValue & dofValuesDotDot()
std::set< std::string > _depend_uo
Depend UserObjects.
virtual bool isTransient() const override
void setDofValue(const OutputData &value, unsigned int index)
unsigned int count() const
Get the number of components Note: For standard and vector variables, the number is one.
std::string paramErrorPrefix(const InputParameters ¶ms, const std::string ¶m)
Generates a canonical paramError prefix for param-related error/warning/info messages.
const DoFValue & dofValuesPreviousNL()
virtual Moose::CoordinateSystemType getCoordSystem(SubdomainID sid) override
std::set< TagID > _fe_coupleable_matrix_tags
const FieldVariableValue & vectorTagValue(TagID tag)
bool isBoundarySubset(const std::set< BoundaryID > &ids) const
Test if the class boundary ids are a subset of the supplied objects.
void addFEVariableCoupleableVectorTag(TagID tag)
const MooseArray< DualRealVectorValue > & _ad_grad_zero
const std::set< BoundaryID > & meshBoundaryIDs() const
Returns the set of all boundary ids for the entire mesh.
void setCZeroVertices()
set the temporary solution vector for node projections of C0 variables
void reinitNode() override
std::vector< MooseVariableFEBase * > _coupled_moose_vars
Vector of all coupled variables.
std::vector< unsigned int > _side_dofs
Side/edge DOF indices.
VariableSecond _default_second
This will always be zero because the default values for optionally coupled variables is always consta...
const VariableSecond & _second_zero
Zero second derivative of a variable.
const MooseArray< Number > & dofValuesDuDotDu()
bool isBlockSubset(const std::set< SubdomainID > &ids) const
Test if the class block ids are a subset of the supplied objects.
const VariableValueType< OutputType, compute_stage >::type & adSln() const
AD.
unsigned int _coupleable_max_qps
Maximum qps for any element in this system.
const FieldVariableGradient & gradSlnOlder() const
FEProblemBase & _c_fe_problem
const FieldVariableSecond & secondSlnPreviousNL() const
const MooseArray< DualReal > & _ad_zero
void setNodalValue(const OutputType &value, unsigned int idx=0)
Set nodal value.
const std::set< SubdomainID > & getNodeBlockIds(const Node &node) const
Return list of blocks to which the given node belongs.
const DoFValue & dofValuesDot()
const VariableValueType< OutputType, compute_stage >::type & adSlnNeighbor() const
neighbor AD
const DoFValue & dofValuesNeighbor()
const FieldVariableGradient & gradSlnDotDot() const
const OutputType & nodalValuePreviousNL()
virtual void coupledCallback(const std::string &, bool)
A call-back function provided by the derived object for actions before coupling a variable with funct...
const UserObject & getUserObjectBase(const std::string &name)
Get an user object with a given parameter name.
unsigned int _dim
the mesh dimension
const FieldVariableValue & uDotOld() const
const FieldVariableCurl & curlSlnOld() const
const FieldVariableValue & uDotDotOldNeighbor() const
const FieldVariableCurl & curlSlnOlderNeighbor() const
const T & getParamTempl(const std::string &name) const
Retrieve a parameter for the object.
virtual const VariableValue & coupledValue(const std::string &var_name, unsigned int comp=0)
Returns value of a coupled variable.
RestartableDataValue & registerRestartableData(const std::string &name, std::unique_ptr< RestartableDataValue > data, THREAD_ID tid, bool mesh_meta_data, bool read_only)
const DoFValue & dofValuesDotDotOldNeighbor()
MooseVariableFE< T > & _var
The variable that this initial condition is acting upon.
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.
const std::vector< Real > * _JxW
pointers to the Jacobian * quadrature weights for current element
static InputParameters validParams()
VariableValue _default_value_zero
This will always be zero because the default values for optionally coupled variables is always consta...
void callMooseErrorRaw(std::string &msg, MooseApp *app)
const std::map< SubdomainID, std::vector< std::shared_ptr< T > > > & getActiveBlockObjects(THREAD_ID tid=0) const
void addFEVariableCoupleableMatrixTag(TagID tag)
VariableGradient _default_gradient
This will always be zero because the default values for optionally coupled variables is always consta...
VectorVariableGradient _default_vector_gradient
This will always be zero because the default values for optionally coupled variables is always consta...
const VariableGradientType< OutputType, compute_stage >::type & adGradSlnNeighbor() const
const std::set< BoundaryID > & meshBoundaryIds() const
Returns a read-only reference to the set of boundary IDs currently present in the Mesh.
std::vector< SubdomainName > _blocks
Vector the block names supplied by the user via the input file.
std::set< std::string > _depend_vars
Dependent variables.
unsigned int _qp
The current quadrature point, contains the "nth" node number when visiting nodes.
const OutputType & nodalValueOlder()
const FieldVariableGradient & gradSlnNeighborDot() const
neighbor grad dots
MooseArray< DualRealVectorValue > _ad_default_gradient
This will always be zero because the default values for optionally coupled variables is always consta...
virtual GradientType gradient(const Point &)
The gradient of the variable at a point.
const std::vector< std::vector< ValueType > > * _phi
pointers to shape functions
const std::set< SubdomainID > & meshSubdomains() const
Returns a read-only reference to the set of subdomains currently present in the Mesh.
bool hasActiveBlockObjects(THREAD_ID tid=0) const
FEProblemBase & _uoi_feproblem
Reference to the FEProblemBase instance.
const MooseArray< Number > & dofValuesDuDotDuNeighbor()
virtual bool isCoupled(const std::string &var_name, unsigned int i=0)
Returns true if a variables has been coupled as name.
std::vector< char > _dof_is_fixed
Whether the degree of freedom is fixed (true/false)
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.
std::shared_ptr< MaterialData > _bnd_material_data
Pointer to MaterialData for boundary (.
std::unordered_map< std::string, std::vector< std::unique_ptr< VariableValue > > > _default_value
Will hold the default value for optional coupled variables.
const FieldVariableValue & slnOlderNeighbor() const
VectorVariableValue _default_vector_value_zero
This will always be zero because the default values for optionally coupled variables is always consta...
const VariableValue & duDotDu() const
const FieldVariableValue & slnOldNeighbor() const
InitialConditionTempl< RealVectorValue > VectorInitialCondition
dof_id_type _nc
number of dofs per node per variable
bool isNodal() const override
Is this variable nodal.
const std::set< BoundaryID > & meshNodesetIds() const
Returns a read-only reference to the set of nodesets currently present in the Mesh.
std::vector< BoundaryName > _boundary_names
Vector the the boundary names.
const OutputType & nodalValue()
Methods for retrieving values of variables at the nodes.
const FieldVariableGradient & gradSlnOld() const
const FieldVariableValue & slnNeighbor() const
neighbor solutions
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.
SystemBase & sys()
Get the system this variable is part of.
virtual Function & getFunction(const std::string &name, THREAD_ID tid=0)
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.
std::map< std::string, ArrayVariableValue * > _default_array_value
Will hold the default value for optional array coupled variables.
const VariableSecondType< OutputType, compute_stage >::type & adSecondSln() const
const OutputType & nodalValueOldNeighbor()
const std::multimap< T, T > & getCyclicDependencies() const
RealType< compute_stage >::type type
const DoFValue & nodalMatrixTagValue(TagID tag)
bool hasBlocks(const SubdomainName &name) const
Test if the supplied block name is valid for this object.
std::set< SubdomainID > _blk_ids
Set of block ids supplied by the user via the input file (for error reporting)
OutputTools< T >::OutputGradient GradientType
const MooseArray< DualRealTensorValue > & _ad_second_zero
std::unordered_map< std::string, std::vector< unsigned int > > _optional_var_index
Unique indices for optionally coupled vars that weren't provided.
MooseApp & _restartable_app
Reference to the application.
THREAD_ID _restartable_tid
The thread ID for this object.
void checkComponent(const MooseObject *obj, unsigned int comp, unsigned int bound, const std::string &var_name)
const UserObject & getUserObjectBaseByName(const std::string &name)
Get an user object with a given name.
const FieldVariableCurl & curlSlnOlder() const
const std::vector< Point > * _xyz_values
pointers to the xyz coordinates of the quadrature points for the current element
bool show_trace
Set to true (the default) to print the stack trace with error and warning messages - false to omit it...
const FieldVariableValue & matrixTagValue(TagID tag)
const THREAD_ID _fni_tid
Thread ID.
dof_id_type _current_dof
The current dof being operated on.
bool hasBoundary(const BoundaryName &name) const
Test if the supplied boundary name is valid for this object.
const std::string & _blk_name
Name of the object.
const Node * _current_node
The current node if the point we are evaluating at also happens to be a node.
void registerRestartableNameWithFilter(const std::string &name, Moose::RESTARTABLE_FILTER filter)
NOTE: This is an internal function meant for MOOSE use only!
MooseArray< DualRealTensorValue > _ad_default_second
This will always be zero because the default values for optionally coupled variables is always consta...
const std::string & _c_name
The name of the object this interface is part of.
ArrayVariableGradient _default_array_gradient
This will always be zero because the default values for optionally coupled variables is always consta...
const std::set< SubdomainID > & meshBlockIDs() const
Return all of the SubdomainIDs for the mesh.
const bool _ignore_uo_dependency
If set, UOs retrieved by this IC will not be executed before this IC.
const std::string & _name
The name of this object, reference to value stored in InputParameters.
const InputParameters & _pars
Parameters of this object, references the InputParameters stored in the InputParametersWarehouse.
const MooseArray< Number > & dofValuesDuDotDotDu()
const OutputType & nodalValueOlderNeighbor()
const DoFValue & dofValuesDotOldNeighbor()
void mooseWarningStream(S &oss, Args &&... args)
const VariableValueType< OutputType, compute_stage >::type & adUDot() const
const MooseArray< Number > & dofValuesDuDotDotDuNeighbor()
const FEType & _fe_type
The finite element type for the IC variable.
const DoFValue & dofValuesDotDotOld()
const FieldVariableValue & slnPreviousNLNeighbor() const
Eigen::Matrix< Real, Eigen::Dynamic, 1 > RealEigenVector
const DoFValue & dofValuesDotDotNeighbor()
const VariableGradientType< OutputType, compute_stage >::type & adGradSln() const
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.
const std::set< BoundaryID > & _boundary_ids
Reference to the boundary_ids, defaults to an empty set if not provided.
const FieldVariableValue & uDotDotOld() const
unsigned int _n_qp
The number of quadrature points for a given element.
DenseVector< DataType > _Ue
Linear solution vector.
DenseVector< DataType > _Fe
Linear b vector.
const FieldVariableValue & slnOlder() const
Concrete definition of a parameter value for a specified type.
Moose::VarKindType kind() const
Kind of the variable (Nonlinear, Auxiliary, ...)
ArrayVariableValue * getDefaultArrayValue(const std::string &var_name)
Helper method to return (and insert if necessary) the default value for an uncoupled array variable.
virtual bool hasBlockMaterialPropertyHelper(const std::string &prop_name)
A helper method to allow the Material object to specialize the behavior of hasBlockMaterialProperty.
const VariableValue & duDotDuNeighbor() const
const OutputType & nodalValueOld()
MooseApp & _app
The MooseApp this object is associated with.
VectorMooseVariable * getVectorVar(const std::string &var_name, unsigned int comp)
Extract pointer to a coupled vector variable.
const FieldVariableValue & uDotOldNeighbor() const
MooseMesh * _bnd_mesh
Point to mesh.
void setOtherCOneVertices()
set the temporary solution vector for node projections of non-Hermitian C1 variables
const FieldVariableValue & uDotNeighbor() const
neighbor dots
Class for stuff related to variables.
std::string _restartable_system_name
The system name this object is in.
const DoFValue & dofValuesOldNeighbor()
virtual MooseMesh & mesh() override
const FieldVariableValue & uDotDotNeighbor() const
void mooseWarning(Args &&... args) const
std::string paramErrorMsg(const std::string ¶m, Args... args) const
const DoFValue & dofValuesPreviousNLNeighbor()
virtual const std::string & name() const
Get the name of the object.
void registerRestartableNameWithFilterOnApp(const std::string &name, Moose::RESTARTABLE_FILTER filter)
Helper function for actually registering the restartable data.
const Elem *const & _current_elem
The current element we are on will retrieving values at specific points in the domain.
const std::string & name() const override
Get the variable name.
const FieldVariableSecond & secondSln() const
element seconds
unsigned int number() const
Get variable number coming from libMesh.
ArrayVariableValue _default_array_value_zero
This will always be zero because the default values for optionally coupled variables is always consta...