Epetra Package Browser (Single Doxygen Collection)  Development
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Macros Groups Pages
Protected Member Functions | Protected Attributes | List of all members
Epetra_VbrMatrix Class Reference

Epetra_VbrMatrix: A class for the construction and use of real-valued double-precision variable block-row sparse matrices. More...

#include <Epetra_VbrMatrix.h>

Inheritance diagram for Epetra_VbrMatrix:
Inheritance graph
[legend]

Protected Member Functions

void DeleteMemory ()
 
bool Allocated () const
 
int SetAllocated (bool Flag)
 
Epetra_SerialDenseMatrix *** Values () const
 
int DoMultiply (bool TransA, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
 
int DoSolve (bool Upper, bool Trans, bool UnitDiagonal, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
 
void InitializeDefaults ()
 
int Allocate ()
 
int BeginInsertValues (int BlockRow, int NumBlockEntries, int *BlockIndices, bool IndicesAreLocal)
 
int BeginReplaceValues (int BlockRow, int NumBlockEntries, int *BlockIndices, bool IndicesAreLocal)
 
int BeginSumIntoValues (int BlockRow, int NumBlockEntries, int *BlockIndices, bool IndicesAreLocal)
 
int SetupForSubmits (int BlockRow, int NumBlockEntries, int *BlockIndices, bool IndicesAreLocal, Epetra_CombineMode SubmitMode)
 
int EndReplaceSumIntoValues ()
 
int EndInsertValues ()
 
int CopyMat (double *A, int LDA, int NumRows, int NumCols, double *B, int LDB, bool SumInto) const
 
int BeginExtractBlockRowCopy (int BlockRow, int MaxNumBlockEntries, int &RowDim, int &NumBlockEntries, int *BlockIndices, int *ColDims, bool IndicesAreLocal) const
 
int SetupForExtracts (int BlockRow, int &RowDim, int NumBlockEntries, bool ExtractView, bool IndicesAreLocal) const
 
int ExtractBlockDimsCopy (int NumBlockEntries, int *ColDims) const
 
int ExtractBlockRowPointers (int BlockRow, int MaxNumBlockEntries, int &RowDim, int &NumBlockEntries, int *BlockIndices, Epetra_SerialDenseMatrix **&Values, bool IndicesAreLocal) const
 
int BeginExtractBlockRowView (int BlockRow, int &RowDim, int &NumBlockEntries, int *&BlockIndices, bool IndicesAreLocal) const
 
int CopyMatDiag (double *A, int LDA, int NumRows, int NumCols, double *Diagonal) const
 
int ReplaceMatDiag (double *A, int LDA, int NumRows, int NumCols, double *Diagonal)
 
void BlockRowMultiply (bool TransA, int RowDim, int NumEntries, int *BlockIndices, int RowOff, int *FirstPointInElementList, int *ElementSizeList, double Alpha, Epetra_SerialDenseMatrix **As, double **X, double Beta, double **Y, int NumVectors) const
 
void BlockRowMultiply (bool TransA, int RowDim, int NumEntries, int *BlockIndices, int RowOff, int *FirstPointInElementList, int *ElementSizeList, Epetra_SerialDenseMatrix **As, double **X, double **Y, int NumVectors) const
 
void FastBlockRowMultiply (bool TransA, int RowDim, int NumEntries, int *BlockIndices, int RowOff, int *FirstPointInElementList, int *ElementSizeList, Epetra_SerialDenseMatrix **As, double **X, double **Y, int NumVectors) const
 
int InverseSums (bool DoRows, Epetra_Vector &x) const
 
int Scale (bool DoRows, const Epetra_Vector &x)
 
void BlockRowNormInf (int RowDim, int NumEntries, Epetra_SerialDenseMatrix **As, double *Y) const
 
void BlockRowNormOne (int RowDim, int NumEntries, int *BlockRowIndices, Epetra_SerialDenseMatrix **As, int *ColFirstPointInElementList, double *x) const
 
void SetStaticGraph (bool Flag)
 
int CheckSizes (const Epetra_SrcDistObject &A)
 Allows the source and target (this) objects to be compared for compatibility, return nonzero if not. More...
 
int CopyAndPermute (const Epetra_SrcDistObject &Source, int NumSameIDs, int NumPermuteIDs, int *PermuteToLIDs, int *PermuteFromLIDs, const Epetra_OffsetIndex *Indexor, Epetra_CombineMode CombineMode=Zero)
 Perform ID copies and permutations that are on processor. More...
 
int PackAndPrepare (const Epetra_SrcDistObject &Source, int NumExportIDs, int *ExportLIDs, int &LenExports, char *&Exports, int &SizeOfPacket, int *Sizes, bool &VarSizes, Epetra_Distributor &Distor)
 Perform any packing or preparation required for call to DoTransfer(). More...
 
int UnpackAndCombine (const Epetra_SrcDistObject &Source, int NumImportIDs, int *ImportLIDs, int LenImports, char *Imports, int &SizeOfPacket, Epetra_Distributor &Distor, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor)
 Perform any unpacking and combining after call to DoTransfer(). More...
 
int SortEntries ()
 Sort column entries, row-by-row, in ascending order. More...
 
bool Sorted () const
 If SortEntries() has been called, this query returns true, otherwise it returns false. More...
 
int MergeRedundantEntries ()
 Add entries that have the same column index. Remove redundant entries from list. More...
 
bool NoRedundancies () const
 If MergeRedundantEntries() has been called, this query returns true, otherwise it returns false. More...
 
bool StaticGraph () const
 
int GeneratePointObjects () const
 
int BlockMap2PointMap (const Epetra_BlockMap &BlockMap, Epetra_Map *&PointMap) const
 
int UpdateOperatorXY (const Epetra_MultiVector &X, const Epetra_MultiVector &Y) const
 
- Protected Member Functions inherited from Epetra_DistObject
virtual int DoTransfer (const Epetra_SrcDistObject &A, Epetra_CombineMode CombineMode, int NumSameIDs, int NumPermuteIDs, int NumRemoteIDs, int NumExportIDs, int *PermuteToLIDs, int *PermuteFromLIDs, int *RemoteLIDs, int *ExportLIDs, int &LenExports, char *&Exports, int &LenImports, char *&Imports, Epetra_Distributor &Distor, bool DoReverse, const Epetra_OffsetIndex *Indexor)
 Perform actual transfer (redistribution) of data across memory images, using Epetra_Distributor object. More...
 
- Protected Member Functions inherited from Epetra_Object
std::string toString (const int &x) const
 
std::string toString (const long long &x) const
 
std::string toString (const double &x) const
 

Protected Attributes

Epetra_CrsGraphGraph_
 
bool Allocated_
 
bool StaticGraph_
 
bool UseTranspose_
 
bool constructedWithFilledGraph_
 
bool matrixFillCompleteCalled_
 
bool StorageOptimized_
 
int NumMyBlockRows_
 
Epetra_DataAccess CV_
 
int * NumBlockEntriesPerRow_
 
int * NumAllocatedBlockEntriesPerRow_
 
int ** Indices_
 
int * ElementSizeList_
 
int * FirstPointInElementList_
 
Epetra_SerialDenseMatrix *** Entries_
 
double * All_Values_Orig_
 
double * All_Values_
 
double NormInf_
 
double NormOne_
 
double NormFrob_
 
Epetra_MultiVectorImportVector_
 
Epetra_MultiVectorExportVector_
 
int * TempRowDims_
 
Epetra_SerialDenseMatrix ** TempEntries_
 
int LenTemps_
 
int CurBlockRow_
 
int CurNumBlockEntries_
 
int * CurBlockIndices_
 
int CurEntry_
 
bool CurIndicesAreLocal_
 
Epetra_CombineMode CurSubmitMode_
 
int CurExtractBlockRow_
 
int CurExtractEntry_
 
int CurExtractNumBlockEntries_
 
bool CurExtractIndicesAreLocal_
 
bool CurExtractView_
 
int CurRowDim_
 
int CurBlockDiag_
 
Epetra_MapRowMatrixRowMap_
 
Epetra_MapRowMatrixColMap_
 
Epetra_ImportRowMatrixImporter_
 
Epetra_MapOperatorDomainMap_
 
Epetra_MapOperatorRangeMap_
 
Epetra_MultiVectorOperatorX_
 
Epetra_MultiVectorOperatorY_
 
bool HavePointObjects_
 
bool squareFillCompleteCalled_
 
- Protected Attributes inherited from Epetra_DistObject
Epetra_BlockMap Map_
 
const Epetra_CommComm_
 
char * Exports_
 
char * Imports_
 
int LenExports_
 
int LenImports_
 
int * Sizes_
 
- Protected Attributes inherited from Epetra_CompObject
Epetra_FlopsFlopCounter_
 

Constructors/Destructor

 Epetra_VbrMatrix (Epetra_DataAccess CV, const Epetra_BlockMap &RowMap, int *NumBlockEntriesPerRow)
 Epetra_VbrMatrix constuctor with variable number of indices per row. More...
 
 Epetra_VbrMatrix (Epetra_DataAccess CV, const Epetra_BlockMap &RowMap, int NumBlockEntriesPerRow)
 Epetra_VbrMatrix constuctor with fixed number of indices per row. More...
 
 Epetra_VbrMatrix (Epetra_DataAccess CV, const Epetra_BlockMap &RowMap, const Epetra_BlockMap &ColMap, int *NumBlockEntriesPerRow)
 Epetra_VbrMatrix constuctor with variable number of indices per row. More...
 
 Epetra_VbrMatrix (Epetra_DataAccess CV, const Epetra_BlockMap &RowMap, const Epetra_BlockMap &ColMap, int NumBlockEntriesPerRow)
 Epetra_VbrMatrix constuctor with fixed number of indices per row. More...
 
 Epetra_VbrMatrix (Epetra_DataAccess CV, const Epetra_CrsGraph &Graph)
 Construct a matrix using an existing Epetra_CrsGraph object. More...
 
 Epetra_VbrMatrix (const Epetra_VbrMatrix &Matrix)
 Copy constructor. More...
 
virtual ~Epetra_VbrMatrix ()
 Epetra_VbrMatrix Destructor. More...
 

Insertion/Replace/SumInto methods

Epetra_VbrMatrixoperator= (const Epetra_VbrMatrix &src)
 
int PutScalar (double ScalarConstant)
 Initialize all values in graph of the matrix with constant value. More...
 
int Scale (double ScalarConstant)
 Multiply all values in the matrix by a constant value (in place: A <- ScalarConstant * A). More...
 
int DirectSubmitBlockEntry (int GlobalBlockRow, int GlobalBlockCol, const double *values, int LDA, int NumRows, int NumCols, bool sum_into)
 Submit a block-entry directly into the matrix (without using a begin/end sequence) More...
 
int BeginInsertGlobalValues (int BlockRow, int NumBlockEntries, int *BlockIndices)
 Initiate insertion of a list of elements in a given global row of the matrix, values are inserted via SubmitEntry(). More...
 
int BeginInsertMyValues (int BlockRow, int NumBlockEntries, int *BlockIndices)
 Initiate insertion of a list of elements in a given local row of the matrix, values are inserted via SubmitEntry(). More...
 
int BeginReplaceGlobalValues (int BlockRow, int NumBlockEntries, int *BlockIndices)
 Initiate replacement of current values with this list of entries for a given global row of the matrix, values are replaced via SubmitEntry() More...
 
int BeginReplaceMyValues (int BlockRow, int NumBlockEntries, int *BlockIndices)
 Initiate replacement of current values with this list of entries for a given local row of the matrix, values are replaced via SubmitEntry() More...
 
int BeginSumIntoGlobalValues (int BlockRow, int NumBlockEntries, int *BlockIndices)
 Initiate summing into current values with this list of entries for a given global row of the matrix, values are replaced via SubmitEntry() More...
 
int BeginSumIntoMyValues (int BlockRow, int NumBlockEntries, int *BlockIndices)
 Initiate summing into current values with this list of entries for a given local row of the matrix, values are replaced via SubmitEntry() More...
 
int SubmitBlockEntry (double *Values, int LDA, int NumRows, int NumCols)
 Submit a block entry to the indicated block row and column specified in the Begin routine. More...
 
int SubmitBlockEntry (Epetra_SerialDenseMatrix &Mat)
 Submit a block entry to the indicated block row and column specified in the Begin routine. More...
 
int EndSubmitEntries ()
 Completes processing of all data passed in for the current block row. More...
 
int ReplaceDiagonalValues (const Epetra_Vector &Diagonal)
 Replaces diagonal values of the with those in the user-provided vector. More...
 
int FillComplete ()
 Signal that data entry is complete, perform transformations to local index space. More...
 
int FillComplete (const Epetra_BlockMap &DomainMap, const Epetra_BlockMap &RangeMap)
 Signal that data entry is complete, perform transformations to local index space. More...
 
bool Filled () const
 If FillComplete() has been called, this query returns true, otherwise it returns false. More...
 

Extraction methods

int ExtractGlobalBlockRowPointers (int BlockRow, int MaxNumBlockEntries, int &RowDim, int &NumBlockEntries, int *BlockIndices, Epetra_SerialDenseMatrix **&Values) const
 Copy the block indices into user-provided array, set pointers for rest of data for specified global block row. More...
 
int ExtractMyBlockRowPointers (int BlockRow, int MaxNumBlockEntries, int &RowDim, int &NumBlockEntries, int *BlockIndices, Epetra_SerialDenseMatrix **&Values) const
 Copy the block indices into user-provided array, set pointers for rest of data for specified local block row. More...
 
int BeginExtractGlobalBlockRowCopy (int BlockRow, int MaxNumBlockEntries, int &RowDim, int &NumBlockEntries, int *BlockIndices, int *ColDims) const
 Initiates a copy of the specified global row in user-provided arrays. More...
 
int BeginExtractMyBlockRowCopy (int BlockRow, int MaxNumBlockEntries, int &RowDim, int &NumBlockEntries, int *BlockIndices, int *ColDims) const
 Initiates a copy of the specified local row in user-provided arrays. More...
 
int ExtractEntryCopy (int SizeOfValues, double *Values, int LDA, bool SumInto) const
 Extract a copy of an entry from the block row specified by one of the BeginExtract routines. More...
 
int BeginExtractGlobalBlockRowView (int BlockRow, int &RowDim, int &NumBlockEntries, int *&BlockIndices) const
 Initiates a view of the specified global row, only works if matrix indices are in global mode. More...
 
int BeginExtractMyBlockRowView (int BlockRow, int &RowDim, int &NumBlockEntries, int *&BlockIndices) const
 Initiates a view of the specified local row, only works if matrix indices are in local mode. More...
 
int ExtractEntryView (Epetra_SerialDenseMatrix *&entry) const
 Returns a pointer to the current block entry. More...
 
int ExtractGlobalBlockRowView (int BlockRow, int &RowDim, int &NumBlockEntries, int *&BlockIndices, Epetra_SerialDenseMatrix **&Values) const
 Initiates a view of the specified global row, only works if matrix indices are in global mode. More...
 
int ExtractMyBlockRowView (int BlockRow, int &RowDim, int &NumBlockEntries, int *&BlockIndices, Epetra_SerialDenseMatrix **&Values) const
 Initiates a view of the specified local row, only works if matrix indices are in local mode. More...
 
int ExtractDiagonalCopy (Epetra_Vector &Diagonal) const
 Returns a copy of the main diagonal in a user-provided vector. More...
 
int BeginExtractBlockDiagonalCopy (int MaxNumBlockDiagonalEntries, int &NumBlockDiagonalEntries, int *RowColDims) const
 Initiates a copy of the block diagonal entries to user-provided arrays. More...
 
int ExtractBlockDiagonalEntryCopy (int SizeOfValues, double *Values, int LDA, bool SumInto) const
 Extract a copy of a block diagonal entry from the matrix. More...
 
int BeginExtractBlockDiagonalView (int &NumBlockDiagonalEntries, int *&RowColDims) const
 Initiates a view of the block diagonal entries. More...
 
int ExtractBlockDiagonalEntryView (double *&Values, int &LDA) const
 Extract a view of a block diagonal entry from the matrix. More...
 

Computational methods

int Multiply1 (bool TransA, const Epetra_Vector &x, Epetra_Vector &y) const
 Returns the result of a Epetra_VbrMatrix multiplied by a Epetra_Vector x in y. More...
 
int Multiply (bool TransA, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
 Returns the result of a Epetra_VbrMatrix multiplied by a Epetra_MultiVector X in Y. More...
 
int Solve (bool Upper, bool Trans, bool UnitDiagonal, const Epetra_Vector &x, Epetra_Vector &y) const
 Returns the result of a solve using the Epetra_VbrMatrix on a Epetra_Vector x in y. More...
 
int Solve (bool Upper, bool Trans, bool UnitDiagonal, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
 Returns the result of a Epetra_VbrMatrix multiplied by a Epetra_MultiVector X in Y. More...
 
int InvRowSums (Epetra_Vector &x) const
 Computes the sum of absolute values of the rows of the Epetra_VbrMatrix, results returned in x. More...
 
int LeftScale (const Epetra_Vector &x)
 Scales the Epetra_VbrMatrix on the left with a Epetra_Vector x. More...
 
int InvColSums (Epetra_Vector &x) const
 Computes the sum of absolute values of the columns of the Epetra_VbrMatrix, results returned in x. More...
 
int RightScale (const Epetra_Vector &x)
 Scales the Epetra_VbrMatrix on the right with a Epetra_Vector x. More...
 

Matrix Properties Query Methods

int OptimizeStorage ()
 Eliminates memory that is used for construction. Make consecutive row index sections contiguous. More...
 
bool StorageOptimized () const
 If OptimizeStorage() has been called, this query returns true, otherwise it returns false. More...
 
bool IndicesAreGlobal () const
 If matrix indices has not been transformed to local, this query returns true, otherwise it returns false. More...
 
bool IndicesAreLocal () const
 If matrix indices has been transformed to local, this query returns true, otherwise it returns false. More...
 
bool IndicesAreContiguous () const
 If matrix indices are packed into single array (done in OptimizeStorage()) return true, otherwise false. More...
 
bool LowerTriangular () const
 If matrix is lower triangular in local index space, this query returns true, otherwise it returns false. More...
 
bool UpperTriangular () const
 If matrix is upper triangular in local index space, this query returns true, otherwise it returns false. More...
 
bool NoDiagonal () const
 If matrix has no diagonal entries based on global row/column index comparisons, this query returns true, otherwise it returns false. More...
 

Attribute access functions

double NormInf () const
 Returns the infinity norm of the global matrix. More...
 
double NormOne () const
 Returns the one norm of the global matrix. More...
 
double NormFrobenius () const
 Returns the frobenius norm of the global matrix. More...
 
int MaxRowDim () const
 Returns the maximum row dimension of all block entries on this processor. More...
 
int MaxColDim () const
 Returns the maximum column dimension of all block entries on this processor. More...
 
int GlobalMaxRowDim () const
 Returns the maximum row dimension of all block entries across all processors. More...
 
int GlobalMaxColDim () const
 Returns the maximum column dimension of all block entries across all processors. More...
 
int NumMyRows () const
 Returns the number of matrix rows owned by the calling processor. More...
 
int NumMyCols () const
 Returns the number of matrix columns owned by the calling processor. More...
 
int NumMyNonzeros () const
 Returns the number of nonzero entriesowned by the calling processor . More...
 
int NumGlobalRows () const
 Returns the number of global matrix rows. More...
 
long long NumGlobalRows64 () const
 
int NumGlobalCols () const
 Returns the number of global matrix columns. More...
 
long long NumGlobalCols64 () const
 
int NumGlobalNonzeros () const
 Returns the number of nonzero entries in the global matrix. More...
 
long long NumGlobalNonzeros64 () const
 
int NumMyBlockRows () const
 Returns the number of Block matrix rows owned by the calling processor. More...
 
int NumMyBlockCols () const
 Returns the number of Block matrix columns owned by the calling processor. More...
 
int NumMyBlockEntries () const
 Returns the number of nonzero block entries in the calling processor's portion of the matrix. More...
 
int NumMyBlockDiagonals () const
 Returns the number of local nonzero block diagonal entries, based on global row/column index comparisons. More...
 
int NumMyDiagonals () const
 Returns the number of local nonzero diagonal entries, based on global row/column index comparisons. More...
 
int NumGlobalBlockRows () const
 Returns the number of global Block matrix rows. More...
 
long long NumGlobalBlockRows64 () const
 
int NumGlobalBlockCols () const
 Returns the number of global Block matrix columns. More...
 
long long NumGlobalBlockCols64 () const
 
int NumGlobalBlockEntries () const
 Returns the number of nonzero block entries in the global matrix. More...
 
long long NumGlobalBlockEntries64 () const
 
int NumGlobalBlockDiagonals () const
 Returns the number of global nonzero block diagonal entries, based on global row/column index comparisions. More...
 
long long NumGlobalBlockDiagonals64 () const
 
int NumGlobalDiagonals () const
 Returns the number of global nonzero diagonal entries, based on global row/column index comparisions. More...
 
long long NumGlobalDiagonals64 () const
 
int NumGlobalBlockEntries (int Row) const
 Returns the current number of nonzero Block entries in specified global row on this processor. More...
 
int NumAllocatedGlobalBlockEntries (int Row) const
 Returns the allocated number of nonzero Block entries in specified global row on this processor. More...
 
int MaxNumBlockEntries () const
 Returns the maximum number of nonzero entries across all rows on this processor. More...
 
int GlobalMaxNumBlockEntries () const
 Returns the maximum number of nonzero entries across all rows on this processor. More...
 
int NumMyBlockEntries (int Row) const
 Returns the current number of nonzero Block entries in specified local row on this processor. More...
 
int NumAllocatedMyBlockEntries (int Row) const
 Returns the allocated number of nonzero Block entries in specified local row on this processor. More...
 
int MaxNumNonzeros () const
 Returns the maximum number of nonzero entries across all block rows on this processor. More...
 
int GlobalMaxNumNonzeros () const
 Returns the maximum number of nonzero entries across all block rows on all processors. More...
 
int IndexBase () const
 Returns the index base for row and column indices for this graph. More...
 
long long IndexBase64 () const
 
const Epetra_CrsGraphGraph () const
 Returns a pointer to the Epetra_CrsGraph object associated with this matrix. More...
 
const Epetra_ImportImporter () const
 Returns the Epetra_Import object that contains the import operations for distributed operations. More...
 
const Epetra_ExportExporter () const
 Returns the Epetra_Export object that contains the export operations for distributed operations. More...
 
const Epetra_BlockMapDomainMap () const
 Returns the Epetra_BlockMap object associated with the domain of this matrix operator. More...
 
const Epetra_BlockMapRangeMap () const
 Returns the Epetra_BlockMap object associated with the range of this matrix operator. More...
 
const Epetra_BlockMapRowMap () const
 Returns the RowMap object as an Epetra_BlockMap (the Epetra_Map base class) needed for implementing Epetra_RowMatrix. More...
 
const Epetra_BlockMapColMap () const
 Returns the ColMap as an Epetra_BlockMap (the Epetra_Map base class) needed for implementing Epetra_RowMatrix. More...
 
const Epetra_CommComm () const
 Fills a matrix with rows from a source matrix based on the specified importer. More...
 

Local/Global ID methods

int LRID (int GRID_in) const
 Returns the local row index for given global row index, returns -1 if no local row for this global row. More...
 
int LRID (long long GRID_in) const
 
int GRID (int LRID_in) const
 Returns the global row index for give local row index, returns IndexBase-1 if we don't have this local row. More...
 
long long GRID64 (int LRID_in) const
 
int LCID (int GCID_in) const
 Returns the local column index for given global column index, returns -1 if no local column for this global column. More...
 
int LCID (long long GCID_in) const
 
int GCID (int LCID_in) const
 Returns the global column index for give local column index, returns IndexBase-1 if we don't have this local column. More...
 
long long GCID64 (int LCID_in) const
 
bool MyGRID (int GRID_in) const
 Returns true if the GRID passed in belongs to the calling processor in this map, otherwise returns false. More...
 
bool MyGRID (long long GRID_in) const
 
bool MyLRID (int LRID_in) const
 Returns true if the LRID passed in belongs to the calling processor in this map, otherwise returns false. More...
 
bool MyGCID (int GCID_in) const
 Returns true if the GCID passed in belongs to the calling processor in this map, otherwise returns false. More...
 
bool MyGCID (long long GCID_in) const
 
bool MyLCID (int LCID_in) const
 Returns true if the LRID passed in belongs to the calling processor in this map, otherwise returns false. More...
 
bool MyGlobalBlockRow (int GID) const
 Returns true of GID is owned by the calling processor, otherwise it returns false. More...
 
bool MyGlobalBlockRow (long long GID) const
 

I/O Methods

virtual void Print (std::ostream &os) const
 Print method. More...
 

Additional methods required to support the Epetra_Operator interface

const char * Label () const
 Returns a character string describing the operator. More...
 
int SetUseTranspose (bool UseTranspose_in)
 If set true, transpose of this operator will be applied. More...
 
int Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
 Returns the result of a Epetra_Operator applied to a Epetra_MultiVector X in Y. More...
 
int ApplyInverse (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const
 Returns the result of a Epetra_Operator inverse applied to an Epetra_MultiVector X in Y. More...
 
bool HasNormInf () const
 Returns true because this class can compute an Inf-norm. More...
 
bool UseTranspose () const
 Returns the current UseTranspose setting. More...
 
const Epetra_MapOperatorDomainMap () const
 Returns the Epetra_Map object associated with the domain of this matrix operator. More...
 
const Epetra_MapOperatorRangeMap () const
 Returns the Epetra_Map object associated with the range of this matrix operator. More...
 

Additional methods required to implement RowMatrix interface

int ExtractGlobalRowCopy (int GlobalRow, int Length, int &NumEntries, double *Values, int *Indices) const
 Returns a copy of the specified global row in user-provided arrays. More...
 
int ExtractMyRowCopy (int MyRow, int Length, int &NumEntries, double *Values, int *Indices) const
 Returns a copy of the specified local row in user-provided arrays. More...
 
int NumMyRowEntries (int MyRow, int &NumEntries) const
 Return the current number of values stored for the specified local row. More...
 
int MaxNumEntries () const
 Returns the maximum of NumMyRowEntries() over all rows. More...
 
const Epetra_BlockMapMap () const
 Map() method inherited from Epetra_DistObject. More...
 
const Epetra_MapRowMatrixRowMap () const
 Returns the EpetraMap object associated with the rows of this matrix. More...
 
const Epetra_MapRowMatrixColMap () const
 Returns the Epetra_Map object associated with columns of this matrix. More...
 
const Epetra_ImportRowMatrixImporter () const
 Returns the Epetra_Import object that contains the import operations for distributed operations. More...
 

Deprecated methods: These methods still work, but will be removed in a future version

const Epetra_BlockMapBlockImportMap () const
 Use BlockColMap() instead. More...
 
int TransformToLocal ()
 Use FillComplete() instead. More...
 
int TransformToLocal (const Epetra_BlockMap *DomainMap, const Epetra_BlockMap *RangeMap)
 Use FillComplete(const Epetra_BlockMap& DomainMap, const Epetra_BlockMap& RangeMap) instead. More...
 

Additional Inherited Members

- Public Member Functions inherited from Epetra_DistObject
 Epetra_DistObject (const Epetra_BlockMap &Map)
 Basic Epetra_DistObject constuctor. More...
 
 Epetra_DistObject (const Epetra_BlockMap &Map, const char *const Label)
 
 Epetra_DistObject (const Epetra_DistObject &Source)
 Epetra_DistObject copy constructor. More...
 
virtual ~Epetra_DistObject ()
 Epetra_DistObject destructor. More...
 
int Import (const Epetra_SrcDistObject &A, const Epetra_Import &Importer, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0)
 Imports an Epetra_DistObject using the Epetra_Import object. More...
 
int Import (const Epetra_SrcDistObject &A, const Epetra_Export &Exporter, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0)
 Imports an Epetra_DistObject using the Epetra_Export object. More...
 
int Export (const Epetra_SrcDistObject &A, const Epetra_Import &Importer, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0)
 Exports an Epetra_DistObject using the Epetra_Import object. More...
 
int Export (const Epetra_SrcDistObject &A, const Epetra_Export &Exporter, Epetra_CombineMode CombineMode, const Epetra_OffsetIndex *Indexor=0)
 Exports an Epetra_DistObject using the Epetra_Export object. More...
 
const Epetra_CommComm () const
 Returns the address of the Epetra_Comm for this multi-vector. More...
 
bool DistributedGlobal () const
 Returns true if this multi-vector is distributed global, i.e., not local replicated. More...
 
- Public Member Functions inherited from Epetra_Object
 Epetra_Object (int TracebackModeIn=-1, bool set_label=true)
 Epetra_Object Constructor. More...
 
 Epetra_Object (const char *const Label, int TracebackModeIn=-1)
 Epetra_Object Constructor. More...
 
 Epetra_Object (const Epetra_Object &Object)
 Epetra_Object Copy Constructor. More...
 
virtual ~Epetra_Object ()
 Epetra_Object Destructor. More...
 
virtual void SetLabel (const char *const Label)
 Epetra_Object Label definition using char *. More...
 
virtual int ReportError (const std::string Message, int ErrorCode) const
 Error reporting method. More...
 
- Public Member Functions inherited from Epetra_SrcDistObject
virtual ~Epetra_SrcDistObject ()
 Epetra_SrcDistObject destructor. More...
 
- Public Member Functions inherited from Epetra_CompObject
Epetra_CompObjectoperator= (const Epetra_CompObject &src)
 
 Epetra_CompObject ()
 Basic Epetra_CompObject constuctor. More...
 
 Epetra_CompObject (const Epetra_CompObject &Source)
 Epetra_CompObject copy constructor. More...
 
virtual ~Epetra_CompObject ()
 Epetra_CompObject destructor. More...
 
void SetFlopCounter (const Epetra_Flops &FlopCounter_in)
 Set the internal Epetra_Flops() pointer. More...
 
void SetFlopCounter (const Epetra_CompObject &CompObject)
 Set the internal Epetra_Flops() pointer to the flop counter of another Epetra_CompObject. More...
 
void UnsetFlopCounter ()
 Set the internal Epetra_Flops() pointer to 0 (no flops counted). More...
 
Epetra_FlopsGetFlopCounter () const
 Get the pointer to the Epetra_Flops() object associated with this object, returns 0 if none. More...
 
void ResetFlops () const
 Resets the number of floating point operations to zero for this multi-vector. More...
 
double Flops () const
 Returns the number of floating point operations with this multi-vector. More...
 
void UpdateFlops (int Flops_in) const
 Increment Flop count for this object. More...
 
void UpdateFlops (long int Flops_in) const
 Increment Flop count for this object. More...
 
void UpdateFlops (long long Flops_in) const
 Increment Flop count for this object. More...
 
void UpdateFlops (double Flops_in) const
 Increment Flop count for this object. More...
 
void UpdateFlops (float Flops_in) const
 Increment Flop count for this object. More...
 
- Public Member Functions inherited from Epetra_BLAS
 Epetra_BLAS (void)
 Epetra_BLAS Constructor. More...
 
 Epetra_BLAS (const Epetra_BLAS &BLAS)
 Epetra_BLAS Copy Constructor. More...
 
virtual ~Epetra_BLAS (void)
 Epetra_BLAS Destructor. More...
 
float ASUM (const int N, const float *X, const int INCX=1) const
 Epetra_BLAS one norm function (SASUM). More...
 
double ASUM (const int N, const double *X, const int INCX=1) const
 Epetra_BLAS one norm function (DASUM). More...
 
float DOT (const int N, const float *X, const float *Y, const int INCX=1, const int INCY=1) const
 Epetra_BLAS dot product function (SDOT). More...
 
double DOT (const int N, const double *X, const double *Y, const int INCX=1, const int INCY=1) const
 Epetra_BLAS dot product function (DDOT). More...
 
float NRM2 (const int N, const float *X, const int INCX=1) const
 Epetra_BLAS norm function (SNRM2). More...
 
double NRM2 (const int N, const double *X, const int INCX=1) const
 Epetra_BLAS norm function (DNRM2). More...
 
void SCAL (const int N, const float ALPHA, float *X, const int INCX=1) const
 Epetra_BLAS vector scale function (SSCAL) More...
 
void SCAL (const int N, const double ALPHA, double *X, const int INCX=1) const
 Epetra_BLAS vector scale function (DSCAL) More...
 
void COPY (const int N, const float *X, float *Y, const int INCX=1, const int INCY=1) const
 Epetra_BLAS vector copy function (SCOPY) More...
 
void COPY (const int N, const double *X, double *Y, const int INCX=1, const int INCY=1) const
 Epetra_BLAS vector scale function (DCOPY) More...
 
int IAMAX (const int N, const float *X, const int INCX=1) const
 Epetra_BLAS arg maximum of absolute value function (ISAMAX) More...
 
int IAMAX (const int N, const double *X, const int INCX=1) const
 Epetra_BLAS arg maximum of absolute value function (IDAMAX) More...
 
void AXPY (const int N, const float ALPHA, const float *X, float *Y, const int INCX=1, const int INCY=1) const
 Epetra_BLAS vector update function (SAXPY) More...
 
void AXPY (const int N, const double ALPHA, const double *X, double *Y, const int INCX=1, const int INCY=1) const
 Epetra_BLAS vector update function (DAXPY) More...
 
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
 Epetra_BLAS matrix-vector multiply function (SGEMV) More...
 
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
 Epetra_BLAS matrix-vector multiply function (DGEMV) More...
 
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
 Epetra_BLAS matrix-matrix multiply function (SGEMM) More...
 
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
 Epetra_BLAS matrix-matrix multiply function (DGEMM) More...
 
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
 Epetra_BLAS symmetric matrix-matrix multiply function (SSYMM) More...
 
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
 Epetra_BLAS matrix-matrix multiply function (DSYMM) More...
 
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
 Epetra_BLAS triangular matrix-matrix multiply function (STRMM) More...
 
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
 Epetra_BLAS triangular matrix-matrix multiply function (DTRMM) More...
 
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
 Eperta_BLAS symetric rank k funtion (ssyrk) More...
 
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
 Eperta_BLAS symetric rank k funtion (dsyrk) More...
 
- Public Member Functions inherited from Epetra_RowMatrix
virtual ~Epetra_RowMatrix ()
 Destructor. More...
 
- Public Member Functions inherited from Epetra_Operator
virtual ~Epetra_Operator ()
 Destructor. More...
 
- Static Public Member Functions inherited from Epetra_Object
static void SetTracebackMode (int TracebackModeValue)
 Set the value of the Epetra_Object error traceback report mode. More...
 
static int GetTracebackMode ()
 Get the value of the Epetra_Object error report mode. More...
 
static std::ostream & GetTracebackStream ()
 Get the output stream for error reporting. More...
 
- Static Public Attributes inherited from Epetra_Object
static int TracebackMode
 

Detailed Description

Epetra_VbrMatrix: A class for the construction and use of real-valued double-precision variable block-row sparse matrices.

The Epetra_VbrMatrix class is a sparse variable block row matrix object. This matrix can be

used in a parallel setting, with data distribution described by Epetra_Map attributes. The structure or graph of the matrix is defined by an Epetra_CrsGraph attribute.

In addition to coefficient access, the primary operations provided by Epetra_VbrMatrix are matrix times vector and matrix times multi-vector multiplication.

Creating and filling Epetra_VbrMatrix objects

Constructing Epetra_VbrMatrix objects is a multi-step process. The basic steps are as follows:

  1. Create Epetra_VbrMatrix instance via one of the constructors:
    • Constructor that accepts one Epetra_Map object, a row-map defining the distribution of matrix rows.
    • Constructor that accepts two Epetra_Map objects. (The second map is a column-map, and describes the set of column-indices that appear in each processor's portion of the matrix. Generally these are overlapping sets – column-indices may appear on more than one processor.)
    • Constructor that accepts an Epetra_CrsGraph object, defining the non-zero structure of the matrix.
  2. Input coefficient values (more detail on this below).
  3. Complete construction by calling FillComplete.

Note that even after FillComplete() has been called, it is possible to update existing matrix entries but it is not possible to create new entries.

Using Epetra_VbrMatrix as an Epetra_RowMatrix

Although Epetra_VbrMatrix does inherit from Epetra_RowMatrix, a design flaw in the inheritance structure of Epetra prohibits the use of an Epetra_VbrMatrix object as an Epetra_RowMatrix in some important situations. Therefore we recommend the use of the Epetra_VbrRowMatrix class to wrap an Epetra_VbrMatrix object for use as an Epetra_RowMatrix. The Epetra_VbrRowMatrix object does not duplicate data in the Epetra_VbrMatrix object, but uses it to satisfy the Epetra_RowMatrix interface.

Epetra_Map attributes

Epetra_VbrMatrix objects have four Epetra_Map attributes, which are held by the Epetra_CrsGraph attribute.

The Epetra_Map attributes can be obtained via these accessor methods:

It is important to note that while the row-map and the range-map are often the same, the column-map and the domain-map are almost never the same. The set of entries in a distributed column-map almost always form overlapping sets, with entries being associated with more than one processor. A domain-map, on the other hand, must be a 1-to-1 map, with entries being associated with only a single processor.

Local versus Global Indices

Epetra_VbrMatrix has query functions IndicesAreLocal() and IndicesAreGlobal(), which are used to determine whether the underlying Epetra_CrsGraph attribute's column-indices have been transformed into a local index space or not. (This transformation occurs when the method Epetra_CrsGraph::FillComplete() is called, which happens when the method Epetra_VbrMatrix::FillComplete() is called.) The state of the indices in the graph determines the behavior of many Epetra_VbrMatrix methods. If an Epetra_VbrMatrix instance is constructed using one of the constructors that does not accept a pre-existing Epetra_CrsGraph object, then an Epetra_CrsGraph attribute is created internally and its indices remain untransformed (IndicesAreGlobal()==true) until Epetra_VbrMatrix::FillComplete() is called. The query function Epetra_VbrMatrix::Filled() returns true if Epetra_VbrMatrix::FillComplete() has been called.

Inputting coefficient values

The process for inputting block-entry coefficients is as follows:

  1. Indicate that values for a specified row are about to be provided by calling one of these methods which specify a block-row and a list of block-column-indices:
  2. Loop over the list of block-column-indices and pass each block-entry to the matrix using the method SubmitBlockEntry().
  3. Complete the process for the specified block-row by calling the method EndSubmitEntries().

Note that the 'GlobalValues' methods have the precondition that IndicesAreGlobal() must be true, and the 'MyValues' methods have the precondition that IndicesAreLocal() must be true. Furthermore, the 'SumInto' and 'Replace' methods may only be used to update matrix entries which already exist, and the 'Insert' methods may only be used if IndicesAreContiguous() is false.

Counting Floating Point Operations

Each Epetra_VbrMatrix object keeps track of the number of serial floating point operations performed using the specified object as the this argument to the function. The Flops() function returns this number as a double precision number. Using this information, in conjunction with the Epetra_Time class, one can get accurate parallel performance numbers. The ResetFlops() function resets the floating point counter.

Definition at line 172 of file Epetra_VbrMatrix.h.

Constructor & Destructor Documentation

Epetra_VbrMatrix::Epetra_VbrMatrix ( Epetra_DataAccess  CV,
const Epetra_BlockMap RowMap,
int *  NumBlockEntriesPerRow 
)

Epetra_VbrMatrix constuctor with variable number of indices per row.

Creates a Epetra_VbrMatrix object and allocates storage.

Parameters
InCV - A Epetra_DataAccess enumerated type set to Copy or View.
InRowMap - A Epetra_BlockMap listing the block rows that this processor will contribute to.
InNumBlockEntriesPerRow - An integer array of length NumRows such that NumBlockEntriesPerRow[i] indicates the (approximate) number of Block entries in the ith row.

Definition at line 58 of file Epetra_VbrMatrix.cpp.

Epetra_VbrMatrix::Epetra_VbrMatrix ( Epetra_DataAccess  CV,
const Epetra_BlockMap RowMap,
int  NumBlockEntriesPerRow 
)

Epetra_VbrMatrix constuctor with fixed number of indices per row.

Creates a Epetra_VbrMatrix object and allocates storage.

Parameters
InCV - A Epetra_DataAccess enumerated type set to Copy or View.
InRowMap - An Epetra_BlockMap listing the block rows that this processor will contribute to.
InNumBlockEntriesPerRow - An integer that indicates the (approximate) number of Block entries in the each Block row. Note that it is possible to use 0 for this value and let fill occur during the insertion phase.

Definition at line 88 of file Epetra_VbrMatrix.cpp.

Epetra_VbrMatrix::Epetra_VbrMatrix ( Epetra_DataAccess  CV,
const Epetra_BlockMap RowMap,
const Epetra_BlockMap ColMap,
int *  NumBlockEntriesPerRow 
)

Epetra_VbrMatrix constuctor with variable number of indices per row.

Creates a Epetra_VbrMatrix object and allocates storage.

Parameters
InCV - A Epetra_DataAccess enumerated type set to Copy or View.
InRowMap - A Epetra_BlockMap listing the block rows that this processor will contribute to.
InColMap - A Epetra_BlockMap.
InNumBlockEntriesPerRow - An integer array of length NumRows such that NumBlockEntriesPerRow[i] indicates the (approximate) number of Block entries in the ith row.

Definition at line 114 of file Epetra_VbrMatrix.cpp.

Epetra_VbrMatrix::Epetra_VbrMatrix ( Epetra_DataAccess  CV,
const Epetra_BlockMap RowMap,
const Epetra_BlockMap ColMap,
int  NumBlockEntriesPerRow 
)

Epetra_VbrMatrix constuctor with fixed number of indices per row.

Creates a Epetra_VbrMatrix object and allocates storage.

Parameters
InCV - A Epetra_DataAccess enumerated type set to Copy or View.
InRowMap - A Epetra_BlockMap listing the block rows that this processor will contribute to.
InColMap - An Epetra_BlockMap listing the block columns that this processor will contribute to.
InNumBlockEntriesPerRow - An integer that indicates the (approximate) number of Block entries in the each Block row. Note that it is possible to use 0 for this value and let fill occur during the insertion phase.

Definition at line 142 of file Epetra_VbrMatrix.cpp.

Epetra_VbrMatrix::Epetra_VbrMatrix ( Epetra_DataAccess  CV,
const Epetra_CrsGraph Graph 
)

Construct a matrix using an existing Epetra_CrsGraph object.

Allows the nonzero structure from another matrix, or a structure that was constructed independently, to be used for this matrix.

Parameters
InCV - A Epetra_DataAccess enumerated type set to Copy or View.
InGraph - A Epetra_CrsGraph object, extracted from another Epetra matrix object or constructed directly from using the Epetra_CrsGraph constructors.

Definition at line 170 of file Epetra_VbrMatrix.cpp.

Epetra_VbrMatrix::Epetra_VbrMatrix ( const Epetra_VbrMatrix Matrix)

Copy constructor.

Definition at line 197 of file Epetra_VbrMatrix.cpp.

Epetra_VbrMatrix::~Epetra_VbrMatrix ( )
virtual

Epetra_VbrMatrix Destructor.

Definition at line 407 of file Epetra_VbrMatrix.cpp.

Member Function Documentation

Epetra_VbrMatrix & Epetra_VbrMatrix::operator= ( const Epetra_VbrMatrix src)

Definition at line 218 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::PutScalar ( double  ScalarConstant)

Initialize all values in graph of the matrix with constant value.

Parameters
InScalarConstant - Value to use.
Returns
Integer error code, set to 0 if successful.

Definition at line 477 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::Scale ( double  ScalarConstant)

Multiply all values in the matrix by a constant value (in place: A <- ScalarConstant * A).

Parameters
InScalarConstant - Value to use.
Returns
Integer error code, set to 0 if successful.

Definition at line 501 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::DirectSubmitBlockEntry ( int  GlobalBlockRow,
int  GlobalBlockCol,
const double *  values,
int  LDA,
int  NumRows,
int  NumCols,
bool  sum_into 
)

Submit a block-entry directly into the matrix (without using a begin/end sequence)

Experimental method which allows submitting a block-entry without first calling BeginInsertGlobalValues. This method copies the input data directly into the matrix storage. The block-entry is specified by global block-row and block-col indices.

Definition at line 654 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginInsertGlobalValues ( int  BlockRow,
int  NumBlockEntries,
int *  BlockIndices 
)

Initiate insertion of a list of elements in a given global row of the matrix, values are inserted via SubmitEntry().

Parameters
InBlockRow - Block Row number (in global coordinates) to put elements.
InNumBlockEntries - Number of entries.
InIndices - Global column indices corresponding to values.
Returns
Integer error code, set to 0 if successful.

Definition at line 522 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginInsertMyValues ( int  BlockRow,
int  NumBlockEntries,
int *  BlockIndices 
)

Initiate insertion of a list of elements in a given local row of the matrix, values are inserted via SubmitEntry().

Parameters
InBlockRow - Block Row number (in local coordinates) to put elements.
InNumBlockEntries - Number of entries.
InIndices - Local column indices corresponding to values.
Returns
Integer error code, set to 0 if successful.

Definition at line 534 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginReplaceGlobalValues ( int  BlockRow,
int  NumBlockEntries,
int *  BlockIndices 
)

Initiate replacement of current values with this list of entries for a given global row of the matrix, values are replaced via SubmitEntry()

Parameters
InRow - Block Row number (in global coordinates) to put elements.
InNumBlockEntries - Number of entries.
InIndices - Global column indices corresponding to values.
Returns
Integer error code, set to 0 if successful.

Definition at line 568 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginReplaceMyValues ( int  BlockRow,
int  NumBlockEntries,
int *  BlockIndices 
)

Initiate replacement of current values with this list of entries for a given local row of the matrix, values are replaced via SubmitEntry()

Parameters
InRow - Block Row number (in local coordinates) to put elements.
InNumBlockEntries - Number of entries.
InIndices - Local column indices corresponding to values.
Returns
Integer error code, set to 0 if successful.

Definition at line 577 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginSumIntoGlobalValues ( int  BlockRow,
int  NumBlockEntries,
int *  BlockIndices 
)

Initiate summing into current values with this list of entries for a given global row of the matrix, values are replaced via SubmitEntry()

Parameters
InRow - Block Row number (in global coordinates) to put elements.
InNumBlockEntries - Number of entries.
InIndices - Global column indices corresponding to values.
Returns
Integer error code, set to 0 if successful.

Definition at line 600 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginSumIntoMyValues ( int  BlockRow,
int  NumBlockEntries,
int *  BlockIndices 
)

Initiate summing into current values with this list of entries for a given local row of the matrix, values are replaced via SubmitEntry()

Parameters
InRow - Block Row number (in local coordinates) to put elements.
InNumBlockEntries - Number of entries.
InIndices - Local column indices corresponding to values.
Returns
Integer error code, set to 0 if successful.

Definition at line 609 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::SubmitBlockEntry ( double *  Values,
int  LDA,
int  NumRows,
int  NumCols 
)

Submit a block entry to the indicated block row and column specified in the Begin routine.

Definition at line 682 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::SubmitBlockEntry ( Epetra_SerialDenseMatrix Mat)

Submit a block entry to the indicated block row and column specified in the Begin routine.

Definition at line 699 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::EndSubmitEntries ( )

Completes processing of all data passed in for the current block row.

  This function completes the processing of all block entries submitted via SubmitBlockEntry().
  It also checks to make sure that SubmitBlockEntry was called the correct number of times as

specified by the Begin routine that initiated the entry process.

Definition at line 705 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::ReplaceDiagonalValues ( const Epetra_Vector Diagonal)

Replaces diagonal values of the with those in the user-provided vector.

  This routine is meant to allow replacement of \b existing diagonal values.
  If a diagonal value does not exist for a given row, the corresponding value in

the input Epetra_Vector will be ignored and the return code will be set to 1.

The Epetra_Map associated with the input Epetra_Vector must be compatible with the RowMap of the matrix.

Parameters
Diagonal(In) - New values to be placed in the main diagonal.
Returns
Integer error code, set to 0 if successful, 1 of one or more diagonal entries not present in matrix.

Definition at line 1414 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::FillComplete ( )

Signal that data entry is complete, perform transformations to local index space.

Definition at line 875 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::FillComplete ( const Epetra_BlockMap DomainMap,
const Epetra_BlockMap RangeMap 
)

Signal that data entry is complete, perform transformations to local index space.

Definition at line 882 of file Epetra_VbrMatrix.cpp.

bool Epetra_VbrMatrix::Filled ( ) const
inlinevirtual

If FillComplete() has been called, this query returns true, otherwise it returns false.

Implements Epetra_RowMatrix.

Definition at line 470 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::ExtractGlobalBlockRowPointers ( int  BlockRow,
int  MaxNumBlockEntries,
int &  RowDim,
int &  NumBlockEntries,
int *  BlockIndices,
Epetra_SerialDenseMatrix **&  Values 
) const

Copy the block indices into user-provided array, set pointers for rest of data for specified global block row.

This function provides the lightest weight approach to accessing a global block row when the matrix may be be stored in local or global index space. In other words, this function will always work because the block indices are returned in user-provided space. All other array arguments are independent of whether or not indices are local or global. Other than the BlockIndices array, all other array argument are returned as pointers to internal data.

Parameters
InBlockRow - Global block row to extract.
InMaxNumBlockEntries - Length of user-provided BlockIndices array.
OutRowDim - Number of equations in the requested block row.
OutNumBlockEntries - Number of nonzero entries actually extracted.
OutBlockIndices - Extracted global column indices for the corresponding block entries.
OutValues - Pointer to list of pointers to block entries. Note that the actual values are not copied.
Returns
Integer error code, set to 0 if successful.

Definition at line 1160 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::ExtractMyBlockRowPointers ( int  BlockRow,
int  MaxNumBlockEntries,
int &  RowDim,
int &  NumBlockEntries,
int *  BlockIndices,
Epetra_SerialDenseMatrix **&  Values 
) const

Copy the block indices into user-provided array, set pointers for rest of data for specified local block row.

This function provides the lightest weight approach to accessing a local block row when the matrix may be be stored in local or global index space. In other words, this function will always work because the block indices are returned in user-provided space. All other array arguments are independent of whether or not indices are local or global. Other than the BlockIndices array, all other array argument are returned as pointers to internal data.

Parameters
InBlockRow - Local block row to extract.
InMaxNumBlockEntries - Length of user-provided BlockIndices array.
OutRowDim - Number of equations in the requested block row.
OutNumBlockEntries - Number of nonzero entries actually extracted.
OutBlockIndices - Extracted local column indices for the corresponding block entries.
OutValues - Pointer to list of pointers to block entries. Note that the actual values are not copied.
Returns
Integer error code, set to 0 if successful.

Definition at line 1172 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginExtractGlobalBlockRowCopy ( int  BlockRow,
int  MaxNumBlockEntries,
int &  RowDim,
int &  NumBlockEntries,
int *  BlockIndices,
int *  ColDims 
) const

Initiates a copy of the specified global row in user-provided arrays.

Parameters
InBlockRow - Global block row to extract.
InMaxNumBlockEntries - Length of user-provided BlockIndices, ColDims, and LDAs arrays.
OutRowDim - Number of equations in the requested block row.
OutNumBlockEntries - Number of nonzero entries actually extracted.
OutBlockIndices - Extracted global column indices for the corresponding block entries.
OutColDim - List of column dimensions for each corresponding block entry that will be extracted.
Returns
Integer error code, set to 0 if successful.

Definition at line 1211 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginExtractMyBlockRowCopy ( int  BlockRow,
int  MaxNumBlockEntries,
int &  RowDim,
int &  NumBlockEntries,
int *  BlockIndices,
int *  ColDims 
) const

Initiates a copy of the specified local row in user-provided arrays.

Parameters
InBlockRow - Local block row to extract.
InMaxNumBlockEntries - Length of user-provided BlockIndices, ColDims, and LDAs arrays.
OutRowDim - Number of equations in the requested block row.
OutNumBlockEntries - Number of nonzero entries actually extracted.
OutBlockIndices - Extracted local column indices for the corresponding block entries.
OutColDim - List of column dimensions for each corresponding block entry that will be extracted.
Returns
Integer error code, set to 0 if successful.

Definition at line 1222 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::ExtractEntryCopy ( int  SizeOfValues,
double *  Values,
int  LDA,
bool  SumInto 
) const

Extract a copy of an entry from the block row specified by one of the BeginExtract routines.

  Once BeginExtractGlobalBlockRowCopy() or BeginExtractMyBlockRowCopy() is called, you can extract
  the block entries of specified block row one-entry-at-a-time.  The entries will be extracted

in an order corresponding to the BlockIndices list that was returned by the BeginExtract routine.

Parameters
InSizeOfValues - Amount of memory associated with Values. This must be at least as big as LDA*NumCol, where NumCol is the column dimension of the block entry being copied
InOutValues - Starting location where the block entry will be copied.
InLDA - Specifies the stride that will be used when copying columns into Values.
InSumInto - If set to true, the block entry values will be summed into existing values.

Definition at line 1278 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginExtractGlobalBlockRowView ( int  BlockRow,
int &  RowDim,
int &  NumBlockEntries,
int *&  BlockIndices 
) const

Initiates a view of the specified global row, only works if matrix indices are in global mode.

Parameters
InBlockRow - Global block row to view.
OutRowDim - Number of equations in the requested block row.
OutNumBlockEntries - Number of nonzero entries to be viewed.
OutBlockIndices - Pointer to global column indices for the corresponding block entries.
Returns
Integer error code, set to 0 if successful.

Definition at line 1314 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginExtractMyBlockRowView ( int  BlockRow,
int &  RowDim,
int &  NumBlockEntries,
int *&  BlockIndices 
) const

Initiates a view of the specified local row, only works if matrix indices are in local mode.

Parameters
InBlockRow - Local block row to view.
OutRowDim - Number of equations in the requested block row.
OutNumBlockEntries - Number of nonzero entries to be viewed.
OutBlockIndices - Pointer to local column indices for the corresponding block entries.
Returns
Integer error code, set to 0 if successful.

Definition at line 1326 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::ExtractEntryView ( Epetra_SerialDenseMatrix *&  entry) const

Returns a pointer to the current block entry.

  After a call to BeginExtractGlobal() or BlockRowViewBeginExtractMyBlockRowView(),
  ExtractEntryView() can be called up to NumBlockEntries times to get each block entry in the

specified block row.

Parameters
InOutentry - A pointer that will be set to the current block entry.

Definition at line 1356 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::ExtractGlobalBlockRowView ( int  BlockRow,
int &  RowDim,
int &  NumBlockEntries,
int *&  BlockIndices,
Epetra_SerialDenseMatrix **&  Values 
) const

Initiates a view of the specified global row, only works if matrix indices are in global mode.

Parameters
InBlockRow - Global block row to view.
OutRowDim - Number of equations in the requested block row.
OutNumBlockEntries - Number of nonzero entries to be viewed.
OutBlockIndices - Pointer to global column indices for the corresponding block entries.
OutValues - Pointer to an array of pointers to the block entries in the specified block row.
Returns
Integer error code, set to 0 if successful.

Definition at line 1365 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::ExtractMyBlockRowView ( int  BlockRow,
int &  RowDim,
int &  NumBlockEntries,
int *&  BlockIndices,
Epetra_SerialDenseMatrix **&  Values 
) const

Initiates a view of the specified local row, only works if matrix indices are in local mode.

Parameters
InBlockRow - Local block row to view.
OutRowDim - Number of equations in the requested block row.
OutNumBlockEntries - Number of nonzero entries to be viewed.
OutBlockIndices - Pointer to local column indices for the corresponding block entries.
OutValues - Pointer to an array of pointers to the block entries in the specified block row.
Returns
Integer error code, set to 0 if successful.

Definition at line 1379 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::ExtractDiagonalCopy ( Epetra_Vector Diagonal) const
virtual

Returns a copy of the main diagonal in a user-provided vector.

Parameters
OutDiagonal - Extracted main diagonal.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

Definition at line 1392 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginExtractBlockDiagonalCopy ( int  MaxNumBlockDiagonalEntries,
int &  NumBlockDiagonalEntries,
int *  RowColDims 
) const

Initiates a copy of the block diagonal entries to user-provided arrays.

Parameters
InMaxNumBlockDiagonalEntries - Length of user-provided RowColDims array.
OutNumBlockDiagonalEntries - Number of block diagonal entries that can actually be extracted.
OutRowColDim - List of row and column dimension for corresponding block diagonal entries.
Returns
Integer error code, set to 0 if successful.

Definition at line 1444 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::ExtractBlockDiagonalEntryCopy ( int  SizeOfValues,
double *  Values,
int  LDA,
bool  SumInto 
) const

Extract a copy of a block diagonal entry from the matrix.

  Once BeginExtractBlockDiagonalCopy() is called, you can extract
  the block diagonal entries one-entry-at-a-time.  The entries will be extracted

in ascending order.

Parameters
InSizeOfValues - Amount of memory associated with Values. This must be at least as big as LDA*NumCol, where NumCol is the column dimension of the block entry being copied
InOutValues - Starting location where the block entry will be copied.
InLDA - Specifies the stride that will be used when copying columns into Values.
InSumInto - If set to true, the block entry values will be summed into existing values.

Definition at line 1455 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginExtractBlockDiagonalView ( int &  NumBlockDiagonalEntries,
int *&  RowColDims 
) const

Initiates a view of the block diagonal entries.

Parameters
OutNumBlockDiagonalEntries - Number of block diagonal entries that can be viewed.
OutRowColDim - Pointer to list of row and column dimension for corresponding block diagonal entries.
Returns
Integer error code, set to 0 if successful.

Definition at line 1476 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::ExtractBlockDiagonalEntryView ( double *&  Values,
int &  LDA 
) const

Extract a view of a block diagonal entry from the matrix.

  Once BeginExtractBlockDiagonalView() is called, you can extract a view of
  the block diagonal entries one-entry-at-a-time.  The views will be extracted

in ascending order.

Parameters
OutValues - Pointer to internal copy of block entry.
OutLDA - Column stride of Values.

Definition at line 1486 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::Multiply1 ( bool  TransA,
const Epetra_Vector x,
Epetra_Vector y 
) const

Returns the result of a Epetra_VbrMatrix multiplied by a Epetra_Vector x in y.

Parameters
InTransA - If true, multiply by the transpose of matrix, otherwise just use matrix.
Inx - A Epetra_Vector to multiply by.
Outy - A Epetra_Vector containing result.
Returns
Integer error code, set to 0 if successful.

Definition at line 1602 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::Multiply ( bool  TransA,
const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
virtual

Returns the result of a Epetra_VbrMatrix multiplied by a Epetra_MultiVector X in Y.

Parameters
InTransA -If true, multiply by the transpose of matrix, otherwise just use matrix.
InX - A Epetra_MultiVector of dimension NumVectors to multiply with matrix.
OutY -A Epetra_MultiVector of dimension NumVectorscontaining result.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

Definition at line 3333 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::Solve ( bool  Upper,
bool  Trans,
bool  UnitDiagonal,
const Epetra_Vector x,
Epetra_Vector y 
) const

Returns the result of a solve using the Epetra_VbrMatrix on a Epetra_Vector x in y.

Parameters
InUpper -If true, solve Ux = y, otherwise solve Lx = y.
InTrans -If true, solve transpose problem.
InUnitDiagonal -If true, assume diagonal is unit (whether it's stored or not).
Inx -A Epetra_Vector to solve for.
Outy -A Epetra_Vector containing result.
Returns
Integer error code, set to 0 if successful.
int Epetra_VbrMatrix::Solve ( bool  Upper,
bool  Trans,
bool  UnitDiagonal,
const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
virtual

Returns the result of a Epetra_VbrMatrix multiplied by a Epetra_MultiVector X in Y.

Parameters
InUpper -If true, solve Ux = y, otherwise solve Lx = y.
InTrans -If true, solve transpose problem.
InUnitDiagonal -If true, assume diagonal is unit (whether it's stored or not).
InX - A Epetra_MultiVector of dimension NumVectors to solve for.
OutY -A Epetra_MultiVector of dimension NumVectors containing result.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

Definition at line 3347 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::InvRowSums ( Epetra_Vector x) const
virtual

Computes the sum of absolute values of the rows of the Epetra_VbrMatrix, results returned in x.

  The vector x will return such that x[i] will contain the inverse of sum of the absolute values of the
  \e this matrix will be scaled such that A(i,j) = x(i)*A(i,j) where i denotes the global row number of A
  and j denotes the global column number of A.  Using the resulting vector from this function as input to LeftScale()

will make the infinity norm of the resulting matrix exactly 1.

Parameters
Outx -A Epetra_Vector containing the row sums of the this matrix.
Warning
It is assumed that the distribution of x is the same as the rows of this.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

Definition at line 2479 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::LeftScale ( const Epetra_Vector x)
virtual

Scales the Epetra_VbrMatrix on the left with a Epetra_Vector x.

The \e this matrix will be scaled such that A(i,j) = x(i)*A(i,j) where i denotes the row number of A
and j denotes the column number of A.
Parameters
Inx -A Epetra_Vector to solve for.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

Definition at line 2613 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::InvColSums ( Epetra_Vector x) const
virtual

Computes the sum of absolute values of the columns of the Epetra_VbrMatrix, results returned in x.

  The vector x will return such that x[j] will contain the inverse of sum of the absolute values of the
  \e this matrix will be sca such that A(i,j) = x(j)*A(i,j) where i denotes the global row number of A
  and j denotes the global column number of A.  Using the resulting vector from this function as input to

RighttScale() will make the one norm of the resulting matrix exactly 1.

Parameters
Outx -A Epetra_Vector containing the column sums of the this matrix.
Warning
It is assumed that the distribution of x is the same as the rows of this.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

Definition at line 2488 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::RightScale ( const Epetra_Vector x)
virtual

Scales the Epetra_VbrMatrix on the right with a Epetra_Vector x.

The \e this matrix will be scaled such that A(i,j) = x(j)*A(i,j) where i denotes the global row number of A
and j denotes the global column number of A.
Parameters
Inx -The Epetra_Vector used for scaling this.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

Definition at line 2622 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::OptimizeStorage ( )

Eliminates memory that is used for construction. Make consecutive row index sections contiguous.

Definition at line 1022 of file Epetra_VbrMatrix.cpp.

bool Epetra_VbrMatrix::StorageOptimized ( ) const
inline

If OptimizeStorage() has been called, this query returns true, otherwise it returns false.

Definition at line 858 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::IndicesAreGlobal ( ) const
inline

If matrix indices has not been transformed to local, this query returns true, otherwise it returns false.

Definition at line 861 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::IndicesAreLocal ( ) const
inline

If matrix indices has been transformed to local, this query returns true, otherwise it returns false.

Definition at line 864 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::IndicesAreContiguous ( ) const
inline

If matrix indices are packed into single array (done in OptimizeStorage()) return true, otherwise false.

Definition at line 867 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::LowerTriangular ( ) const
inlinevirtual

If matrix is lower triangular in local index space, this query returns true, otherwise it returns false.

Implements Epetra_RowMatrix.

Definition at line 870 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::UpperTriangular ( ) const
inlinevirtual

If matrix is upper triangular in local index space, this query returns true, otherwise it returns false.

Implements Epetra_RowMatrix.

Definition at line 873 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::NoDiagonal ( ) const
inline

If matrix has no diagonal entries based on global row/column index comparisons, this query returns true, otherwise it returns false.

Definition at line 876 of file Epetra_VbrMatrix.h.

double Epetra_VbrMatrix::NormInf ( void  ) const
virtual

Returns the infinity norm of the global matrix.

Implements Epetra_RowMatrix.

Definition at line 2726 of file Epetra_VbrMatrix.cpp.

double Epetra_VbrMatrix::NormOne ( void  ) const
virtual

Returns the one norm of the global matrix.

Implements Epetra_RowMatrix.

Definition at line 2785 of file Epetra_VbrMatrix.cpp.

double Epetra_VbrMatrix::NormFrobenius ( ) const

Returns the frobenius norm of the global matrix.

Definition at line 2840 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::MaxRowDim ( ) const
inline

Returns the maximum row dimension of all block entries on this processor.

Definition at line 906 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::MaxColDim ( ) const
inline

Returns the maximum column dimension of all block entries on this processor.

Definition at line 909 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::GlobalMaxRowDim ( ) const
inline

Returns the maximum row dimension of all block entries across all processors.

Definition at line 912 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::GlobalMaxColDim ( ) const
inline

Returns the maximum column dimension of all block entries across all processors.

Definition at line 915 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumMyRows ( ) const
inlinevirtual

Returns the number of matrix rows owned by the calling processor.

Implements Epetra_RowMatrix.

Definition at line 918 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumMyCols ( ) const
inlinevirtual

Returns the number of matrix columns owned by the calling processor.

Implements Epetra_RowMatrix.

Definition at line 920 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumMyNonzeros ( ) const
inlinevirtual

Returns the number of nonzero entriesowned by the calling processor .

Implements Epetra_RowMatrix.

Definition at line 923 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumGlobalRows ( ) const
inlinevirtual

Returns the number of global matrix rows.

Implements Epetra_RowMatrix.

Definition at line 927 of file Epetra_VbrMatrix.h.

long long Epetra_VbrMatrix::NumGlobalRows64 ( ) const
inlinevirtual

Implements Epetra_RowMatrix.

Definition at line 929 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumGlobalCols ( ) const
inlinevirtual

Returns the number of global matrix columns.

Implements Epetra_RowMatrix.

Definition at line 933 of file Epetra_VbrMatrix.h.

long long Epetra_VbrMatrix::NumGlobalCols64 ( ) const
inlinevirtual

Implements Epetra_RowMatrix.

Definition at line 935 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumGlobalNonzeros ( ) const
inlinevirtual

Returns the number of nonzero entries in the global matrix.

Implements Epetra_RowMatrix.

Definition at line 945 of file Epetra_VbrMatrix.h.

long long Epetra_VbrMatrix::NumGlobalNonzeros64 ( ) const
inlinevirtual

Implements Epetra_RowMatrix.

Definition at line 947 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumMyBlockRows ( ) const
inline

Returns the number of Block matrix rows owned by the calling processor.

Definition at line 950 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumMyBlockCols ( ) const
inline

Returns the number of Block matrix columns owned by the calling processor.

Definition at line 953 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumMyBlockEntries ( ) const
inline

Returns the number of nonzero block entries in the calling processor's portion of the matrix.

Definition at line 956 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumMyBlockDiagonals ( ) const
inline

Returns the number of local nonzero block diagonal entries, based on global row/column index comparisons.

Definition at line 959 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumMyDiagonals ( ) const
inlinevirtual

Returns the number of local nonzero diagonal entries, based on global row/column index comparisons.

Implements Epetra_RowMatrix.

Definition at line 962 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumGlobalBlockRows ( ) const
inline

Returns the number of global Block matrix rows.

Definition at line 966 of file Epetra_VbrMatrix.h.

long long Epetra_VbrMatrix::NumGlobalBlockRows64 ( ) const
inline

Definition at line 968 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumGlobalBlockCols ( ) const
inline

Returns the number of global Block matrix columns.

Definition at line 972 of file Epetra_VbrMatrix.h.

long long Epetra_VbrMatrix::NumGlobalBlockCols64 ( ) const
inline

Definition at line 974 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumGlobalBlockEntries ( ) const
inline

Returns the number of nonzero block entries in the global matrix.

Definition at line 978 of file Epetra_VbrMatrix.h.

long long Epetra_VbrMatrix::NumGlobalBlockEntries64 ( ) const
inline

Definition at line 980 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumGlobalBlockDiagonals ( ) const
inline

Returns the number of global nonzero block diagonal entries, based on global row/column index comparisions.

Definition at line 984 of file Epetra_VbrMatrix.h.

long long Epetra_VbrMatrix::NumGlobalBlockDiagonals64 ( ) const
inline

Definition at line 986 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumGlobalDiagonals ( ) const
inlinevirtual

Returns the number of global nonzero diagonal entries, based on global row/column index comparisions.

Implements Epetra_RowMatrix.

Definition at line 990 of file Epetra_VbrMatrix.h.

long long Epetra_VbrMatrix::NumGlobalDiagonals64 ( ) const
inlinevirtual

Implements Epetra_RowMatrix.

Definition at line 992 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumGlobalBlockEntries ( int  Row) const
inline

Returns the current number of nonzero Block entries in specified global row on this processor.

Definition at line 995 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumAllocatedGlobalBlockEntries ( int  Row) const
inline

Returns the allocated number of nonzero Block entries in specified global row on this processor.

Definition at line 998 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::MaxNumBlockEntries ( ) const
inline

Returns the maximum number of nonzero entries across all rows on this processor.

Definition at line 1001 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::GlobalMaxNumBlockEntries ( ) const
inline

Returns the maximum number of nonzero entries across all rows on this processor.

Definition at line 1004 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumMyBlockEntries ( int  Row) const
inline

Returns the current number of nonzero Block entries in specified local row on this processor.

Definition at line 1007 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumAllocatedMyBlockEntries ( int  Row) const
inline

Returns the allocated number of nonzero Block entries in specified local row on this processor.

Definition at line 1010 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::MaxNumNonzeros ( ) const
inline

Returns the maximum number of nonzero entries across all block rows on this processor.

  Let ki = the number of nonzero values in the ith block row of the VbrMatrix object.  For example,
  if the ith block row had 5 block entries and the size of each entry was 4-by-4, ki would be 80.

Then this function return the max over all ki for all row on this processor.

Definition at line 1017 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::GlobalMaxNumNonzeros ( ) const
inline

Returns the maximum number of nonzero entries across all block rows on all processors.

This function returns the max over all processor of MaxNumNonzeros().

Definition at line 1022 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::IndexBase ( ) const
inline

Returns the index base for row and column indices for this graph.

Index base for this map.

Definition at line 1027 of file Epetra_VbrMatrix.h.

long long Epetra_VbrMatrix::IndexBase64 ( ) const
inline

Definition at line 1033 of file Epetra_VbrMatrix.h.

const Epetra_CrsGraph& Epetra_VbrMatrix::Graph ( ) const
inline

Returns a pointer to the Epetra_CrsGraph object associated with this matrix.

Definition at line 1036 of file Epetra_VbrMatrix.h.

const Epetra_Import* Epetra_VbrMatrix::Importer ( ) const
inline

Returns the Epetra_Import object that contains the import operations for distributed operations.

Definition at line 1039 of file Epetra_VbrMatrix.h.

const Epetra_Export* Epetra_VbrMatrix::Exporter ( ) const
inline

Returns the Epetra_Export object that contains the export operations for distributed operations.

Definition at line 1042 of file Epetra_VbrMatrix.h.

const Epetra_BlockMap& Epetra_VbrMatrix::DomainMap ( ) const
inline

Returns the Epetra_BlockMap object associated with the domain of this matrix operator.

Definition at line 1045 of file Epetra_VbrMatrix.h.

const Epetra_BlockMap& Epetra_VbrMatrix::RangeMap ( ) const
inline

Returns the Epetra_BlockMap object associated with the range of this matrix operator.

Definition at line 1048 of file Epetra_VbrMatrix.h.

const Epetra_BlockMap& Epetra_VbrMatrix::RowMap ( ) const
inline

Returns the RowMap object as an Epetra_BlockMap (the Epetra_Map base class) needed for implementing Epetra_RowMatrix.

Definition at line 1051 of file Epetra_VbrMatrix.h.

const Epetra_BlockMap& Epetra_VbrMatrix::ColMap ( ) const
inline

Returns the ColMap as an Epetra_BlockMap (the Epetra_Map base class) needed for implementing Epetra_RowMatrix.

Definition at line 1054 of file Epetra_VbrMatrix.h.

const Epetra_Comm& Epetra_VbrMatrix::Comm ( ) const
inlinevirtual

Fills a matrix with rows from a source matrix based on the specified importer.

Returns a pointer to the Epetra_Comm communicator associated with this matrix.

Implements Epetra_Operator.

Definition at line 1059 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::LRID ( int  GRID_in) const
inline

Returns the local row index for given global row index, returns -1 if no local row for this global row.

Definition at line 1067 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::LRID ( long long  GRID_in) const
inline

Definition at line 1070 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::GRID ( int  LRID_in) const
inline

Returns the global row index for give local row index, returns IndexBase-1 if we don't have this local row.

Definition at line 1075 of file Epetra_VbrMatrix.h.

long long Epetra_VbrMatrix::GRID64 ( int  LRID_in) const
inline

Definition at line 1077 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::LCID ( int  GCID_in) const
inline

Returns the local column index for given global column index, returns -1 if no local column for this global column.

Definition at line 1081 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::LCID ( long long  GCID_in) const
inline

Definition at line 1084 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::GCID ( int  LCID_in) const
inline

Returns the global column index for give local column index, returns IndexBase-1 if we don't have this local column.

Definition at line 1089 of file Epetra_VbrMatrix.h.

long long Epetra_VbrMatrix::GCID64 ( int  LCID_in) const
inline

Definition at line 1091 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::MyGRID ( int  GRID_in) const
inline

Returns true if the GRID passed in belongs to the calling processor in this map, otherwise returns false.

Definition at line 1095 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::MyGRID ( long long  GRID_in) const
inline

Definition at line 1098 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::MyLRID ( int  LRID_in) const
inline

Returns true if the LRID passed in belongs to the calling processor in this map, otherwise returns false.

Definition at line 1102 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::MyGCID ( int  GCID_in) const
inline

Returns true if the GCID passed in belongs to the calling processor in this map, otherwise returns false.

Definition at line 1106 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::MyGCID ( long long  GCID_in) const
inline

Definition at line 1109 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::MyLCID ( int  LCID_in) const
inline

Returns true if the LRID passed in belongs to the calling processor in this map, otherwise returns false.

Definition at line 1113 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::MyGlobalBlockRow ( int  GID) const
inline

Returns true of GID is owned by the calling processor, otherwise it returns false.

Definition at line 1117 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::MyGlobalBlockRow ( long long  GID) const
inline

Definition at line 1120 of file Epetra_VbrMatrix.h.

void Epetra_VbrMatrix::Print ( std::ostream &  os) const
virtual

Print method.

Reimplemented from Epetra_DistObject.

Definition at line 3361 of file Epetra_VbrMatrix.cpp.

const char* Epetra_VbrMatrix::Label ( ) const
inlinevirtual

Returns a character string describing the operator.

Reimplemented from Epetra_Object.

Definition at line 1135 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::SetUseTranspose ( bool  UseTranspose_in)
inlinevirtual

If set true, transpose of this operator will be applied.

  This flag allows the transpose of the given operator to be used implicitly.  Setting this flag
  affects only the Apply() and ApplyInverse() methods.  If the implementation of this interface

does not support transpose use, this method should return a value of -1.

Parameters
InUseTranspose -If true, multiply by the transpose of operator, otherwise just use operator.
Returns
Always returns 0.

Implements Epetra_Operator.

Definition at line 1147 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::Apply ( const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
virtual

Returns the result of a Epetra_Operator applied to a Epetra_MultiVector X in Y.

Parameters
InX - A Epetra_MultiVector of dimension NumVectors to multiply with matrix.
OutY -A Epetra_MultiVector of dimension NumVectors containing result.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_Operator.

Definition at line 3305 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::ApplyInverse ( const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
virtual

Returns the result of a Epetra_Operator inverse applied to an Epetra_MultiVector X in Y.

  In this implementation, we use several existing attributes to determine how virtual
  method ApplyInverse() should call the concrete method Solve().  We pass in the UpperTriangular(),

the Epetra_VbrMatrix::UseTranspose(), and NoDiagonal() methods. The most notable warning is that if a matrix has no diagonal values we assume that there is an implicit unit diagonal that should be accounted for when doing a triangular solve.

Parameters
InX - A Epetra_MultiVector of dimension NumVectors to solve for.
OutY -A Epetra_MultiVector of dimension NumVectors containing result.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_Operator.

Definition at line 3319 of file Epetra_VbrMatrix.cpp.

bool Epetra_VbrMatrix::HasNormInf ( ) const
inlinevirtual

Returns true because this class can compute an Inf-norm.

Implements Epetra_Operator.

Definition at line 1177 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::UseTranspose ( ) const
inlinevirtual

Returns the current UseTranspose setting.

Implements Epetra_Operator.

Definition at line 1180 of file Epetra_VbrMatrix.h.

const Epetra_Map& Epetra_VbrMatrix::OperatorDomainMap ( ) const
inlinevirtual

Returns the Epetra_Map object associated with the domain of this matrix operator.

Implements Epetra_Operator.

Definition at line 1183 of file Epetra_VbrMatrix.h.

const Epetra_Map& Epetra_VbrMatrix::OperatorRangeMap ( ) const
inlinevirtual

Returns the Epetra_Map object associated with the range of this matrix operator.

Implements Epetra_Operator.

Definition at line 1191 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::ExtractGlobalRowCopy ( int  GlobalRow,
int  Length,
int &  NumEntries,
double *  Values,
int *  Indices 
) const

Returns a copy of the specified global row in user-provided arrays.

Parameters
InGlobalRow - Global row to extract.
InLength - Length of Values and Indices.
OutNumEntries - Number of nonzero entries extracted.
OutValues - Extracted values for this row.
OutIndices - Extracted global column indices for the corresponding values.
Returns
Integer error code, set to 0 if successful.

Definition at line 1145 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::ExtractMyRowCopy ( int  MyRow,
int  Length,
int &  NumEntries,
double *  Values,
int *  Indices 
) const
virtual

Returns a copy of the specified local row in user-provided arrays.

Parameters
InMyRow - Local row to extract.
InLength - Length of Values and Indices.
OutNumEntries - Number of nonzero entries extracted.
OutValues - Extracted values for this row.
OutIndices - Extracted local column indices for the corresponding values.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

Definition at line 1559 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::NumMyRowEntries ( int  MyRow,
int &  NumEntries 
) const
virtual

Return the current number of values stored for the specified local row.

Parameters
InMyRow - Local row.
OutNumEntries - Number of nonzero values.
Returns
Integer error code, set to 0 if successful.

Implements Epetra_RowMatrix.

Definition at line 1548 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::MaxNumEntries ( ) const
virtual

Returns the maximum of NumMyRowEntries() over all rows.

Implements Epetra_RowMatrix.

Definition at line 1535 of file Epetra_VbrMatrix.cpp.

const Epetra_BlockMap& Epetra_VbrMatrix::Map ( ) const
inlinevirtual

Map() method inherited from Epetra_DistObject.

Reimplemented from Epetra_DistObject.

Definition at line 1251 of file Epetra_VbrMatrix.h.

const Epetra_Map& Epetra_VbrMatrix::RowMatrixRowMap ( ) const
inlinevirtual

Returns the EpetraMap object associated with the rows of this matrix.

Implements Epetra_RowMatrix.

Definition at line 1254 of file Epetra_VbrMatrix.h.

const Epetra_Map& Epetra_VbrMatrix::RowMatrixColMap ( ) const
inlinevirtual

Returns the Epetra_Map object associated with columns of this matrix.

Implements Epetra_RowMatrix.

Definition at line 1258 of file Epetra_VbrMatrix.h.

const Epetra_Import* Epetra_VbrMatrix::RowMatrixImporter ( ) const
inlinevirtual

Returns the Epetra_Import object that contains the import operations for distributed operations.

Implements Epetra_RowMatrix.

Definition at line 1262 of file Epetra_VbrMatrix.h.

const Epetra_BlockMap& Epetra_VbrMatrix::BlockImportMap ( ) const
inline

Use BlockColMap() instead.

Definition at line 1271 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::TransformToLocal ( )

Use FillComplete() instead.

Definition at line 920 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::TransformToLocal ( const Epetra_BlockMap DomainMap,
const Epetra_BlockMap RangeMap 
)
void Epetra_VbrMatrix::DeleteMemory ( )
protected

Definition at line 413 of file Epetra_VbrMatrix.cpp.

bool Epetra_VbrMatrix::Allocated ( ) const
inlineprotected

Definition at line 1282 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::SetAllocated ( bool  Flag)
inlineprotected

Definition at line 1283 of file Epetra_VbrMatrix.h.

Epetra_SerialDenseMatrix*** Epetra_VbrMatrix::Values ( ) const
inlineprotected

Definition at line 1284 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::DoMultiply ( bool  TransA,
const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
protected

Definition at line 1753 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::DoSolve ( bool  Upper,
bool  Trans,
bool  UnitDiagonal,
const Epetra_MultiVector X,
Epetra_MultiVector Y 
) const
protected

Definition at line 2406 of file Epetra_VbrMatrix.cpp.

void Epetra_VbrMatrix::InitializeDefaults ( )
protected

Definition at line 317 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::Allocate ( )
protected

Definition at line 373 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginInsertValues ( int  BlockRow,
int  NumBlockEntries,
int *  BlockIndices,
bool  IndicesAreLocal 
)
protected

Definition at line 546 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginReplaceValues ( int  BlockRow,
int  NumBlockEntries,
int *  BlockIndices,
bool  IndicesAreLocal 
)
protected

Definition at line 587 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginSumIntoValues ( int  BlockRow,
int  NumBlockEntries,
int *  BlockIndices,
bool  IndicesAreLocal 
)
protected

Definition at line 617 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::SetupForSubmits ( int  BlockRow,
int  NumBlockEntries,
int *  BlockIndices,
bool  IndicesAreLocal,
Epetra_CombineMode  SubmitMode 
)
protected

Definition at line 628 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::EndReplaceSumIntoValues ( )
protected

Definition at line 722 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::EndInsertValues ( )
protected

Definition at line 775 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::CopyMat ( double *  A,
int  LDA,
int  NumRows,
int  NumCols,
double *  B,
int  LDB,
bool  SumInto 
) const
protected

Definition at line 848 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginExtractBlockRowCopy ( int  BlockRow,
int  MaxNumBlockEntries,
int &  RowDim,
int &  NumBlockEntries,
int *  BlockIndices,
int *  ColDims,
bool  IndicesAreLocal 
) const
protected

Definition at line 1233 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::SetupForExtracts ( int  BlockRow,
int &  RowDim,
int  NumBlockEntries,
bool  ExtractView,
bool  IndicesAreLocal 
) const
protected

Definition at line 1253 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::ExtractBlockDimsCopy ( int  NumBlockEntries,
int *  ColDims 
) const
protected

Definition at line 1269 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::ExtractBlockRowPointers ( int  BlockRow,
int  MaxNumBlockEntries,
int &  RowDim,
int &  NumBlockEntries,
int *  BlockIndices,
Epetra_SerialDenseMatrix **&  Values,
bool  IndicesAreLocal 
) const
protected

Definition at line 1184 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BeginExtractBlockRowView ( int  BlockRow,
int &  RowDim,
int &  NumBlockEntries,
int *&  BlockIndices,
bool  IndicesAreLocal 
) const
protected

Definition at line 1337 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::CopyMatDiag ( double *  A,
int  LDA,
int  NumRows,
int  NumCols,
double *  Diagonal 
) const
protected

Definition at line 1505 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::ReplaceMatDiag ( double *  A,
int  LDA,
int  NumRows,
int  NumCols,
double *  Diagonal 
)
protected

Definition at line 1520 of file Epetra_VbrMatrix.cpp.

void Epetra_VbrMatrix::BlockRowMultiply ( bool  TransA,
int  RowDim,
int  NumEntries,
int *  BlockIndices,
int  RowOff,
int *  FirstPointInElementList,
int *  ElementSizeList,
double  Alpha,
Epetra_SerialDenseMatrix **  As,
double **  X,
double  Beta,
double **  Y,
int  NumVectors 
) const
protected

Definition at line 2079 of file Epetra_VbrMatrix.cpp.

void Epetra_VbrMatrix::BlockRowMultiply ( bool  TransA,
int  RowDim,
int  NumEntries,
int *  BlockIndices,
int  RowOff,
int *  FirstPointInElementList,
int *  ElementSizeList,
Epetra_SerialDenseMatrix **  As,
double **  X,
double **  Y,
int  NumVectors 
) const
protected

Definition at line 2291 of file Epetra_VbrMatrix.cpp.

void Epetra_VbrMatrix::FastBlockRowMultiply ( bool  TransA,
int  RowDim,
int  NumEntries,
int *  BlockIndices,
int  RowOff,
int *  FirstPointInElementList,
int *  ElementSizeList,
Epetra_SerialDenseMatrix **  As,
double **  X,
double **  Y,
int  NumVectors 
) const
protected

Definition at line 2132 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::InverseSums ( bool  DoRows,
Epetra_Vector x 
) const
protected

Definition at line 2496 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::Scale ( bool  DoRows,
const Epetra_Vector x 
)
protected

Definition at line 2630 of file Epetra_VbrMatrix.cpp.

void Epetra_VbrMatrix::BlockRowNormInf ( int  RowDim,
int  NumEntries,
Epetra_SerialDenseMatrix **  As,
double *  Y 
) const
protected

Definition at line 2766 of file Epetra_VbrMatrix.cpp.

void Epetra_VbrMatrix::BlockRowNormOne ( int  RowDim,
int  NumEntries,
int *  BlockRowIndices,
Epetra_SerialDenseMatrix **  As,
int *  ColFirstPointInElementList,
double *  x 
) const
protected

Definition at line 2912 of file Epetra_VbrMatrix.cpp.

void Epetra_VbrMatrix::SetStaticGraph ( bool  Flag)
inlineprotected

Definition at line 1360 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::CheckSizes ( const Epetra_SrcDistObject Source)
protectedvirtual

Allows the source and target (this) objects to be compared for compatibility, return nonzero if not.

Implements Epetra_DistObject.

Definition at line 2930 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::CopyAndPermute ( const Epetra_SrcDistObject Source,
int  NumSameIDs,
int  NumPermuteIDs,
int *  PermuteToLIDs,
int *  PermuteFromLIDs,
const Epetra_OffsetIndex Indexor,
Epetra_CombineMode  CombineMode = Zero 
)
protectedvirtual

Perform ID copies and permutations that are on processor.

Implements Epetra_DistObject.

Definition at line 2936 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::PackAndPrepare ( const Epetra_SrcDistObject Source,
int  NumExportIDs,
int *  ExportLIDs,
int &  LenExports,
char *&  Exports,
int &  SizeOfPacket,
int *  Sizes,
bool &  VarSizes,
Epetra_Distributor Distor 
)
protectedvirtual

Perform any packing or preparation required for call to DoTransfer().

Implements Epetra_DistObject.

Definition at line 3033 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::UnpackAndCombine ( const Epetra_SrcDistObject Source,
int  NumImportIDs,
int *  ImportLIDs,
int  LenImports,
char *  Imports,
int &  SizeOfPacket,
Epetra_Distributor Distor,
Epetra_CombineMode  CombineMode,
const Epetra_OffsetIndex Indexor 
)
protectedvirtual

Perform any unpacking and combining after call to DoTransfer().

Implements Epetra_DistObject.

Definition at line 3116 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::SortEntries ( )
protected

Sort column entries, row-by-row, in ascending order.

Definition at line 932 of file Epetra_VbrMatrix.cpp.

bool Epetra_VbrMatrix::Sorted ( ) const
inlineprotected

If SortEntries() has been called, this query returns true, otherwise it returns false.

Definition at line 1396 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::MergeRedundantEntries ( )
protected

Add entries that have the same column index. Remove redundant entries from list.

Definition at line 974 of file Epetra_VbrMatrix.cpp.

bool Epetra_VbrMatrix::NoRedundancies ( ) const
inlineprotected

If MergeRedundantEntries() has been called, this query returns true, otherwise it returns false.

Definition at line 1402 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::StaticGraph ( ) const
inlineprotected

Definition at line 1404 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::GeneratePointObjects ( ) const
protected

Definition at line 3212 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::BlockMap2PointMap ( const Epetra_BlockMap BlockMap,
Epetra_Map *&  PointMap 
) const
protected

Definition at line 3255 of file Epetra_VbrMatrix.cpp.

int Epetra_VbrMatrix::UpdateOperatorXY ( const Epetra_MultiVector X,
const Epetra_MultiVector Y 
) const
protected

Definition at line 3287 of file Epetra_VbrMatrix.cpp.

Member Data Documentation

Epetra_CrsGraph* Epetra_VbrMatrix::Graph_
protected

Definition at line 1410 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::Allocated_
protected

Definition at line 1411 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::StaticGraph_
protected

Definition at line 1412 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::UseTranspose_
protected

Definition at line 1413 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::constructedWithFilledGraph_
protected

Definition at line 1414 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::matrixFillCompleteCalled_
protected

Definition at line 1415 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::StorageOptimized_
protected

Definition at line 1416 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::NumMyBlockRows_
protected

Definition at line 1418 of file Epetra_VbrMatrix.h.

Epetra_DataAccess Epetra_VbrMatrix::CV_
protected

Definition at line 1420 of file Epetra_VbrMatrix.h.

int* Epetra_VbrMatrix::NumBlockEntriesPerRow_
protected

Definition at line 1423 of file Epetra_VbrMatrix.h.

int* Epetra_VbrMatrix::NumAllocatedBlockEntriesPerRow_
protected

Definition at line 1424 of file Epetra_VbrMatrix.h.

int** Epetra_VbrMatrix::Indices_
protected

Definition at line 1425 of file Epetra_VbrMatrix.h.

int* Epetra_VbrMatrix::ElementSizeList_
protected

Definition at line 1426 of file Epetra_VbrMatrix.h.

int* Epetra_VbrMatrix::FirstPointInElementList_
protected

Definition at line 1427 of file Epetra_VbrMatrix.h.

Epetra_SerialDenseMatrix*** Epetra_VbrMatrix::Entries_
protected

Definition at line 1429 of file Epetra_VbrMatrix.h.

double* Epetra_VbrMatrix::All_Values_Orig_
protected

Definition at line 1431 of file Epetra_VbrMatrix.h.

double* Epetra_VbrMatrix::All_Values_
protected

Definition at line 1432 of file Epetra_VbrMatrix.h.

double Epetra_VbrMatrix::NormInf_
mutableprotected

Definition at line 1434 of file Epetra_VbrMatrix.h.

double Epetra_VbrMatrix::NormOne_
mutableprotected

Definition at line 1435 of file Epetra_VbrMatrix.h.

double Epetra_VbrMatrix::NormFrob_
mutableprotected

Definition at line 1436 of file Epetra_VbrMatrix.h.

Epetra_MultiVector* Epetra_VbrMatrix::ImportVector_
mutableprotected

Definition at line 1438 of file Epetra_VbrMatrix.h.

Epetra_MultiVector* Epetra_VbrMatrix::ExportVector_
mutableprotected

Definition at line 1439 of file Epetra_VbrMatrix.h.

int* Epetra_VbrMatrix::TempRowDims_
mutableprotected

Definition at line 1442 of file Epetra_VbrMatrix.h.

Epetra_SerialDenseMatrix** Epetra_VbrMatrix::TempEntries_
mutableprotected

Definition at line 1443 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::LenTemps_
mutableprotected

Definition at line 1444 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::CurBlockRow_
mutableprotected

Definition at line 1445 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::CurNumBlockEntries_
mutableprotected

Definition at line 1446 of file Epetra_VbrMatrix.h.

int* Epetra_VbrMatrix::CurBlockIndices_
mutableprotected

Definition at line 1447 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::CurEntry_
mutableprotected

Definition at line 1448 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::CurIndicesAreLocal_
mutableprotected

Definition at line 1449 of file Epetra_VbrMatrix.h.

Epetra_CombineMode Epetra_VbrMatrix::CurSubmitMode_
mutableprotected

Definition at line 1450 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::CurExtractBlockRow_
mutableprotected

Definition at line 1453 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::CurExtractEntry_
mutableprotected

Definition at line 1454 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::CurExtractNumBlockEntries_
mutableprotected

Definition at line 1455 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::CurExtractIndicesAreLocal_
mutableprotected

Definition at line 1456 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::CurExtractView_
mutableprotected

Definition at line 1457 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::CurRowDim_
mutableprotected

Definition at line 1458 of file Epetra_VbrMatrix.h.

int Epetra_VbrMatrix::CurBlockDiag_
mutableprotected

Definition at line 1461 of file Epetra_VbrMatrix.h.

Epetra_Map* Epetra_VbrMatrix::RowMatrixRowMap_
mutableprotected

Definition at line 1464 of file Epetra_VbrMatrix.h.

Epetra_Map* Epetra_VbrMatrix::RowMatrixColMap_
mutableprotected

Definition at line 1465 of file Epetra_VbrMatrix.h.

Epetra_Import* Epetra_VbrMatrix::RowMatrixImporter_
mutableprotected

Definition at line 1466 of file Epetra_VbrMatrix.h.

Epetra_Map* Epetra_VbrMatrix::OperatorDomainMap_
mutableprotected

Definition at line 1469 of file Epetra_VbrMatrix.h.

Epetra_Map* Epetra_VbrMatrix::OperatorRangeMap_
mutableprotected

Definition at line 1470 of file Epetra_VbrMatrix.h.

Epetra_MultiVector* Epetra_VbrMatrix::OperatorX_
mutableprotected

Definition at line 1471 of file Epetra_VbrMatrix.h.

Epetra_MultiVector* Epetra_VbrMatrix::OperatorY_
mutableprotected

Definition at line 1472 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::HavePointObjects_
mutableprotected

Definition at line 1475 of file Epetra_VbrMatrix.h.

bool Epetra_VbrMatrix::squareFillCompleteCalled_
protected

Definition at line 1477 of file Epetra_VbrMatrix.h.


The documentation for this class was generated from the following files: