Nonlinear eigenvalue system to be solved. More...
#include <NonlinearEigenSystem.h>
| Public Member Functions | |
| NonlinearEigenSystem (EigenProblem &problem, const std::string &name) | |
| virtual void | solve () override | 
| Solve the system (using libMesh magic)  More... | |
| virtual void | stopSolve (const ExecFlagType &exec_flag, const std::set< TagID > &vector_tags_to_close) override | 
| Quit the current solve as soon as possible.  More... | |
| virtual unsigned int | getCurrentNonlinearIterationNumber () override | 
| Returns the current nonlinear iteration number.  More... | |
| virtual void | setupFiniteDifferencedPreconditioner () override | 
| virtual bool | converged () override | 
| Returns the convergence state.  More... | |
| virtual NumericVector< Number > & | RHS () override | 
| NumericVector< Number > & | residualVectorAX () | 
| NumericVector< Number > & | residualVectorBX () | 
| void | attachSLEPcCallbacks () | 
| unsigned int | getNumConvergedEigenvalues () const | 
| Get the number of converged eigenvalues.  More... | |
| virtual libMesh::NonlinearSolver< Number > * | nonlinearSolver () override | 
| virtual SNES | getSNES () override | 
| Retrieve snes from slepc eigen solver.  More... | |
| virtual EPS | getEPS () | 
| Retrieve EPS (SLEPc eigen solver)  More... | |
| libMesh::CondensedEigenSystem & | sys () | 
| void | checkIntegrity () | 
| For eigenvalue problems (including standard and generalized), inhomogeneous (Dirichlet or Neumann) boundary conditions are not allowed.  More... | |
| std::pair< Real, Real > | getConvergedEigenvalue (dof_id_type n) const | 
| Return the Nth converged eigenvalue.  More... | |
| std::pair< Real, Real > | getConvergedEigenpair (dof_id_type n) const | 
| Return the Nth converged eigenvalue and copies the respective eigen vector to the solution vector.  More... | |
| const std::vector< std::pair< Real, Real > > & | getAllConvergedEigenvalues () const | 
| Get the number of converged eigenvalues.  More... | |
| TagID | eigenVectorTag () const | 
| Vector tag ID of right hand side.  More... | |
| TagID | nonEigenVectorTag () const | 
| Vector tag ID of left hand side.  More... | |
| TagID | eigenMatrixTag () const | 
| Matrix tag ID of right hand side.  More... | |
| TagID | nonEigenMatrixTag () const | 
| Matrix tag ID of left hand side.  More... | |
| std::set< TagID > | defaultVectorTags () const override | 
| Get the default vector tags associated with this system.  More... | |
| std::set< TagID > | defaultMatrixTags () const override | 
| Get the default matrix tags associted with this system.  More... | |
| void | precondMatrixIncludesEigenKernels (bool precond_matrix_includes_eigen) | 
| If the preconditioning matrix includes eigen kernels.  More... | |
| bool | precondMatrixIncludesEigenKernels () const | 
| TagID | precondMatrixTag () const | 
| virtual void | attachPreconditioner (libMesh::Preconditioner< Number > *preconditioner) override | 
| Attach a customized preconditioner that requires physics knowledge.  More... | |
| libMesh::Preconditioner< Number > * | preconditioner () const | 
| virtual void | turnOffJacobian () override | 
| Turn off the Jacobian (must be called before equation system initialization)  More... | |
| void | residualAndJacobianTogether () override | 
| Call this method if you want the residual and Jacobian to be computed simultaneously.  More... | |
| void | initializeCondensedMatrices () | 
| Initialize the condensed matrices.  More... | |
| virtual void | postInit () override | 
| virtual void | reinit () override | 
| Reinitialize the system when the degrees of freedom in this system have changed.  More... | |
| NonlinearEigenSystem (EigenProblem &problem, const std::string &name) | |
| bool | converged () | 
| Returns the convergence state.  More... | |
| void | checkIntegrity () | 
| const Parallel::Communicator & | comm () const | 
| processor_id_type | n_processors () const | 
| processor_id_type | processor_id () const | 
| virtual void | preInit () override | 
| This is called prior to the libMesh system has been init'd.  More... | |
| void | reinitMortarFunctors () | 
| Update the mortar functors if the mesh has changed.  More... | |
| bool | computedScalingJacobian () const | 
| bool | computingPreSMOResidual () | 
| Returns true if this system is currently computing the pre-SMO residual for a solve.  More... | |
| virtual void | initialSetup () override | 
| Setup Functions.  More... | |
| virtual void | timestepSetup () override | 
| virtual void | customSetup (const ExecFlagType &exec_type) override | 
| virtual void | residualSetup () override | 
| virtual void | jacobianSetup () override | 
| bool | haveFiniteDifferencedPreconditioner () const | 
| bool | haveFieldSplitPreconditioner () const | 
| virtual void | addKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) | 
| Adds a kernel.  More... | |
| virtual void | addHDGKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) | 
| Adds a hybridized discontinuous Galerkin (HDG) kernel.  More... | |
| virtual void | addNodalKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) | 
| Adds a NodalKernel.  More... | |
| void | addScalarKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) | 
| Adds a scalar kernel.  More... | |
| void | addBoundaryCondition (const std::string &bc_name, const std::string &name, InputParameters ¶meters) | 
| Adds a boundary condition.  More... | |
| virtual void | addKokkosKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) | 
| Adds a Kokkos kernel.  More... | |
| virtual void | addKokkosNodalKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) | 
| Adds a Kokkos nodal kernel.  More... | |
| void | addKokkosBoundaryCondition (const std::string &bc_name, const std::string &name, InputParameters ¶meters) | 
| Adds a Kokkos boundary condition.  More... | |
| void | addConstraint (const std::string &c_name, const std::string &name, InputParameters ¶meters) | 
| Adds a Constraint.  More... | |
| void | addDiracKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) | 
| Adds a Dirac kernel.  More... | |
| void | addDGKernel (std::string dg_kernel_name, const std::string &name, InputParameters ¶meters) | 
| Adds a DG kernel.  More... | |
| void | addInterfaceKernel (std::string interface_kernel_name, const std::string &name, InputParameters ¶meters) | 
| Adds an interface kernel.  More... | |
| void | addDamper (const std::string &damper_name, const std::string &name, InputParameters ¶meters) | 
| Adds a damper.  More... | |
| void | addSplit (const std::string &split_name, const std::string &name, InputParameters ¶meters) | 
| Adds a split.  More... | |
| std::shared_ptr< Split > | getSplit (const std::string &name) | 
| Retrieves a split by name.  More... | |
| MooseObjectWarehouseBase< Split > & | getSplits () | 
| Retrieves all splits.  More... | |
| bool | shouldEvaluatePreSMOResidual () const | 
| We offer the option to check convergence against the pre-SMO residual.  More... | |
| void | setPreSMOResidual (bool use) | 
| Set whether to evaluate the pre-SMO residual and use it in the subsequent relative convergence checks.  More... | |
| const bool & | usePreSMOResidual () const | 
| Whether we are using pre-SMO residual in relative convergence checks.  More... | |
| Real | referenceResidual () const | 
| The reference residual used in relative convergence check.  More... | |
| Real | preSMOResidual () const | 
| The pre-SMO residual.  More... | |
| Real | initialResidual () const | 
| The initial residual.  More... | |
| void | setInitialResidual (Real r) | 
| Record the initial residual (for later relative convergence check)  More... | |
| void | zeroVectorForResidual (const std::string &vector_name) | 
| void | setInitialSolution () | 
| void | setKokkosInitialSolution () | 
| void | setConstraintSecondaryValues (NumericVector< Number > &solution, bool displaced) | 
| Sets the value of constrained variables in the solution vector.  More... | |
| void | constraintResiduals (NumericVector< Number > &residual, bool displaced) | 
| Add residual contributions from Constraints.  More... | |
| void | computeResidualTag (NumericVector< Number > &residual, TagID tag_id) | 
| Computes residual for a given tag.  More... | |
| void | computeResidualTags (const std::set< TagID > &tags) | 
| Form multiple tag-associated residual vectors for all the given tags.  More... | |
| void | computeResidualAndJacobianTags (const std::set< TagID > &vector_tags, const std::set< TagID > &matrix_tags) | 
| Form possibly multiple tag-associated vectors and matrices.  More... | |
| void | computeResidualAndJacobianInternal (const std::set< TagID > &vector_tags, const std::set< TagID > &matrix_tags) | 
| Compute residual and Jacobian from contributions not related to constraints, such as nodal boundary conditions.  More... | |
| void | computeResidual (NumericVector< Number > &residual, TagID tag_id) | 
| Form a residual vector for a given tag.  More... | |
| void | addImplicitGeometricCouplingEntries (GeometricSearchData &geom_search_data) | 
| Adds entries to the Jacobian in the correct positions for couplings coming from dofs being coupled that are related geometrically (i.e.  More... | |
| void | constraintJacobians (const SparseMatrix< Number > &jacobian_to_view, bool displaced) | 
| Add jacobian contributions from Constraints.  More... | |
| void | computeJacobianTags (const std::set< TagID > &tags) | 
| Computes multiple (tag associated) Jacobian matricese.  More... | |
| bool | computeScaling () | 
| Method used to obtain scaling factors for variables.  More... | |
| void | computeJacobian (libMesh::SparseMatrix< Number > &jacobian, const std::set< TagID > &tags) | 
| Associate jacobian to systemMatrixTag, and then form a matrix for all the tags.  More... | |
| void | computeJacobian (libMesh::SparseMatrix< Number > &jacobian) | 
| Take all tags in the system, and form a matrix for all tags in the system.  More... | |
| void | computeJacobianBlocks (std::vector< JacobianBlock *> &blocks) | 
| Computes several Jacobian blocks simultaneously, summing their contributions into smaller preconditioning matrices.  More... | |
| void | computeJacobianBlocks (std::vector< JacobianBlock *> &blocks, const std::set< TagID > &tags) | 
| Real | computeDamping (const NumericVector< Number > &solution, const NumericVector< Number > &update) | 
| Compute damping.  More... | |
| void | onTimestepBegin () | 
| Called at the beginning of the time step.  More... | |
| virtual void | subdomainSetup (SubdomainID subdomain, THREAD_ID tid) | 
| Called from assembling when we hit a new subdomain.  More... | |
| virtual void | subdomainSetup () | 
| virtual void | subdomainSetup () | 
| void | overwriteNodeFace (NumericVector< Number > &soln) | 
| Called from explicit time stepping to overwrite boundary positions (explicit dynamics).  More... | |
| void | updateActive (THREAD_ID tid) | 
| Update active objects of Warehouses owned by NonlinearSystemBase.  More... | |
| virtual void | setSolutionUDot (const NumericVector< Number > &udot) | 
| Set transient term used by residual and Jacobian evaluation.  More... | |
| virtual void | setSolutionUDotDot (const NumericVector< Number > &udotdot) | 
| Set transient term used by residual and Jacobian evaluation.  More... | |
| NumericVector< Number > & | getResidualTimeVector () | 
| Return a numeric vector that is associated with the time tag.  More... | |
| NumericVector< Number > & | getResidualNonTimeVector () | 
| Return a numeric vector that is associated with the nontime tag.  More... | |
| NumericVector< Number > & | residualVector (TagID tag) | 
| Return a residual vector that is associated with the residual tag.  More... | |
| virtual NumericVector< Number > & | residualCopy () override | 
| virtual NumericVector< Number > & | residualGhosted () override | 
| virtual void | augmentSparsity (libMesh::SparsityPattern::Graph &sparsity, std::vector< dof_id_type > &n_nz, std::vector< dof_id_type > &n_oz) override | 
| Will modify the sparsity pattern to add logical geometric connections.  More... | |
| void | setPreconditioner (std::shared_ptr< MoosePreconditioner > pc) | 
| Sets a preconditioner.  More... | |
| MoosePreconditioner const * | getPreconditioner () const | 
| void | useFiniteDifferencedPreconditioner (bool use=true) | 
| If called with true this system will use a finite differenced form of the Jacobian as the preconditioner.  More... | |
| void | useFieldSplitPreconditioner (FieldSplitPreconditionerBase *fsp) | 
| If called with a non-null object true this system will use a field split preconditioner matrix.  More... | |
| FieldSplitPreconditionerBase & | getFieldSplitPreconditioner () | 
| void | addImplicitGeometricCouplingEntriesToJacobian (bool add=true) | 
| If called with true this will add entries into the jacobian to link together degrees of freedom that are found to be related through the geometric search system.  More... | |
| void | assembleConstraintsSeparately (bool separately=true) | 
| Indicates whether to assemble residual and Jacobian after each constraint application.  More... | |
| void | setupDampers () | 
| Setup damping stuff (called before we actually start)  More... | |
| void | reinitIncrementAtQpsForDampers (THREAD_ID tid, const std::set< MooseVariable *> &damped_vars) | 
| Compute the incremental change in variables at QPs for dampers.  More... | |
| void | reinitIncrementAtNodeForDampers (THREAD_ID tid, const std::set< MooseVariable *> &damped_vars) | 
| Compute the incremental change in variables at nodes for dampers.  More... | |
| unsigned int | nNonlinearIterations () const | 
| Return the number of non-linear iterations.  More... | |
| unsigned int | nLinearIterations () const | 
| Return the number of linear iterations.  More... | |
| unsigned int | nResidualEvaluations () const | 
| Return the total number of residual evaluations done so far in this calculation.  More... | |
| Real | finalNonlinearResidual () const | 
| Return the final nonlinear residual.  More... | |
| Real | nonlinearNorm () const | 
| Return the last nonlinear norm.  More... | |
| void | printAllVariableNorms (bool state) | 
| Force the printing of all variable norms after each solve.  More... | |
| void | debuggingResiduals (bool state) | 
| void | setPredictor (std::shared_ptr< Predictor > predictor) | 
| Predictor * | getPredictor () | 
| bool | needBoundaryMaterialOnSide (BoundaryID bnd_id, THREAD_ID tid) const | 
| Indicated whether this system needs material properties on boundaries.  More... | |
| bool | needInterfaceMaterialOnSide (BoundaryID bnd_id, THREAD_ID tid) const | 
| Indicated whether this system needs material properties on interfaces.  More... | |
| bool | needInternalNeighborSideMaterial (SubdomainID subdomain_id, THREAD_ID tid) const | 
| Indicates whether this system needs material properties on internal sides.  More... | |
| bool | doingDG () const | 
| Getter for _doing_dg.  More... | |
| bool | hasSaveIn () const | 
| Weather or not the nonlinear system has save-ins.  More... | |
| bool | hasDiagSaveIn () const | 
| Weather or not the nonlinear system has diagonal Jacobian save-ins.  More... | |
| virtual libMesh::System & | system () override | 
| Get the reference to the libMesh system.  More... | |
| virtual const libMesh::System & | system () const override | 
| virtual void | setSolutionUDotOld (const NumericVector< Number > &u_dot_old) | 
| virtual void | setSolutionUDotDotOld (const NumericVector< Number > &u_dotdot_old) | 
| virtual void | setPreviousNewtonSolution (const NumericVector< Number > &soln) | 
| TagID | timeVectorTag () const override | 
| Ideally, we should not need this API.  More... | |
| TagID | nonTimeVectorTag () const override | 
| TagID | residualVectorTag () const override | 
| TagID | systemMatrixTag () const override | 
| Return the Matrix Tag ID for System.  More... | |
| bool | computeScalingOnce () const | 
| void | computeScalingOnce (bool compute_scaling_once) | 
| void | autoScalingParam (Real resid_vs_jac_scaling_param) | 
| Sets the param that indicates the weighting of the residual vs the Jacobian in determining variable scaling parameters.  More... | |
| void | scalingGroupVariables (const std::vector< std::vector< std::string >> &scaling_group_variables) | 
| void | ignoreVariablesForAutoscaling (const std::vector< std::string > &ignore_variables_for_autoscaling) | 
| bool | offDiagonalsInAutoScaling () const | 
| void | offDiagonalsInAutoScaling (bool off_diagonals_in_auto_scaling) | 
| void | setupDM () | 
| Setup the PETSc DM object (when appropriate)  More... | |
| virtual void | potentiallySetupFiniteDifferencing () | 
| Create finite differencing contexts for assembly of the Jacobian and/or approximating the action of the Jacobian on vectors (e.g.  More... | |
| void | destroyColoring () | 
| Destroy the coloring object if it exists.  More... | |
| virtual void | reinitNodeFace (const Node *node, BoundaryID bnd_id, THREAD_ID tid) | 
| Reinit nodal assembly info on a face.  More... | |
| virtual void | reinitNodeFace (const Node *node, BoundaryID bnd_id, THREAD_ID tid) | 
| Reinit nodal assembly info on a face.  More... | |
| virtual void | restoreSolutions () override final | 
| Restore current solutions (call after your solve failed)  More... | |
| void | serializeSolution () | 
| void | setSolution (const NumericVector< Number > &soln) | 
| Set the solution to a given vector.  More... | |
| void | setPCSide (MooseEnum pcs) | 
| Set the side on which the preconditioner is applied to.  More... | |
| Moose::PCSideType | getPCSide () | 
| Get the current preconditioner side.  More... | |
| void | setMooseKSPNormType (MooseEnum kspnorm) | 
| Set the norm in which the linear convergence will be measured.  More... | |
| Moose::MooseKSPNormType | getMooseKSPNormType () | 
| Get the norm in which the linear convergence is measured.  More... | |
| virtual const NumericVector< Number > *const & | currentSolution () const override final | 
| The solution vector that is currently being operated on.  More... | |
| virtual void | compute (ExecFlagType type) override | 
| Compute time derivatives, auxiliary variables, etc.  More... | |
| unsigned int | number () const | 
| Gets the number of this system.  More... | |
| MooseMesh & | mesh () | 
| const MooseMesh & | mesh () const | 
| SubProblem & | subproblem () | 
| const SubProblem & | subproblem () const | 
| FEProblemBase & | feProblem () | 
| const FEProblemBase & | feProblem () 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... | |
| bool | automaticScaling () const | 
| Getter for whether we are performing automatic scaling.  More... | |
| void | automaticScaling (bool automatic_scaling) | 
| Setter for whether we are performing automatic scaling.  More... | |
| void | setVerboseFlag (const bool &verbose) | 
| Sets the verbose flag.  More... | |
| virtual libMesh::DofMap & | dofMap () | 
| Gets writeable reference to the dof map.  More... | |
| virtual const libMesh::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... | |
| void | update () | 
| Update the system (doing libMesh magic)  More... | |
| virtual void | copyOldSolutions () | 
| Shifts the solutions backwards in time.  More... | |
| virtual void | copyPreviousNonlinearSolutions () | 
| Shifts the solutions backwards in nonlinear iteration history.  More... | |
| virtual void | copyPreviousFixedPointSolutions () | 
| NumericVector< Number > & | solution () | 
| const NumericVector< Number > & | solution () const | 
| NumericVector< Number > & | solutionOld () | 
| const NumericVector< Number > & | solutionOld () const | 
| NumericVector< Number > & | solutionOlder () | 
| const NumericVector< Number > & | solutionOlder () const | 
| virtual const NumericVector< Number > * | solutionPreviousNewton () const | 
| virtual NumericVector< Number > * | solutionPreviousNewton () | 
| virtual void | initSolutionState () | 
| Initializes the solution state.  More... | |
| virtual NumericVector< Number > & | solutionState (const unsigned int state, Moose::SolutionIterationType iteration_type=Moose::SolutionIterationType::Time) | 
| Get a state of the solution (0 = current, 1 = old, 2 = older, etc).  More... | |
| virtual const NumericVector< Number > & | solutionState (const unsigned int state, Moose::SolutionIterationType iteration_type=Moose::SolutionIterationType::Time) const | 
| Get a state of the solution (0 = current, 1 = old, 2 = older, etc).  More... | |
| libMesh::ParallelType | solutionStateParallelType (const unsigned int state, const Moose::SolutionIterationType iteration_type) const | 
| Returns the parallel type of the given solution state.  More... | |
| virtual void | needSolutionState (const unsigned int state, Moose::SolutionIterationType iteration_type=Moose::SolutionIterationType::Time, libMesh::ParallelType parallel_type=GHOSTED) | 
| Registers that the solution state stateis needed.  More... | |
| virtual bool | hasSolutionState (const unsigned int state, Moose::SolutionIterationType iteration_type=Moose::SolutionIterationType::Time) const | 
| Whether or not the system has the solution state (0 = current, 1 = old, 2 = older, etc).  More... | |
| virtual void | addDotVectors () | 
| Add u_dot, u_dotdot, u_dot_old and u_dotdot_old vectors if requested by the time integrator.  More... | |
| virtual std::vector< Number > & | duDotDus () | 
| virtual Number & | duDotDotDu () | 
| virtual const Number & | duDotDotDu () const | 
| virtual const Number & | duDotDu (unsigned int var_num=0) const | 
| virtual NumericVector< Number > * | solutionUDot () | 
| virtual const NumericVector< Number > * | solutionUDot () const | 
| virtual NumericVector< Number > * | solutionUDotDot () | 
| virtual const NumericVector< Number > * | solutionUDotDot () const | 
| virtual NumericVector< Number > * | solutionUDotOld () | 
| virtual const NumericVector< Number > * | solutionUDotOld () const | 
| virtual NumericVector< Number > * | solutionUDotDotOld () | 
| virtual const NumericVector< Number > * | solutionUDotDotOld () const | 
| 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 bool | hasVector (TagID tag_id) const | 
| Check if the tagged vector exists in the system.  More... | |
| virtual void | associateVectorToTag (NumericVector< Number > &vec, TagID tag) | 
| Associate a vector for a given tag.  More... | |
| virtual void | disassociateVectorFromTag (NumericVector< Number > &vec, TagID tag) | 
| Disassociate a given vector from a given tag.  More... | |
| virtual void | disassociateVectorFromTag (TagID tag) | 
| Disassociate any vector that is associated with a given tag.  More... | |
| virtual void | disassociateDefaultVectorTags () | 
| Disassociate the vectors associated with the default vector tags of this system.  More... | |
| virtual bool | hasMatrix (TagID tag) const | 
| Check if the tagged matrix exists in the system.  More... | |
| virtual libMesh::SparseMatrix< Number > & | getMatrix (TagID tag) | 
| Get a raw SparseMatrix.  More... | |
| virtual const libMesh::SparseMatrix< Number > & | getMatrix (TagID tag) const | 
| Get a raw SparseMatrix.  More... | |
| virtual void | activateAllMatrixTags () | 
| Make all existing matrices active.  More... | |
| virtual bool | matrixTagActive (TagID tag) const | 
| If or not a matrix tag is active.  More... | |
| virtual void | deactivateAllMatrixTags () | 
| Make matrices inactive.  More... | |
| void | closeTaggedMatrices (const std::set< TagID > &tags) | 
| Close all matrices associated the tags.  More... | |
| void | flushTaggedMatrices (const std::set< TagID > &tags) | 
| flushes all matrices associated to tags.  More... | |
| virtual void | associateMatrixToTag (libMesh::SparseMatrix< Number > &matrix, TagID tag) | 
| Associate a matrix to a tag.  More... | |
| virtual void | disassociateMatrixFromTag (libMesh::SparseMatrix< Number > &matrix, TagID tag) | 
| Disassociate a matrix from a tag.  More... | |
| virtual void | disassociateMatrixFromTag (TagID tag) | 
| Disassociate any matrix that is associated with a given tag.  More... | |
| virtual void | disassociateDefaultMatrixTags () | 
| Disassociate the matrices associated with the default matrix tags of this system.  More... | |
| virtual NumericVector< Number > & | serializedSolution () | 
| Returns a reference to a serialized version of the solution vector for this subproblem.  More... | |
| virtual void | augmentSendList (std::vector< dof_id_type > &send_list) | 
| Will modify the send_list to add all of the extra ghosted dofs for this system.  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 | 
| MooseVariableFieldBase & | getVariable (THREAD_ID tid, const std::string &var_name) const | 
| Gets a reference to a variable of with specified name.  More... | |
| MooseVariableFieldBase & | getVariable (THREAD_ID tid, unsigned int var_number) const | 
| 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... | |
| template<typename T > | |
| MooseVariableField< T > & | getActualFieldVariable (THREAD_ID tid, const std::string &var_name) | 
| Returns a field variable pointer - this includes finite volume variables.  More... | |
| template<typename T > | |
| MooseVariableField< T > & | getActualFieldVariable (THREAD_ID tid, unsigned int var_number) | 
| Returns a field variable pointer - this includes finite volume variables.  More... | |
| template<typename T > | |
| MooseVariableFV< T > & | getFVVariable (THREAD_ID tid, const std::string &var_name) | 
| Return a finite volume variable.  More... | |
| virtual MooseVariableScalar & | getScalarVariable (THREAD_ID tid, const std::string &var_name) const | 
| Gets a reference to a scalar variable with specified number.  More... | |
| virtual MooseVariableScalar & | getScalarVariable (THREAD_ID tid, unsigned int var_number) const | 
| 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... | |
| unsigned int | nFieldVariables () const | 
| Get the number of field variables in this system.  More... | |
| unsigned int | nFVVariables () const | 
| Get the number of finite volume 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 | addVariableToZeroOnResidual (std::string var_name) | 
| Adds this variable to the list of variables to be zeroed during each residual evaluation.  More... | |
| virtual void | addVariableToZeroOnJacobian (std::string var_name) | 
| 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) | 
| Zero out the solution for the list of variables passed in.  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 libMesh::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, THREAD_ID tid) | 
| Reinit assembly info for a side of an element.  More... | |
| virtual void | reinitNeighborFace (const Elem *elem, unsigned int side, 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 | 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< MooseVariableFieldBase * > & | getVariables (THREAD_ID tid) | 
| const std::vector< MooseVariableScalar * > & | getScalarVariables (THREAD_ID tid) | 
| const std::set< SubdomainID > & | getSubdomainsForVar (unsigned int var_number) const | 
| const std::set< SubdomainID > & | getSubdomainsForVar (const std::string &var_name) const | 
| Get the block where a variable of this system is defined.  More... | |
| void | removeVector (const std::string &name) | 
| Remove a vector from the system with the given name.  More... | |
| void | removeVector (TagID tag_id) | 
| Remove a solution length vector from the system with the specified TagID.  More... | |
| NumericVector< Number > & | addVector (const std::string &vector_name, const bool project, const libMesh::ParallelType type) | 
| Adds a solution length vector to the system.  More... | |
| NumericVector< Number > & | addVector (TagID tag, const bool project, const libMesh::ParallelType type) | 
| Adds a solution length vector to the system with the specified TagID.  More... | |
| void | closeTaggedVector (const TagID tag) | 
| Close vector with the given tag.  More... | |
| void | closeTaggedVectors (const std::set< TagID > &tags) | 
| Close all vectors for given tags.  More... | |
| void | zeroTaggedVector (const TagID tag) | 
| Zero vector with the given tag.  More... | |
| void | zeroTaggedVectors (const std::set< TagID > &tags) | 
| Zero all vectors for given tags.  More... | |
| void | setVariableGlobalDoFs (const std::string &var_name) | 
| set all the global dof indices for a variable  More... | |
| const std::vector< dof_id_type > & | getVariableGlobalDoFs () | 
| Get the global dof indices of a variable, this needs to be called after the indices have been set by setVariableGlobalDoFsMore... | |
| libMesh::SparseMatrix< Number > & | addMatrix (TagID tag) | 
| Adds a matrix with a given tag.  More... | |
| void | removeMatrix (TagID tag) | 
| Removes a matrix with a given tag.  More... | |
| virtual const std::string & | name () const | 
| const std::vector< VariableName > & | getVariableNames () const | 
| void | getStandardFieldVariableNames (std::vector< VariableName > &std_field_variables) const | 
| unsigned int | getMaxVariableNumber () const | 
| Returns the maximum number of all variables on the system.  More... | |
| virtual void | computeVariables (const NumericVector< Number > &) | 
| void | copyVars (libMesh::ExodusII_IO &io) | 
| virtual void | copySolutionsBackwards () | 
| Copy current solution into old and older.  More... | |
| void | addTimeIntegrator (const std::string &type, const std::string &name, InputParameters ¶meters) | 
| bool | hasVarCopy () const | 
| Whether or not there are variables to be restarted from an Exodus mesh file.  More... | |
| void | addScalingVector () | 
| Add the scaling factor vector to the system.  More... | |
| bool | solutionStatesInitialized () const | 
| Whether or not the solution states have been initialized via initSolutionState()  More... | |
| void | clearAllDofIndices () | 
| Clear all dof indices from moose variables.  More... | |
| void | setActiveVariableCoupleableVectorTags (const std::set< TagID > &vtags, THREAD_ID tid) | 
| Set the active vector tags for the variables.  More... | |
| void | setActiveScalarVariableCoupleableVectorTags (const std::set< TagID > &vtags, THREAD_ID tid) | 
| Set the active vector tags for the scalar variables.  More... | |
| Moose::VarKindType | varKind () const | 
| const std::vector< std::unique_ptr< NumericVector< Number > > > & | gradientContainer () const | 
| Reference to the container vector which hold gradients at dofs (if it can be interpreted).  More... | |
| void | copyTimeIntegrators (const SystemBase &other_sys) | 
| Copy time integrators from another system.  More... | |
| const TimeIntegrator & | getTimeIntegrator (const unsigned int var_num) const | 
| Retrieve the time integrator that integrates the given variable's equation.  More... | |
| const TimeIntegrator * | queryTimeIntegrator (const unsigned int var_num) const | 
| Retrieve the time integrator that integrates the given variable's equation.  More... | |
| const std::vector< std::shared_ptr< TimeIntegrator > > & | getTimeIntegrators () | 
| std::string | prefix () const | 
| void | sizeVariableMatrixData () | 
| size the matrix data for each variable for the number of matrix tags we have  More... | |
| const Parallel::Communicator & | comm () const | 
| processor_id_type | n_processors () const | 
| processor_id_type | processor_id () const | 
| PerfGraph & | perfGraph () | 
| Get the PerfGraph.  More... | |
| void | checkKernelCoverage (const std::set< SubdomainID > &mesh_subdomains) const | 
| virtual bool | containsTimeKernel () override | 
| If the system has a kernel that corresponds to a time derivative.  More... | |
| virtual std::vector< std::string > | timeKernelVariableNames () override | 
| Returns the names of the variables that have time derivative kernels in the system.  More... | |
| MooseObjectTagWarehouse< KernelBase > & | getKernelWarehouse () | 
| Access functions to Warehouses from outside NonlinearSystemBase.  More... | |
| const MooseObjectTagWarehouse< KernelBase > & | getKernelWarehouse () const | 
| MooseObjectTagWarehouse< DGKernelBase > & | getDGKernelWarehouse () | 
| MooseObjectTagWarehouse< InterfaceKernelBase > & | getInterfaceKernelWarehouse () | 
| MooseObjectTagWarehouse< DiracKernelBase > & | getDiracKernelWarehouse () | 
| MooseObjectTagWarehouse< IntegratedBCBase > & | getIntegratedBCWarehouse () | 
| const MooseObjectTagWarehouse< IntegratedBCBase > & | getIntegratedBCWarehouse () const | 
| Return the IntegratedBCBase warehouse.  More... | |
| const MooseObjectTagWarehouse< ScalarKernelBase > & | getScalarKernelWarehouse () const | 
| const MooseObjectTagWarehouse< NodalKernelBase > & | getNodalKernelWarehouse () const | 
| MooseObjectTagWarehouse< HDGKernel > & | getHDGKernelWarehouse () | 
| const MooseObjectWarehouse< ElementDamper > & | getElementDamperWarehouse () const | 
| const MooseObjectWarehouse< NodalDamper > & | getNodalDamperWarehouse () const | 
| const ConstraintWarehouse & | getConstraintWarehouse () const | 
| const MooseObjectTagWarehouse< NodalBCBase > & | getNodalBCWarehouse () const | 
| Return the NodalBCBase warehouse.  More... | |
| MooseObjectTagWarehouse< ResidualObject > & | getKokkosKernelWarehouse () | 
| MooseObjectTagWarehouse< ResidualObject > & | getKokkosNodalKernelWarehouse () | 
| MooseObjectTagWarehouse< ResidualObject > & | getKokkosNodalBCWarehouse () | 
| MooseObjectTagWarehouse< ResidualObject > & | getKokkosIntegratedBCWarehouse () | 
| virtual NumericVector< Number > & | getVector (const std::string &name) | 
| Get a raw NumericVector by name.  More... | |
| virtual const NumericVector< Number > & | getVector (const std::string &name) const | 
| virtual NumericVector< Number > & | getVector (TagID tag) | 
| Get a raw NumericVector by tag.  More... | |
| virtual const NumericVector< Number > & | getVector (TagID tag) const | 
| 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 | 
| Static Public Member Functions | |
| static InputParameters | validParams () | 
| Public Attributes | |
| unsigned int | _num_residual_evaluations | 
| libMesh::System & | _sys | 
| Real | _last_nl_rnorm | 
| std::vector< unsigned int > | _current_l_its | 
| unsigned int | _current_nl_its | 
| const ConsoleStream | _console | 
| An instance of helper class to write streams to the Console objects.  More... | |
| Protected Member Functions | |
| virtual void | postAddResidualObject (ResidualObject &object) override | 
| Called after any ResidualObject-derived objects are added to the system.  More... | |
| void | computeScalingJacobian () override | 
| Compute a "Jacobian" for automatic scaling purposes.  More... | |
| void | computeScalingResidual () override | 
| Compute a "residual" for automatic scaling purposes.  More... | |
| void | computeResidualInternal (const std::set< TagID > &tags) | 
| Compute the residual for a given tag.  More... | |
| void | computeKokkosResidual (const std::set< TagID > &tags) | 
| Compute residual with Kokkos objects.  More... | |
| void | computeNodalBCs (NumericVector< Number > &residual) | 
| Enforces nodal boundary conditions.  More... | |
| void | computeNodalBCs (NumericVector< Number > &residual, const std::set< TagID > &tags) | 
| Form a residual for BCs that at least has one of the given tags.  More... | |
| void | computeNodalBCs (const std::set< TagID > &tags) | 
| Form multiple tag-associated residual vectors for the given tags.  More... | |
| void | computeNodalBCsResidualAndJacobian () | 
| compute the residual and Jacobian for nodal boundary conditions  More... | |
| void | computeJacobianInternal (const std::set< TagID > &tags) | 
| Form multiple matrices for all the tags.  More... | |
| void | computeKokkosJacobian (const std::set< TagID > &tags) | 
| Compute Jacobian with Kokkos objects.  More... | |
| void | computeDiracContributions (const std::set< TagID > &tags, bool is_jacobian) | 
| void | computeScalarKernelsJacobians (const std::set< TagID > &tags) | 
| void | enforceNodalConstraintsResidual (NumericVector< Number > &residual) | 
| Enforce nodal constraints.  More... | |
| void | enforceNodalConstraintsJacobian () | 
| void | mortarConstraints (Moose::ComputeType compute_type, const std::set< TagID > &vector_tags, const std::set< TagID > &matrix_tags) | 
| Do mortar constraint residual/jacobian computations.  More... | |
| void | assembleScalingVector () | 
| Assemble the numeric vector of scaling factors such that it can be used during assembly of the system matrix.  More... | |
| void | reinitNodeFace (const Node &secondary_node, const BoundaryID secondary_boundary, const PenetrationInfo &info, const bool displaced) | 
| Reinitialize quantities such as variables, residuals, Jacobians, materials for node-face constraints.  More... | |
| bool | preSolve () | 
| Perform some steps to get ready for the solver.  More... | |
| void | getNodeDofs (dof_id_type node_id, std::vector< dof_id_type > &dofs) | 
| void | checkInvalidSolution () | 
| virtual NumericVector< Number > & | solutionInternal () const override final | 
| Internal getter for solution owned by libMesh.  More... | |
| virtual bool | matrixFromColoring () const | 
| Whether a system matrix is formed from coloring.  More... | |
| PerfID | registerTimedSection (const std::string §ion_name, const unsigned int level) const | 
| Call to register a named section for timing.  More... | |
| PerfID | registerTimedSection (const std::string §ion_name, const unsigned int level, const std::string &live_message, const bool print_dots=true) const | 
| Call to register a named section for timing.  More... | |
| std::string | timedSectionName (const std::string §ion_name) const | 
| Protected Attributes | |
| libMesh::CondensedEigenSystem & | _eigen_sys | 
| EigenProblem & | _eigen_problem | 
| std::unique_ptr< SlepcEigenSolverConfiguration > | _solver_configuration | 
| std::vector< std::pair< Real, Real > > | _eigen_values | 
| unsigned int | _n_eigen_pairs_required | 
| NumericVector< Number > & | _work_rhs_vector_AX | 
| NumericVector< Number > & | _work_rhs_vector_BX | 
| TagID | _Ax_tag | 
| TagID | _Bx_tag | 
| TagID | _A_tag | 
| TagID | _B_tag | 
| TagID | _precond_tag | 
| bool | _precond_matrix_includes_eigen | 
| libMesh::Preconditioner< Number > * | _preconditioner | 
| dof_id_type | _num_constrained_dofs | 
| The number of degrees of freedom constrained at the libMesh level, e.g.  More... | |
| const Parallel::Communicator & | _communicator | 
| NumericVector< Number > * | _residual_ghosted | 
| ghosted form of the residual  More... | |
| std::unique_ptr< NumericVector< Number > > | _residual_copy | 
| Copy of the residual vector, or nullptr if a copy is not needed.  More... | |
| Number | _du_dot_du | 
| \( {du^dot}\over{du} \)  More... | |
| Number | _du_dotdot_du | 
| \( {du^dotdot}\over{du} \)  More... | |
| TagID | _Re_time_tag | 
| Tag for time contribution residual.  More... | |
| std::set< TagID > | _nl_vector_tags | 
| Vector tags to temporarily store all tags associated with the current system.  More... | |
| std::set< TagID > | _nl_matrix_tags | 
| Matrix tags to temporarily store all tags associated with the current system.  More... | |
| NumericVector< Number > * | _Re_time | 
| residual vector for time contributions  More... | |
| TagID | _Re_non_time_tag | 
| Tag for non-time contribution residual.  More... | |
| NumericVector< Number > * | _Re_non_time | 
| residual vector for non-time contributions  More... | |
| TagID | _Re_tag | 
| Used for the residual vector from PETSc.  More... | |
| TagID | _Ke_non_time_tag | 
| Tag for non-time contribution Jacobian.  More... | |
| TagID | _Ke_system_tag | 
| Tag for system contribution Jacobian.  More... | |
| MooseObjectTagWarehouse< DiracKernelBase > | _dirac_kernels | 
| Dirac Kernel storage for each thread.  More... | |
| MooseObjectWarehouse< ElementDamper > | _element_dampers | 
| Element Dampers for each thread.  More... | |
| MooseObjectWarehouse< NodalDamper > | _nodal_dampers | 
| Nodal Dampers for each thread.  More... | |
| MooseObjectWarehouse< GeneralDamper > | _general_dampers | 
| General Dampers.  More... | |
| MooseObjectTagWarehouse< NodalKernelBase > | _nodal_kernels | 
| NodalKernels for each thread.  More... | |
| MooseObjectWarehouseBase< Split > | _splits | 
| Decomposition splits.  More... | |
| ConstraintWarehouse | _constraints | 
| Constraints storage object.  More... | |
| NumericVector< Number > * | _increment_vec | 
| increment vector  More... | |
| bool | _use_finite_differenced_preconditioner | 
| Whether or not to use a finite differenced preconditioner.  More... | |
| MatFDColoring | _fdcoloring | 
| FieldSplitPreconditionerBase * | _fsp | 
| The field split preconditioner if this sytem is using one.  More... | |
| bool | _add_implicit_geometric_coupling_entries_to_jacobian | 
| Whether or not to add implicit geometric couplings to the Jacobian for FDP.  More... | |
| bool | _assemble_constraints_separately | 
| Whether or not to assemble the residual and Jacobian after the application of each constraint.  More... | |
| bool | _need_residual_ghosted | 
| Whether or not a ghosted copy of the residual needs to be made.  More... | |
| bool | _debugging_residuals | 
| true if debugging residuals  More... | |
| bool | _doing_dg | 
| true if DG is active (optimization reasons)  More... | |
| std::vector< std::string > | _vecs_to_zero_for_residual | 
| vectors that will be zeroed before a residual computation  More... | |
| unsigned int | _n_iters | 
| unsigned int | _n_linear_iters | 
| unsigned int | _n_residual_evaluations | 
| Total number of residual evaluations that have been performed.  More... | |
| Real | _final_residual | 
| std::shared_ptr< Predictor > | _predictor | 
| If predictor is active, this is non-NULL.  More... | |
| bool | _computing_pre_smo_residual | 
| Real | _pre_smo_residual | 
| The pre-SMO residual, see setPreSMOResidual for a detailed explanation.  More... | |
| Real | _initial_residual | 
| The initial (i.e., 0th nonlinear iteration) residual, see setPreSMOResidual for a detailed explanation.  More... | |
| bool | _use_pre_smo_residual | 
| Whether to use the pre-SMO initial residual in the relative convergence check.  More... | |
| bool | _print_all_var_norms | 
| bool | _has_save_in | 
| If there is any Kernel or IntegratedBC having save_in.  More... | |
| bool | _has_diag_save_in | 
| If there is any Kernel or IntegratedBC having diag_save_in.  More... | |
| bool | _has_nodalbc_save_in | 
| If there is a nodal BC having save_in.  More... | |
| bool | _has_nodalbc_diag_save_in | 
| If there is a nodal BC having diag_save_in.  More... | |
| bool | _computed_scaling | 
| Flag used to indicate whether we have already computed the scaling Jacobian.  More... | |
| bool | _compute_scaling_once | 
| Whether the scaling factors should only be computed once at the beginning of the simulation through an extra Jacobian evaluation.  More... | |
| Real | _resid_vs_jac_scaling_param | 
| The param that indicates the weighting of the residual vs the Jacobian in determining variable scaling parameters.  More... | |
| std::vector< std::vector< std::string > > | _scaling_group_variables | 
| A container of variable groupings that can be used in scaling calculations.  More... | |
| std::vector< bool > | _variable_autoscaled | 
| Container to hold flag if variable is to participate in autoscaling.  More... | |
| std::vector< std::string > | _ignore_variables_for_autoscaling | 
| A container for variables that do not partipate in autoscaling.  More... | |
| bool | _off_diagonals_in_auto_scaling | 
| Whether to include off diagonals when determining automatic scaling factors.  More... | |
| std::unique_ptr< libMesh::DiagonalMatrix< Number > > | _scaling_matrix | 
| A diagonal matrix used for computing scaling.  More... | |
| const NumericVector< Number > * | _current_solution | 
| solution vector from solver  More... | |
| Moose::PCSideType | _pc_side | 
| Preconditioning side.  More... | |
| Moose::MooseKSPNormType | _ksp_norm | 
| KSP norm type.  More... | |
| bool | _solution_is_invalid | 
| Boolean to see if solution is invalid.  More... | |
| SubProblem & | _subproblem | 
| The subproblem for whom this class holds variable data, etc; this can either be the governing finite element/volume problem or a subjugate displaced problem.  More... | |
| FEProblemBase & | _fe_problem | 
| the governing finite element/volume problem  More... | |
| 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 | 
| NumericVector< Number > * | _u_dot | 
| solution vector for u^dot  More... | |
| NumericVector< Number > * | _u_dotdot | 
| solution vector for u^dotdot  More... | |
| NumericVector< Number > * | _u_dot_old | 
| old solution vector for u^dot  More... | |
| NumericVector< Number > * | _u_dotdot_old | 
| old solution vector for u^dotdot  More... | |
| std::vector< NumericVector< Number > * > | _tagged_vectors | 
| Tagged vectors (pointer)  More... | |
| std::vector< libMesh::SparseMatrix< Number > * > | _tagged_matrices | 
| Tagged matrices (pointer)  More... | |
| std::unordered_map< TagID, libMesh::SparseMatrix< Number > * > | _active_tagged_matrices | 
| Active tagged matrices. A matrix is active if its tag-matrix pair is present in the map. We use a map instead of a vector so that users can easily add and remove to this container with calls to (de)activateMatrixTag.  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::vector< std::shared_ptr< TimeIntegrator > > | _time_integrators | 
| Time integrator.  More... | |
| std::vector< std::vector< MooseVariableFieldBase * > > | _numbered_vars | 
| Map variable number to its pointer.  More... | |
| bool | _automatic_scaling | 
| Whether to automatically scale the variables.  More... | |
| bool | _verbose | 
| True if printing out additional information.  More... | |
| bool | _solution_states_initialized | 
| Whether or not the solution states have been initialized.  More... | |
| std::vector< dof_id_type > | _var_all_dof_indices | 
| Container for the dof indices of a given variable.  More... | |
| std::unique_ptr< NumericVector< Number > > | _serialized_solution | 
| Serialized version of the solution vector, or nullptr if a serialized solution is not needed.  More... | |
| std::vector< std::unique_ptr< NumericVector< Number > > > | _raw_grad_container | 
| A cache for storing gradients at dof locations.  More... | |
| const Parallel::Communicator & | _communicator | 
| MooseApp & | _pg_moose_app | 
| The MooseApp that owns the PerfGraph.  More... | |
| const std::string | _prefix | 
| A prefix to use for all sections.  More... | |
| MooseObjectTagWarehouse< KernelBase > | _kernels | 
| MooseObjectTagWarehouse< HDGKernel > | _hybridized_kernels | 
| MooseObjectTagWarehouse< ScalarKernelBase > | _scalar_kernels | 
| MooseObjectTagWarehouse< DGKernelBase > | _dg_kernels | 
| MooseObjectTagWarehouse< InterfaceKernelBase > | _interface_kernels | 
| MooseObjectTagWarehouse< IntegratedBCBase > | _integrated_bcs | 
| MooseObjectTagWarehouse< NodalBCBase > | _nodal_bcs | 
| MooseObjectWarehouse< DirichletBCBase > | _preset_nodal_bcs | 
| MooseObjectWarehouse< ADDirichletBCBase > | _ad_preset_nodal_bcs | 
| MooseObjectTagWarehouse< ResidualObject > | _kokkos_kernels | 
| MooseObjectTagWarehouse< ResidualObject > | _kokkos_integrated_bcs | 
| MooseObjectTagWarehouse< ResidualObject > | _kokkos_nodal_bcs | 
| MooseObjectWarehouse< ResidualObject > | _kokkos_preset_nodal_bcs | 
| MooseObjectTagWarehouse< ResidualObject > | _kokkos_nodal_kernels | 
Nonlinear eigenvalue system to be solved.
Definition at line 36 of file NonlinearEigenSystem.h.
| NonlinearEigenSystem::NonlinearEigenSystem | ( | EigenProblem & | problem, | 
| const std::string & | name | ||
| ) | 
Definition at line 108 of file NonlinearEigenSystem.C.
| NonlinearEigenSystem::NonlinearEigenSystem | ( | EigenProblem & | problem, | 
| const std::string & | name | ||
| ) | 
| 
 | virtualinherited | 
Make all existing matrices active.
Definition at line 1131 of file SystemBase.C.
Referenced by NonlinearSystemBase::computeJacobianInternal(), LinearSystem::computeLinearSystemInternal(), NonlinearSystemBase::computeResidualAndJacobianInternal(), and NonlinearSystemBase::computeResidualTags().
| 
 | inherited | 
Adds a boundary condition.
| bc_name | The type of the boundary condition | 
| name | The name of the boundary condition | 
| parameters | Boundary condition parameters | 
Definition at line 545 of file NonlinearSystemBase.C.
| 
 | inherited | 
Adds a Constraint.
| c_name | The type of the constraint | 
| name | The name of the constraint | 
| parameters | Constraint parameters | 
Definition at line 633 of file NonlinearSystemBase.C.
| 
 | inherited | 
Adds a damper.
| damper_name | The type of the damper | 
| name | The name of the damper | 
| parameters | Damper parameters | 
Definition at line 706 of file NonlinearSystemBase.C.
| 
 | inherited | 
Adds a DG kernel.
| dg_kernel_name | The type of the DG kernel | 
| name | The name of the DG kernel | 
| parameters | DG kernel parameters | 
Definition at line 662 of file NonlinearSystemBase.C.
| 
 | inherited | 
Adds a Dirac kernel.
| kernel_name | The type of the dirac kernel | 
| name | The name of the Dirac kernel | 
| parameters | Dirac kernel parameters | 
Definition at line 646 of file NonlinearSystemBase.C.
| 
 | virtualinherited | 
Add u_dot, u_dotdot, u_dot_old and u_dotdot_old vectors if requested by the time integrator.
Reimplemented in DisplacedSystem.
Definition at line 1633 of file SystemBase.C.
Referenced by DisplacedSystem::addDotVectors().
| 
 | virtualinherited | 
Adds a hybridized discontinuous Galerkin (HDG) kernel.
| kernel_name | The type of the hybridized kernel | 
| name | The name of the hybridized kernel | 
| parameters | HDG kernel parameters | 
Definition at line 493 of file NonlinearSystemBase.C.
| 
 | inherited | 
Adds entries to the Jacobian in the correct positions for couplings coming from dofs being coupled that are related geometrically (i.e.
near each other across a gap).
Definition at line 2325 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeJacobianInternal().
| 
 | inlineinherited | 
If called with true this will add entries into the jacobian to link together degrees of freedom that are found to be related through the geometric search system.
These entries are really only used by the Finite Difference Preconditioner and the constraint system right now.
Definition at line 510 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addConstraint(), and FiniteDifferencePreconditioner::FiniteDifferencePreconditioner().
| 
 | inherited | 
Adds an interface kernel.
| interface_kernel_name | The type of the interface kernel | 
| name | The name of the interface kernel | 
| parameters | interface kernel parameters | 
Definition at line 684 of file NonlinearSystemBase.C.
| 
 | virtualinherited | 
Adds a kernel.
| kernel_name | The type of the kernel | 
| name | The name of the kernel | 
| parameters | Kernel parameters | 
Reimplemented in MooseEigenSystem.
Definition at line 471 of file NonlinearSystemBase.C.
| 
 | inherited | 
Adds a Kokkos boundary condition.
| bc_name | The type of the boundary condition | 
| name | The name of the boundary condition | 
| parameters | Boundary condition parameters | 
| 
 | virtualinherited | 
Adds a Kokkos kernel.
| kernel_name | The type of the kernel | 
| name | The name of the kernel | 
| parameters | Kernel parameters | 
| 
 | virtualinherited | 
Adds a Kokkos nodal kernel.
| kernel_name | The type of the nodal kernel | 
| name | The name of the kernel | 
| parameters | Kernel parameters | 
| 
 | inherited | 
Adds a matrix with a given tag.
| tag_name | The name of the tag | 
Definition at line 570 of file SystemBase.C.
| 
 | virtualinherited | 
Adds a NodalKernel.
| kernel_name | The type of the nodal kernel | 
| name | The name of the kernel | 
| parameters | Kernel parameters | 
Definition at line 510 of file NonlinearSystemBase.C.
| 
 | inherited | 
Adds a scalar kernel.
| kernel_name | The type of the kernel | 
| name | The name of the kernel | 
| parameters | Kernel parameters | 
Definition at line 532 of file NonlinearSystemBase.C.
| 
 | inherited | 
Add the scaling factor vector to the system.
Definition at line 1545 of file SystemBase.C.
Referenced by MooseVariableBase::initialSetup().
| 
 | inherited | 
Adds a split.
| split_name | The type of the split | 
| name | The name of the split | 
| parameters | Split parameters | 
Definition at line 734 of file NonlinearSystemBase.C.
| 
 | inherited | 
Definition at line 1658 of file SystemBase.C.
| 
 | 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 718 of file SystemBase.C.
Referenced by AuxiliarySystem::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 1175 of file SystemBase.C.
Referenced by CopyNodalVarsAction::act(), and PhysicsBase::copyVariablesFromMesh().
| 
 | virtualinherited | 
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 in DisplacedSystem.
Definition at line 180 of file SystemBase.C.
Referenced by ADDGKernel::ADDGKernel(), DisplacedSystem::addVariableToZeroOnJacobian(), ADIntegratedBCTempl< T >::ADIntegratedBCTempl(), ADKernelTempl< T >::ADKernelTempl(), ArrayDGKernel::ArrayDGKernel(), ArrayIntegratedBC::ArrayIntegratedBC(), ArrayKernel::ArrayKernel(), DGKernel::DGKernel(), IntegratedBC::IntegratedBC(), InterfaceKernelTempl< T >::InterfaceKernelTempl(), Kernel::Kernel(), NodalBC::NodalBC(), and NodalKernel::NodalKernel().
| 
 | virtualinherited | 
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 in DisplacedSystem.
Definition at line 174 of file SystemBase.C.
Referenced by ADDGKernel::ADDGKernel(), DisplacedSystem::addVariableToZeroOnResidual(), ADIntegratedBCTempl< T >::ADIntegratedBCTempl(), ADKernelTempl< T >::ADKernelTempl(), ArrayDGKernel::ArrayDGKernel(), ArrayIntegratedBC::ArrayIntegratedBC(), ArrayKernel::ArrayKernel(), DGKernel::DGKernel(), IntegratedBC::IntegratedBC(), InterfaceKernelTempl< T >::InterfaceKernelTempl(), Kernel::Kernel(), NodalBC::NodalBC(), and NodalKernel::NodalKernel().
| 
 | inherited | 
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. | 
Referenced by SystemBase::addDotVectors(), SystemBase::addScalingVector(), NonlinearTimeIntegratorInterface::addVector(), SecantSolve::allocateStorage(), SteffensenSolve::allocateStorage(), PicardSolve::allocateStorage(), NonlinearSystemBase::getResidualNonTimeVector(), NonlinearSystemBase::getResidualTimeVector(), CentralDifference::initialSetup(), SystemBase::needSolutionState(), 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. | 
| 
 | 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 1495 of file SystemBase.C.
Referenced by NonlinearSystemBase::computeScaling().
| 
 | inlineinherited | 
Indicates whether to assemble residual and Jacobian after each constraint application.
When true, enables "transitive" constraint application: subsequent constraints can use prior constraints' results.
Definition at line 520 of file NonlinearSystemBase.h.
| 
 | protectedinherited | 
Assemble the numeric vector of scaling factors such that it can be used during assembly of the system matrix.
Definition at line 4169 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeScaling(), and NonlinearSystemBase::preSolve().
| 
 | inlineinherited | 
assign the maximum element dofs
Definition at line 597 of file SystemBase.h.
| 
 | inlineinherited | 
assign the maximum node dofs
Definition at line 602 of file SystemBase.h.
| 
 | virtualinherited | 
Associate a matrix to a tag.
Reimplemented in DisplacedSystem.
Definition at line 1076 of file SystemBase.C.
Referenced by SystemBase::addMatrix(), DisplacedSystem::associateMatrixToTag(), NonlinearSystemBase::computeJacobian(), FEProblemBase::computeJacobianInternal(), FEProblemBase::computeJacobianTag(), FEProblemBase::computeLinearSystemSys(), and FEProblemBase::computeResidualAndJacobian().
| 
 | virtualinherited | 
Associate a vector for a given tag.
Reimplemented in DisplacedSystem.
Definition at line 981 of file SystemBase.C.
Referenced by DisplacedSystem::associateVectorToTag(), FEProblemBase::computeLinearSystemSys(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualInternal(), NonlinearSystemBase::computeResidualTag(), FEProblemBase::computeResidualTag(), FEProblemBase::computeResidualType(), LinearSystem::LinearSystem(), and SolverSystem::setSolution().
| 
 | overridevirtual | 
Attach a customized preconditioner that requires physics knowledge.
Generic preconditioners should be implemented in PETSc, instead.
Implements NonlinearSystemBase.
Definition at line 526 of file NonlinearEigenSystem.C.
| void NonlinearEigenSystem::attachSLEPcCallbacks | ( | ) | 
Definition at line 300 of file NonlinearEigenSystem.C.
| 
 | virtualinherited | 
Will modify the send_list to add all of the extra ghosted dofs for this system.
Reimplemented in DisplacedSystem.
Definition at line 452 of file SystemBase.C.
Referenced by DisplacedSystem::augmentSendList(), and extraSendList().
| 
 | overridevirtualinherited | 
Will modify the sparsity pattern to add logical geometric connections.
Implements SystemBase.
Definition at line 3549 of file NonlinearSystemBase.C.
| 
 | inlineinherited | 
Getter for whether we are performing automatic scaling.
Definition at line 122 of file SystemBase.h.
Referenced by SubProblem::automaticScaling().
| 
 | inlineinherited | 
Setter for whether we are performing automatic scaling.
| automatic_scaling | A boolean representing whether we are performing automatic scaling | 
Definition at line 128 of file SystemBase.h.
Sets the param that indicates the weighting of the residual vs the Jacobian in determining variable scaling parameters.
A value of 1 indicates pure residual-based scaling. A value of 0 indicates pure Jacobian-based scaling
Definition at line 725 of file NonlinearSystemBase.h.
| void NonlinearEigenSystem::checkIntegrity | ( | ) | 
For eigenvalue problems (including standard and generalized), inhomogeneous (Dirichlet or Neumann) boundary conditions are not allowed.
Definition at line 468 of file NonlinearEigenSystem.C.
| 
 | inline | 
Definition at line 228 of file NonlinearEigenSystem.h.
| 
 | protectedinherited | 
Definition at line 111 of file SolverSystem.C.
Referenced by NonlinearSystem::solve(), and LinearSystem::solve().
| 
 | inherited | 
System Integrity Checks
Definition at line 3671 of file NonlinearSystemBase.C.
| 
 | inherited | 
Clear all dof indices from moose variables.
Definition at line 1613 of file SystemBase.C.
Referenced by SubProblem::clearAllDofIndices().
Close all matrices associated the tags.
Definition at line 1060 of file SystemBase.C.
Referenced by NonlinearSystemBase::computeJacobianInternal(), LinearSystem::computeLinearSystemInternal(), and NonlinearSystemBase::computeResidualAndJacobianTags().
Close vector with the given tag.
Definition at line 649 of file SystemBase.C.
Referenced by SystemBase::closeTaggedVectors().
Close all vectors for given tags.
Definition at line 667 of file SystemBase.C.
Referenced by NonlinearSystemBase::computeResidualAndJacobianTags(), NonlinearSystemBase::computeResidualTags(), NonlinearSystem::stopSolve(), and LinearSystem::stopSolve().
| 
 | overridevirtualinherited | 
Compute time derivatives, auxiliary variables, etc.
| type | Our current execution stage | 
Implements SystemBase.
Reimplemented in LinearSystem.
Definition at line 134 of file SolverSystem.C.
| 
 | inherited | 
Compute damping.
| solution | The trail solution vector | 
| update | The incremental update to the solution vector | 
Definition at line 3390 of file NonlinearSystemBase.C.
Referenced by FEProblemBase::computeDamping().
| 
 | protectedinherited | 
Definition at line 3476 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeJacobianInternal(), and NonlinearSystemBase::computeResidualInternal().
| 
 | inlineinherited | 
Definition at line 78 of file NonlinearSystemBase.h.
| 
 | inherited | 
Associate jacobian to systemMatrixTag, and then form a matrix for all the tags.
Definition at line 3230 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeJacobian().
| 
 | inherited | 
Take all tags in the system, and form a matrix for all tags in the system.
Definition at line 3217 of file NonlinearSystemBase.C.
| 
 | inherited | 
Computes several Jacobian blocks simultaneously, summing their contributions into smaller preconditioning matrices.
Used by Physics-based preconditioning
| blocks | The blocks to fill in (JacobianBlock is defined in ComputeJacobianBlocksThread) | 
Definition at line 3259 of file NonlinearSystemBase.C.
Referenced by EigenProblem::computeJacobianBlocks(), and FEProblemBase::computeJacobianBlocks().
| 
 | inherited | 
Definition at line 3271 of file NonlinearSystemBase.C.
| 
 | protectedinherited | 
Form multiple matrices for all the tags.
Users should not call this func directly.
Definition at line 2846 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeJacobianTags().
Computes multiple (tag associated) Jacobian matricese.
Definition at line 3240 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeJacobian(), and FEProblemBase::computeJacobianTags().
| 
 | protectedinherited | 
Compute Jacobian with Kokkos objects.
Referenced by NonlinearSystemBase::computeJacobianInternal().
| 
 | protectedinherited | 
Compute residual with Kokkos objects.
Referenced by NonlinearSystemBase::computeResidualInternal().
Enforces nodal boundary conditions.
The boundary condition will be implemented in the residual using all the tags in the system.
Referenced by NonlinearSystemBase::computeResidualTags().
| 
 | protectedinherited | 
Form a residual for BCs that at least has one of the given tags.
Form multiple tag-associated residual vectors for the given tags.
Definition at line 2110 of file NonlinearSystemBase.C.
| 
 | protectedinherited | 
compute the residual and Jacobian for nodal boundary conditions
Definition at line 2166 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeResidualAndJacobianTags().
| 
 | inherited | 
Form a residual vector for a given tag.
Definition at line 820 of file NonlinearSystemBase.C.
| 
 | inherited | 
Compute residual and Jacobian from contributions not related to constraints, such as nodal boundary conditions.
Definition at line 1991 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeResidualAndJacobianTags().
| 
 | inherited | 
Form possibly multiple tag-associated vectors and matrices.
Definition at line 908 of file NonlinearSystemBase.C.
Referenced by FEProblemBase::computeResidualAndJacobian().
| 
 | protectedinherited | 
Compute the residual for a given tag.
| tags | The tags of kernels for which the residual is to be computed. | 
Definition at line 1766 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeResidualTags().
| 
 | inherited | 
Computes residual for a given tag.
| residual | Residual is formed in here | 
| the | tag of kernels for which the residual is to be computed. | 
Definition at line 806 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeResidual(), and CrankNicolson::init().
Form multiple tag-associated residual vectors for all the given tags.
Definition at line 828 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeResidualTag(), and FEProblemBase::computeResidualTags().
| 
 | protectedinherited | 
Definition at line 2760 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeJacobianInternal().
| 
 | inherited | 
Method used to obtain scaling factors for variables.
Definition at line 4008 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::preSolve().
| 
 | overrideprotectedvirtual | 
Compute a "Jacobian" for automatic scaling purposes.
Implements NonlinearSystemBase.
Definition at line 557 of file NonlinearEigenSystem.C.
| 
 | inlineinherited | 
Definition at line 714 of file NonlinearSystemBase.h.
| 
 | inlineinherited | 
Definition at line 715 of file NonlinearSystemBase.h.
| 
 | overrideprotectedvirtual | 
Compute a "residual" for automatic scaling purposes.
Implements NonlinearSystemBase.
Definition at line 563 of file NonlinearEigenSystem.C.
| 
 | inlinevirtualinherited | 
Definition at line 869 of file SystemBase.h.
| 
 | inlineinherited | 
Returns true if this system is currently computing the pre-SMO residual for a solve.
Definition at line 97 of file NonlinearSystemBase.h.
| 
 | inherited | 
Whether we are computing an initial Jacobian for automatic variable scaling.
Definition at line 1552 of file SystemBase.C.
Referenced by Assembly::addJacobianBlock(), Assembly::addJacobianBlockNonlocal(), VectorKernel::computeJacobian(), Kernel::computeJacobian(), EigenKernel::computeJacobian(), and FEProblemBase::computeJacobianTags().
| 
 | inherited | 
Add jacobian contributions from Constraints.
| jacobian | reference to a read-only view of the Jacobian matrix | 
| displaced | Controls whether to do the displaced Constraints or non-displaced | 
Definition at line 2349 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeJacobianInternal().
| 
 | inherited | 
Add residual contributions from Constraints.
| residual | - reference to the residual vector where constraint contributions will be computed | 
| displaced | Controls whether to do the displaced Constraints or non-displaced | 
Definition at line 1362 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeResidualInternal().
| 
 | overridevirtualinherited | 
If the system has a kernel that corresponds to a time derivative.
Implements SolverSystem.
Definition at line 3825 of file NonlinearSystemBase.C.
Referenced by EigenExecutionerBase::checkIntegrity(), and Eigenvalue::checkIntegrity().
| 
 | overridevirtual | 
Returns the convergence state.
Implements SolverSystem.
Definition at line 403 of file NonlinearEigenSystem.C.
| 
 | inlinevirtual | 
Returns the convergence state.
Implements SolverSystem.
Definition at line 226 of file NonlinearEigenSystem.h.
| 
 | virtualinherited | 
Shifts the solutions backwards in time.
Definition at line 1286 of file SystemBase.C.
Referenced by SystemBase::copySolutionsBackwards(), and EigenExecutionerBase::inversePowerIteration().
| 
 | virtualinherited | 
Definition at line 1302 of file SystemBase.C.
Referenced by FixedPointSolve::solveStep().
| 
 | virtualinherited | 
Shifts the solutions backwards in nonlinear iteration history.
Definition at line 1269 of file SystemBase.C.
Referenced by SystemBase::copySolutionsBackwards().
| 
 | virtualinherited | 
Copy current solution into old and older.
Definition at line 1258 of file SystemBase.C.
| 
 | inherited | 
Copy time integrators from another system.
Definition at line 1667 of file SystemBase.C.
| 
 | inherited | 
Definition at line 1183 of file SystemBase.C.
| 
 | inlinefinaloverridevirtualinherited | 
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 117 of file SolverSystem.h.
Referenced by FEProblemBase::computeDamping(), FEProblemBase::computeLinearSystemSys(), FEProblemBase::computeResidualL2Norm(), and AB2PredictorCorrector::step().
| 
 | overridevirtualinherited | 
Reimplemented from SystemBase.
Definition at line 401 of file NonlinearSystemBase.C.
| 
 | virtualinherited | 
Make matrices inactive.
Definition at line 1119 of file SystemBase.C.
Referenced by NonlinearSystemBase::computeResidualTags(), and NonlinearSystemBase::setInitialSolution().
| 
 | inlineinherited | 
Definition at line 589 of file NonlinearSystemBase.h.
| 
 | overridevirtual | 
Get the default matrix tags associted with this system.
Reimplemented from SystemBase.
Definition at line 578 of file NonlinearEigenSystem.C.
| 
 | overridevirtual | 
Get the default vector tags associated with this system.
Reimplemented from SystemBase.
Definition at line 569 of file NonlinearEigenSystem.C.
| 
 | inherited | 
Destroy the coloring object if it exists.
Definition at line 4242 of file NonlinearSystemBase.C.
Referenced by LStableDirk2::solve(), LStableDirk3::solve(), and LStableDirk4::solve().
| 
 | virtualinherited | 
Disassociate the matrices associated with the default matrix tags of this system.
Reimplemented in DisplacedSystem.
Definition at line 1110 of file SystemBase.C.
Referenced by DisplacedSystem::disassociateDefaultMatrixTags().
| 
 | virtualinherited | 
Disassociate the vectors associated with the default vector tags of this system.
Reimplemented in DisplacedSystem.
Definition at line 1015 of file SystemBase.C.
Referenced by DisplacedSystem::disassociateDefaultVectorTags().
| 
 | virtualinherited | 
Disassociate a matrix from a tag.
Reimplemented in DisplacedSystem.
Definition at line 1088 of file SystemBase.C.
Referenced by NonlinearSystemBase::computeJacobian(), FEProblemBase::computeJacobianInternal(), FEProblemBase::computeJacobianTag(), FEProblemBase::computeLinearSystemSys(), FEProblemBase::computeResidualAndJacobian(), SystemBase::disassociateDefaultMatrixTags(), and DisplacedSystem::disassociateMatrixFromTag().
Disassociate any matrix that is associated with a given tag.
Reimplemented in DisplacedSystem.
Definition at line 1099 of file SystemBase.C.
| 
 | virtualinherited | 
Disassociate a given vector from a given tag.
Reimplemented in DisplacedSystem.
Referenced by FEProblemBase::computeLinearSystemSys(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualInternal(), NonlinearSystemBase::computeResidualTag(), FEProblemBase::computeResidualTag(), FEProblemBase::computeResidualType(), SystemBase::disassociateDefaultVectorTags(), DisplacedSystem::disassociateVectorFromTag(), and CentralDifference::initialSetup().
Disassociate any vector that is associated with a given tag.
Reimplemented in DisplacedSystem.
Definition at line 1004 of file SystemBase.C.
| 
 | virtualinherited | 
Gets writeable reference to the dof map.
Definition at line 1163 of file SystemBase.C.
Referenced by NonlinearSystemBase::assembleScalingVector(), MooseApp::attachRelationshipManagers(), SystemBase::augmentSendList(), NonlinearSystemBase::augmentSparsity(), NonlinearSystemBase::computeScaling(), FieldSplitPreconditioner::dofMap(), NonlinearSystemBase::findImplicitGeometricCouplingEntries(), Moose::Kokkos::System::getDofMap(), Adaptivity::init(), initializeCondensedMatrices(), ActivateElementsUserObjectBase::initSolutions(), PNGOutput::makeMeshFunc(), GhostingUserObject::meshChanged(), TableOutput::outputScalarVariables(), Exodus::outputScalarVariables(), and ElementSubdomainModifierBase::setOldAndOlderSolutions().
| 
 | virtualinherited | 
Gets const reference to the dof map.
Definition at line 1169 of file SystemBase.C.
| 
 | inherited | 
Getter for _doing_dg.
Definition at line 3900 of file NonlinearSystemBase.C.
| 
 | inlinevirtualinherited | 
Reimplemented in DisplacedSystem.
Definition at line 257 of file SystemBase.h.
Referenced by DisplacedSystem::duDotDotDu(), and MooseVariableScalar::reinit().
| 
 | inlinevirtualinherited | 
Reimplemented in DisplacedSystem.
Definition at line 1701 of file SystemBase.C.
Referenced by DisplacedSystem::duDotDu(), and MooseVariableScalar::reinit().
| 
 | inlinevirtualinherited | 
Reimplemented in DisplacedSystem.
Definition at line 256 of file SystemBase.h.
Referenced by DisplacedSystem::duDotDus().
| 
 | inline | 
Matrix tag ID of right hand side.
Definition at line 149 of file NonlinearEigenSystem.h.
Referenced by defaultMatrixTags(), Moose::SlepcSupport::mooseEPSFormMatrices(), and Moose::SlepcSupport::mooseSlepcEigenFormJacobianB().
| 
 | inline | 
Vector tag ID of right hand side.
Definition at line 139 of file NonlinearEigenSystem.h.
Referenced by defaultVectorTags(), Moose::SlepcSupport::mooseMatMult_Eigen(), Moose::SlepcSupport::mooseSlepcEigenFormFunctionAB(), and Moose::SlepcSupport::mooseSlepcEigenFormFunctionB().
| 
 | protectedinherited | 
Definition at line 1130 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeJacobianInternal().
| 
 | protectedinherited | 
Enforce nodal constraints.
Definition at line 1105 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeResidualInternal().
| 
 | inlineinherited | 
Definition at line 103 of file SystemBase.h.
Referenced by DMMooseGetEmbedding_Private(), and DMSetUp_Moose_Pre().
| 
 | inlineinherited | 
Definition at line 104 of file SystemBase.h.
| 
 | inlineinherited | 
flushes all matrices associated to tags.
Flush assembles the matrix but doesn't shrink memory allocation
Definition at line 1068 of file SystemBase.C.
| 
 | inherited | 
Returns a field variable pointer - this includes finite volume variables.
Definition at line 118 of file SystemBase.C.
Referenced by BoundsBase::BoundsBase(), Assembly::copyFaceShapes(), Assembly::copyNeighborShapes(), and Assembly::copyShapes().
| 
 | inherited | 
Returns a field variable pointer - this includes finite volume variables.
Definition at line 139 of file SystemBase.C.
| 
 | inline | 
Get the number of converged eigenvalues.
Definition at line 131 of file NonlinearEigenSystem.h.
Referenced by Eigenvalues::execute().
| 
 | inlineinherited | 
Definition at line 649 of file NonlinearSystemBase.h.
| std::pair< Real, Real > NonlinearEigenSystem::getConvergedEigenpair | ( | dof_id_type | n | ) | const | 
Return the Nth converged eigenvalue and copies the respective eigen vector to the solution vector.
Definition at line 515 of file NonlinearEigenSystem.C.
Referenced by solve().
| std::pair< Real, Real > NonlinearEigenSystem::getConvergedEigenvalue | ( | dof_id_type | n | ) | const | 
Return the Nth converged eigenvalue.
Definition at line 506 of file NonlinearEigenSystem.C.
Referenced by solve().
| 
 | overridevirtual | 
Returns the current nonlinear iteration number.
In libmesh, this is updated during the nonlinear solve, so it should be up-to-date.
Implements NonlinearSystemBase.
Definition at line 409 of file NonlinearEigenSystem.C.
| 
 | inlineinherited | 
Definition at line 625 of file NonlinearSystemBase.h.
Referenced by ExplicitTimeIntegrator::initialSetup().
| 
 | inlineinherited | 
Definition at line 630 of file NonlinearSystemBase.h.
| 
 | inlineinherited | 
Definition at line 641 of file NonlinearSystemBase.h.
Referenced by ComputeElemDampingThread::onElement(), and ComputeElemDampingThread::printGeneralExecutionInformation().
| 
 | virtual | 
Retrieve EPS (SLEPc eigen solver)
Definition at line 456 of file NonlinearEigenSystem.C.
Referenced by getSNES(), Moose::SlepcSupport::mooseSlepcEigenFormFunctionA(), Moose::SlepcSupport::mooseSlepcEigenFormFunctionAB(), Moose::SlepcSupport::mooseSlepcEigenFormFunctionB(), and Moose::SlepcSupport::mooseSlepcEigenFormJacobianA().
| 
 | inherited | 
Definition at line 4249 of file NonlinearSystemBase.C.
| 
 | inherited | 
Gets a reference to a variable of with specified name.
This excludes and cannot return finite volume variables.
| tid | Thread id | 
| var_name | variable name | 
Definition at line 111 of file SystemBase.C.
Referenced by Marker::getMarkerValue().
| 
 | inherited | 
Gets a reference to a variable with specified number.
This excludes and cannot return finite volume variables.
| tid | Thread id | 
| var_number | libMesh variable number | 
Definition at line 132 of file SystemBase.C.
| 
 | inherited | 
Return a finite volume variable.
Definition at line 125 of file SystemBase.C.
| 
 | inlineinherited | 
Definition at line 640 of file NonlinearSystemBase.h.
| 
 | inlineinherited | 
Definition at line 631 of file NonlinearSystemBase.h.
Referenced by BoundaryElemIntegrityCheckThread::operator()().
| 
 | inlineinherited | 
Return the IntegratedBCBase warehouse.
Definition at line 659 of file NonlinearSystemBase.h.
| 
 | inlineinherited | 
Definition at line 626 of file NonlinearSystemBase.h.
| 
 | inlineinherited | 
Access functions to Warehouses from outside NonlinearSystemBase.
Definition at line 623 of file NonlinearSystemBase.h.
Referenced by ExplicitTimeIntegrator::initialSetup(), DOFMapOutput::output(), and BlockRestrictionDebugOutput::printBlockRestrictionMap().
| 
 | inlineinherited | 
Definition at line 624 of file NonlinearSystemBase.h.
| 
 | inlineinherited | 
Definition at line 676 of file NonlinearSystemBase.h.
| 
 | inlineinherited | 
Return the Kokkos residual object warehouses
Definition at line 667 of file NonlinearSystemBase.h.
Referenced by ExplicitTimeIntegrator::initialSetup().
| 
 | inlineinherited | 
Definition at line 672 of file NonlinearSystemBase.h.
| 
 | inlineinherited | 
Definition at line 668 of file NonlinearSystemBase.h.
Referenced by ExplicitTimeIntegrator::initialSetup().
| 
 | virtualinherited | 
Get a raw SparseMatrix.
Reimplemented in DisplacedSystem.
Definition at line 1024 of file SystemBase.C.
Referenced by SystemBase::activateAllMatrixTags(), Assembly::addCachedJacobian(), NonlinearSystemBase::addImplicitGeometricCouplingEntries(), Assembly::addJacobianCoupledVarPair(), Assembly::addJacobianLowerD(), Assembly::addJacobianNeighbor(), Assembly::addJacobianNeighborLowerD(), Assembly::addJacobianNonlocal(), SystemBase::addMatrix(), SystemBase::closeTaggedMatrices(), NonlinearSystemBase::computeJacobianInternal(), FEProblemBase::computeJacobianTags(), LinearSystem::computeLinearSystemInternal(), FEProblemBase::computeLinearSystemTags(), FEProblemBase::computeResidualAndJacobian(), NonlinearSystemBase::computeResidualAndJacobianInternal(), NonlinearSystemBase::constraintJacobians(), SystemBase::disassociateMatrixFromTag(), NonlinearSystemBase::enforceNodalConstraintsJacobian(), SystemBase::flushTaggedMatrices(), DisplacedSystem::getMatrix(), LinearSystemContributionObject::linkTaggedVectorsAndMatrices(), MooseVariableScalar::reinit(), Assembly::setCachedJacobian(), and Assembly::zeroCachedJacobian().
| 
 | virtualinherited | 
Get a raw SparseMatrix.
Reimplemented in DisplacedSystem.
Definition at line 1042 of file SystemBase.C.
| 
 | inlineinherited | 
Returns the maximum number of all variables on the system.
Definition at line 867 of file SystemBase.h.
| 
 | inlineinherited | 
Gets the maximum number of dofs used by any one variable on any one element.
Definition at line 585 of file SystemBase.h.
Referenced by Moose::globalDofIndexToDerivative().
| 
 | inlineinherited | 
Gets the maximum number of dofs used by any one variable on any one node.
Definition at line 592 of file SystemBase.h.
| 
 | virtualinherited | 
Get minimal quadrature order needed for integrating variables in this system.
Reimplemented in AuxiliarySystem.
Definition at line 241 of file SystemBase.C.
| 
 | inlineinherited | 
Get the norm in which the linear convergence is measured.
Definition at line 87 of file SolverSystem.h.
Referenced by Moose::PetscSupport::petscSetDefaultKSPNormType().
| 
 | inlineinherited | 
Return the NodalBCBase warehouse.
Definition at line 654 of file NonlinearSystemBase.h.
| 
 | inlineinherited | 
Definition at line 645 of file NonlinearSystemBase.h.
Referenced by ComputeNodalDampingThread::onNode(), and ComputeNodalDampingThread::printGeneralExecutionInformation().
| 
 | inlineinherited | 
Definition at line 636 of file NonlinearSystemBase.h.
Referenced by ExplicitTimeIntegrator::initialSetup().
| 
 | protectedinherited | 
Definition at line 2203 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::findImplicitGeometricCouplingEntries().
| 
 | inline | 
Get the number of converged eigenvalues.
Definition at line 83 of file NonlinearEigenSystem.h.
Referenced by getConvergedEigenpair(), getConvergedEigenvalue(), and solve().
| 
 | inlineinherited | 
Get the current preconditioner side.
Definition at line 76 of file SolverSystem.h.
Referenced by Moose::PetscSupport::petscSetDefaultPCSide().
| 
 | inherited | 
Definition at line 3643 of file NonlinearSystemBase.C.
Referenced by ConsoleUtils::outputExecutionInformation().
| 
 | inlineinherited | 
Definition at line 594 of file NonlinearSystemBase.h.
Referenced by AB2PredictorCorrector::estimateTimeError().
| 
 | inherited | 
Return a numeric vector that is associated with the nontime tag.
Definition at line 1065 of file NonlinearSystemBase.C.
Referenced by PseudoTimestep::currentResidualNorm(), NonlinearSystemBase::NonlinearSystemBase(), and NonlinearSystemBase::residualVector().
| 
 | inherited | 
Return a numeric vector that is associated with the time tag.
Definition at line 1042 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::residualVector().
| 
 | inlineinherited | 
Definition at line 632 of file NonlinearSystemBase.h.
Referenced by ExplicitTimeIntegrator::initialSetup().
| 
 | 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 145 of file SystemBase.C.
Referenced by Assembly::addJacobianOffDiagScalar(), ODEKernel::computeOffDiagJacobianScalar(), VectorKernel::computeOffDiagJacobianScalar(), ArrayKernel::computeOffDiagJacobianScalar(), IntegratedBC::computeOffDiagJacobianScalar(), VectorIntegratedBC::computeOffDiagJacobianScalar(), Kernel::computeOffDiagJacobianScalar(), ArrayIntegratedBC::computeOffDiagJacobianScalar(), ScalarLagrangeMultiplier::computeOffDiagJacobianScalar(), MortarScalarBase::computeOffDiagJacobianScalar(), KernelScalarBase::computeOffDiagJacobianScalarLocal(), KernelScalarBase::computeScalarOffDiagJacobianScalar(), MortarScalarBase::computeScalarOffDiagJacobianScalar(), DMMooseSetVariables(), Assembly::init(), ReferenceResidualConvergence::initialSetup(), and NonlinearSystemBase::setupScalingData().
| 
 | virtualinherited | 
Gets a reference to a variable with specified number.
| tid | Thread id | 
| var_number | libMesh variable number | 
Definition at line 154 of file SystemBase.C.
| 
 | inlineinherited | 
Definition at line 756 of file SystemBase.h.
Referenced by Assembly::addResidualScalar(), ODEKernel::computeJacobian(), ComputeFullJacobianThread::computeOnBoundary(), ComputeFullJacobianThread::computeOnElement(), AuxiliarySystem::computeScalarVars(), Assembly::init(), SystemBase::initSolutionState(), NonlinearThread::onElement(), Assembly::prepareOffDiagScalar(), and Assembly::prepareScalar().
| 
 | overridevirtual | 
Retrieve snes from slepc eigen solver.
It is valid for only nonlinear eigen solver. You should see a big error if you do this for linear solver.
Implements NonlinearSystemBase.
Definition at line 441 of file NonlinearEigenSystem.C.
Referenced by Moose::SlepcSupport::mooseEPSFormMatrices(), and Moose::SlepcSupport::mooseSlepcEigenFormFunctionMFFD().
| 
 | inherited | 
Retrieves a split by name.
| name | The name of the split | 
Definition at line 745 of file NonlinearSystemBase.C.
Referenced by FieldSplitPreconditioner::FieldSplitPreconditioner(), Split::setup(), and StaticCondensationFieldSplitPreconditioner::StaticCondensationFieldSplitPreconditioner().
| 
 | inlineinherited | 
Retrieves all splits.
Definition at line 262 of file NonlinearSystemBase.h.
Referenced by ConsoleUtils::outputExecutionInformation().
| 
 | inherited | 
| 
 | inlineinherited | 
Definition at line 761 of file SystemBase.h.
Referenced by NonlinearSystemBase::checkKernelCoverage(), and SystemBase::getSubdomainsForVar().
| 
 | inherited | 
Get the block where a variable of this system is defined.
| var_name | The name of the variable | 
Definition at line 1707 of file SystemBase.C.
| 
 | inherited | 
Retrieve the time integrator that integrates the given variable's equation.
Definition at line 1683 of file SystemBase.C.
Referenced by AB2PredictorCorrector::estimateTimeError().
| 
 | inherited | 
Definition at line 1695 of file SystemBase.C.
| 
 | inherited | 
Gets a reference to a variable of with specified name.
| tid | Thread id | 
| var_name | variable name | 
Definition at line 90 of file SystemBase.C.
Referenced by AdaptivityAction::act(), Assembly::addJacobianBlockNonlocal(), FEProblemBase::addJacobianBlockTags(), NonlocalKernel::computeNonlocalOffDiagJacobian(), NonlocalIntegratedBC::computeNonlocalOffDiagJacobian(), Assembly::copyFaceShapes(), Assembly::copyNeighborShapes(), Assembly::copyShapes(), SystemBase::copyVars(), DMMooseSetVariables(), FieldSplitPreconditionerTempl< MoosePreconditioner >::FieldSplitPreconditionerTempl(), FiniteDifferencePreconditioner::FiniteDifferencePreconditioner(), NodeElemConstraint::getConnectedDofIndices(), NodeFaceConstraint::getConnectedDofIndices(), SystemBase::getSubdomainsForVar(), ResidualObject::getVariable(), SubProblem::getVariableHelper(), Assembly::init(), NodalNormalsPreprocessor::initialize(), ExplicitTimeIntegrator::initialSetup(), ReferenceResidualConvergence::initialSetup(), LinearSystem::initialSetup(), Assembly::initNonlocalCoupling(), PNGOutput::makeMeshFunc(), MooseStaticCondensationPreconditioner::MooseStaticCondensationPreconditioner(), UpdateErrorVectorsThread::onElement(), Assembly::prepareBlock(), Assembly::prepareBlockNonlocal(), AddPeriodicBCAction::setPeriodicVars(), NonlinearSystemBase::setupScalingData(), and VariableCondensationPreconditioner::VariableCondensationPreconditioner().
| 
 | inherited | 
Gets a reference to a variable with specified number.
| tid | Thread id | 
| var_number | libMesh variable number | 
Definition at line 100 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 164 of file SystemBase.C.
Referenced by PhysicsBasedPreconditioner::addSystem().
| 
 | inlineinherited | 
Get the global dof indices of a variable, this needs to be called after the indices have been set by setVariableGlobalDoFs 
Definition at line 842 of file SystemBase.h.
| 
 | inlineinherited | 
Definition at line 860 of file SystemBase.h.
Referenced by MooseEigenSystem::buildSystemDoFIndices(), NonlinearSystemBase::checkKernelCoverage(), MFEMProblem::getAuxVariableNames(), SystemBase::hasVariable(), SystemBase::isArrayVariable(), AddPeriodicBCAction::setPeriodicVars(), and SingleMatrixPreconditioner::SingleMatrixPreconditioner().
| 
 | inlineinherited | 
Definition at line 751 of file SystemBase.h.
Referenced by Assembly::addJacobianOffDiagScalar(), Assembly::addResidual(), Assembly::addResidualLower(), Assembly::addResidualNeighbor(), Assembly::cacheResidual(), Assembly::cacheResidualLower(), Assembly::cacheResidualNeighbor(), ComputeFullJacobianThread::computeOnBoundary(), ComputeFullJacobianThread::computeOnElement(), Assembly::init(), Assembly::initNonlocalCoupling(), SystemBase::initSolutionState(), ComputeLinearFVGreenGaussGradientFaceThread::operator()(), Assembly::prepareLowerD(), Assembly::prepareNeighbor(), Assembly::prepareOffDiagScalar(), Assembly::prepareResidual(), Assembly::setResidual(), and Assembly::setResidualNeighbor().
| 
 | virtualinherited | 
Get a raw NumericVector by name.
Get a raw NumericVector with the given name.
Reimplemented in DisplacedSystem.
Definition at line 933 of file SystemBase.C.
Referenced by Assembly::addCachedResiduals(), Assembly::addResidual(), Assembly::addResidualLower(), Assembly::addResidualNeighbor(), Assembly::addResidualScalar(), NonlinearSystemBase::assembleScalingVector(), SystemBase::closeTaggedVector(), FEProblemBase::computeBounds(), FEProblemBase::computeNearNullSpace(), FEProblemBase::computeNullSpace(), NonlinearSystemBase::computeResidualAndJacobianTags(), NonlinearSystemBase::computeResidualTags(), CentralDifference::computeTimeDerivatives(), FEProblemBase::computeTransposeNullSpace(), DisplacedSystem::getVector(), Assembly::hasScalingVector(), LinearSystemContributionObject::linkTaggedVectorsAndMatrices(), SystemBase::needSolutionState(), ReferenceResidualConvergence::ReferenceResidualConvergence(), MooseVariableScalar::reinit(), SecantSolve::saveVariableValues(), SteffensenSolve::saveVariableValues(), PicardSolve::saveVariableValues(), NonlinearSystemBase::setPreviousNewtonSolution(), TaggingInterface::setResidual(), SystemBase::solutionPreviousNewton(), SystemBase::solutionState(), MultiAppDofCopyTransfer::transfer(), SecantSolve::transformVariables(), SteffensenSolve::transformVariables(), PicardSolve::transformVariables(), and SystemBase::zeroTaggedVector().
| 
 | virtualinherited | 
Reimplemented in DisplacedSystem.
Definition at line 939 of file SystemBase.C.
| 
 | virtualinherited | 
Get a raw NumericVector by tag.
Reimplemented in DisplacedSystem.
Definition at line 945 of file SystemBase.C.
| 
 | virtualinherited | 
Reimplemented in DisplacedSystem.
Definition at line 963 of file SystemBase.C.
| 
 | inlineinherited | 
Reference to the container vector which hold gradients at dofs (if it can be interpreted).
Mainly used for finite volume systems.
Definition at line 930 of file SystemBase.h.
| 
 | inlineinherited | 
Weather or not the nonlinear system has diagonal Jacobian save-ins.
Definition at line 693 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeJacobianInternal().
| 
 | inlinevirtualinherited | 
Check if the tagged matrix exists in the system.
Reimplemented in DisplacedSystem.
Definition at line 360 of file SystemBase.h.
Referenced by SystemBase::activateAllMatrixTags(), Assembly::addCachedJacobian(), NonlinearSystemBase::addImplicitGeometricCouplingEntries(), Assembly::addJacobianCoupledVarPair(), Assembly::addJacobianLowerD(), Assembly::addJacobianNeighbor(), Assembly::addJacobianNeighborLowerD(), Assembly::addJacobianNonlocal(), SystemBase::addMatrix(), Assembly::cacheJacobian(), Assembly::cacheJacobianBlockNonzero(), Assembly::cacheJacobianCoupledVarPair(), Assembly::cacheJacobianMortar(), Assembly::cacheJacobianNeighbor(), Assembly::cacheJacobianNonlocal(), SystemBase::closeTaggedMatrices(), NonlinearSystemBase::computeJacobianInternal(), FEProblemBase::computeJacobianTags(), FEProblemBase::computeResidualAndJacobian(), NonlinearSystemBase::computeResidualAndJacobianInternal(), NonlinearSystemBase::constraintJacobians(), SystemBase::disassociateMatrixFromTag(), NonlinearSystemBase::enforceNodalConstraintsJacobian(), SystemBase::flushTaggedMatrices(), SystemBase::getMatrix(), DisplacedSystem::hasMatrix(), MooseVariableScalar::reinit(), SystemBase::removeMatrix(), SubProblem::selectMatrixTagsFromSystem(), Assembly::setCachedJacobian(), and Assembly::zeroCachedJacobian().
| 
 | inlineinherited | 
Weather or not the nonlinear system has save-ins.
Definition at line 688 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeResidualTags().
| 
 | virtualinherited | 
Definition at line 876 of file SystemBase.C.
Referenced by MortarScalarBase::computeJacobian(), NonlinearSystemBase::computeJacobianInternal(), ComputeFullJacobianThread::computeOnBoundary(), ComputeFullJacobianThread::computeOnElement(), SystemBase::copyVars(), ExplicitTimeIntegrator::initialSetup(), postAddResidualObject(), AddPeriodicBCAction::setPeriodicVars(), and NonlinearSystemBase::setupScalingData().
| 
 | inlinevirtualinherited | 
Whether or not the system has the solution state (0 = current, 1 = old, 2 = older, etc).
Reimplemented in DisplacedSystem.
Definition at line 1090 of file SystemBase.h.
Referenced by PointwiseRenormalizeVector::execute(), PointwiseRenormalizeVector::finalize(), DisplacedSystem::hasSolutionState(), SystemBase::needSolutionState(), SystemBase::restoreSolutions(), ElementSubdomainModifierBase::setOldAndOlderSolutions(), SystemBase::solutionState(), and SystemBase::solutionStateParallelType().
| 
 | inlineinherited | 
Whether or not there are variables to be restarted from an Exodus mesh file.
Definition at line 883 of file SystemBase.h.
| 
 | virtualinherited | 
Query a system for a variable.
| var_name | name of the variable | 
Definition at line 851 of file SystemBase.C.
Referenced by ADDGKernel::ADDGKernel(), ArrayDGKernel::ArrayDGKernel(), SystemBase::copyVars(), DGKernel::DGKernel(), DMMooseSetVariables(), FEProblemBase::duplicateVariableCheck(), SubProblem::getVariableHelper(), SubProblem::hasAuxiliaryVariable(), ExplicitTimeIntegrator::initialSetup(), ElementSubdomainModifierBase::initialSetup(), InterfaceKernelTempl< T >::InterfaceKernelTempl(), PNGOutput::makeMeshFunc(), MultiAppVariableValueSamplePostprocessorTransfer::MultiAppVariableValueSamplePostprocessorTransfer(), NonlinearSystemBase::setupScalingData(), and Coupleable::writableCoupledValue().
| 
 | inherited | 
Check if the named vector exists in the system.
Definition at line 924 of file SystemBase.C.
Referenced by FEProblemBase::addCachedResidualDirectly(), Assembly::addCachedResiduals(), Assembly::addResidual(), Assembly::addResidualLower(), Assembly::addResidualNeighbor(), Assembly::addResidualScalar(), NonlinearSystemBase::assembleScalingVector(), Assembly::cacheResidual(), Assembly::cacheResidualLower(), Assembly::cacheResidualNeighbor(), SystemBase::closeTaggedVector(), FEProblemBase::computeBounds(), NonlinearSystemBase::computeResidualTags(), CentralDifference::computeTimeDerivatives(), SystemBase::getVector(), DisplacedSystem::hasVector(), MooseVariableScalar::reinit(), SystemBase::removeVector(), SubProblem::selectVectorTagsFromSystem(), NonlinearSystemBase::setPreviousNewtonSolution(), TaggingInterface::setResidual(), SystemBase::solutionPreviousNewton(), and SystemBase::zeroTaggedVector().
| 
 | inlinevirtualinherited | 
Check if the tagged vector exists in the system.
Reimplemented in DisplacedSystem.
Definition at line 281 of file SystemBase.h.
| 
 | inlineinherited | 
Definition at line 112 of file NonlinearSystemBase.h.
| 
 | inlineinherited | 
Definition at line 108 of file NonlinearSystemBase.h.
| 
 | inlineinherited | 
Definition at line 736 of file NonlinearSystemBase.h.
| void NonlinearEigenSystem::initializeCondensedMatrices | ( | ) | 
Initialize the condensed matrices.
This is a no-op if there are no constraints in the DofMap
Definition at line 198 of file NonlinearEigenSystem.C.
Referenced by postInit(), and reinit().
| 
 | inlinevirtualinherited | 
Called only once, just before the solve begins so objects can do some precalculations.
Definition at line 173 of file SystemBase.h.
| 
 | inherited | 
The initial residual.
Definition at line 784 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::referenceResidual().
| 
 | overridevirtualinherited | 
Setup Functions.
Reimplemented from SystemBase.
Definition at line 225 of file NonlinearSystemBase.C.
| 
 | virtualinherited | 
Initializes the solution state.
Reimplemented in DisplacedSystem.
Definition at line 1364 of file SystemBase.C.
Referenced by DisplacedSystem::initSolutionState().
| 
 | virtualinherited | 
If a variable is an array variable.
Definition at line 864 of file SystemBase.C.
| 
 | virtualinherited | 
Definition at line 885 of file SystemBase.C.
Referenced by Assembly::init(), ReferenceResidualConvergence::initialSetup(), and Assembly::initNonlocalCoupling().
| 
 | overridevirtualinherited | 
Reimplemented from SystemBase.
Definition at line 2809 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeJacobianInternal().
| 
 | inlineprotectedvirtualinherited | 
Whether a system matrix is formed from coloring.
This influences things like when to compute time derivatives
Reimplemented in NonlinearSystem.
Definition at line 102 of file SolverSystem.h.
Referenced by SolverSystem::compute(), and NonlinearSystemBase::destroyColoring().
| 
 | virtualinherited | 
If or not a matrix tag is active.
Definition at line 1149 of file SystemBase.C.
| 
 | inlineinherited | 
Definition at line 99 of file SystemBase.h.
Referenced by CreateDisplacedProblemAction::addProxyRelationshipManagers(), DMMooseGetEmbedding_Private(), DMSetUp_Moose_Pre(), SolutionIC::initialSetup(), ComputeNodalUserObjectsThread::onNode(), ComputeNodalKernelsThread::onNode(), and ComputeNodalKernelJacobiansThread::onNode().
| 
 | inlineinherited | 
Definition at line 100 of file SystemBase.h.
| 
 | protectedinherited | 
Do mortar constraint residual/jacobian computations.
Definition at line 3913 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeResidualAndJacobianInternal(), and NonlinearSystemBase::computeResidualInternal().
| 
 | virtualinherited | 
Definition at line 1340 of file SystemBase.C.
Referenced by NonlinearSystemBase::addBoundaryCondition(), NonlinearSystemBase::addConstraint(), NonlinearSystemBase::addDamper(), NonlinearSystemBase::addDGKernel(), NonlinearSystemBase::addDiracKernel(), NonlinearSystemBase::addHDGKernel(), NonlinearSystemBase::addInterfaceKernel(), MooseEigenSystem::addKernel(), AuxiliarySystem::addKernel(), NonlinearSystemBase::addKernel(), SystemBase::addMatrix(), NonlinearSystemBase::addNodalKernel(), AuxiliarySystem::addScalarKernel(), NonlinearSystemBase::addScalarKernel(), NonlinearSystemBase::addSplit(), SystemBase::addTimeIntegrator(), AuxiliarySystem::addVariable(), SystemBase::addVariable(), DiffusionLHDGAssemblyHelper::checkCoupling(), SystemBase::closeTaggedVector(), LinearSystem::computeGradients(), LinearSystem::computeLinearSystemTags(), DisplacedProblem::DisplacedProblem(), SystemBase::getMatrix(), NonlinearSystemBase::getSplit(), DisplacedSystem::getVector(), SystemBase::getVector(), SystemBase::hasVector(), LinearSystem::initialSetup(), Moose::PetscSupport::petscSetDefaults(), postAddResidualObject(), MooseStaticCondensationPreconditioner::prefix(), SystemBase::removeMatrix(), SystemBase::removeVector(), SystemBase::solutionState(), LinearSystem::solve(), LinearTimeIntegratorInterface::timeDerivativeMatrixContribution(), LinearTimeIntegratorInterface::timeDerivativeRHSContribution(), and SystemBase::zeroTaggedVector().
| 
 | inherited | 
Indicated whether this system needs material properties on boundaries.
Definition at line 3845 of file NonlinearSystemBase.C.
| 
 | inherited | 
Indicated whether this system needs material properties on interfaces.
Definition at line 3873 of file NonlinearSystemBase.C.
| 
 | inherited | 
Indicates whether this system needs material properties on internal sides.
Definition at line 3885 of file NonlinearSystemBase.C.
| 
 | virtualinherited | 
Registers that the solution state state is needed. 
Reimplemented in DisplacedSystem.
Definition at line 1450 of file SystemBase.C.
Referenced by SecantSolve::allocateStorage(), PicardSolve::allocateStorage(), EigenExecutionerBase::EigenExecutionerBase(), SystemBase::initSolutionState(), DisplacedSystem::needSolutionState(), and SystemBase::solutionState().
| 
 | inherited | 
Get the number of field variables in this system.
Definition at line 900 of file SystemBase.C.
Referenced by SystemBase::nVariables().
| 
 | inherited | 
Get the number of finite volume variables in this system.
Definition at line 910 of file SystemBase.C.
| 
 | inlineinherited | 
Return the number of linear iterations.
Definition at line 565 of file NonlinearSystemBase.h.
Referenced by IterationAdaptiveDT::acceptStep().
| 
 | inlineinherited | 
Return the number of non-linear iterations.
Definition at line 560 of file NonlinearSystemBase.h.
Referenced by IterationAdaptiveDT::acceptStep().
| 
 | inline | 
Matrix tag ID of left hand side.
Definition at line 154 of file NonlinearEigenSystem.h.
Referenced by defaultMatrixTags(), Moose::SlepcSupport::mooseEPSFormMatrices(), and Moose::SlepcSupport::mooseSlepcEigenFormJacobianA().
| 
 | inline | 
Vector tag ID of left hand side.
Definition at line 144 of file NonlinearEigenSystem.h.
Referenced by computeScalingResidual(), defaultVectorTags(), Moose::SlepcSupport::mooseMatMult_NonEigen(), Moose::SlepcSupport::mooseSlepcEigenFormFunctionA(), and Moose::SlepcSupport::mooseSlepcEigenFormFunctionAB().
| 
 | inlineinherited | 
Return the last nonlinear norm.
Definition at line 581 of file NonlinearSystemBase.h.
Referenced by Console::writeVariableNorms().
| 
 | overridevirtual | 
Implements NonlinearSystemBase.
Definition at line 434 of file NonlinearEigenSystem.C.
| 
 | inlineoverridevirtualinherited | 
Reimplemented from SystemBase.
Definition at line 705 of file NonlinearSystemBase.h.
Referenced by FEProblemBase::addCachedResidualDirectly(), and CrankNicolson::init().
| 
 | inlineinherited | 
Return the total number of residual evaluations done so far in this calculation.
Definition at line 570 of file NonlinearSystemBase.h.
| 
 | inherited | 
Gets the number of this system.
Definition at line 1157 of file SystemBase.C.
Referenced by SetupResidualDebugAction::act(), FEProblemBase::addCachedResidualDirectly(), FEProblemBase::addJacobian(), FEProblemBase::addJacobianBlockTags(), FEProblemBase::addJacobianLowerD(), FEProblemBase::addJacobianNeighbor(), FEProblemBase::addJacobianNeighborLowerD(), FEProblemBase::addJacobianOffDiagScalar(), FEProblemBase::addJacobianScalar(), FEProblemBase::addObjectParamsHelper(), FEProblemBase::addResidual(), FEProblemBase::addResidualLower(), FEProblemBase::addResidualNeighbor(), FEProblemBase::addResidualScalar(), SystemBase::addScalingVector(), ADKernelTempl< T >::ADKernelTempl(), ElementSubdomainModifierBase::applyIC(), ArrayKernel::ArrayKernel(), NonlinearSystemBase::assembleScalingVector(), attachPreconditioner(), DiffusionLHDGAssemblyHelper::checkCoupling(), SolverSystem::compute(), MooseVariableScalar::computeAD(), FEProblemBase::computeBounds(), Assembly::computeFaceMap(), InternalSideIndicatorBase::computeIndicator(), VectorNodalBC::computeJacobian(), ArrayNodalBC::computeJacobian(), NodalBC::computeJacobian(), FVBoundaryScalarLagrangeMultiplierConstraint::computeJacobian(), FVFluxBC::computeJacobian(), FVFluxKernel::computeJacobian(), FVInterfaceKernel::computeJacobian(), FEProblemBase::computeJacobianBlock(), NonlinearSystemBase::computeJacobianInternal(), LinearSystem::computeLinearSystemInternal(), FEProblemBase::computeNearNullSpace(), NonlinearSystemBase::computeNodalBCsResidualAndJacobian(), FEProblemBase::computeNullSpace(), ArrayNodalBC::computeOffDiagJacobian(), VectorNodalBC::computeOffDiagJacobian(), NodalBC::computeOffDiagJacobian(), NodalKernel::computeOffDiagJacobian(), ComputeFullJacobianThread::computeOnBoundary(), ComputeFullJacobianThread::computeOnElement(), ComputeFullJacobianThread::computeOnInterface(), ComputeFullJacobianThread::computeOnInternalFace(), FEProblemBase::computePostCheck(), FVBoundaryScalarLagrangeMultiplierConstraint::computeResidual(), FVFluxKernel::computeResidual(), FVInterfaceKernel::computeResidual(), Kernel::computeResidualAndJacobian(), NodalBC::computeResidualAndJacobian(), IntegratedBC::computeResidualAndJacobian(), NonlinearSystemBase::computeResidualAndJacobianInternal(), NonlinearSystemBase::computeResidualInternal(), FEProblemBase::computeResidualL2Norm(), NonlinearSystemBase::computeResidualTags(), NonlinearSystemBase::computeScaling(), Assembly::computeSinglePointMapAD(), FEProblemBase::computeTransposeNullSpace(), DebugResidualAux::computeValue(), NearestNodeValueAux::computeValue(), SlepcEigenSolverConfiguration::configure_solver(), NonlinearSystemBase::constraintJacobians(), LinearSystem::containsTimeKernel(), Coupleable::coupled(), FEProblemBase::currentLinearSysNum(), FEProblemBase::currentNlSysNum(), PseudoTimestep::currentResidualNorm(), ComputeResidualThread::determineObjectWarehouses(), ComputeResidualAndJacobianThread::determineObjectWarehouses(), Moose::doDerivatives(), VariableResidual::execute(), NodalNormalsCorner::execute(), NodalNormalsEvaluator::execute(), GreaterThanLessThanPostprocessor::execute(), NodalNormalsPreprocessor::execute(), ExplicitTimeIntegrator::ExplicitTimeIntegrator(), InternalSideIndicatorBase::finalize(), NumNonlinearIterations::finalize(), BoundsBase::getDoFIndex(), NonlinearSystemBase::getNodeDofs(), getSNES(), SystemBase::getSubdomainsForVar(), NumLinearIterations::getValue(), Residual::getValue(), NumResidualEvaluations::getValue(), Moose::globalDofIndexToDerivative(), FVBoundaryCondition::hasFaceSide(), ExplicitTimeIntegrator::init(), ExplicitTimeIntegrator::initialSetup(), NonlinearSystemBase::initialSetup(), ActivateElementsUserObjectBase::initSolutions(), EigenExecutionerBase::inversePowerIteration(), Kernel::Kernel(), Moose::SlepcSupport::mooseSlepcEigenFormFunctionA(), Moose::SlepcSupport::mooseSlepcEigenFormFunctionAB(), Moose::SlepcSupport::mooseSlepcEigenFormFunctionB(), Moose::SlepcSupport::mooseSlepcEigenFormJacobianA(), MooseStaticCondensationPreconditioner::MooseStaticCondensationPreconditioner(), MooseVariableInterface< Real >::MooseVariableInterface(), EigenExecutionerBase::nonlinearSolve(), ComputeDiracThread::onElement(), ComputeNodalKernelBCJacobiansThread::onNode(), ComputeNodalKernelJacobiansThread::onNode(), VariableResidualNormsDebugOutput::output(), Moose::PetscSupport::petscLinearConverged(), Moose::PetscSupport::petscNonlinearConverged(), PhysicsBasedPreconditioner::PhysicsBasedPreconditioner(), PointwiseRenormalizeVector::PointwiseRenormalizeVector(), FEProblemBase::prepareAssembly(), SystemBase::prepareFace(), FEProblemBase::prepareFaceShapes(), FEProblemBase::prepareNeighborShapes(), FEProblemBase::prepareShapes(), FEProblemBase::reinitDirac(), FEProblemBase::reinitOffDiagScalars(), NonlinearSystem::residualAndJacobianTogether(), FEProblemBase::setResidual(), FEProblemBase::setResidualNeighbor(), PhysicsBasedPreconditioner::setup(), FVInterfaceKernel::setupData(), NonlinearSystemBase::shouldEvaluatePreSMOResidual(), ActuallyExplicitEuler::solve(), solve(), LStableDirk2::solve(), LStableDirk3::solve(), ImplicitMidpoint::solve(), ExplicitTVDRK2::solve(), LStableDirk4::solve(), AStableDirk4::solve(), ExplicitRK2::solve(), ExplicitSSPRungeKutta::solveStage(), NonlinearThread::subdomainChanged(), UserObject::systemNumber(), MultiAppDofCopyTransfer::transferDofObject(), FVFluxBC::uOnGhost(), FVFluxBC::uOnUSub(), FVFluxBC::updateCurrentFace(), and MortarConstraintBase::zeroInactiveLMDofs().
| 
 | virtualinherited | 
Get the number of variables in this system.
Definition at line 891 of file SystemBase.C.
Referenced by AdaptivityAction::act(), FieldSplitPreconditionerTempl< MoosePreconditioner >::FieldSplitPreconditionerTempl(), FiniteDifferencePreconditioner::FiniteDifferencePreconditioner(), NonlinearSystemBase::getNodeDofs(), Assembly::init(), ExplicitTimeIntegrator::initialSetup(), MaxVarNDofsPerElem::onElement(), MaxVarNDofsPerNode::onNode(), PhysicsBasedPreconditioner::PhysicsBasedPreconditioner(), SingleMatrixPreconditioner::SingleMatrixPreconditioner(), and AuxiliarySystem::variableWiseRelativeSolutionDifferenceNorm().
| 
 | inlineinherited | 
Definition at line 741 of file NonlinearSystemBase.h.
Referenced by ComputeJacobianForScalingThread::computeOnElement().
| 
 | inlineinherited | 
Definition at line 742 of file NonlinearSystemBase.h.
| 
 | inherited | 
Called at the beginning of the time step.
Definition at line 947 of file NonlinearSystemBase.C.
| 
 | inherited | 
Called from explicit time stepping to overwrite boundary positions (explicit dynamics).
This will close/assemble the passed-in soln after overwrite 
Definition at line 1678 of file NonlinearSystemBase.C.
Referenced by ActuallyExplicitEuler::solve().
| 
 | inherited | 
Get the PerfGraph.
Definition at line 78 of file PerfGraphInterface.C.
Referenced by CommonOutputAction::act(), PerfGraphData::finalize(), and PerfGraphOutput::output().
| 
 | overrideprotectedvirtual | 
Called after any ResidualObject-derived objects are added to the system.
Reimplemented from NonlinearSystemBase.
Definition at line 152 of file NonlinearEigenSystem.C.
| 
 | overridevirtual | 
Reimplemented from SystemBase.
Definition at line 226 of file NonlinearEigenSystem.C.
| 
 | inlinevirtualinherited | 
Create finite differencing contexts for assembly of the Jacobian and/or approximating the action of the Jacobian on vectors (e.g.
FD and/or MFFD respectively)
Reimplemented in NonlinearSystem.
Definition at line 764 of file NonlinearSystemBase.h.
Referenced by LStableDirk2::solve(), LStableDirk3::solve(), and LStableDirk4::solve().
| 
 | inline | 
Definition at line 173 of file NonlinearEigenSystem.h.
Referenced by attachPreconditioner(), Moose::SlepcSupport::PCApply_MoosePC(), and Moose::SlepcSupport::PCSetUp_MoosePC().
| 
 | inline | 
If the preconditioning matrix includes eigen kernels.
Definition at line 162 of file NonlinearEigenSystem.h.
Referenced by Eigenvalue::Eigenvalue().
| 
 | inline | 
Definition at line 167 of file NonlinearEigenSystem.h.
| 
 | inline | 
Definition at line 169 of file NonlinearEigenSystem.h.
Referenced by computeScalingJacobian(), and Moose::SlepcSupport::mooseSlepcEigenFormJacobianA().
| 
 | inherited | 
Definition at line 1713 of file SystemBase.C.
Referenced by FieldSplitPreconditioner::FieldSplitPreconditioner(), MoosePreconditioner::initialSetup(), and FieldSplitPreconditioner::prefix().
| 
 | overridevirtualinherited | 
This is called prior to the libMesh system has been init'd.
MOOSE system wrappers can use this method to add vectors and matrices to the libMesh system
Reimplemented from SolverSystem.
Definition at line 190 of file NonlinearSystemBase.C.
Prepare the system for use.
| tid | ID of the thread | 
Definition at line 256 of file SystemBase.C.
Referenced by SubProblem::reinitElemFaceRef().
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 279 of file SystemBase.C.
Prepare the system for use for lower dimensional elements.
| tid | ID of the thread | 
Definition at line 332 of file SystemBase.C.
Referenced by SubProblem::reinitLowerDElem().
Prepare the system for use.
| tid | ID of the thread | 
Definition at line 324 of file SystemBase.C.
Referenced by SubProblem::reinitNeighborFaceRef().
| 
 | inherited | 
The pre-SMO residual.
Definition at line 775 of file NonlinearSystemBase.C.
Referenced by Residual::getValue(), and NonlinearSystemBase::referenceResidual().
| 
 | protectedinherited | 
Perform some steps to get ready for the solver.
These include
Definition at line 4216 of file NonlinearSystemBase.C.
Referenced by NonlinearSystem::solve(), and solve().
| 
 | inlineinherited | 
Force the printing of all variable norms after each solve.
Definition at line 587 of file NonlinearSystemBase.h.
| 
 | inherited | 
Retrieve the time integrator that integrates the given variable's equation.
If no suitable time integrator is found (this could happen for instance if we're solving a non-transient problem), then a nullptr will be returned
Definition at line 1673 of file SystemBase.C.
Referenced by SystemBase::getTimeIntegrator(), HDGKernel::HDGKernel(), and MooseVariableData< OutputType >::MooseVariableData().
| 
 | inherited | 
The reference residual used in relative convergence check.
Definition at line 769 of file NonlinearSystemBase.C.
Referenced by DefaultNonlinearConvergence::checkConvergence(), and EigenExecutionerBase::inversePowerIteration().
| 
 | protectedinherited | 
Call to register a named section for timing.
| section_name | The name of the code section to be timed | 
| level | The importance of the timer - lower is more important (0 will always come out) | 
Definition at line 53 of file PerfGraphInterface.C.
| 
 | protectedinherited | 
Call to register a named section for timing.
| section_name | The name of the code section to be timed | 
| level | The importance of the timer - lower is more important (0 will always come out) | 
| live_message | The message to be printed to the screen during execution | 
| print_dots | Whether or not progress dots should be printed for this section | 
Definition at line 64 of file PerfGraphInterface.C.
| 
 | overridevirtual | 
Reinitialize the system when the degrees of freedom in this system have changed.
This is called after the libMesh system has been reinit'd
Reimplemented from SystemBase.
Definition at line 233 of file NonlinearEigenSystem.C.
Reinit an element assembly info.
| elem | Which element we are reinitializing for | 
| tid | ID of the thread | 
Reimplemented in AuxiliarySystem.
Definition at line 340 of file SystemBase.C.
| 
 | virtualinherited | 
Reinit assembly info for a side of an element.
| elem | The element | 
| side | Side of of the element | 
| tid | Thread ID | 
Reimplemented in AuxiliarySystem.
Definition at line 366 of file SystemBase.C.
Referenced by SubProblem::reinitElemFaceRef().
| 
 | inherited | 
Compute the incremental change in variables at nodes for dampers.
Called before we use damping
| tid | Thread ID | 
| damped_vars | Set of variables for which increment is to be computed | 
Definition at line 3663 of file NonlinearSystemBase.C.
Referenced by ComputeNodalDampingThread::onNode().
| 
 | inherited | 
Compute the incremental change in variables at QPs for dampers.
Called before we use damping
| tid | Thread ID | 
| damped_vars | Set of variables for which increment is to be computed | 
Definition at line 3655 of file NonlinearSystemBase.C.
Referenced by ComputeElemDampingThread::onElement().
Compute the values of the variables on the lower dimensional element.
Definition at line 390 of file SystemBase.C.
Referenced by SubProblem::reinitLowerDElem().
| 
 | inherited | 
Update the mortar functors if the mesh has changed.
Definition at line 207 of file NonlinearSystemBase.C.
Compute the values of the variables at all the current points.
Definition at line 382 of file SystemBase.C.
| 
 | virtualinherited | 
Compute the values of the variables at all the current points.
Definition at line 374 of file SystemBase.C.
Referenced by SubProblem::reinitNeighborFaceRef().
Reinit nodal assembly info.
| node | Node to reinit for | 
| tid | Thread ID | 
Definition at line 398 of file SystemBase.C.
| 
 | virtualinherited | 
Reinit nodal assembly info on a face.
| node | Node to reinit | 
| bnd_id | Boundary ID | 
| tid | Thread ID | 
Definition at line 410 of file SystemBase.C.
| 
 | inherited | 
Reinit nodal assembly info on a face.
| node | Node to reinit | 
| bnd_id | Boundary ID | 
| tid | Thread ID | 
Definition at line 410 of file SystemBase.C.
| 
 | protectedinherited | 
Reinitialize quantities such as variables, residuals, Jacobians, materials for node-face constraints.
Definition at line 1158 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::constraintJacobians(), NonlinearSystemBase::constraintResiduals(), and NonlinearSystemBase::setConstraintSecondaryValues().
| 
 | virtualinherited | 
Reinit variables at a set of nodes.
| nodes | List of node ids to reinit | 
| tid | Thread ID | 
Definition at line 422 of file SystemBase.C.
| 
 | virtualinherited | 
Reinit variables at a set of neighbor nodes.
| nodes | List of node ids to reinit | 
| tid | Thread ID | 
Definition at line 433 of file SystemBase.C.
| 
 | 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 444 of file SystemBase.C.
Removes a matrix with a given tag.
| tag_name | The name of the tag | 
Definition at line 590 of file SystemBase.C.
| 
 | inherited | 
Remove a vector from the system with the given name.
Definition at line 1334 of file SystemBase.C.
Referenced by SystemBase::restoreOldSolutions().
Remove a solution length vector from the system with the specified TagID.
| tag_id | Tag ID | 
Definition at line 700 of file SystemBase.C.
| 
 | overridevirtual | 
Call this method if you want the residual and Jacobian to be computed simultaneously.
Implements NonlinearSystemBase.
Definition at line 548 of file NonlinearEigenSystem.C.
| 
 | overridevirtualinherited | 
Reimplemented from SystemBase.
Definition at line 3510 of file NonlinearSystemBase.C.
| 
 | overridevirtualinherited | 
Reimplemented from SystemBase.
Definition at line 3519 of file NonlinearSystemBase.C.
| 
 | overridevirtualinherited | 
Reimplemented from SystemBase.
Definition at line 1727 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::computeResidualAndJacobianInternal(), and NonlinearSystemBase::computeResidualInternal().
| 
 | inherited | 
Return a residual vector that is associated with the residual tag.
Definition at line 1088 of file NonlinearSystemBase.C.
| NumericVector< Number > & NonlinearEigenSystem::residualVectorAX | ( | ) | 
Definition at line 422 of file NonlinearEigenSystem.C.
| NumericVector< Number > & NonlinearEigenSystem::residualVectorBX | ( | ) | 
Definition at line 428 of file NonlinearEigenSystem.C.
| 
 | inlineoverridevirtualinherited | 
Reimplemented from SystemBase.
Definition at line 706 of file NonlinearSystemBase.h.
Referenced by FEProblemBase::computeResidualAndJacobian(), NonlinearSystemBase::computeResidualAndJacobianTags(), FEProblemBase::computeResidualInternal(), NonlinearSystemBase::computeResidualTag(), NonlinearSystemBase::computeResidualTags(), FEProblemBase::computeResidualType(), and FEProblemBase::setResidualNeighbor().
| 
 | virtualinherited | 
Restore the old and older solutions when the saved solutions present.
Definition at line 542 of file SystemBase.C.
| 
 | finaloverridevirtualinherited | 
Restore current solutions (call after your solve failed)
Reimplemented from SystemBase.
Definition at line 43 of file SolverSystem.C.
| 
 | overridevirtual | 
Implements NonlinearSystemBase.
Definition at line 416 of file NonlinearEigenSystem.C.
Referenced by computeScalingResidual().
| 
 | virtualinherited | 
Save the old and older solutions.
Definition at line 510 of file SystemBase.C.
| 
 | inlineinherited | 
Definition at line 730 of file NonlinearSystemBase.h.
| 
 | virtualinherited | 
Returns a reference to a serialized version of the solution vector for this subproblem.
Reimplemented in DisplacedSystem.
Definition at line 1646 of file SystemBase.C.
Referenced by PNGOutput::calculateRescalingValues(), PNGOutput::makeMeshFunc(), and DisplacedSystem::serializedSolution().
| 
 | inherited | 
Definition at line 52 of file SolverSystem.C.
Referenced by SolverSystem::setSolution().
| 
 | inherited | 
Set the active vector tags for the scalar variables.
Definition at line 1626 of file SystemBase.C.
Referenced by SubProblem::setActiveScalarVariableCoupleableVectorTags().
| 
 | inherited | 
Set the active vector tags for the variables.
Definition at line 1620 of file SystemBase.C.
Referenced by SubProblem::setActiveFEVariableCoupleableVectorTags().
| 
 | inherited | 
Sets the value of constrained variables in the solution vector.
Definition at line 1220 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::setInitialSolution().
Record the initial residual (for later relative convergence check)
Definition at line 790 of file NonlinearSystemBase.C.
Referenced by DefaultNonlinearConvergence::checkConvergence().
| 
 | inherited | 
Definition at line 956 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::preSolve().
| 
 | inherited | 
Referenced by NonlinearSystemBase::setInitialSolution().
Set the norm in which the linear convergence will be measured.
| kspnorm | The required norm | 
Definition at line 94 of file SolverSystem.C.
Referenced by MoosePreconditioner::MoosePreconditioner().
Set the side on which the preconditioner is applied to.
| pcs | The required preconditioning side | 
Definition at line 79 of file SolverSystem.C.
Referenced by MoosePreconditioner::MoosePreconditioner().
| 
 | inherited | 
Sets a preconditioner.
| pc | The preconditioner to be set | 
Definition at line 3634 of file NonlinearSystemBase.C.
Referenced by SetupPreconditionerAction::act().
Definition at line 1025 of file NonlinearSystemBase.C.
Referenced by SetupPredictorAction::act().
| 
 | inlineinherited | 
Set whether to evaluate the pre-SMO residual and use it in the subsequent relative convergence checks.
If set to true, an additional residual evaluation is performed before any solution-modifying object is executed, and before the initial (0-th nonlinear iteration) residual evaluation. Such residual is referred to as the pre-SMO residual. If the pre-SMO residual is evaluated, it is used in the subsequent relative convergence checks.
If set to false, no residual evaluation takes place before the initial residual evaluation, and the initial residual is used in the subsequent relative convergence checks. This mode is recommended for performance-critical code as it avoids the additional pre-SMO residual evaluation.
Definition at line 286 of file NonlinearSystemBase.h.
Referenced by FEProblemSolve::FEProblemSolve().
| 
 | virtualinherited | 
Definition at line 3906 of file NonlinearSystemBase.C.
Referenced by FEProblemBase::computePostCheck().
| 
 | inherited | 
Set the solution to a given vector.
| soln | The vector which should be treated as the solution. | 
Definition at line 67 of file SolverSystem.C.
Referenced by FEProblemBase::computeDamping(), FEProblemBase::computeJacobianInternal(), FEProblemBase::computeJacobianTag(), FEProblemBase::computeLinearSystemTags(), FEProblemBase::computeResidualAndJacobian(), FEProblemBase::computeResidualInternal(), FEProblemBase::computeResidualTag(), FEProblemBase::computeResidualType(), ActuallyExplicitEuler::solve(), and ExplicitSSPRungeKutta::solveStage().
| 
 | virtualinherited | 
Set transient term used by residual and Jacobian evaluation.
| udot | transient term | 
Definition at line 3610 of file NonlinearSystemBase.C.
| 
 | virtualinherited | 
Set transient term used by residual and Jacobian evaluation.
| udotdot | transient term | 
Definition at line 3616 of file NonlinearSystemBase.C.
| 
 | virtualinherited | 
Definition at line 3628 of file NonlinearSystemBase.C.
| 
 | virtualinherited | 
Definition at line 3622 of file NonlinearSystemBase.C.
| 
 | inherited | 
Setup damping stuff (called before we actually start)
Definition at line 3649 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::preInit().
| 
 | inherited | 
Setup the PETSc DM object (when appropriate)
Definition at line 464 of file NonlinearSystemBase.C.
Referenced by FEProblemBase::solve().
| 
 | overridevirtual | 
Implements NonlinearSystemBase.
Definition at line 397 of file NonlinearEigenSystem.C.
| 
 | inherited | 
set all the global dof indices for a variable
| var_name | The name of the variable | 
Definition at line 186 of file SystemBase.C.
| 
 | inlineinherited | 
Sets the verbose flag.
| [in] | verbose | Verbose flag | 
Definition at line 134 of file SystemBase.h.
Referenced by Executioner::Executioner().
| 
 | inherited | 
We offer the option to check convergence against the pre-SMO residual.
This method handles the logic as to whether we should perform such residual evaluation.
Definition at line 751 of file NonlinearSystemBase.C.
Referenced by NonlinearSystemBase::preSMOResidual(), and NonlinearSystem::solve().
| 
 | inherited | 
size the matrix data for each variable for the number of matrix tags we have
Definition at line 1719 of file SystemBase.C.
| 
 | inlineinherited | 
Definition at line 196 of file SystemBase.h.
Referenced by Adaptivity::adaptMesh(), TransientMultiApp::appTransferVector(), MooseEigenSystem::combineSystemSolution(), NonlinearSystemBase::computeDamping(), AuxiliarySystem::computeElementalVarsHelper(), NonlinearSystemBase::computeJacobianInternal(), AuxiliarySystem::computeMortarNodalVars(), NonlinearSystemBase::computeNodalBCs(), AuxiliarySystem::computeNodalVarsHelper(), NonlinearSystemBase::computeResidualTags(), AuxiliarySystem::computeScalarVars(), NonlinearSystemBase::constraintResiduals(), SystemBase::copyVars(), MultiAppPostprocessorToAuxScalarTransfer::execute(), MultiAppScalarToAuxScalarTransfer::execute(), NodalNormalsCorner::execute(), NodalNormalsEvaluator::execute(), MultiAppVariableValueSamplePostprocessorTransfer::execute(), NodalNormalsPreprocessor::execute(), NodalNormalsCorner::finalize(), NodalNormalsEvaluator::finalize(), NodalNormalsPreprocessor::finalize(), NodalNormalsCorner::initialize(), NodalNormalsEvaluator::initialize(), NodalNormalsPreprocessor::initialize(), MooseEigenSystem::initSystemSolution(), ComputeMarkerThread::onElement(), ComputeIndicatorThread::onElement(), ComputeUserObjectsThread::onElement(), ComputeNodalUserObjectsThread::onNode(), FEProblemBase::projectInitialConditionOnCustomRange(), FEProblemBase::projectSolution(), Transient::relativeSolutionDifferenceNorm(), MultiApp::restore(), ElementSubdomainModifierBase::restoreOverriddenDofValues(), SystemBase::restoreSolutions(), SecantSolve::saveVariableValues(), SteffensenSolve::saveVariableValues(), PicardSolve::saveVariableValues(), MooseEigenSystem::scaleSystemSolution(), AuxiliarySystem::serializeSolution(), NonlinearSystemBase::setConstraintSecondaryValues(), NonlinearSystemBase::setInitialSolution(), DisplacedSystem::solutionInternal(), solve(), MultiAppDofCopyTransfer::transfer(), SecantSolve::transformVariables(), SteffensenSolve::transformVariables(), PicardSolve::transformVariables(), AuxiliarySystem::variableWiseRelativeSolutionDifferenceNorm(), and SystemBase::zeroVariables().
| 
 | inlineinherited | 
Definition at line 199 of file SystemBase.h.
| 
 | inlinefinaloverrideprotectedvirtualinherited | 
Internal getter for solution owned by libMesh.
Implements SystemBase.
Definition at line 123 of file SolverSystem.h.
| 
 | inlineinherited | 
Definition at line 197 of file SystemBase.h.
Referenced by MooseEigenSystem::combineSystemSolution(), CentralDifference::computeTimeDerivatives(), NonlinearSystemBase::constraintResiduals(), ActivateElementsUserObjectBase::initSolutions(), MooseEigenSystem::initSystemSolutionOld(), MooseVariableScalar::reinit(), Transient::relativeSolutionDifferenceNorm(), SystemBase::restoreSolutions(), ElementSubdomainModifierBase::setOldAndOlderSolutions(), ActuallyExplicitEuler::solve(), AdamsPredictor::timestepSetup(), and AuxiliarySystem::variableWiseRelativeSolutionDifferenceNorm().
| 
 | inlineinherited | 
Definition at line 200 of file SystemBase.h.
| 
 | inlineinherited | 
Definition at line 198 of file SystemBase.h.
Referenced by MooseEigenSystem::combineSystemSolution(), CentralDifference::computeTimeDerivatives(), ActivateElementsUserObjectBase::initSolutions(), MooseVariableScalar::reinit(), and ElementSubdomainModifierBase::setOldAndOlderSolutions().
| 
 | inlineinherited | 
Definition at line 201 of file SystemBase.h.
| 
 | virtualinherited | 
Reimplemented in DisplacedSystem.
Definition at line 1355 of file SystemBase.C.
Referenced by AuxiliarySystem::copyCurrentIntoPreviousNL(), SystemBase::copyPreviousNonlinearSolutions(), and SystemBase::restoreSolutions().
| 
 | virtualinherited | 
Reimplemented in DisplacedSystem.
Definition at line 1346 of file SystemBase.C.
| 
 | virtualinherited | 
Get a state of the solution (0 = current, 1 = old, 2 = older, etc).
If the state does not exist, it will be initialized in addition to any newer states before it that have not been initialized.
Reimplemented in DisplacedSystem.
Definition at line 1431 of file SystemBase.C.
Referenced by SystemBase::copyOldSolutions(), SystemBase::copyPreviousFixedPointSolutions(), SystemBase::copyPreviousNonlinearSolutions(), PointwiseRenormalizeVector::execute(), PointwiseRenormalizeVector::finalize(), MooseVariableBase::getSolution(), SystemBase::restoreOldSolutions(), SystemBase::saveOldSolutions(), SystemBase::solution(), SystemBase::solutionOld(), SystemBase::solutionOlder(), and DisplacedSystem::solutionState().
| 
 | virtualinherited | 
Get a state of the solution (0 = current, 1 = old, 2 = older, etc).
Reimplemented in DisplacedSystem.
Definition at line 1402 of file SystemBase.C.
| 
 | inherited | 
Returns the parallel type of the given solution state.
Definition at line 1440 of file SystemBase.C.
Referenced by SystemBase::needSolutionState().
| 
 | inlineinherited | 
Whether or not the solution states have been initialized via initSolutionState()
After the solution states have been initialized, additional solution states cannot be added.
Definition at line 896 of file SystemBase.h.
Referenced by ScalarKernelBase::uOld(), and AuxScalarKernel::uOld().
| 
 | inlinevirtualinherited | 
Reimplemented in DisplacedSystem.
Definition at line 261 of file SystemBase.h.
Referenced by MooseVariableScalar::adUDot(), ActuallyExplicitEuler::computeTimeDerivatives(), ImplicitEuler::computeTimeDerivatives(), ExplicitEuler::computeTimeDerivatives(), NewmarkBeta::computeTimeDerivatives(), BDF2::computeTimeDerivatives(), CentralDifference::computeTimeDerivatives(), CrankNicolson::computeTimeDerivatives(), LStableDirk2::computeTimeDerivatives(), LStableDirk3::computeTimeDerivatives(), ImplicitMidpoint::computeTimeDerivatives(), ExplicitTVDRK2::computeTimeDerivatives(), LStableDirk4::computeTimeDerivatives(), AStableDirk4::computeTimeDerivatives(), ExplicitRK2::computeTimeDerivatives(), SystemBase::copyOldSolutions(), CrankNicolson::init(), CentralDifference::initialSetup(), MooseVariableScalar::reinit(), SystemBase::restoreSolutions(), DisplacedSystem::solutionUDot(), and MooseVariableScalar::uDot().
| 
 | inlinevirtualinherited | 
Reimplemented in DisplacedSystem.
Definition at line 265 of file SystemBase.h.
| 
 | inlinevirtualinherited | 
Reimplemented in DisplacedSystem.
Definition at line 262 of file SystemBase.h.
Referenced by NewmarkBeta::computeTimeDerivatives(), CentralDifference::computeTimeDerivatives(), SystemBase::copyOldSolutions(), CentralDifference::initialSetup(), MooseVariableScalar::reinit(), SystemBase::restoreSolutions(), DisplacedSystem::solutionUDotDot(), and MooseVariableScalar::uDotDot().
| 
 | inlinevirtualinherited | 
Reimplemented in DisplacedSystem.
Definition at line 266 of file SystemBase.h.
| 
 | inlinevirtualinherited | 
Reimplemented in DisplacedSystem.
Definition at line 264 of file SystemBase.h.
Referenced by NewmarkBeta::computeADTimeDerivatives(), NewmarkBeta::computeTimeDerivatives(), SystemBase::copyOldSolutions(), MooseVariableScalar::reinit(), SystemBase::restoreOldSolutions(), SystemBase::restoreSolutions(), SystemBase::saveOldSolutions(), DisplacedSystem::solutionUDotDotOld(), and MooseVariableScalar::uDotDotOld().
| 
 | inlinevirtualinherited | 
Reimplemented in DisplacedSystem.
Definition at line 268 of file SystemBase.h.
| 
 | inlinevirtualinherited | 
Reimplemented in DisplacedSystem.
Definition at line 263 of file SystemBase.h.
Referenced by NewmarkBeta::computeADTimeDerivatives(), NewmarkBeta::computeTimeDerivatives(), SystemBase::copyOldSolutions(), MooseVariableScalar::reinit(), SystemBase::restoreOldSolutions(), SystemBase::restoreSolutions(), SystemBase::saveOldSolutions(), DisplacedSystem::solutionUDotOld(), and MooseVariableScalar::uDotOld().
| 
 | inlinevirtualinherited | 
Reimplemented in DisplacedSystem.
Definition at line 267 of file SystemBase.h.
| 
 | overridevirtual | 
Solve the system (using libMesh magic)
Implements NonlinearSystemBase.
Definition at line 240 of file NonlinearEigenSystem.C.
| 
 | overridevirtual | 
Quit the current solve as soon as possible.
Implements SolverSystem.
Definition at line 391 of file NonlinearEigenSystem.C.
| 
 | inherited | 
Definition at line 1592 of file SystemBase.C.
| 
 | virtualinherited | 
Called from assembling when we hit a new subdomain.
| subdomain | ID of the new subdomain | 
| tid | Thread ID | 
Definition at line 1031 of file NonlinearSystemBase.C.
| 
 | virtualinherited | 
Reimplemented in AuxiliarySystem.
Definition at line 1592 of file SystemBase.C.
Referenced by AuxiliarySystem::subdomainSetup(), and NonlinearSystemBase::subdomainSetup().
| 
 | inlineinherited | 
Definition at line 101 of file SystemBase.h.
Referenced by CreateDisplacedProblemAction::addProxyRelationshipManagers(), MooseVariableBase::allDofIndices(), NonlinearSystemBase::constraintJacobians(), NonlinearSystemBase::constraintResiduals(), Moose::globalDofIndexToDerivative(), NonlinearSystemBase::initialSetup(), MooseVariableScalar::MooseVariableScalar(), NonlinearSystemBase::overwriteNodeFace(), MooseVariableScalar::reinit(), NonlinearSystemBase::reinitNodeFace(), NonlinearSystemBase::setConstraintSecondaryValues(), and MooseVariableScalar::sizeMatrixTagData().
| 
 | inlineinherited | 
Definition at line 102 of file SystemBase.h.
| 
 | inline | 
Definition at line 98 of file NonlinearEigenSystem.h.
Referenced by Moose::SlepcSupport::mooseEPSFormMatrices(), Moose::SlepcSupport::mooseSlepcEigenFormFunctionAB(), Moose::SlepcSupport::mooseSlepcEigenFormFunctionB(), Moose::SlepcSupport::mooseSlepcEigenFormJacobianA(), Moose::SlepcSupport::mooseSlepcEigenFormJacobianB(), and postAddResidualObject().
| 
 | inlineoverridevirtualinherited | 
Get the reference to the libMesh system.
Implements SystemBase.
Definition at line 695 of file NonlinearSystemBase.h.
Referenced by Adaptivity::adaptMesh(), PhysicsBasedPreconditioner::addSystem(), PhysicsBasedPreconditioner::apply(), FEProblemBase::computeJacobianTags(), FEProblemBase::computeResidualAndJacobian(), NonlinearSystemBase::computeScaling(), PseudoTimestep::currentResidualNorm(), DMMooseFunction(), DMMooseJacobian(), VariableResidual::execute(), NonlinearSystemBase::getResidualNonTimeVector(), NonlinearSystemBase::getResidualTimeVector(), NonlinearSystem::getSNES(), ExplicitTimeIntegrator::initialSetup(), ReferenceResidualConvergence::initialSetup(), MooseStaticCondensationPreconditioner::MooseStaticCondensationPreconditioner(), Moose::PetscSupport::petscSetDefaults(), PhysicsBasedPreconditioner::PhysicsBasedPreconditioner(), ComputeJacobianThread::postElement(), NonlinearSystemBase::residualGhosted(), Moose::PetscSupport::setLineSearchFromParams(), PhysicsBasedPreconditioner::setup(), NonlinearSystemBase::setupScalingData(), SingleMatrixPreconditioner::SingleMatrixPreconditioner(), NonlinearSystem::solve(), solve(), LStableDirk2::solve(), LStableDirk3::solve(), ImplicitMidpoint::solve(), ExplicitTVDRK2::solve(), LStableDirk4::solve(), AStableDirk4::solve(), ExplicitRK2::solve(), FieldSplitPreconditioner::system(), NonlinearSystemBase::turnOffJacobian(), ReferenceResidualConvergence::updateReferenceResidual(), VariableCondensationPreconditioner::VariableCondensationPreconditioner(), and Console::writeVariableNorms().
| 
 | inlineoverridevirtualinherited | 
| 
 | inlineoverridevirtualinherited | 
Return the Matrix Tag ID for System.
Reimplemented from SystemBase.
Definition at line 707 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addImplicitGeometricCouplingEntries(), NonlinearSystemBase::computeJacobian(), NonlinearSystemBase::computeJacobianInternal(), FEProblemBase::computeJacobianInternal(), FEProblemBase::computeResidualAndJacobian(), NonlinearSystemBase::constraintJacobians(), and NonlinearSystemBase::enforceNodalConstraintsJacobian().
| 
 | protectedinherited | 
section_name.Optionally adds a prefix if one is defined.
Definition at line 47 of file PerfGraphInterface.C.
Referenced by PerfGraphInterface::registerTimedSection().
| 
 | overridevirtualinherited | 
Returns the names of the variables that have time derivative kernels in the system.
Implements SolverSystem.
Definition at line 3833 of file NonlinearSystemBase.C.
| 
 | overridevirtualinherited | 
Reimplemented from SystemBase.
Definition at line 338 of file NonlinearSystemBase.C.
| 
 | inlineoverridevirtualinherited | 
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 704 of file NonlinearSystemBase.h.
Referenced by FEProblemBase::addCachedResidualDirectly(), NonlinearSystemBase::containsTimeKernel(), and NonlinearSystemBase::timeKernelVariableNames().
| 
 | overridevirtual | 
Turn off the Jacobian (must be called before equation system initialization)
Reimplemented from NonlinearSystemBase.
Definition at line 542 of file NonlinearEigenSystem.C.
| 
 | inherited | 
Update the system (doing libMesh magic)
Definition at line 1243 of file SystemBase.C.
Referenced by Adaptivity::adaptMesh(), MooseEigenSystem::combineSystemSolution(), NonlinearSystemBase::computeDamping(), NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeResidualTags(), EigenProblem::doFreeNonlinearPowerIterations(), PointwiseRenormalizeVector::finalize(), MooseEigenSystem::initSystemSolution(), MooseEigenSystem::initSystemSolutionOld(), MooseEigenSystem::scaleSystemSolution(), NonlinearSystemBase::setConstraintSecondaryValues(), NonlinearSystemBase::setInitialSolution(), EigenProblem::solve(), FEProblemBase::solve(), DisplacedProblem::syncSolutions(), MultiAppDofCopyTransfer::transfer(), SecantSolve::transformVariables(), SteffensenSolve::transformVariables(), and PicardSolve::transformVariables().
Update active objects of Warehouses owned by NonlinearSystemBase.
Definition at line 3358 of file NonlinearSystemBase.C.
| 
 | inlineinherited | 
If called with a non-null object true this system will use a field split preconditioner matrix.
Definition at line 494 of file NonlinearSystemBase.h.
Referenced by FieldSplitPreconditionerTempl< MoosePreconditioner >::FieldSplitPreconditionerTempl().
| 
 | inlineinherited | 
If called with true this system will use a finite differenced form of the Jacobian as the preconditioner.
Definition at line 486 of file NonlinearSystemBase.h.
Referenced by FiniteDifferencePreconditioner::FiniteDifferencePreconditioner().
| 
 | inlineinherited | 
Whether we are using pre-SMO residual in relative convergence checks.
Definition at line 289 of file NonlinearSystemBase.h.
Referenced by Console::outputSystemInformation(), and NonlinearSystemBase::referenceResidual().
| 
 | staticinherited | 
Definition at line 16 of file PerfGraphInterface.C.
Referenced by Convergence::validParams().
| 
 | inlineinherited | 
Definition at line 924 of file SystemBase.h.
Referenced by Coupleable::coupled().
Zero vector with the given tag.
Definition at line 674 of file SystemBase.C.
Referenced by SystemBase::zeroTaggedVectors().
Zero all vectors for given tags.
Definition at line 693 of file SystemBase.C.
Referenced by NonlinearSystemBase::computeResidualAndJacobianTags(), and NonlinearSystemBase::computeResidualTags().
| 
 | virtualinherited | 
Zero out the solution for the list of variables passed in.
@ param vars_to_be_zeroed The variable names in this vector will have their solutions set to zero after this call
Reimplemented in DisplacedSystem.
Definition at line 200 of file SystemBase.C.
Referenced by DisplacedSystem::zeroVariables(), SystemBase::zeroVariablesForJacobian(), and SystemBase::zeroVariablesForResidual().
| 
 | 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 235 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 229 of file SystemBase.C.
| 
 | inherited | 
Definition at line 796 of file NonlinearSystemBase.C.
| 
 | protected | 
Definition at line 203 of file NonlinearEigenSystem.h.
Referenced by nonEigenMatrixTag(), NonlinearEigenSystem(), and postAddResidualObject().
| 
 | protectedinherited | 
Active tagged matrices. A matrix is active if its tag-matrix pair is present in the map. We use a map instead of a vector so that users can easily add and remove to this container with calls to (de)activateMatrixTag.
Definition at line 1025 of file SystemBase.h.
Referenced by SystemBase::activateAllMatrixTags(), SystemBase::deactivateAllMatrixTags(), and SystemBase::reinitElem().
| 
 | protectedinherited | 
Definition at line 928 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addBoundaryCondition(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::setInitialSolution(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
Whether or not to add implicit geometric couplings to the Jacobian for FDP.
Definition at line 977 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addImplicitGeometricCouplingEntriesToJacobian(), NonlinearSystemBase::augmentSparsity(), and NonlinearSystemBase::computeJacobianInternal().
| 
 | protectedinherited | 
Definition at line 988 of file SystemBase.h.
Referenced by SolverSystem::checkInvalidSolution(), NonlinearSystemBase::computeJacobianBlocks(), NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeJacobianTags(), LinearSystem::computeLinearSystemInternal(), LinearSystem::computeLinearSystemTags(), NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::computeResidualTags(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::shouldEvaluatePreSMOResidual(), and NonlinearSystem::solve().
| 
 | protectedinherited | 
Whether or not to assemble the residual and Jacobian after the application of each constraint.
Definition at line 980 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::assembleConstraintsSeparately(), NonlinearSystemBase::constraintJacobians(), and NonlinearSystemBase::constraintResiduals().
| 
 | protectedinherited | 
Whether to automatically scale the variables.
Definition at line 1055 of file SystemBase.h.
Referenced by SystemBase::automaticScaling(), NonlinearSystemBase::initialSetup(), and NonlinearSystemBase::preSolve().
| 
 | protected | 
Definition at line 201 of file NonlinearEigenSystem.h.
Referenced by nonEigenVectorTag(), NonlinearEigenSystem(), and postAddResidualObject().
| 
 | protected | 
Definition at line 204 of file NonlinearEigenSystem.h.
Referenced by eigenMatrixTag(), NonlinearEigenSystem(), and postAddResidualObject().
| 
 | protected | 
Definition at line 202 of file NonlinearEigenSystem.h.
Referenced by eigenVectorTag(), NonlinearEigenSystem(), and postAddResidualObject().
| 
 | protectedinherited | 
Whether the scaling factors should only be computed once at the beginning of the simulation through an extra Jacobian evaluation.
If this is set to false, then the scaling factors will be computed during an extra Jacobian evaluation at the beginning of every time step.
Definition at line 1035 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeScaling(), and NonlinearSystemBase::computeScalingOnce().
| 
 | protectedinherited | 
Flag used to indicate whether we have already computed the scaling Jacobian.
Definition at line 1030 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computedScalingJacobian(), and NonlinearSystemBase::computeScaling().
| 
 | protectedinherited | 
Definition at line 1004 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computingPreSMOResidual(), and NonlinearSystem::solve().
| 
 | inherited | 
An instance of helper class to write streams to the Console objects.
Definition at line 31 of file ConsoleStreamInterface.h.
Referenced by IterationAdaptiveDT::acceptStep(), MeshOnlyAction::act(), SetupDebugAction::act(), MaterialOutputAction::act(), Adaptivity::adaptMesh(), FEProblemBase::adaptMesh(), PerfGraph::addToExecutionList(), SimplePredictor::apply(), SystemBase::applyScalingFactors(), MultiApp::backup(), FEProblemBase::backupMultiApps(), CoarsenedPiecewiseLinear::buildCoarsenedGrid(), DefaultSteadyStateConvergence::checkConvergence(), MeshDiagnosticsGenerator::checkElementOverlap(), MeshDiagnosticsGenerator::checkElementTypes(), MeshDiagnosticsGenerator::checkElementVolumes(), FEProblemBase::checkExceptionAndStopSolve(), SolverSystem::checkInvalidSolution(), MeshDiagnosticsGenerator::checkLocalJacobians(), MeshDiagnosticsGenerator::checkNonConformalMesh(), MeshDiagnosticsGenerator::checkNonConformalMeshFromAdaptivity(), MeshDiagnosticsGenerator::checkNonMatchingEdges(), MeshDiagnosticsGenerator::checkNonPlanarSides(), FEProblemBase::checkProblemIntegrity(), ReferenceResidualConvergence::checkRelativeConvergence(), MeshDiagnosticsGenerator::checkSidesetsOrientation(), MeshDiagnosticsGenerator::checkWatertightNodesets(), MeshDiagnosticsGenerator::checkWatertightSidesets(), IterationAdaptiveDT::computeAdaptiveDT(), TransientBase::computeConstrainedDT(), DefaultMultiAppFixedPointConvergence::computeCustomConvergencePostprocessor(), NonlinearSystemBase::computeDamping(), FixedPointIterationAdaptiveDT::computeDT(), IterationAdaptiveDT::computeDT(), IterationAdaptiveDT::computeFailedDT(), IterationAdaptiveDT::computeInitialDT(), IterationAdaptiveDT::computeInterpolationDT(), LinearSystem::computeLinearSystemTags(), FEProblemBase::computeLinearSystemTags(), NonlinearSystemBase::computeScaling(), Problem::console(), IterationAdaptiveDT::constrainStep(), TimeStepper::constrainStep(), MultiApp::createApp(), FEProblemBase::execMultiApps(), FEProblemBase::execMultiAppTransfers(), MFEMSteady::execute(), MessageFromInput::execute(), SteadyBase::execute(), Eigenvalue::execute(), ActionWarehouse::executeActionsWithAction(), ActionWarehouse::executeAllActions(), MeshGeneratorSystem::executeMeshGenerators(), ElementQualityChecker::finalize(), SidesetAroundSubdomainUpdater::finalize(), FEProblemBase::finishMultiAppStep(), MeshRepairGenerator::fixOverlappingNodes(), CoarsenBlockGenerator::generate(), MeshGenerator::generateInternal(), VariableCondensationPreconditioner::getDofToCondense(), NonlinearEigen::init(), InversePowerMethod::init(), FEProblemBase::initialAdaptMesh(), DefaultMultiAppFixedPointConvergence::initialize(), SubProblem::initialSetup(), EigenExecutionerBase::inversePowerIteration(), FEProblemBase::joinAndFinalize(), TransientBase::keepGoing(), IterationAdaptiveDT::limitDTByFunction(), IterationAdaptiveDT::limitDTToPostprocessorValue(), FEProblemBase::logAdd(), EigenExecutionerBase::makeBXConsistent(), Console::meshChanged(), MooseBase::mooseDeprecated(), MooseBase::mooseInfo(), MooseBase::mooseWarning(), MooseBase::mooseWarningNonPrefixed(), ReferenceResidualConvergence::nonlinearConvergenceSetup(), ReporterDebugOutput::output(), PerfGraphOutput::output(), SolutionInvalidityOutput::output(), MaterialPropertyDebugOutput::output(), DOFMapOutput::output(), VariableResidualNormsDebugOutput::output(), Console::output(), ControlOutput::outputActiveObjects(), ControlOutput::outputChangedControls(), ControlOutput::outputControls(), Console::outputInput(), Console::outputPostprocessors(), PseudoTimestep::outputPseudoTimestep(), Console::outputReporters(), DefaultMultiAppFixedPointConvergence::outputResidualNorm(), Console::outputScalarVariables(), Console::outputSystemInformation(), FEProblemBase::possiblyRebuildGeomSearchPatches(), EigenExecutionerBase::postExecute(), AB2PredictorCorrector::postSolve(), ActionWarehouse::printActionDependencySets(), BlockRestrictionDebugOutput::printBlockRestrictionMap(), SolutionInvalidity::printDebug(), EigenExecutionerBase::printEigenvalue(), SecantSolve::printFixedPointConvergenceHistory(), SteffensenSolve::printFixedPointConvergenceHistory(), PicardSolve::printFixedPointConvergenceHistory(), FixedPointSolve::printFixedPointConvergenceReason(), PerfGraphLivePrint::printLiveMessage(), MaterialPropertyDebugOutput::printMaterialMap(), PerfGraphLivePrint::printStats(), NEML2Action::printSummary(), AutomaticMortarGeneration::projectPrimaryNodesSinglePair(), AutomaticMortarGeneration::projectSecondaryNodesSinglePair(), CoarsenBlockGenerator::recursiveCoarsen(), SolutionTimeAdaptiveDT::rejectStep(), MultiApp::restore(), FEProblemBase::restoreMultiApps(), FEProblemBase::restoreSolutions(), NonlinearSystemBase::setInitialSolution(), MooseApp::setupOptions(), Checkpoint::shouldOutput(), SubProblem::showFunctorRequestors(), SubProblem::showFunctors(), FullSolveMultiApp::showStatusMessage(), EigenProblem::solve(), FEProblemSolve::solve(), NonlinearSystem::solve(), FixedPointSolve::solve(), LinearSystem::solve(), LStableDirk2::solve(), LStableDirk3::solve(), ImplicitMidpoint::solve(), ExplicitTVDRK2::solve(), AStableDirk4::solve(), LStableDirk4::solve(), ExplicitRK2::solve(), TransientMultiApp::solveStep(), FixedPointSolve::solveStep(), PerfGraphLivePrint::start(), AB2PredictorCorrector::step(), NonlinearEigen::takeStep(), MFEMTransient::takeStep(), TransientBase::takeStep(), TerminateChainControl::terminate(), SubProblem::timestepSetup(), FEProblemBase::updateMeshXFEM(), Convergence::verboseOutput(), Console::writeTimestepInformation(), Console::writeVariableNorms(), and FEProblemBase::~FEProblemBase().
| 
 | protectedinherited | 
Constraints storage object.
Definition at line 961 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addConstraint(), NonlinearSystemBase::checkKernelCoverage(), NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::constraintJacobians(), NonlinearSystemBase::constraintResiduals(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::enforceNodalConstraintsJacobian(), NonlinearSystemBase::enforceNodalConstraintsResidual(), NonlinearSystemBase::findImplicitGeometricCouplingEntries(), NonlinearSystemBase::getConstraintWarehouse(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::needBoundaryMaterialOnSide(), NonlinearSystemBase::overwriteNodeFace(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::setConstraintSecondaryValues(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | inherited | 
Definition at line 750 of file NonlinearSystemBase.h.
Referenced by SolutionHistory::output(), and NonlinearSystemBase::preSolve().
| 
 | inherited | 
Definition at line 751 of file NonlinearSystemBase.h.
Referenced by DefaultNonlinearConvergence::checkConvergence(), SolutionHistory::output(), and NonlinearSystemBase::preSolve().
| 
 | protectedinherited | 
solution vector from solver
Definition at line 105 of file SolverSystem.h.
Referenced by NonlinearSystem::computeScalingJacobian(), computeScalingJacobian(), NonlinearSystem::computeScalingResidual(), computeScalingResidual(), SolverSystem::currentSolution(), SolverSystem::preInit(), SolverSystem::restoreSolutions(), SolverSystem::serializeSolution(), SolverSystem::setSolution(), and NonlinearSystem::solve().
| 
 | protectedinherited | 
true if debugging residuals
Definition at line 985 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeResidualTags(), and NonlinearSystemBase::debuggingResiduals().
| 
 | protectedinherited | 
Definition at line 919 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addDGKernel(), NonlinearSystemBase::checkKernelCoverage(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::getDGKernelWarehouse(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::needInternalNeighborSideMaterial(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
Dirac Kernel storage for each thread.
Definition at line 943 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addDiracKernel(), NonlinearSystemBase::computeDiracContributions(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::getDiracKernelWarehouse(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
true if DG is active (optimization reasons)
Definition at line 988 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addDGKernel(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::doingDG(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), and NonlinearSystemBase::timestepSetup().
| 
 | protectedinherited | 
\( {du^dot}\over{du} \)
Definition at line 884 of file NonlinearSystemBase.h.
| 
 | protectedinherited | 
\( {du^dotdot}\over{du} \)
Definition at line 886 of file NonlinearSystemBase.h.
| 
 | protected | 
Definition at line 195 of file NonlinearEigenSystem.h.
Referenced by attachPreconditioner(), attachSLEPcCallbacks(), computeScalingJacobian(), computeScalingResidual(), getSNES(), and solve().
| 
 | protected | 
Definition at line 194 of file NonlinearEigenSystem.h.
Referenced by attachSLEPcCallbacks(), converged(), getConvergedEigenpair(), getConvergedEigenvalue(), getEPS(), getNumConvergedEigenvalues(), initializeCondensedMatrices(), NonlinearEigenSystem(), postAddResidualObject(), solve(), and sys().
Definition at line 197 of file NonlinearEigenSystem.h.
Referenced by getAllConvergedEigenvalues(), and solve().
| 
 | protectedinherited | 
Element Dampers for each thread.
Definition at line 946 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addDamper(), NonlinearSystemBase::computeDamping(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::getElementDamperWarehouse(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::subdomainSetup(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
Definition at line 989 of file SystemBase.h.
Referenced by NonlinearSystemBase::addBoundaryCondition(), NonlinearSystemBase::addConstraint(), NonlinearSystemBase::addDamper(), NonlinearSystemBase::addDGKernel(), NonlinearSystemBase::addDiracKernel(), NonlinearSystemBase::addHDGKernel(), NonlinearSystemBase::addInterfaceKernel(), MooseEigenSystem::addKernel(), AuxiliarySystem::addKernel(), NonlinearSystemBase::addKernel(), NonlinearSystemBase::addNodalKernel(), AuxiliarySystem::addScalarKernel(), NonlinearSystemBase::addScalarKernel(), NonlinearSystemBase::addSplit(), SystemBase::addTimeIntegrator(), and SystemBase::addVariable().
| 
 | protectedinherited | 
Definition at line 971 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::destroyColoring(), NonlinearSystem::setupColoringFiniteDifferencedPreconditioner(), and NonlinearSystem::solve().
| 
 | protectedinherited | 
the governing finite element/volume problem
Definition at line 986 of file SystemBase.h.
Referenced by NonlinearSystemBase::addBoundaryCondition(), NonlinearSystemBase::addDGKernel(), NonlinearSystemBase::addDiracKernel(), SystemBase::addDotVectors(), NonlinearSystemBase::addHDGKernel(), NonlinearSystemBase::addInterfaceKernel(), NonlinearSystemBase::addKernel(), NonlinearSystemBase::addNodalKernel(), NonlinearSystemBase::addScalarKernel(), NonlinearSystemBase::addSplit(), NonlinearSystemBase::assembleScalingVector(), NonlinearSystemBase::augmentSparsity(), SolverSystem::checkInvalidSolution(), NonlinearSystemBase::checkKernelCoverage(), AuxiliarySystem::clearScalarVariableCoupleableTags(), SolverSystem::compute(), AuxiliarySystem::compute(), NonlinearSystemBase::computeDamping(), NonlinearSystemBase::computeDiracContributions(), AuxiliarySystem::computeElementalVarsHelper(), LinearSystem::computeGradients(), NonlinearSystemBase::computeJacobian(), NonlinearSystemBase::computeJacobianBlocks(), NonlinearSystemBase::computeJacobianInternal(), LinearSystem::computeLinearSystemInternal(), LinearSystem::computeLinearSystemTags(), AuxiliarySystem::computeMortarNodalVars(), NonlinearSystemBase::computeNodalBCs(), NonlinearSystemBase::computeNodalBCsResidualAndJacobian(), AuxiliarySystem::computeNodalVarsHelper(), NonlinearSystemBase::computeResidualAndJacobianInternal(), NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::computeResidualTags(), NonlinearSystemBase::computeScalarKernelsJacobians(), AuxiliarySystem::computeScalarVars(), NonlinearSystemBase::computeScaling(), NonlinearSystem::computeScalingJacobian(), NonlinearSystem::computeScalingResidual(), NonlinearSystemBase::constraintJacobians(), NonlinearSystemBase::constraintResiduals(), LinearSystem::containsTimeKernel(), NonlinearSystem::converged(), NonlinearSystemBase::customSetup(), MooseEigenSystem::eigenKernelOnCurrent(), MooseEigenSystem::eigenKernelOnOld(), NonlinearSystemBase::enforceNodalConstraintsJacobian(), NonlinearSystemBase::enforceNodalConstraintsResidual(), SystemBase::feProblem(), NonlinearSystemBase::getResidualNonTimeVector(), NonlinearSystemBase::getResidualTimeVector(), LinearSystem::initialSetup(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), LinearSystem::LinearSystem(), NonlinearSystemBase::NonlinearSystemBase(), NonlinearSystemBase::overwriteNodeFace(), NonlinearSystem::potentiallySetupFiniteDifferencing(), NonlinearSystemBase::preInit(), NonlinearSystemBase::reinitNodeFace(), NonlinearSystem::residualAndJacobianTogether(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::setConstraintSecondaryValues(), NonlinearSystemBase::setInitialSolution(), AuxiliarySystem::setScalarVariableCoupleableTags(), NonlinearSystemBase::shouldEvaluatePreSMOResidual(), NonlinearSystem::solve(), and NonlinearSystemBase::timestepSetup().
| 
 | protectedinherited | 
Definition at line 999 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::finalNonlinearResidual(), and NonlinearSystem::solve().
| 
 | protectedinherited | 
The field split preconditioner if this sytem is using one.
Definition at line 974 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::getFieldSplitPreconditioner(), NonlinearSystemBase::haveFieldSplitPreconditioner(), NonlinearSystemBase::setupDM(), and NonlinearSystemBase::useFieldSplitPreconditioner().
| 
 | protectedinherited | 
General Dampers.
Definition at line 952 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addDamper(), NonlinearSystemBase::computeDamping(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
If there is any Kernel or IntegratedBC having diag_save_in.
Definition at line 1019 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addBoundaryCondition(), NonlinearSystemBase::addDGKernel(), MooseEigenSystem::addKernel(), NonlinearSystemBase::addKernel(), NonlinearSystemBase::addNodalKernel(), NonlinearSystemBase::computeJacobianInternal(), and NonlinearSystemBase::hasDiagSaveIn().
| 
 | protectedinherited | 
If there is a nodal BC having diag_save_in.
Definition at line 1025 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addBoundaryCondition(), NonlinearSystemBase::computeJacobianInternal(), and NonlinearSystemBase::hasDiagSaveIn().
| 
 | protectedinherited | 
If there is a nodal BC having save_in.
Definition at line 1022 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addBoundaryCondition(), NonlinearSystemBase::computeResidualTags(), and NonlinearSystemBase::hasSaveIn().
| 
 | protectedinherited | 
If there is any Kernel or IntegratedBC having save_in.
Definition at line 1016 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addBoundaryCondition(), NonlinearSystemBase::addDGKernel(), MooseEigenSystem::addKernel(), NonlinearSystemBase::addKernel(), NonlinearSystemBase::addNodalKernel(), NonlinearSystemBase::computeNodalBCs(), and NonlinearSystemBase::hasSaveIn().
| 
 | protectedinherited | 
Definition at line 917 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addHDGKernel(), and NonlinearSystemBase::getHDGKernelWarehouse().
| 
 | protectedinherited | 
A container for variables that do not partipate in autoscaling.
Definition at line 1051 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::ignoreVariablesForAutoscaling(), and NonlinearSystemBase::setupScalingData().
| 
 | protectedinherited | 
increment vector
Definition at line 964 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeDamping(), NonlinearSystemBase::reinitIncrementAtNodeForDampers(), NonlinearSystemBase::reinitIncrementAtQpsForDampers(), and NonlinearSystemBase::setupDampers().
| 
 | protectedinherited | 
The initial (i.e., 0th nonlinear iteration) residual, see setPreSMOResidual for a detailed explanation.
Definition at line 1009 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::initialResidual(), and NonlinearSystemBase::setInitialResidual().
| 
 | protectedinherited | 
BoundaryCondition Warhouses
Definition at line 925 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addBoundaryCondition(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::getIntegratedBCWarehouse(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::needBoundaryMaterialOnSide(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
Definition at line 920 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addInterfaceKernel(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::getInterfaceKernelWarehouse(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::needBoundaryMaterialOnSide(), NonlinearSystemBase::needInterfaceMaterialOnSide(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
Tag for non-time contribution Jacobian.
Definition at line 909 of file NonlinearSystemBase.h.
| 
 | protectedinherited | 
Tag for system contribution Jacobian.
Definition at line 912 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::NonlinearSystemBase(), and NonlinearSystemBase::systemMatrixTag().
| 
 | protectedinherited | 
Kernel Storage
Definition at line 916 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addHDGKernel(), MooseEigenSystem::addKernel(), NonlinearSystemBase::addKernel(), NonlinearSystemBase::checkKernelCoverage(), NonlinearSystemBase::containsTimeKernel(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::getKernelWarehouse(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::subdomainSetup(), NonlinearSystemBase::timeKernelVariableNames(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
Definition at line 935 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::customSetup(), NonlinearSystemBase::getKokkosIntegratedBCWarehouse(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
Kokkos residual object warhouses
Definition at line 934 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::checkKernelCoverage(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
Definition at line 936 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::customSetup(), NonlinearSystemBase::getKokkosNodalBCWarehouse(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
Definition at line 938 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::checkKernelCoverage(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::getKokkosNodalKernelWarehouse(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
Definition at line 937 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::setInitialSolution(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
KSP norm type.
Definition at line 110 of file SolverSystem.h.
Referenced by SolverSystem::getMooseKSPNormType(), and SolverSystem::setMooseKSPNormType().
| 
 | inherited | 
Definition at line 749 of file NonlinearSystemBase.h.
Referenced by DefaultNonlinearConvergence::checkConvergence(), and NonlinearSystemBase::nonlinearNorm().
| 
 | protectedinherited | 
Active flags for tagged matrices.
Definition at line 1027 of file SystemBase.h.
Referenced by SystemBase::activateAllMatrixTags(), SystemBase::deactivateAllMatrixTags(), and SystemBase::matrixTagActive().
| 
 | protectedinherited | 
Maximum number of dofs for any one variable on any one element.
Definition at line 1043 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 1046 of file SystemBase.h.
Referenced by SystemBase::assignMaxVarNDofsPerNode(), and SystemBase::getMaxVarNDofsPerNode().
| 
 | protectedinherited | 
Maximum variable number.
Definition at line 1000 of file SystemBase.h.
Referenced by SystemBase::addVariable(), and SystemBase::getMaxVariableNumber().
| 
 | protectedinherited | 
Definition at line 991 of file SystemBase.h.
Referenced by SystemBase::addVariable(), NonlinearSystemBase::assembleScalingVector(), SystemBase::augmentSendList(), NonlinearSystemBase::checkKernelCoverage(), AuxiliarySystem::computeElementalVarsHelper(), NonlinearSystemBase::computeJacobianInternal(), AuxiliarySystem::computeMortarNodalVars(), AuxiliarySystem::computeNodalVarsHelper(), NonlinearSystemBase::constraintJacobians(), NonlinearSystemBase::constraintResiduals(), NonlinearSystemBase::findImplicitGeometricCouplingEntries(), NonlinearSystemBase::getNodeDofs(), SystemBase::initialSetup(), SystemBase::mesh(), NonlinearSystemBase::overwriteNodeFace(), NonlinearSystemBase::reinitNodeFace(), NonlinearSystemBase::setConstraintSecondaryValues(), SystemBase::setVariableGlobalDoFs(), AuxiliarySystem::variableWiseRelativeSolutionDifferenceNorm(), and SystemBase::zeroVariables().
| 
 | protected | 
Definition at line 198 of file NonlinearEigenSystem.h.
Referenced by solve().
| 
 | protectedinherited | 
Definition at line 993 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::nNonlinearIterations(), and NonlinearSystem::solve().
| 
 | protectedinherited | 
Definition at line 994 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::nLinearIterations(), and NonlinearSystem::solve().
| 
 | protectedinherited | 
Total number of residual evaluations that have been performed.
Definition at line 997 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeResidualTags(), and NonlinearSystemBase::nResidualEvaluations().
| 
 | protectedinherited | 
The name of this system.
Definition at line 993 of file SystemBase.h.
| 
 | protectedinherited | 
Whether or not a ghosted copy of the residual needs to be made.
Definition at line 983 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::computeResidualTags(), NonlinearSystemBase::constraintResiduals(), NonlinearSystemBase::getResidualNonTimeVector(), NonlinearSystemBase::getResidualTimeVector(), and NonlinearSystemBase::residualGhosted().
| 
 | protectedinherited | 
Matrix tags to temporarily store all tags associated with the current system.
Definition at line 895 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeJacobian(), and NonlinearSystemBase::computeJacobianBlocks().
| 
 | protectedinherited | 
Vector tags to temporarily store all tags associated with the current system.
Definition at line 892 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeResidualTag().
| 
 | protectedinherited | 
Definition at line 926 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addBoundaryCondition(), checkIntegrity(), NonlinearSystemBase::computeJacobianBlocks(), NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeNodalBCs(), NonlinearSystemBase::computeNodalBCsResidualAndJacobian(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::getNodalBCWarehouse(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
Nodal Dampers for each thread.
Definition at line 949 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addDamper(), NonlinearSystemBase::computeDamping(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::getNodalDamperWarehouse(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::subdomainSetup(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
NodalKernels for each thread.
Definition at line 955 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addNodalKernel(), NonlinearSystemBase::checkKernelCoverage(), NonlinearSystemBase::computeJacobianInternal(), NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::getNodalKernelWarehouse(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::subdomainSetup(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protected | 
The number of degrees of freedom constrained at the libMesh level, e.g.
via hanging node or periodic boundary constraints
Definition at line 212 of file NonlinearEigenSystem.h.
Referenced by attachSLEPcCallbacks(), initializeCondensedMatrices(), and solve().
| 
 | inherited | 
Definition at line 591 of file NonlinearSystemBase.h.
| 
 | protectedinherited | 
Map variable number to its pointer.
Definition at line 1052 of file SystemBase.h.
Referenced by SystemBase::addVariable(), and SystemBase::getVariable().
| 
 | protectedinherited | 
Whether to include off diagonals when determining automatic scaling factors.
Definition at line 1054 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::initialSetup(), and NonlinearSystemBase::offDiagonalsInAutoScaling().
| 
 | protectedinherited | 
Preconditioning side.
Definition at line 108 of file SolverSystem.h.
Referenced by SolverSystem::getPCSide(), and SolverSystem::setPCSide().
| 
 | protectedinherited | 
The MooseApp that owns the PerfGraph.
Definition at line 124 of file PerfGraphInterface.h.
Referenced by PerfGraphInterface::perfGraph().
| 
 | protectedinherited | 
The pre-SMO residual, see setPreSMOResidual for a detailed explanation.
Definition at line 1007 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::preSMOResidual(), and NonlinearSystem::solve().
| 
 | protected | 
Definition at line 206 of file NonlinearEigenSystem.h.
Referenced by postAddResidualObject(), and precondMatrixIncludesEigenKernels().
| 
 | protected | 
Definition at line 205 of file NonlinearEigenSystem.h.
Referenced by NonlinearEigenSystem(), postAddResidualObject(), and precondMatrixTag().
| 
 | protected | 
Definition at line 208 of file NonlinearEigenSystem.h.
Referenced by attachPreconditioner(), and preconditioner().
| 
 | protectedinherited | 
If predictor is active, this is non-NULL.
Definition at line 1002 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::getPredictor(), NonlinearSystemBase::onTimestepBegin(), NonlinearSystemBase::setInitialSolution(), and NonlinearSystemBase::setPredictor().
| 
 | protectedinherited | 
A prefix to use for all sections.
Definition at line 127 of file PerfGraphInterface.h.
Referenced by PerfGraphInterface::timedSectionName().
| 
 | protectedinherited | 
Definition at line 927 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addBoundaryCondition(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::setInitialSolution(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
Definition at line 1013 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::printAllVariableNorms().
| 
 | protectedinherited | 
A cache for storing gradients at dof locations.
We store it on the system because we create copies of variables on each thread and that would lead to increased data duplication when using threading-based parallelism.
Definition at line 1073 of file SystemBase.h.
Referenced by LinearSystem::computeGradients(), SystemBase::gradientContainer(), and SystemBase::initialSetup().
| 
 | protectedinherited | 
residual vector for non-time contributions
Definition at line 903 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeNodalBCs(), NonlinearSystemBase::computeResidualAndJacobianTags(), NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::computeResidualTags(), NonlinearSystemBase::getResidualNonTimeVector(), and NonlinearSystemBase::residualGhosted().
| 
 | protectedinherited | 
Tag for non-time contribution residual.
Definition at line 901 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::getResidualNonTimeVector(), NonlinearSystemBase::nonTimeVectorTag(), and NonlinearSystemBase::residualGhosted().
| 
 | protectedinherited | 
Used for the residual vector from PETSc.
Definition at line 906 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::NonlinearSystemBase(), and NonlinearSystemBase::residualVectorTag().
| 
 | protectedinherited | 
residual vector for time contributions
Definition at line 898 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeNodalBCs(), NonlinearSystemBase::getResidualTimeVector(), and NonlinearSystemBase::residualGhosted().
| 
 | protectedinherited | 
Tag for time contribution residual.
Definition at line 889 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::getResidualTimeVector(), NonlinearSystemBase::residualGhosted(), and NonlinearSystemBase::timeVectorTag().
| 
 | protectedinherited | 
The param that indicates the weighting of the residual vs the Jacobian in determining variable scaling parameters.
A value of 1 indicates pure residual-based scaling. A value of 0 indicates pure Jacobian-based scaling
Definition at line 1040 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::autoScalingParam(), and NonlinearSystemBase::computeScaling().
| 
 | protectedinherited | 
Copy of the residual vector, or nullptr if a copy is not needed.
Definition at line 881 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::preInit(), and NonlinearSystemBase::residualCopy().
| 
 | protectedinherited | 
ghosted form of the residual
Definition at line 878 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::computeResidualTags(), NonlinearSystemBase::constraintResiduals(), and NonlinearSystemBase::residualGhosted().
| 
 | protectedinherited | 
Definition at line 1034 of file SystemBase.h.
Referenced by SystemBase::restoreOldSolutions(), and SystemBase::saveOldSolutions().
| 
 | protectedinherited | 
Definition at line 1035 of file SystemBase.h.
Referenced by SystemBase::restoreOldSolutions(), and SystemBase::saveOldSolutions().
| 
 | protectedinherited | 
Definition at line 1030 of file SystemBase.h.
| 
 | protectedinherited | 
Definition at line 1031 of file SystemBase.h.
| 
 | protectedinherited | 
Definition at line 918 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addScalarKernel(), NonlinearSystemBase::checkKernelCoverage(), NonlinearSystemBase::computeResidualInternal(), NonlinearSystemBase::computeScalarKernelsJacobians(), NonlinearSystemBase::customSetup(), NonlinearSystemBase::getScalarKernelWarehouse(), NonlinearSystemBase::initialSetup(), NonlinearSystemBase::jacobianSetup(), NonlinearSystemBase::residualSetup(), NonlinearSystemBase::timestepSetup(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
A container of variable groupings that can be used in scaling calculations.
This can be useful for simulations in which vector-like variables are split into invidual scalar-field components like for solid/fluid mechanics
Definition at line 1045 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::scalingGroupVariables(), and NonlinearSystemBase::setupScalingData().
| 
 | protectedinherited | 
A diagonal matrix used for computing scaling.
Definition at line 1057 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeScaling(), NonlinearSystem::computeScalingJacobian(), computeScalingJacobian(), and NonlinearSystemBase::initialSetup().
| 
 | protectedinherited | 
Serialized version of the solution vector, or nullptr if a serialized solution is not needed.
Definition at line 1068 of file SystemBase.h.
Referenced by AuxiliarySystem::compute(), SolverSystem::preInit(), SystemBase::serializedSolution(), SolverSystem::serializeSolution(), AuxiliarySystem::serializeSolution(), and SolverSystem::setSolution().
| 
 | protectedinherited | 
Boolean to see if solution is invalid.
Definition at line 113 of file SolverSystem.h.
| 
 | protectedinherited | 
Whether or not the solution states have been initialized.
Definition at line 1061 of file SystemBase.h.
Referenced by SystemBase::initSolutionState(), and SystemBase::solutionStatesInitialized().
| 
 | protected | 
Definition at line 196 of file NonlinearEigenSystem.h.
Referenced by NonlinearEigenSystem().
| 
 | protectedinherited | 
Decomposition splits.
Definition at line 958 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::addSplit(), NonlinearSystemBase::getSplit(), NonlinearSystemBase::getSplits(), and NonlinearSystemBase::updateActive().
| 
 | protectedinherited | 
The subproblem for whom this class holds variable data, etc; this can either be the governing finite element/volume problem or a subjugate displaced problem.
Definition at line 983 of file SystemBase.h.
Referenced by SystemBase::activateAllMatrixTags(), SystemBase::addMatrix(), SystemBase::addScalingVector(), SystemBase::addVariable(), SystemBase::associateMatrixToTag(), SystemBase::associateVectorToTag(), SystemBase::augmentSendList(), SystemBase::closeTaggedVector(), SystemBase::computingScalingJacobian(), SystemBase::deactivateAllMatrixTags(), SystemBase::disassociateDefaultMatrixTags(), SystemBase::disassociateDefaultVectorTags(), SystemBase::disassociateMatrixFromTag(), SystemBase::disassociateVectorFromTag(), SystemBase::getMatrix(), NonlinearSystemBase::getResidualNonTimeVector(), NonlinearSystemBase::getResidualTimeVector(), SystemBase::getVector(), SystemBase::matrixTagActive(), SystemBase::needSolutionState(), SystemBase::prepare(), SystemBase::prepareFace(), SystemBase::reinitElem(), SystemBase::removeMatrix(), SystemBase::removeVector(), NonlinearSystemBase::residualGhosted(), SolverSystem::setSolution(), SystemBase::setVariableGlobalDoFs(), SystemBase::subproblem(), SystemBase::zeroTaggedVector(), and SystemBase::zeroVariables().
| 
 | inherited | 
Definition at line 747 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::NonlinearSystemBase(), NonlinearSystemBase::preInit(), NonlinearSystemBase::setInitialSolution(), NonlinearSystemBase::setupDampers(), and NonlinearSystemBase::system().
| 
 | protectedinherited | 
Tagged matrices (pointer)
Definition at line 1023 of file SystemBase.h.
Referenced by SystemBase::associateMatrixToTag(), SystemBase::disassociateMatrixFromTag(), SystemBase::getMatrix(), SystemBase::hasMatrix(), and SystemBase::removeMatrix().
| 
 | protectedinherited | 
Tagged vectors (pointer)
Definition at line 1021 of file SystemBase.h.
Referenced by SystemBase::associateVectorToTag(), SystemBase::disassociateVectorFromTag(), SystemBase::getVector(), SystemBase::hasVector(), and SystemBase::removeVector().
| 
 | protectedinherited | 
Time integrator.
Definition at line 1049 of file SystemBase.h.
Referenced by SystemBase::addTimeIntegrator(), SolverSystem::compute(), AuxiliarySystem::compute(), NonlinearSystemBase::computeResidualAndJacobianTags(), NonlinearSystemBase::computeResidualTags(), SystemBase::copyTimeIntegrators(), SystemBase::getTimeIntegrators(), NonlinearSystemBase::onTimestepBegin(), SystemBase::queryTimeIntegrator(), NonlinearSystem::solve(), and solve().
| 
 | protectedinherited | 
solution vector for u^dot
Definition at line 1006 of file SystemBase.h.
Referenced by SystemBase::addDotVectors(), NonlinearSystemBase::setSolutionUDot(), and SystemBase::solutionUDot().
| 
 | protectedinherited | 
old solution vector for u^dot
Definition at line 1011 of file SystemBase.h.
Referenced by SystemBase::addDotVectors(), NonlinearSystemBase::setSolutionUDotOld(), and SystemBase::solutionUDotOld().
| 
 | protectedinherited | 
solution vector for u^dotdot
Definition at line 1008 of file SystemBase.h.
Referenced by SystemBase::addDotVectors(), NonlinearSystemBase::setSolutionUDotDot(), and SystemBase::solutionUDotDot().
| 
 | protectedinherited | 
old solution vector for u^dotdot
Definition at line 1013 of file SystemBase.h.
Referenced by SystemBase::addDotVectors(), NonlinearSystemBase::setSolutionUDotDotOld(), and SystemBase::solutionUDotDotOld().
| 
 | protectedinherited | 
Whether or not to use a finite differenced preconditioner.
Definition at line 969 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::haveFiniteDifferencedPreconditioner(), NonlinearSystem::potentiallySetupFiniteDifferencing(), and NonlinearSystemBase::useFiniteDifferencedPreconditioner().
| 
 | protectedinherited | 
Whether to use the pre-SMO initial residual in the relative convergence check.
Definition at line 1011 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::setPreSMOResidual(), NonlinearSystemBase::shouldEvaluatePreSMOResidual(), and NonlinearSystemBase::usePreSMOResidual().
| 
 | protectedinherited | 
Container for the dof indices of a given variable.
Definition at line 1064 of file SystemBase.h.
Referenced by SystemBase::getVariableGlobalDoFs(), and SystemBase::setVariableGlobalDoFs().
| 
 | protectedinherited | 
default kind of variables in this system
Definition at line 1038 of file SystemBase.h.
Referenced by SystemBase::varKind().
| 
 | protectedinherited | 
Map of variables (variable id -> array of subdomains where it lives)
Definition at line 998 of file SystemBase.h.
Referenced by SystemBase::addVariable(), SystemBase::getSubdomainsForVar(), and SystemBase::getVariableBlocks().
| 
 | protectedinherited | 
Definition at line 1040 of file SystemBase.h.
Referenced by SystemBase::addVariableToCopy(), SystemBase::copyVars(), and SystemBase::hasVarCopy().
| 
 | protectedinherited | 
Container to hold flag if variable is to participate in autoscaling.
Definition at line 1048 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeScaling(), and NonlinearSystemBase::setupScalingData().
| 
 | protectedinherited | 
Variable warehouses (one for each thread)
Definition at line 996 of file SystemBase.h.
Referenced by NonlinearSystemBase::addBoundaryCondition(), NonlinearSystemBase::addInterfaceKernel(), AuxiliarySystem::addVariable(), SystemBase::addVariable(), SystemBase::applyScalingFactors(), NonlinearSystemBase::assembleScalingVector(), SystemBase::clearAllDofIndices(), AuxiliarySystem::compute(), SystemBase::customSetup(), SystemBase::getActualFieldVariable(), SystemBase::getFieldVariable(), SystemBase::getFVVariable(), AuxiliarySystem::getMinQuadratureOrder(), SystemBase::getMinQuadratureOrder(), SystemBase::getScalarVariable(), SystemBase::getScalarVariables(), SystemBase::getVariable(), SystemBase::getVariableNames(), SystemBase::getVariables(), LinearSystem::initialSetup(), SystemBase::initialSetup(), SystemBase::jacobianSetup(), SystemBase::nFieldVariables(), SystemBase::nFVVariables(), 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(), SystemBase::reinitScalars(), SystemBase::residualSetup(), SystemBase::setActiveScalarVariableCoupleableVectorTags(), SystemBase::setActiveVariableCoupleableVectorTags(), NonlinearSystemBase::setupScalingData(), SystemBase::sizeVariableMatrixData(), SystemBase::subdomainSetup(), and SystemBase::timestepSetup().
| 
 | protectedinherited | 
Definition at line 1003 of file SystemBase.h.
Referenced by SystemBase::addVariableToZeroOnJacobian(), and SystemBase::zeroVariablesForJacobian().
| 
 | protectedinherited | 
Definition at line 1002 of file SystemBase.h.
Referenced by SystemBase::addVariableToZeroOnResidual(), and SystemBase::zeroVariablesForResidual().
| 
 | protectedinherited | 
vectors that will be zeroed before a residual computation
Definition at line 991 of file NonlinearSystemBase.h.
Referenced by NonlinearSystemBase::computeResidualTags(), and NonlinearSystemBase::zeroVectorForResidual().
| 
 | protectedinherited | 
True if printing out additional information.
Definition at line 1058 of file SystemBase.h.
Referenced by SystemBase::applyScalingFactors(), and SystemBase::setVerboseFlag().
| 
 | protected | 
Definition at line 199 of file NonlinearEigenSystem.h.
Referenced by residualVectorAX().
| 
 | protected | 
Definition at line 200 of file NonlinearEigenSystem.h.
Referenced by residualVectorBX(), and RHS().
 1.8.14
 1.8.14