|
| const std::vector< int > & | Stencil (int i=0) |
| | Local Stencil Info. More...
|
| |
| int | RowIndex (int i=0) |
| | RowIndex. More...
|
| |
| const std::vector< long long > & | Stencil64 (int i=0) |
| | Local Stencil Info. More...
|
| |
| long long | RowIndex64 (int i=0) |
| | RowIndex. More...
|
| |
| void | LoadBlock (const Epetra_RowMatrix &BaseMatrix, const int Row, const int Col) |
| | Routine for loading a base matrices values into the large Block Matrix The Row and Col arguments are indices into RowStencil. More...
|
| |
| void | LoadBlock (const Epetra_RowMatrix &BaseMatrix, const long long Row, const long long Col) |
| |
| void | SumIntoBlock (double alpha, const Epetra_RowMatrix &BaseMatrix, const int Row, const int Col) |
| | Routine for summing base matrices values into the large Block Matrix The Row and Col arguments are indices into RowStencil. More...
|
| |
| void | SumIntoBlock (double alpha, const Epetra_RowMatrix &BaseMatrix, const long long Row, const long long Col) |
| |
| void | SumIntoGlobalBlock (double alpha, const Epetra_RowMatrix &BaseMatrix, const int Row, const int Col) |
| | Routine for summing base matrices values into the large Block Matrix The Row and Col arguments are global indices. More...
|
| |
| void | SumIntoGlobalBlock (double alpha, const Epetra_RowMatrix &BaseMatrix, const long long Row, const long long Col) |
| |
| void | BlockSumIntoGlobalValues (const int BaseRow, int NumIndices, double *Values, const int *Indices, const int Row, const int Col) |
| | Sum Entries into Block matrix using base-matrix numbering plus block Row and Col The Row and Col arguments are indices into RowStencil. More...
|
| |
| void | BlockSumIntoGlobalValues (const long long BaseRow, int NumIndices, double *Values, const long long *Indices, const long long Row, const long long Col) |
| |
| void | BlockReplaceGlobalValues (const int BaseRow, int NumIndices, double *Values, const int *Indices, const int Row, const int Col) |
| |
| void | BlockReplaceGlobalValues (const long long BaseRow, int NumIndices, double *Values, const long long *Indices, const long long Row, const long long Col) |
| |
| void | BlockExtractGlobalRowView (const int BaseRow, int &NumEntries, double *&Values, const int Row, const int Col) |
| |
| void | BlockExtractGlobalRowView (const long long BaseRow, int &NumEntries, double *&Values, const long long Row, const long long Col) |
| |
| void | ExtractBlock (Epetra_CrsMatrix &BaseMatrix, const int Row, const int Col) |
| |
| void | ExtractBlock (Epetra_CrsMatrix &BaseMatrix, const long long Row, const long long Col) |
| |
| template<> |
| std::vector< int > & | TRowIndices () |
| |
| template<> |
| std::vector< std::vector< int > > & | TRowStencil () |
| |
| template<> |
| std::vector< long long > & | TRowIndices () |
| |
| template<> |
std::vector< std::vector< long
long > > & | TRowStencil () |
| |
| | Epetra_CrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, const int *NumEntriesPerRow, bool StaticProfile=false) |
| |
| | Epetra_CrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, int NumEntriesPerRow, bool StaticProfile=false) |
| |
| | Epetra_CrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, const Epetra_Map &ColMap, const int *NumEntriesPerRow, bool StaticProfile=false) |
| |
| | Epetra_CrsMatrix (Epetra_DataAccess CV, const Epetra_Map &RowMap, const Epetra_Map &ColMap, int NumEntriesPerRow, bool StaticProfile=false) |
| |
| | Epetra_CrsMatrix (Epetra_DataAccess CV, const Epetra_CrsGraph &Graph) |
| |
| | Epetra_CrsMatrix (const Epetra_CrsMatrix &SourceMatrix, const Epetra_Import &RowImporter, const Epetra_Map *DomainMap=0, const Epetra_Map *RangeMap=0, bool RestrictCommunicator=false) |
| |
| | Epetra_CrsMatrix (const Epetra_CrsMatrix &SourceMatrix, const Epetra_Import &RowImporter, const Epetra_Import *DomainImporter, const Epetra_Map *DomainMap, const Epetra_Map *RangeMap, bool RestrictCommunicator) |
| |
| | Epetra_CrsMatrix (const Epetra_CrsMatrix &SourceMatrix, const Epetra_Export &RowExporter, const Epetra_Map *DomainMap=0, const Epetra_Map *RangeMap=0, bool RestrictCommunicator=false) |
| |
| | Epetra_CrsMatrix (const Epetra_CrsMatrix &SourceMatrix, const Epetra_Export &RowExporter, const Epetra_Export *DomainExporter, const Epetra_Map *DomainMap, const Epetra_Map *RangeMap, bool RestrictCommunicator) |
| |
| | Epetra_CrsMatrix (const Epetra_CrsMatrix &Matrix) |
| |
| virtual | ~Epetra_CrsMatrix () |
| |
| Epetra_CrsMatrix & | operator= (const Epetra_CrsMatrix &src) |
| |
| int | PutScalar (double ScalarConstant) |
| |
| int | Scale (double ScalarConstant) |
| |
| virtual int | InsertGlobalValues (int GlobalRow, int NumEntries, const double *Values, const int *Indices) |
| |
| virtual int | InsertGlobalValues (int GlobalRow, int NumEntries, double *Values, int *Indices) |
| |
| virtual int | ReplaceGlobalValues (int GlobalRow, int NumEntries, const double *Values, const int *Indices) |
| |
| virtual int | SumIntoGlobalValues (int GlobalRow, int NumEntries, const double *Values, const int *Indices) |
| |
| int | InsertMyValues (int MyRow, int NumEntries, const double *Values, const int *Indices) |
| |
| int | InsertMyValues (int MyRow, int NumEntries, double *Values, int *Indices) |
| |
| int | ReplaceMyValues (int MyRow, int NumEntries, const double *Values, const int *Indices) |
| |
| int | SumIntoMyValues (int MyRow, int NumEntries, const double *Values, const int *Indices) |
| |
| int | ReplaceDiagonalValues (const Epetra_Vector &Diagonal) |
| |
| int | FillComplete (bool OptimizeDataStorage=true) |
| |
| int | FillComplete (const Epetra_Map &DomainMap, const Epetra_Map &RangeMap, bool OptimizeDataStorage=true) |
| |
| int | OptimizeStorage () |
| |
| int | MakeDataContiguous () |
| |
| int | ExtractGlobalRowCopy (int GlobalRow, int Length, int &NumEntries, double *Values, int *Indices) const |
| |
| int | ExtractMyRowCopy (int MyRow, int Length, int &NumEntries, double *Values, int *Indices) const |
| |
| int | ExtractGlobalRowCopy (int GlobalRow, int Length, int &NumEntries, double *Values) const |
| |
| int | ExtractMyRowCopy (int MyRow, int Length, int &NumEntries, double *Values) const |
| |
| int | ExtractDiagonalCopy (Epetra_Vector &Diagonal) const |
| |
| int | ExtractGlobalRowView (int GlobalRow, int &NumEntries, double *&Values, int *&Indices) const |
| |
| int | ExtractMyRowView (int MyRow, int &NumEntries, double *&Values, int *&Indices) const |
| |
| int | ExtractGlobalRowView (int GlobalRow, int &NumEntries, double *&Values) const |
| |
| int | ExtractMyRowView (int MyRow, int &NumEntries, double *&Values) const |
| |
| int | Multiply (bool TransA, const Epetra_Vector &x, Epetra_Vector &y) const |
| |
| int | Multiply (bool TransA, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
| |
| int | Solve (bool Upper, bool Trans, bool UnitDiagonal, const Epetra_Vector &x, Epetra_Vector &y) const |
| |
| int | Solve (bool Upper, bool Trans, bool UnitDiagonal, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
| |
| int | InvRowSums (Epetra_Vector &x) const |
| |
| int | InvRowMaxs (Epetra_Vector &x) const |
| |
| int | LeftScale (const Epetra_Vector &x) |
| |
| int | InvColSums (Epetra_Vector &x) const |
| |
| int | InvColMaxs (Epetra_Vector &x) const |
| |
| int | RightScale (const Epetra_Vector &x) |
| |
| bool | Filled () const |
| |
| bool | StorageOptimized () const |
| |
| bool | IndicesAreGlobal () const |
| |
| bool | IndicesAreLocal () const |
| |
| bool | IndicesAreContiguous () const |
| |
| bool | LowerTriangular () const |
| |
| bool | UpperTriangular () const |
| |
| bool | NoDiagonal () const |
| |
| double | NormInf () const |
| |
| double | NormOne () const |
| |
| double | NormFrobenius () const |
| |
| int | NumGlobalNonzeros () const |
| |
| int | NumGlobalRows () const |
| |
| int | NumGlobalCols () const |
| |
| int | NumGlobalDiagonals () const |
| |
| int | NumMyNonzeros () const |
| |
| int | NumMyRows () const |
| |
| int | NumMyCols () const |
| |
| int | NumMyDiagonals () const |
| |
| int | NumGlobalEntries (long long Row) const |
| |
| int | NumAllocatedGlobalEntries (int Row) const |
| |
| int | MaxNumEntries () const |
| |
| int | GlobalMaxNumEntries () const |
| |
| int | NumMyEntries (int Row) const |
| |
| int | NumAllocatedMyEntries (int Row) const |
| |
| int | IndexBase () const |
| |
| bool | StaticGraph () |
| |
| const Epetra_CrsGraph & | Graph () const |
| |
| const Epetra_Map & | RowMap () const |
| |
| int | ReplaceRowMap (const Epetra_BlockMap &newmap) |
| |
| bool | HaveColMap () const |
| |
| int | ReplaceColMap (const Epetra_BlockMap &newmap) |
| |
| int | ReplaceDomainMapAndImporter (const Epetra_Map &NewDomainMap, const Epetra_Import *NewImporter) |
| |
| int | RemoveEmptyProcessesInPlace (const Epetra_BlockMap *NewMap) |
| |
| const Epetra_Map & | ColMap () const |
| |
| const Epetra_Map & | DomainMap () const |
| |
| const Epetra_Map & | RangeMap () const |
| |
| const Epetra_Import * | Importer () const |
| |
| const Epetra_Export * | Exporter () const |
| |
| const Epetra_Comm & | Comm () const |
| |
| int | LRID (int GRID_in) const |
| |
| int | GRID (int LRID_in) const |
| |
| int | LCID (int GCID_in) const |
| |
| int | GCID (int LCID_in) const |
| |
| bool | MyGRID (int GRID_in) const |
| |
| bool | MyLRID (int LRID_in) const |
| |
| bool | MyGCID (int GCID_in) const |
| |
| bool | MyLCID (int LCID_in) const |
| |
| bool | MyGlobalRow (int GID) const |
| |
| virtual void | Print (std::ostream &os) const |
| |
| const char * | Label () const |
| |
| int | SetUseTranspose (bool UseTranspose_in) |
| |
| int | Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
| |
| int | ApplyInverse (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
| |
| bool | HasNormInf () const |
| |
| bool | UseTranspose () const |
| |
| const Epetra_Map & | OperatorDomainMap () const |
| |
| const Epetra_Map & | OperatorRangeMap () const |
| |
| int | NumMyRowEntries (int MyRow, int &NumEntries) const |
| |
| const Epetra_BlockMap & | Map () const |
| |
| const Epetra_Map & | RowMatrixRowMap () const |
| |
| const Epetra_Map & | RowMatrixColMap () const |
| |
| const Epetra_Import * | RowMatrixImporter () const |
| |
| double * | operator[] (int Loc) |
| |
| int | ExtractCrsDataPointers (int *&IndexOffset, int *&Indices, double *&Values_in) const |
| |
| Epetra_IntSerialDenseVector & | ExpertExtractIndexOffset () |
| |
| Epetra_IntSerialDenseVector & | ExpertExtractIndices () |
| |
| double *& | ExpertExtractValues () |
| |
| int | ExpertStaticFillComplete (const Epetra_Map &DomainMap, const Epetra_Map &RangeMap, const Epetra_Import *Importer=0, const Epetra_Export *Exporter=0, int NumMyDiagonals=-1) |
| |
| int | ExpertMakeUniqueCrsGraphData () |
| |
| int | SortGhostsAssociatedWithEachProcessor (bool Flag) |
| |
| const Epetra_Map & | ImportMap () const |
| |
| int | TransformToLocal () |
| |
| int | TransformToLocal (const Epetra_Map *DomainMap, const Epetra_Map *RangeMap) |
| |
| | Epetra_BLAS (void) |
| |
| | Epetra_BLAS (const Epetra_BLAS &BLAS) |
| |
| virtual | ~Epetra_BLAS (void) |
| |
| float | ASUM (const int N, const float *X, const int INCX=1) const |
| |
| double | ASUM (const int N, const double *X, const int INCX=1) const |
| |
| float | DOT (const int N, const float *X, const float *Y, const int INCX=1, const int INCY=1) const |
| |
| double | DOT (const int N, const double *X, const double *Y, const int INCX=1, const int INCY=1) const |
| |
| float | NRM2 (const int N, const float *X, const int INCX=1) const |
| |
| double | NRM2 (const int N, const double *X, const int INCX=1) const |
| |
| void | SCAL (const int N, const float ALPHA, float *X, const int INCX=1) const |
| |
| void | SCAL (const int N, const double ALPHA, double *X, const int INCX=1) const |
| |
| void | COPY (const int N, const float *X, float *Y, const int INCX=1, const int INCY=1) const |
| |
| void | COPY (const int N, const double *X, double *Y, const int INCX=1, const int INCY=1) const |
| |
| int | IAMAX (const int N, const float *X, const int INCX=1) const |
| |
| int | IAMAX (const int N, const double *X, const int INCX=1) const |
| |
| void | AXPY (const int N, const float ALPHA, const float *X, float *Y, const int INCX=1, const int INCY=1) const |
| |
| void | AXPY (const int N, const double ALPHA, const double *X, double *Y, const int INCX=1, const int INCY=1) const |
| |
| void | GEMV (const char TRANS, const int M, const int N, const float ALPHA, const float *A, const int LDA, const float *X, const float BETA, float *Y, const int INCX=1, const int INCY=1) const |
| |
| void | GEMV (const char TRANS, const int M, const int N, const double ALPHA, const double *A, const int LDA, const double *X, const double BETA, double *Y, const int INCX=1, const int INCY=1) const |
| |
| void | GEMM (const char TRANSA, const char TRANSB, const int M, const int N, const int K, const float ALPHA, const float *A, const int LDA, const float *B, const int LDB, const float BETA, float *C, const int LDC) const |
| |
| void | GEMM (const char TRANSA, const char TRANSB, const int M, const int N, const int K, const double ALPHA, const double *A, const int LDA, const double *B, const int LDB, const double BETA, double *C, const int LDC) const |
| |
| void | SYMM (const char SIDE, const char UPLO, const int M, const int N, const float ALPHA, const float *A, const int LDA, const float *B, const int LDB, const float BETA, float *C, const int LDC) const |
| |
| void | SYMM (const char SIDE, const char UPLO, const int M, const int N, const double ALPHA, const double *A, const int LDA, const double *B, const int LDB, const double BETA, double *C, const int LDC) const |
| |
| void | TRMM (const char SIDE, const char UPLO, const char TRANSA, const char DIAG, const int M, const int N, const float ALPHA, const float *A, const int LDA, float *B, const int LDB) const |
| |
| void | TRMM (const char SIDE, const char UPLO, const char TRANSA, const char DIAG, const int M, const int N, const double ALPHA, const double *A, const int LDA, double *B, const int LDB) const |
| |
| void | SYRK (const char UPLO, const char TRANS, const int N, const int K, const float ALPHA, const float *A, const int LDA, const float BETA, float *C, const int LDC) const |
| |
| void | SYRK (const char UPLO, const char TRANS, const int N, const int K, const double ALPHA, const double *A, const int LDA, const double BETA, double *C, const int LDC) const |
| |