Creates the mesh of subchannels in a quadrilateral lattice. More...
#include <QuadSubChannelMesh.h>
Public Types | |
enum | ParallelType { ParallelType::DEFAULT, ParallelType::REPLICATED, ParallelType::DISTRIBUTED } |
typedef std::pair< const Node *, BoundaryID > | PeriodicNodeInfo |
typedef DataFileName | DataFileParameterType |
Public Member Functions | |
QuadSubChannelMesh (const InputParameters ¶meters) | |
QuadSubChannelMesh (const QuadSubChannelMesh &other_mesh) | |
virtual std::unique_ptr< MooseMesh > | safeClone () const override |
virtual void | buildMesh () override |
virtual Node * | getChannelNode (unsigned int i_chan, unsigned iz) const override |
Get the subchannel mesh node for a given channel index and elevation index. More... | |
virtual Node * | getPinNode (unsigned int i_pin, unsigned iz) const override |
Get the pin mesh node for a given pin index and elevation index. More... | |
virtual const unsigned int & | getNumOfChannels () const override |
Return the number of channels per layer. More... | |
virtual const unsigned int & | getNumOfGapsPerLayer () const override |
Return the number of gaps per layer. More... | |
virtual const unsigned int & | getNumOfPins () const override |
Return the number of pins. More... | |
virtual bool | pinMeshExist () const override |
Return if Pin Mesh exists or not. More... | |
virtual bool | ductMeshExist () const override |
Return if Duct Mesh exists or not. More... | |
virtual const std::pair< unsigned int, unsigned int > & | getGapChannels (unsigned int i_gap) const override |
Return a pair of subchannel indices for a given gap index. More... | |
virtual const std::pair< unsigned int, unsigned int > & | getGapPins (unsigned int i_gap) const override |
Return a pair of pin indices for a given gap index. More... | |
virtual const std::vector< unsigned int > & | getChannelGaps (unsigned int i_chan) const override |
Return a vector of gap indices for a given channel index. More... | |
virtual const std::vector< unsigned int > & | getPinChannels (unsigned int i_pin) const override |
Return a vector of channel indices for a given Pin index. More... | |
virtual const std::vector< unsigned int > & | getChannelPins (unsigned int i_chan) const override |
Return a vector of pin indices for a given channel index. More... | |
virtual const Real & | getPitch () const override |
Return the pitch between 2 subchannels. More... | |
virtual const Real & | getCrossflowSign (unsigned int i_chan, unsigned int i_local) const override |
Return a sign for the crossflow given a subchannel index and local neighbor index. More... | |
virtual const unsigned int & | getNx () const |
Number of subchannels in the -x direction. More... | |
virtual const unsigned int & | getNy () const |
Number of subchannels in the -y direction. More... | |
const Real & | getGap () const |
Returns the gap, not to be confused with the gap between pins, this refers to the gap next to the duct. More... | |
unsigned int | getSubchannelIndexFromPoint (const Point &p) const override |
Return a subchannel index for a given physical point p More... | |
virtual unsigned int | channelIndex (const Point &point) const override |
unsigned int | getPinIndexFromPoint (const Point &p) const override |
Return a pin index for a given physical point p More... | |
virtual unsigned int | pinIndex (const Point &p) const override |
virtual EChannelType | getSubchannelType (unsigned int index) const override |
Return the type of the subchannel for given subchannel index. More... | |
virtual Real | getGapWidth (unsigned int axial_index, unsigned int gap_index) const override |
Return gap width for a given gap index. More... | |
virtual const std::vector< Real > & | getZGrid () const |
Get axial location of layers. More... | |
virtual unsigned int | getZIndex (const Point &point) const |
Get axial index of point. More... | |
virtual const std::vector< std::vector< Real > > & | getKGrid () const |
Get axial cell location and value of loss coefficient. More... | |
virtual const std::vector< Real > & | getZBlockage () const |
Get axial location of blockage (in,out) [m]. More... | |
virtual const std::vector< unsigned int > & | getIndexBlockage () const |
Get index of blocked subchannels. More... | |
virtual const std::vector< Real > & | getReductionBlockage () const |
Get area reduction of blocked subchannels. More... | |
virtual const Real & | getKij () const |
Return lateral loss coefficient. More... | |
virtual const unsigned int & | getNumOfAxialCells () const |
Return the number of axial cells. More... | |
virtual const Real & | getPinDiameter () const |
Return Pin diameter. More... | |
virtual const Real & | getHeatedLengthEntry () const |
Return unheated length at entry. More... | |
virtual const Real & | getHeatedLength () const |
Return heated length. More... | |
virtual const Real & | getHeatedLengthExit () const |
Return unheated length at exit. More... | |
virtual MooseMesh & | clone () const |
void | determineUseDistributedMesh () |
std::unique_ptr< MeshBase > | buildMeshBaseObject (unsigned int dim=libMesh::invalid_uint) |
std::unique_ptr< T > | buildTypedMesh (unsigned int dim=libMesh::invalid_uint) |
void | setMeshBase (std::unique_ptr< MeshBase > mesh_base) |
virtual void | init () |
virtual unsigned int | dimension () const |
virtual unsigned int | spatialDimension () const |
virtual unsigned int | effectiveSpatialDimension () const |
unsigned int | getBlocksMaxDimension (const std::vector< SubdomainName > &blocks) const |
std::vector< BoundaryID > | getBoundaryIDs (const Elem *const elem, const unsigned short int side) const |
const std::set< BoundaryID > & | getBoundaryIDs () const |
std::vector< BoundaryID > | getBoundaryIDs (const std::vector< BoundaryName > &boundary_name, bool generate_unknown=false) const |
const Elem * | getLowerDElem (const Elem *, unsigned short int) const |
unsigned int | getHigherDSide (const Elem *elem) const |
void | buildNodeList () |
void | buildBndElemList () |
const std::map< dof_id_type, std::vector< dof_id_type > > & | nodeToElemMap () |
const std::map< dof_id_type, std::vector< dof_id_type > > & | nodeToActiveSemilocalElemMap () |
virtual bnd_node_iterator | bndNodesBegin () |
virtual bnd_node_iterator | bndNodesEnd () |
virtual bnd_elem_iterator | bndElemsBegin () |
virtual bnd_elem_iterator | bndElemsEnd () |
void | buildNodeListFromSideList () |
void | buildSideList (std::vector< dof_id_type > &el, std::vector< unsigned short int > &sl, std::vector< boundary_id_type > &il) |
std::vector< std::tuple< dof_id_type, unsigned short int, boundary_id_type > > | buildSideList () |
std::vector< std::tuple< dof_id_type, unsigned short int, boundary_id_type > > | buildActiveSideList () const |
unsigned int | sideWithBoundaryID (const Elem *const elem, const BoundaryID boundary_id) const |
MeshBase::node_iterator | localNodesBegin () |
MeshBase::const_node_iterator | localNodesBegin () const |
MeshBase::node_iterator | localNodesEnd () |
MeshBase::const_node_iterator | localNodesEnd () const |
MeshBase::element_iterator | activeLocalElementsBegin () |
MeshBase::const_element_iterator | activeLocalElementsBegin () const |
const MeshBase::element_iterator | activeLocalElementsEnd () |
const MeshBase::const_element_iterator | activeLocalElementsEnd () const |
virtual dof_id_type | nNodes () const |
virtual dof_id_type | nElem () const |
virtual dof_id_type | nLocalNodes () const |
virtual dof_id_type | nActiveElem () const |
virtual dof_id_type | nActiveLocalElem () const |
virtual SubdomainID | nSubdomains () const |
virtual unsigned int | nPartitions () const |
virtual bool | skipPartitioning () const |
virtual bool | skipNoncriticalPartitioning () const |
virtual dof_id_type | maxNodeId () const |
virtual dof_id_type | maxElemId () const |
virtual const Node & | node (const dof_id_type i) const |
virtual Node & | node (const dof_id_type i) |
virtual const Node & | nodeRef (const dof_id_type i) const |
virtual Node & | nodeRef (const dof_id_type i) |
virtual const Node * | nodePtr (const dof_id_type i) const |
virtual Node * | nodePtr (const dof_id_type i) |
virtual const Node * | queryNodePtr (const dof_id_type i) const |
virtual Node * | queryNodePtr (const dof_id_type i) |
virtual Elem * | elem (const dof_id_type i) |
virtual const Elem * | elem (const dof_id_type i) const |
virtual Elem * | elemPtr (const dof_id_type i) |
virtual const Elem * | elemPtr (const dof_id_type i) const |
virtual Elem * | queryElemPtr (const dof_id_type i) |
virtual const Elem * | queryElemPtr (const dof_id_type i) const |
bool | prepared () const |
virtual void | prepared (bool state) |
void | needsPrepareForUse () |
void | meshChanged () |
virtual void | onMeshChanged () |
void | cacheChangedLists () |
ConstElemPointerRange * | refinedElementRange () const |
ConstElemPointerRange * | coarsenedElementRange () const |
const std::vector< const Elem *> & | coarsenedElementChildren (const Elem *elem) const |
void | updateActiveSemiLocalNodeRange (std::set< dof_id_type > &ghosted_elems) |
bool | isSemiLocal (Node *const node) const |
const std::unordered_map< boundary_id_type, std::unordered_set< dof_id_type > > & | getBoundariesToElems () const |
const std::unordered_map< boundary_id_type, std::unordered_set< dof_id_type > > & | getBoundariesToActiveSemiLocalElemIds () const |
std::unordered_set< dof_id_type > | getBoundaryActiveSemiLocalElemIds (BoundaryID bid) const |
std::unordered_set< dof_id_type > | getBoundaryActiveNeighborElemIds (BoundaryID bid) const |
bool | isBoundaryFullyExternalToSubdomains (BoundaryID bid, const std::set< SubdomainID > &blk_group) const |
const std::set< SubdomainID > & | meshSubdomains () const |
const std::set< BoundaryID > & | meshBoundaryIds () const |
const std::set< BoundaryID > & | meshSidesetIds () const |
const std::set< BoundaryID > & | meshNodesetIds () const |
void | setBoundaryToNormalMap (std::unique_ptr< std::map< BoundaryID, RealVectorValue >> boundary_map) |
void | setBoundaryToNormalMap (std::map< BoundaryID, RealVectorValue > *boundary_map) |
void | setMeshBoundaryIDs (std::set< BoundaryID > boundary_IDs) |
const RealVectorValue & | getNormalByBoundaryID (BoundaryID id) const |
bool | prepare (const MeshBase *mesh_to_clone) |
void | update () |
unsigned int | uniformRefineLevel () const |
void | setUniformRefineLevel (unsigned int, bool deletion=true) |
bool | skipDeletionRepartitionAfterRefine () const |
bool | skipRefineWhenUseSplit () const |
void | addGhostedBoundary (BoundaryID boundary_id) |
void | setGhostedBoundaryInflation (const std::vector< Real > &inflation) |
const std::set< unsigned int > & | getGhostedBoundaries () const |
const std::vector< Real > & | getGhostedBoundaryInflation () const |
void | ghostGhostedBoundaries () |
void | needGhostGhostedBoundaries (bool needghost) |
unsigned int | getPatchSize () const |
unsigned int | getGhostingPatchSize () const |
unsigned int | getMaxLeafSize () const |
void | setPatchUpdateStrategy (Moose::PatchUpdateType patch_update_strategy) |
const Moose::PatchUpdateType & | getPatchUpdateStrategy () const |
libMesh::BoundingBox | getInflatedProcessorBoundingBox (Real inflation_multiplier=0.01) const |
operator libMesh::MeshBase & () | |
operator const libMesh::MeshBase & () const | |
MeshBase & | getMesh () |
MeshBase & | getMesh (const std::string &name) |
const MeshBase & | getMesh () const |
const MeshBase & | getMesh (const std::string &name) const |
const MeshBase * | getMeshPtr () const |
void | printInfo (std::ostream &os=libMesh::out, const unsigned int verbosity=0) const |
const std::set< SubdomainID > & | getNodeBlockIds (const Node &node) const |
const std::vector< dof_id_type > & | getNodeList (boundary_id_type nodeset_id) const |
const Node * | addUniqueNode (const Point &p, Real tol=1e-6) |
Node * | addQuadratureNode (const Elem *elem, const unsigned short int side, const unsigned int qp, BoundaryID bid, const Point &point) |
Node * | getQuadratureNode (const Elem *elem, const unsigned short int side, const unsigned int qp) |
void | clearQuadratureNodes () |
BoundaryID | getBoundaryID (const BoundaryName &boundary_name) const |
SubdomainID | getSubdomainID (const SubdomainName &subdomain_name) const |
std::vector< SubdomainID > | getSubdomainIDs (const std::vector< SubdomainName > &subdomain_names) const |
std::set< SubdomainID > | getSubdomainIDs (const std::set< SubdomainName > &subdomain_names) const |
void | setSubdomainName (SubdomainID subdomain_id, const SubdomainName &name) |
const std::string & | getSubdomainName (SubdomainID subdomain_id) const |
std::vector< SubdomainName > | getSubdomainNames (const std::vector< SubdomainID > &subdomain_ids) const |
void | setBoundaryName (BoundaryID boundary_id, BoundaryName name) |
const std::string & | getBoundaryName (BoundaryID boundary_id) |
void | buildPeriodicNodeMap (std::multimap< dof_id_type, dof_id_type > &periodic_node_map, unsigned int var_number, libMesh::PeriodicBoundaries *pbs) const |
void | buildPeriodicNodeSets (std::map< BoundaryID, std::set< dof_id_type >> &periodic_node_sets, unsigned int var_number, libMesh::PeriodicBoundaries *pbs) const |
Real | dimensionWidth (unsigned int component) const |
bool | detectOrthogonalDimRanges (Real tol=1e-6) |
void | addPeriodicVariable (unsigned int var_num, BoundaryID primary, BoundaryID secondary) |
bool | isTranslatedPeriodic (unsigned int nonlinear_var_num, unsigned int component) const |
RealVectorValue | minPeriodicVector (unsigned int nonlinear_var_num, Point p, Point q) const |
Real | minPeriodicDistance (unsigned int nonlinear_var_num, Point p, Point q) const |
const std::pair< BoundaryID, BoundaryID > * | getPairedBoundaryMapping (unsigned int component) |
void | buildRefinementAndCoarseningMaps (Assembly *assembly) |
const std::vector< std::vector< QpMap > > & | getRefinementMap (const Elem &elem, int parent_side, int child, int child_side) |
const std::vector< std::pair< unsigned int, QpMap > > & | getCoarseningMap (const Elem &elem, int input_side) |
void | changeBoundaryId (const boundary_id_type old_id, const boundary_id_type new_id, bool delete_prev) |
const std::set< BoundaryID > & | getSubdomainBoundaryIds (const SubdomainID subdomain_id) const |
std::set< BoundaryID > | getSubdomainInterfaceBoundaryIds (const SubdomainID subdomain_id) const |
std::set< SubdomainID > | getBoundaryConnectedBlocks (const BoundaryID bid) const |
std::set< SubdomainID > | getBoundaryConnectedSecondaryBlocks (const BoundaryID bid) const |
std::set< SubdomainID > | getInterfaceConnectedBlocks (const BoundaryID bid) const |
const std::set< SubdomainID > & | getBlockConnectedBlocks (const SubdomainID subdomain_id) const |
bool | isBoundaryNode (dof_id_type node_id) const |
bool | isBoundaryNode (dof_id_type node_id, BoundaryID bnd_id) const |
bool | isBoundaryElem (dof_id_type elem_id) const |
bool | isBoundaryElem (dof_id_type elem_id, BoundaryID bnd_id) const |
void | errorIfDistributedMesh (std::string name) const |
virtual bool | isDistributedMesh () const |
bool | isParallelTypeForced () const |
void | setParallelType (ParallelType parallel_type) |
ParallelType | getParallelType () const |
const MooseEnum & | partitionerName () const |
bool | isPartitionerForced () const |
void | allowRecovery (bool allow) |
void | setCustomPartitioner (libMesh::Partitioner *partitioner) |
bool | isRegularOrthogonal () |
bool | hasSecondOrderElements () |
virtual std::unique_ptr< libMesh::PointLocatorBase > | getPointLocator () const |
virtual std::string | getFileName () const |
void | needsRemoteElemDeletion (bool need_delete) |
bool | needsRemoteElemDeletion () const |
void | allowRemoteElementRemoval (bool allow_removal) |
bool | allowRemoteElementRemoval () const |
void | deleteRemoteElements () |
bool | hasMeshBase () const |
bool | hasElementID (const std::string &id_name) const |
unsigned int | getElementIDIndex (const std::string &id_name) const |
dof_id_type | maxElementID (unsigned int elem_id_index) const |
dof_id_type | minElementID (unsigned int elem_id_index) const |
bool | areElemIDsIdentical (const std::string &id_name1, const std::string &id_name2) const |
std::set< dof_id_type > | getAllElemIDs (unsigned int elem_id_index) const |
std::set< dof_id_type > | getElemIDsOnBlocks (unsigned int elem_id_index, const std::set< SubdomainID > &blks) const |
std::unordered_map< dof_id_type, std::set< dof_id_type > > | getElemIDMapping (const std::string &from_id_name, const std::string &to_id_name) const |
void | cacheFaceInfoVariableOwnership () const |
void | cacheFVElementalDoFs () const |
void | computeFiniteVolumeCoords () const |
void | isDisplaced (bool is_displaced) |
bool | isDisplaced () const |
const std::map< boundary_id_type, std::vector< dof_id_type > > & | nodeSetNodes () const |
Moose::CoordinateSystemType | getCoordSystem (SubdomainID sid) const |
const std::map< SubdomainID, Moose::CoordinateSystemType > & | getCoordSystem () const |
Moose::CoordinateSystemType | getUniqueCoordSystem () const |
void | setCoordSystem (const std::vector< SubdomainName > &blocks, const MultiMooseEnum &coord_sys) |
void | setAxisymmetricCoordAxis (const MooseEnum &rz_coord_axis) |
void | setGeneralAxisymmetricCoordAxes (const std::vector< SubdomainName > &blocks, const std::vector< std::pair< Point, RealVectorValue >> &axes) |
const std::pair< Point, RealVectorValue > & | getGeneralAxisymmetricCoordAxis (SubdomainID subdomain_id) const |
bool | usingGeneralAxisymmetricCoordAxes () const |
unsigned int | getAxisymmetricRadialCoord () const |
void | checkCoordinateSystems () |
void | setCoordData (const MooseMesh &other_mesh) |
void | markFiniteVolumeInfoDirty () |
bool | isFiniteVolumeInfoDirty () const |
MooseAppCoordTransform & | coordTransform () |
const MooseUnits & | lengthUnit () const |
const std::unordered_map< std::pair< const Elem *, unsigned short int >, const Elem *> & | getLowerDElemMap () const |
bool | isSplit () const |
void | buildFiniteVolumeInfo () const |
void | setupFiniteVolumeMeshData () const |
void | doingPRefinement (bool doing_p_refinement) |
bool | doingPRefinement () const |
unsigned int | maxPLevel () const |
unsigned int | maxHLevel () const |
const std::vector< QpMap > & | getPRefinementMap (const Elem &elem) const |
const std::vector< QpMap > & | getPRefinementSideMap (const Elem &elem) const |
const std::vector< QpMap > & | getPCoarseningMap (const Elem &elem) const |
const std::vector< QpMap > & | getPCoarseningSideMap (const Elem &elem) const |
void | buildPRefinementAndCoarseningMaps (Assembly *assembly) |
bool | isLowerD (const SubdomainID subdomain_id) const |
bool | hasLowerD () const |
const std::set< SubdomainID > & | interiorLowerDBlocks () const |
const std::set< SubdomainID > & | boundaryLowerDBlocks () const |
bool | getConstructNodeListFromSideList () |
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 () |
libMesh::ConstElemRange * | getActiveLocalElementRange () |
libMesh::ConstElemRange * | getActiveLocalElementRange () |
libMesh::NodeRange * | getActiveNodeRange () |
libMesh::NodeRange * | getActiveNodeRange () |
SemiLocalNodeRange * | getActiveSemiLocalNodeRange () const |
SemiLocalNodeRange * | getActiveSemiLocalNodeRange () const |
libMesh::ConstNodeRange * | getLocalNodeRange () |
libMesh::ConstNodeRange * | getLocalNodeRange () |
libMesh::StoredRange< MooseMesh::const_bnd_node_iterator, const BndNode *> * | getBoundaryNodeRange () |
libMesh::StoredRange< MooseMesh::const_bnd_node_iterator, const BndNode *> * | getBoundaryNodeRange () |
libMesh::StoredRange< MooseMesh::const_bnd_elem_iterator, const BndElement *> * | getBoundaryElementRange () |
libMesh::StoredRange< MooseMesh::const_bnd_elem_iterator, const BndElement *> * | getBoundaryElementRange () |
virtual Real | getMinInDimension (unsigned int component) const |
virtual Real | getMinInDimension (unsigned int component) const |
virtual Real | getMaxInDimension (unsigned int component) const |
virtual Real | getMaxInDimension (unsigned int component) const |
bool | isCustomPartitionerRequested () const |
bool | isCustomPartitionerRequested () const |
void | setIsCustomPartitionerRequested (bool cpr) |
void | setIsCustomPartitionerRequested (bool cpr) |
unsigned int | nFace () const |
unsigned int | nFace () const |
const std::vector< const FaceInfo *> & | faceInfo () const |
const FaceInfo * | faceInfo (const Elem *elem, unsigned int side) const |
const std::vector< const FaceInfo *> & | faceInfo () const |
const FaceInfo * | faceInfo (const Elem *elem, unsigned int side) const |
face_info_iterator | ownedFaceInfoBegin () |
face_info_iterator | ownedFaceInfoBegin () |
face_info_iterator | ownedFaceInfoEnd () |
face_info_iterator | ownedFaceInfoEnd () |
elem_info_iterator | ownedElemInfoBegin () |
elem_info_iterator | ownedElemInfoBegin () |
elem_info_iterator | ownedElemInfoEnd () |
elem_info_iterator | ownedElemInfoEnd () |
const ElemInfo & | elemInfo (const dof_id_type id) const |
const ElemInfo & | elemInfo (const dof_id_type id) const |
const std::vector< const ElemInfo *> & | elemInfoVector () const |
const std::vector< const ElemInfo *> & | elemInfoVector () const |
const std::vector< FaceInfo > & | allFaceInfo () const |
const std::vector< FaceInfo > & | allFaceInfo () const |
const Parallel::Communicator & | comm () const |
processor_id_type | n_processors () const |
processor_id_type | processor_id () const |
virtual Node * | getChanNodeFromDuct (Node *) override |
Duct functions not applicable to quad channel. More... | |
virtual Node * | getDuctNodeFromChannel (Node *) override |
Function that gets the duct node from the channel node. More... | |
virtual Node * | getChannelNodeFromDuct (Node *) override |
Function that gets the channel node from the duct node. More... | |
virtual const std::vector< Node * > | getDuctNodes () const override |
Function that return the vector with the maps to the nodes if they exist. More... | |
Static Public Member Functions | |
static InputParameters | validParams () |
static void | generatePinCenters (unsigned int nx, unsigned int ny, Real pitch, Real elev, std::vector< Point > &pin_centers) |
Generate pin centers. More... | |
static void | generateZGrid (Real unheated_length_entry, Real heated_length, Real unheated_length_exit, unsigned int n_cells, std::vector< Real > &z_grid) |
Generate the spacing in z-direction using heated and unteaded lengths. More... | |
static void | setSubdomainName (MeshBase &mesh, SubdomainID subdomain_id, const SubdomainName &name) |
static void | changeBoundaryId (MeshBase &mesh, const boundary_id_type old_id, const boundary_id_type new_id, bool delete_prev) |
static MooseEnum | partitioning () |
static MooseEnum | elemTypes () |
static void | setPartitioner (MeshBase &mesh_base, MooseEnum &partitioner, bool use_distributed_mesh, const InputParameters ¶ms, MooseObject &context_obj) |
Public Attributes | |
std::vector< std::vector< Real > > | _subchannel_position |
x,y coordinates of the subchannel centroids More... | |
const ConsoleStream | _console |
Protected Types | |
typedef std::vector< BndNode *>::iterator | bnd_node_iterator_imp |
typedef std::vector< BndNode *>::const_iterator | const_bnd_node_iterator_imp |
typedef std::vector< BndElement *>::iterator | bnd_elem_iterator_imp |
typedef std::vector< BndElement *>::const_iterator | const_bnd_elem_iterator_imp |
Protected Member Functions | |
void | cacheInfo () |
void | freeBndNodes () |
void | freeBndElems () |
void | setPartitionerHelper (MeshBase *mesh=nullptr) |
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 |
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 |
Protected Attributes | |
unsigned int | _nx |
number of subchannels in the x direction More... | |
unsigned int | _ny |
number of subchannels in the y direction More... | |
unsigned int | _n_channels |
number of subchannels in total More... | |
unsigned int | _n_gaps |
Number of gaps per layer. More... | |
unsigned int | _n_pins |
Number of pins. More... | |
Real | _gap |
The gap, not to be confused with the gap between pins, this refers to the gap next to the duct. More... | |
std::vector< std::vector< Node * > > | _nodes |
vector of subchannel nodes More... | |
std::vector< std::vector< Node * > > | _pin_nodes |
vector of fuel pin nodes More... | |
std::vector< std::vector< Node * > > | _gapnodes |
vector of gap (interface between pairs of neighboring subchannels) nodes More... | |
std::vector< std::pair< unsigned int, unsigned int > > | _gap_to_chan_map |
map relating gap index to subchannel index More... | |
std::vector< std::pair< unsigned int, unsigned int > > | _gap_to_pin_map |
map relating gap index to fuel pin index More... | |
std::vector< std::vector< unsigned int > > | _chan_to_gap_map |
map relating subchannel index to gap index More... | |
std::vector< std::vector< unsigned int > > | _chan_to_pin_map |
map relating subchannel index to fuel pin index More... | |
std::vector< std::vector< unsigned int > > | _pin_to_chan_map |
map relating fuel pin index to subchannel index More... | |
std::vector< std::vector< double > > | _sign_id_crossflow_map |
Matrix used to give local sign to crossflow quantities. More... | |
std::vector< std::vector< Real > > | _gij_map |
Vector to store gap size. More... | |
std::vector< EChannelType > | _subch_type |
Subchannel type. More... | |
bool | _pin_mesh_exist |
Flag that informs the solver whether there is a Pin Mesh or not. More... | |
Real | _unheated_length_entry |
unheated length of the fuel Pin at the entry of the assembly More... | |
Real | _heated_length |
heated length of the fuel Pin More... | |
Real | _unheated_length_exit |
unheated length of the fuel Pin at the exit of the assembly More... | |
std::vector< Real > | _z_grid |
axial location of nodes More... | |
std::vector< std::vector< Real > > | _k_grid |
axial form loss coefficient per computational cell More... | |
std::vector< Real > | _spacer_z |
axial location of the spacers More... | |
std::vector< Real > | _spacer_k |
form loss coefficient of the spacers More... | |
std::vector< Real > | _z_blockage |
axial location of blockage (inlet, outlet) [m] More... | |
std::vector< unsigned int > | _index_blockage |
index of subchannels affected by blockage More... | |
std::vector< Real > | _reduction_blockage |
area reduction of subchannels affected by blockage More... | |
Real | _kij |
Lateral form loss coefficient. More... | |
Real | _pitch |
Distance between the neighbor fuel pins, pitch. More... | |
Real | _pin_diameter |
fuel Pin diameter More... | |
unsigned int | _n_cells |
number of axial cells More... | |
X | |
Y | |
Z | |
MIN | |
MAX | |
std::vector< std::unique_ptr< libMesh::GhostingFunctor > > | _ghosting_functors |
std::vector< std::shared_ptr< RelationshipManager > > | _relationship_managers |
bool | _built_from_other_mesh |
ParallelType | _parallel_type |
bool | _use_distributed_mesh |
bool | _distribution_overridden |
bool | _parallel_type_overridden |
std::unique_ptr< libMesh::MeshBase > | _mesh |
MooseEnum | _partitioner_name |
bool | _partitioner_overridden |
std::unique_ptr< libMesh::Partitioner > | _custom_partitioner |
bool | _custom_partitioner_requested |
unsigned int | _uniform_refine_level |
bool | _skip_refine_when_use_split |
bool | _skip_deletion_repartition_after_refine |
bool | _is_changed |
bool | _is_nemesis |
bool | _moose_mesh_prepared |
std::unique_ptr< ConstElemPointerRange > | _refined_elements |
std::unique_ptr< ConstElemPointerRange > | _coarsened_elements |
std::map< const Elem *, std::vector< const Elem *> > | _coarsened_element_children |
std::set< Node *> | _semilocal_node_list |
std::unique_ptr< libMesh::ConstElemRange > | _active_local_elem_range |
std::unique_ptr< SemiLocalNodeRange > | _active_semilocal_node_range |
std::unique_ptr< libMesh::NodeRange > | _active_node_range |
std::unique_ptr< libMesh::ConstNodeRange > | _local_node_range |
std::unique_ptr< libMesh::StoredRange< MooseMesh::const_bnd_node_iterator, const BndNode *> > | _bnd_node_range |
std::unique_ptr< libMesh::StoredRange< MooseMesh::const_bnd_elem_iterator, const BndElement *> > | _bnd_elem_range |
std::map< dof_id_type, std::vector< dof_id_type > > | _node_to_elem_map |
bool | _node_to_elem_map_built |
std::map< dof_id_type, std::vector< dof_id_type > > | _node_to_active_semilocal_elem_map |
bool | _node_to_active_semilocal_elem_map_built |
std::set< SubdomainID > | _mesh_subdomains |
std::unique_ptr< std::map< BoundaryID, RealVectorValue > > | _boundary_to_normal_map |
std::vector< BndNode *> | _bnd_nodes |
std::map< boundary_id_type, std::set< dof_id_type > > | _bnd_node_ids |
std::vector< BndElement *> | _bnd_elems |
std::unordered_map< boundary_id_type, std::unordered_set< dof_id_type > > | _bnd_elem_ids |
std::map< dof_id_type, Node *> | _quadrature_nodes |
std::map< dof_id_type, std::map< unsigned int, std::map< dof_id_type, Node *> > > | _elem_to_side_to_qp_to_quadrature_nodes |
std::vector< BndNode > | _extra_bnd_nodes |
std::map< dof_id_type, std::set< SubdomainID > > | _block_node_list |
std::map< boundary_id_type, std::vector< dof_id_type > > | _node_set_nodes |
std::set< unsigned int > | _ghosted_boundaries |
std::vector< Real > | _ghosted_boundaries_inflation |
unsigned int | _patch_size |
unsigned int | _ghosting_patch_size |
unsigned int | _max_leaf_size |
Moose::PatchUpdateType | _patch_update_strategy |
std::vector< Node *> | _node_map |
bool | _regular_orthogonal_mesh |
std::vector< std::vector< Real > > | _bounds |
std::vector< std::pair< BoundaryID, BoundaryID > > | _paired_boundary |
const bool | _is_split |
const bool & | _enabled |
MooseApp & | _app |
const std::string | _type |
const std::string | _name |
const InputParameters & | _pars |
Factory & | _factory |
ActionFactory & | _action_factory |
MooseApp & | _restartable_app |
const std::string | _restartable_system_name |
const THREAD_ID | _restartable_tid |
const bool | _restartable_read_only |
MooseApp & | _pg_moose_app |
const std::string | _prefix |
std::set< BoundaryID > | _mesh_boundary_ids |
std::set< BoundaryID > | _mesh_sideset_ids |
std::set< BoundaryID > | _mesh_nodeset_ids |
const Parallel::Communicator & | _communicator |
Friends | |
class | SCMQuadSubChannelMeshGenerator |
class | SCMQuadPinMeshGenerator |
class | QuadSubChannel1PhaseProblem |
Creates the mesh of subchannels in a quadrilateral lattice.
Definition at line 18 of file QuadSubChannelMesh.h.
QuadSubChannelMesh::QuadSubChannelMesh | ( | const InputParameters & | parameters | ) |
Definition at line 28 of file QuadSubChannelMesh.C.
QuadSubChannelMesh::QuadSubChannelMesh | ( | const QuadSubChannelMesh & | other_mesh | ) |
Definition at line 33 of file QuadSubChannelMesh.C.
|
overridevirtual |
|
overridevirtual |
Implements SubChannelMesh.
Definition at line 81 of file QuadSubChannelMesh.C.
|
inlineoverridevirtual |
Return if Duct Mesh exists or not.
Implements SubChannelMesh.
Definition at line 52 of file QuadSubChannelMesh.h.
|
static |
Generate pin centers.
nx | number of channels in x-direction (must be more than 1) |
ny | number of channels in y-direction (must be more than 1) |
elev | elevation in z-direction |
pin_centers | Positions in 3D space of pin centers |
Definition at line 122 of file QuadSubChannelMesh.C.
Referenced by SCMDetailedQuadPinMeshGenerator::generate().
|
staticinherited |
Generate the spacing in z-direction using heated and unteaded lengths.
Definition at line 39 of file SubChannelMesh.C.
Referenced by SCMQuadSubChannelMeshGenerator::SCMQuadSubChannelMeshGenerator(), SCMTriDuctMeshGenerator::SCMTriDuctMeshGenerator(), and SCMTriSubChannelMeshGenerator::SCMTriSubChannelMeshGenerator().
|
inlineoverridevirtual |
Return a vector of gap indices for a given channel index.
Implements SubChannelMesh.
Definition at line 63 of file QuadSubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::computeh(), and QuadSubChannel1PhaseProblem::initializeSolution().
|
inlineoverridevirtual |
Get the subchannel mesh node for a given channel index and elevation index.
Implements SubChannelMesh.
Definition at line 26 of file QuadSubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::computeAddedHeatPin(), QuadSubChannel1PhaseProblem::computeBeta(), QuadSubChannel1PhaseProblem::computeh(), QuadSubChannel1PhaseProblem::initializeSolution(), and QuadSubChannelNormalSliceValues::output().
|
inlineoverridevirtual |
Function that gets the channel node from the duct node.
Implements SubChannelMesh.
Definition at line 44 of file QuadSubChannelMesh.h.
|
inlineoverridevirtual |
Return a vector of pin indices for a given channel index.
Implements SubChannelMesh.
Definition at line 71 of file QuadSubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::computeAddedHeatPin(), SCMQuadPowerAux::computeValue(), QuadSubChannel1PhaseProblem::initializeSolution(), and SCMQuadPowerIC::value().
|
inlineoverridevirtual |
Duct functions not applicable to quad channel.
Over-writing to avoid abstract template definition in this class
Implements SubChannelMesh.
Definition at line 42 of file QuadSubChannelMesh.h.
|
inlineoverridevirtual |
Return a sign for the crossflow given a subchannel index and local neighbor index.
Implements SubChannelMesh.
Definition at line 76 of file QuadSubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::computeh().
|
inlineoverridevirtual |
Function that gets the duct node from the channel node.
Implements SubChannelMesh.
Definition at line 43 of file QuadSubChannelMesh.h.
|
inlineoverridevirtual |
Function that return the vector with the maps to the nodes if they exist.
Implements SubChannelMesh.
Definition at line 45 of file QuadSubChannelMesh.h.
|
inline |
Returns the gap, not to be confused with the gap between pins, this refers to the gap next to the duct.
Edge Pitch W = (pitch/2 - pin_diameter/2 + gap) [m]
Definition at line 88 of file QuadSubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::computeFrictionFactor(), QuadSubChannel1PhaseProblem::initializeSolution(), SCMQuadWettedPerimIC::value(), and SCMQuadFlowAreaIC::value().
|
inlineoverridevirtual |
Return a pair of subchannel indices for a given gap index.
Implements SubChannelMesh.
Definition at line 54 of file QuadSubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::computeBeta(), and QuadSubChannel1PhaseProblem::computeh().
|
inlineoverridevirtual |
Return a pair of pin indices for a given gap index.
Implements SubChannelMesh.
Definition at line 59 of file QuadSubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::initializeSolution().
|
inlineoverridevirtual |
Return gap width for a given gap index.
Implements SubChannelMesh.
Definition at line 101 of file QuadSubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::computeBeta().
|
inlinevirtualinherited |
Return heated length.
Definition at line 164 of file SubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::computeh(), TriSubChannel1PhaseProblem::computeh(), SCMTriPowerAux::computeValue(), SCMQuadPowerAux::computeValue(), SCMPlanarMean::execute(), SCMPinSurfaceTemperature::execute(), SCMQuadPowerIC::initialSetup(), SCMQuadPowerAux::initialSetup(), SCMTriPowerIC::initialSetup(), SCMTriPowerAux::initialSetup(), QuadSubChannelNormalSliceValues::output(), SCMQuadPowerIC::SCMQuadPowerIC(), SCMTriPowerIC::SCMTriPowerIC(), FCTFdisplacementIC::value(), SCMQuadPowerIC::value(), and SCMTriPowerIC::value().
|
inlinevirtualinherited |
Return unheated length at entry.
Definition at line 159 of file SubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::computeh(), TriSubChannel1PhaseProblem::computeh(), SCMTriPowerAux::computeValue(), SCMQuadPowerAux::computeValue(), SCMPinSurfaceTemperature::execute(), SCMPlanarMean::execute(), SCMQuadPowerIC::initialSetup(), SCMQuadPowerAux::initialSetup(), SCMTriPowerIC::initialSetup(), SCMTriPowerAux::initialSetup(), QuadSubChannelNormalSliceValues::output(), SCMQuadPowerIC::value(), FCTFdisplacementIC::value(), and SCMTriPowerIC::value().
|
inlinevirtualinherited |
Return unheated length at exit.
Definition at line 169 of file SubChannelMesh.h.
Referenced by SCMPinSurfaceTemperature::execute(), SCMPlanarMean::execute(), and QuadSubChannelNormalSliceValues::output().
|
inlinevirtualinherited |
Get index of blocked subchannels.
Definition at line 48 of file SubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::initializeSolution(), TriSubChannel1PhaseProblem::initializeSolution(), SCMQuadFlowAreaIC::value(), SCMTriFlowAreaIC::value(), and MarvelTriFlowAreaIC::value().
|
inlinevirtualinherited |
Get axial cell location and value of loss coefficient.
Definition at line 38 of file SubChannelMesh.h.
Referenced by SubChannel1PhaseProblem::computeDP().
|
inlinevirtualinherited |
|
inlinevirtualinherited |
Return the number of axial cells.
Definition at line 63 of file SubChannelMesh.h.
Referenced by TriSubChannel1PhaseProblem::computeh(), SCMPinSurfaceTemperature::execute(), SCMPlanarMean::execute(), SubChannelDelta::execute(), SCMQuadPowerIC::initialSetup(), SCMTriPowerIC::initialSetup(), SCMTriPowerAux::initialSetup(), SCMQuadPowerAux::initialSetup(), QuadSubChannelNormalSliceValues::output(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
inlineoverridevirtual |
Return the number of channels per layer.
Implements SubChannelMesh.
Definition at line 48 of file QuadSubChannelMesh.h.
Referenced by QuadSubChannelNormalSliceValues::output().
|
inlineoverridevirtual |
Return the number of gaps per layer.
Implements SubChannelMesh.
Definition at line 49 of file QuadSubChannelMesh.h.
|
inlineoverridevirtual |
Return the number of pins.
Implements SubChannelMesh.
Definition at line 50 of file QuadSubChannelMesh.h.
|
inlinevirtual |
Number of subchannels in the -x direction.
Definition at line 81 of file QuadSubChannelMesh.h.
Referenced by SCMQuadPowerIC::initialSetup(), SCMQuadPowerAux::initialSetup(), QuadSubChannelNormalSliceValues::output(), QuadSubChannelNormalSliceValues::QuadSubChannelNormalSliceValues(), SCMQuadPowerAux::SCMQuadPowerAux(), and SCMQuadPowerIC::SCMQuadPowerIC().
|
inlinevirtual |
Number of subchannels in the -y direction.
Definition at line 83 of file QuadSubChannelMesh.h.
Referenced by SCMQuadPowerIC::initialSetup(), SCMQuadPowerAux::initialSetup(), QuadSubChannelNormalSliceValues::QuadSubChannelNormalSliceValues(), SCMQuadPowerAux::SCMQuadPowerAux(), and SCMQuadPowerIC::SCMQuadPowerIC().
|
inlineoverridevirtual |
Return a vector of channel indices for a given Pin index.
Implements SubChannelMesh.
Definition at line 67 of file QuadSubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::initializeSolution().
|
inlinevirtualinherited |
Return Pin diameter.
Definition at line 149 of file SubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::computeBeta(), TriSubChannel1PhaseProblem::computeBeta(), QuadSubChannel1PhaseProblem::computeFrictionFactor(), TriSubChannel1PhaseProblem::computeFrictionFactor(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::externalSolve(), TriSubChannel1PhaseProblem::initializeSolution(), SCMQuadWettedPerimIC::value(), MarvelTriWettedPerimIC::value(), SCMTriWettedPerimIC::value(), SCMQuadFlowAreaIC::value(), SCMTriFlowAreaIC::value(), and MarvelTriFlowAreaIC::value().
|
overridevirtual |
Return a pin index for a given physical point p
Implements SubChannelMesh.
Definition at line 102 of file QuadSubChannelMesh.C.
Referenced by SCMQuadPowerAux::computeValue(), and SCMQuadPowerIC::value().
|
inlineoverridevirtual |
Get the pin mesh node for a given pin index and elevation index.
Implements SubChannelMesh.
Definition at line 31 of file QuadSubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::computeAddedHeatPin(), and QuadSubChannel1PhaseProblem::initializeSolution().
|
inlineoverridevirtual |
Return the pitch between 2 subchannels.
Reimplemented from SubChannelMesh.
Definition at line 75 of file QuadSubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::computeBeta(), QuadSubChannel1PhaseProblem::computeFrictionFactor(), QuadSubChannel1PhaseProblem::initializeSolution(), SCMQuadWettedPerimIC::value(), and SCMQuadFlowAreaIC::value().
|
inlinevirtualinherited |
Get area reduction of blocked subchannels.
Definition at line 53 of file SubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::initializeSolution(), TriSubChannel1PhaseProblem::initializeSolution(), SCMQuadFlowAreaIC::value(), SCMTriFlowAreaIC::value(), and MarvelTriFlowAreaIC::value().
|
overridevirtual |
Return a subchannel index for a given physical point p
Implements SubChannelMesh.
Definition at line 71 of file QuadSubChannelMesh.C.
Referenced by SCMQuadPowerAux::computeValue(), SCMQuadWettedPerimIC::value(), SCMQuadPowerIC::value(), and SCMQuadFlowAreaIC::value().
|
inlineoverridevirtual |
Return the type of the subchannel for given subchannel index.
Implements SubChannelMesh.
Definition at line 96 of file QuadSubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::computeFrictionFactor(), QuadSubChannel1PhaseProblem::initializeSolution(), SCMQuadWettedPerimIC::value(), and SCMQuadFlowAreaIC::value().
|
inlinevirtualinherited |
Get axial location of blockage (in,out) [m].
Definition at line 43 of file SubChannelMesh.h.
Referenced by QuadSubChannel1PhaseProblem::initializeSolution(), TriSubChannel1PhaseProblem::initializeSolution(), SCMQuadFlowAreaIC::value(), SCMTriFlowAreaIC::value(), and MarvelTriFlowAreaIC::value().
|
inlinevirtualinherited |
Get axial location of layers.
Definition at line 28 of file SubChannelMesh.h.
Referenced by TriSubChannel1PhaseProblem::computeh(), SCMPinSurfaceTemperature::execute(), SCMPlanarMean::execute(), SCMQuadPowerIC::initialSetup(), SCMTriPowerIC::initialSetup(), SCMTriPowerAux::initialSetup(), SCMQuadPowerAux::initialSetup(), QuadSubChannelNormalSliceValues::output(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
virtualinherited |
Get axial index of point.
Definition at line 52 of file SubChannelMesh.C.
Referenced by SCMPinSolutionTransfer::getFromNode(), and SCMSolutionTransfer::getFromNode().
|
overridevirtual |
Implements SubChannelMesh.
Definition at line 112 of file QuadSubChannelMesh.C.
|
inlineoverridevirtual |
Return if Pin Mesh exists or not.
Implements SubChannelMesh.
Definition at line 51 of file QuadSubChannelMesh.h.
Referenced by SCMQuadPowerAux::computeValue(), and SCMQuadPowerIC::value().
|
overridevirtual |
Implements MooseMesh.
Definition at line 60 of file QuadSubChannelMesh.C.
|
static |
Definition at line 20 of file QuadSubChannelMesh.C.
|
friend |
Definition at line 163 of file QuadSubChannelMesh.h.
|
friend |
Definition at line 162 of file QuadSubChannelMesh.h.
|
friend |
Definition at line 161 of file QuadSubChannelMesh.h.
|
protected |
map relating subchannel index to gap index
Definition at line 133 of file QuadSubChannelMesh.h.
Referenced by getChannelGaps().
|
protected |
map relating subchannel index to fuel pin index
Definition at line 135 of file QuadSubChannelMesh.h.
Referenced by getChannelPins().
|
protected |
The gap, not to be confused with the gap between pins, this refers to the gap next to the duct.
Edge Pitch W = (pitch/2 - pin_diameter/2 + gap) [m]
Definition at line 121 of file QuadSubChannelMesh.h.
Referenced by getGap().
map relating gap index to subchannel index
Definition at line 129 of file QuadSubChannelMesh.h.
Referenced by getGapChannels().
map relating gap index to fuel pin index
Definition at line 131 of file QuadSubChannelMesh.h.
Referenced by getGapPins().
|
protected |
vector of gap (interface between pairs of neighboring subchannels) nodes
Definition at line 127 of file QuadSubChannelMesh.h.
|
protected |
Vector to store gap size.
Definition at line 141 of file QuadSubChannelMesh.h.
Referenced by getGapWidth(), and QuadSubChannel1PhaseProblem::initializeSolution().
|
protectedinherited |
heated length of the fuel Pin
Definition at line 204 of file SubChannelMesh.h.
Referenced by SubChannelMesh::getHeatedLength().
|
protectedinherited |
index of subchannels affected by blockage
Definition at line 218 of file SubChannelMesh.h.
Referenced by SubChannelMesh::getIndexBlockage().
|
protectedinherited |
axial form loss coefficient per computational cell
Definition at line 210 of file SubChannelMesh.h.
Referenced by SubChannelMesh::getKGrid().
|
protectedinherited |
Lateral form loss coefficient.
Definition at line 222 of file SubChannelMesh.h.
Referenced by SubChannelMesh::getKij().
|
protectedinherited |
number of axial cells
Definition at line 228 of file SubChannelMesh.h.
Referenced by SubChannelMesh::getNumOfAxialCells().
|
protected |
number of subchannels in total
Definition at line 112 of file QuadSubChannelMesh.h.
Referenced by getNumOfChannels().
|
protected |
Number of gaps per layer.
Definition at line 114 of file QuadSubChannelMesh.h.
Referenced by getNumOfGapsPerLayer().
|
protected |
|
protected |
vector of subchannel nodes
Definition at line 123 of file QuadSubChannelMesh.h.
Referenced by getChannelNode().
|
protected |
number of subchannels in the x direction
Definition at line 108 of file QuadSubChannelMesh.h.
Referenced by channelIndex(), getNx(), getPinIndexFromPoint(), getSubchannelIndexFromPoint(), pinIndex(), and QuadSubChannelMesh().
|
protected |
number of subchannels in the y direction
Definition at line 110 of file QuadSubChannelMesh.h.
Referenced by channelIndex(), getNy(), getPinIndexFromPoint(), getSubchannelIndexFromPoint(), pinIndex(), and QuadSubChannelMesh().
|
protectedinherited |
fuel Pin diameter
Definition at line 226 of file SubChannelMesh.h.
Referenced by TriSubChannelMesh::channelIndex(), and SubChannelMesh::getPinDiameter().
|
protected |
Flag that informs the solver whether there is a Pin Mesh or not.
Definition at line 145 of file QuadSubChannelMesh.h.
Referenced by pinMeshExist().
|
protected |
vector of fuel pin nodes
Definition at line 125 of file QuadSubChannelMesh.h.
Referenced by SCMQuadPinMeshGenerator::generate(), and getPinNode().
|
protected |
map relating fuel pin index to subchannel index
Definition at line 137 of file QuadSubChannelMesh.h.
Referenced by getPinChannels().
|
protectedinherited |
Distance between the neighbor fuel pins, pitch.
Definition at line 224 of file SubChannelMesh.h.
Referenced by channelIndex(), TriSubChannelMesh::channelIndex(), getPinIndexFromPoint(), getPitch(), SubChannelMesh::getPitch(), getSubchannelIndexFromPoint(), pinIndex(), and TriSubChannelMesh::pinIndex().
|
protectedinherited |
area reduction of subchannels affected by blockage
Definition at line 220 of file SubChannelMesh.h.
Referenced by SubChannelMesh::getReductionBlockage().
|
protected |
Matrix used to give local sign to crossflow quantities.
Definition at line 139 of file QuadSubChannelMesh.h.
Referenced by getCrossflowSign().
|
protectedinherited |
form loss coefficient of the spacers
Definition at line 214 of file SubChannelMesh.h.
|
protectedinherited |
axial location of the spacers
Definition at line 212 of file SubChannelMesh.h.
|
protected |
Subchannel type.
Definition at line 143 of file QuadSubChannelMesh.h.
Referenced by getSubchannelType().
|
inherited |
x,y coordinates of the subchannel centroids
Definition at line 232 of file SubChannelMesh.h.
Referenced by TriSubChannelMesh::channelIndex(), QuadSubChannelMesh(), TriSubChannelMesh::setChannelToDuctMaps(), SubChannelPointValue::SubChannelPointValue(), and TriSubChannelMesh::TriSubChannelMesh().
|
protectedinherited |
unheated length of the fuel Pin at the entry of the assembly
Definition at line 202 of file SubChannelMesh.h.
Referenced by SCMQuadSubChannelMeshGenerator::generate(), SCMTriSubChannelMeshGenerator::generate(), and SubChannelMesh::getHeatedLengthEntry().
|
protectedinherited |
unheated length of the fuel Pin at the exit of the assembly
Definition at line 206 of file SubChannelMesh.h.
Referenced by SubChannelMesh::getHeatedLengthExit().
|
protectedinherited |
axial location of blockage (inlet, outlet) [m]
Definition at line 216 of file SubChannelMesh.h.
Referenced by SubChannelMesh::getZBlockage().
|
protectedinherited |
axial location of nodes
Definition at line 208 of file SubChannelMesh.h.
Referenced by SubChannelMesh::getZGrid(), and SubChannelMesh::getZIndex().