Epetra  Development
 All Classes Namespaces Files Functions Variables Enumerations Enumerator Pages
List of all members
Epetra_FEVbrMatrix Class Reference

#include <Epetra_FEVbrMatrix.h>

Inheritance diagram for Epetra_FEVbrMatrix:
Inheritance graph
[legend]
Collaboration diagram for Epetra_FEVbrMatrix:
Collaboration graph
[legend]

Public Member Functions

Constructors/Destructor
 Epetra_FEVbrMatrix (Epetra_DataAccess CV, const Epetra_BlockMap &RowMap, int *NumBlockEntriesPerRow, bool ignoreNonLocalEntries=false)
 Epetra_FEVbrMatrix constuctor with variable number of indices per row. More...
 
 Epetra_FEVbrMatrix (Epetra_DataAccess CV, const Epetra_BlockMap &RowMap, int NumBlockEntriesPerRow, bool ignoreNonLocalEntries=false)
 Epetra_FEVbrMatrix constuctor with fixed number of indices per row. More...
 
 Epetra_FEVbrMatrix (Epetra_DataAccess CV, const Epetra_BlockMap &RowMap, const Epetra_BlockMap &ColMap, int *NumBlockEntriesPerRow, bool ignoreNonLocalEntries=false)
 Epetra_FEVbrMatrix constuctor with variable number of indices per row. More...
 
 Epetra_FEVbrMatrix (Epetra_DataAccess CV, const Epetra_BlockMap &RowMap, const Epetra_BlockMap &ColMap, int NumBlockEntriesPerRow, bool ignoreNonLocalEntries=false)
 Epetra_FEVbrMatrix constuctor with fixed number of indices per row. More...
 
 Epetra_FEVbrMatrix (Epetra_DataAccess CV, const Epetra_CrsGraph &Graph, bool ignoreNonLocalEntries=false)
 
 Epetra_FEVbrMatrix (const Epetra_FEVbrMatrix &src)
 
virtual ~Epetra_FEVbrMatrix ()
 Epetra_VbrMatrix Destructor.
 
- Public Member Functions inherited from Epetra_VbrMatrix
 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.
 
virtual ~Epetra_VbrMatrix ()
 Epetra_VbrMatrix Destructor.
 
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.
 
int SubmitBlockEntry (Epetra_SerialDenseMatrix &Mat)
 Submit a block entry to the indicated block row and column specified in the Begin routine.
 
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.
 
int FillComplete (const Epetra_BlockMap &DomainMap, const Epetra_BlockMap &RangeMap)
 Signal that data entry is complete, perform transformations to local index space.
 
bool Filled () const
 If FillComplete() has been called, this query returns true, otherwise it returns false.
 
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...
 
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...
 
int OptimizeStorage ()
 Eliminates memory that is used for construction. Make consecutive row index sections contiguous.
 
bool StorageOptimized () const
 If OptimizeStorage() has been called, this query returns true, otherwise it returns false.
 
bool IndicesAreGlobal () const
 If matrix indices has not been transformed to local, this query returns true, otherwise it returns false.
 
bool IndicesAreLocal () const
 If matrix indices has been transformed to local, this query returns true, otherwise it returns false.
 
bool IndicesAreContiguous () const
 If matrix indices are packed into single array (done in OptimizeStorage()) return true, otherwise false.
 
bool LowerTriangular () const
 If matrix is lower triangular in local index space, this query returns true, otherwise it returns false.
 
bool UpperTriangular () const
 If matrix is upper triangular in local index space, this query returns true, otherwise it returns false.
 
bool NoDiagonal () const
 If matrix has no diagonal entries based on global row/column index comparisons, this query returns true, otherwise it returns false.
 
double NormInf () const
 Returns the infinity norm of the global matrix.
 
double NormOne () const
 Returns the one norm of the global matrix.
 
double NormFrobenius () const
 Returns the frobenius norm of the global matrix.
 
int MaxRowDim () const
 Returns the maximum row dimension of all block entries on this processor.
 
int MaxColDim () const
 Returns the maximum column dimension of all block entries on this processor.
 
int GlobalMaxRowDim () const
 Returns the maximum row dimension of all block entries across all processors.
 
int GlobalMaxColDim () const
 Returns the maximum column dimension of all block entries across all processors.
 
int NumMyRows () const
 Returns the number of matrix rows owned by the calling processor.
 
int NumMyCols () const
 Returns the number of matrix columns owned by the calling processor.
 
int NumMyNonzeros () const
 Returns the number of nonzero entriesowned by the calling processor .
 
int NumGlobalRows () const
 Returns the number of global matrix rows.
 
long long NumGlobalRows64 () const
 
int NumGlobalCols () const
 Returns the number of global matrix columns.
 
long long NumGlobalCols64 () const
 
int NumGlobalNonzeros () const
 Returns the number of nonzero entries in the global matrix.
 
long long NumGlobalNonzeros64 () const
 
int NumMyBlockRows () const
 Returns the number of Block matrix rows owned by the calling processor.
 
int NumMyBlockCols () const
 Returns the number of Block matrix columns owned by the calling processor.
 
int NumMyBlockEntries () const
 Returns the number of nonzero block entries in the calling processor's portion of the matrix.
 
int NumMyBlockDiagonals () const
 Returns the number of local nonzero block diagonal entries, based on global row/column index comparisons.
 
int NumMyDiagonals () const
 Returns the number of local nonzero diagonal entries, based on global row/column index comparisons.
 
int NumGlobalBlockRows () const
 Returns the number of global Block matrix rows.
 
long long NumGlobalBlockRows64 () const
 
int NumGlobalBlockCols () const
 Returns the number of global Block matrix columns.
 
long long NumGlobalBlockCols64 () const
 
int NumGlobalBlockEntries () const
 Returns the number of nonzero block entries in the global matrix.
 
long long NumGlobalBlockEntries64 () const
 
int NumGlobalBlockDiagonals () const
 Returns the number of global nonzero block diagonal entries, based on global row/column index comparisions.
 
long long NumGlobalBlockDiagonals64 () const
 
int NumGlobalDiagonals () const
 Returns the number of global nonzero diagonal entries, based on global row/column index comparisions.
 
long long NumGlobalDiagonals64 () const
 
int NumGlobalBlockEntries (int Row) const
 Returns the current number of nonzero Block entries in specified global row on this processor.
 
int NumAllocatedGlobalBlockEntries (int Row) const
 Returns the allocated number of nonzero Block entries in specified global row on this processor.
 
int MaxNumBlockEntries () const
 Returns the maximum number of nonzero entries across all rows on this processor.
 
int GlobalMaxNumBlockEntries () const
 Returns the maximum number of nonzero entries across all rows on this processor.
 
int NumMyBlockEntries (int Row) const
 Returns the current number of nonzero Block entries in specified local row on this processor.
 
int NumAllocatedMyBlockEntries (int Row) const
 Returns the allocated number of nonzero Block entries in specified local row on this processor.
 
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.
 
const Epetra_ImportImporter () const
 Returns the Epetra_Import object that contains the import operations for distributed operations.
 
const Epetra_ExportExporter () const
 Returns the Epetra_Export object that contains the export operations for distributed operations.
 
const Epetra_BlockMapDomainMap () const
 Returns the Epetra_BlockMap object associated with the domain of this matrix operator.
 
const Epetra_BlockMapRangeMap () const
 Returns the Epetra_BlockMap object associated with the range of this matrix operator.
 
const Epetra_BlockMapRowMap () const
 Returns the RowMap object as an Epetra_BlockMap (the Epetra_Map base class) needed for implementing Epetra_RowMatrix.
 
const Epetra_BlockMapColMap () const
 Returns the ColMap as an Epetra_BlockMap (the Epetra_Map base class) needed for implementing Epetra_RowMatrix.
 
const Epetra_CommComm () const
 Fills a matrix with rows from a source matrix based on the specified importer. More...
 
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.
 
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.
 
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.
 
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.
 
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.
 
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.
 
bool MyGCID (int GCID_in) const
 Returns true if the GCID passed in belongs to the calling processor in this map, otherwise returns false.
 
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.
 
bool MyGlobalBlockRow (int GID) const
 Returns true of GID is owned by the calling processor, otherwise it returns false.
 
bool MyGlobalBlockRow (long long GID) const
 
virtual void Print (std::ostream &os) const
 Print method.
 
const char * Label () const
 Returns a character string describing the operator.
 
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.
 
bool UseTranspose () const
 Returns the current UseTranspose setting.
 
const Epetra_MapOperatorDomainMap () const
 Returns the Epetra_Map object associated with the domain of this matrix operator.
 
const Epetra_MapOperatorRangeMap () const
 Returns the Epetra_Map object associated with the range of this matrix operator.
 
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.
 
const Epetra_BlockMapMap () const
 Map() method inherited from Epetra_DistObject.
 
const Epetra_MapRowMatrixRowMap () const
 Returns the EpetraMap object associated with the rows of this matrix.
 
const Epetra_MapRowMatrixColMap () const
 Returns the Epetra_Map object associated with columns of this matrix.
 
const Epetra_ImportRowMatrixImporter () const
 Returns the Epetra_Import object that contains the import operations for distributed operations.
 
const Epetra_BlockMapBlockImportMap () const
 Use BlockColMap() instead.
 
int TransformToLocal ()
 Use FillComplete() instead.
 
int TransformToLocal (const Epetra_BlockMap *DomainMap, const Epetra_BlockMap *RangeMap)
 Use FillComplete(const Epetra_BlockMap& DomainMap, const Epetra_BlockMap& RangeMap) instead.
 
- 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.
 
virtual ~Epetra_DistObject ()
 Epetra_DistObject destructor.
 
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.
 
bool DistributedGlobal () const
 Returns true if this multi-vector is distributed global, i.e., not local replicated.
 
- 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 int ReportError (const std::string Message, int ErrorCode) const
 Error reporting method.
 
virtual void SetLabel (const char *const Label)
 Epetra_Object Label definition using char *. More...
 
- Public Member Functions inherited from Epetra_SrcDistObject
virtual ~Epetra_SrcDistObject ()
 Epetra_SrcDistObject destructor.
 
- Public Member Functions inherited from Epetra_CompObject
Epetra_CompObjectoperator= (const Epetra_CompObject &src)
 
 Epetra_CompObject ()
 Basic Epetra_CompObject constuctor.
 
 Epetra_CompObject (const Epetra_CompObject &Source)
 Epetra_CompObject copy constructor.
 
virtual ~Epetra_CompObject ()
 Epetra_CompObject destructor.
 
void SetFlopCounter (const Epetra_Flops &FlopCounter_in)
 Set the internal Epetra_Flops() pointer.
 
void SetFlopCounter (const Epetra_CompObject &CompObject)
 Set the internal Epetra_Flops() pointer to the flop counter of another Epetra_CompObject.
 
void UnsetFlopCounter ()
 Set the internal Epetra_Flops() pointer to 0 (no flops counted).
 
Epetra_FlopsGetFlopCounter () const
 Get the pointer to the Epetra_Flops() object associated with this object, returns 0 if none.
 
void ResetFlops () const
 Resets the number of floating point operations to zero for this multi-vector.
 
double Flops () const
 Returns the number of floating point operations with this multi-vector.
 
void UpdateFlops (int Flops_in) const
 Increment Flop count for this object.
 
void UpdateFlops (long int Flops_in) const
 Increment Flop count for this object.
 
void UpdateFlops (long long Flops_in) const
 Increment Flop count for this object.
 
void UpdateFlops (double Flops_in) const
 Increment Flop count for this object.
 
void UpdateFlops (float Flops_in) const
 Increment Flop count for this object.
 
- 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.
 
float ASUM (const int N, const float *X, const int INCX=1) const
 Epetra_BLAS one norm function (SASUM).
 
double ASUM (const int N, const double *X, const int INCX=1) const
 Epetra_BLAS one norm function (DASUM).
 
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).
 
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).
 
float NRM2 (const int N, const float *X, const int INCX=1) const
 Epetra_BLAS norm function (SNRM2).
 
double NRM2 (const int N, const double *X, const int INCX=1) const
 Epetra_BLAS norm function (DNRM2).
 
void SCAL (const int N, const float ALPHA, float *X, const int INCX=1) const
 Epetra_BLAS vector scale function (SSCAL)
 
void SCAL (const int N, const double ALPHA, double *X, const int INCX=1) const
 Epetra_BLAS vector scale function (DSCAL)
 
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)
 
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)
 
int IAMAX (const int N, const float *X, const int INCX=1) const
 Epetra_BLAS arg maximum of absolute value function (ISAMAX)
 
int IAMAX (const int N, const double *X, const int INCX=1) const
 Epetra_BLAS arg maximum of absolute value function (IDAMAX)
 
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)
 
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)
 
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)
 
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)
 
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)
 
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)
 
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)
 
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)
 
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)
 
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)
 
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)
 
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)
 
- Public Member Functions inherited from Epetra_RowMatrix
virtual ~Epetra_RowMatrix ()
 Destructor.
 
- Public Member Functions inherited from Epetra_Operator
virtual ~Epetra_Operator ()
 Destructor.
 

Insertion/Replace/SumInto methods

Epetra_FEVbrMatrixoperator= (const Epetra_FEVbrMatrix &src)
 
int PutScalar (double ScalarConstant)
 Initialize all values in graph of the matrix with constant value. 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 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 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 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.
 
int EndSubmitEntries ()
 Completes processing of all data passed in for the current block row. More...
 
int GlobalAssemble (bool callFillComplete=true)
 

Additional Inherited Members

- 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.
 
static std::ostream & GetTracebackStream ()
 Get the output stream for error reporting.
 
- Static Public Attributes inherited from Epetra_Object
static int TracebackMode
 
- Protected Member Functions inherited from Epetra_VbrMatrix
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.
 
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.
 
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().
 
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().
 
int SortEntries ()
 Sort column entries, row-by-row, in ascending order.
 
bool Sorted () const
 If SortEntries() has been called, this query returns true, otherwise it returns false.
 
int MergeRedundantEntries ()
 Add entries that have the same column index. Remove redundant entries from list.
 
bool NoRedundancies () const
 If MergeRedundantEntries() has been called, this query returns true, otherwise it returns false.
 
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.
 
- 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 inherited from Epetra_VbrMatrix
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_
 

Detailed Description

Epetra Finite-Element VbrMatrix. This class provides the ability to input finite-element style sub-matrix data, including sub-matrices with non-local rows (which could correspond to shared finite-element nodes for example). This class inherits Epetra_VbrMatrix, and so all Epetra_VbrMatrix functionality is also available.

Constructor & Destructor Documentation

Epetra_FEVbrMatrix::Epetra_FEVbrMatrix ( Epetra_DataAccess  CV,
const Epetra_BlockMap RowMap,
int *  NumBlockEntriesPerRow,
bool  ignoreNonLocalEntries = false 
)

Epetra_FEVbrMatrix constuctor with variable number of indices per row.

Creates a Epetra_FEVbrMatrix 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.
Epetra_FEVbrMatrix::Epetra_FEVbrMatrix ( Epetra_DataAccess  CV,
const Epetra_BlockMap RowMap,
int  NumBlockEntriesPerRow,
bool  ignoreNonLocalEntries = false 
)

Epetra_FEVbrMatrix constuctor with fixed number of indices per row.

Creates a Epetra_FEVbrMatrix 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.
Epetra_FEVbrMatrix::Epetra_FEVbrMatrix ( Epetra_DataAccess  CV,
const Epetra_BlockMap RowMap,
const Epetra_BlockMap ColMap,
int *  NumBlockEntriesPerRow,
bool  ignoreNonLocalEntries = false 
)

Epetra_FEVbrMatrix constuctor with variable number of indices per row.

Creates a Epetra_FEVbrMatrix 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 listing the block columns to be contained on this processor.
InNumBlockEntriesPerRow - An integer array of length NumRows such that NumBlockEntriesPerRow[i] indicates the (approximate) number of Block entries in the ith row.
Epetra_FEVbrMatrix::Epetra_FEVbrMatrix ( Epetra_DataAccess  CV,
const Epetra_BlockMap RowMap,
const Epetra_BlockMap ColMap,
int  NumBlockEntriesPerRow,
bool  ignoreNonLocalEntries = false 
)

Epetra_FEVbrMatrix constuctor with fixed number of indices per row.

Creates a Epetra_FEVbrMatrix 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.
InColMap - An Epetra_BlockMap listing the block columns to be contained on this processor.
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.
Epetra_FEVbrMatrix::Epetra_FEVbrMatrix ( Epetra_DataAccess  CV,
const Epetra_CrsGraph Graph,
bool  ignoreNonLocalEntries = false 
)

Constructor with pre-constructed Graph.

Epetra_FEVbrMatrix::Epetra_FEVbrMatrix ( const Epetra_FEVbrMatrix src)

Copy Constructor.

Member Function Documentation

int Epetra_FEVbrMatrix::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.
int Epetra_FEVbrMatrix::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.
int Epetra_FEVbrMatrix::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.
int Epetra_FEVbrMatrix::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.

int Epetra_FEVbrMatrix::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.

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