Ifpack Package Browser (Single Doxygen Collection)
Development
|
Ifpack_SerialTriDiMatrix: A class for constructing and using real double precision general TriDi matrices. More...
#include <Ifpack_SerialTriDiMatrix.h>
Protected Member Functions | |
void | CopyMat (const double *Source, int NumRowCol, double *Target, int NRC2, bool add=false) |
void | CleanupData () |
Protected Attributes | |
int | N_ |
int | LDA_ |
bool | A_Copied_ |
Epetra_DataAccess | CV_ |
double * | A_ |
double * | DL_ |
double * | D_ |
double * | DU_ |
double * | DU2_ |
bool | UseTranspose_ |
Friends | |
class | Epetra_VbrMatrix |
Constructor/Destructor Methods | |
Ifpack_SerialTriDiMatrix (bool set_object_label=true) | |
Default constructor; defines a zero size object. More... | |
Ifpack_SerialTriDiMatrix (int NumRowCol, bool set_object_label=true) | |
Shaped constructor; defines a variable-sized object. More... | |
Ifpack_SerialTriDiMatrix (Epetra_DataAccess CV, double *A_in, int NumRowCol, bool set_object_label=true) | |
Set object values from two-dimensional array. More... | |
Ifpack_SerialTriDiMatrix (const Ifpack_SerialTriDiMatrix &Source) | |
Ifpack_SerialTriDiMatrix copy constructor. More... | |
virtual | ~Ifpack_SerialTriDiMatrix () |
Ifpack_SerialTriDiMatrix destructor. More... | |
Shaping/sizing Methods | |
int | Shape (int NumRowCol) |
Set dimensions of a Ifpack_SerialTriDiMatrix object; init values to zero. More... | |
int | Reshape (int, int) |
Mathematical methods | |
int | Multiply (char TransA, char TransB, double ScalarAB, const Ifpack_SerialTriDiMatrix &A, const Ifpack_SerialTriDiMatrix &B, double ScalarThis) |
Matrix-Matrix multiplication, this = ScalarThis*this + ScalarAB*A*B. More... | |
int | Scale (double ScalarA) |
Matrix-Vector multiplication, y = A*x, where 'this' == A. More... | |
virtual double | NormOne () const |
Computes the 1-Norm of the this matrix. More... | |
virtual double | NormInf () const |
Computes the Infinity-Norm of the this matrix. More... | |
Data Accessor methods | |
Ifpack_SerialTriDiMatrix & | operator= (const Ifpack_SerialTriDiMatrix &Source) |
Value copy from one matrix to another. More... | |
bool | operator== (const Ifpack_SerialTriDiMatrix &rhs) const |
Comparison operator. More... | |
bool | operator!= (const Ifpack_SerialTriDiMatrix &rhs) const |
Inequality operator. More... | |
Ifpack_SerialTriDiMatrix & | operator+= (const Ifpack_SerialTriDiMatrix &Source) |
Add one matrix to another. More... | |
double & | operator() (int RowIndex, int ColIndex) |
Element access function. More... | |
const double & | operator() (int RowIndex, int ColIndex) const |
Element access function. More... | |
int | Random () |
Column access function. More... | |
int | N () const |
Returns column dimension of system. More... | |
int | LDA () const |
double * | A () const |
Returns pointer to the this matrix. More... | |
double * | DL () |
Returns pointer to the this matrix. More... | |
double * | DL () const |
double * | D () |
double * | D () const |
double * | DU () |
double * | DU () const |
double * | DU2 () |
double * | DU2 () const |
Epetra_DataAccess | CV () const |
Returns the data access mode of the this matrix. More... | |
I/O methods | |
virtual void | Print (std::ostream &os) const |
Print service methods; defines behavior of ostream << operator. More... | |
Deprecated methods (will be removed in later versions of this class) | |
virtual double | OneNorm () const |
Computes the 1-Norm of the this matrix (identical to NormOne() method). More... | |
virtual double | InfNorm () const |
Computes the Infinity-Norm of the this matrix (identical to NormInf() method). More... | |
Additional methods to support Ifpack_SerialTriDiOperator interface | |
virtual int | SetUseTranspose (bool UseTranspose_in) |
If set true, transpose of this operator will be applied. More... | |
virtual int | ApplyInverse (const Ifpack_SerialTriDiMatrix &X, Ifpack_SerialTriDiMatrix &Y) |
Returns the result of a Ifpack_SerialTriDiOperator inverse applied to an Ifpack_SerialTriDiMatrix X in Y. More... | |
virtual const char * | Label () const |
Returns a character string describing the operator. More... | |
virtual bool | UseTranspose () const |
Returns the current UseTranspose setting. More... | |
virtual bool | HasNormInf () const |
Returns true if the this object can provide an approximate Inf-norm, false otherwise. More... | |
virtual int | RowColDim () const |
Returns the column dimension of operator. More... | |
Additional Inherited Members | |
Public Member Functions inherited from Epetra_BLAS | |
Epetra_BLAS (void) | |
Epetra_BLAS (const Epetra_BLAS &BLAS) | |
virtual | ~Epetra_BLAS (void) |
float | ASUM (const int N, const float *X, const int INCX=1) const |
double | ASUM (const int N, const double *X, const int INCX=1) const |
float | DOT (const int N, const float *X, const float *Y, const int INCX=1, const int INCY=1) const |
double | DOT (const int N, const double *X, const double *Y, const int INCX=1, const int INCY=1) const |
float | NRM2 (const int N, const float *X, const int INCX=1) const |
double | NRM2 (const int N, const double *X, const int INCX=1) const |
void | SCAL (const int N, const float ALPHA, float *X, const int INCX=1) const |
void | SCAL (const int N, const double ALPHA, double *X, const int INCX=1) const |
void | COPY (const int N, const float *X, float *Y, const int INCX=1, const int INCY=1) const |
void | COPY (const int N, const double *X, double *Y, const int INCX=1, const int INCY=1) const |
int | IAMAX (const int N, const float *X, const int INCX=1) const |
int | IAMAX (const int N, const double *X, const int INCX=1) const |
void | AXPY (const int N, const float ALPHA, const float *X, float *Y, const int INCX=1, const int INCY=1) const |
void | AXPY (const int N, const double ALPHA, const double *X, double *Y, const int INCX=1, const int INCY=1) const |
void | GEMV (const char TRANS, const int M, const int N, const float ALPHA, const float *A, const int LDA, const float *X, const float BETA, float *Y, const int INCX=1, const int INCY=1) const |
void | GEMV (const char TRANS, const int M, const int N, const double ALPHA, const double *A, const int LDA, const double *X, const double BETA, double *Y, const int INCX=1, const int INCY=1) const |
void | GEMM (const char TRANSA, const char TRANSB, const int M, const int N, const int K, const float ALPHA, const float *A, const int LDA, const float *B, const int LDB, const float BETA, float *C, const int LDC) const |
void | GEMM (const char TRANSA, const char TRANSB, const int M, const int N, const int K, const double ALPHA, const double *A, const int LDA, const double *B, const int LDB, const double BETA, double *C, const int LDC) const |
void | SYMM (const char SIDE, const char UPLO, const int M, const int N, const float ALPHA, const float *A, const int LDA, const float *B, const int LDB, const float BETA, float *C, const int LDC) const |
void | SYMM (const char SIDE, const char UPLO, const int M, const int N, const double ALPHA, const double *A, const int LDA, const double *B, const int LDB, const double BETA, double *C, const int LDC) const |
void | TRMM (const char SIDE, const char UPLO, const char TRANSA, const char DIAG, const int M, const int N, const float ALPHA, const float *A, const int LDA, float *B, const int LDB) const |
void | TRMM (const char SIDE, const char UPLO, const char TRANSA, const char DIAG, const int M, const int N, const double ALPHA, const double *A, const int LDA, double *B, const int LDB) const |
void | SYRK (const char UPLO, const char TRANS, const int N, const int K, const float ALPHA, const float *A, const int LDA, const float BETA, float *C, const int LDC) const |
void | SYRK (const char UPLO, const char TRANS, const int N, const int K, const double ALPHA, const double *A, const int LDA, const double BETA, double *C, const int LDC) const |
Epetra_BLAS (void) | |
Epetra_BLAS (const Epetra_BLAS &BLAS) | |
virtual | ~Epetra_BLAS (void) |
float | ASUM (const int N, const float *X, const int INCX=1) const |
double | ASUM (const int N, const double *X, const int INCX=1) const |
float | DOT (const int N, const float *X, const float *Y, const int INCX=1, const int INCY=1) const |
double | DOT (const int N, const double *X, const double *Y, const int INCX=1, const int INCY=1) const |
float | NRM2 (const int N, const float *X, const int INCX=1) const |
double | NRM2 (const int N, const double *X, const int INCX=1) const |
void | SCAL (const int N, const float ALPHA, float *X, const int INCX=1) const |
void | SCAL (const int N, const double ALPHA, double *X, const int INCX=1) const |
void | COPY (const int N, const float *X, float *Y, const int INCX=1, const int INCY=1) const |
void | COPY (const int N, const double *X, double *Y, const int INCX=1, const int INCY=1) const |
int | IAMAX (const int N, const float *X, const int INCX=1) const |
int | IAMAX (const int N, const double *X, const int INCX=1) const |
void | AXPY (const int N, const float ALPHA, const float *X, float *Y, const int INCX=1, const int INCY=1) const |
void | AXPY (const int N, const double ALPHA, const double *X, double *Y, const int INCX=1, const int INCY=1) const |
void | GEMV (const char TRANS, const int M, const int N, const float ALPHA, const float *A, const int LDA, const float *X, const float BETA, float *Y, const int INCX=1, const int INCY=1) const |
void | GEMV (const char TRANS, const int M, const int N, const double ALPHA, const double *A, const int LDA, const double *X, const double BETA, double *Y, const int INCX=1, const int INCY=1) const |
void | GEMM (const char TRANSA, const char TRANSB, const int M, const int N, const int K, const float ALPHA, const float *A, const int LDA, const float *B, const int LDB, const float BETA, float *C, const int LDC) const |
void | GEMM (const char TRANSA, const char TRANSB, const int M, const int N, const int K, const double ALPHA, const double *A, const int LDA, const double *B, const int LDB, const double BETA, double *C, const int LDC) const |
void | SYMM (const char SIDE, const char UPLO, const int M, const int N, const float ALPHA, const float *A, const int LDA, const float *B, const int LDB, const float BETA, float *C, const int LDC) const |
void | SYMM (const char SIDE, const char UPLO, const int M, const int N, const double ALPHA, const double *A, const int LDA, const double *B, const int LDB, const double BETA, double *C, const int LDC) const |
void | TRMM (const char SIDE, const char UPLO, const char TRANSA, const char DIAG, const int M, const int N, const float ALPHA, const float *A, const int LDA, float *B, const int LDB) const |
void | TRMM (const char SIDE, const char UPLO, const char TRANSA, const char DIAG, const int M, const int N, const double ALPHA, const double *A, const int LDA, double *B, const int LDB) const |
void | SYRK (const char UPLO, const char TRANS, const int N, const int K, const float ALPHA, const float *A, const int LDA, const float BETA, float *C, const int LDC) const |
void | SYRK (const char UPLO, const char TRANS, const int N, const int K, const double ALPHA, const double *A, const int LDA, const double BETA, double *C, const int LDC) const |
Ifpack_SerialTriDiMatrix: A class for constructing and using real double precision general TriDi matrices.
The Ifpack_SerialTriDiMatrix class enables the construction and use of real-valued, general, double-precision TriDi matrices. It is built on the BLAS, and derives from the Epetra_BLAS.
The Ifpack_SerialTriDiMatrix class is intended to provide very basic support for TriDiagonal matrices.
Constructing Ifpack_SerialTriDiMatrix Objects
There are four Ifpack_SerialTriDiMatrix constructors. The first constructs a zero-sized object which should be made to appropriate length using the Shape() or Reshape() functions and then filled with the [] or () operators. The second constructs an object sized to the dimensions specified, which should be filled with the [] or () operators. The third is a constructor that accepts user data as a 2D array, and the fourth is a copy constructor. The third constructor has two data access modes (specified by the Epetra_DataAccess argument):
Extracting Data from Ifpack_SerialTriDiMatrix Objects
Once a Ifpack_SerialTriDiMatrix is constructed, it is possible to view the data via access functions.
Vector and Utility Functions
Once a Ifpack_SerialTriDiMatrix is constructed, several mathematical functions can be applied to the object. Specifically:
Counting floating point operations The Ifpack_SerialTriDiMatrix class has Epetra_CompObject as a base class. Thus, floating point operations are counted and accumulated in the Epetra_Flop object (if any) that was set using the SetFlopCounter() method in the Epetra_CompObject base class.
Definition at line 106 of file Ifpack_SerialTriDiMatrix.h.
Default constructor; defines a zero size object.
Ifpack_SerialTriDiMatrix objects defined by the default constructor should be sized with the Shape() or Reshape functions. Values should be defined by using the () operators.
Definition at line 47 of file Ifpack_SerialTriDiMatrix.cpp.
Shaped constructor; defines a variable-sized object.
In | NumRowCol - Number of rows and columns in object. |
Ifpack_SerialTriDiMatrix objects defined by the shaped constructor are already shaped to the dimensions given as a parameters. All values are initialized to 0. Calling this constructor is equivalent to using the default constructor, and then calling the Shape function on it. Values should be defined by using the [] or () operators.
Definition at line 62 of file Ifpack_SerialTriDiMatrix.cpp.
Ifpack_SerialTriDiMatrix::Ifpack_SerialTriDiMatrix | ( | Epetra_DataAccess | CV, |
double * | A_in, | ||
int | NumRowCol, | ||
bool | set_object_label = true |
||
) |
Set object values from two-dimensional array.
In | Epetra_DataAccess - Enumerated type set to Copy or View. |
In | A - Pointer to an array of double precision numbers. The |
In | NumRows - Number of rows and columns in object. |
See Detailed Description section for further discussion.
Definition at line 84 of file Ifpack_SerialTriDiMatrix.cpp.
Ifpack_SerialTriDiMatrix::Ifpack_SerialTriDiMatrix | ( | const Ifpack_SerialTriDiMatrix & | Source | ) |
Ifpack_SerialTriDiMatrix copy constructor.
Definition at line 120 of file Ifpack_SerialTriDiMatrix.cpp.
|
virtual |
Ifpack_SerialTriDiMatrix destructor.
Definition at line 202 of file Ifpack_SerialTriDiMatrix.cpp.
int Ifpack_SerialTriDiMatrix::Shape | ( | int | NumRowCol | ) |
Set dimensions of a Ifpack_SerialTriDiMatrix object; init values to zero.
In | NumRowCol - Number of rows and columns in object. |
Allows user to define the dimensions of a Ifpack_SerialTriDiMatrix at any point. This function can be called at any point after construction. Any values that were previously in this object are destroyed and the resized matrix starts off with all zero values.
Definition at line 179 of file Ifpack_SerialTriDiMatrix.cpp.
int Ifpack_SerialTriDiMatrix::Reshape | ( | int | NumRows, |
int | NumCols | ||
) |
Definition at line 147 of file Ifpack_SerialTriDiMatrix.cpp.
int Ifpack_SerialTriDiMatrix::Multiply | ( | char | TransA, |
char | TransB, | ||
double | ScalarAB, | ||
const Ifpack_SerialTriDiMatrix & | A, | ||
const Ifpack_SerialTriDiMatrix & | B, | ||
double | ScalarThis | ||
) |
Matrix-Matrix multiplication, this = ScalarThis*this + ScalarAB*A*B.
This function performs a variety of matrix-matrix multiply operations.
In | TransA - Operate with the transpose of A if = 'T', else no transpose if = 'N'. |
In | TransB - Operate with the transpose of B if = 'T', else no transpose if = 'N'. |
In | ScalarAB - Scalar to multiply with A*B. |
In | A - TriDi Matrix. |
In | B - TriDi Matrix. |
In | ScalarThis - Scalar to multiply with this. |
Definition at line 380 of file Ifpack_SerialTriDiMatrix.cpp.
int Ifpack_SerialTriDiMatrix::Scale | ( | double | ScalarA | ) |
Matrix-Vector multiplication, y = A*x, where 'this' == A.
Matrix-Matrix multiplication with a symmetric matrix A.
If SideA = 'L', compute \e this = ScalarThis*\e this + ScalarAB*A*B. If SideA = 'R', compute \e this = ScalarThis*\e this + ScalarAB*B*A.
This function performs a variety of matrix-matrix multiply operations.
In | SideA - Specifies order of A relative to B. |
In | ScalarAB - Scalar to multiply with A*B. |
In | A - Symmetric TriDi Matrix, either upper or lower triangle will be used depending on value of A.Upper(). |
In | B - TriDi Matrix. |
In | ScalarThis - Scalar to multiply with this. |
ScalarA | (In) Scalar to multiply with A. |
Definition at line 364 of file Ifpack_SerialTriDiMatrix.cpp.
|
virtual |
Computes the 1-Norm of the this matrix.
Definition at line 344 of file Ifpack_SerialTriDiMatrix.cpp.
|
virtual |
Computes the Infinity-Norm of the this matrix.
Definition at line 359 of file Ifpack_SerialTriDiMatrix.cpp.
Ifpack_SerialTriDiMatrix & Ifpack_SerialTriDiMatrix::operator= | ( | const Ifpack_SerialTriDiMatrix & | Source | ) |
Value copy from one matrix to another.
The operator= allows one to copy the values from one existing SerialTriDiMatrix to another, as long as there is enough room in the target to hold the source.
Definition at line 218 of file Ifpack_SerialTriDiMatrix.cpp.
bool Ifpack_SerialTriDiMatrix::operator== | ( | const Ifpack_SerialTriDiMatrix & | rhs | ) | const |
Comparison operator.
operator== compares two Ifpack_SerialTriDiMatrix objects, returns false if sizes are different, or if any coefficients differ by an amount greater than Epetra_MinDouble.
Definition at line 285 of file Ifpack_SerialTriDiMatrix.cpp.
|
inline |
Inequality operator.
operator!= simply returns the negation of operator==.
Definition at line 272 of file Ifpack_SerialTriDiMatrix.h.
Ifpack_SerialTriDiMatrix & Ifpack_SerialTriDiMatrix::operator+= | ( | const Ifpack_SerialTriDiMatrix & | Source | ) |
Add one matrix to another.
The operator+= allows one to add the values from one existin SerialTriDiMatrix to another, as long as there is enough room in the target to hold the source.
Definition at line 304 of file Ifpack_SerialTriDiMatrix.cpp.
|
inline |
Element access function.
The parentheses operator returns the element in the ith row and jth column if A(i,j) is specified,
\warning No bounds checking is done unless Epetra is compiled with HAVE_EPETRA_ARRAY_BOUNDS_CHECK.
Definition at line 460 of file Ifpack_SerialTriDiMatrix.h.
|
inline |
Element access function.
The parentheses operator returns the element in the ith row and jth column if A(i,j) is specified, the expression A[j][i] (note that i and j are reversed) will return the same element. Thus, A(i,j) = A[j][i] for all valid i and j.
\warning No bounds checking is done unless Epetra is compiled with HAVE_EPETRA_ARRAY_BOUNDS_CHECK.
Definition at line 496 of file Ifpack_SerialTriDiMatrix.h.
int Ifpack_SerialTriDiMatrix::Random | ( | ) |
Column access function.
The parentheses operator returns the element in the ith row and jth column if A(i,j) is specified, the expression A[j][i] (note that i and j are reversed) will return the same element. Thus, A(i,j) = A[j][i] for all valid i and j.
The parentheses operator returns the element in the ith row and jth column if A(i,j) is specified, the expression A[j][i] (note that i and j are reversed) will return the same element. Thus, A(i,j) = A[j][i] for all valid i and j.
SerialTriDiMatrix uses the random number generator provided by Epetra_Util. The matrix values will be set to random values on the interval (-1.0, 1.0).
Definition at line 390 of file Ifpack_SerialTriDiMatrix.cpp.
|
inline |
Returns column dimension of system.
Definition at line 344 of file Ifpack_SerialTriDiMatrix.h.
|
inline |
Definition at line 346 of file Ifpack_SerialTriDiMatrix.h.
|
inline |
Returns pointer to the this matrix.
Definition at line 349 of file Ifpack_SerialTriDiMatrix.h.
|
inline |
Returns pointer to the this matrix.
Definition at line 354 of file Ifpack_SerialTriDiMatrix.h.
|
inline |
Definition at line 355 of file Ifpack_SerialTriDiMatrix.h.
|
inline |
Definition at line 356 of file Ifpack_SerialTriDiMatrix.h.
|
inline |
Definition at line 357 of file Ifpack_SerialTriDiMatrix.h.
|
inline |
Definition at line 358 of file Ifpack_SerialTriDiMatrix.h.
|
inline |
Definition at line 359 of file Ifpack_SerialTriDiMatrix.h.
|
inline |
Definition at line 360 of file Ifpack_SerialTriDiMatrix.h.
|
inline |
Definition at line 361 of file Ifpack_SerialTriDiMatrix.h.
|
inline |
Returns the data access mode of the this matrix.
Definition at line 364 of file Ifpack_SerialTriDiMatrix.h.
|
virtual |
Print service methods; defines behavior of ostream << operator.
Definition at line 402 of file Ifpack_SerialTriDiMatrix.cpp.
|
inlinevirtual |
Computes the 1-Norm of the this matrix (identical to NormOne() method).
Definition at line 380 of file Ifpack_SerialTriDiMatrix.h.
|
inlinevirtual |
Computes the Infinity-Norm of the this matrix (identical to NormInf() method).
Definition at line 383 of file Ifpack_SerialTriDiMatrix.h.
|
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.
In | UseTranspose -If true, multiply by the transpose of operator, otherwise just use operator. |
Definition at line 399 of file Ifpack_SerialTriDiMatrix.h.
|
inlinevirtual |
Returns the result of a Ifpack_SerialTriDiOperator inverse applied to an Ifpack_SerialTriDiMatrix X in Y.
In | X - A Ifpack_SerialTriDiMatrix to solve for. |
Out | Y -A Ifpack_SerialTriDiMatrix containing result. |
Definition at line 411 of file Ifpack_SerialTriDiMatrix.h.
|
inlinevirtual |
Returns a character string describing the operator.
Definition at line 419 of file Ifpack_SerialTriDiMatrix.h.
|
inlinevirtual |
Returns the current UseTranspose setting.
Definition at line 422 of file Ifpack_SerialTriDiMatrix.h.
|
inlinevirtual |
Returns true if the this object can provide an approximate Inf-norm, false otherwise.
Definition at line 425 of file Ifpack_SerialTriDiMatrix.h.
|
inlinevirtual |
Returns the column dimension of operator.
Definition at line 428 of file Ifpack_SerialTriDiMatrix.h.
|
protected |
Definition at line 313 of file Ifpack_SerialTriDiMatrix.cpp.
|
protected |
Definition at line 209 of file Ifpack_SerialTriDiMatrix.cpp.
|
friend |
Definition at line 447 of file Ifpack_SerialTriDiMatrix.h.
|
protected |
Definition at line 437 of file Ifpack_SerialTriDiMatrix.h.
|
protected |
Definition at line 438 of file Ifpack_SerialTriDiMatrix.h.
|
protected |
Definition at line 439 of file Ifpack_SerialTriDiMatrix.h.
|
protected |
Definition at line 440 of file Ifpack_SerialTriDiMatrix.h.
|
protected |
Definition at line 449 of file Ifpack_SerialTriDiMatrix.h.
|
protected |
Definition at line 450 of file Ifpack_SerialTriDiMatrix.h.
|
protected |
Definition at line 451 of file Ifpack_SerialTriDiMatrix.h.
|
protected |
Definition at line 452 of file Ifpack_SerialTriDiMatrix.h.
|
protected |
Definition at line 453 of file Ifpack_SerialTriDiMatrix.h.
|
protected |
Definition at line 455 of file Ifpack_SerialTriDiMatrix.h.