FEI Package Browser (Single Doxygen Collection)
Version of the Day
|
#include <fei_MatrixGraph.hpp>
Classes | |
class | Factory |
Public Types | |
enum | { REDUCED_INDICES = 0, UNREDUCED_INDICES = 1, BLOCK_ENTRY_GRAPH = 2, POINT_ENTRY_GRAPH = 3 } |
Public Member Functions | |
virtual | ~MatrixGraph () |
virtual void | setParameters (const fei::ParameterSet ¶ms)=0 |
virtual void | setRowSpace (fei::SharedPtr< fei::VectorSpace > rowSpace)=0 |
virtual fei::SharedPtr < fei::VectorSpace > | getRowSpace ()=0 |
virtual void | setColumnSpace (fei::SharedPtr< fei::VectorSpace > columnSpace)=0 |
virtual fei::SharedPtr < fei::VectorSpace > | getColSpace ()=0 |
virtual int | definePattern (int numIDs, int idType)=0 |
virtual int | definePattern (int numIDs, int idType, int fieldID)=0 |
virtual int | definePattern (int numIDs, int idType, const int *numFieldsPerID, const int *fieldIDs)=0 |
virtual int | definePattern (int numIDs, const int *idTypes, const int *numFieldsPerID, const int *fieldIDs)=0 |
virtual int | initConnectivityBlock (int blockID, int numConnectivityLists, int patternID, bool diagonal=false)=0 |
virtual int | initConnectivityBlock (int numConnectivityLists, int patternID, bool diagonal=false)=0 |
virtual int | initConnectivityBlock (int blockID, int numConnectivityLists, int rowPatternID, int colPatternID)=0 |
virtual int | initConnectivity (int blockID, int connectivityID, const int *connectedIdentifiers)=0 |
virtual int | initConnectivity (int blockID, int connectivityID, const int *rowConnectedIdentifiers, const int *colConnectedIdentifiers)=0 |
virtual int | initConnectivity (int patternID, const int *connectedIdentifiers)=0 |
virtual int | initConnectivity (int rowPatternID, const int *rowConnectedIdentifiers, int colPatternID, const int *colConnectedIdentifiers)=0 |
virtual int | initConnectivity (int idType, int numRows, const int *rowIDs, const int *rowOffsets, const int *packedColumnIDs)=0 |
virtual int | initConnectivity (int idType, int fieldID, int numRows, const int *rowIDs, const int *rowOffsets, const int *packedColumnIDs)=0 |
virtual int | initConnectivity (int idType, int numRows, const int *rowIDs, const int *rowLengths, const int *const *columnIDs)=0 |
virtual int | initLagrangeConstraint (int constraintID, int constraintIDType, int numIDs, const int *idTypes, const int *IDs, const int *fieldIDs)=0 |
virtual int | initPenaltyConstraint (int constraintID, int constraintIDType, int numIDs, const int *idTypes, const int *IDs, const int *fieldIDs)=0 |
virtual int | initSlaveConstraint (int numIDs, const int *idTypes, const int *IDs, const int *fieldIDs, int offsetOfSlave, int offsetIntoSlaveField, const double *weights, double rhsValue)=0 |
virtual bool | newSlaveData ()=0 |
virtual bool | hasSlaveDof (int ID, int idType)=0 |
virtual int | initComplete ()=0 |
virtual fei::SharedPtr < fei::SparseRowGraph > | createGraph (bool blockEntryGraph, bool localRowGraph_includeSharedRows=false)=0 |
virtual int | compareStructure (const fei::MatrixGraph &matrixGraph, bool &equivalent) const =0 |
virtual int | getNumConnectivityBlocks () const =0 |
virtual std::map< int, fei::ConnectivityBlock * > & | getConnectivityBlocks ()=0 |
virtual int | getConnectivityBlockIDs (std::vector< int > &blockIDs) const =0 |
virtual int | getNumIDsPerConnectivityList (int blockID) const =0 |
virtual int | getConnectivityNumIndices (int blockID) const =0 |
virtual int | getConnectivityNumIndices (int blockID, int &numRowIndices, int &numColIndices)=0 |
virtual int | getConnectivityIndices (int blockID, int connectivityID, int indicesAllocLen, int *indices, int &numIndices)=0 |
virtual int | getConnectivityIndices (int blockID, int connectivityID, int rowIndicesAllocLen, int *rowIndices, int &numRowIndices, int colIndicesAllocLen, int *colIndices, int &numColIndices)=0 |
virtual int | getPatternNumIndices (int patternID, int &numIndices)=0 |
virtual int | getPatternIndices (int patternID, const int *IDs, std::vector< int > &indices)=0 |
virtual int | getLocalNumLagrangeConstraints () const =0 |
virtual int | getGlobalNumSlaveConstraints () const =0 |
virtual ConstraintType * | getLagrangeConstraint (int constraintID)=0 |
virtual std::map< int, ConstraintType * > & | getLagrangeConstraints ()=0 |
virtual ConstraintType * | getPenaltyConstraint (int constraintID)=0 |
virtual ConstraintType * | getSlaveConstraint (int constraintID)=0 |
virtual int | getConstraintConnectivityIndices (ConstraintType *cr, std::vector< int > &globalIndices)=0 |
virtual const fei::ConnectivityBlock * | getConnectivityBlock (int blockID) const =0 |
virtual fei::ConnectivityBlock * | getConnectivityBlock (int blockID)=0 |
virtual void | setIndicesMode (int mode)=0 |
virtual fei::SharedPtr < fei::FillableMat > | getSlaveDependencyMatrix ()=0 |
virtual fei::Pattern * | getPattern (int patternID)=0 |
virtual int | createSlaveMatrices ()=0 |
virtual fei::SharedPtr < fei::Reducer > | getReducer ()=0 |
virtual fei::SharedPtr < fei::SparseRowGraph > | getRemotelyOwnedGraphRows ()=0 |
virtual void | getConstrainedIndices (std::vector< int > &crindices) const =0 |
A container for the data that defines connectivity, and which will ultimately be used to generate a matrix graph.
Definition at line 33 of file fei_MatrixGraph.hpp.
anonymous enum |
Enumerator | |
---|---|
REDUCED_INDICES | |
UNREDUCED_INDICES | |
BLOCK_ENTRY_GRAPH | |
POINT_ENTRY_GRAPH |
Definition at line 51 of file fei_MatrixGraph.hpp.
|
inlinevirtual |
Destructor.
Definition at line 57 of file fei_MatrixGraph.hpp.
|
pure virtual |
Set parameters from a ParameterSet object. Currently two parameters are recognized: "debugOutput 'path'" where 'path' is the path to the location where debug-log files will be produced.
"name 'string'" where 'string' is an identifier that will be used in debug-log file-names.
Implemented in fei::MatrixGraph_Impl2.
Referenced by beam_main(), test_MatrixGraph::create_MatrixGraph(), main(), poisson3_main(), snl_fei_tester::setParameter(), and snl_fei_tester::testInitialization().
|
pure virtual |
Provide a VectorSpace to be used for looking up indices, field-masks, etc., for the row-space. If no column-VectorSpace is provided, it will be assumed that the column-space equals the row-space.
Implemented in fei::MatrixGraph_Impl2.
Referenced by test_MatrixGraph::create_MatrixGraph().
|
pure virtual |
Obtain the VectorSpace that corresponds to the row-space for this MatrixGraph object.
Implemented in fei::MatrixGraph_Impl2.
Referenced by fei_test_utils::copy_feiMatrix_to_FillableMat(), snl_fei::Broker_FEData::createMatrix(), snl_fei::Broker_FEData::createVector(), snl_fei::Broker_LinSysCore::createVector(), Factory_Aztec::createVector(), extractDirichletBCs(), fei::utils::getConnectivityArrays(), fei::MatrixReducer::getGlobalNumRows(), fei::MatrixReducer::getLocalNumRows(), fei::Matrix_Impl< T >::getOffset(), HexBeam_Functions::init_shared_nodes(), snl_fei::LinearSystem_General::LinearSystem_General(), fei::Lookup_Impl::Lookup_Impl(), fei::Matrix_core::Matrix_core(), test_Matrix::matrix_test1(), fei::MatrixReducer::MatrixReducer(), fei::Reducer::Reducer(), test_Matrix::serialtest1(), test_Matrix::serialtest2(), test_Matrix::serialtest3(), snl_fei::Broker_LinSysCore::setGlobalOffsets(), fei::Matrix_core::setMatrixGraph(), snl_fei::Broker_LinSysCore::setMatrixStructure(), snl_fei::Broker_FEData::setStructure(), fei::Matrix_Impl< T >::sumIn(), fei::Matrix_Local::sumInFieldData(), fei::MatrixReducer::sumInFieldData(), test_MatrixGraph::test5(), fei::MatrixReducer::writeToFile(), fei::Matrix_Local::writeToFile(), fei::Matrix_Impl< T >::writeToFile(), fei::Matrix_Local::writeToStream(), and fei::Matrix_Impl< T >::writeToStream().
|
pure virtual |
Provide a VectorSpace to be used for looking up indices, field-masks, etc., for the column-space. If no column-VectorSpace is provided, it will be assumed that the column-space equals the row-space.
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Obtain the VectorSpace that corresponds to the column-space for this MatrixGraph object.
Implemented in fei::MatrixGraph_Impl2.
Referenced by fei::Matrix_Impl< T >::getOffset(), fei::Matrix_Impl< T >::sumIn(), fei::Matrix_Local::sumInFieldData(), fei::MatrixReducer::sumInFieldData(), fei::Matrix_Impl< T >::writeToFile(), and fei::Matrix_Local::writeToStream().
|
pure virtual |
Define a pattern to use for subsequent blocked-contributions. Examples include element-contributions. Return an int patternID that can be used to reference this pattern in calls to initConnectivityBlock, etc
This is the simplest of the pattern-definition methods. IMPORTANT NOTE: this method does not associate a field with the identifiers. Only use this method for problems where you explicitly don't want or need to associate fields with identifiers. Examples would include problems where only a single scalar field exists across the entire mesh and thus doesn't need to be explicitly referenced. Other cases where this might be used is for non finite-element problems that don't have identifier/field pairs.
numIDs | Input. number of identifiers per pattern 'instance'. |
idType | Input. Specifies which type of identifiers are associated with instances of this pattern. Must be one of the idTypes defined for a VectorSpace that is associated with this MatrixGraph. idTypes are defined via the method VectorSpace::defineIDTypes(). |
Implemented in fei::MatrixGraph_Impl2.
Referenced by test_Matrix::create_matrix(), test_MatrixGraph::create_MatrixGraph(), snl_fei_tester::definePattern(), init_elem_connectivities(), HexBeam_Functions::init_elem_connectivities(), init_nonsymmetric_block(), test_Matrix::serialtest1(), test_Matrix::serialtest2(), test_Matrix::serialtest3(), test_Matrix_unit2(), and test_Matrix_unit4().
|
pure virtual |
Define a pattern to use for subsequent blocked-contributions. Examples include element-contributions. Return an int patternID that can be used to reference this pattern in calls to initConnectivityBlock, etc
This is the simplest of the 3 pattern-definition methods that associate fields with identifiers (there is one pattern-definition method above that allows for specifying a pattern of identifiers that don't have associated fields). This method defines patterns for contributions where a single field is associated with each identifier in a list of identifiers, and all the identifiers in the list are of the same type.
numIDs | Input. number of identifiers per pattern 'instance'. |
idType | Input. Specifies which type of identifiers are associated with instances of this pattern. Must be one of the idTypes defined for a VectorSpace that is associated with this MatrixGraph. idTypes are defined via the method VectorSpace::defineIDTypes(). |
fieldID | Input. field-identifier for the single field that is to reside at each identifier. |
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Define a pattern to use for subsequent blocked-contributions. Examples include element-contributions. Return an int patternID that can be used to reference this pattern in calls to initConnectivityBlock, etc.
This is the 'middle' of the pattern-definition methods, in terms of the complexity of pattern that can be defined. This method defines patterns for contributions where the identifiers are all of the same type, but an arbitrary list of fields can be associated with each identifier.
numIDs | Input. number of identifiers per pattern 'instance'. |
idType | Input. Specifies which type of identifiers are associated with instances of this pattern. Must be one of the idTypes defined for a VectorSpace that is associated with this MatrixGraph. idTypes are defined via the method VectorSpace::defineIDTypes(). |
numFieldsPerID | Input. List of length numIDs. i-th entry ives the number of fields to be associated with the i-th identifier in a contribution. |
fieldIDs | Input. Packed list of length sum(numFieldsPerID[i]). Contains the fieldIDs to be associated with the identifiers for a contribution. |
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Define a pattern to use for subsequent blocked-contributions. Examples include element-contributions. Return an int patternID that can be used to reference this pattern in calls to initConnectivityBlock, etc.
This is the most general of the pattern-definition methods. This method defines a pattern consisting of a mixture of identifier-types, with each identifier having an arbitrary list of associated fields.
numIDs | Input. number of identifiers per pattern 'instance'. |
idTypes | Input. List of length numIDs. Specifies the type of each identifier to be contributed for instances of this pattern. Each of the idTypes must be one of the idTypes defined for a VectorSpace that is associated with this MatrixGraph. idTypes are defined via the method VectorSpace::defineIDTypes(). |
numFieldsPerID | Input. List of length numIDs. i-th entry gives the number of fields to be associated with the i-th identifier in a contribution. |
fieldIDs | Input. Packed list of length sum(numFieldsPerID[i]). Contains the fieldIDs to be associated with the identifiers for a contribution. |
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Initialize a block of connectivity contributions. An example is a block of elements which share a common layout of nodes/fields per element.
This method accepts only one pattern-id, implying that connectivities in this block describe a symmetric structure. See the other overloading of this method for the non-symmetric case.
blockID | Input. User-specified identifier for this block. Will generally be required to be non-negative. |
numConnectivityLists | Input. Number of connectivity-lists that will be supplied for this block. |
patternID | Input. Descriptor for the connectivities to be provided. Must be a pattern that was previously defined via definePattern(). |
diagonal | Optional argument, defaults to false. If specified as true, each connectivity list will only contribute diagonal entries to the graph. This is used if the connectivity-block represents a collection of lumped- mass submatrix contributions, or something similar. |
Implemented in fei::MatrixGraph_Impl2.
Referenced by test_Matrix::create_matrix(), test_MatrixGraph::create_MatrixGraph(), init_elem_connectivities(), HexBeam_Functions::init_elem_connectivities(), init_nonsymmetric_block(), snl_fei_tester::initElemBlocks(), test_Matrix::serialtest1(), test_Matrix::serialtest2(), test_Matrix::serialtest3(), test_Matrix_unit2(), and test_Matrix_unit4().
|
pure virtual |
Initialize a block of connectivity contributions. An example is a block of elements which share a common layout of nodes/fields per element.
This method accepts only one pattern-id, implying that connectivities in this block describe a symmetric structure. See the other overloading of this method for the non-symmetric case.
blockID | Input. User-specified identifier for this block. Will generally be required to be non-negative. |
numConnectivityLists | Input. Number of connectivity-lists that will be supplied for this block. |
patternID | Input. Descriptor for the connectivities to be provided. Must be a pattern that was previously defined via definePattern(). |
diagonal | Optional argument, defaults to false. If specified as true, each connectivity list will only contribute diagonal entries to the graph. This is used if the connectivity-block represents a collection of lumped- mass submatrix contributions, or something similar. |
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Initialize a block of connectivity contributions. An example is a block of elements which share a common layout of nodes/fields per element.
This method accepts two pattern-ids, implying that connectivities in this block describe a non-symmetric structure. See the other overloading of this method for the symmetric case.
blockID | Input. User-specified identifier for this block. Will generally be required to be non-negative. |
numConnectivityLists | Input. Number of connectivity-lists that will be supplied for this block. |
rowPatternID | Input. Descriptor for the row-connectivities to be provided. Must be a pattern that was previously defined via definePattern(). |
colPatternID | Input. Descriptor for the column-connectivities to be provided. Must be a pattern that was previously defined via definePattern(). |
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Make a contribution to the MatrixGraph's connectivity. Examples would include element-node connectivity lists, etc.
blockID | Input. Must correspond to a blockID that was previously used in a call to initConnectivityBlock(). |
connectivityID | Input. Identifier for this connectivity list. May be an element-identifier, etc. |
connectedIdentifiers | Input. List of the identifiers that form this connectivity list. |
Implemented in fei::MatrixGraph_Impl2.
Referenced by test_Matrix::create_matrix(), test_MatrixGraph::create_MatrixGraph(), init_elem_connectivities(), HexBeam_Functions::init_elem_connectivities(), init_nonsymmetric_block(), snl_fei_tester::initElemBlocks(), test_Matrix::serialtest1(), test_Matrix::serialtest2(), test_Matrix::serialtest3(), test_Matrix_unit2(), and test_Matrix_unit4().
|
pure virtual |
Make a contribution to the MatrixGraph's connectivity. This overloading of initConnectivity() provides for structurally non-symmetric entries.
blockID | Input. Must correspond to a blockID that was previously used in a call to initConnectivityBlock(). |
connectivityID | Input. Identifier for this connectivity list. May be an element-identifier, etc. |
rowConnectedIdentifiers | Input. List of the identifiers that form the connectivity list for the row-space. |
colConnectedIdentifiers | Input. List of the identifiers that form the connectivity list for the column-space. |
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Make a contribution to the MatrixGraph's connectivity. This overloading of initConnectivity() assumes structurally symmetric entries.
patternID | Input. Must correspond to a Pattern ID that was previously used in a call to definePattern(). |
connectedIdentifiers | Input. List of the identifiers that form the connectivity list for the row-space (and the column-space, since this is a structurally symmetric contribution). |
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Make a contribution to the MatrixGraph's connectivity. This overloading of initConnectivity() provides for structurally non-symmetric entries.
rowPatternID | Input. Must correspond to a Pattern ID that was previously used in a call to definePattern(). |
rowConnectedIdentifiers | Input. List of the identifiers that form the connectivity list for the row-space. |
colPatternID | Input. Must correspond to a Pattern ID that was previously used in a call to definePattern(). |
colConnectedIdentifiers | Input. List of the identifiers that form the connectivity list for the column-space. |
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Initialize a set of arbitrary positions in the graph by providing data in a "raw" or "purely algebraic" format similar to what might be used with a standard sparse CSR (compressed sparse row) matrix.
idType | identifier-type |
numRows | Number of rows, length of the following 'rowIDs' list. |
rowIDs | List of length 'numRows', specifying identifiers in the row-space. |
rowOffsets | List of length numRows+1, giving offsets into the 'packedColumnIDs' list at which each row begins. i.e., the column IDs for rowIDs[i] are packedColumnIDs[rowOffsets[i]...rowOffsets[i+1]-1]. |
packedColumnIDs | Packed list of length rowOffsets[numRows], containing the column IDs. |
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Initialize a set of arbitrary positions in the graph by providing data in a "raw" or "purely algebraic" format similar to what might be used with a standard sparse CSR (compressed sparse row) matrix. Also specify a fieldID to be associated with these graph positions.
idType | identifier-type |
fieldID | field-identifier |
numRows | Number of rows, length of the following 'rowIDs' list. |
rowIDs | List of length 'numRows', specifying identifiers in the row-space. |
rowOffsets | List of length numRows+1, giving offsets into the 'packedColumnIDs' list at which each row begins. i.e., the column IDs for rowIDs[i] are packedColumnIDs[rowOffsets[i]...rowOffsets[i+1]-1]. |
packedColumnIDs | Packed list of length rowOffsets[numRows], containing the column IDs. |
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Initialize a set of arbitrary positions in the graph by providing data in a "raw" or "purely algebraic" format similar to what might be used with a standard sparse CSR (compressed sparse row) matrix.
idType | identifier-type |
numRows | Number of rows, length of the following 'rowIDs' list. |
rowIDs | List of length 'numRows', specifying identifiers in the row-space. |
rowLengths | List of length numRows, giving the number of column IDs for each row ID. |
columnIDs | C-style table (list of lists) containing the column IDs. Number of rows is numRows, length of i-th row is rowLengths[i]. |
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Initialize a lagrange-multiplier constraint.
Implemented in fei::MatrixGraph_Impl2.
Referenced by HexBeam_Functions::init_constraints(), and snl_fei_tester::initConstraints().
|
pure virtual |
Initialize a penalty constraint.
Implemented in fei::MatrixGraph_Impl2.
Referenced by snl_fei_tester::initConstraints().
|
pure virtual |
Initialize a slave constraint. (Note to self: document the parameters.)
Implemented in fei::MatrixGraph_Impl2.
Referenced by HexBeam_Functions::init_slave_constraints(), snl_fei_tester::initConstraints(), test_Matrix::serialtest3(), test_MatrixGraph::test5(), and test_MatrixGraph_test6().
|
pure virtual |
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Query whether a given mesh object has one or more slave DOFs.
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Signal the MatrixGraph object that initialization is complete. At this point the MatrixGraph implementation performs internal synchronizations etc. This is a collective method.
Implemented in fei::MatrixGraph_Impl2.
Referenced by beam_main(), test_Matrix::create_matrix(), main(), poisson3_main(), test_Matrix::serialtest1(), test_Matrix::serialtest2(), test_Matrix::serialtest3(), test_MatrixGraph::test1(), test_MatrixGraph::test3(), test_Matrix::test3(), test_MatrixGraph::test4(), test_MatrixGraph::test5(), test_Matrix_unit2(), test_Matrix_unit4(), test_MatrixGraph_test6(), and snl_fei_tester::testInitialization().
|
pure virtual |
Generate a sparse row-based graph from structural data that has been accumulated. Don't use this until after initComplete() has been called.
locallyOwnedRows | Those rows of a matrix that would be owned by the local processor. |
blockEntryGraph | Specifies whether the graph should be constructed on a block-entry or point-entry basis. If there is only 1 scalar DOF at each mesh-object, then a block-entry graph is the same as a point-entry graph. |
Implemented in fei::MatrixGraph_Impl2.
Referenced by fei::Matrix_Local::create_Matrix_Local(), snl_fei::Broker_LinSysCore::setMatrixStructure(), test_MatrixGraph::test1(), test_MatrixGraph::test3(), test_MatrixGraph::test4(), and test_MatrixGraph::test5().
|
pure virtual |
Query whether the specified MatrixGraph is structurally equivalent to this MatrixGraph.
Implemented in fei::MatrixGraph_Impl2.
Referenced by test_MatrixGraph_test6().
|
pure virtual |
Query how many connectivity blocks have been initialized.
Implemented in fei::MatrixGraph_Impl2.
Referenced by fei::MatrixGraph_Impl2::compareStructure(), and snl_fei::Broker_FEData::setStructure().
|
pure virtual |
Query for the container of connectivity-blocks.
Implemented in fei::MatrixGraph_Impl2.
Referenced by fei::utils::getConnectivityArrays(), fei::Lookup_Impl::getNumElemBlocks(), and snl_fei::Broker_FEData::setStructure().
|
pure virtual |
Query for the list of connectivity-block-IDs.
Implemented in fei::MatrixGraph_Impl2.
Referenced by fei::MatrixGraph_Impl2::compareStructure(), fei::Lookup_Impl::getElemBlockIDs(), and snl_fei::Broker_FEData::setStructure().
|
pure virtual |
Query how many IDs are in each connectivity list in the specified connectivity block.
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Query how many scatter-indices are associated with each connectivity list for a given connectivity-block.
Implemented in fei::MatrixGraph_Impl2.
Referenced by load_elem_data(), snl_fei_tester::loadElemBlocks(), fei::Matrix_Local::sumIn(), fei::MatrixReducer::sumIn(), and test_Matrix::test3().
|
pure virtual |
Query how many scatter-indices are associated with each connectivity list for a given connectivity-block, in both the row-dimension and the column-dimension.
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Obtain the scatter-indices associated with a connectivity list.
Implemented in fei::MatrixGraph_Impl2.
Referenced by load_elem_data(), HexBeam_Functions::load_elem_data(), snl_fei_tester::loadElemBlocks(), test_Matrix::serialtest1(), fei::Matrix_Local::sumIn(), fei::MatrixReducer::sumIn(), and test_Matrix::test3().
|
pure virtual |
Obtain the scatter-indices for both the row- and column-dimension, associated with a connectivity list.
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Query associated with Pattern rather than connectivity-block.
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Query associated with Pattern rather than connectivity-block.
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Query number of local lagrange constraints
Implemented in fei::MatrixGraph_Impl2.
Referenced by fei::MatrixGraph_Impl2::compareStructure(), snl_fei::resolveConflictingCRs(), and snl_fei::Broker_FEData::setStructure().
|
pure virtual |
Query number of slave-constraints
Implemented in fei::MatrixGraph_Impl2.
Referenced by fei::MatrixGraph_Impl2::compareStructure(), Factory_Aztec::createMatrix(), Factory_Aztec::createVector(), extractDirichletBCs(), and fei::Matrix_Impl< T >::Matrix_Impl().
|
pure virtual |
Won't typically be of interest to application users of fei:: methods.
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Won't typically be of interest to application users of fei:: methods.
Implemented in fei::MatrixGraph_Impl2.
Referenced by snl_fei::resolveConflictingCRs().
|
pure virtual |
Won't typically be of interest to application users of fei:: methods.
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Won't typically be of interest to application users of fei:: methods.
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Won't typically be of interest to application users of fei:: methods.
Implemented in fei::MatrixGraph_Impl2.
Referenced by snl_fei::resolveConflictingCRs().
|
pure virtual |
Won't typically be of interest to application users of fei:: methods.
Implemented in fei::MatrixGraph_Impl2.
Referenced by fei::MatrixGraph_Impl2::compareStructure(), fei::Lookup_Impl::getElemBlockInfo(), fei::Lookup_Impl::getFieldIDsTable(), fei::Lookup_Impl::getNumFieldsPerNode(), snl_fei::Broker_FEData::setStructure(), and fei::Matrix_Impl< T >::sumIn().
|
pure virtual |
Won't typically be of interest to application users of fei:: methods.
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Utility method.
Implemented in fei::MatrixGraph_Impl2.
Referenced by HexBeam_Functions::load_elem_data(), and snl_fei_tester::testLoading().
|
pure virtual |
Utility method.
Implemented in fei::MatrixGraph_Impl2.
|
pure virtual |
Retrieve pointer to specified Pattern object. If specified pattern is not found, return NULL.
Implemented in fei::MatrixGraph_Impl2.
Referenced by test_Matrix_unit2(), and test_Matrix_unit4().
|
pure virtual |
power-users only
Implemented in fei::MatrixGraph_Impl2.
Referenced by snl_fei_tester::testLoading().
|
pure virtual |
Query for the object that manages the equation-space reductions associated with removing slave constraints from the linear system.
Implemented in fei::MatrixGraph_Impl2.
Referenced by Factory_Aztec::createMatrix(), snl_fei::Factory::createVector(), Factory_Aztec::createVector(), extractDirichletBCs(), and fei::DirichletBCManager::finalizeBCEqns().
|
pure virtual |
query for shared-but-not-owned graph rows
Implemented in fei::MatrixGraph_Impl2.
Referenced by fei::Matrix_Impl< T >::Matrix_Impl().
|
pure virtual |
fill a vector with eqn-numbers of constrained ids
Implemented in fei::MatrixGraph_Impl2.