Base class for the 1-phase steady-state/transient interwrapper solver. More...
#include <InterWrapper1PhaseProblem.h>
Classes | |
struct | StructPetscMatVec |
Standard return structure for reusing in implicit/explicit formulations. More... | |
Public Types | |
enum | Direction { Direction::TO_EXTERNAL_APP, Direction::FROM_EXTERNAL_APP } |
enum | CoverageCheckMode { CoverageCheckMode::FALSE, CoverageCheckMode::TRUE, CoverageCheckMode::OFF, CoverageCheckMode::ON, CoverageCheckMode::SKIP_LIST, CoverageCheckMode::ONLY_LIST } |
typedef DataFileName | DataFileParameterType |
Public Member Functions | |
InterWrapper1PhaseProblem (const InputParameters ¶ms) | |
virtual | ~InterWrapper1PhaseProblem () |
virtual void | externalSolve () override |
virtual void | syncSolutions (Direction direction) override |
virtual bool | solverSystemConverged (const unsigned int) override |
virtual void | initialSetup () override |
virtual void | solve (unsigned int nl_sys_num=0) override final |
virtual void | addExternalVariables () |
virtual libMesh::EquationSystems & | es () override |
virtual MooseMesh & | mesh () override |
virtual const MooseMesh & | mesh () const override |
const MooseMesh & | mesh (bool use_displaced) const override |
void | setCoordSystem (const std::vector< SubdomainName > &blocks, const MultiMooseEnum &coord_sys) |
void | setAxisymmetricCoordAxis (const MooseEnum &rz_coord_axis) |
void | setCoupling (Moose::CouplingType type) |
Moose::CouplingType | coupling () const |
void | setCouplingMatrix (std::unique_ptr< libMesh::CouplingMatrix > cm, const unsigned int nl_sys_num) |
void | setCouplingMatrix (libMesh::CouplingMatrix *cm, const unsigned int nl_sys_num) |
const libMesh::CouplingMatrix * | couplingMatrix (const unsigned int nl_sys_num) const override |
void | setNonlocalCouplingMatrix () |
bool | areCoupled (const unsigned int ivar, const unsigned int jvar, const unsigned int nl_sys_num) const |
bool | hasUOAuxStateCheck () const |
bool | checkingUOAuxState () const |
void | trustUserCouplingMatrix () |
std::vector< std::pair< MooseVariableFEBase *, MooseVariableFEBase *> > & | couplingEntries (const THREAD_ID tid, const unsigned int nl_sys_num) |
std::vector< std::pair< MooseVariableFEBase *, MooseVariableFEBase *> > & | nonlocalCouplingEntries (const THREAD_ID tid, const unsigned int nl_sys_num) |
virtual bool | hasVariable (const std::string &var_name) const override |
bool | hasSolverVariable (const std::string &var_name) const |
virtual const MooseVariableFieldBase & | getVariable (const THREAD_ID tid, const std::string &var_name, Moose::VarKindType expected_var_type=Moose::VarKindType::VAR_ANY, Moose::VarFieldType expected_var_field_type=Moose::VarFieldType::VAR_FIELD_ANY) const override |
virtual const MooseVariableFieldBase & | getVariable (const THREAD_ID tid, const std::string &var_name, Moose::VarKindType expected_var_type=Moose::VarKindType::VAR_ANY, Moose::VarFieldType expected_var_field_type=Moose::VarFieldType::VAR_FIELD_ANY) const =0 |
virtual MooseVariableFieldBase & | getVariable (const THREAD_ID tid, const std::string &var_name, Moose::VarKindType expected_var_type=Moose::VarKindType::VAR_ANY, Moose::VarFieldType expected_var_field_type=Moose::VarFieldType::VAR_FIELD_ANY) |
virtual MooseVariableFieldBase & | getVariable (const THREAD_ID tid, const std::string &var_name, Moose::VarKindType expected_var_type=Moose::VarKindType::VAR_ANY, Moose::VarFieldType expected_var_field_type=Moose::VarFieldType::VAR_FIELD_ANY) |
MooseVariableFieldBase & | getActualFieldVariable (const THREAD_ID tid, const std::string &var_name) override |
virtual MooseVariable & | getStandardVariable (const THREAD_ID tid, const std::string &var_name) override |
virtual VectorMooseVariable & | getVectorVariable (const THREAD_ID tid, const std::string &var_name) override |
virtual ArrayMooseVariable & | getArrayVariable (const THREAD_ID tid, const std::string &var_name) override |
virtual bool | hasScalarVariable (const std::string &var_name) const override |
virtual MooseVariableScalar & | getScalarVariable (const THREAD_ID tid, const std::string &var_name) override |
virtual libMesh::System & | getSystem (const std::string &var_name) override |
virtual void | setActiveElementalMooseVariables (const std::set< MooseVariableFEBase * > &moose_vars, const THREAD_ID tid) override |
virtual void | clearActiveElementalMooseVariables (const THREAD_ID tid) override |
virtual void | clearActiveFEVariableCoupleableMatrixTags (const THREAD_ID tid) override |
virtual void | clearActiveFEVariableCoupleableVectorTags (const THREAD_ID tid) override |
virtual void | setActiveFEVariableCoupleableVectorTags (std::set< TagID > &vtags, const THREAD_ID tid) override |
virtual void | setActiveFEVariableCoupleableMatrixTags (std::set< TagID > &mtags, const THREAD_ID tid) override |
virtual void | clearActiveScalarVariableCoupleableMatrixTags (const THREAD_ID tid) override |
virtual void | clearActiveScalarVariableCoupleableVectorTags (const THREAD_ID tid) override |
virtual void | setActiveScalarVariableCoupleableVectorTags (std::set< TagID > &vtags, const THREAD_ID tid) override |
virtual void | setActiveScalarVariableCoupleableMatrixTags (std::set< TagID > &mtags, const THREAD_ID tid) override |
virtual void | createQRules (libMesh::QuadratureType type, libMesh::Order order, libMesh::Order volume_order=libMesh::INVALID_ORDER, libMesh::Order face_order=libMesh::INVALID_ORDER, SubdomainID block=Moose::ANY_BLOCK_ID, bool allow_negative_qweights=true) |
void | bumpVolumeQRuleOrder (libMesh::Order order, SubdomainID block) |
void | bumpAllQRuleOrder (libMesh::Order order, SubdomainID block) |
unsigned int | getMaxQps () const |
libMesh::Order | getMaxScalarOrder () const |
void | checkNonlocalCoupling () |
void | checkUserObjectJacobianRequirement (THREAD_ID tid) |
void | setVariableAllDoFMap (const std::vector< const MooseVariableFEBase * > &moose_vars) |
const std::vector< const MooseVariableFEBase *> & | getUserObjectJacobianVariables (const THREAD_ID tid) const |
virtual Assembly & | assembly (const THREAD_ID tid, const unsigned int sys_num) override |
virtual const Assembly & | assembly (const THREAD_ID tid, const unsigned int sys_num) const override |
virtual std::vector< VariableName > | getVariableNames () |
void | checkDuplicatePostprocessorVariableNames () |
void | timestepSetup () override |
void | customSetup (const ExecFlagType &exec_type) override |
void | residualSetup () override |
void | jacobianSetup () override |
virtual void | prepare (const Elem *elem, const THREAD_ID tid) override |
virtual void | prepare (const Elem *elem, unsigned int ivar, unsigned int jvar, const std::vector< dof_id_type > &dof_indices, const THREAD_ID tid) override |
virtual void | prepareFace (const Elem *elem, const THREAD_ID tid) override |
virtual void | setCurrentSubdomainID (const Elem *elem, const THREAD_ID tid) override |
virtual void | setNeighborSubdomainID (const Elem *elem, unsigned int side, const THREAD_ID tid) override |
virtual void | setNeighborSubdomainID (const Elem *elem, const THREAD_ID tid) |
virtual void | prepareAssembly (const THREAD_ID tid) override |
virtual void | addGhostedElem (dof_id_type elem_id) override |
virtual void | addGhostedBoundary (BoundaryID boundary_id) override |
virtual void | ghostGhostedBoundaries () override |
virtual void | sizeZeroes (unsigned int size, const THREAD_ID tid) |
virtual bool | reinitDirac (const Elem *elem, const THREAD_ID tid) override |
virtual void | reinitElem (const Elem *elem, const THREAD_ID tid) override |
virtual void | reinitElemPhys (const Elem *elem, const std::vector< Point > &phys_points_in_elem, const THREAD_ID tid) override |
void | reinitElemFace (const Elem *elem, unsigned int side, BoundaryID, const THREAD_ID tid) |
virtual void | reinitElemFace (const Elem *elem, unsigned int side, const THREAD_ID tid) override |
virtual void | reinitLowerDElem (const Elem *lower_d_elem, const THREAD_ID tid, const std::vector< Point > *const pts=nullptr, const std::vector< Real > *const weights=nullptr) override |
virtual void | reinitNode (const Node *node, const THREAD_ID tid) override |
virtual void | reinitNodeFace (const Node *node, BoundaryID bnd_id, const THREAD_ID tid) override |
virtual void | reinitNodes (const std::vector< dof_id_type > &nodes, const THREAD_ID tid) override |
virtual void | reinitNodesNeighbor (const std::vector< dof_id_type > &nodes, const THREAD_ID tid) override |
virtual void | reinitNeighbor (const Elem *elem, unsigned int side, const THREAD_ID tid) override |
virtual void | reinitNeighborPhys (const Elem *neighbor, unsigned int neighbor_side, const std::vector< Point > &physical_points, const THREAD_ID tid) override |
virtual void | reinitNeighborPhys (const Elem *neighbor, const std::vector< Point > &physical_points, const THREAD_ID tid) override |
virtual void | reinitElemNeighborAndLowerD (const Elem *elem, unsigned int side, const THREAD_ID tid) override |
virtual void | reinitScalars (const THREAD_ID tid, bool reinit_for_derivative_reordering=false) override |
virtual void | reinitOffDiagScalars (const THREAD_ID tid) override |
virtual void | getDiracElements (std::set< const Elem * > &elems) override |
virtual void | clearDiracInfo () override |
virtual void | subdomainSetup (SubdomainID subdomain, const THREAD_ID tid) |
virtual void | neighborSubdomainSetup (SubdomainID subdomain, const THREAD_ID tid) |
virtual void | newAssemblyArray (std::vector< std::shared_ptr< SolverSystem >> &solver_systems) |
virtual void | initNullSpaceVectors (const InputParameters ¶meters, std::vector< std::shared_ptr< NonlinearSystemBase >> &nl) |
virtual void | init () override |
virtual void | solveLinearSystem (const unsigned int linear_sys_num, const Moose::PetscSupport::PetscOptions *po=nullptr) |
virtual void | setException (const std::string &message) |
virtual bool | hasException () |
virtual void | checkExceptionAndStopSolve (bool print_message=true) |
virtual unsigned int | nNonlinearIterations (const unsigned int nl_sys_num) const override |
virtual unsigned int | nLinearIterations (const unsigned int nl_sys_num) const override |
virtual Real | finalNonlinearResidual (const unsigned int nl_sys_num) const override |
virtual bool | computingPreSMOResidual (const unsigned int nl_sys_num) const override |
virtual std::string | solverTypeString (unsigned int solver_sys_num=0) |
virtual bool | startedInitialSetup () |
virtual void | onTimestepBegin () override |
virtual void | onTimestepEnd () override |
virtual Real & | time () const |
virtual Real & | timeOld () const |
virtual int & | timeStep () const |
virtual Real & | dt () const |
virtual Real & | dtOld () const |
Real | getTimeFromStateArg (const Moose::StateArg &state) const |
virtual void | transient (bool trans) |
virtual bool | isTransient () const override |
virtual void | addTimeIntegrator (const std::string &type, const std::string &name, InputParameters ¶meters) |
virtual void | addPredictor (const std::string &type, const std::string &name, InputParameters ¶meters) |
virtual void | copySolutionsBackwards () |
virtual void | advanceState () |
virtual void | restoreSolutions () |
virtual void | saveOldSolutions () |
virtual void | restoreOldSolutions () |
void | needSolutionState (unsigned int oldest_needed, Moose::SolutionIterationType iteration_type) |
virtual void | outputStep (ExecFlagType type) |
virtual void | postExecute () |
void | forceOutput () |
virtual void | initPetscOutputAndSomeSolverSettings () |
Moose::PetscSupport::PetscOptions & | getPetscOptions () |
void | logAdd (const std::string &system, const std::string &name, const std::string &type, const InputParameters ¶ms) const |
virtual void | addFunction (const std::string &type, const std::string &name, InputParameters ¶meters) |
virtual bool | hasFunction (const std::string &name, const THREAD_ID tid=0) |
virtual Function & | getFunction (const std::string &name, const THREAD_ID tid=0) |
virtual void | addMeshDivision (const std::string &type, const std::string &name, InputParameters ¶ms) |
MeshDivision & | getMeshDivision (const std::string &name, const THREAD_ID tid=0) const |
virtual void | addConvergence (const std::string &type, const std::string &name, InputParameters ¶meters) |
virtual Convergence & | getConvergence (const std::string &name, const THREAD_ID tid=0) const |
virtual const std::vector< std::shared_ptr< Convergence > > & | getConvergenceObjects (const THREAD_ID tid=0) const |
virtual bool | hasConvergence (const std::string &name, const THREAD_ID tid=0) const |
bool | needToAddDefaultNonlinearConvergence () const |
bool | needToAddDefaultMultiAppFixedPointConvergence () const |
void | setNeedToAddDefaultNonlinearConvergence () |
void | setNeedToAddDefaultMultiAppFixedPointConvergence () |
bool | hasSetMultiAppFixedPointConvergenceName () const |
virtual void | addDefaultNonlinearConvergence (const InputParameters ¶ms) |
virtual bool | onlyAllowDefaultNonlinearConvergence () const |
void | addDefaultMultiAppFixedPointConvergence (const InputParameters ¶ms) |
virtual void | addLineSearch (const InputParameters &) |
virtual void | lineSearch () |
LineSearch * | getLineSearch () override |
virtual void | addDistribution (const std::string &type, const std::string &name, InputParameters ¶meters) |
virtual Distribution & | getDistribution (const std::string &name) |
virtual void | addSampler (const std::string &type, const std::string &name, InputParameters ¶meters) |
virtual Sampler & | getSampler (const std::string &name, const THREAD_ID tid=0) |
NonlinearSystemBase & | getNonlinearSystemBase (const unsigned int sys_num) |
const NonlinearSystemBase & | getNonlinearSystemBase (const unsigned int sys_num) const |
void | setCurrentNonlinearSystem (const unsigned int nl_sys_num) |
NonlinearSystemBase & | currentNonlinearSystem () |
const NonlinearSystemBase & | currentNonlinearSystem () const |
virtual const SystemBase & | systemBaseNonlinear (const unsigned int sys_num) const override |
virtual SystemBase & | systemBaseNonlinear (const unsigned int sys_num) override |
virtual const SystemBase & | systemBaseSolver (const unsigned int sys_num) const override |
virtual SystemBase & | systemBaseSolver (const unsigned int sys_num) override |
virtual const SystemBase & | systemBaseAuxiliary () const override |
virtual SystemBase & | systemBaseAuxiliary () override |
virtual NonlinearSystem & | getNonlinearSystem (const unsigned int sys_num) |
virtual const SystemBase & | getSystemBase (const unsigned int sys_num) const |
virtual SystemBase & | getSystemBase (const unsigned int sys_num) |
LinearSystem & | getLinearSystem (unsigned int sys_num) |
const LinearSystem & | getLinearSystem (unsigned int sys_num) const |
SolverSystem & | getSolverSystem (unsigned int sys_num) |
const SolverSystem & | getSolverSystem (unsigned int sys_num) const |
void | setCurrentLinearSystem (unsigned int sys_num) |
LinearSystem & | currentLinearSystem () |
const LinearSystem & | currentLinearSystem () const |
virtual const SystemBase & | systemBaseLinear (unsigned int sys_num) const override |
virtual SystemBase & | systemBaseLinear (unsigned int sys_num) override |
virtual void | addVariable (const std::string &var_type, const std::string &var_name, InputParameters ¶ms) |
virtual void | addKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addHDGKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addNodalKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addScalarKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addBoundaryCondition (const std::string &bc_name, const std::string &name, InputParameters ¶meters) |
virtual void | addConstraint (const std::string &c_name, const std::string &name, InputParameters ¶meters) |
virtual void | setInputParametersFEProblem (InputParameters ¶meters) |
virtual void | addAuxVariable (const std::string &var_type, const std::string &var_name, InputParameters ¶ms) |
virtual void | addAuxVariable (const std::string &var_name, const libMesh::FEType &type, const std::set< SubdomainID > *const active_subdomains=NULL) |
virtual void | addAuxArrayVariable (const std::string &var_name, const libMesh::FEType &type, unsigned int components, const std::set< SubdomainID > *const active_subdomains=NULL) |
virtual void | addAuxScalarVariable (const std::string &var_name, libMesh::Order order, Real scale_factor=1., const std::set< SubdomainID > *const active_subdomains=NULL) |
virtual void | addAuxKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addAuxScalarKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
AuxiliarySystem & | getAuxiliarySystem () |
virtual void | addDiracKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addDGKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addFVKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addLinearFVKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addFVBC (const std::string &fv_bc_name, const std::string &name, InputParameters ¶meters) |
virtual void | addLinearFVBC (const std::string &fv_bc_name, const std::string &name, InputParameters ¶meters) |
virtual void | addFVInterfaceKernel (const std::string &fv_ik_name, const std::string &name, InputParameters ¶meters) |
virtual void | addInterfaceKernel (const std::string &kernel_name, const std::string &name, InputParameters ¶meters) |
virtual void | addInitialCondition (const std::string &ic_name, const std::string &name, InputParameters ¶meters) |
virtual void | addFVInitialCondition (const std::string &ic_name, const std::string &name, InputParameters ¶meters) |
void | projectSolution () |
unsigned short | getCurrentICState () |
void | projectInitialConditionOnCustomRange (libMesh::ConstElemRange &elem_range, ConstBndNodeRange &bnd_node_range) |
virtual void | addMaterial (const std::string &material_name, const std::string &name, InputParameters ¶meters) |
virtual void | addMaterialHelper (std::vector< MaterialWarehouse * > warehouse, const std::string &material_name, const std::string &name, InputParameters ¶meters) |
virtual void | addInterfaceMaterial (const std::string &material_name, const std::string &name, InputParameters ¶meters) |
virtual void | addFunctorMaterial (const std::string &functor_material_name, const std::string &name, InputParameters ¶meters) |
void | prepareMaterials (const std::unordered_set< unsigned int > &consumer_needed_mat_props, const SubdomainID blk_id, const THREAD_ID tid) |
void | reinitMaterials (SubdomainID blk_id, const THREAD_ID tid, bool swap_stateful=true) |
void | reinitMaterialsFace (SubdomainID blk_id, const THREAD_ID tid, bool swap_stateful=true, const std::deque< MaterialBase * > *reinit_mats=nullptr) |
void | reinitMaterialsNeighbor (SubdomainID blk_id, const THREAD_ID tid, bool swap_stateful=true, const std::deque< MaterialBase * > *reinit_mats=nullptr) |
void | reinitMaterialsBoundary (BoundaryID boundary_id, const THREAD_ID tid, bool swap_stateful=true, const std::deque< MaterialBase * > *reinit_mats=nullptr) |
void | reinitMaterialsInterface (BoundaryID boundary_id, const THREAD_ID tid, bool swap_stateful=true) |
virtual void | swapBackMaterials (const THREAD_ID tid) |
virtual void | swapBackMaterialsFace (const THREAD_ID tid) |
virtual void | swapBackMaterialsNeighbor (const THREAD_ID tid) |
void | setActiveMaterialProperties (const std::unordered_set< unsigned int > &mat_prop_ids, const THREAD_ID tid) |
bool | hasActiveMaterialProperties (const THREAD_ID tid) const |
void | clearActiveMaterialProperties (const THREAD_ID tid) |
std::vector< std::shared_ptr< T > > | addObject (const std::string &type, const std::string &name, InputParameters ¶meters, const bool threaded=true, const std::string &var_param_name="variable") |
virtual void | addPostprocessor (const std::string &pp_name, const std::string &name, InputParameters ¶meters) |
virtual void | addVectorPostprocessor (const std::string &pp_name, const std::string &name, InputParameters ¶meters) |
virtual void | addReporter (const std::string &type, const std::string &name, InputParameters ¶meters) |
const ReporterData & | getReporterData () const |
ReporterData & | getReporterData (ReporterData::WriteKey) |
virtual std::vector< std::shared_ptr< UserObject > > | addUserObject (const std::string &user_object_name, const std::string &name, InputParameters ¶meters) |
const ExecuteMooseObjectWarehouse< UserObject > & | getUserObjects () const |
T & | getUserObject (const std::string &name, unsigned int tid=0) const |
const UserObject & | getUserObjectBase (const std::string &name, const THREAD_ID tid=0) const |
const Positions & | getPositionsObject (const std::string &name) const |
bool | hasUserObject (const std::string &name) const |
bool | hasPostprocessorValueByName (const PostprocessorName &name) const |
const PostprocessorValue & | getPostprocessorValueByName (const PostprocessorName &name, std::size_t t_index=0) const |
void | setPostprocessorValueByName (const PostprocessorName &name, const PostprocessorValue &value, std::size_t t_index=0) |
bool | hasPostprocessor (const std::string &name) const |
const VectorPostprocessorValue & | getVectorPostprocessorValueByName (const std::string &object_name, const std::string &vector_name, std::size_t t_index=0) const |
void | setVectorPostprocessorValueByName (const std::string &object_name, const std::string &vector_name, const VectorPostprocessorValue &value, std::size_t t_index=0) |
const VectorPostprocessor & | getVectorPostprocessorObjectByName (const std::string &object_name, const THREAD_ID tid=0) const |
virtual void | addDamper (const std::string &damper_name, const std::string &name, InputParameters ¶meters) |
void | setupDampers () |
bool | hasDampers () |
virtual void | addIndicator (const std::string &indicator_name, const std::string &name, InputParameters ¶meters) |
virtual void | addMarker (const std::string &marker_name, const std::string &name, InputParameters ¶meters) |
virtual void | addMultiApp (const std::string &multi_app_name, const std::string &name, InputParameters ¶meters) |
std::shared_ptr< MultiApp > | getMultiApp (const std::string &multi_app_name) const |
std::vector< std::shared_ptr< Transfer > > | getTransfers (ExecFlagType type, Transfer::DIRECTION direction) const |
std::vector< std::shared_ptr< Transfer > > | getTransfers (Transfer::DIRECTION direction) const |
const ExecuteMooseObjectWarehouse< Transfer > & | getMultiAppTransferWarehouse (Transfer::DIRECTION direction) const |
void | execMultiAppTransfers (ExecFlagType type, Transfer::DIRECTION direction) |
bool | execMultiApps (ExecFlagType type, bool auto_advance=true) |
void | finalizeMultiApps () |
void | incrementMultiAppTStep (ExecFlagType type) |
void | advanceMultiApps (ExecFlagType type) |
void | finishMultiAppStep (ExecFlagType type, bool recurse_through_multiapp_levels=false) |
void | backupMultiApps (ExecFlagType type) |
void | restoreMultiApps (ExecFlagType type, bool force=false) |
Real | computeMultiAppsDT (ExecFlagType type) |
virtual void | addTransfer (const std::string &transfer_name, const std::string &name, InputParameters ¶meters) |
void | execTransfers (ExecFlagType type) |
Real | computeResidualL2Norm (NonlinearSystemBase &sys) |
Real | computeResidualL2Norm (LinearSystem &sys) |
virtual Real | computeResidualL2Norm () |
virtual void | computeResidualSys (libMesh::NonlinearImplicitSystem &sys, const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual) |
void | computeResidual (libMesh::NonlinearImplicitSystem &sys, const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual) |
virtual void | computeResidual (const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual, const unsigned int nl_sys_num) |
void | computeResidualAndJacobian (const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual, libMesh::SparseMatrix< libMesh::Number > &jacobian) |
virtual void | computeResidualTag (const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual, TagID tag) |
virtual void | computeResidualType (const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual, TagID tag) |
virtual void | computeResidualInternal (const NumericVector< libMesh::Number > &soln, NumericVector< libMesh::Number > &residual, const std::set< TagID > &tags) |
virtual void | computeResidualTags (const std::set< TagID > &tags) |
virtual void | computeJacobianSys (libMesh::NonlinearImplicitSystem &sys, const NumericVector< libMesh::Number > &soln, libMesh::SparseMatrix< libMesh::Number > &jacobian) |
virtual void | computeJacobian (const NumericVector< libMesh::Number > &soln, libMesh::SparseMatrix< libMesh::Number > &jacobian, const unsigned int nl_sys_num) |
virtual void | computeJacobianTag (const NumericVector< libMesh::Number > &soln, libMesh::SparseMatrix< libMesh::Number > &jacobian, TagID tag) |
virtual void | computeJacobianInternal (const NumericVector< libMesh::Number > &soln, libMesh::SparseMatrix< libMesh::Number > &jacobian, const std::set< TagID > &tags) |
virtual void | computeJacobianTags (const std::set< TagID > &tags) |
virtual void | computeJacobianBlocks (std::vector< JacobianBlock * > &blocks, const unsigned int nl_sys_num) |
virtual void | computeJacobianBlock (libMesh::SparseMatrix< libMesh::Number > &jacobian, libMesh::System &precond_system, unsigned int ivar, unsigned int jvar) |
virtual void | computeLinearSystemSys (libMesh::LinearImplicitSystem &sys, libMesh::SparseMatrix< libMesh::Number > &system_matrix, NumericVector< libMesh::Number > &rhs, const bool compute_gradients=true) |
void | computeLinearSystemTags (const NumericVector< libMesh::Number > &soln, const std::set< TagID > &vector_tags, const std::set< TagID > &matrix_tags, const bool compute_gradients=true) |
virtual Real | computeDamping (const NumericVector< libMesh::Number > &soln, const NumericVector< libMesh::Number > &update) |
virtual bool | shouldUpdateSolution () |
virtual bool | updateSolution (NumericVector< libMesh::Number > &vec_solution, NumericVector< libMesh::Number > &ghosted_solution) |
virtual void | predictorCleanup (NumericVector< libMesh::Number > &ghosted_solution) |
virtual void | computeBounds (libMesh::NonlinearImplicitSystem &sys, NumericVector< libMesh::Number > &lower, NumericVector< libMesh::Number > &upper) |
virtual void | computeNearNullSpace (libMesh::NonlinearImplicitSystem &sys, std::vector< NumericVector< libMesh::Number > * > &sp) |
virtual void | computeNullSpace (libMesh::NonlinearImplicitSystem &sys, std::vector< NumericVector< libMesh::Number > * > &sp) |
virtual void | computeTransposeNullSpace (libMesh::NonlinearImplicitSystem &sys, std::vector< NumericVector< libMesh::Number > * > &sp) |
virtual void | computePostCheck (libMesh::NonlinearImplicitSystem &sys, const NumericVector< libMesh::Number > &old_soln, NumericVector< libMesh::Number > &search_direction, NumericVector< libMesh::Number > &new_soln, bool &changed_search_direction, bool &changed_new_soln) |
virtual void | computeIndicatorsAndMarkers () |
virtual void | computeIndicators () |
virtual void | computeMarkers () |
virtual void | addResidual (const THREAD_ID tid) override |
virtual void | addResidualNeighbor (const THREAD_ID tid) override |
virtual void | addResidualLower (const THREAD_ID tid) override |
virtual void | addResidualScalar (const THREAD_ID tid=0) |
virtual void | cacheResidual (const THREAD_ID tid) override |
virtual void | cacheResidualNeighbor (const THREAD_ID tid) override |
virtual void | addCachedResidual (const THREAD_ID tid) override |
virtual void | addCachedResidualDirectly (NumericVector< libMesh::Number > &residual, const THREAD_ID tid) |
virtual void | setResidual (NumericVector< libMesh::Number > &residual, const THREAD_ID tid) override |
virtual void | setResidual (libMesh::NumericVector< libMesh::Number > &residual, const THREAD_ID tid)=0 |
virtual void | setResidualNeighbor (NumericVector< libMesh::Number > &residual, const THREAD_ID tid) override |
virtual void | setResidualNeighbor (libMesh::NumericVector< libMesh::Number > &residual, const THREAD_ID tid)=0 |
virtual void | addJacobian (const THREAD_ID tid) override |
virtual void | addJacobianNeighbor (const THREAD_ID tid) override |
virtual void | addJacobianNeighbor (libMesh::SparseMatrix< libMesh::Number > &jacobian, unsigned int ivar, unsigned int jvar, const DofMap &dof_map, std::vector< dof_id_type > &dof_indices, std::vector< dof_id_type > &neighbor_dof_indices, const std::set< TagID > &tags, const THREAD_ID tid) override |
virtual void | addJacobianNeighbor (libMesh::SparseMatrix< libMesh::Number > &jacobian, unsigned int ivar, unsigned int jvar, const libMesh::DofMap &dof_map, std::vector< dof_id_type > &dof_indices, std::vector< dof_id_type > &neighbor_dof_indices, const std::set< TagID > &tags, const THREAD_ID tid)=0 |
virtual void | addJacobianNeighborLowerD (const THREAD_ID tid) override |
virtual void | addJacobianLowerD (const THREAD_ID tid) override |
virtual void | addJacobianBlockTags (libMesh::SparseMatrix< libMesh::Number > &jacobian, unsigned int ivar, unsigned int jvar, const DofMap &dof_map, std::vector< dof_id_type > &dof_indices, const std::set< TagID > &tags, const THREAD_ID tid) |
virtual void | addJacobianScalar (const THREAD_ID tid=0) |
virtual void | addJacobianOffDiagScalar (unsigned int ivar, const THREAD_ID tid=0) |
virtual void | cacheJacobian (const THREAD_ID tid) override |
virtual void | cacheJacobianNeighbor (const THREAD_ID tid) override |
virtual void | addCachedJacobian (const THREAD_ID tid) override |
virtual void | prepareShapes (unsigned int var, const THREAD_ID tid) override |
virtual void | prepareFaceShapes (unsigned int var, const THREAD_ID tid) override |
virtual void | prepareNeighborShapes (unsigned int var, const THREAD_ID tid) override |
virtual void | addDisplacedProblem (std::shared_ptr< DisplacedProblem > displaced_problem) |
virtual std::shared_ptr< const DisplacedProblem > | getDisplacedProblem () const |
virtual std::shared_ptr< DisplacedProblem > | getDisplacedProblem () |
virtual void | updateGeomSearch (GeometricSearchData::GeometricSearchType type=GeometricSearchData::ALL) override |
virtual void | updateMortarMesh () |
void | createMortarInterface (const std::pair< BoundaryID, BoundaryID > &primary_secondary_boundary_pair, const std::pair< SubdomainID, SubdomainID > &primary_secondary_subdomain_pair, bool on_displaced, bool periodic, const bool debug, const bool correct_edge_dropping, const Real minimum_projection_angle) |
const std::unordered_map< std::pair< BoundaryID, BoundaryID >, AutomaticMortarGeneration > & | getMortarInterfaces (bool on_displaced) const |
virtual void | possiblyRebuildGeomSearchPatches () |
virtual GeometricSearchData & | geomSearchData () override |
void | setRestartFile (const std::string &file_name) |
const MaterialPropertyRegistry & | getMaterialPropertyRegistry () const |
const InitialConditionWarehouse & | getInitialConditionWarehouse () const |
const FVInitialConditionWarehouse & | getFVInitialConditionWarehouse () const |
SolverParams & | solverParams (unsigned int solver_sys_num=0) |
const SolverParams & | solverParams (unsigned int solver_sys_num=0) const |
Adaptivity & | adaptivity () |
virtual void | initialAdaptMesh () |
virtual bool | adaptMesh () |
unsigned int | getNumCyclesCompleted () |
bool | hasInitialAdaptivity () const |
bool | hasInitialAdaptivity () const |
void | initXFEM (std::shared_ptr< XFEMInterface > xfem) |
std::shared_ptr< XFEMInterface > | getXFEM () |
bool | haveXFEM () |
virtual bool | updateMeshXFEM () |
virtual void | meshChanged (bool intermediate_change, bool contract_mesh, bool clean_refinement_flags) |
void | notifyWhenMeshChanges (MeshChangedInterface *mci) |
void | notifyWhenMeshDisplaces (MeshDisplacedInterface *mdi) |
void | initElementStatefulProps (const libMesh::ConstElemRange &elem_range, const bool threaded) |
virtual void | checkProblemIntegrity () |
void | registerRandomInterface (RandomInterface &random_interface, const std::string &name) |
void | setConstJacobian (bool state) |
void | setKernelCoverageCheck (CoverageCheckMode mode) |
void | setKernelCoverageCheck (bool flag) |
void | setKernelCoverageCheck (CoverageCheckMode mode) |
void | setMaterialCoverageCheck (CoverageCheckMode mode) |
void | setMaterialCoverageCheck (bool flag) |
void | setMaterialCoverageCheck (CoverageCheckMode mode) |
void | setParallelBarrierMessaging (bool flag) |
void | setVerboseProblem (bool verbose) |
bool | verboseMultiApps () const |
void | parentOutputPositionChanged () |
unsigned int | subspaceDim (const std::string &prefix) const |
const MaterialWarehouse & | getMaterialWarehouse () const |
const MaterialWarehouse & | getRegularMaterialsWarehouse () const |
const MaterialWarehouse & | getDiscreteMaterialWarehouse () const |
const MaterialWarehouse & | getInterfaceMaterialsWarehouse () const |
std::shared_ptr< MaterialBase > | getMaterial (std::string name, Moose::MaterialDataType type, const THREAD_ID tid=0, bool no_warn=false) |
MaterialData & | getMaterialData (Moose::MaterialDataType type, const THREAD_ID tid=0) const |
bool | restoreOriginalNonzeroPattern () const |
bool | errorOnJacobianNonzeroReallocation () const |
void | setErrorOnJacobianNonzeroReallocation (bool state) |
bool | preserveMatrixSparsityPattern () const |
void | setPreserveMatrixSparsityPattern (bool preserve) |
bool | ignoreZerosInJacobian () const |
void | setIgnoreZerosInJacobian (bool state) |
bool | acceptInvalidSolution () const |
bool | allowInvalidSolution () const |
bool | showInvalidSolutionConsole () const |
bool | immediatelyPrintInvalidSolution () const |
bool | hasTimeIntegrator () const |
virtual void | execute (const ExecFlagType &exec_type) |
virtual void | executeAllObjects (const ExecFlagType &exec_type) |
virtual Executor & | getExecutor (const std::string &name) |
virtual void | computeUserObjects (const ExecFlagType &type, const Moose::AuxGroup &group) |
virtual void | computeUserObjectByName (const ExecFlagType &type, const Moose::AuxGroup &group, const std::string &name) |
void | needsPreviousNewtonIteration (bool state) |
bool | needsPreviousNewtonIteration () const |
ExecuteMooseObjectWarehouse< Control > & | getControlWarehouse () |
void | executeControls (const ExecFlagType &exec_type) |
void | executeSamplers (const ExecFlagType &exec_type) |
virtual void | updateActiveObjects () |
void | reportMooseObjectDependency (MooseObject *a, MooseObject *b) |
ExecuteMooseObjectWarehouse< MultiApp > & | getMultiAppWarehouse () |
bool | hasJacobian () const |
bool | constJacobian () const |
void | addOutput (const std::string &, const std::string &, InputParameters &) |
TheWarehouse & | theWarehouse () const |
void | setSNESMFReuseBase (bool reuse, bool set_by_user) |
bool | useSNESMFReuseBase () |
void | skipExceptionCheck (bool skip_exception_check) |
bool | isSNESMFReuseBaseSetbyUser () |
bool & | petscOptionsInserted () |
PetscOptions & | petscOptionsDatabase () |
virtual void | setUDotRequested (const bool u_dot_requested) |
virtual void | setUDotDotRequested (const bool u_dotdot_requested) |
virtual void | setUDotOldRequested (const bool u_dot_old_requested) |
virtual void | setUDotDotOldRequested (const bool u_dotdot_old_requested) |
virtual bool | uDotRequested () |
virtual bool | uDotDotRequested () |
virtual bool | uDotOldRequested () |
virtual bool | uDotDotOldRequested () |
void | haveADObjects (bool have_ad_objects) override |
virtual void | haveADObjects (bool have_ad_objects) |
bool | haveADObjects () const |
bool | haveADObjects () const |
bool | shouldSolve () const |
const MortarData & | mortarData () const |
MortarData & | mortarData () |
virtual bool | hasNeighborCoupling () const |
virtual bool | hasMortarCoupling () const |
void | computingNonlinearResid (bool computing_nonlinear_residual) final |
bool | computingNonlinearResid () const |
virtual void | computingNonlinearResid (const bool computing_nonlinear_residual) |
bool | computingNonlinearResid () const |
void | setCurrentlyComputingResidual (bool currently_computing_residual) final |
void | numGridSteps (unsigned int num_grid_steps) |
void | uniformRefine () |
void | automaticScaling (bool automatic_scaling) override |
virtual void | automaticScaling (bool automatic_scaling) |
bool | automaticScaling () const |
bool | automaticScaling () const |
virtual void | reinitElemFaceRef (const Elem *elem, unsigned int side, Real tolerance, const std::vector< Point > *const pts, const std::vector< Real > *const weights=nullptr, const THREAD_ID tid=0) override |
virtual void | reinitNeighborFaceRef (const Elem *neighbor_elem, unsigned int neighbor_side, Real tolerance, const std::vector< Point > *const pts, const std::vector< Real > *const weights=nullptr, const THREAD_ID tid=0) override |
bool | fvBCsIntegrityCheck () const |
void | fvBCsIntegrityCheck (bool fv_bcs_integrity_check) |
void | getFVMatsAndDependencies (SubdomainID block_id, std::vector< std::shared_ptr< MaterialBase >> &face_materials, std::vector< std::shared_ptr< MaterialBase >> &neighbor_materials, std::set< MooseVariableFieldBase * > &variables, const THREAD_ID tid) |
void | resizeMaterialData (Moose::MaterialDataType data_type, unsigned int nqp, const THREAD_ID tid) |
bool | haveDisplaced () const override final |
bool | hasLinearConvergenceObjects () const |
void | setNonlinearConvergenceNames (const std::vector< ConvergenceName > &convergence_names) |
void | setLinearConvergenceNames (const std::vector< ConvergenceName > &convergence_names) |
void | setMultiAppFixedPointConvergenceName (const ConvergenceName &convergence_name) |
const std::vector< ConvergenceName > & | getNonlinearConvergenceNames () const |
const std::vector< ConvergenceName > & | getLinearConvergenceNames () const |
const ConvergenceName & | getMultiAppFixedPointConvergenceName () const |
void | computingScalingJacobian (bool computing_scaling_jacobian) |
bool | computingScalingJacobian () const override final |
void | computingScalingResidual (bool computing_scaling_residual) |
bool | computingScalingResidual () const override final |
MooseAppCoordTransform & | coordTransform () |
virtual std::size_t | numNonlinearSystems () const override |
virtual std::size_t | numLinearSystems () const override |
virtual std::size_t | numSolverSystems () const override |
bool | isSolverSystemNonlinear (const unsigned int sys_num) |
virtual unsigned int | currentNlSysNum () const override |
virtual unsigned int | currentLinearSysNum () const override |
virtual unsigned int | nlSysNum (const NonlinearSystemName &nl_sys_name) const override |
unsigned int | linearSysNum (const LinearSystemName &linear_sys_name) const override |
unsigned int | solverSysNum (const SolverSystemName &solver_sys_name) const override |
unsigned int | systemNumForVariable (const VariableName &variable_name) const |
bool | getFailNextNonlinearConvergenceCheck () const |
bool | getFailNextSystemConvergenceCheck () const |
void | setFailNextNonlinearConvergenceCheck () |
void | setFailNextSystemConvergenceCheck () |
void | resetFailNextNonlinearConvergenceCheck () |
void | resetFailNextSystemConvergenceCheck () |
void | setExecutionPrinting (const ExecFlagEnum &print_exec) |
bool | shouldPrintExecution (const THREAD_ID tid) const |
void | reinitMortarUserObjects (BoundaryID primary_boundary_id, BoundaryID secondary_boundary_id, bool displaced) |
virtual const std::vector< VectorTag > & | currentResidualVectorTags () const override |
void | setCurrentResidualVectorTags (const std::set< TagID > &vector_tags) |
void | clearCurrentResidualVectorTags () |
void | clearCurrentJacobianMatrixTags () |
virtual void | needFV () override |
virtual bool | haveFV () const override |
virtual bool | hasNonlocalCoupling () const override |
bool | identifyVariableGroupsInNL () const |
virtual void | setCurrentLowerDElem (const Elem *const lower_d_elem, const THREAD_ID tid) override |
virtual void | setCurrentBoundaryID (BoundaryID bid, const THREAD_ID tid) override |
const std::vector< NonlinearSystemName > & | getNonlinearSystemNames () const |
const std::vector< LinearSystemName > & | getLinearSystemNames () const |
const std::vector< SolverSystemName > & | getSolverSystemNames () const |
virtual const libMesh::CouplingMatrix & | nonlocalCouplingMatrix (const unsigned i) const override |
virtual bool | checkNonlocalCouplingRequirement () const override |
virtual Moose::FEBackend | feBackend () const |
const bool & | currentlyComputingResidual () const |
const bool & | currentlyComputingResidual () const |
virtual bool | nlConverged (const unsigned int nl_sys_num) |
virtual bool | converged (const unsigned int sys_num) |
bool | defaultGhosting () |
virtual TagID | addVectorTag (const TagName &tag_name, const Moose::VectorTagType type=Moose::VECTOR_TAG_RESIDUAL) |
void | addNotZeroedVectorTag (const TagID tag) |
bool | vectorTagNotZeroed (const TagID tag) const |
virtual const VectorTag & | getVectorTag (const TagID tag_id) const |
std::vector< VectorTag > | getVectorTags (const std::set< TagID > &tag_ids) const |
virtual const std::vector< VectorTag > & | getVectorTags (const Moose::VectorTagType type=Moose::VECTOR_TAG_ANY) const |
virtual TagID | getVectorTagID (const TagName &tag_name) const |
virtual TagName | vectorTagName (const TagID tag) const |
virtual bool | vectorTagExists (const TagID tag_id) const |
virtual bool | vectorTagExists (const TagName &tag_name) const |
virtual unsigned int | numVectorTags (const Moose::VectorTagType type=Moose::VECTOR_TAG_ANY) const |
virtual Moose::VectorTagType | vectorTagType (const TagID tag_id) const |
virtual TagID | addMatrixTag (TagName tag_name) |
virtual TagID | getMatrixTagID (const TagName &tag_name) const |
virtual TagName | matrixTagName (TagID tag) |
virtual bool | matrixTagExists (const TagName &tag_name) const |
virtual bool | matrixTagExists (TagID tag_id) const |
virtual unsigned int | numMatrixTags () const |
virtual std::map< TagName, TagID > & | getMatrixTags () |
virtual bool | hasLinearVariable (const std::string &var_name) const |
virtual bool | hasAuxiliaryVariable (const std::string &var_name) const |
virtual const std::set< MooseVariableFieldBase *> & | getActiveElementalMooseVariables (const THREAD_ID tid) const |
virtual bool | hasActiveElementalMooseVariables (const THREAD_ID tid) const |
Moose::CoordinateSystemType | getCoordSystem (SubdomainID sid) const |
unsigned int | getAxisymmetricRadialCoord () const |
virtual DiracKernelInfo & | diracKernelInfo () |
void | reinitNeighborLowerDElem (const Elem *elem, const THREAD_ID tid=0) |
void | reinitMortarElem (const Elem *elem, const THREAD_ID tid=0) |
virtual void | storeSubdomainMatPropName (SubdomainID block_id, const std::string &name) |
virtual void | storeBoundaryMatPropName (BoundaryID boundary_id, const std::string &name) |
virtual void | storeSubdomainZeroMatProp (SubdomainID block_id, const MaterialPropertyName &name) |
virtual void | storeBoundaryZeroMatProp (BoundaryID boundary_id, const MaterialPropertyName &name) |
virtual void | storeSubdomainDelayedCheckMatProp (const std::string &requestor, SubdomainID block_id, const std::string &name) |
virtual void | storeBoundaryDelayedCheckMatProp (const std::string &requestor, BoundaryID boundary_id, const std::string &name) |
virtual void | checkBlockMatProps () |
virtual void | checkBoundaryMatProps () |
virtual void | markMatPropRequested (const std::string &) |
virtual bool | isMatPropRequested (const std::string &prop_name) const |
void | addConsumedPropertyName (const MooseObjectName &obj_name, const std::string &prop_name) |
const std::map< MooseObjectName, std::set< std::string > > & | getConsumedPropertyMap () const |
virtual std::set< SubdomainID > | getMaterialPropertyBlocks (const std::string &prop_name) |
virtual std::vector< SubdomainName > | getMaterialPropertyBlockNames (const std::string &prop_name) |
virtual bool | hasBlockMaterialProperty (SubdomainID block_id, const std::string &prop_name) |
virtual std::set< BoundaryID > | getMaterialPropertyBoundaryIDs (const std::string &prop_name) |
virtual std::vector< BoundaryName > | getMaterialPropertyBoundaryNames (const std::string &prop_name) |
virtual bool | hasBoundaryMaterialProperty (BoundaryID boundary_id, const std::string &prop_name) |
virtual std::set< dof_id_type > & | ghostedElems () |
const bool & | currentlyComputingJacobian () const |
void | setCurrentlyComputingJacobian (const bool currently_computing_jacobian) |
const bool & | currentlyComputingResidualAndJacobian () const |
void | setCurrentlyComputingResidualAndJacobian (bool currently_computing_residual_and_jacobian) |
virtual bool | safeAccessTaggedMatrices () const |
virtual bool | safeAccessTaggedVectors () const |
const std::set< TagID > & | getActiveScalarVariableCoupleableVectorTags (const THREAD_ID tid) const |
const std::set< TagID > & | getActiveScalarVariableCoupleableMatrixTags (const THREAD_ID tid) const |
const std::set< TagID > & | getActiveFEVariableCoupleableVectorTags (const THREAD_ID tid) const |
const std::set< TagID > & | getActiveFEVariableCoupleableMatrixTags (const THREAD_ID tid) const |
void | addAlgebraicGhostingFunctor (libMesh::GhostingFunctor &algebraic_gf, bool to_mesh=true) |
void | addCouplingGhostingFunctor (libMesh::GhostingFunctor &coupling_gf, bool to_mesh=true) |
void | removeAlgebraicGhostingFunctor (libMesh::GhostingFunctor &algebraic_gf) |
void | removeCouplingGhostingFunctor (libMesh::GhostingFunctor &coupling_gf) |
void | hasScalingVector (const unsigned int nl_sys_num) |
void | clearAllDofIndices () |
const Moose::Functor< T > & | getFunctor (const std::string &name, const THREAD_ID tid, const std::string &requestor_name, bool requestor_is_ad) |
bool | hasFunctor (const std::string &name, const THREAD_ID tid) const |
bool | hasFunctorWithType (const std::string &name, const THREAD_ID tid) const |
void | addFunctor (const std::string &name, const Moose::FunctorBase< T > &functor, const THREAD_ID tid) |
const Moose::FunctorBase< T > & | addPiecewiseByBlockLambdaFunctor (const std::string &name, PolymorphicLambda my_lammy, const std::set< ExecFlagType > &clearance_schedule, const MooseMesh &mesh, const std::set< SubdomainID > &block_ids, const THREAD_ID tid) |
void | setFunctorOutput (bool set_output) |
void | registerUnfilledFunctorRequest (T *functor_interface, const std::string &functor_name, const THREAD_ID tid) |
void | reinitFVFace (const THREAD_ID tid, const FaceInfo &fi) |
void | preparePRefinement () |
bool | doingPRefinement () const |
bool | havePRefinement () const |
MooseVariableFEBase & | getVariableHelper (const THREAD_ID tid, const std::string &var_name, Moose::VarKindType expected_var_type, Moose::VarFieldType expected_var_field_type, const std::vector< T > &systems, const SystemBase &aux) const |
void | _setCLIOption () |
virtual void | terminateSolve () |
virtual bool | isSolveTerminationRequested () const |
const ConsoleStream & | console () const |
virtual bool | enabled () const |
std::shared_ptr< MooseObject > | getSharedPtr () |
std::shared_ptr< const MooseObject > | getSharedPtr () const |
MooseApp & | getMooseApp () const |
const std::string & | type () const |
virtual const std::string & | name () const |
std::string | typeAndName () const |
std::string | errorPrefix (const std::string &error_type) const |
void | callMooseError (std::string msg, const bool with_prefix) const |
MooseObjectParameterName | uniqueParameterName (const std::string ¶meter_name) const |
const InputParameters & | parameters () const |
MooseObjectName | uniqueName () const |
const T & | getParam (const std::string &name) const |
std::vector< std::pair< T1, T2 > > | getParam (const std::string ¶m1, const std::string ¶m2) const |
const T * | queryParam (const std::string &name) const |
const T & | getRenamedParam (const std::string &old_name, const std::string &new_name) const |
T | getCheckedPointerParam (const std::string &name, const std::string &error_string="") const |
bool | isParamValid (const std::string &name) const |
bool | isParamSetByUser (const std::string &nm) const |
void | paramError (const std::string ¶m, Args... args) const |
void | paramWarning (const std::string ¶m, Args... args) const |
void | paramInfo (const std::string ¶m, Args... args) const |
void | connectControllableParams (const std::string ¶meter, const std::string &object_type, const std::string &object_name, const std::string &object_parameter) const |
void | mooseError (Args &&... args) const |
void | mooseErrorNonPrefixed (Args &&... args) const |
void | mooseDocumentedError (const std::string &repo_name, const unsigned int issue_num, Args &&... args) const |
void | mooseWarning (Args &&... args) const |
void | mooseWarningNonPrefixed (Args &&... args) const |
void | mooseDeprecated (Args &&... args) const |
void | mooseInfo (Args &&... args) const |
std::string | getDataFileName (const std::string ¶m) const |
std::string | getDataFileNameByName (const std::string &relative_path) const |
std::string | getDataFilePath (const std::string &relative_path) const |
PerfGraph & | perfGraph () |
const libMesh::ConstElemRange & | getEvaluableElementRange () |
const libMesh::ConstElemRange & | getEvaluableElementRange () |
const libMesh::ConstElemRange & | getNonlinearEvaluableElementRange () |
const libMesh::ConstElemRange & | getNonlinearEvaluableElementRange () |
const libMesh::ConstElemRange & | getCurrentAlgebraicElementRange () |
const libMesh::ConstElemRange & | getCurrentAlgebraicElementRange () |
const libMesh::ConstNodeRange & | getCurrentAlgebraicNodeRange () |
const libMesh::ConstNodeRange & | getCurrentAlgebraicNodeRange () |
const ConstBndNodeRange & | getCurrentAlgebraicBndNodeRange () |
const ConstBndNodeRange & | getCurrentAlgebraicBndNodeRange () |
void | setCurrentAlgebraicElementRange (libMesh::ConstElemRange *range) |
void | setCurrentAlgebraicElementRange (libMesh::ConstElemRange *range) |
void | setCurrentAlgebraicNodeRange (libMesh::ConstNodeRange *range) |
void | setCurrentAlgebraicNodeRange (libMesh::ConstNodeRange *range) |
void | setCurrentAlgebraicBndNodeRange (ConstBndNodeRange *range) |
void | setCurrentAlgebraicBndNodeRange (ConstBndNodeRange *range) |
void | allowOutput (bool state) |
void | allowOutput (bool state) |
void | allowOutput (bool state) |
void | allowOutput (bool state) |
bool | hasMultiApps () const |
bool | hasMultiApps (ExecFlagType type) const |
bool | hasMultiApps () const |
bool | hasMultiApps (ExecFlagType type) const |
bool | hasMultiApp (const std::string &name) const |
bool | hasMultiApp (const std::string &name) const |
const AutomaticMortarGeneration & | getMortarInterface (const std::pair< BoundaryID, BoundaryID > &primary_secondary_boundary_pair, const std::pair< SubdomainID, SubdomainID > &primary_secondary_subdomain_pair, bool on_displaced) const |
AutomaticMortarGeneration & | getMortarInterface (const std::pair< BoundaryID, BoundaryID > &primary_secondary_boundary_pair, const std::pair< SubdomainID, SubdomainID > &primary_secondary_subdomain_pair, bool on_displaced) |
const AutomaticMortarGeneration & | getMortarInterface (const std::pair< BoundaryID, BoundaryID > &primary_secondary_boundary_pair, const std::pair< SubdomainID, SubdomainID > &primary_secondary_subdomain_pair, bool on_displaced) const |
AutomaticMortarGeneration & | getMortarInterface (const std::pair< BoundaryID, BoundaryID > &primary_secondary_boundary_pair, const std::pair< SubdomainID, SubdomainID > &primary_secondary_subdomain_pair, bool on_displaced) |
const MaterialPropertyStorage & | getMaterialPropertyStorage () |
const MaterialPropertyStorage & | getMaterialPropertyStorage () |
const MaterialPropertyStorage & | getBndMaterialPropertyStorage () |
const MaterialPropertyStorage & | getBndMaterialPropertyStorage () |
const MaterialPropertyStorage & | getNeighborMaterialPropertyStorage () |
const MaterialPropertyStorage & | getNeighborMaterialPropertyStorage () |
const MooseObjectWarehouse< Indicator > & | getIndicatorWarehouse () |
const MooseObjectWarehouse< Indicator > & | getIndicatorWarehouse () |
const MooseObjectWarehouse< InternalSideIndicatorBase > & | getInternalSideIndicatorWarehouse () |
const MooseObjectWarehouse< InternalSideIndicatorBase > & | getInternalSideIndicatorWarehouse () |
const MooseObjectWarehouse< Marker > & | getMarkerWarehouse () |
const MooseObjectWarehouse< Marker > & | getMarkerWarehouse () |
bool | needBoundaryMaterialOnSide (BoundaryID bnd_id, const THREAD_ID tid) |
bool | needBoundaryMaterialOnSide (BoundaryID bnd_id, const THREAD_ID tid) |
bool | needInterfaceMaterialOnSide (BoundaryID bnd_id, const THREAD_ID tid) |
bool | needInterfaceMaterialOnSide (BoundaryID bnd_id, const THREAD_ID tid) |
bool | needSubdomainMaterialOnSide (SubdomainID subdomain_id, const THREAD_ID tid) |
bool | needSubdomainMaterialOnSide (SubdomainID subdomain_id, const THREAD_ID tid) |
const ExecFlagType & | getCurrentExecuteOnFlag () const |
const ExecFlagType & | getCurrentExecuteOnFlag () const |
void | setCurrentExecuteOnFlag (const ExecFlagType &) |
void | setCurrentExecuteOnFlag (const ExecFlagType &) |
const Parallel::Communicator & | comm () const |
processor_id_type | n_processors () const |
processor_id_type | processor_id () const |
Static Public Member Functions | |
static InputParameters | validParams () |
static void | selectVectorTagsFromSystem (const SystemBase &system, const std::vector< VectorTag > &input_vector_tags, std::set< TagID > &selected_tags) |
static void | selectMatrixTagsFromSystem (const SystemBase &system, const std::map< TagName, TagID > &input_matrix_tags, std::set< TagID > &selected_tags) |
static void | objectSetupHelper (const std::vector< T * > &objects, const ExecFlagType &exec_flag) |
static void | objectSetupHelper (const std::vector< T * > &objects, const ExecFlagType &exec_flag) |
static void | objectExecuteHelper (const std::vector< T * > &objects) |
static void | objectExecuteHelper (const std::vector< T * > &objects) |
Public Attributes | |
std::map< std::string, std::vector< dof_id_type > > | _var_dof_map |
const ConsoleStream | _console |
std::vector< Real > | _real_zero |
std::vector< VariableValue > | _scalar_zero |
std::vector< VariableValue > | _zero |
std::vector< VariablePhiValue > | _phi_zero |
std::vector< MooseArray< ADReal > > | _ad_zero |
std::vector< VariableGradient > | _grad_zero |
std::vector< MooseArray< ADRealVectorValue > > | _ad_grad_zero |
std::vector< VariablePhiGradient > | _grad_phi_zero |
std::vector< VariableSecond > | _second_zero |
std::vector< MooseArray< ADRealTensorValue > > | _ad_second_zero |
std::vector< VariablePhiSecond > | _second_phi_zero |
std::vector< Point > | _point_zero |
std::vector< VectorVariableValue > | _vector_zero |
std::vector< VectorVariableCurl > | _vector_curl_zero |
Protected Member Functions | |
virtual Real | computeFrictionFactor (Real Re)=0 |
Returns friction factor. More... | |
virtual void | computeWijFromSolve (int iblock) |
Computes diversion crossflow per gap for block with index iblock Block is a partition of the whole domain. More... | |
virtual void | computeSumWij (int iblock) |
Computes net diversion crossflow per channel for block iblock. More... | |
virtual void | computeMdot (int iblock) |
Computes mass flow per channel for block iblock. More... | |
virtual void | computeWijPrime (int iblock) |
Computes turbulent crossflow per gap for block iblock. More... | |
virtual void | computeDP (int iblock) |
Computes Pressure Drop per channel for block iblock. More... | |
virtual void | computeP (int iblock) |
Computes Pressure per channel for block iblock. More... | |
virtual void | computeh (int iblock) |
Computes Enthalpy per channel for block iblock. More... | |
virtual void | computeT (int iblock) |
Computes Temperature per channel for block iblock. More... | |
virtual void | computeRho (int iblock) |
Computes Density per channel for block iblock. More... | |
virtual void | computeMu (int iblock) |
Computes Viscosity per channel for block iblock. More... | |
virtual void | computeWij (int iblock) |
Computes cross fluxes for block iblock. More... | |
virtual Real | computeAddedHeat (unsigned int i_ch, unsigned int iz) |
Computes added heat for channel i_ch and cell iz. More... | |
virtual libMesh::DenseVector< Real > | residualFunction (int iblock, libMesh::DenseVector< Real > solution) |
Computes Residual per gap for block iblock. More... | |
virtual PetscErrorCode | petscSnesSolver (int iblock, const libMesh::DenseVector< Real > &solution, libMesh::DenseVector< Real > &root) |
Computes solution of nonlinear equation using snes. More... | |
virtual PetscErrorCode | implicitPetscSolve (int iblock) |
Computes implicit solve using PetSc. More... | |
virtual void | initializeSolution () |
Function to initialize the solution fields. More... | |
virtual PetscScalar | computeInterpolationCoefficients (PetscScalar Peclet=0.0) |
Functions that computes the interpolation scheme given the Peclet number. More... | |
virtual PetscScalar | computeInterpolatedValue (PetscScalar topValue, PetscScalar botValue, PetscScalar Peclet=0.0) |
PetscErrorCode | cleanUp () |
virtual PetscErrorCode | createPetscVector (Vec &v, PetscInt n) |
Petsc Functions. More... | |
virtual PetscErrorCode | createPetscMatrix (Mat &M, PetscInt n, PetscInt m) |
template<class T > | |
PetscErrorCode | populateVectorFromDense (Vec &x, const T &solution, const unsigned int first_axial_level, const unsigned int last_axial_level, const unsigned int cross_dimension) |
template<class T > | |
PetscErrorCode | populateDenseFromVector (const Vec &x, T &solution, const unsigned int first_axial_level, const unsigned int last_axial_level, const unsigned int cross_dimension) |
template<class T > | |
PetscErrorCode | populateVectorFromHandle (Vec &x, const T &solution, const unsigned int first_axial_level, const unsigned int last_axial_level, const unsigned int cross_dimension) |
template<class T > | |
PetscErrorCode | populateSolutionChan (const Vec &x, T &solution, const unsigned int first_axial_level, const unsigned int last_axial_level, const unsigned int cross_dimension) |
template<class T > | |
PetscErrorCode | populateSolutionGap (const Vec &x, T &solution, const unsigned int first_axial_level, const unsigned int last_axial_level, const unsigned int cross_dimension) |
virtual void | meshChanged () |
MooseVariableFieldBase & | getVariableHelper (const THREAD_ID tid, const std::string &var_name, Moose::VarKindType expected_var_type, Moose::VarFieldType expected_var_field_type, const std::vector< T > &nls, const SystemBase &aux) const |
void | createTagVectors () |
void | createTagSolutions () |
virtual void | meshDisplaced () |
void | computeSystems (const ExecFlagType &type) |
bool | duplicateVariableCheck (const std::string &var_name, const libMesh::FEType &type, bool is_aux, const std::set< SubdomainID > *const active_subdomains) |
void | computeUserObjectsInternal (const ExecFlagType &type, const Moose::AuxGroup &group, TheWarehouse::Query &query) |
void | checkDisplacementOrders () |
void | checkUserObjects () |
void | checkDependMaterialsHelper (const std::map< SubdomainID, std::vector< std::shared_ptr< MaterialBase >>> &materials_map) |
void | checkCoordinateSystems () |
void | reinitBecauseOfGhostingOrNewGeomObjects (bool mortar_changed=false) |
void | addObjectParamsHelper (InputParameters ¶ms, const std::string &object_name, const std::string &var_param_name="variable") |
bool | verifyVectorTags () const |
void | markFamilyPRefinement (const InputParameters ¶ms) |
PerfID | registerTimedSection (const std::string §ion_name, const unsigned int level) const |
PerfID | registerTimedSection (const std::string §ion_name, const unsigned int level, const std::string &live_message, const bool print_dots=true) const |
std::string | timedSectionName (const std::string §ion_name) const |
T & | declareRestartableData (const std::string &data_name, Args &&... args) |
ManagedValue< T > | declareManagedRestartableDataWithContext (const std::string &data_name, void *context, Args &&... args) |
const T & | getRestartableData (const std::string &data_name) const |
T & | declareRestartableDataWithContext (const std::string &data_name, void *context, Args &&... args) |
T & | declareRecoverableData (const std::string &data_name, Args &&... args) |
T & | declareRestartableDataWithObjectName (const std::string &data_name, const std::string &object_name, Args &&... args) |
T & | declareRestartableDataWithObjectNameWithContext (const std::string &data_name, const std::string &object_name, void *context, Args &&... args) |
std::string | restartableName (const std::string &data_name) const |
Friends | |
PetscErrorCode | formFunctionIW (SNES snes, Vec x, Vec f, void *info) |
creates the residual function to be used in the PETCs snes context More... | |
Base class for the 1-phase steady-state/transient interwrapper solver.
Definition at line 28 of file InterWrapper1PhaseProblem.h.
InterWrapper1PhaseProblem::InterWrapper1PhaseProblem | ( | const InputParameters & | params | ) |
Definition at line 98 of file InterWrapper1PhaseProblem.C.
|
virtual |
Definition at line 245 of file InterWrapper1PhaseProblem.C.
|
protected |
Definition at line 253 of file InterWrapper1PhaseProblem.C.
Referenced by ~InterWrapper1PhaseProblem().
|
protectedvirtual |
Computes added heat for channel i_ch and cell iz.
Definition at line 1477 of file InterWrapper1PhaseProblem.C.
Referenced by computeh().
Computes Pressure Drop per channel for block iblock.
Time derivative term
Advective derivative term
Cross derivative term
Friction term
Gravity force
Assembling system
Reimplemented in TriInterWrapper1PhaseProblem.
Definition at line 793 of file InterWrapper1PhaseProblem.C.
Referenced by implicitPetscSolve(), and residualFunction().
Returns friction factor.
Implemented in TriInterWrapper1PhaseProblem, and QuadInterWrapper1PhaseProblem.
Referenced by computeDP().
Computes Enthalpy per channel for block iblock.
Time derivative term
Advective derivative term
Cross derivative term
Added heat enthalpy
Assembling system
Reimplemented in TriInterWrapper1PhaseProblem.
Definition at line 1502 of file InterWrapper1PhaseProblem.C.
Referenced by externalSolve(), and implicitPetscSolve().
|
protectedvirtual |
Definition at line 343 of file InterWrapper1PhaseProblem.C.
Referenced by computeDP(), computeh(), computeP(), and computeWij().
|
protectedvirtual |
Functions that computes the interpolation scheme given the Peclet number.
Definition at line 316 of file InterWrapper1PhaseProblem.C.
Referenced by computeDP(), computeh(), computeInterpolatedValue(), computeP(), and computeWij().
Computes mass flow per channel for block iblock.
Definition at line 566 of file InterWrapper1PhaseProblem.C.
Referenced by implicitPetscSolve(), and residualFunction().
Computes Viscosity per channel for block iblock.
Definition at line 1941 of file InterWrapper1PhaseProblem.C.
Referenced by externalSolve(), and TriInterWrapper1PhaseProblem::externalSolve().
Computes Pressure per channel for block iblock.
Definition at line 1243 of file InterWrapper1PhaseProblem.C.
Referenced by implicitPetscSolve(), and residualFunction().
Computes Density per channel for block iblock.
Definition at line 1916 of file InterWrapper1PhaseProblem.C.
Referenced by externalSolve(), and TriInterWrapper1PhaseProblem::externalSolve().
Computes net diversion crossflow per channel for block iblock.
Definition at line 501 of file InterWrapper1PhaseProblem.C.
Referenced by implicitPetscSolve(), and residualFunction().
Computes Temperature per channel for block iblock.
Definition at line 1900 of file InterWrapper1PhaseProblem.C.
Referenced by externalSolve(), and TriInterWrapper1PhaseProblem::externalSolve().
Computes cross fluxes for block iblock.
Assembling system
Definition at line 1966 of file InterWrapper1PhaseProblem.C.
Referenced by implicitPetscSolve(), and residualFunction().
Computes diversion crossflow per gap for block with index iblock Block is a partition of the whole domain.
Definition at line 468 of file InterWrapper1PhaseProblem.C.
Referenced by externalSolve(), and TriInterWrapper1PhaseProblem::externalSolve().
Computes turbulent crossflow per gap for block iblock.
Update turbulent crossflow
Definition at line 678 of file InterWrapper1PhaseProblem.C.
Referenced by externalSolve(), implicitPetscSolve(), and residualFunction().
|
protectedvirtual |
Definition at line 364 of file InterWrapper1PhaseProblem.C.
Referenced by InterWrapper1PhaseProblem().
|
protectedvirtual |
Petsc Functions.
Definition at line 352 of file InterWrapper1PhaseProblem.C.
Referenced by computeWij(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
overridevirtual |
Implements ExternalProblem.
Reimplemented in TriInterWrapper1PhaseProblem.
Definition at line 2927 of file InterWrapper1PhaseProblem.C.
|
protectedvirtual |
Computes implicit solve using PetSc.
Initializing flags
Assembling matrices
Setting up linear solver
Solving
Destroying solver elements
Recovering the solutions
Assigning the solutions to arrays
Populating Mass flow
Populating Pressure
Populating Crossflow
Populating Enthalpy
Populating sum_Wij
Destroying arrays
Definition at line 2393 of file InterWrapper1PhaseProblem.C.
Referenced by externalSolve().
|
protectedvirtual |
Function to initialize the solution fields.
Definition at line 2910 of file InterWrapper1PhaseProblem.C.
Referenced by externalSolve(), and TriInterWrapper1PhaseProblem::externalSolve().
|
overridevirtual |
Reimplemented from ExternalProblem.
Definition at line 226 of file InterWrapper1PhaseProblem.C.
|
protectedvirtual |
Computes solution of nonlinear equation using snes.
Definition at line 2337 of file InterWrapper1PhaseProblem.C.
Referenced by computeWijFromSolve().
|
protected |
Definition at line 294 of file InterWrapper1PhaseProblem.h.
Referenced by computeWijPrime(), and implicitPetscSolve().
|
protected |
Definition at line 423 of file InterWrapper1PhaseProblem.C.
|
protected |
Definition at line 447 of file InterWrapper1PhaseProblem.C.
|
protected |
Definition at line 376 of file InterWrapper1PhaseProblem.C.
Referenced by computeSumWij(), computeWij(), and implicitPetscSolve().
|
protected |
Definition at line 399 of file InterWrapper1PhaseProblem.C.
|
protectedvirtual |
Computes Residual per gap for block iblock.
Definition at line 2295 of file InterWrapper1PhaseProblem.C.
Referenced by formFunctionIW().
|
overridevirtual |
Reimplemented from ExternalProblem.
Definition at line 310 of file InterWrapper1PhaseProblem.C.
Implements ExternalProblem.
Definition at line 3082 of file InterWrapper1PhaseProblem.C.
|
static |
Definition at line 58 of file InterWrapper1PhaseProblem.C.
Referenced by QuadInterWrapper1PhaseProblem::validParams(), and TriInterWrapper1PhaseProblem::validParams().
|
friend |
creates the residual function to be used in the PETCs snes context
Definition at line 29 of file InterWrapper1PhaseProblem.C.
Referenced by petscSnesSolver().
|
protected |
Added resistances for monolithic convergence.
Definition at line 282 of file InterWrapper1PhaseProblem.h.
Referenced by implicitPetscSolve().
|
protected |
Definition at line 283 of file InterWrapper1PhaseProblem.h.
Referenced by implicitPetscSolve().
|
protected |
Axial momentum conservation - advective (Eulerian) derivative.
Definition at line 227 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeDP(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 228 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeDP(), and InterWrapper1PhaseProblem().
|
protected |
Axial momentum conservation - cross flux derivative.
Definition at line 230 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeDP(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 231 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeDP(), and InterWrapper1PhaseProblem().
|
protected |
Axial momentum conservation - friction force.
Definition at line 233 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeDP(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 234 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeDP(), and InterWrapper1PhaseProblem().
|
protected |
Axial momentum conservation - buoyancy force No implicit matrix.
Definition at line 237 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeDP(), and InterWrapper1PhaseProblem().
|
protected |
Axial momentum conservation - pressure force.
Definition at line 239 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeP(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 240 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeP(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Axial momentum system matrix.
Definition at line 242 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeDP(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 243 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeDP(), computeSumWij(), computeWijPrime(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Axial momentum conservation - time derivative.
Definition at line 224 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeDP(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 225 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeDP(), and InterWrapper1PhaseProblem().
|
protected |
Mass conservation - density time derivative No implicit matrix.
Axial momentum Axial momentum conservation - compute turbulent cross fluxes
Definition at line 221 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeWijPrime(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 222 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeWijPrime(), and InterWrapper1PhaseProblem().
|
protected |
The absolute convergence tolerance for the ksp linear solver.
Definition at line 139 of file InterWrapper1PhaseProblem.h.
Referenced by computeh(), computeMdot(), computeP(), implicitPetscSolve(), and petscSnesSolver().
|
protected |
Thermal diffusion coefficient used in turbulent crossflow.
Definition at line 127 of file InterWrapper1PhaseProblem.h.
Referenced by computeWijPrime().
|
protected |
Definition at line 106 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeDP(), computeDP(), TriInterWrapper1PhaseProblem::computeh(), computeh(), computeMdot(), computeMu(), computeP(), computeRho(), computeSumWij(), computeT(), computeWij(), computeWijFromSolve(), computeWijPrime(), externalSolve(), TriInterWrapper1PhaseProblem::externalSolve(), implicitPetscSolve(), InterWrapper1PhaseProblem(), petscSnesSolver(), and residualFunction().
|
protected |
Cross momentum conservation - advective (Eulerian) derivative.
Definition at line 250 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeWij(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 251 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeWij(), and InterWrapper1PhaseProblem().
|
protected |
Cross momentum conservation - friction force.
Definition at line 253 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeWij(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 254 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeWij(), and InterWrapper1PhaseProblem().
|
protected |
Cross momentum conservation - pressure force.
Definition at line 256 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeWij(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 257 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeWij(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Lateral momentum system matrix.
Definition at line 259 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeWij(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 260 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeWij(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Cross momentum Cross momentum conservation - time derivative.
Definition at line 247 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeWij(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 248 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeWij(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 261 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), and InterWrapper1PhaseProblem().
|
protected |
Flag that activates or deactivates the calculation of density.
Definition at line 113 of file InterWrapper1PhaseProblem.h.
Referenced by externalSolve(), and TriInterWrapper1PhaseProblem::externalSolve().
|
protected |
Flag that informs if we need to solve the Enthalpy/Temperature equations or not.
Definition at line 117 of file InterWrapper1PhaseProblem.h.
Referenced by externalSolve(), and TriInterWrapper1PhaseProblem::externalSolve().
|
protected |
Flag that activates or deactivates the calculation of viscosity.
Definition at line 115 of file InterWrapper1PhaseProblem.h.
Referenced by externalSolve(), and TriInterWrapper1PhaseProblem::externalSolve().
|
protected |
Variable that informs whether we exited external solve with a converged solution or not.
Definition at line 121 of file InterWrapper1PhaseProblem.h.
Referenced by externalSolve(), TriInterWrapper1PhaseProblem::externalSolve(), InterWrapper1PhaseProblem(), and solverSystemConverged().
|
protected |
Definition at line 286 of file InterWrapper1PhaseProblem.h.
Referenced by implicitPetscSolve().
|
protected |
Turbulent modeling parameter used in axial momentum equation.
Definition at line 129 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeDP(), and computeDP().
|
protected |
Definition at line 160 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeDP(), computeDP(), computeP(), and initialSetup().
|
protected |
Time step.
Definition at line 123 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeDP(), computeDP(), TriInterWrapper1PhaseProblem::computeh(), computeh(), computeMdot(), and computeWij().
|
protected |
The divergence tolerance for the ksp linear solver.
Definition at line 141 of file InterWrapper1PhaseProblem.h.
Referenced by computeh(), computeMdot(), computeP(), implicitPetscSolve(), and petscSnesSolver().
|
protected |
Solutions handles and link to TH tables properties.
Definition at line 156 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeh(), computeh(), computeMu(), computeRho(), computeT(), externalSolve(), TriInterWrapper1PhaseProblem::externalSolve(), and initialSetup().
|
protected |
Definition at line 100 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeDP(), and computeDP().
|
protected |
No implicit matrix.
Definition at line 279 of file InterWrapper1PhaseProblem.h.
|
protected |
Definition at line 161 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeh(), computeh(), computeT(), externalSolve(), TriInterWrapper1PhaseProblem::externalSolve(), implicitPetscSolve(), and initialSetup().
|
protected |
Enthalpy conservation - source and sink.
Definition at line 274 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeh(), and InterWrapper1PhaseProblem().
|
protected |
Enthalpy conservation - advective (Eulerian) derivative;.
Definition at line 268 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeh(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 269 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeh(), and InterWrapper1PhaseProblem().
|
protected |
Enthalpy conservation - cross flux derivative.
Definition at line 271 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeh(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 272 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeh(), and InterWrapper1PhaseProblem().
|
protected |
System matrices.
Definition at line 276 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeh(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 277 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeh(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Enthalpy Enthalpy conservation - time derivative.
Definition at line 265 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeh(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 266 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeh(), and InterWrapper1PhaseProblem().
|
protected |
Flag to define the usage of a implicit or explicit solution.
Definition at line 147 of file InterWrapper1PhaseProblem.h.
Referenced by computeDP(), computeh(), computeMdot(), computeP(), computeSumWij(), computeWij(), computeWijPrime(), and InterWrapper1PhaseProblem().
|
protected |
The interpolation method used in constructing the systems.
Definition at line 145 of file InterWrapper1PhaseProblem.h.
Referenced by computeInterpolationCoefficients().
|
protected |
Definition at line 101 of file InterWrapper1PhaseProblem.h.
Referenced by computeWij().
|
protected |
Definition at line 284 of file InterWrapper1PhaseProblem.h.
Referenced by implicitPetscSolve().
|
protected |
Definition at line 285 of file InterWrapper1PhaseProblem.h.
Referenced by implicitPetscSolve().
|
protected |
The maximum number of iterations to use for the ksp linear solver.
Definition at line 143 of file InterWrapper1PhaseProblem.h.
Referenced by computeh(), computeMdot(), computeP(), implicitPetscSolve(), and petscSnesSolver().
|
protected |
Mass conservation - axial convection.
Definition at line 214 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeMdot(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 215 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeMdot(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Mass conservation Mass conservation - sum of cross fluxes.
Definition at line 209 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeSumWij(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 157 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeDP(), computeDP(), computeMdot(), computeWij(), computeWijPrime(), implicitPetscSolve(), initializeSolution(), and initialSetup().
|
protected |
Thermal monolithic bool.
Definition at line 153 of file InterWrapper1PhaseProblem.h.
Referenced by externalSolve(), and implicitPetscSolve().
|
protected |
Definition at line 165 of file InterWrapper1PhaseProblem.h.
Referenced by computeMu(), and initialSetup().
|
protected |
Definition at line 104 of file InterWrapper1PhaseProblem.h.
Referenced by externalSolve().
|
protected |
number of axial blocks
Definition at line 95 of file InterWrapper1PhaseProblem.h.
Referenced by externalSolve(), TriInterWrapper1PhaseProblem::externalSolve(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 102 of file InterWrapper1PhaseProblem.h.
Referenced by externalSolve(), TriInterWrapper1PhaseProblem::externalSolve(), initializeSolution(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 105 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeDP(), computeDP(), TriInterWrapper1PhaseProblem::computeh(), computeh(), computeMdot(), computeMu(), computeP(), computeRho(), computeSumWij(), computeT(), computeWij(), computeWijPrime(), externalSolve(), TriInterWrapper1PhaseProblem::externalSolve(), implicitPetscSolve(), initializeSolution(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 103 of file InterWrapper1PhaseProblem.h.
Referenced by computeSumWij(), computeWij(), computeWijFromSolve(), computeWijPrime(), implicitPetscSolve(), InterWrapper1PhaseProblem(), petscSnesSolver(), and residualFunction().
|
protected |
Definition at line 109 of file InterWrapper1PhaseProblem.h.
|
protected |
Outlet Pressure.
Definition at line 125 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeh(), computeh(), computeMu(), computeRho(), computeT(), externalSolve(), and TriInterWrapper1PhaseProblem::externalSolve().
|
protected |
Definition at line 159 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeh(), computeh(), computeMu(), computeP(), computeRho(), computeT(), computeWij(), externalSolve(), TriInterWrapper1PhaseProblem::externalSolve(), implicitPetscSolve(), and initialSetup().
|
protected |
Convergence tolerance for the pressure loop in external solve.
Definition at line 131 of file InterWrapper1PhaseProblem.h.
Referenced by externalSolve(), and TriInterWrapper1PhaseProblem::externalSolve().
|
protected |
Flag that informs if there is a pin mesh or not.
Definition at line 119 of file InterWrapper1PhaseProblem.h.
Referenced by computeAddedHeat(), externalSolve(), and initialSetup().
|
protected |
Definition at line 211 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeDP(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 212 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeWij(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 168 of file InterWrapper1PhaseProblem.h.
Referenced by computeAddedHeat(), TriInterWrapper1PhaseProblem::computeh(), and initialSetup().
|
protected |
Definition at line 164 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeDP(), computeDP(), TriInterWrapper1PhaseProblem::computeh(), computeh(), computeMdot(), computeRho(), and initialSetup().
|
protected |
The relative convergence tolerance, (relative decrease) for the ksp linear solver.
Definition at line 137 of file InterWrapper1PhaseProblem.h.
Referenced by computeh(), computeMdot(), computeP(), implicitPetscSolve(), and petscSnesSolver().
|
protected |
Definition at line 166 of file InterWrapper1PhaseProblem.h.
Referenced by computeDP(), and initialSetup().
|
protected |
Segregated solve.
Definition at line 151 of file InterWrapper1PhaseProblem.h.
Referenced by computeDP(), computeh(), computeMdot(), computeP(), computeSumWij(), computeWij(), and externalSolve().
|
protected |
Flag to define the usage of staggered or collocated pressure.
Definition at line 149 of file InterWrapper1PhaseProblem.h.
Referenced by computeP(), and computeWij().
|
protected |
Definition at line 93 of file InterWrapper1PhaseProblem.h.
Referenced by computeAddedHeat(), TriInterWrapper1PhaseProblem::computeDP(), computeDP(), TriInterWrapper1PhaseProblem::computeh(), computeh(), computeMdot(), computeMu(), computeP(), computeRho(), computeSumWij(), computeT(), computeWij(), computeWijPrime(), externalSolve(), TriInterWrapper1PhaseProblem::externalSolve(), implicitPetscSolve(), initializeSolution(), populateSolutionChan(), and populateVectorFromHandle().
|
protected |
Definition at line 158 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeDP(), computeDP(), computeMdot(), computeSumWij(), implicitPetscSolve(), and initialSetup().
|
protected |
Maximum iterations for the inner temperature loop.
Definition at line 135 of file InterWrapper1PhaseProblem.h.
Referenced by externalSolve(), and TriInterWrapper1PhaseProblem::externalSolve().
|
protected |
Definition at line 162 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeh(), computeh(), computeMu(), computeRho(), computeT(), externalSolve(), TriInterWrapper1PhaseProblem::externalSolve(), and initialSetup().
|
protected |
Convergence tolerance for the temperature loop in external solve.
Definition at line 133 of file InterWrapper1PhaseProblem.h.
Referenced by externalSolve(), and TriInterWrapper1PhaseProblem::externalSolve().
|
protected |
Definition at line 163 of file InterWrapper1PhaseProblem.h.
Referenced by externalSolve(), and initialSetup().
|
protected |
Flag that activates or deactivates the transient parts of the equations we solve by multiplication.
Definition at line 111 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeDP(), computeDP(), TriInterWrapper1PhaseProblem::computeh(), computeh(), computeMdot(), and computeWij().
|
protected |
Definition at line 167 of file InterWrapper1PhaseProblem.h.
Referenced by initialSetup().
|
protected |
Definition at line 96 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeDP(), computeDP(), TriInterWrapper1PhaseProblem::computeh(), computeh(), computeMdot(), computeSumWij(), computeWij(), computeWijFromSolve(), externalSolve(), TriInterWrapper1PhaseProblem::externalSolve(), implicitPetscSolve(), InterWrapper1PhaseProblem(), and residualFunction().
|
protected |
Definition at line 97 of file InterWrapper1PhaseProblem.h.
Referenced by computeWij(), externalSolve(), TriInterWrapper1PhaseProblem::externalSolve(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 99 of file InterWrapper1PhaseProblem.h.
Referenced by computeWij(), InterWrapper1PhaseProblem(), and residualFunction().
|
protected |
Definition at line 210 of file InterWrapper1PhaseProblem.h.
Referenced by cleanUp(), computeSumWij(), computeWij(), computeWijPrime(), implicitPetscSolve(), and InterWrapper1PhaseProblem().
|
protected |
Definition at line 98 of file InterWrapper1PhaseProblem.h.
Referenced by TriInterWrapper1PhaseProblem::computeDP(), computeDP(), TriInterWrapper1PhaseProblem::computeh(), computeh(), computeWijPrime(), and InterWrapper1PhaseProblem().
|
protected |
axial location of nodes
Definition at line 108 of file InterWrapper1PhaseProblem.h.
Referenced by computeAddedHeat(), computeDP(), computeh(), computeMdot(), computeWij(), and computeWijPrime().