Mesh class for triangular, edge and corner subchannels for hexagonal lattice fuel assemblies. More...
#include <TriSubChannelMesh.h>
Public Types | |
enum | ParallelType { ParallelType::DEFAULT, ParallelType::REPLICATED, ParallelType::DISTRIBUTED } |
typedef std::pair< const Node *, BoundaryID > | PeriodicNodeInfo |
typedef DataFileName | DataFileParameterType |
Public Member Functions | |
TriSubChannelMesh (const InputParameters ¶meters) | |
TriSubChannelMesh (const TriSubChannelMesh &other_mesh) | |
virtual std::unique_ptr< MooseMesh > | safeClone () const override |
virtual void | buildMesh () override |
virtual const unsigned int & | getNumOfPins () const override |
Return the number of pins. 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 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 Real & | getDuctToPinGap () const |
Return the the gap thickness between the duct and peripheral fuel pins. More... | |
virtual const unsigned int & | getNumOfRings () const |
Return the number of rings. More... | |
virtual const unsigned int & | getPinIndex (const unsigned int channel_idx, const unsigned int neighbor_idx) |
Return Pin index given subchannel index and local neighbor index. More... | |
virtual const Real & | getWireDiameter () const |
Return wire diameter. More... | |
virtual const Real & | getFlatToFlat () const |
Return flat to flat [m]. More... | |
virtual const Real & | getWireLeadLength () const |
Return the wire lead length. More... | |
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 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 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 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 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 |
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::pair< unsigned int, unsigned int > & | getSweepFlowGaps (unsigned int i_chan) const |
virtual const std::pair< unsigned int, unsigned int > & | getSweepFlowChans (unsigned int i_chan) const |
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 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 |
void | setChannelToDuctMaps (const std::vector< Node *> &duct_nodes) |
Function that gets the channel node from the duct node. More... | |
virtual Node * | getChanNodeFromDuct (Node *duct_node) override |
Function that gets the channel node from the duct node. More... | |
virtual Node * | getDuctNodeFromChannel (Node *channel_node) override |
Function that gets the duct node from the channel node. More... | |
virtual Node * | getChannelNodeFromDuct (Node *channel_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. 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 & | getPitch () const |
Return the pitch between 2 subchannels. 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 |
Static Public Member Functions | |
static InputParameters | validParams () |
static void | rodPositions (std::vector< Point > &positions, unsigned int nrings, Real pitch, Point center) |
Calculates and stores the pin positions/centers for a hexagonal assembly containing the given number of rings in a triangular/alternating row grid spaced 'pitch' apart. 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 |
Static Public Attributes | |
static const unsigned int | N_CORNERS = 6 |
number of corners in the duct x-sec More... | |
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 | _n_rings |
number of rings of fuel pins More... | |
unsigned int | _n_channels |
number of subchannels More... | |
Real | _flat_to_flat |
the distance between flat surfaces of the duct facing each other More... | |
Real | _dwire |
wire diameter More... | |
Real | _hwire |
wire lead length More... | |
Real | _duct_to_pin_gap |
the gap thickness between the duct and peripheral fuel pins More... | |
std::vector< std::vector< Node * > > | _nodes |
nodes More... | |
std::vector< std::vector< Node * > > | _pin_nodes |
pin nodes More... | |
std::vector< Node * > | _duct_nodes |
A list of all mesh nodes that form the (elements of) the hexagonal duct mesh that surrounds the pins/subchannels. More... | |
std::map< Node *, Node * > | _chan_to_duct_node_map |
A map for providing the closest/corresponding duct node associated with each subchannel node. More... | |
std::map< Node *, Node * > | _duct_node_to_chan_map |
A map for providing the closest/corresponding subchannel node associated with each duct node. More... | |
std::vector< std::pair< unsigned int, unsigned int > > | _gap_to_chan_map |
stores the channel pairs for each gap More... | |
std::vector< std::pair< unsigned int, unsigned int > > | _gap_to_pin_map |
stores the fuel pins belonging to each gap More... | |
std::vector< std::vector< unsigned int > > | _chan_to_gap_map |
stores the gaps that forms each subchannel More... | |
std::vector< std::vector< Real > > | _sign_id_crossflow_map |
Defines the global cross-flow direction -1 or 1 for each subchannel and for all gaps that are belonging to the corresponding subchannel. More... | |
std::vector< std::vector< Real > > | _gij_map |
gap size More... | |
std::vector< Point > | _pin_position |
x,y coordinates of the fuel pins More... | |
std::vector< std::vector< Real > > | _pins_in_rings |
fuel pins that are belonging to each ring More... | |
std::vector< std::vector< unsigned int > > | _chan_to_pin_map |
stores the fuel pins belonging to each subchannel More... | |
unsigned int | _npins |
number of fuel pins More... | |
unsigned int | _n_gaps |
number of gaps More... | |
std::vector< EChannelType > | _subch_type |
subchannel type More... | |
std::vector< EChannelType > | _gap_type |
gap type More... | |
std::vector< std::pair< unsigned int, unsigned int > > | _gap_pairs_sf |
sweeping flow model gap pairs per channel to specify directional edge flow More... | |
std::vector< std::pair< unsigned int, unsigned int > > | _chan_pairs_sf |
sweeping flow model channel pairs to specify directional edge flow More... | |
std::vector< std::vector< unsigned int > > | _pin_to_chan_map |
TODO: channel indices corresponding to a given pin index. More... | |
bool | _pin_mesh_exist |
Flag that informs the solver whether there is a Pin Mesh or not. More... | |
bool | _duct_mesh_exist |
Flag that informs the solver whether there is a Duct 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 | SCMTriSubChannelMeshGenerator |
class | SCMTriDuctMeshGenerator |
class | SCMTriPinMeshGenerator |
class | SCMDetailedTriPinMeshGenerator |
class | TriSubChannel1PhaseProblem |
Mesh class for triangular, edge and corner subchannels for hexagonal lattice fuel assemblies.
Definition at line 17 of file TriSubChannelMesh.h.
TriSubChannelMesh::TriSubChannelMesh | ( | const InputParameters & | parameters | ) |
Definition at line 25 of file TriSubChannelMesh.C.
TriSubChannelMesh::TriSubChannelMesh | ( | const TriSubChannelMesh & | other_mesh | ) |
Definition at line 30 of file TriSubChannelMesh.C.
|
overridevirtual |
|
overridevirtual |
Function that returns the subchannel index given a point Determining a channel index given a point Looping over all subchannels to determine the closest one to the point Special treatment for edge and corner subchannels since deformed elements may lead to wrong transfers
Implements SubChannelMesh.
Definition at line 77 of file TriSubChannelMesh.C.
Referenced by getSubchannelIndexFromPoint().
|
inlineoverridevirtual |
Return if Duct Mesh exists or not.
Implements SubChannelMesh.
Definition at line 33 of file TriSubChannelMesh.h.
|
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 85 of file TriSubChannelMesh.h.
|
inlineoverridevirtual |
Get the subchannel mesh node for a given channel index and elevation index.
Implements SubChannelMesh.
Definition at line 69 of file TriSubChannelMesh.h.
|
inlineoverridevirtual |
Function that gets the channel node from the duct node.
Implements SubChannelMesh.
Definition at line 151 of file TriSubChannelMesh.h.
|
inlineoverridevirtual |
Return a vector of pin indices for a given channel index.
Implements SubChannelMesh.
Definition at line 122 of file TriSubChannelMesh.h.
Referenced by SCMTriPowerAux::computeValue(), and SCMTriPowerIC::value().
|
inlineoverridevirtual |
Function that gets the channel node from the duct node.
Implements SubChannelMesh.
Definition at line 135 of file TriSubChannelMesh.h.
|
inlineoverridevirtual |
Return a sign for the crossflow given a subchannel index and local neighbor index.
Implements SubChannelMesh.
Definition at line 89 of file TriSubChannelMesh.h.
|
inlineoverridevirtual |
Function that gets the duct node from the channel node.
Implements SubChannelMesh.
Definition at line 143 of file TriSubChannelMesh.h.
|
inlineoverridevirtual |
Function that return the vector with the maps to the nodes.
Implements SubChannelMesh.
Definition at line 159 of file TriSubChannelMesh.h.
|
inlinevirtual |
Return the the gap thickness between the duct and peripheral fuel pins.
Definition at line 38 of file TriSubChannelMesh.h.
Referenced by TriSubChannel1PhaseProblem::computeFrictionFactor(), TriSubChannel1PhaseProblem::computeh(), TriSubChannel1PhaseProblem::initializeSolution(), SCMTriWettedPerimIC::value(), MarvelTriWettedPerimIC::value(), SCMTriFlowAreaIC::value(), and MarvelTriFlowAreaIC::value().
|
inlinevirtual |
Return flat to flat [m].
Definition at line 62 of file TriSubChannelMesh.h.
Referenced by TriSubChannel1PhaseProblem::initializeSolution().
|
inlineoverridevirtual |
Return a pair of subchannel indices for a given gap index.
Implements SubChannelMesh.
Definition at line 76 of file TriSubChannelMesh.h.
|
inlineoverridevirtual |
Return a pair of pin indices for a given gap index.
Implements SubChannelMesh.
Definition at line 81 of file TriSubChannelMesh.h.
|
inlineoverridevirtual |
Return gap width for a given gap index.
Implements SubChannelMesh.
Definition at line 102 of file TriSubChannelMesh.h.
|
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(), SCMQuadPowerAux::initialSetup(), SCMTriPowerIC::initialSetup(), SCMTriPowerAux::initialSetup(), QuadSubChannelNormalSliceValues::output(), and SubChannel1PhaseProblem::SubChannel1PhaseProblem().
|
inlineoverridevirtual |
Return the number of channels per layer.
Implements SubChannelMesh.
Definition at line 73 of file TriSubChannelMesh.h.
|
inlineoverridevirtual |
Return the number of gaps per layer.
Implements SubChannelMesh.
Definition at line 74 of file TriSubChannelMesh.h.
|
inlineoverridevirtual |
Return the number of pins.
Implements SubChannelMesh.
Definition at line 25 of file TriSubChannelMesh.h.
Referenced by SCMTriPowerAux::initialSetup(), SCMTriPowerIC::initialSetup(), SCMTriPowerAux::SCMTriPowerAux(), and SCMTriPowerIC::SCMTriPowerIC().
|
inlinevirtual |
Return the number of rings.
Definition at line 43 of file TriSubChannelMesh.h.
Referenced by TriSubChannel1PhaseProblem::initializeSolution().
|
inlineoverridevirtual |
Return a vector of channel indices for a given Pin index.
Implements SubChannelMesh.
Definition at line 117 of file TriSubChannelMesh.h.
|
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().
|
inlinevirtual |
Return Pin index given subchannel index and local neighbor index.
Definition at line 48 of file TriSubChannelMesh.h.
|
overridevirtual |
Return a pin index for a given physical point p
Function that returns the pin number given a point
Implements SubChannelMesh.
Definition at line 165 of file TriSubChannelMesh.C.
Referenced by SCMTriPowerAux::computeValue(), and SCMTriPowerIC::value().
|
inlineoverridevirtual |
Get the pin mesh node for a given pin index and elevation index.
Implements SubChannelMesh.
Definition at line 27 of file TriSubChannelMesh.h.
|
inlinevirtualinherited |
Return the pitch between 2 subchannels.
Reimplemented in QuadSubChannelMesh.
Definition at line 144 of file SubChannelMesh.h.
Referenced by TriSubChannel1PhaseProblem::computeBeta(), TriSubChannel1PhaseProblem::computeFrictionFactor(), TriSubChannel1PhaseProblem::computeh(), SubChannel1PhaseProblem::computeWijResidual(), TriSubChannel1PhaseProblem::initializeSolution(), MarvelTriWettedPerimIC::value(), SCMTriWettedPerimIC::value(), FCTFdisplacementIC::value(), SCMTriFlowAreaIC::value(), and MarvelTriFlowAreaIC::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
Function that returns the subchannel index given a point
Implements SubChannelMesh.
Definition at line 70 of file TriSubChannelMesh.C.
Referenced by SCMTriPowerAux::computeValue(), MarvelTriWettedPerimIC::value(), SCMTriWettedPerimIC::value(), FCTFdisplacementIC::value(), SCMTriPowerIC::value(), MarvelTriFlowAreaIC::value(), and SCMTriFlowAreaIC::value().
|
inlineoverridevirtual |
Return the type of the subchannel for given subchannel index.
Implements SubChannelMesh.
Definition at line 97 of file TriSubChannelMesh.h.
Referenced by SCMTriPowerAux::computeValue(), MarvelTriWettedPerimIC::value(), SCMTriWettedPerimIC::value(), FCTFdisplacementIC::value(), SCMTriPowerIC::value(), MarvelTriFlowAreaIC::value(), and SCMTriFlowAreaIC::value().
|
inlinevirtual |
Definition at line 112 of file TriSubChannelMesh.h.
Referenced by TriSubChannel1PhaseProblem::computeh().
|
inlinevirtual |
Definition at line 107 of file TriSubChannelMesh.h.
|
inlinevirtual |
Return wire diameter.
Definition at line 57 of file TriSubChannelMesh.h.
Referenced by TriSubChannel1PhaseProblem::computeBeta(), TriSubChannel1PhaseProblem::computeFrictionFactor(), TriSubChannel1PhaseProblem::computeh(), TriSubChannel1PhaseProblem::initializeSolution(), SCMTriWettedPerimIC::value(), MarvelTriWettedPerimIC::value(), SCMTriFlowAreaIC::value(), and MarvelTriFlowAreaIC::value().
|
inlinevirtual |
Return the wire lead length.
Definition at line 67 of file TriSubChannelMesh.h.
Referenced by TriSubChannel1PhaseProblem::computeBeta(), TriSubChannel1PhaseProblem::computeFrictionFactor(), TriSubChannel1PhaseProblem::computeh(), TriSubChannel1PhaseProblem::initializeSolution(), SCMTriWettedPerimIC::value(), MarvelTriWettedPerimIC::value(), SCMTriFlowAreaIC::value(), and MarvelTriFlowAreaIC::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(), SCMTriPowerAux::initialSetup(), SCMQuadPowerAux::initialSetup(), SCMTriPowerIC::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 |
Function that returns the pin number given a point
Implements SubChannelMesh.
Definition at line 173 of file TriSubChannelMesh.C.
Referenced by getPinIndexFromPoint().
|
inlineoverridevirtual |
Return if Pin Mesh exists or not.
Implements SubChannelMesh.
Definition at line 32 of file TriSubChannelMesh.h.
Referenced by SCMTriPowerAux::computeValue(), and SCMTriPowerIC::value().
|
static |
Calculates and stores the pin positions/centers for a hexagonal assembly containing the given number of rings in a triangular/alternating row grid spaced 'pitch' apart.
The points are generated such that the duct is centered at the given center point.
Defining parameters
Definition at line 201 of file TriSubChannelMesh.C.
Referenced by SCMDetailedTriPinMeshGenerator::generate(), SCMTriPinMeshGenerator::generate(), pinIndex(), SCMDetailedTriSubChannelMeshGenerator::SCMDetailedTriSubChannelMeshGenerator(), SCMTriSubChannelMeshGenerator::SCMTriSubChannelMeshGenerator(), and TEST().
|
overridevirtual |
Implements MooseMesh.
Definition at line 64 of file TriSubChannelMesh.C.
void TriSubChannelMesh::setChannelToDuctMaps | ( | const std::vector< Node *> & | duct_nodes | ) |
Function that gets the channel node from the duct node.
Definition at line 268 of file TriSubChannelMesh.C.
Referenced by SCMTriDuctMeshGenerator::generate().
|
static |
Definition at line 17 of file TriSubChannelMesh.C.
|
friend |
Definition at line 242 of file TriSubChannelMesh.h.
|
friend |
Definition at line 240 of file TriSubChannelMesh.h.
|
friend |
Definition at line 241 of file TriSubChannelMesh.h.
|
friend |
Definition at line 239 of file TriSubChannelMesh.h.
|
friend |
Definition at line 243 of file TriSubChannelMesh.h.
sweeping flow model channel pairs to specify directional edge flow
Definition at line 219 of file TriSubChannelMesh.h.
Referenced by getSweepFlowChans().
|
protected |
A map for providing the closest/corresponding duct node associated with each subchannel node.
i.e. a map of subchannel mesh nodes to duct mesh nodes.
Definition at line 184 of file TriSubChannelMesh.h.
Referenced by getDuctNodeFromChannel(), and setChannelToDuctMaps().
|
protected |
stores the gaps that forms each subchannel
Definition at line 194 of file TriSubChannelMesh.h.
Referenced by getChannelGaps().
|
protected |
stores the fuel pins belonging to each subchannel
Definition at line 207 of file TriSubChannelMesh.h.
Referenced by getChannelPins(), and getPinIndex().
|
protected |
Flag that informs the solver whether there is a Duct Mesh or not.
Definition at line 225 of file TriSubChannelMesh.h.
Referenced by ductMeshExist().
|
protected |
A map for providing the closest/corresponding subchannel node associated with each duct node.
i.e. a map of duct mesh nodes to subchannel mesh nodes.
Definition at line 187 of file TriSubChannelMesh.h.
Referenced by getChannelNodeFromDuct(), getChanNodeFromDuct(), and setChannelToDuctMaps().
|
protected |
A list of all mesh nodes that form the (elements of) the hexagonal duct mesh that surrounds the pins/subchannels.
Definition at line 181 of file TriSubChannelMesh.h.
Referenced by getDuctNodes(), and setChannelToDuctMaps().
|
protected |
the gap thickness between the duct and peripheral fuel pins
Definition at line 173 of file TriSubChannelMesh.h.
Referenced by channelIndex(), and getDuctToPinGap().
|
protected |
|
protected |
the distance between flat surfaces of the duct facing each other
Definition at line 167 of file TriSubChannelMesh.h.
Referenced by channelIndex(), and getFlatToFlat().
sweeping flow model gap pairs per channel to specify directional edge flow
Definition at line 217 of file TriSubChannelMesh.h.
Referenced by getSweepFlowGaps().
stores the channel pairs for each gap
Definition at line 190 of file TriSubChannelMesh.h.
Referenced by getGapChannels().
stores the fuel pins belonging to each gap
Definition at line 192 of file TriSubChannelMesh.h.
Referenced by getGapPins().
|
protected |
gap type
Definition at line 215 of file TriSubChannelMesh.h.
|
protected |
gap size
Definition at line 201 of file TriSubChannelMesh.h.
Referenced by getGapWidth(), and TriSubChannel1PhaseProblem::initializeSolution().
|
protectedinherited |
heated length of the fuel Pin
Definition at line 204 of file SubChannelMesh.h.
Referenced by SubChannelMesh::getHeatedLength().
|
protected |
wire lead length
Definition at line 171 of file TriSubChannelMesh.h.
Referenced by getWireLeadLength().
|
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
Definition at line 165 of file TriSubChannelMesh.h.
Referenced by channelIndex(), and getNumOfChannels().
|
protected |
number of gaps
Definition at line 211 of file TriSubChannelMesh.h.
Referenced by getNumOfGapsPerLayer().
|
protected |
number of rings of fuel pins
Definition at line 163 of file TriSubChannelMesh.h.
Referenced by channelIndex(), getNumOfRings(), and pinIndex().
|
protected |
nodes
Definition at line 175 of file TriSubChannelMesh.h.
Referenced by getChannelNode(), and setChannelToDuctMaps().
|
protected |
number of fuel pins
Definition at line 209 of file TriSubChannelMesh.h.
Referenced by getNumOfPins(), and pinIndex().
|
protectedinherited |
fuel Pin diameter
Definition at line 226 of file SubChannelMesh.h.
Referenced by channelIndex(), and SubChannelMesh::getPinDiameter().
|
protected |
Flag that informs the solver whether there is a Pin Mesh or not.
Definition at line 223 of file TriSubChannelMesh.h.
Referenced by pinMeshExist().
|
protected |
pin nodes
Definition at line 177 of file TriSubChannelMesh.h.
Referenced by SCMTriPinMeshGenerator::generate(), and getPinNode().
|
protected |
x,y coordinates of the fuel pins
Definition at line 203 of file TriSubChannelMesh.h.
|
protected |
TODO: channel indices corresponding to a given pin index.
Definition at line 221 of file TriSubChannelMesh.h.
Referenced by getPinChannels().
|
protected |
fuel pins that are belonging to each ring
Definition at line 205 of file TriSubChannelMesh.h.
|
protectedinherited |
Distance between the neighbor fuel pins, pitch.
Definition at line 224 of file SubChannelMesh.h.
Referenced by QuadSubChannelMesh::channelIndex(), channelIndex(), QuadSubChannelMesh::getPinIndexFromPoint(), QuadSubChannelMesh::getPitch(), SubChannelMesh::getPitch(), QuadSubChannelMesh::getSubchannelIndexFromPoint(), QuadSubChannelMesh::pinIndex(), and pinIndex().
|
protectedinherited |
area reduction of subchannels affected by blockage
Definition at line 220 of file SubChannelMesh.h.
Referenced by SubChannelMesh::getReductionBlockage().
|
protected |
Defines the global cross-flow direction -1 or 1 for each subchannel and for all gaps that are belonging to the corresponding subchannel.
Given a subchannel and a gap, if the neighbor subchannel index belonging to the same gap is lower, set it to -1, otherwise set it to 1.
Definition at line 199 of file TriSubChannelMesh.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 213 of file TriSubChannelMesh.h.
Referenced by channelIndex(), and getSubchannelType().
|
inherited |
x,y coordinates of the subchannel centroids
Definition at line 232 of file SubChannelMesh.h.
Referenced by channelIndex(), QuadSubChannelMesh::QuadSubChannelMesh(), setChannelToDuctMaps(), SubChannelPointValue::SubChannelPointValue(), and 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().
|
static |
number of corners in the duct x-sec
Definition at line 246 of file TriSubChannelMesh.h.
Referenced by SCMTriDuctMeshGenerator::ductCorners().