PIPS-NLP
|
#include <PetscSpGenMatrix.h>
Public Member Functions | |
PetscSparseStorage * | getStorage () |
PetscSparseStorage & | storage () |
PetscSpGenMatrix (int m, int n, int nnz) | |
PetscSpGenMatrix (Mat M) | |
virtual int | isKindOf (int type) |
virtual void | atPutDense (int row, int col, double *A, int lda, int rowExtent, int colExtent) |
virtual void | fromGetDense (int row, int col, double *A, int lda, int rowExtent, int colExtent) |
virtual void | fromGetSpRow (int row, int col, double A[], int lenA, int jcolA[], int &nnz, int colExtent, int &info) |
virtual void | atPutSpRow (int row, double A[], int lenA, int jcolA[], int &info) |
virtual void | getSize (int &m, int &n) |
virtual void | atPutSubmatrix (int destRow, int destCol, DoubleMatrix &M, int srcRow, int srcCol, int rowExtent, int colExtent) |
virtual void | mult (double beta, OoqpVector &y, double alpha, OoqpVector &x) |
virtual void | transMult (double beta, OoqpVector &y, double alpha, OoqpVector &x) |
virtual void | getDiagonal (OoqpVector &vec) |
virtual void | setToDiagonal (OoqpVector &vec) |
virtual void | atPutDiagonal (int idiag, OoqpVector &v) |
virtual void | fromGetDiagonal (int idiag, OoqpVector &v) |
virtual double | abmaxnorm () |
virtual void | writeToStream (ostream &out) const |
virtual void | randomize (double alpha, double beta, double *seed) |
virtual void | putSparseTriple (int irow[], int len, int jcol[], double A[], int &info) |
virtual void | SymmetricScale (OoqpVector &vec) |
virtual void | ColumnScale (OoqpVector &vec) |
virtual void | RowScale (OoqpVector &vec) |
virtual void | scalarMult (double num) |
virtual | ~PetscSpGenMatrix () |
virtual void | copyMtxFromDouble (int copyLength, double *values) |
![]() | |
virtual void | matTransDMultMat (OoqpVector &d, SymMatrix **res)=0 |
virtual void | matTransDinvMultMat (OoqpVector &d, SymMatrix **res)=0 |
![]() | |
DoubleMatrix () | |
virtual void | fromAddDense (int row, int col, double *A, int lda, int rowExtent, int colExtent) |
virtual void | writeToStream (std::ostream &out) const =0 |
virtual void | getSize (long long &m, long long &n)=0 |
virtual | ~DoubleMatrix () |
virtual void | setAdditiveDiagonal (OoqpVector &additiveDiag_) |
virtual void | copyDiagonalVal_From (int idiag, OoqpVector &x, bool firstCall, std::map< int, int > &ValIdxMap) |
virtual void | fromGetSpRow_WithRowStart (int row, int col, double A[], int lenA, int jcolA[], int &nnz, int colExtent, int &info, int &rowStart) |
virtual void | fromGetDense_withMap (int row, int col, double *A, int lda, int rowExtent, int colExtent, int const FirstCall, std::map< int, int > &ValIdxMap) |
virtual double * | getMatVal () |
virtual int * | krowM () |
virtual int * | jcolM () |
virtual double * | M () |
![]() | |
int | refs () |
IotrRefCount () | |
Protected Attributes | |
PetscSparseStorageHandle | mStorage |
Additional Inherited Members | |
![]() | |
static void | release (IotrRefCount **obj) |
static void | addRef (IotrRefCount *const *obj) |
![]() | |
static int | instances = 0 |
![]() | |
virtual | ~IotrRefCount () |
PetscSpGenMatrix::PetscSpGenMatrix | ( | int | m, |
int | n, | ||
int | nnz | ||
) |
PetscSpGenMatrix::PetscSpGenMatrix | ( | Mat | M | ) |
|
inlinevirtual |
|
virtual |
the magnitude of the element in this matrix with largest absolute value.
Implements DoubleMatrix.
|
virtual |
Set the value of some of the elements of this matrix.
Implements GenMatrix.
|
virtual |
Set some of the diagonal elements of this matrix.
idiag | the index of the first diagonal element to be modified. |
x | the new values for the diagonal elements. |
The length of x is the number of diagonal elements to be modified. Typically x will have length less than the length of the diagonal.
Implements DoubleMatrix.
|
virtual |
Put a sparse row into this matrix.
The meaning of the parmameters is the same as in fromGetSpRow.
Implements GenMatrix.
|
virtual |
Put a submatrix of M into this matrix.
destRow | The top row of the submatrix of M is placed at destRow. |
destCol | The leftmost column of the submatrix of M is placed at destCol. |
srcRow | The first row of the submatrix of M is srcRow. |
srcCol | The first column of the submatrix of M is srcCol. |
rowExtent | rowExtent rows are copied from M. |
colExtent | colExtent columns are copied from M. |
Implements GenMatrix.
|
virtual |
Implements DoubleMatrix.
|
virtual |
Reimplemented from DoubleMatrix.
|
virtual |
Get the value of some of the elements of this matrix.
row | start reading the elements of this matrix from row number "row". |
col | start reading the elements of this matrix from column number "col". |
A | Any array to hold the values from this matrix. |
ldA | the leading dimension of A. |
rowExtent | get rowExtent rows from this matrix. |
colExtent | get colExtent columns from this matrix. |
Implements DoubleMatrix.
|
virtual |
Get some of the diagonal elements of this matrix.
idiag | the index of the first diagonal element to be read. |
x | a vector to hold the diagonal elements |
The length of x is the number of diagonal elements to be gotten. Typically x will have length less than the length of the diagonal.
Implements DoubleMatrix.
|
virtual |
Get one sparse row from this matrix.
row | get row number "row" |
col | ignore all elements of the row before column "col" |
A | store the values of the sparse row in A |
lenA | the length of A |
jcolA | an array of length lenA containing the column index of each element in the sparse row |
colExtent | ignore all elements of the row that have column indices greater than or equal to col + colExtent |
info | info is 0 if and only if the sparse row can fit into A. |
Implements DoubleMatrix.
|
virtual |
Place the diagonal elements of this matrix in the vector vec
Implements DoubleMatrix.
|
virtual |
Implements DoubleMatrix.
|
inline |
|
virtual |
True if this matrix identifies itself to be of type matrixType.
Implements DoubleMatrix.
|
virtual |
y = beta * y + alpha * this * x
Implements DoubleMatrix.
|
virtual |
Copy elements from sparse triple format into this matrix
len | the number of elements |
irow | an array containing the row number of the elements |
jcol | an array containing the column number of the elements |
A | an array containing the values for the elements. |
info | on return, info will be zero if and only if the insertion was successful. |
Implements DoubleMatrix.
|
virtual |
Fill this matrix with random elements.
alpha | the elements will be no smaller than alpha. |
beta | the elements will be no larger than beta. |
seed | a arbitrary number used to seed the random number generator. |
Implements GenMatrix.
|
virtual |
Implements DoubleMatrix.
|
virtual |
Implements DoubleMatrix.
|
virtual |
Set the matrix to the diagoanl matrix whose diagonal is vec
Implements DoubleMatrix.
|
inline |
|
virtual |
Get the number of rows and columns in the matrix
m | the number of rows |
n | the number of columns |
Implements DoubleMatrix.
|
virtual |
y = beta * y + alpha * this^T * x
Implements DoubleMatrix.
|
virtual |
|
protected |