|
EpetraExt Package Browser (Single Doxygen Collection)
Development
|
This is the complete list of members for EpetraExt::BlockVector, including all inherited members.
| ASUM(const int N, const float *X, const int INCX=1) const | Epetra_BLAS | |
| ASUM(const int N, const double *X, const int INCX=1) const | Epetra_BLAS | |
| AXPY(const int N, const float ALPHA, const float *X, float *Y, const int INCX=1, const int INCY=1) const | Epetra_BLAS | |
| AXPY(const int N, const double ALPHA, const double *X, double *Y, const int INCX=1, const int INCY=1) const | Epetra_BLAS | |
| BaseMap_ | EpetraExt::BlockVector | protected |
| BlockReplaceGlobalValues(int NumIndices, double *Values, int *Indices, int BlockRow) | EpetraExt::BlockVector | |
| BlockReplaceGlobalValues(int NumIndices, double *Values, long long *Indices, long long BlockRow) | EpetraExt::BlockVector | |
| BlockSumIntoGlobalValues(int NumIndices, double *Values, int *Indices, int BlockRow) | EpetraExt::BlockVector | |
| BlockSumIntoGlobalValues(int NumIndices, double *Values, long long *Indices, long long BlockRow) | EpetraExt::BlockVector | |
| BlockVector(const Epetra_BlockMap &BaseMap, const Epetra_BlockMap &GlobalMap) | EpetraExt::BlockVector | |
| BlockVector(Epetra_DataAccess CV, const Epetra_BlockMap &BaseMap, const Epetra_Vector &BlockVec) | EpetraExt::BlockVector | |
| BlockVector(const BlockVector &MV) | EpetraExt::BlockVector | |
| COPY(const int N, const float *X, float *Y, const int INCX=1, const int INCY=1) const | Epetra_BLAS | |
| COPY(const int N, const double *X, double *Y, const int INCX=1, const int INCY=1) const | Epetra_BLAS | |
| DOT(const int N, const float *X, const float *Y, const int INCX=1, const int INCY=1) const | Epetra_BLAS | |
| DOT(const int N, const double *X, const double *Y, const int INCX=1, const int INCY=1) const | Epetra_BLAS | |
| Epetra_BLAS(void) | Epetra_BLAS | |
| Epetra_BLAS(const Epetra_BLAS &BLAS) | Epetra_BLAS | |
| Epetra_Vector(const Epetra_BlockMap &Map, bool zeroOut=true) | Epetra_Vector | |
| Epetra_Vector(const Epetra_Vector &Source) | Epetra_Vector | |
| Epetra_Vector(Epetra_DataAccess CV, const Epetra_BlockMap &Map, double *V) | Epetra_Vector | |
| Epetra_Vector(Epetra_DataAccess CV, const Epetra_MultiVector &Source, int Index) | Epetra_Vector | |
| ExtractBlockValues(Epetra_Vector &BaseVec, long long BlockRow) const | EpetraExt::BlockVector | |
| ExtractCopy(double *V) const | Epetra_Vector | |
| ExtractView(double **V) const | Epetra_Vector | |
| 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 | Epetra_BLAS | |
| 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 | Epetra_BLAS | |
| 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 | Epetra_BLAS | |
| 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 | Epetra_BLAS | |
| GetBaseMap() const | EpetraExt::BlockVector | |
| GetBlock(long long BlockRow) const | EpetraExt::BlockVector | |
| GetBlock(long long BlockRow) | EpetraExt::BlockVector | |
| IAMAX(const int N, const float *X, const int INCX=1) const | Epetra_BLAS | |
| IAMAX(const int N, const double *X, const int INCX=1) const | Epetra_BLAS | |
| LoadBlockValues(const Epetra_Vector &BaseVec, long long BlockRow) | EpetraExt::BlockVector | |
| Map() const =0 | Epetra_SrcDistObject | pure virtual |
| NRM2(const int N, const float *X, const int INCX=1) const | Epetra_BLAS | |
| NRM2(const int N, const double *X, const int INCX=1) const | Epetra_BLAS | |
| Offset_ | EpetraExt::BlockVector | protected |
| operator[](int index) | Epetra_Vector | |
| operator[](int index) const | Epetra_Vector | |
| Print(std::ostream &os) const | Epetra_DistObject | virtual |
| ReplaceGlobalValues(int NumEntries, const double *Values, const int *Indices) | Epetra_Vector | |
| ReplaceGlobalValues(int NumEntries, const double *Values, const long long *Indices) | Epetra_Vector | |
| ReplaceGlobalValues(int NumEntries, int BlockOffset, const double *Values, const int *Indices) | Epetra_Vector | |
| ReplaceMyValues(int NumEntries, const double *Values, const int *Indices) | Epetra_Vector | |
| ReplaceMyValues(int NumEntries, int BlockOffset, const double *Values, const int *Indices) | Epetra_Vector | |
| ResetView(double *Values_in) | Epetra_Vector | |
| SCAL(const int N, const float ALPHA, float *X, const int INCX=1) const | Epetra_BLAS | |
| SCAL(const int N, const double ALPHA, double *X, const int INCX=1) const | Epetra_BLAS | |
| SumIntoGlobalValues(int NumEntries, const double *Values, const int *Indices) | Epetra_Vector | |
| SumIntoGlobalValues(int NumEntries, int BlockOffset, const double *Values, const int *Indices) | Epetra_Vector | |
| SumIntoMyValues(int NumEntries, const double *Values, const int *Indices) | Epetra_Vector | |
| SumIntoMyValues(int NumEntries, int BlockOffset, const double *Values, const int *Indices) | Epetra_Vector | |
| 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 | Epetra_BLAS | |
| 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 | Epetra_BLAS | |
| 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 | Epetra_BLAS | |
| 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 | Epetra_BLAS | |
| 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 | Epetra_BLAS | |
| 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 | Epetra_BLAS | |
| ~BlockVector() | EpetraExt::BlockVector | virtual |
| ~Epetra_BLAS(void) | Epetra_BLAS | virtual |
| ~Epetra_Vector() | Epetra_Vector | virtual |
1.8.5