FEI
Version of the Day
|
#include <fei_MatrixGraph_Impl2.hpp>
Classes | |
class | Factory |
Public Member Functions | |
MatrixGraph_Impl2 (fei::SharedPtr< fei::VectorSpace > rowSpace, fei::SharedPtr< fei::VectorSpace > colSpace, const char *name=NULL) | |
virtual | ~MatrixGraph_Impl2 () |
void | setParameters (const fei::ParameterSet ¶ms) |
void | setRowSpace (fei::SharedPtr< fei::VectorSpace > rowSpace) |
fei::SharedPtr< fei::VectorSpace > | getRowSpace () |
void | setColumnSpace (fei::SharedPtr< fei::VectorSpace > columnSpace) |
fei::SharedPtr< fei::VectorSpace > | getColSpace () |
int | definePattern (int numIDs, int idType) |
int | definePattern (int numIDs, int idType, int fieldID) |
int | definePattern (int numIDs, int idType, const int *numFieldsPerID, const int *fieldIDs) |
int | definePattern (int numIDs, const int *idTypes, const int *numFieldsPerID, const int *fieldIDs) |
int | initConnectivityBlock (int blockID, int numConnectivityLists, int patternID, bool diagonal=false) |
int | initConnectivityBlock (int numConnectivityLists, int patternID, bool diagonal=false) |
int | initConnectivityBlock (int blockID, int numConnectivityLists, int rowPatternID, int colPatternID) |
int | initConnectivity (int blockID, int connectivityID, const int *connectedIdentifiers) |
int | initConnectivity (int blockID, int connectivityID, const int *rowConnectedIdentifiers, const int *colConnectedIdentifiers) |
int | initConnectivity (int patternID, const int *connectedIdentifiers) |
int | initConnectivity (int rowPatternID, const int *rowConnectedIdentifiers, int colPatternID, const int *colConnectedIdentifiers) |
int | initConnectivity (int idType, int numRows, const int *rowIDs, const int *rowOffsets, const int *packedColumnIDs) |
int | initConnectivity (int idType, int fieldID, int numRows, const int *rowIDs, const int *rowOffsets, const int *packedColumnIDs) |
int | initConnectivity (int idType, int numRows, const int *rowIDs, const int *rowLengths, const int *const *columnIDs) |
int | initLagrangeConstraint (int constraintID, int constraintIDType, int numIDs, const int *idTypes, const int *IDs, const int *fieldIDs) |
int | initPenaltyConstraint (int constraintID, int constraintIDType, int numIDs, const int *idTypes, const int *IDs, const int *fieldIDs) |
int | initSlaveConstraint (int numIDs, const int *idTypes, const int *IDs, const int *fieldIDs, int offsetOfSlave, int offsetIntoSlaveField, const double *weights, double rhsValue) |
bool | hasSlaveDof (int ID, int idType) |
int | initComplete () |
fei::SharedPtr < fei::SparseRowGraph > | createGraph (bool blockEntryGraph, bool localRowGraph_includeSharedRows=false) |
int | compareStructure (const fei::MatrixGraph &matrixGraph, bool &equivalent) const |
int | getNumConnectivityBlocks () const |
std::map< int, fei::ConnectivityBlock * > & | getConnectivityBlocks () |
int | getConnectivityBlockIDs (std::vector< int > &blockIDs) const |
int | getNumIDsPerConnectivityList (int blockID) const |
int | getConnectivityNumIndices (int blockID) const |
int | getConnectivityNumIndices (int blockID, int &numRowIndices, int &numColIndices) |
int | getConnectivityIndices (int blockID, int connectivityID, int indicesAllocLen, int *indices, int &numIndices) |
int | getConnectivityIndices (int blockID, int connectivityID, int rowIndicesAllocLen, int *rowIndices, int &numRowIndices, int colIndicesAllocLen, int *colIndices, int &numColIndices) |
int | getPatternNumIndices (int patternID, int &numIndices) |
int | getPatternIndices (int patternID, const int *IDs, std::vector< int > &indices) |
int | getLocalNumLagrangeConstraints () const |
int | getGlobalNumSlaveConstraints () const |
ConstraintType * | getLagrangeConstraint (int constraintID) |
std::map< int, ConstraintType * > & | getLagrangeConstraints () |
ConstraintType * | getPenaltyConstraint (int constraintID) |
ConstraintType * | getSlaveConstraint (int constraintID) |
int | getConstraintConnectivityIndices (ConstraintType *cr, std::vector< int > &globalIndices) |
const fei::ConnectivityBlock * | getConnectivityBlock (int blockID) const |
fei::ConnectivityBlock * | getConnectivityBlock (int blockID) |
void | setIndicesMode (int mode) |
fei::SharedPtr< FillableMat > | getSlaveDependencyMatrix () |
fei::Pattern * | getPattern (int patternID) |
int | createSlaveMatrices () |
fei::SharedPtr< fei::Reducer > | getReducer () |
fei::SharedPtr < fei::SparseRowGraph > | getRemotelyOwnedGraphRows () |
void | getConstrainedIndices (std::vector< int > &crindices) const |
Public Member Functions inherited from fei::MatrixGraph | |
virtual | ~MatrixGraph () |
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_Impl2.hpp.
fei::MatrixGraph_Impl2::MatrixGraph_Impl2 | ( | fei::SharedPtr< fei::VectorSpace > | rowSpace, |
fei::SharedPtr< fei::VectorSpace > | colSpace, | ||
const char * | name = NULL |
||
) |
Constructor.
rowSpace | |
colSpace | |
name |
Definition at line 93 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Destructor.
Definition at line 141 of file fei_MatrixGraph_Impl2.cpp.
|
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.
Implements fei::MatrixGraph.
Definition at line 165 of file fei_MatrixGraph_Impl2.cpp.
|
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.
Implements fei::MatrixGraph.
Definition at line 222 of file fei_MatrixGraph_Impl2.cpp.
|
inlinevirtual |
Obtain the VectorSpace that corresponds to the row-space for this MatrixGraph object.
Implements fei::MatrixGraph.
Definition at line 715 of file fei_MatrixGraph_Impl2.hpp.
|
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.
Implements fei::MatrixGraph.
Definition at line 230 of file fei_MatrixGraph_Impl2.cpp.
|
inlinevirtual |
Obtain the VectorSpace that corresponds to the column-space for this MatrixGraph object.
Implements fei::MatrixGraph.
Definition at line 720 of file fei_MatrixGraph_Impl2.hpp.
|
virtual |
Define a pattern to use for subsequent blocked-contributions. Examples include element-contributions. returns patternID.
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(). |
Implements fei::MatrixGraph.
Definition at line 266 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Define a pattern to use for subsequent blocked-contributions. Examples include element-contributions. returns patternID.
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. |
Implements fei::MatrixGraph.
Definition at line 277 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Define a pattern to use for subsequent blocked-contributions. Examples include element-contributions. returns patternID
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. |
Implements fei::MatrixGraph.
Definition at line 300 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Define a pattern to use for subsequent blocked-contributions. Examples include element-contributions.
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. |
Implements fei::MatrixGraph.
Definition at line 330 of file fei_MatrixGraph_Impl2.cpp.
|
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. |
Implements fei::MatrixGraph.
Definition at line 376 of file fei_MatrixGraph_Impl2.cpp.
|
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. |
Implements fei::MatrixGraph.
Definition at line 414 of file fei_MatrixGraph_Impl2.cpp.
|
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(). |
Implements fei::MatrixGraph.
Definition at line 447 of file fei_MatrixGraph_Impl2.cpp.
|
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. |
Implements fei::MatrixGraph.
Definition at line 489 of file fei_MatrixGraph_Impl2.cpp.
|
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. |
Implements fei::MatrixGraph.
Definition at line 753 of file fei_MatrixGraph_Impl2.cpp.
|
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. |
Implements fei::MatrixGraph.
Definition at line 814 of file fei_MatrixGraph_Impl2.cpp.
|
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. |
Implements fei::MatrixGraph.
Definition at line 833 of file fei_MatrixGraph_Impl2.cpp.
|
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. |
Implements fei::MatrixGraph.
Definition at line 560 of file fei_MatrixGraph_Impl2.cpp.
|
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. |
Implements fei::MatrixGraph.
Definition at line 909 of file fei_MatrixGraph_Impl2.cpp.
|
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]. |
Implements fei::MatrixGraph.
Definition at line 600 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Initialize a lagrange-multiplier constraint.
Implements fei::MatrixGraph.
Definition at line 940 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Initialize a penalty constraint.
Implements fei::MatrixGraph.
Definition at line 988 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Initialize a slave constraint. (Note to self: document the parameters.)
Implements fei::MatrixGraph.
Definition at line 1047 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Query whether a given mesh object has one or more slave DOFs.
Implements fei::MatrixGraph.
Definition at line 1026 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Signal the MatrixGraph object that initialization is complete. At this point the MatrixGraph implementation performs internal synchronizations etc. This is a collective method.
Implements fei::MatrixGraph.
Definition at line 1164 of file fei_MatrixGraph_Impl2.cpp.
|
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 that are 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. |
Implements fei::MatrixGraph.
Definition at line 1300 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Query whether the specified MatrixGraph is structurally equivalent to this MatrixGraph.
Implements fei::MatrixGraph.
Definition at line 1728 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Query how many connectivity blocks have been initialized.
Implements fei::MatrixGraph.
Definition at line 1801 of file fei_MatrixGraph_Impl2.cpp.
|
inlinevirtual |
Query for the container of connectivity-blocks.
Implements fei::MatrixGraph.
Definition at line 725 of file fei_MatrixGraph_Impl2.hpp.
|
virtual |
Query for the list of connectivity-block-IDs.
Implements fei::MatrixGraph.
Definition at line 1807 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Query how many IDs are in each connectivity list in the specified connectivity block.
Implements fei::MatrixGraph.
Definition at line 1823 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Query how many scatter-indices are associated with each connectivity list for a given connectivity-block.
Implements fei::MatrixGraph.
Definition at line 1833 of file fei_MatrixGraph_Impl2.cpp.
|
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.
Implements fei::MatrixGraph.
Definition at line 1844 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Obtain the scatter-indices associated with a connectivity list.
Implements fei::MatrixGraph.
Definition at line 1881 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Obtain the scatter-indices for both the row- and column-dimension, associated with a connectivity list.
Implements fei::MatrixGraph.
Definition at line 1946 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Query associated with Pattern rather than connectivity-block.
Implements fei::MatrixGraph.
Definition at line 863 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Given a Pattern and list of IDs, fill output vector with associated indices.
Implements fei::MatrixGraph.
Definition at line 877 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Query number of local lagrange constraints
Implements fei::MatrixGraph.
Definition at line 2064 of file fei_MatrixGraph_Impl2.cpp.
|
inlinevirtual |
Query number of slave-constraints
Implements fei::MatrixGraph.
Definition at line 730 of file fei_MatrixGraph_Impl2.hpp.
|
virtual |
Won't typically be of interest to application users of fei:: methods.
Implements fei::MatrixGraph.
Definition at line 1132 of file fei_MatrixGraph_Impl2.cpp.
|
inlinevirtual |
Won't typically be of interest to application users of fei:: methods.
Implements fei::MatrixGraph.
Definition at line 735 of file fei_MatrixGraph_Impl2.hpp.
|
virtual |
Won't typically be of interest to application users of fei:: methods.
Implements fei::MatrixGraph.
Definition at line 1154 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Won't typically be of interest to application users of fei:: methods.
Implements fei::MatrixGraph.
Definition at line 1143 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Won't typically be of interest to application users of fei:: methods.
Implements fei::MatrixGraph.
Definition at line 1659 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Won't typically be of interest to application users of fei:: methods.
Implements fei::MatrixGraph.
Definition at line 1861 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Won't typically be of interest to application users of fei:: methods.
Implements fei::MatrixGraph.
Definition at line 1871 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Utility method.
Implements fei::MatrixGraph.
Definition at line 2669 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Utility method.
Implements fei::MatrixGraph.
Definition at line 2686 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
Retrieve pointer to specified Pattern object. If specified pattern is not found, return NULL.
Implements fei::MatrixGraph.
Definition at line 362 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
power-users only
Implements fei::MatrixGraph.
Definition at line 1383 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
query for the equation-reduction manager.
Implements fei::MatrixGraph.
Definition at line 1564 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
query for shared-but-not-owned graph rows
Implements fei::MatrixGraph.
Definition at line 1571 of file fei_MatrixGraph_Impl2.cpp.
|
virtual |
fill a vector with eqn-numbers of constrained ids
Implements fei::MatrixGraph.
Definition at line 1577 of file fei_MatrixGraph_Impl2.cpp.