FEI Package Browser (Single Doxygen Collection)
Version of the Day
|
#include <SNL_FEI_Structure.hpp>
Public Member Functions | |
SNL_FEI_Structure (MPI_Comm comm) | |
virtual | ~SNL_FEI_Structure () |
int | parameters (int numParams, const char *const *paramStrings) |
int | initFields (int numFields, const int *fieldSizes, const int *fieldIDs, const int *fieldTypes=NULL) |
int | initElemBlock (GlobalID elemBlockID, int numElements, int numNodesPerElement, const int *numFieldsPerNode, const int *const *nodalFieldIDs, int numElemDofFieldsPerElement, const int *elemDofFieldIDs, int interleaveStrategy) |
int | initElem (GlobalID elemBlockID, GlobalID elemID, const GlobalID *elemConn) |
int | initSlaveVariable (GlobalID slaveNodeID, int slaveFieldID, int offsetIntoSlaveField, int numMasterNodes, const GlobalID *masterNodeIDs, const int *masterFieldIDs, const double *weights, double rhsValue) |
int | deleteMultCRs () |
int | initSharedNodes (int numSharedNodes, const GlobalID *sharedNodeIDs, const int *numProcsPerNode, const int *const *sharingProcIDs) |
int | initCRMult (int numCRNodes, const GlobalID *CRNodes, const int *CRFields, int &CRID) |
int | initCRPen (int numCRNodes, const GlobalID *CRNodes, const int *CRFields, int &CRID) |
int | initComplete (bool generateGraph=true) |
const std::vector< int > & | getFieldIDs () const |
const int * | getFieldIDsPtr () |
const int * | getFieldSizesPtr () |
int | getNumFields () |
int | getFieldSize (int fieldID) |
fei::FieldDofMap< int > & | getFieldDofMap () |
bool | isInLocalElement (int nodeNumber) |
const int * | getNumFieldsPerNode (GlobalID blockID) |
const int *const * | getFieldIDsTable (GlobalID blockID) |
int | getEqnNumber (int nodeNumber, int fieldID) |
int | getOwnerProcForEqn (int eqn) |
int | getNumElemBlocks () |
const GlobalID * | getElemBlockIDs () |
void | getElemBlockInfo (GlobalID blockID, int &interleaveStrategy, int &lumpingStrategy, int &numElemDOF, int &numElements, int &numNodesPerElem, int &numEqnsPerElem) |
int | addBlock (GlobalID blockID) |
int | getBlockDescriptor (GlobalID blockID, BlockDescriptor *&block) |
int | getBlockDescriptor_index (int index, BlockDescriptor *&block) |
int | getIndexOfBlock (GlobalID blockID) const |
int | getBlockID (unsigned index) const |
int | allocateBlockConnectivity (GlobalID blockID) |
void | destroyConnectivityTables () |
ConnectivityTable & | getBlockConnectivity (GlobalID blockID) |
void | getScatterIndices_ID (GlobalID blockID, GlobalID elemID, int interleaveStrategy, int *scatterIndices) |
void | getScatterIndices_index (int blockIndex, int elemIndex, int interleaveStrategy, int *scatterIndices) |
int | getBlkScatterIndices_index (int blockIndex, int elemIndex, int *scatterIndices) |
void | getScatterIndices_ID (GlobalID blockID, GlobalID elemID, int interleaveStrategy, int *scatterIndices, int *blkScatterIndices, int *blkSizes) |
void | getScatterIndices_index (int blockIndex, int elemIndex, int interleaveStrategy, int *scatterIndices, int *blkScatterIndices, int *blkSizes) |
int | getNumSharedNodes () |
const int * | getSharedNodeNumbers () |
const int * | getSharedNodeProcs (int nodeNumber) |
int | getNumSharingProcs (int nodeNumber) |
int | getNumSubdomains (int nodeNumber) |
int * | getSubdomainList (int nodeNumber) |
int | translateToReducedNodeNumber (int nodeNumber, int proc) |
int | getAssociatedNodeNumber (int eqnNumber) |
int | getAssociatedFieldID (int eqnNumber) |
bool | isExactlyBlkEqn (int ptEqn) |
int | ptEqnToBlkEqn (int ptEqn) |
int | getOffsetIntoBlkEqn (int blkEqn, int ptEqn) |
int | getBlkEqnSize (int blkEqn) |
int | getNumActiveNodes () |
NodeDatabase & | getNodeDatabase () |
std::map< GlobalID, int > & | getActiveNodeIDList () |
std::vector< int > & | getGlobalNodeOffsets () |
std::vector< int > & | getGlobalEqnOffsets () |
std::vector< int > & | getGlobalBlkEqnOffsets () |
NodeCommMgr & | getNodeCommMgr () |
EqnCommMgr & | getEqnCommMgr () |
void | initializeEqnCommMgr () |
void | getEqnInfo (int &numGlobalEqns, int &numLocalEqns, int &localStartRow, int &localEndRow) |
int | getEqnNumbers (GlobalID ID, int idType, int fieldID, int &numEqns, int *eqnNumbers) |
int | getEqnNumbers (int numIDs, const GlobalID *IDs, int idType, int fieldID, int &numEqns, int *eqnNumbers) |
void | getEqnBlkInfo (int &numGlobalEqnBlks, int &numLocalEqnBlks, int &localBlkOffset) |
snl_fei::PointBlockMap & | getBlkEqnMapper () |
void | destroyMatIndices () |
int | getNumMultConstRecords () |
std::map< GlobalID, snl_fei::Constraint< GlobalID > * > & | getMultConstRecords () |
int | getMultConstRecord (int CRID, snl_fei::Constraint< GlobalID > *&multCR) |
int | getNumPenConstRecords () |
std::map< GlobalID, snl_fei::Constraint< GlobalID > * > & | getPenConstRecords () |
int | getPenConstRecord (int CRID, snl_fei::Constraint< GlobalID > *&penCR) |
void | addSlaveVariable (SlaveVariable *svar) |
int | calculateSlaveEqns (MPI_Comm comm) |
fei::FillableMat * | getSlaveDependencies () |
EqnBuffer * | getSlaveEqns () |
int | numSlaveEquations () |
bool | isSlaveEqn (int eqn) |
bool | translateToReducedEqn (int eqn, int &reducedEqn) |
int | translateToReducedEqns (EqnCommMgr &eqnCommMgr) |
int | translateToReducedEqns (EqnBuffer &eqnBuf) |
int | translateToReducedEqns (ProcEqns &procEqns) |
int | translateMatToReducedEqns (fei::CSRMat &mat) |
int | translateFromReducedEqn (int reducedEqn) |
int | getMasterEqnNumbers (int slaveEqn, std::vector< int > *&masterEqns) |
int | getMasterEqnCoefs (int slaveEqn, std::vector< double > *&masterCoefs) |
int | getMasterEqnRHS (int slaveEqn, double &rhsValue) |
int | getNumGlobalEqns () |
int | getNumLocalEqns () |
int | getFirstLocalEqn () |
int | getLastLocalEqn () |
int | getFirstReducedEqn () |
int | getLastReducedEqn () |
int | getNumGlobalEqnBlks () |
int | getNumLocalEqnBlks () |
int | getNumLocalReducedEqnBlks () |
int | getGlobalMaxBlkSize () |
int | getNumLocalReducedEqns () |
int | getMatrixRowLengths (std::vector< int > &rowLengths) |
int | getMatrixStructure (int **colIndices, std::vector< int > &rowLengths) |
int | getMatrixStructure (int **ptColIndices, std::vector< int > &ptRowLengths, int **blkColIndices, int *blkIndices_1D, std::vector< int > &blkRowLengths, std::vector< int > &numPtRowsPerBlkRow) |
int | calcTotalNumElemDOF () |
int | calcNumMultCREqns () |
MPI_Comm | getCommunicator () const |
int | setDbgOut (std::ostream &ostr, const char *path, const char *feiName) |
Public Member Functions inherited from Lookup | |
virtual | ~Lookup () |
Static Public Member Functions | |
static int | gatherSlaveEqns (MPI_Comm comm, EqnCommMgr *eqnCommMgr, EqnBuffer *slaveEqns) |
static int | removeCouplings (EqnBuffer &eqnbuf, int &levelsOfCoupling) |
Private Member Functions | |
NodeDescriptor * | findNode (GlobalID nodeID) |
NodeDescriptor & | findNodeDescriptor (GlobalID nodeID) |
int | writeEqn2NodeMap () |
int | getElemNodeDescriptors (int blockIndex, int elemIndex, NodeDescriptor **nodes) |
int | getNodeIndices_simple (NodeDescriptor **nodes, int numNodes, int fieldID, int *scatterIndices, int &offset) |
int | getNodeIndices_simple (NodeDescriptor **nodes, int numNodes, int fieldID, int *scatterIndices, int &offset, int *blkScatterIndices, int *blkSizes, int &blkOffset) |
int | getNodeMajorIndices (NodeDescriptor **nodes, int numNodes, int **fieldIDs, int *fieldsPerNode, int *scatterIndices, int &offset) |
int | getNodeBlkIndices (NodeDescriptor **nodes, int numNodes, int *scatterIndices, int &offset) |
int | getNodeMajorIndices (NodeDescriptor **nodes, int numNodes, int **fieldIDs, int *fieldsPerNode, int *scatterIndices, int &offset, int *blkScatterIndices, int *blkSizes, int &blkOffset) |
int | getNodeMajorIndices (NodeDescriptor **nodes, int numNodes, std::vector< int > *fieldIDs, std::vector< int > &fieldsPerNode, std::vector< int > &scatterIndices) |
int | getFieldMajorIndices (NodeDescriptor **nodes, int numNodes, int **fieldIDs, int *fieldsPerNode, int *scatterIndices, int &offset) |
int | getFieldMajorIndices (NodeDescriptor **nodes, int numNodes, std::vector< int > *fieldIDs, std::vector< int > &fieldsPerNode, std::vector< int > &scatterIndices) |
void | calcGlobalEqnInfo (int numLocallyOwnedNodes, int numLocalEqns, int numLocalEqnBlks) |
int | finalizeActiveNodes () |
int | finalizeNodeCommMgr () |
bool | activeNodesInitialized () |
int | formMatrixStructure () |
int | initElemBlockStructure () |
int | initMultCRStructure () |
int | initPenCRStructure () |
int | createMatrixPosition (int row, int col, const char *callingFunction) |
int | createMatrixPositions (int row, int numCols, int *cols, const char *callingFunction) |
int | createMatrixPositions (fei::CSRMat &mat) |
int | createSymmEqnStructure (std::vector< int > &scatterIndices) |
int | createBlkSymmEqnStructure (std::vector< int > &scatterIndices) |
int | storeElementScatterIndices (std::vector< int > &scatterIndices) |
int | storeElementScatterIndices_noSlaves (std::vector< int > &scatterIndices) |
int | storeElementScatterBlkIndices_noSlaves (std::vector< int > &scatterIndices) |
void | storeLocalNodeIndices (NodeDescriptor &iNode, int iField, NodeDescriptor &jNode, int jField) |
void | storeNodalColumnIndices (int eqn, NodeDescriptor &node, int fieldID) |
void | storeNodalRowIndices (NodeDescriptor &node, int fieldID, int eqn) |
void | storeNodalSendIndex (NodeDescriptor &node, int fieldID, int col) |
void | storeNodalSendIndices (NodeDescriptor &iNode, int iField, NodeDescriptor &jNode, int jField) |
int | assembleReducedStructure () |
bool | nodalEqnsAllSlaves (const NodeDescriptor *node, std::vector< int > &slaveEqns) |
int | initializeBlkEqnMapper () |
int | setNumNodesAndEqnsPerBlock () |
void | destroyBlockRoster () |
std::ostream & | dbgOut () |
void | addCR (int CRID, snl_fei::Constraint< GlobalID > *&cr, std::map< GlobalID, snl_fei::Constraint< GlobalID > * > &crDB) |
int | setNodalEqnInfo () |
void | setElemDOFEqnInfo () |
int | setMultCREqnInfo () |
SNL_FEI_Structure (const SNL_FEI_Structure &src) | |
SNL_FEI_Structure & | operator= (const SNL_FEI_Structure &src) |
The SNL_FEI_Structure class is a container for the data that makes up the structure of a finite element problem. It contains things like the FieldDatabase, NodeDatabase, ConnectivityTable, etc.
This class is the primary class that implements the general "FEI initialization phase", where the user passes all structure-defining data, which ends up being translated into a corresponding sparse matrix structure.
The problem structure is initialized gradually by calling the 'init' functions in this class. They also exist in the FEI class, where they are documented.
Once all structure-defining data has been passed, the process is completed by calling the initComplete function.
Definition at line 43 of file SNL_FEI_Structure.hpp.
SNL_FEI_Structure::SNL_FEI_Structure | ( | MPI_Comm | comm | ) |
Constructor.
comm | MPI_Communicator |
name | String by which this structure instance may be referred to. |
debugOutputLevel | Determines whether this object will produce a file containing a log of debug output information. |
path | If debugOutputLevel is not zero, the debug log file will be placed in the location specified by path. |
Definition at line 49 of file SNL_FEI_Structure.cpp.
References comm_, eqnCommMgr_, fieldDatabase_, Kdd_, Kdi_, Kid_, fei::localProc(), localProc_, masterProc_, nodeCommMgr_, nodeDatabase_, fei::numProcs(), numProcs_, EqnCommMgr::setNumRHSs(), slaveEqns_, and slaveVars_.
|
virtual |
Destructor.
Definition at line 191 of file SNL_FEI_Structure.cpp.
References blkEqnMapper_, deleteMultCRs(), destroyBlockRoster(), destroyConnectivityTables(), destroyMatIndices(), fei::destroyValues(), eqnCommMgr_, fieldDatabase_, Kdd_, Kdi_, Kid_, nodeCommMgr_, nodeDatabase_, penCRs_, slaveEqns_, slaveMatrix_, and slaveVars_.
|
private |
int SNL_FEI_Structure::parameters | ( | int | numParams, |
const char *const * | paramStrings | ||
) |
Set parameters on this object. Currently three parameters are recognized: "debugOutput 'path'" where 'path' is the path to the location where debug-log files will be produced.
"debugOutputOff" which will turn off debug-output.
"checkSharedNodes" which specifies that a 'sanity-check' should be done to make sure that the shared-node information is globally consistent, before any communication is attempted which depends on the consistency of that information.
"sharedNodeOwnership <string>" where <string> can be either LowNumberedProc or ProcWithLocalElem. LowNumberedProc specifies that the lowest-numbered sharing processor will be the owner of shared nodes, while ProcWithLocalElem specifies that ownership will be given to the proc with a local element containing the shared node, if not all sharing procs have local elements containing the shared node.
Definition at line 147 of file SNL_FEI_Structure.cpp.
References NodeCommMgr::CALLER_SPECIFIES, checkSharedNodes_, debugOutput_, FEI_ISTRINGSTREAM, snl_fei::getParam(), snl_fei::getParamValue(), nodeCommMgr_, outputLevel_, NodeCommMgr::PROC_WITH_LOCAL_ELEM, NodeCommMgr::setSharedOwnershipRule(), and NodeCommMgr::STRICTLY_LOW_PROC.
Referenced by FEI_Implementation::parameters().
int SNL_FEI_Structure::initFields | ( | int | numFields, |
const int * | fieldSizes, | ||
const int * | fieldIDs, | ||
const int * | fieldTypes = NULL |
||
) |
Definition at line 361 of file SNL_FEI_Structure.cpp.
References fei::FieldDofMap< LocalOrdinal >::add_field(), dbgOut(), debugOutput_, FEI_ENDL, FEI_OSTREAM, FEI_SUCCESS, fieldDatabase_, fieldDofMap_, fieldIDs_, fieldSizes_, and fei::sortedListInsert().
Referenced by FEI_Implementation::initFields(), test_SNL_FEI_Structure::test1(), and test_SNL_FEI_Structure::test2().
int SNL_FEI_Structure::initElemBlock | ( | GlobalID | elemBlockID, |
int | numElements, | ||
int | numNodesPerElement, | ||
const int * | numFieldsPerNode, | ||
const int *const * | nodalFieldIDs, | ||
int | numElemDofFieldsPerElement, | ||
const int * | elemDofFieldIDs, | ||
int | interleaveStrategy | ||
) |
Definition at line 409 of file SNL_FEI_Structure.cpp.
References addBlock(), allocateBlockConnectivity(), BlockDescriptor::allocateFieldIDsTable(), CHK_ERR, fei::console_out(), dbgOut(), debugOutput_, ERReturn, FEI_ENDL, FEI_OSTREAM, FEI_SUCCESS, BlockDescriptor::fieldIDsTablePtr(), BlockDescriptor::fieldsPerNodePtr(), getBlockDescriptor(), getFieldSize(), BlockDescriptor::setElemDofFieldIDs(), BlockDescriptor::setInterleaveStrategy(), BlockDescriptor::setNumBlkEqnsPerElement(), BlockDescriptor::setNumDistinctFields(), BlockDescriptor::setNumElemDOFPerElement(), BlockDescriptor::setNumElements(), BlockDescriptor::setNumEqnsPerElement(), BlockDescriptor::setNumNodesPerElement(), and fei::sortedListInsert().
Referenced by FEI_Implementation::initElemBlock(), test_SNL_FEI_Structure::test1(), and test_SNL_FEI_Structure::test2().
int SNL_FEI_Structure::initElem | ( | GlobalID | elemBlockID, |
GlobalID | elemID, | ||
const GlobalID * | elemConn | ||
) |
Definition at line 517 of file SNL_FEI_Structure.cpp.
References CHK_ERR, fei::console_out(), dbgOut(), debugOutput_, ConnectivityTable::elem_conn_ids, ConnectivityTable::elemIDs, FEI_ENDL, FEI_OSTREAM, FEI_SUCCESS, getBlockConnectivity(), getBlockDescriptor(), BlockDescriptor::getNumNodesPerElement(), NodeDatabase::initNodeIDs(), nodeDatabase_, and outputLevel_.
Referenced by FEI_Implementation::initElem(), test_SNL_FEI_Structure::test1(), and test_SNL_FEI_Structure::test2().
int SNL_FEI_Structure::initSlaveVariable | ( | GlobalID | slaveNodeID, |
int | slaveFieldID, | ||
int | offsetIntoSlaveField, | ||
int | numMasterNodes, | ||
const GlobalID * | masterNodeIDs, | ||
const int * | masterFieldIDs, | ||
const double * | weights, | ||
double | rhsValue | ||
) |
Definition at line 589 of file SNL_FEI_Structure.cpp.
References SlaveVariable::addMasterField(), SlaveVariable::addMasterNodeID(), addSlaveVariable(), SlaveVariable::addWeight(), dbgOut(), debugOutput_, ERReturn, FEI_ENDL, FEI_OSTREAM, FEI_SUCCESS, getFieldSize(), SlaveVariable::setFieldID(), SlaveVariable::setFieldOffset(), and SlaveVariable::setNodeID().
Referenced by FEI_Implementation::initSlaveVariable().
int SNL_FEI_Structure::deleteMultCRs | ( | ) |
Definition at line 657 of file SNL_FEI_Structure.cpp.
References fei::destroyValues(), and multCRs_.
Referenced by FEI_Implementation::deleteMultCRs(), and ~SNL_FEI_Structure().
int SNL_FEI_Structure::initSharedNodes | ( | int | numSharedNodes, |
const GlobalID * | sharedNodeIDs, | ||
const int * | numProcsPerNode, | ||
const int *const * | sharingProcIDs | ||
) |
Definition at line 668 of file SNL_FEI_Structure.cpp.
References activeNodesInitialized_, NodeCommMgr::addSharedNodes(), CHK_ERR, connTables_, dbgOut(), debugOutput_, FEI_ENDL, FEI_OSTREAM, FEI_SUCCESS, NodeCommMgr::informLocal(), and nodeCommMgr_.
Referenced by FEI_Implementation::initSharedNodes(), test_SNL_FEI_Structure::test1(), and test_SNL_FEI_Structure::test2().
int SNL_FEI_Structure::initCRMult | ( | int | numCRNodes, |
const GlobalID * | CRNodes, | ||
const int * | CRFields, | ||
int & | CRID | ||
) |
Definition at line 730 of file SNL_FEI_Structure.cpp.
References addCR(), dbgOut(), debugOutput_, FEI_ENDL, FEI_OSTREAM, FEI_SUCCESS, snl_fei::Constraint< RecordType >::getMasterFieldIDs(), snl_fei::Constraint< RecordType >::getMasters(), localProc_, multCRs_, and snl_fei::Constraint< RecordType >::setConstraintID().
Referenced by FEI_Implementation::initCRMult().
int SNL_FEI_Structure::initCRPen | ( | int | numCRNodes, |
const GlobalID * | CRNodes, | ||
const int * | CRFields, | ||
int & | CRID | ||
) |
Definition at line 775 of file SNL_FEI_Structure.cpp.
References addCR(), dbgOut(), debugOutput_, FEI_ENDL, FEI_OSTREAM, FEI_SUCCESS, snl_fei::Constraint< RecordType >::getMasterFieldIDs(), snl_fei::Constraint< RecordType >::getMasters(), localProc_, penCRs_, snl_fei::Constraint< RecordType >::setConstraintID(), and snl_fei::Constraint< RecordType >::setIsPenalty().
Referenced by FEI_Implementation::initCRPen().
int SNL_FEI_Structure::initComplete | ( | bool | generateGraph = true | ) |
Definition at line 845 of file SNL_FEI_Structure.cpp.
References blkEqnMapper_, blockMatrix_, calcGlobalEqnInfo(), calcNumMultCREqns(), calcTotalNumElemDOF(), calculateSlaveEqns(), CHK_ERR, comm_, fei::console_out(), NodeDatabase::countLocalNodalEqns(), NodeDatabase::countLocalNodeDescriptors(), dbgOut(), debugOutput_, eqnCommMgr_, ERReturn, EqnCommMgr::exchangeIndices(), EqnCommMgr::exchangePtToBlkInfo(), FEI_ENDL, FEI_OSTREAM, FEI_SUCCESS, finalizeActiveNodes(), finalizeNodeCommMgr(), firstLocalNodeNumber_, formMatrixStructure(), generateGraph_, globalMaxBlkSize_, initializeBlkEqnMapper(), initializeEqnCommMgr(), isSlaveEqn(), localEndRow_, localProc_, localReducedBlkOffset_, localStartRow_, matIndicesDestroyed_, nodeDatabase_, numLocalElemDOF_, numLocalEqnBlks_, numLocalEqns_, numLocalMultCRs_, numLocalNodalEqns_, numLocalReducedEqnBlks_, numLocalReducedRows_, numSlvs_, ptEqnToBlkEqn(), reducedEndRow_, reducedStartRow_, setElemDOFEqnInfo(), setMultCREqnInfo(), setNodalEqnInfo(), setNumNodesAndEqnsPerBlock(), EqnCommMgr::setNumRHSs(), slvCommMgr_, structureFinalized_, NodeDatabase::synchronize(), sysBlkMatIndices_, sysMatIndices_, translateToReducedEqn(), and writeEqn2NodeMap().
Referenced by FEI_Implementation::initComplete(), test_SNL_FEI_Structure::test1(), and test_SNL_FEI_Structure::test2().
|
inline |
Definition at line 122 of file SNL_FEI_Structure.hpp.
References fieldIDs_.
Referenced by Filter::calculateResidualNorms().
|
inlinevirtual |
implementation of Lookup::getFieldIDsPtr
Implements Lookup.
Definition at line 126 of file SNL_FEI_Structure.hpp.
References fieldDatabase_, and workarray_.
Referenced by initializeBlkEqnMapper(), and FEDataFilter::residualNorm().
|
inlinevirtual |
implementation of Lookup::getFieldSizesPtr
Implements Lookup.
Definition at line 137 of file SNL_FEI_Structure.hpp.
References fieldDatabase_, and workarray_.
|
inlinevirtual |
implementation of Lookup::getNumFields
Implements Lookup.
Definition at line 148 of file SNL_FEI_Structure.hpp.
References fieldDatabase_.
Referenced by FEDataFilter::residualNorm().
|
inlinevirtual |
implementation of Lookup::getFieldSize
Implements Lookup.
Definition at line 151 of file SNL_FEI_Structure.hpp.
References fieldDatabase_.
Referenced by Filter::calculateResidualNorms(), calculateSlaveEqns(), FEDataFilter::generalElemInput(), FEDataFilter::getBlockFieldNodeSolution(), LinSysCoreFilter::getBlockFieldNodeSolution(), FEDataFilter::getBlockNodeSolution(), LinSysCoreFilter::getBlockNodeSolution(), getEqnNumbers(), getFieldMajorIndices(), FEI_Implementation::getFieldSize(), FEDataFilter::getNodalFieldSolution(), LinSysCoreFilter::getNodalFieldSolution(), FEDataFilter::getNodalSolution(), LinSysCoreFilter::getNodalSolution(), getNodeIndices_simple(), getNodeMajorIndices(), initElemBlock(), initializeEqnCommMgr(), FEDataFilter::initLinSysCore(), LinSysCoreFilter::initLinSysCore(), initSlaveVariable(), LinSysCoreFilter::loadCRMult(), LinSysCoreFilter::loadCRPen(), FEDataFilter::loadFEDataMultCR(), FEDataFilter::loadFEDataPenCR(), FEDataFilter::loadNodeBCs(), LinSysCoreFilter::loadNodeBCs(), nodalEqnsAllSlaves(), FEDataFilter::putBlockFieldNodeSolution(), LinSysCoreFilter::putBlockFieldNodeSolution(), FEDataFilter::putBlockNodeSolution(), LinSysCoreFilter::putBlockNodeSolution(), FEDataFilter::putIntoRHS(), LinSysCoreFilter::putIntoRHS(), FEDataFilter::putNodalFieldData(), LinSysCoreFilter::putNodalFieldData(), FEDataFilter::putNodalFieldSolution(), LinSysCoreFilter::putNodalFieldSolution(), LinSysCoreFilter::resolveConflictingCRs(), setNodalEqnInfo(), setNumNodesAndEqnsPerBlock(), storeLocalNodeIndices(), storeNodalColumnIndices(), storeNodalRowIndices(), LinSysCoreFilter::storeNodalSendEqn(), storeNodalSendIndex(), storeNodalSendIndices(), FEDataFilter::sumIntoMatrixDiagonal(), FEDataFilter::sumIntoRHS(), LinSysCoreFilter::sumIntoRHS(), test_SNL_FEI_Structure::test1(), and writeEqn2NodeMap().
|
inline |
Definition at line 159 of file SNL_FEI_Structure.hpp.
References fieldDofMap_.
Referenced by FEDataFilter::enforceEssentialBCs(), FEDataFilter::generalElemInput(), FEDataFilter::getNodalFieldSolution(), FEDataFilter::getReducedSolnEntry(), FEDataFilter::giveToLocalReducedMatrix(), FEDataFilter::giveToLocalReducedRHS(), FEDataFilter::giveToMatrix(), FEDataFilter::giveToRHS(), FEDataFilter::initLinSysCore(), FEDataFilter::loadFEDataMultCR(), FEDataFilter::loadFEDataPenCR(), and FEDataFilter::sumIntoMatrixDiagonal().
|
virtual |
implementation of Lookup::isInLocalElement
Implements Lookup.
Definition at line 811 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), NodeDescriptor::getGlobalNodeID(), NodeCommMgr::getLocalNodeIDs(), NodeDatabase::getNodeWithNumber(), NodeCommMgr::getSharedNodeIndex(), nodeCommMgr_, nodeDatabase_, and numProcs_.
Referenced by FEDataFilter::getReducedSolnEntry().
|
virtual |
Given a blockID, return a pointer to a list (of length numNodesPerElem) of numFieldsPerNode.
blockID | identifier of the elem-block in question |
Implements Lookup.
Definition at line 277 of file SNL_FEI_Structure.cpp.
References BlockDescriptor::fieldsPerNodePtr(), and getBlockDescriptor().
|
virtual |
Given a blockID, return a pointer to a table, (num-rows == numNodesPerElem, row-length[i] == fieldsPerNode[i]) containing the fieldIDs at each node of elements in that element-block.
blockID | identifier of the elem-block in question |
Implements Lookup.
Definition at line 287 of file SNL_FEI_Structure.cpp.
References BlockDescriptor::fieldIDsTablePtr(), and getBlockDescriptor().
|
virtual |
Given a nodeNumber/fieldID pair, return the associated first equation- number.
Implements Lookup.
Definition at line 322 of file SNL_FEI_Structure.cpp.
References CHK_ERR, fei::console_out(), ERReturn, FEI_ENDL, NodeDescriptor::getFieldEqnNumber(), NodeDatabase::getNodeWithNumber(), nodeDatabase_, and translateToReducedEqn().
int SNL_FEI_Structure::getOwnerProcForEqn | ( | int | eqn | ) |
Given a global equation number, return the processor on which that equation resides.
eqn | Global 0-based equation number. |
Definition at line 347 of file SNL_FEI_Structure.cpp.
References globalEqnOffsets_.
Referenced by calculateSlaveEqns(), createBlkSymmEqnStructure(), createSymmEqnStructure(), LinSysCoreFilter::getFromMatrix(), LinSysCoreFilter::getFromRHS(), storeElementScatterBlkIndices_noSlaves(), storeElementScatterIndices(), and storeElementScatterIndices_noSlaves().
|
inlinevirtual |
Return the number of element-blocks in the (local) finite-element problem.
Implements Lookup.
Definition at line 187 of file SNL_FEI_Structure.hpp.
References blockIDs_.
Referenced by FEDataFilter::allocElemStuff(), LinSysCoreFilter::allocElemStuff(), calcTotalNumElemDOF(), FEI_Implementation::getNumElemBlocks(), initElemBlockStructure(), initializeBlkEqnMapper(), FEDataFilter::initLinSysCore(), LinSysCoreFilter::initLinSysCore(), FEDataFilter::loadFEDataPenCR(), and setElemDOFEqnInfo().
|
inlinevirtual |
Return a pointer to the list (of length numElemBlocks) containing the element-block identifiers for the (local) finite-element problem.
Implements Lookup.
Definition at line 188 of file SNL_FEI_Structure.hpp.
References blockIDs_.
|
virtual |
Given a blockID, provide several pieces of element-block information.
interleaveStrategy | element-equation ordering: 0 => node-major, 1 => field-major |
lumpingStrategy | element-matrices may be lumped if they're mass matrices, 0 => not lumped, 1 => lumped |
numElemDOF | number of element-dof at each element in this block |
numElements | number of elements in this block |
numNodesPerElem | number of nodes connected to each element in this block |
numEqnsPerElem | number of scalar equations at each element in this block |
Implements Lookup.
Definition at line 297 of file SNL_FEI_Structure.cpp.
References getBlockDescriptor(), BlockDescriptor::getInterleaveStrategy(), BlockDescriptor::getLumpingStrategy(), BlockDescriptor::getNumElemDOFPerElement(), BlockDescriptor::getNumElements(), BlockDescriptor::getNumEqnsPerElement(), and BlockDescriptor::getNumNodesPerElement().
int SNL_FEI_Structure::addBlock | ( | GlobalID | blockID | ) |
Definition at line 2804 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), blockIDs_, blocks_, connTables_, FEI_SUCCESS, and BlockDescriptor::setGlobalBlockID().
Referenced by initElemBlock().
int SNL_FEI_Structure::getBlockDescriptor | ( | GlobalID | blockID, |
BlockDescriptor *& | block | ||
) |
Definition at line 2829 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), blockIDs_, blocks_, fei::console_out(), FEI_ENDL, and FEI_SUCCESS.
Referenced by FEDataFilter::generalElemInput(), LinSysCoreFilter::generalElemInput(), FEDataFilter::getBlockElemSolution(), LinSysCoreFilter::getBlockElemSolution(), FEDataFilter::getBlockFieldNodeSolution(), LinSysCoreFilter::getBlockFieldNodeSolution(), FEDataFilter::getBlockNodeSolution(), LinSysCoreFilter::getBlockNodeSolution(), getElemBlockInfo(), getFieldIDsTable(), FEI_Implementation::getNumBlockActEqns(), FEI_Implementation::getNumBlockActNodes(), FEI_Implementation::getNumBlockElemDOF(), FEI_Implementation::getNumBlockElements(), FEI_Implementation::getNumEqnsPerElement(), getNumFieldsPerNode(), FEI_Implementation::getNumNodesPerElement(), initElem(), initElemBlock(), FEDataFilter::putBlockElemSolution(), LinSysCoreFilter::putBlockElemSolution(), FEDataFilter::putBlockFieldNodeSolution(), LinSysCoreFilter::putBlockFieldNodeSolution(), FEDataFilter::putBlockNodeSolution(), LinSysCoreFilter::putBlockNodeSolution(), FEDataFilter::sumInElem(), LinSysCoreFilter::sumInElem(), FEDataFilter::sumInElemMatrix(), LinSysCoreFilter::sumInElemMatrix(), FEDataFilter::sumInElemRHS(), and LinSysCoreFilter::sumInElemRHS().
int SNL_FEI_Structure::getBlockDescriptor_index | ( | int | index, |
BlockDescriptor *& | block | ||
) |
Given an index, return the corresponding block-descriptor.
Definition at line 2853 of file SNL_FEI_Structure.cpp.
References blockIDs_, blocks_, ERReturn, FEI_FATAL_ERROR, and FEI_SUCCESS.
Referenced by FEDataFilter::allocElemStuff(), LinSysCoreFilter::allocElemStuff(), calcTotalNumElemDOF(), initElemBlockStructure(), initializeBlkEqnMapper(), FEDataFilter::initLinSysCore(), LinSysCoreFilter::initLinSysCore(), and setElemDOFEqnInfo().
int SNL_FEI_Structure::getIndexOfBlock | ( | GlobalID | blockID | ) | const |
Given a blockID, return its index. Returns -1 if blockID not found.
Definition at line 2846 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), and blockIDs_.
Referenced by NodeCommMgr::exchangeSharedRemoteFieldsBlks(), finalizeActiveNodes(), FEDataFilter::generalElemInput(), FEI_Implementation::getBlockNodeIDList(), NodeCommMgr::processRecvMessage(), FEDataFilter::putBlockNodeSolution(), and LinSysCoreFilter::putBlockNodeSolution().
|
inline |
Given an index, return a blockID. Returns -1 if index out of range.
Definition at line 207 of file SNL_FEI_Structure.hpp.
References blockIDs_.
Referenced by NodeCommMgr::packLocalNodesAndData(), and NodeCommMgr::packRemoteNodesAndData().
int SNL_FEI_Structure::allocateBlockConnectivity | ( | GlobalID | blockID | ) |
Definition at line 2864 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), blockIDs_, blocks_, comm_, connTables_, fei::console_out(), FEI_ENDL, FEI_SUCCESS, and MPI_Abort.
Referenced by initElemBlock().
void SNL_FEI_Structure::destroyConnectivityTables | ( | ) |
Definition at line 254 of file SNL_FEI_Structure.cpp.
References blockIDs_, and connTables_.
Referenced by ~SNL_FEI_Structure().
ConnectivityTable & SNL_FEI_Structure::getBlockConnectivity | ( | GlobalID | blockID | ) |
Definition at line 2895 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), blockIDs_, comm_, connTables_, fei::console_out(), FEI_ENDL, and MPI_Abort.
Referenced by LinSysCoreFilter::getBlockElemSolution(), initElem(), initElemBlockStructure(), FEDataFilter::initLinSysCore(), LinSysCoreFilter::initLinSysCore(), and LinSysCoreFilter::putBlockElemSolution().
void SNL_FEI_Structure::getScatterIndices_ID | ( | GlobalID | blockID, |
GlobalID | elemID, | ||
int | interleaveStrategy, | ||
int * | scatterIndices | ||
) |
Definition at line 3766 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), blockIDs_, connTables_, fei::console_out(), FEI_ENDL, and getScatterIndices_index().
Referenced by LinSysCoreFilter::generalElemInput().
void SNL_FEI_Structure::getScatterIndices_index | ( | int | blockIndex, |
int | elemIndex, | ||
int | interleaveStrategy, | ||
int * | scatterIndices | ||
) |
Definition at line 3851 of file SNL_FEI_Structure.cpp.
References blocks_, fei::console_out(), FEI_ENDL, fieldDatabase_, BlockDescriptor::fieldIDsTablePtr(), BlockDescriptor::fieldsPerNodePtr(), getElemNodeDescriptors(), getFieldMajorIndices(), getNodeIndices_simple(), getNodeMajorIndices(), BlockDescriptor::getNumNodesPerElement(), and work_nodePtrs_.
Referenced by getScatterIndices_ID(), and initElemBlockStructure().
int SNL_FEI_Structure::getBlkScatterIndices_index | ( | int | blockIndex, |
int | elemIndex, | ||
int * | scatterIndices | ||
) |
Definition at line 3831 of file SNL_FEI_Structure.cpp.
References blocks_, fei::console_out(), ERReturn, FEI_ENDL, getElemNodeDescriptors(), getNodeBlkIndices(), BlockDescriptor::getNumNodesPerElement(), and work_nodePtrs_.
void SNL_FEI_Structure::getScatterIndices_ID | ( | GlobalID | blockID, |
GlobalID | elemID, | ||
int | interleaveStrategy, | ||
int * | scatterIndices, | ||
int * | blkScatterIndices, | ||
int * | blkSizes | ||
) |
Definition at line 3797 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), blockIDs_, connTables_, fei::console_out(), FEI_ENDL, and getScatterIndices_index().
void SNL_FEI_Structure::getScatterIndices_index | ( | int | blockIndex, |
int | elemIndex, | ||
int | interleaveStrategy, | ||
int * | scatterIndices, | ||
int * | blkScatterIndices, | ||
int * | blkSizes | ||
) |
Definition at line 3909 of file SNL_FEI_Structure.cpp.
References blocks_, fei::console_out(), FEI_ENDL, fieldDatabase_, BlockDescriptor::fieldIDsTablePtr(), BlockDescriptor::fieldsPerNodePtr(), getElemNodeDescriptors(), getFieldMajorIndices(), getNodeIndices_simple(), getNodeMajorIndices(), BlockDescriptor::getNumNodesPerElement(), and work_nodePtrs_.
|
inlinevirtual |
Return the number of local nodes that are shared by multiple processors
Implements Lookup.
Definition at line 246 of file SNL_FEI_Structure.hpp.
References NodeCommMgr::getNumSharedNodes(), and nodeCommMgr_.
|
inlinevirtual |
Return a pointer to the list of shared nodeNumbers
Implements Lookup.
Definition at line 248 of file SNL_FEI_Structure.hpp.
References NodeCommMgr::getSharedNodeNumbers(), and nodeCommMgr_.
|
inlinevirtual |
Given a shared nodeNumber, return a pointer to the list of sharing procs.
nodeNumber | The subject of the query. Function returns NULL if 'nodeNumber' is not a shared node. |
Implements Lookup.
Definition at line 252 of file SNL_FEI_Structure.hpp.
References NodeCommMgr::getSharedNodeIndex_num(), NodeCommMgr::getSharedNodeProcs(), and nodeCommMgr_.
|
inlinevirtual |
Given a shared nodeNumber, return the number of processors that share it.
nodeNumber | Function returns -1 if 'nodeNumber' is not a shared node. |
Implements Lookup.
Definition at line 258 of file SNL_FEI_Structure.hpp.
References NodeCommMgr::getSharedNodeIndex_num(), NodeCommMgr::getSharedNodeProcs(), and nodeCommMgr_.
|
inlinevirtual |
Given a nodeNumber, return the number of subdomains that contain this node. subdomains correspond to processors. The number of subdomains that contain a node does not always equal the number of processors that share a node. There are two kinds of "sharing" – the "normal" kind, where a node is shared because it is connected to elements that reside on more than one processor, and the "wierd" kind where nodes are considered shared simply because of being in cross-processor constraints. This function describes how many processors share this node in the "normal" sense. Thus, in general, this relationship holds: getNumSubdomains(nodeNum) <= getNumSharingProcs(nodeNum)
nodeNumber |
Implements Lookup.
Definition at line 264 of file SNL_FEI_Structure.hpp.
References NodeDescriptor::getGlobalNodeID(), NodeDatabase::getNodeWithNumber(), NodeCommMgr::getSharedNodeNumSubdomains(), nodeCommMgr_, and nodeDatabase_.
|
inlinevirtual |
Given a nodeNumber, return a list of the subdomains that contain this node. This is the list of subdomains that's counted by the method 'getNumSubdomains' above.
nodeNumber |
Implements Lookup.
Definition at line 272 of file SNL_FEI_Structure.hpp.
References NodeDescriptor::getGlobalNodeID(), NodeDatabase::getNodeWithNumber(), NodeCommMgr::getSharedNodeSubdomainList(), nodeCommMgr_, and nodeDatabase_.
int SNL_FEI_Structure::translateToReducedNodeNumber | ( | int | nodeNumber, |
int | proc | ||
) |
Definition at line 3290 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), globalNumNodesVanished_, localProc_, and localVanishedNodeNumbers_.
Referenced by getAssociatedNodeNumber().
|
inlinevirtual |
implementation of Lookup::getAssociatedNodeNumber
Implements Lookup.
Definition at line 286 of file SNL_FEI_Structure.hpp.
References NodeDatabase::getAssociatedNodeNumber(), localProc_, nodeDatabase_, translateFromReducedEqn(), and translateToReducedNodeNumber().
Referenced by FEDataFilter::enforceEssentialBCs(), FEDataFilter::getReducedSolnEntry(), FEDataFilter::giveToLocalReducedMatrix(), FEDataFilter::giveToLocalReducedRHS(), FEDataFilter::giveToMatrix(), and LinSysCoreFilter::initLinSysCore().
|
inlinevirtual |
implementation of Lookup::getAssociatedFieldID
Implements Lookup.
Definition at line 298 of file SNL_FEI_Structure.hpp.
References NodeDatabase::getAssociatedFieldID(), nodeDatabase_, and translateFromReducedEqn().
|
inlinevirtual |
Query whether a pt-eqn corresponds exactly to a blk-eqn. in other words, is pt-eqn the first point equation in a block-equation.
ptEqn |
Implements Lookup.
Definition at line 308 of file SNL_FEI_Structure.hpp.
References blkEqnMapper_, and snl_fei::PointBlockMap::isExactlyBlkEqn().
|
inlinevirtual |
Given a pt-eqn, return the corresponding blk-eqn.
ptEqn |
Implements Lookup.
Definition at line 312 of file SNL_FEI_Structure.hpp.
References blkEqnMapper_, and snl_fei::PointBlockMap::eqnToBlkEqn().
Referenced by initComplete().
|
inlinevirtual |
Given a blk-eqn and a pt-eqn, return the pt-eqn's offset into the blk-eqn (i.e., distance from the 'beginning' of the blk-eqn)
blkEqn | |
ptEqn |
Implements Lookup.
Definition at line 316 of file SNL_FEI_Structure.hpp.
References blkEqnMapper_, and snl_fei::PointBlockMap::getBlkEqnOffset().
|
inlinevirtual |
Given a blk-eqn, return the 'size', or number of pt-eqns corresponding to it.
blkEqn |
Implements Lookup.
Definition at line 320 of file SNL_FEI_Structure.hpp.
References blkEqnMapper_, and snl_fei::PointBlockMap::getBlkEqnSize().
|
inline |
Definition at line 326 of file SNL_FEI_Structure.hpp.
References NodeDatabase::getNodeIDs(), and nodeDatabase_.
Referenced by FEDataFilter::getBlockFieldNodeSolution(), LinSysCoreFilter::getBlockFieldNodeSolution(), FEI_Implementation::getBlockNodeIDList(), FEDataFilter::getBlockNodeSolution(), LinSysCoreFilter::getBlockNodeSolution(), FEDataFilter::getNodalFieldSolution(), LinSysCoreFilter::getNodalFieldSolution(), FEDataFilter::getNodalSolution(), LinSysCoreFilter::getNodalSolution(), FEDataFilter::putBlockNodeSolution(), LinSysCoreFilter::putBlockNodeSolution(), test_SNL_FEI_Structure::test1(), and test_SNL_FEI_Structure::test2().
|
inline |
Definition at line 328 of file SNL_FEI_Structure.hpp.
References nodeDatabase_.
Referenced by Filter::calculateResidualNorms(), FEDataFilter::enforceEssentialBCs(), Filter::findNode(), Filter::findNodeDescriptor(), FEDataFilter::getBlockFieldNodeSolution(), LinSysCoreFilter::getBlockFieldNodeSolution(), FEI_Implementation::getBlockNodeIDList(), FEDataFilter::getBlockNodeSolution(), LinSysCoreFilter::getBlockNodeSolution(), fei::DirichletBCManager::getEqnNumber(), FEI_Implementation::getLocalNodeIDList(), FEDataFilter::getNodalFieldSolution(), LinSysCoreFilter::getNodalFieldSolution(), FEDataFilter::getNodalSolution(), LinSysCoreFilter::getNodalSolution(), FEI_Implementation::getNumLocalNodes(), FEI_Implementation::getNumSolnParams(), FEDataFilter::getReducedSolnEntry(), FEDataFilter::giveToLocalReducedMatrix(), FEDataFilter::giveToLocalReducedRHS(), FEDataFilter::giveToMatrix(), FEDataFilter::giveToRHS(), FEDataFilter::initLinSysCore(), LinSysCoreFilter::initLinSysCore(), FEDataFilter::loadFEDataMultCR(), FEDataFilter::loadFEDataPenCR(), FEDataFilter::loadNodeBCs(), FEDataFilter::putBlockFieldNodeSolution(), LinSysCoreFilter::putBlockFieldNodeSolution(), FEDataFilter::putBlockNodeSolution(), LinSysCoreFilter::putBlockNodeSolution(), FEDataFilter::putNodalFieldData(), LinSysCoreFilter::putNodalFieldData(), FEDataFilter::putNodalFieldSolution(), LinSysCoreFilter::putNodalFieldSolution(), LinSysCoreFilter::resolveConflictingCRs(), and FEDataFilter::sumIntoMatrixDiagonal().
|
inline |
Definition at line 330 of file SNL_FEI_Structure.hpp.
References NodeDatabase::getNodeIDs(), and nodeDatabase_.
|
inline |
Definition at line 333 of file SNL_FEI_Structure.hpp.
References globalNodeOffsets_.
Referenced by LinSysCoreFilter::initialize(), and LinSysCoreFilter::initLinSysCore().
|
inline |
Definition at line 334 of file SNL_FEI_Structure.hpp.
References globalEqnOffsets_.
Referenced by FEDataFilter::initialize(), LinSysCoreFilter::initialize(), and LinSysCoreFilter::initLinSysCore().
|
inline |
Definition at line 335 of file SNL_FEI_Structure.hpp.
References globalBlkEqnOffsets_.
Referenced by LinSysCoreFilter::initLinSysCore().
|
inline |
Definition at line 337 of file SNL_FEI_Structure.hpp.
References nodeCommMgr_.
Referenced by FEI_Implementation::FEI_Implementation(), FEDataFilter::getReducedSolnEntry(), FEDataFilter::initLinSysCore(), and LinSysCoreFilter::initLinSysCore().
|
inline |
Definition at line 338 of file SNL_FEI_Structure.hpp.
References eqnCommMgr_.
Referenced by FEDataFilter::FEDataFilter(), FEDataFilter::initialize(), LinSysCoreFilter::initialize(), and LinSysCoreFilter::LinSysCoreFilter().
void SNL_FEI_Structure::initializeEqnCommMgr | ( | ) |
Definition at line 3140 of file SNL_FEI_Structure.cpp.
References EqnCommMgr::addLocalEqn(), EqnCommMgr::addRemoteIndices(), dbgOut(), debugOutput_, eqnCommMgr_, FEI_ENDL, FEI_OSTREAM, NodeDescriptor::getFieldEqnNumbers(), NodeDescriptor::getFieldIDList(), getFieldSize(), NodeDescriptor::getNumFields(), NodeCommMgr::getNumSharedNodes(), NodeDescriptor::getOwnerProc(), NodeCommMgr::getSharedNodeAtIndex(), NodeCommMgr::getSharedNodeProcs(), localProc_, nodeCommMgr_, fei::numProcs(), and translateToReducedEqn().
Referenced by initComplete().
void SNL_FEI_Structure::getEqnInfo | ( | int & | numGlobalEqns, |
int & | numLocalEqns, | ||
int & | localStartRow, | ||
int & | localEndRow | ||
) |
Definition at line 3206 of file SNL_FEI_Structure.cpp.
References localEndRow_, localStartRow_, numGlobalEqns_, and numLocalEqns_.
int SNL_FEI_Structure::getEqnNumbers | ( | GlobalID | ID, |
int | idType, | ||
int | fieldID, | ||
int & | numEqns, | ||
int * | eqnNumbers | ||
) |
Definition at line 3216 of file SNL_FEI_Structure.cpp.
References CHK_ERR, ERReturn, FEI_NODE, FEI_SUCCESS, NodeDescriptor::getFieldEqnNumber(), getFieldSize(), NodeDatabase::getNodeWithID(), and nodeDatabase_.
Referenced by calculateSlaveEqns(), FEI_Implementation::getEqnNumbers(), FEDataFilter::putIntoRHS(), LinSysCoreFilter::putIntoRHS(), FEDataFilter::sumIntoRHS(), and LinSysCoreFilter::sumIntoRHS().
int SNL_FEI_Structure::getEqnNumbers | ( | int | numIDs, |
const GlobalID * | IDs, | ||
int | idType, | ||
int | fieldID, | ||
int & | numEqns, | ||
int * | eqnNumbers | ||
) |
Definition at line 3240 of file SNL_FEI_Structure.cpp.
References ERReturn, FEI_NODE, FEI_SUCCESS, NodeDescriptor::getFieldEqnNumber(), getFieldSize(), NodeDatabase::getNodeWithID(), and nodeDatabase_.
void SNL_FEI_Structure::getEqnBlkInfo | ( | int & | numGlobalEqnBlks, |
int & | numLocalEqnBlks, | ||
int & | localBlkOffset | ||
) |
Definition at line 3306 of file SNL_FEI_Structure.cpp.
References localBlkOffset_, numGlobalEqnBlks_, and numLocalEqnBlks_.
|
inline |
Definition at line 355 of file SNL_FEI_Structure.hpp.
References blkEqnMapper_.
Referenced by initializeBlkEqnMapper().
void SNL_FEI_Structure::destroyMatIndices | ( | ) |
Definition at line 263 of file SNL_FEI_Structure.cpp.
References matIndicesDestroyed_, sysBlkMatIndices_, and sysMatIndices_.
Referenced by FEI_Implementation::initComplete(), and ~SNL_FEI_Structure().
|
inline |
Definition at line 359 of file SNL_FEI_Structure.hpp.
References multCRs_.
Referenced by calcNumMultCREqns(), FEI_Implementation::getCRMultIDList(), LinSysCoreFilter::getCRMultipliers(), FEI_Implementation::getNumCRMultipliers(), FEDataFilter::initLinSysCore(), and LinSysCoreFilter::resolveConflictingCRs().
|
inline |
Definition at line 362 of file SNL_FEI_Structure.hpp.
References multCRs_.
Referenced by FEI_Implementation::getCRMultIDList(), LinSysCoreFilter::getCRMultipliers(), LinSysCoreFilter::resolveConflictingCRs(), and LinSysCoreFilter::setLinSysCoreCREqns().
|
inline |
Definition at line 365 of file SNL_FEI_Structure.hpp.
References multCRs_.
Referenced by LinSysCoreFilter::getCRMultipliers(), LinSysCoreFilter::loadCRMult(), and LinSysCoreFilter::putCRMultipliers().
|
inline |
Definition at line 378 of file SNL_FEI_Structure.hpp.
References penCRs_.
Referenced by FEDataFilter::initLinSysCore().
|
inline |
Definition at line 380 of file SNL_FEI_Structure.hpp.
References penCRs_.
Referenced by finalizeActiveNodes(), FEDataFilter::initLinSysCore(), and LinSysCoreFilter::setLinSysCoreCREqns().
|
inline |
Definition at line 383 of file SNL_FEI_Structure.hpp.
References penCRs_.
Referenced by LinSysCoreFilter::loadCRPen().
|
inline |
Definition at line 396 of file SNL_FEI_Structure.hpp.
References slaveVars_.
Referenced by initSlaveVariable().
int SNL_FEI_Structure::calculateSlaveEqns | ( | MPI_Comm | comm | ) |
Definition at line 3316 of file SNL_FEI_Structure.cpp.
References EqnBuffer::addEqn(), EqnCommMgr::addLocalEqn(), EqnCommMgr::addRemoteIndices(), fei::Allgatherv(), CHK_ERR, comm_, dbgOut(), debugOutput_, eqnCommMgr_, EqnBuffer::eqnNumbers(), EqnBuffer::eqns(), ERReturn, FEI_ENDL, FEI_NODE, FEI_OSTREAM, gatherSlaveEqns(), getEqnNumbers(), SlaveVariable::getFieldID(), SlaveVariable::getFieldOffset(), getFieldSize(), NodeDescriptor::getGlobalNodeID(), SlaveVariable::getMasterFields(), SlaveVariable::getMasterNodeIDs(), SlaveVariable::getNodeID(), NodeDescriptor::getNodeNumber(), NodeDatabase::getNodeWithEqn(), NodeDescriptor::getOwnerProc(), getOwnerProcForEqn(), NodeCommMgr::getSharedNodeIndex(), NodeCommMgr::getSharedNodeProcs(), SlaveVariable::getWeights(), fei::GlobalMax(), globalNumNodesVanished_, highestSlv_, localProc_, localVanishedNodeNumbers_, lowestSlv_, nodalEqnsAllSlaves(), nodeCommMgr_, nodeDatabase_, numProcs_, numSlvs_, removeCouplings(), EqnCommMgr::setNumRHSs(), slaveEqns_, slaveMatrix_, slaveVars_, slvCommMgr_, slvEqnNumbers_, fei::sortedListInsert(), and translateToReducedEqn().
Referenced by initComplete().
|
inline |
Definition at line 400 of file SNL_FEI_Structure.hpp.
References slaveMatrix_.
Referenced by LinSysCoreFilter::assembleReducedEqns(), LinSysCoreFilter::assembleReducedRHS(), and assembleReducedStructure().
|
inline |
Definition at line 402 of file SNL_FEI_Structure.hpp.
References slaveEqns_.
|
inline |
Definition at line 404 of file SNL_FEI_Structure.hpp.
References numSlvs_.
Referenced by LinSysCoreFilter::assembleEqns(), FEDataFilter::assembleRHS(), LinSysCoreFilter::assembleRHS(), Filter::calculateResidualNorms(), createBlkSymmEqnStructure(), createSymmEqnStructure(), LinSysCoreFilter::enforceEssentialBCs(), LinSysCoreFilter::exchangeRemoteBCs(), LinSysCoreFilter::generalElemInput(), LinSysCoreFilter::getEqnSolnEntry(), FEDataFilter::getNodalFieldSolution(), LinSysCoreFilter::giveToMatrix(), LinSysCoreFilter::giveToRHS(), and LinSysCoreFilter::initLinSysCore().
bool SNL_FEI_Structure::isSlaveEqn | ( | int | eqn | ) |
Given a "global" equation number, return true if it is a slave equation.
Definition at line 3643 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), EqnBuffer::eqnNumbers(), numSlvs_, and slaveEqns_.
Referenced by LinSysCoreFilter::assembleEqns(), LinSysCoreFilter::assembleRHS(), Filter::calculateResidualNorms(), createBlkSymmEqnStructure(), createSymmEqnStructure(), initComplete(), and LinSysCoreFilter::initLinSysCore().
bool SNL_FEI_Structure::translateToReducedEqn | ( | int | eqn, |
int & | reducedEqn | ||
) |
Given a "global" equation number, return the corresponding equation number in the "reduced" equation space. This is a trivial one-to-one mapping unless there are slave equations. If there are slave equations, then the number of 'reduced' equations is reduced by num-slave-eqns, and any particular global equation number is reduced by the number of slave equations that are smaller than it.
Definition at line 3656 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), highestSlv_, lowestSlv_, numSlvs_, and slvEqnNumbers_.
Referenced by Filter::calculateResidualNorms(), calculateSlaveEqns(), createBlkSymmEqnStructure(), createSymmEqnStructure(), LinSysCoreFilter::enforceEssentialBCs(), LinSysCoreFilter::exchangeRemoteBCs(), getEqnNumber(), LinSysCoreFilter::getEqnsFromRHS(), LinSysCoreFilter::getEqnSolnEntry(), LinSysCoreFilter::giveToMatrix(), initComplete(), initializeBlkEqnMapper(), initializeEqnCommMgr(), LinSysCoreFilter::initLinSysCore(), initMultCRStructure(), FEDataFilter::putBlockFieldNodeSolution(), LinSysCoreFilter::putBlockFieldNodeSolution(), LinSysCoreFilter::putNodalFieldSolution(), storeElementScatterIndices(), storeLocalNodeIndices(), storeNodalColumnIndices(), storeNodalRowIndices(), translateMatToReducedEqns(), and translateToReducedEqns().
int SNL_FEI_Structure::translateToReducedEqns | ( | EqnCommMgr & | eqnCommMgr | ) |
Given an EqnCommMgr object with global equation numbers, translate all of its indices (row-numbers and column-indices) to the "reduced" equation space.
Definition at line 2095 of file SNL_FEI_Structure.cpp.
References CHK_ERR, EqnCommMgr::getRecvEqns(), EqnCommMgr::getRecvProcEqns(), EqnCommMgr::getSendEqns(), EqnCommMgr::getSendProcEqns(), and numSlvs_.
int SNL_FEI_Structure::translateToReducedEqns | ( | EqnBuffer & | eqnBuf | ) |
Given an EqnBuffer object with global equation numbers, translate all of its indices (row-numbers and column-indices) to the "reduced" equation space.
Definition at line 2108 of file SNL_FEI_Structure.cpp.
References EqnBuffer::eqnNumbers(), EqnBuffer::eqns(), EqnBuffer::getNumEqns(), and translateToReducedEqn().
int SNL_FEI_Structure::translateToReducedEqns | ( | ProcEqns & | procEqns | ) |
Given a ProcEqns object with global equation numbers, translate all of its indices (row-numbers and column-indices) to the "reduced" equation space.
Definition at line 2130 of file SNL_FEI_Structure.cpp.
References ProcEqns::procEqnNumbersPtr(), and translateToReducedEqn().
int SNL_FEI_Structure::translateMatToReducedEqns | ( | fei::CSRMat & | mat | ) |
Given a CSRMat object with global equation numbers, translate all of its indices (row-numbers and column-indices) to the "reduced" equation space.
Definition at line 2148 of file SNL_FEI_Structure.cpp.
References fei::CSRMat::getGraph(), fei::SparseRowGraph::packedColumnIndices, fei::SparseRowGraph::rowNumbers, and translateToReducedEqn().
Referenced by assembleReducedStructure().
int SNL_FEI_Structure::translateFromReducedEqn | ( | int | reducedEqn | ) |
Given an "Reduced" equation number, translate it to the "global" numbering, which is the numbering that includes slave equations. This is the inverse of the 'translateToReducedEqn' function above.
Definition at line 3679 of file SNL_FEI_Structure.cpp.
References EqnBuffer::eqnNumbers(), EqnBuffer::getNumEqns(), and slaveEqns_.
Referenced by getAssociatedFieldID(), getAssociatedNodeNumber(), and FEDataFilter::getReducedSolnEntry().
int SNL_FEI_Structure::getMasterEqnNumbers | ( | int | slaveEqn, |
std::vector< int > *& | masterEqns | ||
) |
Given a slave equation, fill a std::vector with the equation-numbers upon which the slave depends.
slaveEqn | |
masterEqns | Output. NULL if slaveEqn is not a slave equation. |
Definition at line 3700 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), EqnBuffer::eqnNumbers(), EqnBuffer::eqns(), EqnBuffer::getNumEqns(), and slaveEqns_.
Referenced by LinSysCoreFilter::getEqnSolnEntry().
int SNL_FEI_Structure::getMasterEqnCoefs | ( | int | slaveEqn, |
std::vector< double > *& | masterCoefs | ||
) |
Given a slave equation, fill a std::vector with the coefficients of the equations upon which the slave depends.
slaveEqn | |
masterCoefs | Output. NULL if slaveEqn is not a slave equation. |
Definition at line 3723 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), EqnBuffer::eqnNumbers(), EqnBuffer::eqns(), EqnBuffer::getNumEqns(), and slaveEqns_.
Referenced by LinSysCoreFilter::getEqnSolnEntry().
int SNL_FEI_Structure::getMasterEqnRHS | ( | int | slaveEqn, |
double & | rhsValue | ||
) |
Given a slave equation, provide the rhs-value associated with the master equation that the slave is defined by.
slaveEqn | |
rhsValue | Output. Not referenced if slaveEqn is not a slave equation. |
Definition at line 3746 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), EqnBuffer::eqnNumbers(), EqnBuffer::getNumEqns(), EqnBuffer::rhsCoefsPtr(), and slaveEqns_.
Referenced by LinSysCoreFilter::getEqnSolnEntry().
|
inline |
Definition at line 476 of file SNL_FEI_Structure.hpp.
References numGlobalEqns_.
Referenced by test_SNL_FEI_Structure::test1(), and test_SNL_FEI_Structure::test2().
|
inline |
Definition at line 477 of file SNL_FEI_Structure.hpp.
References numLocalEqns_.
Referenced by LinSysCoreFilter::initialize(), test_SNL_FEI_Structure::test1(), and test_SNL_FEI_Structure::test2().
|
inline |
Definition at line 478 of file SNL_FEI_Structure.hpp.
References localStartRow_.
|
inline |
Definition at line 479 of file SNL_FEI_Structure.hpp.
References localEndRow_.
|
inline |
Definition at line 481 of file SNL_FEI_Structure.hpp.
References reducedStartRow_.
Referenced by Filter::calculateResidualNorms().
|
inline |
Definition at line 482 of file SNL_FEI_Structure.hpp.
References reducedEndRow_.
Referenced by Filter::calculateResidualNorms().
|
inline |
Definition at line 484 of file SNL_FEI_Structure.hpp.
References numGlobalEqnBlks_.
|
inline |
Definition at line 485 of file SNL_FEI_Structure.hpp.
References numLocalEqnBlks_.
Referenced by LinSysCoreFilter::initialize().
|
inline |
Definition at line 486 of file SNL_FEI_Structure.hpp.
References numLocalReducedEqnBlks_.
Referenced by LinSysCoreFilter::initialize().
|
inline |
Definition at line 487 of file SNL_FEI_Structure.hpp.
References globalMaxBlkSize_.
Referenced by LinSysCoreFilter::initialize().
|
inline |
Definition at line 489 of file SNL_FEI_Structure.hpp.
References numLocalReducedRows_.
Referenced by LinSysCoreFilter::initialize().
int SNL_FEI_Structure::getMatrixRowLengths | ( | std::vector< int > & | rowLengths | ) |
Definition at line 1200 of file SNL_FEI_Structure.cpp.
References numLocalReducedRows_, fei::ctg_set< T >::size(), structureFinalized_, and sysMatIndices_.
Referenced by LinSysCoreFilter::initialize(), test_SNL_FEI_Structure::test1(), and test_SNL_FEI_Structure::test2().
int SNL_FEI_Structure::getMatrixStructure | ( | int ** | colIndices, |
std::vector< int > & | rowLengths | ||
) |
Definition at line 1213 of file SNL_FEI_Structure.cpp.
References fei::copySetToArray(), numLocalReducedRows_, fei::ctg_set< T >::size(), structureFinalized_, and sysMatIndices_.
Referenced by getMatrixStructure(), LinSysCoreFilter::initialize(), test_SNL_FEI_Structure::test1(), and test_SNL_FEI_Structure::test2().
int SNL_FEI_Structure::getMatrixStructure | ( | int ** | ptColIndices, |
std::vector< int > & | ptRowLengths, | ||
int ** | blkColIndices, | ||
int * | blkIndices_1D, | ||
std::vector< int > & | blkRowLengths, | ||
std::vector< int > & | numPtRowsPerBlkRow | ||
) |
Definition at line 1229 of file SNL_FEI_Structure.cpp.
References blkEqnMapper_, fei::console_out(), fei::copySetToArray(), snl_fei::PointBlockMap::eqnToBlkEqn(), ERReturn, FEI_ENDL, snl_fei::PointBlockMap::getBlkEqnSize(), getMatrixStructure(), snl_fei::PointBlockMap::getPtEqns(), globalMaxBlkSize_, fei::ctg_set< T >::insert2(), localProc_, localReducedBlkOffset_, numLocalReducedEqnBlks_, numLocalReducedRows_, reducedStartRow_, fei::ctg_set< T >::size(), sysBlkMatIndices_, and sysMatIndices_.
|
static |
Referenced by calculateSlaveEqns().
|
static |
Definition at line 3529 of file SNL_FEI_Structure.cpp.
References EqnBuffer::addEqn(), CHK_ERR, fei::console_out(), EqnBuffer::eqnNumbers(), EqnBuffer::eqns(), ERReturn, FEI_ENDL, EqnBuffer::getCoefAndRemoveIndex(), and EqnBuffer::isInIndices().
Referenced by calculateSlaveEqns().
int SNL_FEI_Structure::calcTotalNumElemDOF | ( | ) |
Definition at line 2548 of file SNL_FEI_Structure.cpp.
References CHK_ERR, getBlockDescriptor_index(), getNumElemBlocks(), BlockDescriptor::getNumElemDOFPerElement(), and BlockDescriptor::getNumElements().
Referenced by initComplete().
int SNL_FEI_Structure::calcNumMultCREqns | ( | ) |
Definition at line 2568 of file SNL_FEI_Structure.cpp.
References getNumMultConstRecords().
Referenced by initComplete().
|
inline |
Definition at line 508 of file SNL_FEI_Structure.hpp.
References comm_.
Referenced by Filter::calculateResidualNorms().
int SNL_FEI_Structure::setDbgOut | ( | std::ostream & | ostr, |
const char * | path, | ||
const char * | feiName | ||
) |
Definition at line 227 of file SNL_FEI_Structure.cpp.
References dbgOStreamPtr_, dbgPath_, debugOutput_, name_, and setDbgOutCalled_.
Referenced by FEI_Implementation::setDebugOutput().
|
private |
Return a pointer to a NodeDescriptor, may return NULL. The caller is responsible for checking for a NULL pointer and doing the right thing.
Definition at line 1368 of file SNL_FEI_Structure.cpp.
References NodeDatabase::getNodeWithID(), and nodeDatabase_.
Referenced by initMultCRStructure(), and initPenCRStructure().
|
private |
Return a reference to a NodeDescriptor, will abort in debug with an error and seg-fault in optimized mode if a NodeDescriptor object is not found (i.e. it dereferences a NULL ptr).
Definition at line 1350 of file SNL_FEI_Structure.cpp.
References fei::console_out(), FEI_ENDL, NodeDatabase::getNodeWithID(), and nodeDatabase_.
|
private |
Definition at line 2488 of file SNL_FEI_Structure.cpp.
References fei::console_out(), dbgPath_, ERReturn, FEI_ENDL, FEI_OFSTREAM, FEI_OSTRINGSTREAM, FEI_SUCCESS, NodeDescriptor::getBlkEqnNumber(), snl_fei::Constraint< RecordType >::getBlkEqnNumber(), snl_fei::Constraint< RecordType >::getEqnNumber(), NodeDescriptor::getFieldEqnNumbers(), NodeDescriptor::getFieldIDList(), getFieldSize(), NodeDescriptor::getGlobalNodeID(), NodeDatabase::getNodeAtIndex(), NodeDatabase::getNodeIDs(), NodeDescriptor::getNodeNumber(), NodeDescriptor::getNumFields(), NodeDescriptor::getOwnerProc(), localProc_, multCRs_, name_, nodeDatabase_, and numProcs_.
Referenced by initComplete().
|
private |
Definition at line 3975 of file SNL_FEI_Structure.cpp.
References activeNodesInitialized_, CHK_ERR, connTables_, FEI_SUCCESS, NodeDatabase::getNodeWithID(), and nodeDatabase_.
Referenced by getBlkScatterIndices_index(), and getScatterIndices_index().
|
private |
Definition at line 4003 of file SNL_FEI_Structure.cpp.
References NodeDescriptor::getFieldEqnNumbers(), and getFieldSize().
Referenced by getScatterIndices_index().
|
private |
Definition at line 4026 of file SNL_FEI_Structure.cpp.
References NodeDescriptor::getBlkEqnNumber(), NodeDescriptor::getFieldEqnNumbers(), getFieldSize(), and NodeDescriptor::getNumNodalDOF().
|
private |
Definition at line 4054 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), fei::console_out(), FEI_COUT, FEI_ENDL, FEI_SUCCESS, NodeDescriptor::getFieldEqnNumbers(), NodeDescriptor::getFieldIDList(), getFieldSize(), NodeDescriptor::getGlobalNodeID(), NodeDescriptor::getNumFields(), and outputLevel_.
Referenced by getScatterIndices_index().
|
private |
Definition at line 4105 of file SNL_FEI_Structure.cpp.
References NodeDescriptor::getBlkEqnNumber().
Referenced by getBlkScatterIndices_index().
|
private |
Definition at line 4118 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), fei::console_out(), FEI_COUT, FEI_ENDL, FEI_SUCCESS, NodeDescriptor::getBlkEqnNumber(), NodeDescriptor::getFieldEqnNumbers(), NodeDescriptor::getFieldIDList(), getFieldSize(), NodeDescriptor::getGlobalNodeID(), NodeDescriptor::getNumFields(), NodeDescriptor::getNumNodalDOF(), and outputLevel_.
|
private |
Definition at line 4174 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), comm_, fei::console_out(), FEI_COUT, FEI_ENDL, FEI_SUCCESS, NodeDescriptor::getFieldEqnNumbers(), NodeDescriptor::getFieldIDList(), getFieldSize(), NodeDescriptor::getGlobalNodeID(), NodeDescriptor::getNumFields(), MPI_Abort, and outputLevel_.
|
private |
Definition at line 4233 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), ERReturn, FEI_SUCCESS, NodeDescriptor::getFieldEqnNumbers(), NodeDescriptor::getFieldIDList(), getFieldSize(), NodeDescriptor::getNumFields(), and fei::searchList().
Referenced by getScatterIndices_index().
|
private |
Definition at line 4295 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), fei::console_out(), FEI_ENDL, FEI_SUCCESS, NodeDescriptor::getFieldEqnNumbers(), NodeDescriptor::getFieldIDList(), getFieldSize(), NodeDescriptor::getNumFields(), and outputLevel_.
|
private |
Definition at line 2579 of file SNL_FEI_Structure.cpp.
References comm_, fei::console_out(), dbgOut(), debugOutput_, FEI_ENDL, FEI_OSTREAM, firstLocalNodeNumber_, globalBlkEqnOffsets_, globalEqnOffsets_, globalNodeOffsets_, localBlkOffset_, localEndRow_, localProc_, localStartRow_, masterProc_, MPI_Abort, MPI_SUCCESS, n, numGlobalEqnBlks_, numGlobalEqns_, numGlobalNodes_, and numProcs_.
Referenced by initComplete().
|
private |
Definition at line 2909 of file SNL_FEI_Structure.cpp.
References activeNodesInitialized_, NodeDescriptor::addBlockIndex(), NodeDescriptor::addField(), blockIDs_, blocks_, CHK_ERR, connTables_, fei::console_out(), dbgOut(), debugOutput_, ConnectivityTable::elem_conn_ids, ConnectivityTable::elem_conn_ptrs, ConnectivityTable::elemIDs, ConnectivityTable::elemNumbers, FEI_ENDL, FEI_OSTREAM, FEI_SUCCESS, getIndexOfBlock(), snl_fei::Constraint< RecordType >::getMasters(), NodeDatabase::getNodeWithID(), getPenConstRecords(), NodeCommMgr::getSharedNodeIDs(), NodeCommMgr::informLocal(), NodeDatabase::initNodeID(), localProc_, n, nodeCommMgr_, nodeDatabase_, ConnectivityTable::numNodesPerElem, numProcs_, and NodeDescriptor::setOwnerProc().
Referenced by initComplete().
|
private |
Definition at line 3048 of file SNL_FEI_Structure.cpp.
References checkSharedNodes_, CHK_ERR, dbgOut(), debugOutput_, FEI_COUT, FEI_ENDL, FEI_OSTREAM, NodeDescriptor::getGlobalNodeID(), NodeCommMgr::getNumSharedNodes(), NodeDescriptor::getOwnerProc(), NodeCommMgr::getSharedNodeAtIndex(), NodeCommMgr::initComplete(), localProc_, nodeCommMgr_, nodeDatabase_, numProcs_, and outputLevel_.
Referenced by initComplete().
|
private |
|
private |
Definition at line 1081 of file SNL_FEI_Structure.cpp.
References CHK_ERR, fei::console_out(), createMatrixPosition(), dbgOut(), debugOutput_, eqnCommMgr_, ERReturn, EqnCommMgr::exchangeIndices(), FEI_ENDL, FEI_OSTREAM, EqnCommMgr::getNumLocalEqns(), initElemBlockStructure(), initMultCRStructure(), initPenCRStructure(), EqnCommMgr::localEqnNumbers(), EqnCommMgr::localEqns(), localProc_, reducedEndRow_, and reducedStartRow_.
Referenced by initComplete().
|
private |
Definition at line 1150 of file SNL_FEI_Structure.cpp.
References assembleReducedStructure(), CHK_ERR, createSymmEqnStructure(), dbgOut(), debugOutput_, ConnectivityTable::elemIDs, FEI_ENDL, FEI_OSTREAM, FEI_SUCCESS, getBlockConnectivity(), getBlockDescriptor_index(), BlockDescriptor::getGlobalBlockID(), BlockDescriptor::getInterleaveStrategy(), getNumElemBlocks(), BlockDescriptor::getNumElements(), BlockDescriptor::getNumEqnsPerElement(), getScatterIndices_index(), reducedEqnCounter_, and BlockDescriptor::setNumElements().
Referenced by formMatrixStructure().
|
private |
Definition at line 1376 of file SNL_FEI_Structure.cpp.
References createMatrixPosition(), dbgOut(), debugOutput_, FEI_ENDL, FEI_OSTREAM, FEI_SUCCESS, findNode(), snl_fei::Constraint< RecordType >::getEqnNumber(), snl_fei::Constraint< RecordType >::getMasterFieldIDs(), snl_fei::Constraint< RecordType >::getMasters(), NodeDescriptor::getOwnerProc(), localProc_, multCRs_, storeNodalColumnIndices(), storeNodalRowIndices(), storeNodalSendIndex(), and translateToReducedEqn().
Referenced by formMatrixStructure().
|
private |
Definition at line 1449 of file SNL_FEI_Structure.cpp.
References dbgOut(), debugOutput_, FEI_ENDL, FEI_OSTREAM, FEI_SUCCESS, findNode(), snl_fei::Constraint< RecordType >::getMasterFieldIDs(), snl_fei::Constraint< RecordType >::getMasters(), NodeDescriptor::getOwnerProc(), localProc_, penCRs_, storeLocalNodeIndices(), and storeNodalSendIndices().
Referenced by formMatrixStructure().
|
private |
Definition at line 2210 of file SNL_FEI_Structure.cpp.
References dbgOut(), debugOutput_, FEI_ENDL, generateGraph_, fei::ctg_set< T >::insert2(), outputLevel_, reducedEndRow_, reducedStartRow_, and sysMatIndices_.
Referenced by createBlkSymmEqnStructure(), createMatrixPositions(), createSymmEqnStructure(), formMatrixStructure(), initMultCRStructure(), storeLocalNodeIndices(), storeNodalColumnIndices(), and storeNodalRowIndices().
|
private |
Definition at line 2249 of file SNL_FEI_Structure.cpp.
References dbgOut(), debugOutput_, FEI_ENDL, generateGraph_, fei::ctg_set< T >::insert2(), outputLevel_, reducedEndRow_, reducedStartRow_, and sysMatIndices_.
Referenced by assembleReducedStructure(), and storeElementScatterIndices().
|
private |
Definition at line 2178 of file SNL_FEI_Structure.cpp.
References CHK_ERR, createMatrixPosition(), generateGraph_, fei::CSRMat::getGraph(), fei::SparseRowGraph::packedColumnIndices, fei::SparseRowGraph::rowNumbers, and fei::SparseRowGraph::rowOffsets.
|
private |
Definition at line 1698 of file SNL_FEI_Structure.cpp.
References EqnCommMgr::addRemoteIndices(), assembleReducedStructure(), CHK_ERR, fei::console_out(), createMatrixPosition(), fei::FillableMat::createPosition(), eqnCommMgr_, ERReturn, FEI_ENDL, FEI_SUCCESS, getOwnerProcForEqn(), isSlaveEqn(), Kdd_, Kdi_, Kid_, localProc_, numSlaveEquations(), reducedEndRow_, reducedEqnCounter_, reducedStartRow_, rSlave_, storeElementScatterIndices(), storeElementScatterIndices_noSlaves(), translateToReducedEqn(), and workSpace_.
Referenced by initElemBlockStructure().
|
private |
Definition at line 1813 of file SNL_FEI_Structure.cpp.
References EqnCommMgr::addRemoteIndices(), assembleReducedStructure(), CHK_ERR, fei::console_out(), createMatrixPosition(), fei::FillableMat::createPosition(), eqnCommMgr_, ERReturn, FEI_ENDL, FEI_SUCCESS, getOwnerProcForEqn(), isSlaveEqn(), Kdd_, Kdi_, Kid_, localProc_, numSlaveEquations(), reducedEndRow_, reducedEqnCounter_, reducedStartRow_, rSlave_, storeElementScatterBlkIndices_noSlaves(), storeElementScatterIndices(), translateToReducedEqn(), and workSpace_.
|
private |
Definition at line 1927 of file SNL_FEI_Structure.cpp.
References EqnCommMgr::addRemoteIndices(), CHK_ERR, createMatrixPositions(), eqnCommMgr_, ERReturn, FEI_SUCCESS, getOwnerProcForEqn(), localEndRow_, localStartRow_, translateToReducedEqn(), and workSpace_.
Referenced by createBlkSymmEqnStructure(), and createSymmEqnStructure().
|
private |
Definition at line 1966 of file SNL_FEI_Structure.cpp.
References EqnCommMgr::addRemoteIndices(), dbgOut(), debugOutput_, eqnCommMgr_, FEI_ENDL, FEI_SUCCESS, generateGraph_, getOwnerProcForEqn(), fei::ctg_set< T >::insert2(), localEndRow_, outputLevel_, reducedStartRow_, and sysMatIndices_.
Referenced by createSymmEqnStructure().
|
private |
Definition at line 2004 of file SNL_FEI_Structure.cpp.
References EqnCommMgr::addRemoteIndices(), dbgOut(), debugOutput_, eqnCommMgr_, FEI_ENDL, FEI_SUCCESS, generateGraph_, getOwnerProcForEqn(), fei::ctg_set< T >::insert2(), localEndRow_, outputLevel_, reducedStartRow_, and sysMatIndices_.
Referenced by createBlkSymmEqnStructure().
|
private |
Definition at line 1591 of file SNL_FEI_Structure.cpp.
References fei::console_out(), createMatrixPosition(), FEI_ENDL, NodeDescriptor::getFieldEqnNumber(), getFieldSize(), translateToReducedEqn(), and voidERReturn.
Referenced by initPenCRStructure().
|
private |
Definition at line 1631 of file SNL_FEI_Structure.cpp.
References fei::console_out(), createMatrixPosition(), FEI_ENDL, NodeDescriptor::getFieldEqnNumber(), getFieldSize(), localEndRow_, localStartRow_, translateToReducedEqn(), and voidERReturn.
Referenced by initMultCRStructure().
|
private |
Definition at line 1667 of file SNL_FEI_Structure.cpp.
References fei::console_out(), createMatrixPosition(), FEI_ENDL, NodeDescriptor::getFieldEqnNumber(), getFieldSize(), translateToReducedEqn(), and voidERReturn.
Referenced by initMultCRStructure().
|
private |
Definition at line 1529 of file SNL_FEI_Structure.cpp.
References EqnCommMgr::addRemoteIndices(), fei::console_out(), eqnCommMgr_, FEI_ENDL, NodeDescriptor::getFieldEqnNumber(), getFieldSize(), NodeDescriptor::getOwnerProc(), and voidERReturn.
Referenced by initMultCRStructure().
|
private |
Definition at line 1558 of file SNL_FEI_Structure.cpp.
References EqnCommMgr::addRemoteIndices(), fei::console_out(), eqnCommMgr_, FEI_ENDL, NodeDescriptor::getFieldEqnNumber(), getFieldSize(), NodeDescriptor::getOwnerProc(), and voidERReturn.
Referenced by initPenCRStructure().
|
private |
Definition at line 2042 of file SNL_FEI_Structure.cpp.
References EqnCommMgr::addRemoteEqns(), CHK_ERR, fei::FillableMat::clear(), createMatrixPositions(), csrD, csrKdd, csrKdi, csrKid, eqnCommMgr_, FEI_SUCCESS, getSlaveDependencies(), Kdd_, Kdi_, Kid_, fei::multiply_CSRMat_CSRMat(), fei::multiply_trans_CSRMat_CSRMat(), numProcs_, reducedEqnCounter_, tmpMat1_, tmpMat2_, and translateMatToReducedEqns().
Referenced by createBlkSymmEqnStructure(), createSymmEqnStructure(), and initElemBlockStructure().
|
private |
Definition at line 1328 of file SNL_FEI_Structure.cpp.
References fei::binarySearch(), NodeDescriptor::getFieldEqnNumbers(), NodeDescriptor::getFieldIDList(), getFieldSize(), and NodeDescriptor::getNumFields().
Referenced by calculateSlaveEqns().
|
private |
Definition at line 2290 of file SNL_FEI_Structure.cpp.
References fei::Allgatherv(), blkEqnMapper_, CHK_ERR, comm_, f(), fieldDatabase_, getBlkEqnMapper(), NodeDescriptor::getBlkEqnNumber(), snl_fei::Constraint< RecordType >::getBlkEqnNumber(), getBlockDescriptor_index(), snl_fei::Constraint< RecordType >::getEqnNumber(), NodeDescriptor::getFieldEqnNumbers(), getFieldIDsPtr(), snl_fei::PointBlockMap::getMaxBlkEqnSize(), NodeDatabase::getNodeAtIndex(), NodeDatabase::getNodeIDs(), getNumElemBlocks(), BlockDescriptor::getNumElemDOFPerElement(), BlockDescriptor::getNumElements(), NodeDescriptor::getNumFields(), NodeDescriptor::getNumNodalDOF(), fei::GlobalMax(), globalMaxBlkSize_, globalNodeOffsets_, globalNumNodesVanished_, localBlkOffset_, localProc_, localStartRow_, multCRs_, nodeDatabase_, numLocalNodalEqns_, numProcs_, snl_fei::PointBlockMap::setBlkEqnSize(), snl_fei::PointBlockMap::setEqn(), snl_fei::PointBlockMap::setMaxBlkEqnSize(), snl_fei::PointBlockMap::setPtEqualBlk(), and translateToReducedEqn().
Referenced by initComplete().
|
private |
Definition at line 3082 of file SNL_FEI_Structure.cpp.
References blockIDs_, blocks_, NodeDescriptor::getBlockIndexList(), NodeDescriptor::getFieldIDList(), getFieldSize(), NodeDatabase::getNodeAtIndex(), NodeDescriptor::getNumFields(), NodeDatabase::getNumNodeDescriptors(), and nodeDatabase_.
Referenced by initComplete().
|
private |
Definition at line 247 of file SNL_FEI_Structure.cpp.
References blockIDs_, and blocks_.
Referenced by ~SNL_FEI_Structure().
|
inlineprivate |
Definition at line 614 of file SNL_FEI_Structure.hpp.
References dbgOStreamPtr_.
Referenced by calcGlobalEqnInfo(), calculateSlaveEqns(), createMatrixPosition(), createMatrixPositions(), finalizeActiveNodes(), finalizeNodeCommMgr(), formMatrixStructure(), initComplete(), initCRMult(), initCRPen(), initElem(), initElemBlock(), initElemBlockStructure(), initFields(), initializeEqnCommMgr(), initMultCRStructure(), initPenCRStructure(), initSharedNodes(), initSlaveVariable(), storeElementScatterBlkIndices_noSlaves(), and storeElementScatterIndices_noSlaves().
|
private |
Definition at line 4356 of file SNL_FEI_Structure.cpp.
Referenced by initCRMult(), and initCRPen().
|
private |
Definition at line 2720 of file SNL_FEI_Structure.cpp.
References NodeDescriptor::getFieldIDList(), getFieldSize(), NodeDatabase::getNodeAtIndex(), NodeDatabase::getNodeIDs(), NodeDescriptor::getNumFields(), NodeDescriptor::getOwnerProc(), localBlkOffset_, localProc_, localStartRow_, nodeDatabase_, NodeDescriptor::setBlkEqnNumber(), NodeDescriptor::setFieldEqnNumber(), and NodeDescriptor::setNumNodalDOF().
Referenced by initComplete().
|
private |
Definition at line 2767 of file SNL_FEI_Structure.cpp.
References connTables_, BlockDescriptor::elemDOFEqnNumbers(), getBlockDescriptor_index(), getNumElemBlocks(), BlockDescriptor::getNumElemDOFPerElement(), localStartRow_, numLocalNodalEqns_, and voidERReturn.
Referenced by initComplete().
|
private |
Definition at line 2459 of file SNL_FEI_Structure.cpp.
References localBlkOffset_, localStartRow_, multCRs_, numLocalElemDOF_, numLocalEqnBlks_, numLocalMultCRs_, numLocalNodalEqns_, snl_fei::Constraint< RecordType >::setBlkEqnNumber(), and snl_fei::Constraint< RecordType >::setEqnNumber().
Referenced by initComplete().
|
private |
|
private |
Definition at line 630 of file SNL_FEI_Structure.hpp.
Referenced by allocateBlockConnectivity(), calcGlobalEqnInfo(), calculateSlaveEqns(), getBlockConnectivity(), getCommunicator(), getNodeMajorIndices(), initComplete(), initializeBlkEqnMapper(), and SNL_FEI_Structure().
|
private |
Definition at line 632 of file SNL_FEI_Structure.hpp.
Referenced by calcGlobalEqnInfo(), calculateSlaveEqns(), createBlkSymmEqnStructure(), createSymmEqnStructure(), finalizeActiveNodes(), finalizeNodeCommMgr(), formMatrixStructure(), getAssociatedNodeNumber(), getMatrixStructure(), initComplete(), initCRMult(), initCRPen(), initializeBlkEqnMapper(), initializeEqnCommMgr(), initMultCRStructure(), initPenCRStructure(), setNodalEqnInfo(), SNL_FEI_Structure(), translateToReducedNodeNumber(), and writeEqn2NodeMap().
|
private |
Definition at line 632 of file SNL_FEI_Structure.hpp.
Referenced by calcGlobalEqnInfo(), and SNL_FEI_Structure().
|
private |
Definition at line 632 of file SNL_FEI_Structure.hpp.
Referenced by assembleReducedStructure(), calcGlobalEqnInfo(), calculateSlaveEqns(), finalizeActiveNodes(), finalizeNodeCommMgr(), initializeBlkEqnMapper(), isInLocalElement(), SNL_FEI_Structure(), and writeEqn2NodeMap().
|
private |
Definition at line 634 of file SNL_FEI_Structure.hpp.
Referenced by getFieldIDs(), and initFields().
|
private |
Definition at line 635 of file SNL_FEI_Structure.hpp.
Referenced by initFields().
|
private |
Definition at line 636 of file SNL_FEI_Structure.hpp.
Referenced by getFieldIDsPtr(), getFieldSize(), getFieldSizesPtr(), getNumFields(), getScatterIndices_index(), initFields(), initializeBlkEqnMapper(), SNL_FEI_Structure(), and ~SNL_FEI_Structure().
|
private |
Definition at line 637 of file SNL_FEI_Structure.hpp.
Referenced by getFieldDofMap(), and initFields().
|
private |
Definition at line 638 of file SNL_FEI_Structure.hpp.
Referenced by getFieldIDsPtr(), and getFieldSizesPtr().
|
private |
Definition at line 640 of file SNL_FEI_Structure.hpp.
Referenced by addBlock(), allocateBlockConnectivity(), destroyBlockRoster(), destroyConnectivityTables(), finalizeActiveNodes(), getBlockConnectivity(), getBlockDescriptor(), getBlockDescriptor_index(), getBlockID(), getElemBlockIDs(), getIndexOfBlock(), getNumElemBlocks(), getScatterIndices_ID(), and setNumNodesAndEqnsPerBlock().
|
private |
Definition at line 641 of file SNL_FEI_Structure.hpp.
Referenced by addBlock(), allocateBlockConnectivity(), destroyBlockRoster(), finalizeActiveNodes(), getBlkScatterIndices_index(), getBlockDescriptor(), getBlockDescriptor_index(), getScatterIndices_index(), and setNumNodesAndEqnsPerBlock().
|
private |
Definition at line 642 of file SNL_FEI_Structure.hpp.
Referenced by addBlock(), allocateBlockConnectivity(), destroyConnectivityTables(), finalizeActiveNodes(), getBlockConnectivity(), getElemNodeDescriptors(), getScatterIndices_ID(), initSharedNodes(), and setElemDOFEqnInfo().
|
private |
Definition at line 644 of file SNL_FEI_Structure.hpp.
Referenced by calculateSlaveEqns(), finalizeActiveNodes(), finalizeNodeCommMgr(), findNode(), findNodeDescriptor(), getActiveNodeIDList(), getAssociatedFieldID(), getAssociatedNodeNumber(), getElemNodeDescriptors(), getEqnNumber(), getEqnNumbers(), getNodeDatabase(), getNumActiveNodes(), getNumSubdomains(), getSubdomainList(), initComplete(), initElem(), initializeBlkEqnMapper(), isInLocalElement(), setNodalEqnInfo(), setNumNodesAndEqnsPerBlock(), SNL_FEI_Structure(), writeEqn2NodeMap(), and ~SNL_FEI_Structure().
|
private |
Definition at line 646 of file SNL_FEI_Structure.hpp.
Referenced by finalizeActiveNodes(), getElemNodeDescriptors(), and initSharedNodes().
|
private |
Definition at line 648 of file SNL_FEI_Structure.hpp.
Referenced by calcGlobalEqnInfo(), getGlobalNodeOffsets(), and initializeBlkEqnMapper().
|
private |
Definition at line 649 of file SNL_FEI_Structure.hpp.
Referenced by calcGlobalEqnInfo(), getGlobalEqnOffsets(), and getOwnerProcForEqn().
|
private |
Definition at line 650 of file SNL_FEI_Structure.hpp.
Referenced by calcGlobalEqnInfo(), and getGlobalBlkEqnOffsets().
|
private |
Definition at line 652 of file SNL_FEI_Structure.hpp.
Referenced by addSlaveVariable(), calculateSlaveEqns(), SNL_FEI_Structure(), and ~SNL_FEI_Structure().
|
private |
Definition at line 653 of file SNL_FEI_Structure.hpp.
Referenced by calculateSlaveEqns(), getMasterEqnCoefs(), getMasterEqnNumbers(), getMasterEqnRHS(), getSlaveEqns(), isSlaveEqn(), SNL_FEI_Structure(), translateFromReducedEqn(), and ~SNL_FEI_Structure().
|
private |
Definition at line 654 of file SNL_FEI_Structure.hpp.
Referenced by calculateSlaveEqns(), and translateToReducedEqn().
|
private |
Definition at line 655 of file SNL_FEI_Structure.hpp.
Referenced by calculateSlaveEqns(), initComplete(), isSlaveEqn(), numSlaveEquations(), translateToReducedEqn(), and translateToReducedEqns().
|
private |
Definition at line 655 of file SNL_FEI_Structure.hpp.
Referenced by calculateSlaveEqns(), and translateToReducedEqn().
|
private |
Definition at line 655 of file SNL_FEI_Structure.hpp.
Referenced by calculateSlaveEqns(), and translateToReducedEqn().
|
private |
Definition at line 656 of file SNL_FEI_Structure.hpp.
Referenced by calculateSlaveEqns(), getSlaveDependencies(), and ~SNL_FEI_Structure().
|
private |
Definition at line 657 of file SNL_FEI_Structure.hpp.
Referenced by calculateSlaveEqns(), initializeBlkEqnMapper(), and translateToReducedNodeNumber().
|
private |
Definition at line 658 of file SNL_FEI_Structure.hpp.
Referenced by calculateSlaveEqns(), and translateToReducedNodeNumber().
|
private |
Definition at line 660 of file SNL_FEI_Structure.hpp.
Referenced by calculateSlaveEqns(), finalizeActiveNodes(), finalizeNodeCommMgr(), getNodeCommMgr(), getNumSharedNodes(), getNumSharingProcs(), getNumSubdomains(), getSharedNodeNumbers(), getSharedNodeProcs(), getSubdomainList(), initializeEqnCommMgr(), initSharedNodes(), isInLocalElement(), parameters(), SNL_FEI_Structure(), and ~SNL_FEI_Structure().
|
private |
Definition at line 661 of file SNL_FEI_Structure.hpp.
Referenced by assembleReducedStructure(), calculateSlaveEqns(), createBlkSymmEqnStructure(), createSymmEqnStructure(), formMatrixStructure(), getEqnCommMgr(), initComplete(), initializeEqnCommMgr(), SNL_FEI_Structure(), storeElementScatterBlkIndices_noSlaves(), storeElementScatterIndices(), storeElementScatterIndices_noSlaves(), storeNodalSendIndex(), storeNodalSendIndices(), and ~SNL_FEI_Structure().
|
private |
Definition at line 662 of file SNL_FEI_Structure.hpp.
Referenced by calculateSlaveEqns(), and initComplete().
|
private |
Definition at line 664 of file SNL_FEI_Structure.hpp.
Referenced by calcGlobalEqnInfo(), getEqnInfo(), and getNumGlobalEqns().
|
private |
Definition at line 665 of file SNL_FEI_Structure.hpp.
Referenced by getEqnInfo(), getNumLocalEqns(), and initComplete().
|
private |
Definition at line 666 of file SNL_FEI_Structure.hpp.
Referenced by calcGlobalEqnInfo(), getEqnInfo(), getFirstLocalEqn(), initComplete(), initializeBlkEqnMapper(), setElemDOFEqnInfo(), setMultCREqnInfo(), setNodalEqnInfo(), storeElementScatterIndices(), and storeNodalColumnIndices().
|
private |
Definition at line 667 of file SNL_FEI_Structure.hpp.
Referenced by calcGlobalEqnInfo(), getEqnInfo(), getLastLocalEqn(), initComplete(), storeElementScatterBlkIndices_noSlaves(), storeElementScatterIndices(), storeElementScatterIndices_noSlaves(), and storeNodalColumnIndices().
|
private |
Definition at line 669 of file SNL_FEI_Structure.hpp.
Referenced by initComplete(), initializeBlkEqnMapper(), setElemDOFEqnInfo(), and setMultCREqnInfo().
|
private |
Definition at line 670 of file SNL_FEI_Structure.hpp.
Referenced by initComplete(), and setMultCREqnInfo().
|
private |
Definition at line 671 of file SNL_FEI_Structure.hpp.
Referenced by initComplete(), and setMultCREqnInfo().
|
private |
Definition at line 673 of file SNL_FEI_Structure.hpp.
Referenced by createBlkSymmEqnStructure(), createMatrixPosition(), createMatrixPositions(), createSymmEqnStructure(), formMatrixStructure(), getFirstReducedEqn(), getMatrixStructure(), initComplete(), storeElementScatterBlkIndices_noSlaves(), and storeElementScatterIndices_noSlaves().
|
private |
Definition at line 673 of file SNL_FEI_Structure.hpp.
Referenced by createBlkSymmEqnStructure(), createMatrixPosition(), createMatrixPositions(), createSymmEqnStructure(), formMatrixStructure(), getLastReducedEqn(), and initComplete().
|
private |
Definition at line 673 of file SNL_FEI_Structure.hpp.
Referenced by getMatrixRowLengths(), getMatrixStructure(), getNumLocalReducedEqns(), and initComplete().
|
private |
Definition at line 674 of file SNL_FEI_Structure.hpp.
Referenced by assembleReducedStructure(), createBlkSymmEqnStructure(), createSymmEqnStructure(), SNL_FEI_Structure(), and ~SNL_FEI_Structure().
|
private |
Definition at line 674 of file SNL_FEI_Structure.hpp.
Referenced by assembleReducedStructure(), createBlkSymmEqnStructure(), createSymmEqnStructure(), SNL_FEI_Structure(), and ~SNL_FEI_Structure().
|
private |
Definition at line 674 of file SNL_FEI_Structure.hpp.
Referenced by assembleReducedStructure(), createBlkSymmEqnStructure(), createSymmEqnStructure(), SNL_FEI_Structure(), and ~SNL_FEI_Structure().
|
private |
Definition at line 675 of file SNL_FEI_Structure.hpp.
Referenced by assembleReducedStructure().
|
private |
Definition at line 675 of file SNL_FEI_Structure.hpp.
Referenced by assembleReducedStructure().
|
private |
Definition at line 675 of file SNL_FEI_Structure.hpp.
Referenced by assembleReducedStructure().
|
private |
Definition at line 675 of file SNL_FEI_Structure.hpp.
Referenced by assembleReducedStructure().
|
private |
Definition at line 675 of file SNL_FEI_Structure.hpp.
Referenced by assembleReducedStructure().
|
private |
Definition at line 675 of file SNL_FEI_Structure.hpp.
Referenced by assembleReducedStructure().
|
private |
Definition at line 676 of file SNL_FEI_Structure.hpp.
Referenced by assembleReducedStructure(), createBlkSymmEqnStructure(), createSymmEqnStructure(), and initElemBlockStructure().
|
private |
Definition at line 676 of file SNL_FEI_Structure.hpp.
|
private |
Definition at line 677 of file SNL_FEI_Structure.hpp.
Referenced by createBlkSymmEqnStructure(), and createSymmEqnStructure().
|
private |
Definition at line 677 of file SNL_FEI_Structure.hpp.
|
private |
Definition at line 678 of file SNL_FEI_Structure.hpp.
Referenced by getBlkScatterIndices_index(), and getScatterIndices_index().
|
private |
Definition at line 680 of file SNL_FEI_Structure.hpp.
Referenced by getMatrixRowLengths(), getMatrixStructure(), and initComplete().
|
private |
Definition at line 681 of file SNL_FEI_Structure.hpp.
Referenced by createMatrixPosition(), createMatrixPositions(), initComplete(), storeElementScatterBlkIndices_noSlaves(), and storeElementScatterIndices_noSlaves().
|
private |
Definition at line 683 of file SNL_FEI_Structure.hpp.
Referenced by createMatrixPosition(), createMatrixPositions(), destroyMatIndices(), getMatrixRowLengths(), getMatrixStructure(), initComplete(), storeElementScatterBlkIndices_noSlaves(), and storeElementScatterIndices_noSlaves().
|
private |
Definition at line 685 of file SNL_FEI_Structure.hpp.
Referenced by initComplete().
|
private |
Definition at line 686 of file SNL_FEI_Structure.hpp.
Referenced by calcGlobalEqnInfo(), getEqnBlkInfo(), and getNumGlobalEqnBlks().
|
private |
Definition at line 687 of file SNL_FEI_Structure.hpp.
Referenced by getEqnBlkInfo(), getNumLocalEqnBlks(), initComplete(), and setMultCREqnInfo().
|
private |
Definition at line 688 of file SNL_FEI_Structure.hpp.
Referenced by getMatrixStructure(), getNumLocalReducedEqnBlks(), and initComplete().
|
private |
Definition at line 689 of file SNL_FEI_Structure.hpp.
Referenced by calcGlobalEqnInfo(), getEqnBlkInfo(), initializeBlkEqnMapper(), setMultCREqnInfo(), and setNodalEqnInfo().
|
private |
Definition at line 690 of file SNL_FEI_Structure.hpp.
Referenced by getMatrixStructure(), and initComplete().
|
private |
Definition at line 691 of file SNL_FEI_Structure.hpp.
Referenced by getGlobalMaxBlkSize(), getMatrixStructure(), initComplete(), and initializeBlkEqnMapper().
|
private |
Definition at line 693 of file SNL_FEI_Structure.hpp.
Referenced by calcGlobalEqnInfo(), and initComplete().
|
private |
Definition at line 694 of file SNL_FEI_Structure.hpp.
Referenced by calcGlobalEqnInfo().
|
private |
Definition at line 696 of file SNL_FEI_Structure.hpp.
Referenced by destroyMatIndices(), getMatrixStructure(), and initComplete().
|
private |
Definition at line 697 of file SNL_FEI_Structure.hpp.
Referenced by destroyMatIndices(), and initComplete().
|
private |
Definition at line 699 of file SNL_FEI_Structure.hpp.
Referenced by createBlkSymmEqnStructure(), createSymmEqnStructure(), and storeElementScatterIndices().
|
private |
Definition at line 701 of file SNL_FEI_Structure.hpp.
Referenced by getBlkEqnMapper(), getBlkEqnSize(), getMatrixStructure(), getOffsetIntoBlkEqn(), initComplete(), initializeBlkEqnMapper(), isExactlyBlkEqn(), ptEqnToBlkEqn(), and ~SNL_FEI_Structure().
|
private |
Definition at line 703 of file SNL_FEI_Structure.hpp.
Referenced by deleteMultCRs(), getMultConstRecord(), getMultConstRecords(), getNumMultConstRecords(), initCRMult(), initializeBlkEqnMapper(), initMultCRStructure(), setMultCREqnInfo(), and writeEqn2NodeMap().
|
private |
Definition at line 705 of file SNL_FEI_Structure.hpp.
Referenced by getNumPenConstRecords(), getPenConstRecord(), getPenConstRecords(), initCRPen(), initPenCRStructure(), and ~SNL_FEI_Structure().
|
private |
Definition at line 707 of file SNL_FEI_Structure.hpp.
Referenced by finalizeNodeCommMgr(), and parameters().
|
private |
Definition at line 709 of file SNL_FEI_Structure.hpp.
Referenced by setDbgOut(), and writeEqn2NodeMap().
|
private |
Definition at line 711 of file SNL_FEI_Structure.hpp.
Referenced by createMatrixPosition(), createMatrixPositions(), finalizeNodeCommMgr(), getFieldMajorIndices(), getNodeMajorIndices(), initElem(), parameters(), storeElementScatterBlkIndices_noSlaves(), and storeElementScatterIndices_noSlaves().
|
private |
Definition at line 712 of file SNL_FEI_Structure.hpp.
Referenced by calcGlobalEqnInfo(), calculateSlaveEqns(), createMatrixPosition(), createMatrixPositions(), finalizeActiveNodes(), finalizeNodeCommMgr(), formMatrixStructure(), initComplete(), initCRMult(), initCRPen(), initElem(), initElemBlock(), initElemBlockStructure(), initFields(), initializeEqnCommMgr(), initMultCRStructure(), initPenCRStructure(), initSharedNodes(), initSlaveVariable(), parameters(), setDbgOut(), storeElementScatterBlkIndices_noSlaves(), and storeElementScatterIndices_noSlaves().
|
private |
Definition at line 713 of file SNL_FEI_Structure.hpp.
Referenced by setDbgOut(), and writeEqn2NodeMap().
|
private |
Definition at line 715 of file SNL_FEI_Structure.hpp.
Referenced by dbgOut(), and setDbgOut().
|
private |
Definition at line 719 of file SNL_FEI_Structure.hpp.
Referenced by setDbgOut().