#include <DisplacedSystem.h>
Public Member Functions | |
DisplacedSystem (DisplacedProblem &problem, SystemBase &undisplaced_system, const std::string &name, Moose::VarKindType var_kind) | |
virtual | ~DisplacedSystem () |
virtual void | init () override |
Initialize the system. More... | |
virtual NumericVector< Number > & | getVector (TagID tag_id) override |
Get a raw NumericVector. More... | |
virtual const NumericVector< Number > & | getVector (TagID tag_id) const override |
Get a raw NumericVector. More... | |
virtual TagID | residualVectorTag () override |
virtual TagID | systemMatrixTag () override |
Return the Matrix Tag ID for System. More... | |
virtual TagID | timeVectorTag () override |
Ideally, we should not need this API. More... | |
virtual TagID | nonTimeVectorTag () override |
virtual void | associateVectorToTag (NumericVector< Number > &vec, TagID tag) override |
Associate a vector for a given tag. More... | |
virtual void | disassociateVectorFromTag (NumericVector< Number > &vec, TagID tag) override |
Associate a vector for a given tag. More... | |
virtual void | disassociateAllTaggedVectors () override |
Disassociate all vectors, and then hasVector() will return false. More... | |
virtual void | associateMatrixToTag (SparseMatrix< Number > &matrix, TagID tag) override |
associate a matirx to a tag More... | |
virtual void | disassociateMatrixFromTag (SparseMatrix< Number > &matrix, TagID tag) override |
disassociate a matirx from a tag More... | |
virtual void | disassociateAllTaggedMatrices () override |
Clear all tagged matrices. More... | |
virtual NumericVector< Number > & | getVector (const std::string &name) override |
Get a raw NumericVector. More... | |
virtual NumericVector< Number > & | serializedSolution () override |
Returns a reference to a serialized version of the solution vector for this subproblem. More... | |
const NumericVector< Number > *const & | currentSolution () const override |
The solution vector that is currently being operated on. More... | |
NumericVector< Number > & | solution () override |
NumericVector< Number > & | solutionOld () override |
NumericVector< Number > & | solutionOlder () override |
NumericVector< Number > * | solutionPreviousNewton () override |
const NumericVector< Number > & | solution () const override |
const NumericVector< Number > & | solutionOld () const override |
const NumericVector< Number > & | solutionOlder () const override |
const NumericVector< Number > * | solutionPreviousNewton () const override |
NumericVector< Number > * | solutionUDot () override |
NumericVector< Number > * | solutionUDotDot () override |
NumericVector< Number > * | solutionUDotOld () override |
NumericVector< Number > * | solutionUDotDotOld () override |
const NumericVector< Number > * | solutionUDot () const override |
const NumericVector< Number > * | solutionUDotDot () const override |
const NumericVector< Number > * | solutionUDotOld () const override |
const NumericVector< Number > * | solutionUDotDotOld () const override |
virtual Number & | duDotDu () override |
virtual Number & | duDotDotDu () override |
virtual const Number & | duDotDu () const override |
virtual const Number & | duDotDotDu () const override |
virtual NumericVector< Number > & | residualCopy () override |
Return the residual copy from the NonlinearSystem. More... | |
virtual NumericVector< Number > & | residualGhosted () override |
virtual void | augmentSendList (std::vector< dof_id_type > &send_list) override |
Will modify the send_list to add all of the extra ghosted dofs for this system. More... | |
virtual void | augmentSparsity (SparsityPattern::Graph &, std::vector< dof_id_type > &, std::vector< dof_id_type > &) override |
This is an empty function since the displaced system doesn't have a matrix! All sparsity pattern modification will be taken care of by the undisplaced system directly. More... | |
virtual void | addVariableToZeroOnResidual (std::string var_name) override |
Adds this variable to the list of variables to be zeroed during each residual evaluation. More... | |
virtual void | addVariableToZeroOnJacobian (std::string var_name) override |
Adds this variable to the list of variables to be zeroed during each jacobian evaluation. More... | |
virtual void | zeroVariables (std::vector< std::string > &vars_to_be_zeroed) override |
Zero out the solution for the list of variables passed in. More... | |
virtual bool | hasVector (TagID tag_id) const override |
Check if the tagged vector exists in the system. More... | |
virtual bool | hasMatrix (TagID tag_id) const override |
Check if the tagged matrix exists in the system. More... | |
virtual SparseMatrix< Number > & | getMatrix (TagID tag) override |
Get a raw SparseMatrix. More... | |
virtual const SparseMatrix< Number > & | getMatrix (TagID tag) const override |
Get a raw SparseMatrix. More... | |
virtual TransientExplicitSystem & | sys () |
virtual System & | system () override |
Get the reference to the libMesh system. More... | |
virtual const System & | system () const override |
void | addTimeIntegrator (std::shared_ptr< TimeIntegrator > ti) override |
virtual void | addTimeIntegrator (const std::string &, const std::string &, InputParameters &) |
virtual void | addTimeIntegrator (std::shared_ptr< TimeIntegrator >) |
virtual unsigned int | number () const |
Gets the number of this system. More... | |
virtual MooseMesh & | mesh () |
virtual const MooseMesh & | mesh () const |
virtual SubProblem & | subproblem () |
virtual const SubProblem & | subproblem () const |
void | applyScalingFactors (const std::vector< Real > &inverse_scaling_factors) |
Applies scaling factors to the system's variables. More... | |
bool | computingScalingJacobian () const |
Whether we are computing an initial Jacobian for automatic variable scaling. More... | |
void | computingScalingJacobian (bool computing_scaling_jacobian) |
Setter for whether we're computing the scaling jacobian. More... | |
bool | computingScalingResidual () const |
Whether we are computing an initial Residual for automatic variable scaling. More... | |
void | computingScalingResidual (bool computing_scaling_residual) |
Setter for whether we're computing the scaling residual. More... | |
virtual DofMap & | dofMap () |
Gets writeable reference to the dof map. More... | |
virtual const DofMap & | dofMap () const |
Gets const reference to the dof map. More... | |
virtual void | initializeObjects () |
Called only once, just before the solve begins so objects can do some precalculations. More... | |
virtual void | addExtraVectors () |
Method called during initialSetup to add extra system vector if they are required by the simulation. More... | |
virtual void | update () |
Update the system (doing libMesh magic) More... | |
virtual void | solve () |
Solve the system (using libMesh magic) More... | |
virtual void | copyOldSolutions () |
Shifts the solutions backwards in time. More... | |
virtual void | restoreSolutions () |
Restore current solutions (call after your solve failed) More... | |
virtual void | saveOldSolutions () |
Save the old and older solutions. More... | |
virtual void | restoreOldSolutions () |
Restore the old and older solutions when the saved solutions present. More... | |
bool | hasVector (const std::string &tag_name) const |
Check if the named vector exists in the system. More... | |
virtual TagID | timeMatrixTag () |
Return the Matrix Tag ID for Time. More... | |
virtual void | activeAllMatrixTags () |
Make all exsiting matrices ative. More... | |
virtual void | activeMatrixTag (TagID tag) |
Active a matrix for tag. More... | |
virtual bool | matrixTagActive (TagID tag) const |
If or not a matrix tag is active. More... | |
virtual void | deactiveMatrixTag (TagID tag) |
deactive a matrix for tag More... | |
virtual void | deactiveAllMatrixTags () |
Make matrices inactive. More... | |
void | closeTaggedMatrices (const std::set< TagID > &tags) |
Close all matrices associated the tags. More... | |
virtual void | addVariable (const std::string &var_type, const std::string &var_name, InputParameters ¶meters) |
Canonical method for adding a variable. More... | |
virtual bool | isArrayVariable (const std::string &var_name) const |
If a variable is an array variable. More... | |
virtual bool | isScalarVariable (unsigned int var_name) const |
MooseVariableFEBase & | getVariable (THREAD_ID tid, const std::string &var_name) |
Gets a reference to a variable of with specified name. More... | |
MooseVariableFEBase & | getVariable (THREAD_ID tid, unsigned int var_number) |
Gets a reference to a variable with specified number. More... | |
template<typename T > | |
MooseVariableFE< T > & | getFieldVariable (THREAD_ID tid, const std::string &var_name) |
Gets a reference to a variable of with specified name. More... | |
template<typename T > | |
MooseVariableFE< T > & | getFieldVariable (THREAD_ID tid, unsigned int var_number) |
Gets a reference to a variable with specified number. More... | |
virtual MooseVariableScalar & | getScalarVariable (THREAD_ID tid, const std::string &var_name) |
Gets a reference to a scalar variable with specified number. More... | |
virtual MooseVariableScalar & | getScalarVariable (THREAD_ID tid, unsigned int var_number) |
Gets a reference to a variable with specified number. More... | |
virtual const std::set< SubdomainID > * | getVariableBlocks (unsigned int var_number) |
Get the block where a variable of this system is defined. More... | |
virtual unsigned int | nVariables () const |
Get the number of variables in this system. More... | |
std::size_t | getMaxVarNDofsPerElem () const |
Gets the maximum number of dofs used by any one variable on any one element. More... | |
std::size_t | getMaxVarNDofsPerNode () const |
Gets the maximum number of dofs used by any one variable on any one node. More... | |
void | assignMaxVarNDofsPerElem (std::size_t max_dofs) |
assign the maximum element dofs More... | |
void | assignMaxVarNDofsPerNode (std::size_t max_dofs) |
assign the maximum node dofs More... | |
virtual void | zeroVariablesForResidual () |
Zero out the solution for the variables that were registered as needing to have their solutions zeroed on out on residual evaluation by a call to addVariableToZeroOnResidual() More... | |
virtual void | zeroVariablesForJacobian () |
Zero out the solution for the variables that were registered as needing to have their solutions zeroed on out on Jacobian evaluation by a call to addVariableToZeroOnResidual() More... | |
virtual Order | getMinQuadratureOrder () |
Get minimal quadrature order needed for integrating variables in this system. More... | |
virtual void | prepare (THREAD_ID tid) |
Prepare the system for use. More... | |
virtual void | prepareFace (THREAD_ID tid, bool resize_data) |
Prepare the system for use on sides. More... | |
virtual void | prepareNeighbor (THREAD_ID tid) |
Prepare the system for use. More... | |
virtual void | prepareLowerD (THREAD_ID tid) |
Prepare the system for use for lower dimensional elements. More... | |
virtual void | reinitElem (const Elem *elem, THREAD_ID tid) |
Reinit an element assembly info. More... | |
virtual void | reinitElemFace (const Elem *elem, unsigned int side, BoundaryID bnd_id, THREAD_ID tid) |
Reinit assembly info for a side of an element. More... | |
virtual void | reinitNeighborFace (const Elem *elem, unsigned int side, BoundaryID bnd_id, THREAD_ID tid) |
Compute the values of the variables at all the current points. More... | |
virtual void | reinitNeighbor (const Elem *elem, THREAD_ID tid) |
Compute the values of the variables at all the current points. More... | |
virtual void | reinitLowerD (THREAD_ID tid) |
Compute the values of the variables on the lower dimensional element. More... | |
virtual void | reinitNode (const Node *node, THREAD_ID tid) |
Reinit nodal assembly info. More... | |
virtual void | reinitNodeFace (const Node *node, BoundaryID bnd_id, THREAD_ID tid) |
Reinit nodal assembly info on a face. More... | |
virtual void | reinitNodes (const std::vector< dof_id_type > &nodes, THREAD_ID tid) |
Reinit variables at a set of nodes. More... | |
virtual void | reinitNodesNeighbor (const std::vector< dof_id_type > &nodes, THREAD_ID tid) |
Reinit variables at a set of neighbor nodes. More... | |
virtual void | reinitScalars (THREAD_ID tid, bool reinit_for_derivative_reordering=false) |
Reinit scalar varaibles. More... | |
virtual void | addVariableToCopy (const std::string &dest_name, const std::string &source_name, const std::string ×tep) |
Add info about variable that will be copied. More... | |
const std::vector< MooseVariableFEBase * > & | getVariables (THREAD_ID tid) |
const std::vector< MooseVariableScalar * > & | getScalarVariables (THREAD_ID tid) |
const std::set< SubdomainID > & | getSubdomainsForVar (unsigned int var_number) const |
virtual void | removeVector (const std::string &name) |
Remove a vector from the system with the given name. More... | |
virtual void | removeVector (TagID tag_id) |
Remove a solution length vector from the system with the specified TagID. More... | |
virtual NumericVector< Number > & | addVector (const std::string &vector_name, const bool project, const ParallelType type) |
Adds a solution length vector to the system. More... | |
NumericVector< Number > & | addVector (TagID tag, const bool project, const ParallelType type) |
Adds a solution length vector to the system with the specified TagID. More... | |
virtual void | closeTaggedVectors (const std::set< TagID > &tags) |
Close all vectors for given tags. More... | |
virtual void | zeroTaggedVectors (const std::set< TagID > &tags) |
Zero all vectors for given tags. More... | |
virtual SparseMatrix< Number > & | addMatrix (TagID) |
Adds a jacobian sized vector. More... | |
virtual void | removeMatrix (TagID) |
Removes a jacobian sized vector. More... | |
virtual const std::string & | name () const |
const std::vector< VariableName > & | getVariableNames () const |
unsigned int | getMaxVariableNumber () const |
Returns the maximum number of all variables on the system. More... | |
virtual void | computeVariables (const NumericVector< Number > &) |
void | copyVars (ExodusII_IO &io) |
virtual void | copySolutionsBackwards () |
Copy current solution into old and older. More... | |
virtual void | addTimeIntegrator (const std::string &, const std::string &, InputParameters &) |
TimeIntegrator * | getTimeIntegrator () |
const TimeIntegrator * | getTimeIntegrator () const |
std::shared_ptr< TimeIntegrator > | getSharedTimeIntegrator () |
virtual bool | hasVariable (const std::string &var_name) const |
Query a system for a variable. More... | |
virtual bool | hasScalarVariable (const std::string &var_name) const |
Protected Attributes | |
SystemBase & | _undisplaced_system |
TransientExplicitSystem & | _sys |
SubProblem & | _subproblem |
MooseApp & | _app |
Factory & | _factory |
MooseMesh & | _mesh |
std::string | _name |
The name of this system. More... | |
std::vector< VariableWarehouse > | _vars |
Variable warehouses (one for each thread) More... | |
std::map< unsigned int, std::set< SubdomainID > > | _var_map |
Map of variables (variable id -> array of subdomains where it lives) More... | |
unsigned int | _max_var_number |
Maximum variable number. More... | |
std::vector< std::string > | _vars_to_be_zeroed_on_residual |
std::vector< std::string > | _vars_to_be_zeroed_on_jacobian |
Real | _du_dot_du |
Real | _du_dotdot_du |
std::vector< NumericVector< Number > * > | _tagged_vectors |
Tagged vectors (pointer) More... | |
std::vector< SparseMatrix< Number > * > | _tagged_matrices |
Tagged matrices (pointer) More... | |
std::vector< bool > | _matrix_tag_active_flags |
Active flags for tagged matrices. More... | |
NumericVector< Real > * | _saved_old |
NumericVector< Real > * | _saved_older |
NumericVector< Real > * | _saved_dot_old |
NumericVector< Real > * | _saved_dotdot_old |
Moose::VarKindType | _var_kind |
default kind of variables in this system More... | |
std::vector< VarCopyInfo > | _var_to_copy |
size_t | _max_var_n_dofs_per_elem |
Maximum number of dofs for any one variable on any one element. More... | |
size_t | _max_var_n_dofs_per_node |
Maximum number of dofs for any one variable on any one node. More... | |
std::shared_ptr< TimeIntegrator > | _time_integrator |
Time integrator. More... | |
std::vector< std::vector< MooseVariableFEBase * > > | _numbered_vars |
Map variable number to its pointer. More... | |
MooseObjectWarehouseBase< MooseVariableBase > | _variable_warehouse |
Storage for MooseVariable objects. More... | |
bool | _computing_scaling_jacobian |
Flag used to indicate whether we are computing the scaling Jacobian. More... | |
bool | _computing_scaling_residual |
Flag used to indicate whether we are computing the scaling Residual. More... | |
Definition at line 24 of file DisplacedSystem.h.
DisplacedSystem::DisplacedSystem | ( | DisplacedProblem & | problem, |
SystemBase & | undisplaced_system, | ||
const std::string & | name, | ||
Moose::VarKindType | var_kind | ||
) |
Definition at line 18 of file DisplacedSystem.C.
|
virtual |
Definition at line 34 of file DisplacedSystem.C.
|
virtualinherited |
Make all exsiting matrices ative.
Definition at line 944 of file SystemBase.C.
Referenced by NonlinearSystemBase::computeJacobianInternal(), and NonlinearSystemBase::computeResidualTags().
|
virtualinherited |
|
virtualinherited |
Method called during initialSetup to add extra system vector if they are required by the simulation.
Reimplemented in NonlinearSystemBase, and AuxiliarySystem.
Definition at line 1062 of file SystemBase.C.
|
inlinevirtualinherited |
Adds a jacobian sized vector.
tag_name | The name of the tag |
Reimplemented in NonlinearSystem.
Definition at line 722 of file SystemBase.h.
|
inline |
Definition at line 755 of file SystemBase.h.
|
inlinevirtualinherited |
Reimplemented in NonlinearSystemBase, and AuxiliarySystem.
Definition at line 755 of file SystemBase.h.
|
overridevirtual |
Reimplemented from SystemBase.
Definition at line 51 of file DisplacedSystem.C.
Referenced by DisplacedProblem::DisplacedProblem().
|
inline |
Definition at line 761 of file SystemBase.h.
|
virtualinherited |
Canonical method for adding a variable.
var_type | the type of the variable, e.g. MooseVariableScalar |
var_name | the variable name, e.g. 'u' |
params | the InputParameters from which to construct the variable |
Reimplemented in AuxiliarySystem.
Definition at line 614 of file SystemBase.C.
Referenced by DisplacedProblem::addAuxVariable(), AuxiliarySystem::addVariable(), and DisplacedProblem::addVariable().
|
virtualinherited |
Add info about variable that will be copied.
dest_name | Name of the nodal variable being used for copying into (name is from the exodusII file) |
source_name | Name of the nodal variable being used for copying from (name is from the exodusII file) |
timestep | Timestep in the file being used |
Definition at line 991 of file SystemBase.C.
|
inlineoverridevirtual |
Adds this variable to the list of variables to be zeroed during each jacobian evaluation.
var_name | The name of the variable to be zeroed. |
Reimplemented from SystemBase.
Definition at line 180 of file DisplacedSystem.h.
|
inlineoverridevirtual |
Adds this variable to the list of variables to be zeroed during each residual evaluation.
var_name | The name of the variable to be zeroed. |
Reimplemented from SystemBase.
Definition at line 171 of file DisplacedSystem.h.
|
virtualinherited |
Adds a solution length vector to the system.
vector_name | The name of the vector. |
project | Whether or not to project this vector when doing mesh refinement. If the vector is just going to be recomputed then there is no need to project it. |
type | What type of parallel vector. This is usually either PARALLEL or GHOSTED. GHOSTED is needed if you are going to be accessing off-processor entries. The ghosting pattern is the same as the solution vector. |
Reimplemented in AuxiliarySystem.
Definition at line 543 of file SystemBase.C.
Referenced by NonlinearSystemBase::addDotVectors(), NonlinearSystemBase::addExtraVectors(), AStableDirk4::AStableDirk4(), MultiApp::createApp(), ExplicitTimeIntegrator::ExplicitTimeIntegrator(), NonlinearSystemBase::getResidualNonTimeVector(), NonlinearSystemBase::getResidualTimeVector(), FEProblemBase::initNullSpaceVectors(), LStableDirk3::LStableDirk3(), LStableDirk4::LStableDirk4(), PicardSolve::PicardSolve(), NonlinearSystemBase::residualGhosted(), and SystemBase::saveOldSolutions().
|
inherited |
Adds a solution length vector to the system with the specified TagID.
tag_name | The name of the tag |
project | Whether or not to project this vector when doing mesh refinement. If the vector is just going to be recomputed then there is no need to project it. |
type | What type of parallel vector. This is usually either PARALLEL or GHOSTED. GHOSTED is needed if you are going to be accessing off-processor entries. The ghosting pattern is the same as the solution vector. |
Definition at line 553 of file SystemBase.C.
|
inherited |
Applies scaling factors to the system's variables.
inverse_scaling_factors | A vector containing the inverse of each variable's scaling factor, e.g. 1 / scaling_factor |
Definition at line 1141 of file SystemBase.C.
Referenced by NonlinearSystem::computeScaling().
|
inlineinherited |
|
inlineinherited |
|
inlineoverridevirtual |
associate a matirx to a tag
Reimplemented from SystemBase.
Definition at line 67 of file DisplacedSystem.h.
|
inlineoverridevirtual |
Associate a vector for a given tag.
Reimplemented from SystemBase.
Definition at line 52 of file DisplacedSystem.h.
|
inlineoverridevirtual |
Will modify the send_list to add all of the extra ghosted dofs for this system.
Reimplemented from SystemBase.
Definition at line 152 of file DisplacedSystem.h.
|
inlineoverridevirtual |
This is an empty function since the displaced system doesn't have a matrix! All sparsity pattern modification will be taken care of by the undisplaced system directly.
Implements SystemBase.
Definition at line 161 of file DisplacedSystem.h.
|
inherited |
Close all matrices associated the tags.
Definition at line 874 of file SystemBase.C.
Referenced by NonlinearSystemBase::computeJacobianInternal().
|
virtualinherited |
Close all vectors for given tags.
Definition at line 577 of file SystemBase.C.
Referenced by NonlinearSystemBase::computeResidualTags().
|
inlinevirtualinherited |
Definition at line 746 of file SystemBase.h.
|
inlineinherited |
Whether we are computing an initial Jacobian for automatic variable scaling.
Definition at line 121 of file SystemBase.h.
Referenced by Assembly::addJacobianBlock(), Assembly::addJacobianBlockNonlocal(), Assembly::addJacobianNeighbor(), Assembly::cacheJacobianBlock(), VectorKernel::computeJacobian(), and Kernel::computeJacobian().
|
inlineinherited |
Setter for whether we're computing the scaling jacobian.
Definition at line 126 of file SystemBase.h.
|
inlineinherited |
Whether we are computing an initial Residual for automatic variable scaling.
Definition at line 134 of file SystemBase.h.
|
inlineinherited |
Setter for whether we're computing the scaling residual.
Definition at line 139 of file SystemBase.h.
|
virtualinherited |
Shifts the solutions backwards in time.
Definition at line 1099 of file SystemBase.C.
Referenced by EigenExecutionerBase::inversePowerIteration().
|
virtualinherited |
|
inherited |
Definition at line 999 of file SystemBase.C.
|
inlineoverridevirtual |
The solution vector that is currently being operated on.
This is typically a ghosted vector that comes in from the Nonlinear solver.
Implements SystemBase.
Definition at line 89 of file DisplacedSystem.h.
|
virtualinherited |
Make matrices inactive.
Definition at line 933 of file SystemBase.C.
Referenced by NonlinearSystemBase::computeResidualTags(), and NonlinearSystemBase::setInitialSolution().
|
virtualinherited |
|
inlineoverridevirtual |
Clear all tagged matrices.
Reimplemented from SystemBase.
Definition at line 77 of file DisplacedSystem.h.
|
inlineoverridevirtual |
Disassociate all vectors, and then hasVector() will return false.
Reimplemented from SystemBase.
Definition at line 62 of file DisplacedSystem.h.
|
inlineoverridevirtual |
disassociate a matirx from a tag
Reimplemented from SystemBase.
Definition at line 72 of file DisplacedSystem.h.
|
inlineoverridevirtual |
Associate a vector for a given tag.
Reimplemented from SystemBase.
Definition at line 57 of file DisplacedSystem.h.
|
virtualinherited |
Gets writeable reference to the dof map.
Definition at line 979 of file SystemBase.C.
Referenced by AddPeriodicBCAction::act(), SystemBase::augmentSendList(), NonlinearSystemBase::augmentSparsity(), AddPeriodicBCAction::autoTranslationBoundaries(), NonlinearSystem::computeScaling(), NonlinearSystemBase::findImplicitGeometricCouplingEntries(), Adaptivity::init(), DisplacedProblem::init(), PNGOutput::makeMeshFunc(), GhostingUserObject::meshChanged(), TableOutput::outputScalarVariables(), Nemesis::outputScalarVariables(), and Exodus::outputScalarVariables().
|
virtualinherited |
Gets const reference to the dof map.
Definition at line 985 of file SystemBase.C.
|
inlineoverridevirtual |
|
inlineoverridevirtual |
|
inlineoverridevirtual |
|
inlineoverridevirtual |
|
inherited |
Gets a reference to a variable of with specified name.
tid | Thread id |
var_name | variable name |
Definition at line 129 of file SystemBase.C.
Referenced by Assembly::copyFaceShapes(), Assembly::copyNeighborShapes(), Assembly::copyShapes(), DisplacedProblem::getArrayVariable(), Marker::getMarkerValue(), DisplacedProblem::getStandardVariable(), and DisplacedProblem::getVectorVariable().
|
inherited |
Gets a reference to a variable with specified number.
tid | Thread id |
var_number | libMesh variable number |
Definition at line 136 of file SystemBase.C.
|
inlineoverridevirtual |
Get a raw SparseMatrix.
Reimplemented from SystemBase.
Definition at line 207 of file DisplacedSystem.h.
|
inlineoverridevirtual |
Get a raw SparseMatrix.
Reimplemented from SystemBase.
Definition at line 203 of file DisplacedSystem.h.
|
inlineinherited |
Returns the maximum number of all variables on the system.
Definition at line 744 of file SystemBase.h.
|
inlineinherited |
Gets the maximum number of dofs used by any one variable on any one element.
Definition at line 480 of file SystemBase.h.
Referenced by MooseVariableScalar::computeAD(), Assembly::computeAffineMapAD(), Assembly::computeFaceMap(), and Assembly::computeSinglePointMapAD().
|
inlineinherited |
Gets the maximum number of dofs used by any one variable on any one node.
Definition at line 487 of file SystemBase.h.
Referenced by MooseVariableScalar::computeAD().
|
virtualinherited |
Get minimal quadrature order needed for integrating variables in this system.
Reimplemented in AuxiliarySystem.
Definition at line 232 of file SystemBase.C.
|
virtualinherited |
Gets a reference to a scalar variable with specified number.
tid | Thread id |
var_name | A string which is the name of the variable to get. |
Definition at line 142 of file SystemBase.C.
Referenced by Assembly::addJacobianOffDiagScalar(), VectorIntegratedBC::computeJacobianBlockScalar(), ArrayIntegratedBC::computeJacobianBlockScalar(), IntegratedBC::computeJacobianBlockScalar(), ODEKernel::computeOffDiagJacobian(), VectorKernel::computeOffDiagJacobianScalar(), ArrayKernel::computeOffDiagJacobianScalar(), Kernel::computeOffDiagJacobianScalar(), DisplacedProblem::getScalarVariable(), Assembly::init(), and ReferenceResidualProblem::initialSetup().
|
virtualinherited |
Gets a reference to a variable with specified number.
tid | Thread id |
var_number | libMesh variable number |
Definition at line 151 of file SystemBase.C.
|
inlineinherited |
Definition at line 654 of file SystemBase.h.
Referenced by Assembly::addResidualScalar(), ComputeFullJacobianThread::computeFaceJacobian(), ComputeFullJacobianThread::computeJacobian(), ODEKernel::computeJacobian(), AuxiliarySystem::computeScalarVars(), Assembly::init(), ComputeJacobianThread::onElement(), Assembly::prepareOffDiagScalar(), and Assembly::prepareScalar().
|
inlineinherited |
|
inlineinherited |
Definition at line 659 of file SystemBase.h.
|
inlineinherited |
Definition at line 763 of file SystemBase.h.
Referenced by DT2::computeDT(), Transient::endStep(), AB2PredictorCorrector::estimateTimeError(), MooseVariableData< OutputType >::MooseVariableData(), and Transient::preExecute().
|
inlineinherited |
Definition at line 764 of file SystemBase.h.
|
inherited |
Gets a reference to a variable of with specified name.
tid | Thread id |
var_name | variable name |
Definition at line 109 of file SystemBase.C.
Referenced by Assembly::addJacobianBlock(), Assembly::addJacobianBlockNonlocal(), Assembly::addJacobianNeighbor(), SystemBase::addVariableToZeroOnJacobian(), SystemBase::addVariableToZeroOnResidual(), VectorIntegratedBC::computeJacobianBlock(), ArrayIntegratedBC::computeJacobianBlock(), NonlocalIntegratedBC::computeJacobianBlock(), NonlocalKernel::computeNonlocalOffDiagJacobian(), NonlocalIntegratedBC::computeNonlocalOffDiagJacobian(), ArrayDGKernel::computeOffDiagElemNeighJacobian(), Kernel::computeOffDiagJacobian(), VectorKernel::computeOffDiagJacobian(), ArrayKernel::computeOffDiagJacobian(), EigenKernel::computeOffDiagJacobian(), ArrayNodalBC::computeOffDiagJacobian(), NonlocalKernel::computeOffDiagJacobian(), KernelGrad::computeOffDiagJacobian(), KernelValue::computeOffDiagJacobian(), NodeFaceConstraint::computeOffDiagJacobian(), Assembly::copyFaceShapes(), Assembly::copyNeighborShapes(), Assembly::copyShapes(), SystemBase::copyVars(), FieldSplitPreconditioner::FieldSplitPreconditioner(), FiniteDifferencePreconditioner::FiniteDifferencePreconditioner(), EqualValueEmbeddedConstraint::getConnectedDofIndices(), NodeElemConstraint::getConnectedDofIndices(), NodeFaceConstraint::getConnectedDofIndices(), SystemBase::getScalarVariable(), SubProblem::getVariableHelper(), Assembly::init(), NodalNormalsPreprocessor::initialize(), ReferenceResidualProblem::initialSetup(), Assembly::initNonlocalCoupling(), PNGOutput::makeMeshFunc(), PhysicsBasedPreconditioner::PhysicsBasedPreconditioner(), Assembly::prepareBlock(), Assembly::prepareBlockNonlocal(), AddPeriodicBCAction::setPeriodicVars(), SingleMatrixPreconditioner::SingleMatrixPreconditioner(), and UpdateErrorVectorsThread::UpdateErrorVectorsThread().
|
inherited |
Gets a reference to a variable with specified number.
tid | Thread id |
var_number | libMesh variable number |
Definition at line 118 of file SystemBase.C.
|
virtualinherited |
Get the block where a variable of this system is defined.
var_number | The number of the variable |
Definition at line 161 of file SystemBase.C.
Referenced by PhysicsBasedPreconditioner::addSystem().
|
inlineinherited |
Definition at line 739 of file SystemBase.h.
Referenced by MooseEigenSystem::buildSystemDoFIndices(), NonlinearSystemBase::checkKernelCoverage(), SystemBase::hasVariable(), SystemBase::isArrayVariable(), and AddPeriodicBCAction::setPeriodicVars().
|
inlineinherited |
Definition at line 649 of file SystemBase.h.
Referenced by Assembly::addJacobianOffDiagScalar(), Assembly::addResidual(), Assembly::addResidualNeighbor(), Assembly::cacheResidual(), Assembly::cacheResidualLower(), Assembly::cacheResidualNeighbor(), ComputeFullJacobianThread::computeFaceJacobian(), ComputeFullJacobianThread::computeJacobian(), Assembly::init(), Assembly::initNonlocalCoupling(), Assembly::prepareLowerD(), Assembly::prepareNeighbor(), Assembly::prepareOffDiagScalar(), Assembly::prepareResidual(), Assembly::setResidual(), and Assembly::setResidualNeighbor().
|
overridevirtual |
Get a raw NumericVector.
Get a raw NumericVector with the given name.
Reimplemented from SystemBase.
Definition at line 42 of file DisplacedSystem.C.
|
inlineoverridevirtual |
Get a raw NumericVector.
Reimplemented from SystemBase.
Definition at line 39 of file DisplacedSystem.h.
|
inlineoverridevirtual |
Get a raw NumericVector.
Reimplemented from SystemBase.
Definition at line 35 of file DisplacedSystem.h.
|
inlineoverridevirtual |
Check if the tagged matrix exists in the system.
Reimplemented from SystemBase.
Definition at line 198 of file DisplacedSystem.h.
|
virtualinherited |
Definition at line 719 of file SystemBase.C.
Referenced by ComputeFullJacobianThread::computeFaceJacobian(), ComputeFullJacobianThread::computeJacobian(), NonlinearSystemBase::computeJacobianInternal(), SystemBase::copyVars(), DisplacedProblem::getScalarVariable(), DisplacedProblem::hasScalarVariable(), and AddPeriodicBCAction::setPeriodicVars().
|
virtualinherited |
Query a system for a variable.
var_name | name of the variable |
Definition at line 694 of file SystemBase.C.
Referenced by ADDGKernel< compute_stage >::ADDGKernel(), ADKernelTempl< T, compute_stage >::ADKernelTempl(), ArrayDGKernel::ArrayDGKernel(), ArrayKernel::ArrayKernel(), SystemBase::copyVars(), DGKernel::DGKernel(), FEProblemBase::duplicateVariableCheck(), DisplacedProblem::getArrayVariable(), DisplacedProblem::getStandardVariable(), DisplacedProblem::getSystem(), SubProblem::getVariableHelper(), DisplacedProblem::getVectorVariable(), DisplacedProblem::hasVariable(), InterfaceKernelTempl< T >::InterfaceKernelTempl(), Kernel::Kernel(), and PNGOutput::makeMeshFunc().
|
inherited |
Check if the named vector exists in the system.
Definition at line 748 of file SystemBase.C.
Referenced by Assembly::addCachedResidual(), Assembly::addCachedResiduals(), Assembly::addResidual(), Assembly::addResidualNeighbor(), Assembly::addResidualScalar(), AuxiliarySystem::addVector(), SystemBase::addVector(), Assembly::cacheResidual(), Assembly::cacheResidualLower(), Assembly::cacheResidualNeighbor(), ArrayNodalBC::computeResidual(), VectorNodalBC::computeResidual(), NodalBC::computeResidual(), NonlinearSystemBase::computeResidualTags(), SystemBase::getVector(), hasVector(), MooseVariableScalar::reinit(), and SystemBase::removeVector().
|
inlineoverridevirtual |
Check if the tagged vector exists in the system.
Reimplemented from SystemBase.
Definition at line 193 of file DisplacedSystem.h.
|
overridevirtual |
Initialize the system.
Reimplemented from SystemBase.
Definition at line 37 of file DisplacedSystem.C.
Referenced by DisplacedProblem::init().
|
inlinevirtualinherited |
Called only once, just before the solve begins so objects can do some precalculations.
Definition at line 168 of file SystemBase.h.
|
virtualinherited |
|
virtualinherited |
Definition at line 728 of file SystemBase.C.
Referenced by ODEKernel::computeOffDiagJacobian(), Assembly::init(), ReferenceResidualProblem::initialSetup(), and Assembly::initNonlocalCoupling().
|
virtualinherited |
|
inlinevirtualinherited |
Definition at line 106 of file SystemBase.h.
Referenced by CreateDisplacedProblemAction::addProxyRelationshipManagers(), NonlinearSystem::computeScaling(), DMMooseGetEmbedding_Private(), DMSetUp_Moose_Pre(), MooseVariableData< OutputType >::MooseVariableData(), ComputeNodalKernelsThread::onNode(), and ComputeNodalKernelJacobiansThread::onNode().
|
inlinevirtualinherited |
Definition at line 107 of file SystemBase.h.
|
virtualinherited |
Definition at line 1135 of file SystemBase.C.
Referenced by NonlinearSystemBase::addBoundaryCondition(), NonlinearSystemBase::addConstraint(), NonlinearSystemBase::addDamper(), NonlinearSystemBase::addDGKernel(), NonlinearSystemBase::addDiracKernel(), NonlinearSystemBase::addInterfaceKernel(), MooseEigenSystem::addKernel(), AuxiliarySystem::addKernel(), NonlinearSystemBase::addKernel(), NonlinearSystem::addMatrix(), NonlinearSystemBase::addNodalKernel(), AuxiliarySystem::addScalarKernel(), NonlinearSystemBase::addScalarKernel(), NonlinearSystemBase::addSplit(), AuxiliarySystem::addTimeIntegrator(), NonlinearSystemBase::addTimeIntegrator(), AuxiliarySystem::addVariable(), SystemBase::addVariable(), SystemBase::addVector(), NonlinearSystemBase::getSplit(), getVector(), SystemBase::getVector(), SystemBase::hasVector(), SystemBase::removeVector(), and NonlinearSystemBase::setInitialSolution().
|
inlineoverridevirtual |
Reimplemented from SystemBase.
Definition at line 50 of file DisplacedSystem.h.
Referenced by DisplacedProblem::addCachedResidualDirectly().
|
virtualinherited |
Gets the number of this system.
Definition at line 973 of file SystemBase.C.
Referenced by ArrayNodalBC::computeOffDiagJacobian(), VectorNodalBC::computeOffDiagJacobian(), NodalBC::computeOffDiagJacobian(), NodalKernel::computeOffDiagJacobian(), EqualValueEmbeddedConstraint::computeQpJacobian(), EqualValueEmbeddedConstraint::computeQpOffDiagJacobian(), DebugResidualAux::computeValue(), NearestNodeValueAux::computeValue(), BoundsAux::computeValue(), NodalNormalsEvaluator::execute(), NodalNormalsCorner::execute(), NodalNormalsPreprocessor::execute(), NonlinearSystemBase::getNodeDofs(), EqualValueEmbeddedConstraint::reinitConstraint(), and MultiAppFieldTransfer::transferDofObject().
|
virtualinherited |
Get the number of variables in this system.
Definition at line 734 of file SystemBase.C.
Referenced by FieldSplitPreconditioner::FieldSplitPreconditioner(), FiniteDifferencePreconditioner::FiniteDifferencePreconditioner(), NonlinearSystemBase::getNodeDofs(), Assembly::init(), MaxVarNDofsPerElem::onElement(), MaxVarNDofsPerNode::onNode(), PhysicsBasedPreconditioner::PhysicsBasedPreconditioner(), and SingleMatrixPreconditioner::SingleMatrixPreconditioner().
|
virtualinherited |
Prepare the system for use.
tid | ID of the thread |
Definition at line 247 of file SystemBase.C.
Referenced by DisplacedProblem::prepare(), DisplacedProblem::reinitDirac(), SubProblem::reinitElemFaceRef(), and DisplacedProblem::reinitElemPhys().
|
virtualinherited |
Prepare the system for use on sides.
This will try to reuse the preparation done on the element.
tid | ID of the thread |
resize_data | Pass True if this system needs to resize residual and jacobian datastructures based on preparing this face |
Definition at line 270 of file SystemBase.C.
Referenced by DisplacedProblem::prepareFace().
|
virtualinherited |
Prepare the system for use for lower dimensional elements.
tid | ID of the thread |
Definition at line 311 of file SystemBase.C.
Referenced by SubProblem::reinitLowerDElemRef().
|
virtualinherited |
Prepare the system for use.
tid | ID of the thread |
Definition at line 303 of file SystemBase.C.
Referenced by DisplacedProblem::reinitNeighbor(), SubProblem::reinitNeighborFaceRef(), and DisplacedProblem::reinitNeighborPhys().
|
virtualinherited |
Reinit an element assembly info.
elem | Which element we are reinitializing for |
tid | ID of the thread |
Reimplemented in AuxiliarySystem.
Definition at line 319 of file SystemBase.C.
Referenced by DisplacedProblem::reinitElem().
|
virtualinherited |
Reinit assembly info for a side of an element.
elem | The element |
side | Side of of the element |
bnd_id | Boundary id on that side |
tid | Thread ID |
Reimplemented in AuxiliarySystem.
Definition at line 339 of file SystemBase.C.
Referenced by DisplacedProblem::reinitElemFace(), SubProblem::reinitElemFaceRef(), and DisplacedProblem::reinitNeighbor().
|
virtualinherited |
Compute the values of the variables on the lower dimensional element.
Definition at line 369 of file SystemBase.C.
Referenced by SubProblem::reinitLowerDElemRef().
|
virtualinherited |
Compute the values of the variables at all the current points.
Definition at line 361 of file SystemBase.C.
Referenced by DisplacedProblem::reinitNeighborPhys().
|
virtualinherited |
Compute the values of the variables at all the current points.
Definition at line 350 of file SystemBase.C.
Referenced by DisplacedProblem::reinitNeighbor(), SubProblem::reinitNeighborFaceRef(), and DisplacedProblem::reinitNeighborPhys().
|
virtualinherited |
Reinit nodal assembly info.
node | Node to reinit for |
tid | Thread ID |
Definition at line 377 of file SystemBase.C.
Referenced by DisplacedProblem::reinitNode().
|
virtualinherited |
Reinit nodal assembly info on a face.
node | Node to reinit |
bnd_id | Boundary ID |
tid | Thread ID |
Definition at line 389 of file SystemBase.C.
Referenced by DisplacedProblem::reinitNodeFace().
|
virtualinherited |
Reinit variables at a set of nodes.
nodes | List of node ids to reinit |
tid | Thread ID |
Definition at line 401 of file SystemBase.C.
Referenced by DisplacedProblem::reinitNodes().
|
virtualinherited |
Reinit variables at a set of neighbor nodes.
nodes | List of node ids to reinit |
tid | Thread ID |
Definition at line 412 of file SystemBase.C.
Referenced by DisplacedProblem::reinitNodesNeighbor().
|
virtualinherited |
Reinit scalar varaibles.
tid | Thread ID |
reinit_for_derivative_reordering | A flag indicating whether we are reinitializing for the purpose of re-ordering derivative information for ADNodalBCs |
Definition at line 423 of file SystemBase.C.
Referenced by DisplacedProblem::reinitScalars().
|
inlinevirtualinherited |
Removes a jacobian sized vector.
tag_name | The name of the tag |
Definition at line 732 of file SystemBase.h.
|
virtualinherited |
Remove a vector from the system with the given name.
Definition at line 1129 of file SystemBase.C.
Referenced by SystemBase::restoreOldSolutions().
|
virtualinherited |
Remove a solution length vector from the system with the specified TagID.
tag_id | Tag ID |
Definition at line 597 of file SystemBase.C.
|
inlineoverridevirtual |
Return the residual copy from the NonlinearSystem.
Reimplemented from SystemBase.
Definition at line 143 of file DisplacedSystem.h.
|
inlineoverridevirtual |
Reimplemented from SystemBase.
Definition at line 147 of file DisplacedSystem.h.
|
inlineoverridevirtual |
|
virtualinherited |
Restore the old and older solutions when the saved solutions present.
Definition at line 514 of file SystemBase.C.
Referenced by DisplacedProblem::restoreOldSolutions().
|
virtualinherited |
Restore current solutions (call after your solve failed)
Reimplemented in NonlinearSystemBase.
Definition at line 1115 of file SystemBase.C.
Referenced by NonlinearSystemBase::restoreSolutions().
|
virtualinherited |
Save the old and older solutions.
Definition at line 489 of file SystemBase.C.
Referenced by DisplacedProblem::saveOldSolutions().
|
inlineoverridevirtual |
Returns a reference to a serialized version of the solution vector for this subproblem.
Implements SystemBase.
Definition at line 84 of file DisplacedSystem.h.
|
inlineoverridevirtual |
|
inlineoverridevirtual |
|
overridevirtual |
Implements SystemBase.
Definition at line 69 of file DisplacedSystem.C.
|
overridevirtual |
Implements SystemBase.
Definition at line 57 of file DisplacedSystem.C.
|
overridevirtual |
Implements SystemBase.
Definition at line 75 of file DisplacedSystem.C.
|
overridevirtual |
Implements SystemBase.
Definition at line 63 of file DisplacedSystem.C.
|
inlineoverridevirtual |
|
inlineoverridevirtual |
|
inlineoverridevirtual |
Implements SystemBase.
Definition at line 117 of file DisplacedSystem.h.
|
inlineoverridevirtual |
|
inlineoverridevirtual |
Implements SystemBase.
Definition at line 121 of file DisplacedSystem.h.
|
inlineoverridevirtual |
Implements SystemBase.
Definition at line 105 of file DisplacedSystem.h.
|
inlineoverridevirtual |
Implements SystemBase.
Definition at line 129 of file DisplacedSystem.h.
|
inlineoverridevirtual |
Implements SystemBase.
Definition at line 113 of file DisplacedSystem.h.
|
inlineoverridevirtual |
Implements SystemBase.
Definition at line 125 of file DisplacedSystem.h.
|
inlineoverridevirtual |
Implements SystemBase.
Definition at line 109 of file DisplacedSystem.h.
|
virtualinherited |
Solve the system (using libMesh magic)
Reimplemented in NonlinearSystemBase, NonlinearSystem, NonlinearEigenSystem, and DumpObjectsNonlinearSystem.
Definition at line 1073 of file SystemBase.C.
|
inlinevirtualinherited |
Definition at line 108 of file SystemBase.h.
Referenced by CreateDisplacedProblemAction::addProxyRelationshipManagers(), MooseVariableBase::allDofIndices(), MultiAppVariableValueSamplePostprocessorTransfer::execute(), MultiAppVariableValueSampleTransfer::execute(), MooseVariableData< OutputType >::MooseVariableData(), MooseVariableScalar::MooseVariableScalar(), and MooseVariableScalar::reinit().
|
inlinevirtualinherited |
Definition at line 109 of file SystemBase.h.
|
inlinevirtual |
Definition at line 212 of file DisplacedSystem.h.
Referenced by UpdateDisplacedMeshThread::init(), DisplacedProblem::syncSolutions(), and DisplacedProblem::updateMesh().
|
overridevirtual |
|
overridevirtual |
Get the reference to the libMesh system.
Implements SystemBase.
Definition at line 81 of file DisplacedSystem.C.
Referenced by DisplacedProblem::getSystem().
|
inlineoverridevirtual |
Return the Matrix Tag ID for System.
Reimplemented from SystemBase.
Definition at line 46 of file DisplacedSystem.h.
|
virtualinherited |
Return the Matrix Tag ID for Time.
Definition at line 761 of file SystemBase.C.
|
inlineoverridevirtual |
Ideally, we should not need this API.
There exists a really bad API "addCachedResidualDirectly " in FEProblem and DisplacedProblem This API should go away once addCachedResidualDirectly is removed in the future Return Tag ID for Time
Reimplemented from SystemBase.
Definition at line 48 of file DisplacedSystem.h.
Referenced by DisplacedProblem::addCachedResidualDirectly().
|
virtualinherited |
Update the system (doing libMesh magic)
Definition at line 1067 of file SystemBase.C.
Referenced by MooseEigenSystem::combineSystemSolution(), NonlinearSystemBase::computeDamping(), NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeResidualTags(), dataLoad(), MooseEigenSystem::initSystemSolution(), MooseEigenSystem::initSystemSolutionOld(), RestartableDataIO::restartEquationSystemsObject(), MooseEigenSystem::scaleSystemSolution(), NonlinearSystemBase::setConstraintSlaveValues(), NonlinearSystemBase::setInitialSolution(), PicardSolve::solve(), PicardSolve::solveStep(), DisplacedProblem::syncSolutions(), and MultiAppFieldTransfer::transfer().
|
virtualinherited |
Zero all vectors for given tags.
Definition at line 587 of file SystemBase.C.
Referenced by NonlinearSystemBase::computeResidualTags().
|
inlineoverridevirtual |
Zero out the solution for the list of variables passed in.
Reimplemented from SystemBase.
Definition at line 188 of file DisplacedSystem.h.
|
virtualinherited |
Zero out the solution for the variables that were registered as needing to have their solutions zeroed on out on Jacobian evaluation by a call to addVariableToZeroOnResidual()
Definition at line 226 of file SystemBase.C.
|
virtualinherited |
Zero out the solution for the variables that were registered as needing to have their solutions zeroed on out on residual evaluation by a call to addVariableToZeroOnResidual()
Definition at line 220 of file SystemBase.C.
|
protectedinherited |
Definition at line 771 of file SystemBase.h.
Referenced by NonlinearSystemBase::computeJacobianBlocks(), NonlinearSystemBase::computeJacobianTags(), and NonlinearSystemBase::computeResidualTags().
|
protectedinherited |
Flag used to indicate whether we are computing the scaling Jacobian.
Definition at line 827 of file SystemBase.h.
Referenced by NonlinearSystemBase::computeJacobianInternal(), NonlinearSystem::computeScaling(), NonlinearSystemBase::computeTimeDerivatives(), and SystemBase::computingScalingJacobian().
|
protectedinherited |
Flag used to indicate whether we are computing the scaling Residual.
Definition at line 830 of file SystemBase.h.
Referenced by NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::computeResidualTags(), NonlinearSystem::computeScaling(), and SystemBase::computingScalingResidual().
|
protectedinherited |
Definition at line 788 of file SystemBase.h.
Referenced by SystemBase::duDotDu().
|
protectedinherited |
Definition at line 789 of file SystemBase.h.
Referenced by SystemBase::duDotDotDu().
|
protectedinherited |
Definition at line 772 of file SystemBase.h.
Referenced by NonlinearSystemBase::addBoundaryCondition(), NonlinearSystemBase::addConstraint(), NonlinearSystemBase::addDamper(), NonlinearSystemBase::addDGKernel(), NonlinearSystemBase::addDiracKernel(), NonlinearSystemBase::addInterfaceKernel(), MooseEigenSystem::addKernel(), AuxiliarySystem::addKernel(), NonlinearSystemBase::addKernel(), NonlinearSystemBase::addNodalKernel(), AuxiliarySystem::addScalarKernel(), NonlinearSystemBase::addScalarKernel(), NonlinearSystemBase::addSplit(), AuxiliarySystem::addTimeIntegrator(), NonlinearSystemBase::addTimeIntegrator(), and SystemBase::addVariable().
|
protectedinherited |
Active flags for tagged matrices.
Definition at line 796 of file SystemBase.h.
Referenced by SystemBase::activeAllMatrixTags(), SystemBase::activeMatrixTag(), SystemBase::deactiveAllMatrixTags(), SystemBase::deactiveMatrixTag(), and SystemBase::matrixTagActive().
|
protectedinherited |
Maximum number of dofs for any one variable on any one element.
Definition at line 812 of file SystemBase.h.
Referenced by SystemBase::assignMaxVarNDofsPerElem(), and SystemBase::getMaxVarNDofsPerElem().
|
protectedinherited |
Maximum number of dofs for any one variable on any one node.
Definition at line 815 of file SystemBase.h.
Referenced by SystemBase::assignMaxVarNDofsPerNode(), and SystemBase::getMaxVarNDofsPerNode().
|
protectedinherited |
Maximum variable number.
Definition at line 783 of file SystemBase.h.
Referenced by SystemBase::addVariable(), and SystemBase::getMaxVariableNumber().
|
protectedinherited |
Definition at line 774 of file SystemBase.h.
Referenced by SystemBase::addVariable(), SystemBase::augmentSendList(), NonlinearSystemBase::computeDamping(), AuxiliarySystem::computeElementalVarsHelper(), NonlinearSystemBase::computeJacobianBlocks(), NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeNodalBCs(), AuxiliarySystem::computeNodalVarsHelper(), NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::constraintJacobians(), NonlinearSystemBase::constraintResiduals(), NonlinearSystemBase::findImplicitGeometricCouplingEntries(), NonlinearSystemBase::getNodeDofs(), SystemBase::mesh(), NonlinearSystemBase::setConstraintSlaveValues(), NonlinearSystemBase::setInitialSolution(), NonlinearSystemBase::setVariableGlobalDoFs(), and SystemBase::zeroVariables().
|
protectedinherited |
The name of this system.
Definition at line 776 of file SystemBase.h.
|
protectedinherited |
Map variable number to its pointer.
Definition at line 821 of file SystemBase.h.
Referenced by SystemBase::addVariable(), and SystemBase::getVariable().
|
protectedinherited |
Definition at line 803 of file SystemBase.h.
Referenced by SystemBase::restoreOldSolutions(), and SystemBase::saveOldSolutions().
|
protectedinherited |
Definition at line 804 of file SystemBase.h.
Referenced by SystemBase::restoreOldSolutions(), and SystemBase::saveOldSolutions().
|
protectedinherited |
Definition at line 799 of file SystemBase.h.
Referenced by SystemBase::restoreOldSolutions(), and SystemBase::saveOldSolutions().
|
protectedinherited |
Definition at line 800 of file SystemBase.h.
Referenced by SystemBase::restoreOldSolutions(), and SystemBase::saveOldSolutions().
|
protectedinherited |
Definition at line 769 of file SystemBase.h.
Referenced by SystemBase::activeAllMatrixTags(), SystemBase::activeMatrixTag(), NonlinearSystem::addMatrix(), SystemBase::addVariableToZeroOnJacobian(), SystemBase::addVariableToZeroOnResidual(), SystemBase::addVector(), SystemBase::associateMatrixToTag(), SystemBase::associateVectorToTag(), SystemBase::augmentSendList(), SystemBase::closeTaggedVectors(), SystemBase::deactiveAllMatrixTags(), SystemBase::deactiveMatrixTag(), SystemBase::disassociateMatrixFromTag(), SystemBase::disassociateVectorFromTag(), SystemBase::matrixTagActive(), SystemBase::prepare(), SystemBase::prepareFace(), SystemBase::reinitElem(), SystemBase::removeVector(), SystemBase::subproblem(), and SystemBase::zeroTaggedVectors().
|
protected |
Definition at line 222 of file DisplacedSystem.h.
Referenced by DisplacedSystem(), getVector(), solutionOld(), solutionOlder(), sys(), and system().
|
protectedinherited |
Tagged matrices (pointer)
Definition at line 794 of file SystemBase.h.
Referenced by NonlinearSystem::addMatrix(), SystemBase::associateMatrixToTag(), SystemBase::disassociateAllTaggedMatrices(), SystemBase::disassociateMatrixFromTag(), SystemBase::getMatrix(), and SystemBase::hasMatrix().
|
protectedinherited |
Tagged vectors (pointer)
Definition at line 792 of file SystemBase.h.
Referenced by SystemBase::addVector(), SystemBase::associateVectorToTag(), SystemBase::disassociateAllTaggedVectors(), SystemBase::disassociateVectorFromTag(), SystemBase::getVector(), SystemBase::hasVector(), and SystemBase::removeVector().
|
protectedinherited |
Time integrator.
Definition at line 818 of file SystemBase.h.
Referenced by NonlinearSystemBase::addTimeIntegrator(), addTimeIntegrator(), NonlinearSystemBase::computeResidualTags(), NonlinearSystemBase::computeTimeDerivatives(), SystemBase::getSharedTimeIntegrator(), SystemBase::getTimeIntegrator(), NonlinearSystemBase::onTimestepBegin(), NonlinearEigenSystem::solve(), and NonlinearSystem::solve().
|
protected |
Definition at line 221 of file DisplacedSystem.h.
Referenced by addVariableToZeroOnJacobian(), addVariableToZeroOnResidual(), associateMatrixToTag(), associateVectorToTag(), augmentSendList(), currentSolution(), disassociateAllTaggedMatrices(), disassociateAllTaggedVectors(), disassociateMatrixFromTag(), disassociateVectorFromTag(), duDotDotDu(), duDotDu(), getMatrix(), getVector(), hasMatrix(), hasVector(), nonTimeVectorTag(), residualCopy(), residualGhosted(), residualVectorTag(), serializedSolution(), solution(), solutionUDot(), solutionUDotDot(), solutionUDotDotOld(), solutionUDotOld(), systemMatrixTag(), timeVectorTag(), and zeroVariables().
|
protectedinherited |
default kind of variables in this system
Definition at line 807 of file SystemBase.h.
|
protectedinherited |
Map of variables (variable id -> array of subdomains where it lives)
Definition at line 781 of file SystemBase.h.
Referenced by SystemBase::addVariable(), SystemBase::getSubdomainsForVar(), and SystemBase::getVariableBlocks().
|
protectedinherited |
Definition at line 809 of file SystemBase.h.
Referenced by SystemBase::addVariableToCopy(), and SystemBase::copyVars().
|
protectedinherited |
Storage for MooseVariable objects.
Definition at line 824 of file SystemBase.h.
|
protectedinherited |
Variable warehouses (one for each thread)
Definition at line 779 of file SystemBase.h.
Referenced by NonlinearSystemBase::addBoundaryCondition(), NonlinearSystemBase::addInterfaceKernel(), AuxiliarySystem::addVariable(), SystemBase::addVariable(), SystemBase::applyScalingFactors(), AuxiliarySystem::compute(), NonlinearSystem::computeScaling(), SystemBase::getFieldVariable(), AuxiliarySystem::getMinQuadratureOrder(), SystemBase::getMinQuadratureOrder(), SystemBase::getScalarVariable(), SystemBase::getScalarVariables(), SystemBase::getVariable(), SystemBase::getVariableNames(), SystemBase::getVariables(), SystemBase::nVariables(), SystemBase::prepare(), SystemBase::prepareFace(), SystemBase::prepareLowerD(), SystemBase::prepareNeighbor(), SystemBase::reinitElem(), SystemBase::reinitElemFace(), SystemBase::reinitLowerD(), SystemBase::reinitNeighbor(), SystemBase::reinitNeighborFace(), SystemBase::reinitNode(), SystemBase::reinitNodeFace(), SystemBase::reinitNodes(), SystemBase::reinitNodesNeighbor(), and SystemBase::reinitScalars().
|
protectedinherited |
Definition at line 786 of file SystemBase.h.
Referenced by SystemBase::addVariableToZeroOnJacobian(), and SystemBase::zeroVariablesForJacobian().
|
protectedinherited |
Definition at line 785 of file SystemBase.h.
Referenced by SystemBase::addVariableToZeroOnResidual(), and SystemBase::zeroVariablesForResidual().