Quadrilateral subchannel solver. More...
#include <QuadSubChannel1PhaseProblem.h>
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 | |
QuadSubChannel1PhaseProblem (const InputParameters ¶ms) | |
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 |
virtual const PostprocessorValue & | getPostprocessorValueByName (const PostprocessorName &name) const |
void | setPostprocessorValueByName (const PostprocessorName &name, const PostprocessorValue &value, std::size_t t_index=0) |
bool | hasPostprocessor (const std::string &name) const |
bool | hasPostprocessor (const std::string ¶m_name, const unsigned int index=0) 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 |
bool | isDefaultPostprocessorValue (const std::string ¶m_name, const unsigned int index=0) const |
bool | hasPostprocessorByName (const PostprocessorName &name) const |
std::size_t | coupledPostprocessors (const std::string ¶m_name) const |
const PostprocessorName & | getPostprocessorName (const std::string ¶m_name, const unsigned int index=0) const |
const PostprocessorValue & | getPostprocessorValue (const std::string ¶m_name, const unsigned int index=0) const |
const PostprocessorValue & | getPostprocessorValue (const std::string ¶m_name, const unsigned int index=0) const |
const PostprocessorValue & | getPostprocessorValueOld (const std::string ¶m_name, const unsigned int index=0) const |
const PostprocessorValue & | getPostprocessorValueOld (const std::string ¶m_name, const unsigned int index=0) const |
const PostprocessorValue & | getPostprocessorValueOlder (const std::string ¶m_name, const unsigned int index=0) const |
const PostprocessorValue & | getPostprocessorValueOlder (const std::string ¶m_name, const unsigned int index=0) const |
const PostprocessorValue & | getPostprocessorValueOldByName (const PostprocessorName &name) const |
const PostprocessorValue & | getPostprocessorValueOldByName (const PostprocessorName &name) const |
const PostprocessorValue & | getPostprocessorValueOlderByName (const PostprocessorName &name) const |
const PostprocessorValue & | getPostprocessorValueOlderByName (const PostprocessorName &name) 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 void | initializeSolution () override |
Function to initialize the solution & geometry fields. More... | |
virtual Real | computeFrictionFactor (FrictionStruct friction_args) override |
Returns friction factor. More... | |
virtual Real | computeAddedHeatPin (unsigned int i_ch, unsigned int iz) override |
Computes added heat for channel i_ch and cell iz. More... | |
virtual Real | computeBeta (unsigned int i_gap, unsigned int iz) override |
Computes turbulent mixing coefficient. More... | |
virtual void | computeh (int iblock) override |
Computes Enthalpy per channel for block iblock. More... | |
void | computeWijFromSolve (int iblock) |
Computes diversion crossflow per gap for block iblock. More... | |
void | computeSumWij (int iblock) |
Computes net diversion crossflow per channel for block iblock. More... | |
void | computeMdot (int iblock) |
Computes mass flow per channel for block iblock. More... | |
void | computeWijPrime (int iblock) |
Computes turbulent crossflow per gap for block iblock. More... | |
void | computeDP (int iblock) |
Computes Pressure Drop per channel for block iblock. More... | |
void | computeP (int iblock) |
Computes Pressure per channel for block iblock. More... | |
void | computeT (int iblock) |
Computes Temperature per channel for block iblock. More... | |
void | computeRho (int iblock) |
Computes Density per channel for block iblock. More... | |
void | computeMu (int iblock) |
Computes Viscosity per channel for block iblock. More... | |
void | computeWijResidual (int iblock) |
Computes Residual Matrix based on the lateral momentum conservation equation for block iblock. More... | |
Real | computeAddedHeatDuct (unsigned int i_ch, unsigned int iz) |
Function that computes the heat flux added by the duct. More... | |
libMesh::DenseVector< Real > | residualFunction (int iblock, libMesh::DenseVector< Real > solution) |
Computes Residual Vector based on the lateral momentum conservation equation for block iblock & updates flow variables based on current crossflow solution. More... | |
PetscErrorCode | petscSnesSolver (int iblock, const libMesh::DenseVector< Real > &solution, libMesh::DenseVector< Real > &root) |
Computes solution of nonlinear equation using snes and provided a residual in a formFunction. More... | |
PetscErrorCode | implicitPetscSolve (int iblock) |
Computes implicit solve using PetSc. More... | |
PetscScalar | computeInterpolationCoefficients (PetscScalar Peclet=0.0) |
Functions that computes the interpolation scheme given the Peclet number. More... | |
PetscScalar | computeInterpolatedValue (PetscScalar topValue, PetscScalar botValue, PetscScalar Peclet=0.0) |
PetscErrorCode | cleanUp () |
PetscErrorCode | createPetscVector (Vec &v, PetscInt n) |
Petsc Functions. More... | |
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 |
virtual void | addPostprocessorDependencyHelper (const PostprocessorName &) const |
Quadrilateral subchannel solver.
Definition at line 18 of file QuadSubChannel1PhaseProblem.h.
QuadSubChannel1PhaseProblem::QuadSubChannel1PhaseProblem | ( | const InputParameters & | params | ) |
Definition at line 36 of file QuadSubChannel1PhaseProblem.C.
|
protectedinherited |
Definition at line 279 of file SubChannel1PhaseProblem.C.
Referenced by SubChannel1PhaseProblem::~SubChannel1PhaseProblem().
|
protectedinherited |
Function that computes the heat flux added by the duct.
Definition at line 1312 of file SubChannel1PhaseProblem.C.
Referenced by TriSubChannel1PhaseProblem::computeh().
|
overrideprotectedvirtual |
Computes added heat for channel i_ch and cell iz.
Implements SubChannel1PhaseProblem.
Definition at line 427 of file QuadSubChannel1PhaseProblem.C.
Referenced by computeh().
|
overrideprotectedvirtual |
Computes turbulent mixing coefficient.
Implements SubChannel1PhaseProblem.
Definition at line 360 of file QuadSubChannel1PhaseProblem.C.
Computes Pressure Drop per channel for block iblock.
Upwind local form loss
Upwind local form loss
Time derivative term
Advective derivative term
Cross derivative term
Friction term
Upwind local form loss
Gravity force
Assembling system
Definition at line 578 of file SubChannel1PhaseProblem.C.
Referenced by SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::residualFunction().
|
overrideprotectedvirtual |
Returns friction factor.
Pang, B. et al. KIT, 2013
Todreas-Kazimi NUCLEAR SYSTEMS, second edition, Volume 1, 2011
Implements SubChannel1PhaseProblem.
Definition at line 208 of file QuadSubChannel1PhaseProblem.C.
Computes Enthalpy per channel for block iblock.
Time derivative term
Advective derivative term
Cross derivative term
Added heat enthalpy
Assembling system
Implements SubChannel1PhaseProblem.
Definition at line 464 of file QuadSubChannel1PhaseProblem.C.
|
protectedinherited |
Definition at line 361 of file SubChannel1PhaseProblem.C.
Referenced by SubChannel1PhaseProblem::computeDP(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeP(), and SubChannel1PhaseProblem::computeWijResidual().
|
protectedinherited |
Functions that computes the interpolation scheme given the Peclet number.
Definition at line 341 of file SubChannel1PhaseProblem.C.
Referenced by SubChannel1PhaseProblem::computeDP(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeInterpolatedValue(), SubChannel1PhaseProblem::computeP(), and SubChannel1PhaseProblem::computeWijResidual().
Computes mass flow per channel for block iblock.
Definition at line 468 of file SubChannel1PhaseProblem.C.
Referenced by SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::residualFunction().
Computes Viscosity per channel for block iblock.
Definition at line 1378 of file SubChannel1PhaseProblem.C.
Referenced by SubChannel1PhaseProblem::externalSolve().
Computes Pressure per channel for block iblock.
Definition at line 1079 of file SubChannel1PhaseProblem.C.
Referenced by SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::residualFunction().
Computes Density per channel for block iblock.
Definition at line 1355 of file SubChannel1PhaseProblem.C.
Referenced by SubChannel1PhaseProblem::externalSolve().
Computes net diversion crossflow per channel for block iblock.
Definition at line 403 of file SubChannel1PhaseProblem.C.
Referenced by SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::residualFunction().
Computes Temperature per channel for block iblock.
Definition at line 1340 of file SubChannel1PhaseProblem.C.
Referenced by SubChannel1PhaseProblem::externalSolve().
Computes diversion crossflow per gap for block iblock.
Definition at line 370 of file SubChannel1PhaseProblem.C.
Referenced by SubChannel1PhaseProblem::externalSolve().
Computes turbulent crossflow per gap for block iblock.
Update turbulent crossflow
Definition at line 1719 of file SubChannel1PhaseProblem.C.
Referenced by SubChannel1PhaseProblem::externalSolve(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::residualFunction().
Computes Residual Matrix based on the lateral momentum conservation equation for block iblock.
Assembling system
Definition at line 1401 of file SubChannel1PhaseProblem.C.
Referenced by SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::residualFunction().
|
inlineprotectedinherited |
Definition at line 195 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::SubChannel1PhaseProblem(), and TriSubChannel1PhaseProblem::TriSubChannel1PhaseProblem().
|
inlineprotectedinherited |
Petsc Functions.
Definition at line 184 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeWijResidual(), SubChannel1PhaseProblem::implicitPetscSolve(), SubChannel1PhaseProblem::SubChannel1PhaseProblem(), and TriSubChannel1PhaseProblem::TriSubChannel1PhaseProblem().
|
overridevirtualinherited |
Assigning temperature to the fuel pins
Assigning temperatures to duct
Implements ExternalProblem.
Definition at line 2512 of file SubChannel1PhaseProblem.C.
|
protectedinherited |
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 1912 of file SubChannel1PhaseProblem.C.
Referenced by SubChannel1PhaseProblem::externalSolve().
|
overrideprotectedvirtual |
Function to initialize the solution & geometry fields.
update surface area, wetted perimeter based on: Dpin, displacement
Calculate subchannel area
Correct subchannel area and wetted perimeter in case of overlapping pins
Apply area reduction on subchannels affected by blockage
update map of gap between pins (gij) based on: Dpin, displacement
Implements SubChannel1PhaseProblem.
Definition at line 46 of file QuadSubChannel1PhaseProblem.C.
|
overridevirtualinherited |
Reimplemented from ExternalProblem.
Definition at line 241 of file SubChannel1PhaseProblem.C.
|
protectedinherited |
Computes solution of nonlinear equation using snes and provided a residual in a formFunction.
Definition at line 1857 of file SubChannel1PhaseProblem.C.
Referenced by SubChannel1PhaseProblem::computeWijFromSolve().
|
protectedinherited |
Definition at line 322 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeWijPrime(), and SubChannel1PhaseProblem::implicitPetscSolve().
|
protectedinherited |
Definition at line 396 of file SubChannel1PhaseProblem.h.
|
protectedinherited |
Definition at line 420 of file SubChannel1PhaseProblem.h.
|
protectedinherited |
Definition at line 373 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeSumWij(), and SubChannel1PhaseProblem::implicitPetscSolve().
|
protectedinherited |
Definition at line 347 of file SubChannel1PhaseProblem.h.
|
protectedinherited |
Computes Residual Vector based on the lateral momentum conservation equation for block iblock & updates flow variables based on current crossflow solution.
Definition at line 1815 of file SubChannel1PhaseProblem.C.
Referenced by formFunction().
|
overridevirtualinherited |
Reimplemented from ExternalProblem.
Definition at line 335 of file SubChannel1PhaseProblem.C.
Implements ExternalProblem.
Definition at line 2744 of file SubChannel1PhaseProblem.C.
|
static |
Definition at line 17 of file QuadSubChannel1PhaseProblem.C.
|
protectedinherited |
Added resistances for monolithic convergence.
Definition at line 310 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::implicitPetscSolve().
|
protectedinherited |
Definition at line 311 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::implicitPetscSolve().
|
protectedinherited |
Axial momentum conservation - advective (Eulerian) derivative.
Definition at line 258 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeDP(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 259 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeDP(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Axial momentum conservation - cross flux derivative.
Definition at line 261 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeDP(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 262 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeDP(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Axial momentum conservation - friction force.
Definition at line 264 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeDP(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 265 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeDP(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Axial momentum conservation - buoyancy force No implicit matrix.
Definition at line 268 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeDP(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Axial momentum conservation - pressure force.
Definition at line 270 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeP(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 271 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeP(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Axial momentum system matrix.
Definition at line 273 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeDP(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 274 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeDP(), SubChannel1PhaseProblem::computeSumWij(), SubChannel1PhaseProblem::computeWijPrime(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Axial momentum conservation - time derivative.
Definition at line 255 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeDP(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 256 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeDP(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Mass conservation - density time derivative No implicit matrix.
Axial momentum Axial momentum conservation - compute turbulent cross fluxes
Definition at line 252 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeWijPrime(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 253 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeWijPrime(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
The absolute convergence tolerance for the ksp linear solver.
Definition at line 144 of file SubChannel1PhaseProblem.h.
Referenced by computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::computeP(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::petscSnesSolver().
|
protected |
Thermal diffusion coefficient used in turbulent crossflow.
Definition at line 32 of file QuadSubChannel1PhaseProblem.h.
Referenced by computeBeta().
|
protectedinherited |
Definition at line 110 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeDP(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::computeMu(), SubChannel1PhaseProblem::computeP(), SubChannel1PhaseProblem::computeRho(), SubChannel1PhaseProblem::computeSumWij(), SubChannel1PhaseProblem::computeT(), SubChannel1PhaseProblem::computeWijFromSolve(), SubChannel1PhaseProblem::computeWijPrime(), SubChannel1PhaseProblem::computeWijResidual(), SubChannel1PhaseProblem::externalSolve(), SubChannel1PhaseProblem::implicitPetscSolve(), SubChannel1PhaseProblem::petscSnesSolver(), SubChannel1PhaseProblem::residualFunction(), SubChannel1PhaseProblem::SubChannel1PhaseProblem(), and TriSubChannel1PhaseProblem::TriSubChannel1PhaseProblem().
|
protectedinherited |
Cross momentum conservation - advective (Eulerian) derivative.
Definition at line 281 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeWijResidual(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 282 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeWijResidual(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Cross momentum conservation - friction force.
Definition at line 284 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeWijResidual(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 285 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeWijResidual(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Cross momentum conservation - pressure force.
Definition at line 287 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeWijResidual(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 288 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeWijResidual(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Lateral momentum system matrix.
Definition at line 290 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeWijResidual(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 291 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeWijResidual(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Cross momentum Cross momentum conservation - time derivative.
Definition at line 278 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeWijResidual(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 279 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeWijResidual(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Flag that activates or deactivates the calculation of density.
Definition at line 118 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::externalSolve().
|
protectedinherited |
Flag that informs if we need to solve the Enthalpy/Temperature equations or not.
Definition at line 122 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::externalSolve().
|
protectedinherited |
Flag that activates or deactivates the calculation of viscosity.
Definition at line 120 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::externalSolve().
|
protected |
Flag that activates the use of constant beta.
Definition at line 36 of file QuadSubChannel1PhaseProblem.h.
Referenced by computeBeta().
|
protectedinherited |
Variable that informs whether we exited external solve with a converged solution or not.
Definition at line 128 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::externalSolve(), SubChannel1PhaseProblem::solverSystemConverged(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 314 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::implicitPetscSolve().
|
protectedinherited |
Turbulent modeling parameter used in axial momentum equation.
Definition at line 134 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeDP().
|
protected |
Flag that activates one of the two friction models (default: f=a*Re^b, non-default: Todreas-Kazimi)
Definition at line 34 of file QuadSubChannel1PhaseProblem.h.
Referenced by computeFrictionFactor().
|
protectedinherited |
Flag that activates the effect of deformation (pin/duct) based on the auxvalues for displacement, Dpin.
Definition at line 162 of file SubChannel1PhaseProblem.h.
Referenced by initializeSolution(), and TriSubChannel1PhaseProblem::initializeSolution().
|
protectedinherited |
Definition at line 181 of file SubChannel1PhaseProblem.h.
Referenced by initializeSolution(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Definition at line 169 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeDP(), SubChannel1PhaseProblem::computeP(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Definition at line 173 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::externalSolve(), initializeSolution(), TriSubChannel1PhaseProblem::initializeSolution(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Time step.
Definition at line 130 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeDP(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::computeWijResidual(), and SubChannel1PhaseProblem::externalSolve().
|
protectedinherited |
The divergence tolerance for the ksp linear solver.
Definition at line 146 of file SubChannel1PhaseProblem.h.
Referenced by computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::computeP(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::petscSnesSolver().
|
protectedinherited |
Flag that informs if there is a pin mesh or not.
Definition at line 126 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeAddedHeatDuct(), SubChannel1PhaseProblem::externalSolve(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Solutions handles and link to TH tables properties.
Definition at line 165 of file SubChannel1PhaseProblem.h.
Referenced by computeBeta(), TriSubChannel1PhaseProblem::computeBeta(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMu(), SubChannel1PhaseProblem::computeRho(), SubChannel1PhaseProblem::computeT(), SubChannel1PhaseProblem::externalSolve(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Referenced by SubChannel1PhaseProblem::computeDP().
|
protectedinherited |
Definition at line 104 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeDP().
|
protectedinherited |
Definition at line 170 of file SubChannel1PhaseProblem.h.
Referenced by computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeT(), SubChannel1PhaseProblem::externalSolve(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Enthalpy conservation - source and sink.
Definition at line 304 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), computeh(), TriSubChannel1PhaseProblem::computeh(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Enthalpy conservation - advective (Eulerian) derivative;.
Definition at line 298 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), computeh(), TriSubChannel1PhaseProblem::computeh(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 299 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), computeh(), TriSubChannel1PhaseProblem::computeh(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Enthalpy conservation - cross flux derivative.
Definition at line 301 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), computeh(), TriSubChannel1PhaseProblem::computeh(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 302 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), computeh(), TriSubChannel1PhaseProblem::computeh(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
System matrices.
Definition at line 306 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 307 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Enthalpy Enthalpy conservation - time derivative.
Definition at line 295 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), computeh(), TriSubChannel1PhaseProblem::computeh(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 296 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), computeh(), TriSubChannel1PhaseProblem::computeh(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Flag to define the usage of a implicit or explicit solution.
Definition at line 152 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeDP(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::computeP(), SubChannel1PhaseProblem::computeSumWij(), SubChannel1PhaseProblem::computeWijPrime(), SubChannel1PhaseProblem::computeWijResidual(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
The interpolation method used in constructing the systems.
Definition at line 150 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeDP(), TriSubChannel1PhaseProblem::computeh(), and SubChannel1PhaseProblem::computeInterpolationCoefficients().
|
protectedinherited |
Definition at line 105 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeWijResidual().
|
protectedinherited |
Definition at line 312 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::implicitPetscSolve().
|
protectedinherited |
Definition at line 313 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::implicitPetscSolve().
|
protectedinherited |
The maximum number of iterations to use for the ksp linear solver.
Definition at line 148 of file SubChannel1PhaseProblem.h.
Referenced by computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::computeP(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::petscSnesSolver().
|
protectedinherited |
Mass conservation - axial convection.
Definition at line 245 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 246 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Matrices and vectors to be used in implicit assembly Mass conservation Mass conservation - sum of cross fluxes.
Definition at line 240 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeSumWij(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 166 of file SubChannel1PhaseProblem.h.
Referenced by computeBeta(), TriSubChannel1PhaseProblem::computeBeta(), SubChannel1PhaseProblem::computeDP(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::computeWijPrime(), SubChannel1PhaseProblem::computeWijResidual(), SubChannel1PhaseProblem::implicitPetscSolve(), initializeSolution(), TriSubChannel1PhaseProblem::initializeSolution(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Thermal monolithic bool.
Definition at line 158 of file SubChannel1PhaseProblem.h.
Referenced by computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::externalSolve(), and SubChannel1PhaseProblem::implicitPetscSolve().
|
protectedinherited |
Definition at line 175 of file SubChannel1PhaseProblem.h.
Referenced by computeBeta(), TriSubChannel1PhaseProblem::computeBeta(), SubChannel1PhaseProblem::computeMu(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
number of axial blocks
Definition at line 99 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::externalSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 106 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::externalSolve(), initializeSolution(), TriSubChannel1PhaseProblem::initializeSolution(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 109 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeDP(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::computeMu(), SubChannel1PhaseProblem::computeP(), SubChannel1PhaseProblem::computeRho(), SubChannel1PhaseProblem::computeSumWij(), SubChannel1PhaseProblem::computeT(), SubChannel1PhaseProblem::computeWijPrime(), SubChannel1PhaseProblem::computeWijResidual(), SubChannel1PhaseProblem::externalSolve(), SubChannel1PhaseProblem::implicitPetscSolve(), initializeSolution(), TriSubChannel1PhaseProblem::initializeSolution(), SubChannel1PhaseProblem::SubChannel1PhaseProblem(), and TriSubChannel1PhaseProblem::TriSubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 107 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeSumWij(), SubChannel1PhaseProblem::computeWijFromSolve(), SubChannel1PhaseProblem::computeWijPrime(), SubChannel1PhaseProblem::computeWijResidual(), SubChannel1PhaseProblem::implicitPetscSolve(), initializeSolution(), TriSubChannel1PhaseProblem::initializeSolution(), SubChannel1PhaseProblem::petscSnesSolver(), SubChannel1PhaseProblem::residualFunction(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 108 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::externalSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 114 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::externalSolve().
|
protectedinherited |
Definition at line 111 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeAddedHeatDuct(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Outlet Pressure.
Definition at line 132 of file SubChannel1PhaseProblem.h.
Referenced by computeBeta(), TriSubChannel1PhaseProblem::computeBeta(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMu(), SubChannel1PhaseProblem::computeRho(), SubChannel1PhaseProblem::computeT(), and SubChannel1PhaseProblem::externalSolve().
|
protectedinherited |
Definition at line 168 of file SubChannel1PhaseProblem.h.
Referenced by computeBeta(), TriSubChannel1PhaseProblem::computeBeta(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMu(), SubChannel1PhaseProblem::computeP(), SubChannel1PhaseProblem::computeRho(), SubChannel1PhaseProblem::computeT(), SubChannel1PhaseProblem::computeWijResidual(), SubChannel1PhaseProblem::externalSolve(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Convergence tolerance for the pressure loop in external solve.
Definition at line 136 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::externalSolve().
|
protectedinherited |
Flag that informs if there is a pin mesh or not.
Definition at line 124 of file SubChannel1PhaseProblem.h.
Referenced by computeAddedHeatPin(), TriSubChannel1PhaseProblem::computeAddedHeatPin(), SubChannel1PhaseProblem::externalSolve(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Definition at line 242 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeDP(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 243 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeWijResidual(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 179 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Definition at line 178 of file SubChannel1PhaseProblem.h.
Referenced by computeAddedHeatPin(), TriSubChannel1PhaseProblem::computeAddedHeatPin(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Definition at line 174 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeDP(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::computeRho(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
The relative convergence tolerance, (relative decrease) for the ksp linear solver.
Definition at line 142 of file SubChannel1PhaseProblem.h.
Referenced by computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::computeP(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::petscSnesSolver().
|
protectedinherited |
Definition at line 176 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeDP(), TriSubChannel1PhaseProblem::computeh(), initializeSolution(), TriSubChannel1PhaseProblem::initializeSolution(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Segregated solve.
Definition at line 156 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeDP(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::computeP(), SubChannel1PhaseProblem::computeSumWij(), SubChannel1PhaseProblem::computeWijResidual(), and SubChannel1PhaseProblem::externalSolve().
|
protectedinherited |
Flag to define the usage of staggered or collocated pressure.
Definition at line 154 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeP(), and SubChannel1PhaseProblem::computeWijResidual().
|
protected |
Definition at line 29 of file QuadSubChannel1PhaseProblem.h.
Referenced by computeAddedHeatPin(), computeBeta(), computeFrictionFactor(), computeh(), and initializeSolution().
|
protectedinherited |
Definition at line 167 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeDP(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::computeSumWij(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Maximum iterations for the inner temperature loop.
Definition at line 140 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::externalSolve().
|
protectedinherited |
Definition at line 171 of file SubChannel1PhaseProblem.h.
Referenced by computeBeta(), TriSubChannel1PhaseProblem::computeBeta(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMu(), SubChannel1PhaseProblem::computeRho(), SubChannel1PhaseProblem::computeT(), SubChannel1PhaseProblem::externalSolve(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Convergence tolerance for the temperature loop in external solve.
Definition at line 138 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::externalSolve().
|
protectedinherited |
Definition at line 180 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::externalSolve(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Definition at line 172 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::externalSolve(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Flag that activates or deactivates the transient parts of the equations we solve by multiplication.
Definition at line 116 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeDP(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::computeWijResidual(), and SubChannel1PhaseProblem::externalSolve().
|
protectedinherited |
Boolean to printout information related to subchannel solve.
Definition at line 160 of file SubChannel1PhaseProblem.h.
Referenced by computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeP(), SubChannel1PhaseProblem::externalSolve(), and SubChannel1PhaseProblem::implicitPetscSolve().
|
protectedinherited |
Definition at line 177 of file SubChannel1PhaseProblem.h.
Referenced by computeBeta(), TriSubChannel1PhaseProblem::computeBeta(), initializeSolution(), TriSubChannel1PhaseProblem::initializeSolution(), and SubChannel1PhaseProblem::initialSetup().
|
protectedinherited |
Definition at line 100 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeDP(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::computeSumWij(), SubChannel1PhaseProblem::computeWijFromSolve(), SubChannel1PhaseProblem::computeWijResidual(), SubChannel1PhaseProblem::externalSolve(), SubChannel1PhaseProblem::implicitPetscSolve(), SubChannel1PhaseProblem::residualFunction(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 101 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeWijResidual(), SubChannel1PhaseProblem::externalSolve(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 103 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeWijResidual(), SubChannel1PhaseProblem::residualFunction(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 241 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::cleanUp(), SubChannel1PhaseProblem::computeSumWij(), SubChannel1PhaseProblem::computeWijPrime(), SubChannel1PhaseProblem::computeWijResidual(), SubChannel1PhaseProblem::implicitPetscSolve(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
Definition at line 102 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeDP(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeWijPrime(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
protectedinherited |
axial location of nodes
Definition at line 113 of file SubChannel1PhaseProblem.h.
Referenced by SubChannel1PhaseProblem::computeAddedHeatDuct(), computeAddedHeatPin(), TriSubChannel1PhaseProblem::computeAddedHeatPin(), SubChannel1PhaseProblem::computeDP(), computeh(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeMdot(), SubChannel1PhaseProblem::computeWijPrime(), SubChannel1PhaseProblem::computeWijResidual(), initializeSolution(), TriSubChannel1PhaseProblem::initializeSolution(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().