FEI Package Browser (Single Doxygen Collection)
Version of the Day
|
This is the complete list of members for fei::Matrix_Impl< T >, including all inherited members.
addLogEqn(int eqn) | fei::Logger | protected |
addLogID(int ID) | fei::Logger | protected |
changedSinceMark() | fei::Matrix_Impl< T > | inlinevirtual |
changedSinceMark_ | fei::Matrix_Impl< T > | private |
convertPtToBlk(int numRows, const int *rows, int numCols, const int *cols, int *blkRows, int *blkRowOffsets, int *blkCols, int *blkColOffsets) | fei::Matrix_core | protected |
copyIn(int numRows, const int *rows, int numCols, const int *cols, const double *const *values, int format=0) | fei::Matrix_Impl< T > | virtual |
copyOutRow(int row, int len, double *coefs, int *indices) const | fei::Matrix_Impl< T > | virtual |
copyPointRowsToBlockRow(int numPtRows, int numPtCols, const double *const *ptValues, int numBlkCols, const int *blkColDims, double **blkValues) | fei::Matrix_core | protected |
copyTransposeToWorkArrays(int numRows, int numCols, const double *const *values, std::vector< double > &work_1D, std::vector< const double * > &work_2D) | fei::Matrix_core | static |
dbgprefix_ | fei::Matrix_Impl< T > | private |
eqnComm_ | fei::Matrix_core | protected |
firstLocalOffset() const | fei::Matrix_core | inlineprotected |
gatherFromOverlap(bool accumulate=true) | fei::Matrix_Impl< T > | virtual |
getBeginPointer() | fei::Matrix_Impl< T > | inlinevirtual |
getCommunicator() const | fei::Matrix_core | inlineprotected |
getGlobalNumRows() const | fei::Matrix_Impl< T > | inlinevirtual |
getLocalNumRows() const | fei::Matrix_Impl< T > | inlinevirtual |
getLogEqns() | fei::Logger | protected |
getLogIDs() | fei::Logger | protected |
getMatrix() | fei::Matrix_Impl< T > | inline |
getMatrix() const | fei::Matrix_Impl< T > | inline |
getMatrixGraph() const | fei::Matrix_Impl< T > | inlinevirtual |
getOffset(int row, int col) | fei::Matrix_Impl< T > | inlinevirtual |
getOwnerProc(int globalEqn) const | fei::Matrix_core | protected |
getRemotelyOwnedMatrices() | fei::Matrix_core | |
getRemotelyOwnedMatrix(int proc) const | fei::Matrix_core | inline |
getRemotelyOwnedMatrix(int proc) | fei::Matrix_core | inline |
getRowLength(int row, int &length) const | fei::Matrix_Impl< T > | virtual |
giveToBlockMatrix(int numRows, const int *rows, int numCols, const int *cols, const double *const *values, bool sumInto) | fei::Matrix_Impl< T > | privatevirtual |
giveToMatrix(int numRows, const int *rows, int numCols, const int *cols, const double *const *values, bool sumInto, int format) | fei::Matrix_Impl< T > | privatevirtual |
giveToUnderlyingBlockMatrix(int row, int rowDim, int numCols, const int *cols, const int *LDAs, const int *colDims, const double *const *values, bool sumInto) | fei::Matrix_Impl< T > | virtual |
giveToUnderlyingMatrix(int numRows, const int *rows, int numCols, const int *cols, const double *const *values, bool sumInto, int format) | fei::Matrix_Impl< T > | virtual |
globalAssemble() | fei::Matrix_Impl< T > | inlinevirtual |
globalAssembleCalled_ | fei::Matrix_Impl< T > | private |
globalOffsets() | fei::Matrix_core | inlineprotected |
globalOffsets() const | fei::Matrix_core | inlineprotected |
haveBlockMatrix() const | fei::Matrix_core | inlineprotected |
haveFEMatrix() const | fei::Matrix_core | inlineprotected |
isLogEqn(int eqn) | fei::Logger | protected |
isLogID(int ID) | fei::Logger | protected |
lastLocalOffset() const | fei::Matrix_core | inlineprotected |
localProc() const | fei::Matrix_core | inlineprotected |
logEqns_ | fei::Logger | protected |
Logger() | fei::Logger | protected |
logIDs_ | fei::Logger | protected |
markState() | fei::Matrix_Impl< T > | inlinevirtual |
matrix_ | fei::Matrix_Impl< T > | private |
Matrix_core(fei::SharedPtr< fei::MatrixGraph > matrixGraph, int numLocalEqns) | fei::Matrix_core | |
Matrix_Impl(fei::SharedPtr< T > matrix, fei::SharedPtr< fei::MatrixGraph > matrixGraph, int numLocalEqns, bool zeroSharedRows=true) | fei::Matrix_Impl< T > | |
multiply(fei::Vector *x, fei::Vector *y) | fei::Matrix_Impl< T > | virtual |
name_ | fei::Matrix_core | protected |
numProcs() const | fei::Matrix_core | inlineprotected |
output_level_ | fei::Logger | protected |
output_stream_ | fei::Logger | protected |
parameters(const fei::ParameterSet ¶mset) | fei::Matrix_Impl< T > | virtual |
putScalar(double scalar) | fei::Matrix_Impl< T > | virtual |
putScalar_remotelyOwned(double scalar) | fei::Matrix_core | |
setBlockMatrix(bool flag) | fei::Matrix_core | inlineprotected |
setCommSizes() | fei::Matrix_Impl< T > | virtual |
setEqnComm(fei::SharedPtr< fei::EqnComm > eqnComm) | fei::Matrix_core | |
setFEMatrix(bool flag) | fei::Matrix_core | inlineprotected |
setMatrixGraph(fei::SharedPtr< fei::MatrixGraph > matrixGraph) | fei::Matrix_Impl< T > | inlinevirtual |
setName(const char *name) | fei::Matrix_core | protected |
setOutputLevel(OutputLevel olevel) | fei::Logger | protected |
setRHS(fei::SharedPtr< fei::Vector > rhsvector) | fei::Matrix_core | |
setSlaveInfo(fei::SharedPtr< fei::MatrixGraph > matrixGraph) | fei::Matrix_core | |
sumIn(int numRows, const int *rows, int numCols, const int *cols, const double *const *values, int format=0) | fei::Matrix_Impl< T > | virtual |
sumIn(int blockID, int connectivityID, const double *const *values, int format=0) | fei::Matrix_Impl< T > | virtual |
sumInFieldData(int fieldID, int idType, int rowID, int colID, const double *const *data, int format=0) | fei::Matrix_Impl< T > | virtual |
sumInFieldData(int fieldID, int idType, int rowID, int colID, const double *data, int format=0) | fei::Matrix_Impl< T > | virtual |
typeName() | fei::Matrix_Impl< T > | inlinevirtual |
usingBlockEntryStorage() | fei::Matrix_Impl< T > | inlinevirtual |
vecSpace() const | fei::Matrix_core | inlineprotected |
vecSpace() | fei::Matrix_core | inlineprotected |
work_data1D_ | fei::Matrix_core | protected |
work_data2D_ | fei::Matrix_core | protected |
work_indices2_ | fei::Matrix_core | protected |
work_indices_ | fei::Matrix_core | protected |
work_ints_ | fei::Matrix_core | protected |
writeToFile(const char *filename, bool matrixMarketFormat=true) | fei::Matrix_Impl< T > | virtual |
writeToStream(FEI_OSTREAM &ostrm, bool matrixMarketFormat=true) | fei::Matrix_Impl< T > | virtual |
~Logger() | fei::Logger | protectedvirtual |
~Matrix() | fei::Matrix | inlinevirtual |
~Matrix_core() | fei::Matrix_core | virtual |
~Matrix_Impl() | fei::Matrix_Impl< T > | virtual |