NeoPZ
|
Root matrix class (abstract). Matrix. More...
#include <pzmatrix.h>
Public Member Functions | |
TPZMatrix () | |
Simple constructor. More... | |
TPZMatrix (const TPZMatrix< TVar > &cp) | |
virtual | ~TPZMatrix () |
Simple destructor. More... | |
virtual TPZMatrix< TVar > * | Clone () const =0 |
virtual int64_t | MemoryFootprint () const |
Returns the approximate size of the memory footprint (amount of memory required to store this object). More... | |
template<class TVar2 > | |
void | CopyFrom (TPZMatrix< TVar2 > ©) |
void | AutoFill (int64_t nrow, int64_t ncol, int symmetric) |
Fill matrix storage with randomic values. More... | |
virtual int | VerifySymmetry (REAL tol=1.e-13) const |
Checks if current matrix value is symmetric. More... | |
virtual int | Put (const int64_t row, const int64_t col, const TVar &value) |
Put values with bounds checking if DEBUG variable is defined. More... | |
virtual const TVar & | Get (const int64_t row, const int64_t col) const |
Get value with bound checking. More... | |
const TVar & | g (const int64_t row, const int64_t col) const |
Substitution for the () operator when const arguments are needed. More... | |
TVar & | operator() (const int64_t row, const int64_t col) |
The operators check on the bounds if the DEBUG variable is defined. More... | |
virtual TVar & | s (const int64_t row, const int64_t col) |
The operators check on the bounds if the DEBUG variable is defined. More... | |
TVar & | operator() (const int64_t row) |
The operators check on the bounds if the DEBUG variable is defined. More... | |
virtual int | PutVal (const int64_t, const int64_t, const TVar &val) |
Put values without bounds checking This method is faster than "Put" if DEBUG is defined. More... | |
virtual const TVar & | GetVal (const int64_t, const int64_t) const |
Get values without bounds checking This method is faster than "Get" if DEBUG is defined. More... | |
virtual void | AddKel (TPZFMatrix< TVar > &elmat, TPZVec< int64_t > &destinationindex) |
Add a contribution of a stiffness matrix. More... | |
virtual void | AddKel (TPZFMatrix< TVar > &elmat, TPZVec< int64_t > &sourceindex, TPZVec< int64_t > &destinationindex) |
Add a contribution of a stiffness matrix. More... | |
void | SetIsDecomposed (int val) |
Sets current matrix to decomposed state. More... | |
virtual bool | Compare (TPZSavable *copy, bool override=false) override |
Compare the object for identity with the object pointed to, eventually copy the object. More... | |
virtual bool | Compare (TPZSavable *copy, bool override=false) const override |
Compare the object for identity with the object pointed to, eventually copy the object. More... | |
virtual void | GetSub (const TPZVec< int64_t > &indices, TPZFMatrix< TVar > &block) const |
Extract the block indicated by the indices from the matrix. More... | |
bool | CompareValues (TPZMatrix< TVar > &M, TVar tol) |
Compare values of this to B, with a precision tolerance tol. More... | |
template<> | |
void | Print (const char *name, std::ostream &out, const MatrixOutputFormat form) const |
template<> | |
void | Print (const char *name, std::ostream &out, const MatrixOutputFormat form) const |
template<> | |
void | Print (const char *name, std::ostream &out, const MatrixOutputFormat form) const |
template<> | |
void | SolveCG (int64_t &numiterations, TPZSolver< std::complex< float > > &preconditioner, const TPZFMatrix< std::complex< float > > &F, TPZFMatrix< std::complex< float > > &result, TPZFMatrix< std::complex< float > > *residual, REAL &tol, const int FromCurrent) |
template<> | |
void | SolveCG (int64_t &numiterations, TPZSolver< std::complex< double > > &preconditioner, const TPZFMatrix< std::complex< double > > &F, TPZFMatrix< std::complex< double > > &result, TPZFMatrix< std::complex< double > > *residual, REAL &tol, const int FromCurrent) |
template<> | |
void | SolveCG (int64_t &numiterations, TPZSolver< std::complex< long double > > &preconditioner, const TPZFMatrix< std::complex< long double > > &F, TPZFMatrix< std::complex< long double > > &result, TPZFMatrix< std::complex< long double > > *residual, REAL &tol, const int FromCurrent) |
template<> | |
void | SolveGMRES (int64_t &numiterations, TPZSolver< std::complex< float > > &preconditioner, TPZFMatrix< std::complex< float > > &H, int &numvectors, const TPZFMatrix< std::complex< float > > &F, TPZFMatrix< std::complex< float > > &result, TPZFMatrix< std::complex< float > > *residual, REAL &tol, const int FromCurrent) |
template<> | |
void | SolveGMRES (int64_t &numiterations, TPZSolver< std::complex< double > > &preconditioner, TPZFMatrix< std::complex< double > > &H, int &numvectors, const TPZFMatrix< std::complex< double > > &F, TPZFMatrix< std::complex< double > > &result, TPZFMatrix< std::complex< double > > *residual, REAL &tol, const int FromCurrent) |
template<> | |
void | SolveGMRES (int64_t &numiterations, TPZSolver< std::complex< long double > > &preconditioner, TPZFMatrix< std::complex< long double > > &H, int &numvectors, const TPZFMatrix< std::complex< long double > > &F, TPZFMatrix< std::complex< long double > > &result, TPZFMatrix< std::complex< long double > > *residual, REAL &tol, const int FromCurrent) |
template<> | |
void | SolveBICG (int64_t &numiterations, TPZSolver< std::complex< float > > &preconditioner, const TPZFMatrix< std::complex< float > > &F, TPZFMatrix< std::complex< float > > &result, REAL &tol) |
template<> | |
void | SolveBICG (int64_t &numiterations, TPZSolver< std::complex< double > > &preconditioner, const TPZFMatrix< std::complex< double > > &F, TPZFMatrix< std::complex< double > > &result, REAL &tol) |
template<> | |
void | SolveBICG (int64_t &numiterations, TPZSolver< std::complex< long double > > &preconditioner, const TPZFMatrix< std::complex< long double > > &F, TPZFMatrix< std::complex< long double > > &result, REAL &tol) |
template<> | |
void | SolveBICGStab (int64_t &numiterations, TPZSolver< std::complex< float > > &preconditioner, const TPZFMatrix< std::complex< float > > &F, TPZFMatrix< std::complex< float > > &result, TPZFMatrix< std::complex< float > > *residual, REAL &tol, const int FromCurrent) |
template<> | |
void | SolveBICGStab (int64_t &numiterations, TPZSolver< std::complex< double > > &preconditioner, const TPZFMatrix< std::complex< double > > &F, TPZFMatrix< std::complex< double > > &result, TPZFMatrix< std::complex< double > > *residual, REAL &tol, const int FromCurrent) |
template<> | |
void | SolveBICGStab (int64_t &numiterations, TPZSolver< std::complex< long double > > &preconditioner, const TPZFMatrix< std::complex< long double > > &F, TPZFMatrix< std::complex< long double > > &result, TPZFMatrix< std::complex< long double > > *residual, REAL &tol, const int FromCurrent) |
template<> | |
void | SolveIR (int64_t &numiterations, TPZSolver< std::complex< float > > &preconditioner, const TPZFMatrix< std::complex< float > > &F, TPZFMatrix< std::complex< float > > &result, TPZFMatrix< std::complex< float > > *residual, REAL &tol, const int FromCurrent) |
template<> | |
void | SolveIR (int64_t &numiterations, TPZSolver< std::complex< double > > &preconditioner, const TPZFMatrix< std::complex< double > > &F, TPZFMatrix< std::complex< double > > &result, TPZFMatrix< std::complex< double > > *residual, REAL &tol, const int FromCurrent) |
template<> | |
void | SolveIR (int64_t &numiterations, TPZSolver< std::complex< long double > > &preconditioner, const TPZFMatrix< std::complex< long double > > &F, TPZFMatrix< std::complex< long double > > &result, TPZFMatrix< std::complex< long double > > *residual, REAL &tol, const int FromCurrent) |
template<> | |
bool | SolveEigenvaluesJacobi (int64_t &numiterations, REAL &tol, TPZVec< std::complex< float > > *Sort) |
template<> | |
bool | SolveEigenvaluesJacobi (int64_t &numiterations, REAL &tol, TPZVec< std::complex< double > > *Sort) |
template<> | |
bool | SolveEigenvaluesJacobi (int64_t &numiterations, REAL &tol, TPZVec< std::complex< long double > > *Sort) |
Algebraic | |
Implements algebraic operations with matrices | |
virtual void | Multiply (const TPZFMatrix< TVar > &A, TPZFMatrix< TVar > &res, int opt=0) const |
It mutiplies itself by TPZMatrix<TVar>A putting the result in res. More... | |
virtual void | Add (const TPZMatrix< TVar > &A, TPZMatrix< TVar > &res) const |
It adds itself to TPZMatrix<TVar>A putting the result in res. More... | |
virtual void | MultAdd (const TPZFMatrix< TVar > &x, const TPZFMatrix< TVar > &y, TPZFMatrix< TVar > &z, const TVar alpha=1., const TVar beta=0., const int opt=0) const |
It computes z = beta * y + alpha * opt(this)*x but z and x can not overlap in memory. More... | |
virtual void | Residual (const TPZFMatrix< TVar > &x, const TPZFMatrix< TVar > &rhs, TPZFMatrix< TVar > &res) |
Computes res = rhs - this * x. More... | |
virtual void | Substract (const TPZMatrix< TVar > &A, TPZMatrix< TVar > &result) const |
It substracts A from storing the result in result. More... | |
virtual void | Identity () |
Converts the matrix in an identity matrix. More... | |
virtual void | Transpose (TPZMatrix< TVar > *const T) const |
It makes *T the transpose of current matrix. More... | |
int | Inverse (TPZFMatrix< TVar > &Inv, DecomposeType dec) |
It makes Inv =[this]. IMPORTANT OBSERVATION –> The original matrix (calling object) no is more equal. It containts the some decomposition (LU or Cholesky or ...) More... | |
TVar | MatrixNorm (int p, int64_t numiter=2000000, REAL tol=1.e-10) const |
Computes the matrix norm of this. More... | |
TVar | ConditionNumber (int p, int64_t numiter=2000000, REAL tol=1.e-10) |
Computes the matrix condition number of this. More... | |
SubMatrices | |
Operations with SUB MATRICES. | |
virtual int | PutSub (const int64_t sRow, const int64_t sCol, const TPZFMatrix< TVar > &Source) |
It puts submatrix Source on actual matrix structure. More... | |
virtual int | GetSub (const int64_t sRow, const int64_t sCol, const int64_t rowSize, const int64_t colSize, TPZFMatrix< TVar > &Target) const |
Gets submatrix storing it on Target. More... | |
virtual int | AddSub (const int64_t sRow, const int64_t sCol, const TPZFMatrix< TVar > &Source) |
It adds Source matrix on current matrix from position (sRow, sCol) More... | |
virtual int | InsertSub (const int64_t sRow, const int64_t sCol, const int64_t rowSize, const int64_t colSize, const int64_t pRow, const int64_t pCol, TPZMatrix< TVar > *Target) const |
Inserts a submatrix from current object on matrix *Target with no redimentioning. More... | |
virtual int | AddSub (const int64_t sRow, const int64_t sCol, const int64_t rowSize, const int64_t colSize, const int64_t pRow, const int64_t pCol, TPZMatrix< TVar > *pA) const |
Adds a submatrix from current object in *Target. More... | |
Inquire | |
Returns information of the current object | |
virtual void | UpdateFrom (TPZAutoPointer< TPZMatrix< TVar > >) |
Updates the values of the matrix based on the values of the matrix. More... | |
virtual int | IsSimetric () const |
Checks if the current matrix is symmetric. More... | |
int | IsSquare () const |
Checks if current matrix is square. More... | |
virtual void | Simetrize () |
Simetrizes copies upper plan to the lower plan, making its data simetric. More... | |
virtual int | IsDefPositive () const |
Checks if current matrix is definite positive. More... | |
int | IsDecomposed () const |
Checks if current matrix is already decomposed. More... | |
Factorization | |
Those member functions perform the matrix factorization | |
virtual int | Decompose_LU (std::list< int64_t > &singular) |
Decomposes the current matrix using LU decomposition. More... | |
virtual int | Decompose_LU () |
virtual int | Decompose_Cholesky () |
Decomposes the current matrix using Cholesky method. The current matrix has to be symmetric. More... | |
virtual int | Decompose_Cholesky (std::list< int64_t > &singular) |
Decomposes the current matrix using Cholesky method. More... | |
virtual int | Decompose_LDLt (std::list< int64_t > &singular) |
Decomposes the current matrix using LDLt. The current matrix has to be symmetric. "L" is lower triangular with 1.0 in its diagonal and "D" is a Diagonal matrix. More... | |
virtual int | Decompose_LDLt () |
Decomposes the current matrix using LDLt. More... | |
Substitutions | |
Substitutions forward and backward | |
virtual int | Substitution (TPZFMatrix< TVar > *B) const |
Computes Forward and Backward substitution for a "LU" decomposed matrix. More... | |
virtual int | Subst_Forward (TPZFMatrix< TVar > *b) const |
Computes B = Y, where A*Y = B, A is lower triangular. More... | |
virtual int | Subst_Backward (TPZFMatrix< TVar > *b) const |
Computes B = Y, where A*Y = B, A is upper triangular. More... | |
virtual int | Subst_LForward (TPZFMatrix< TVar > *b) const |
Computes B = Y, where A*Y = B, A is lower triangular with A(i,i)=1. More... | |
virtual int | Subst_LBackward (TPZFMatrix< TVar > *b) const |
Computes B = Y, where A*Y = B, A is upper triangular with A(i,i)=1. More... | |
virtual int | Subst_Diag (TPZFMatrix< TVar > *b) const |
Computes B = Y, where A*Y = B, A is diagonal matrix. More... | |
TPZSavable | |
Methods which would make TPZMatrix<TVar>compliant with TPZSavable | |
int | ClassId () const override |
Define the class id associated with the class. More... | |
void | Read (TPZStream &buf, void *context) override |
Unpacks the object structure from a stream of bytes. More... | |
void | Write (TPZStream &buf, int withclassid) const override |
Packs the object structure in a stream of bytes. More... | |
Public Member Functions inherited from TPZSavable | |
TPZSavable () | |
virtual | ~TPZSavable () |
virtual std::list< std::map< std::string, uint64_t > > | VersionHistory () const |
virtual std::pair< std::string, uint64_t > | Version () const |
Public Member Functions inherited from TPZRegisterClassId | |
template<typename T > | |
TPZRegisterClassId (int(T::*)() const) | |
TPZRegisterClassId ()=default | |
Static Public Member Functions | |
static int | Error (const char *msg, const char *msg2=0) |
Returns error messages. More... | |
Static Public Member Functions inherited from TPZSavable | |
static std::set< TPZRestoreClassBase * > & | RestoreClassSet () |
This static function guarantees that the gMap object is available when needed. More... | |
static std::map< int, TPZRestore_t > & | ClassIdMap () |
This static function guarantees that the gMap object is available when needed. More... | |
static std::pair< std::string, uint64_t > | NeoPZVersion () |
static void | Register (TPZRestoreClassBase *restore) |
static void | RegisterClassId (int classid, TPZRestore_t fun) |
static TPZSavable * | CreateInstance (const int &classId) |
Protected Member Functions | |
void | PrepareZ (const TPZFMatrix< TVar > &y, TPZFMatrix< TVar > &z, const TVar beta, const int opt) const |
Is an auxiliar method used by MultiplyAdd. More... | |
TPZMatrix (const int64_t row, const int64_t col) | |
Constructor. More... | |
virtual int | Clear () |
It clears data structure. More... | |
Static Protected Member Functions | |
static void | Swap (int64_t *a, int64_t *b) |
Swaps contents of a in b and b in a. More... | |
Protected Attributes | |
int64_t | fRow |
Number of rows in matrix. More... | |
int64_t | fCol |
Number of cols in matrix. More... | |
char | fDecomposed |
Decomposition type used to decompose the current matrix. More... | |
char | fDefPositive |
Definite Posistiveness of current matrix. More... | |
Static Protected Attributes | |
static TVar | gZero |
Initializing value to static variable. More... | |
Generic | |
virtual void | Input (std::istream &in=std::cin) |
Input operation. More... | |
virtual void | Print (std::ostream &out) const |
virtual void | Print (const char *name, std::ostream &out=std::cout, const MatrixOutputFormat form=EFormatted) const |
It prints the matrix data in a MatrixFormat Rows X Cols. More... | |
int64_t | Rows () const |
Returns number of rows. More... | |
int64_t | Cols () const |
Returns number of cols. More... | |
virtual int64_t | Dim () const |
Returns the dimension of the matrix if the matrix is square. More... | |
virtual int | Resize (const int64_t newRows, const int64_t newCols) |
Redimensions a matriz keeping the previous values. More... | |
virtual int | Redim (const int64_t newRows, const int64_t newCols) |
Redimensions the matrix reinitializing it with zero. More... | |
virtual int | Zero () |
Zeroes the matrix. More... | |
template<class TT > | |
std::istream & | operator>> (std::istream &in, TPZMatrix< TT > &A) |
Input operation. More... | |
Solvers | |
virtual void | SolveJacobi (int64_t &numiterations, const TPZFMatrix< TVar > &F, TPZFMatrix< TVar > &result, TPZFMatrix< TVar > *residual, TPZFMatrix< TVar > &scratch, REAL &tol, const int FromCurrent=0) |
Solves the linear system using Jacobi method. . More... | |
virtual void | SolveSOR (int64_t &numiterations, const TPZFMatrix< TVar > &F, TPZFMatrix< TVar > &result, TPZFMatrix< TVar > *residual, TPZFMatrix< TVar > &scratch, const REAL overrelax, REAL &tol, const int FromCurrent=0, const int direction=1) |
Solves the linear system using Successive Over Relaxation method (Gauss Seidel). . More... | |
virtual void | SolveSSOR (int64_t &numiterations, const TPZFMatrix< TVar > &F, TPZFMatrix< TVar > &result, TPZFMatrix< TVar > *residual, TPZFMatrix< TVar > &scratch, const REAL overrelax, REAL &tol, const int FromCurrent=0) |
Solves the linear system using Symmetric Successive Over Relaxation method (Gauss Seidel). . More... | |
virtual void | SolveCG (int64_t &numiterations, TPZSolver< TVar > &preconditioner, const TPZFMatrix< TVar > &F, TPZFMatrix< TVar > &result, TPZFMatrix< TVar > *residual, REAL &tol, const int FromCurrent=0) |
Solves the linear system using Conjugate Gradient method. . More... | |
virtual void | SolveBICG (int64_t &numiterations, TPZSolver< TVar > &preconditioner, const TPZFMatrix< TVar > &F, TPZFMatrix< TVar > &result, REAL &tol) |
Solves the linear system using Bi-Conjugate Gradient method. . More... | |
virtual void | SolveBICGStab (int64_t &numiterations, TPZSolver< TVar > &preconditioner, const TPZFMatrix< TVar > &F, TPZFMatrix< TVar > &result, TPZFMatrix< TVar > *residual, REAL &tol, const int FromCurrent=0) |
Solves the linear system using Bi-Conjugate Gradient stabilized method. . More... | |
virtual void | SolveGMRES (int64_t &numiterations, TPZSolver< TVar > &preconditioner, TPZFMatrix< TVar > &H, int &numvectors, const TPZFMatrix< TVar > &F, TPZFMatrix< TVar > &result, TPZFMatrix< TVar > *residual, REAL &tol, const int FromCurrent) |
Solves the linear system using Generalized Minimal Residual (GMRES) method. . More... | |
virtual void | SolveIR (int64_t &numiterations, TPZSolver< TVar > &preconditioner, const TPZFMatrix< TVar > &F, TPZFMatrix< TVar > &result, TPZFMatrix< TVar > *residual, REAL &tol, const int FromCurrent=0) |
Solves the linear system using IR method. . More... | |
virtual bool | SolveEigenvaluesJacobi (int64_t &numiterations, REAL &tol, TPZVec< TVar > *Sort=0) |
Transforms this matrix in a diagonal matrix, where the diagonal values are its eigenvalues. This method is efficient only for small matrices. More... | |
virtual bool | SolveEigensystemJacobi (int64_t &numiterations, REAL &tol, TPZVec< TVar > &Eigenvalues, TPZFMatrix< TVar > &Eigenvectors) const |
Compute Eigenvalues and Eigenvectors of this matrix. This method is efficient only for small matrices. More... | |
virtual int | SolveDirect (TPZFMatrix< TVar > &F, const DecomposeType dt, std::list< int64_t > &singular) |
Solves the linear system using Direct methods. More... | |
virtual int | SolveDirect (TPZFMatrix< TVar > &F, const DecomposeType dt) |
Solves the linear system using Direct methods. More... | |
virtual int | Decompose (const DecomposeType dt, std::list< int64_t > &singular) |
decompose the system of equations acording to the decomposition scheme More... | |
int | Solve_LU (TPZFMatrix< TVar > *B, std::list< int64_t > &singular) |
Solves the linear system using LU method . More... | |
int | Solve_LU (TPZFMatrix< TVar > *B) |
Solves the linear system using LU method . More... | |
virtual int | Solve_Cholesky (TPZFMatrix< TVar > *B) |
Solves the linear system using Cholesky method . More... | |
int | Solve_Cholesky (TPZFMatrix< TVar > *B, std::list< int64_t > &singular) |
Solves the linear system using Cholesky method . More... | |
int | Solve_LDLt (TPZFMatrix< TVar > *B, std::list< int64_t > &singular) |
Solves the linear system using LDLt method . More... | |
int | Solve_LDLt (TPZFMatrix< TVar > *B) |
Solves the linear system using LDLt method . More... | |
static TVar | ReturnNearestValue (TVar val, TPZVec< TVar > &Vec, TVar tol) |
Retorna o valor mais proximo a "val" (exceto valores no intervalo -tol <= val <= +tol) contido no vetor Vec. More... | |
Root matrix class (abstract). Matrix.
Abstract class TPZMatrix<TVar>which defines interface of derived matrix classes.
Definition at line 60 of file pzmatrix.h.
Simple constructor.
Definition at line 67 of file pzmatrix.h.
Definition at line 74 of file pzmatrix.h.
Simple destructor.
Definition at line 43 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::TPZMatrix().
|
inlineprotected |
Constructor.
row | Number of rows |
col | Number of cols |
Definition at line 761 of file pzmatrix.h.
|
virtual |
It adds itself to TPZMatrix<TVar>A putting the result in res.
A | TPZMatrix<TVar>to added to current matrix |
res | Contains the result |
Definition at line 64 of file pzmatrix.cpp.
Referenced by TPZDohrSubstruct< TVar >::Contribute_v2_local(), operator+(), TPZMatrix< STATE >::PutVal(), and TPZDohrSubstruct< TVar >::SolveSystemZi().
|
virtual |
Add a contribution of a stiffness matrix.
elmat | Element matrix to be contributed |
destinationindex | Contains destine indexes on current matrix |
Reimplemented in TPZFYsmpMatrix< TVar >, TPZFrontMatrix< TVar, store, front >, and TPZParFrontMatrix< TVar, store, front >.
Definition at line 506 of file pzmatrix.cpp.
Referenced by TPZFrontStructMatrix< front >::AssembleElement(), TPZGradientReconstruction::AssembleGlobalMatrix(), TPZFrontStructMatrix< front >::AssembleNew(), TPZFrontMatrix< TVar, store, front >::Clone(), TPZStructMatrixST::ExecuteAssemble(), TPZStructMatrixGCTP::MultiThread_Assemble(), TPZStructMatrixGCTP::Serial_Assemble(), TPZStructMatrixGC::Serial_Assemble(), TPZStructMatrixCS::Serial_Assemble(), TPZStructMatrixOT::Serial_Assemble(), TPZStructMatrixOR::Serial_Assemble(), TPZPairStructMatrix::SerialAssemble(), TPZStructMatrixOR::ThreadData::ThreadAssembly(), TPZPairStructMatrix::ThreadData::ThreadAssembly1(), TPZPairStructMatrix::ThreadData::ThreadAssembly2(), TPZStructMatrixGC::ThreadData::ThreadWork(), TPZStructMatrixCS::ThreadData::ThreadWork(), TPZStructMatrixOT::ThreadData::ThreadWork(), TPZPairStructMatrix::TPZPairStructMatrix(), and TPZMatrix< STATE >::Zero().
|
virtual |
Add a contribution of a stiffness matrix.
elmat | Element matrix to be contributed |
sourceindex | Contains source indexes on current matrix |
destinationindex | Contains destine indexes on current matrix |
Reimplemented in TPZSkylMatrix< TVar >, TPZFYsmpMatrix< TVar >, TPZFrontMatrix< TVar, store, front >, and TPZParFrontMatrix< TVar, store, front >.
Definition at line 534 of file pzmatrix.cpp.
|
virtual |
It adds Source matrix on current matrix from position (sRow, sCol)
sRow | Specifies starting row on current object |
sCol | Specifies starting column on current object. |
Source | The matrix to be added |
Definition at line 625 of file pzmatrix.cpp.
Referenced by TPZMat1dLin::Contribute(), and TPZMatrix< STATE >::Zero().
|
virtual |
Adds a submatrix from current object in *Target.
sRow | Specifies starting row on current object |
sCol | Specifies starting column on current object. |
rowSize | Specifies the amount of rows from sRow |
colSize | Specifies the amount of columns from sCol |
pRow | Specifies starting row on pA |
pCol | Specifies starting column on pA. |
pA | The matrix to be added. |
Definition at line 676 of file pzmatrix.cpp.
void TPZMatrix< TVar >::AutoFill | ( | int64_t | nrow, |
int64_t | ncol, | ||
int | symmetric | ||
) |
Fill matrix storage with randomic values.
This method use GetVal and PutVal which are implemented by each type matrices
Fill the matrix with random values (non singular matrix)
Fill data
Making diagonally dominant and non zero in diagonal
Definition at line 1960 of file pzmatrix.cpp.
Referenced by TPZSYsmpMatrix< TVar >::AutoFill(), TPZFYsmpMatrix< TVar >::AutoFill(), and TPZMatrix< STATE >::CopyFrom().
|
overridevirtual |
Define the class id associated with the class.
This id has to be unique for all classes A non unique id is flagged at the startup of the program
Implements TPZSavable.
Reimplemented in TPZFNMatrix< 9, T >, TPZFNMatrix< 3, T >, TPZFNMatrix< 30, std::complex< double > >, TPZSkylMatrix< TVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, TPZMatRed< TVar, TPZFMatrix< TVar > >, TPZFYsmpMatrix< TVar >, TPZSYsmpMatrix< TVar >, TPZDohrMatrix< TVar, TSubStruct >, TPZSBMatrix< TVar >, TPZSkylNSymMatrix< TVar >, TPZSFMatrix< TVar >, TPZDohrPrecond< TVar, TSubStruct >, TPZVerySparseMatrix< TVar >, TPZSkylParMatrix< TVar >, TPZSparseBlockDiagonal< TVar >, and TPZTransfer< TVar >.
Definition at line 957 of file pzmatrix.h.
Referenced by TPZTransfer< TVar >::ClassId(), TPZAbstractFrontMatrix< TVar >::ClassId(), TPZVerySparseMatrix< TVar >::ClassId(), TPZDohrPrecond< TVar, TSubStruct >::ClassId(), TPZBlockDiagonal< STATE >::ClassId(), TPZSFMatrix< TVar >::ClassId(), TPZFBMatrix< TVar >::ClassId(), TPZSkylNSymMatrix< TVar >::ClassId(), TPZSBMatrix< TVar >::ClassId(), TPZDohrMatrix< TVar, TSubStruct >::ClassId(), TPZSpMatrix< TVar >::ClassId(), TPZSYsmpMatrix< TVar >::ClassId(), TPZFYsmpMatrix< TVar >::ClassId(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::ClassId(), TPZFMatrix< STATE >::ClassId(), TPZSkylMatrix< TVar >::ClassId(), TPZMatrix< STATE >::Decompose(), and TPZMatrix< STATE >::MemoryFootprint().
|
inlineprotectedvirtual |
It clears data structure.
Reimplemented in TPZSkylMatrix< TVar >, TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, TPZFMatrix< STATE >, TPZSkylNSymMatrix< TVar >, TPZSpMatrix< TVar >, TPZSBMatrix< TVar >, TPZFBMatrix< TVar >, TPZSFMatrix< TVar >, TPZBlockDiagonal< TVar >, and TPZBlockDiagonal< STATE >.
Definition at line 774 of file pzmatrix.h.
|
pure virtual |
Implemented in TPZFrontMatrix< TVar, store, front >, TPZParFrontMatrix< TVar, store, front >, TPZDohrMatrix< TVar, TSubStruct >, TPZDohrPrecond< TVar, TSubStruct >, and TPZTransfer< TVar >.
Referenced by main(), and TPZMatrix< STATE >::TPZMatrix().
|
inline |
Returns number of cols.
Definition at line 809 of file pzmatrix.h.
Referenced by TPZHWTools::A2x2Inverse(), TPZHWTools::A3x3Inverse(), TPZMatrix< STATE >::Add(), TPZCheckRestraint::AddDependency(), TPZConnect::AddDependency(), TPZFMatrix< STATE >::AddFel(), TPZDohrSubstruct< TVar >::AddInternalSolution(), TPZMatrix< STATE >::AddSub(), ParallelAssembleTaskMatrix< TVar, TSubStruct >::addWorkItem(), TPZProjectEllipse::AdjustingWithEllipse(), TPZProjectEllipse::AdjustingWithSimpleEllipse(), TPZInterpolatedElement::AdjustPreferredSideOrder(), AdjustSolutionDerivatives(), pztopology::TPZPyramid::AdjustTopDirections(), TPZProjectEllipse::AlmostZeroToZero(), TPZCompElHDivPressure< TSHAPE >::Append(), TPZCompElHDiv< TSHAPE >::Append(), Append(), TPZCompElDisc::AppendExternalShapeFunctions(), TPZElementMatrix::ApplyConstraints(), TPZElementMatrix::ApplyOneShapeConstraints(), TPZPorousElasticCriterion::ApplyStrainComputeSigma(), TPZElasticCriterion::ApplyStrainComputeSigma(), TPZPlasticStep< YC_t, TF_t, ER_t >::ApplyStrainComputeSigma(), TPZPlasticStepPV< YC_t, ER_t >::ApplyStrainComputeSigma(), TPZSandlerExtended::ApplyStrainComputeSigma(), TPZPlasticStepPV< YC_t, ER_t >::ApplyStressComputeStrain(), TPZDohrAssembly< STATE >::Assemble(), TPZStructMatrixGCTP::Assemble(), TPZStructMatrixGC::Assemble(), TPZStructMatrixST::Assemble(), TPZStructMatrixCS::Assemble(), TPZStructMatrixTBBFlow::Assemble(), TPZStructMatrixOT::Assemble(), TPZStructMatrixOR::Assemble(), TPZDohrAssembly< STATE >::AssembleCoarse(), TPZSBMatrix< TVar >::AutoFill(), TPZMatrix< STATE >::AutoFill(), TPZAxesTools< TVar >::Axes2XYZ(), TPZInterpolatedElement::CalcIntegral(), TPZCondensedCompEl::CalcResidual(), TPZAgglomerateElement::CalcStiff(), TPZCompElLagrange::CalcStiff(), TPZCondensedCompEl::CalcStiff(), TPZCheckMesh::CheckConstraintDimension(), CheckConvergence(), TPZConnect::CheckDependency(), TPZSBFemElementGroup::CoeficientsReal(), TPZSBFemVolume::CoeficientsReal(), TPZMatrix< STATE >::CompareValues(), TPZAxesTools< TVar >::ComputeDetjac(), pztopology::TPZCube::ComputeDirections(), pztopology::TPZPyramid::ComputeDirections(), pztopology::TPZPrism::ComputeDirections(), pztopology::TPZLine::ComputeDirections(), pztopology::TPZTetrahedron::ComputeDirections(), pztopology::TPZQuadrilateral::ComputeDirections(), TPZMatElasticity2D::ComputeSigma(), TPZReducedSpace::ComputeSolution(), TPZInterpolatedElement::ComputeSolution(), TPZSBFemVolume::ComputeSolution(), TPZCompElDisc::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolutionHDiv(), TPZCompElHDivPressure< TSHAPE >::ComputeSolutionPressureHDiv(), TPZDohrPrecond< TVar, TSubStruct >::ComputeV1(), TPZMatHybrid::Contribute(), TPZElast3Dnlinear::Contribute(), TPZPlaca::Contribute(), TPZMatOrthotropic::Contribute(), TPZMatPlaca2::Contribute(), TPZElasticity2DHybrid::Contribute(), TPZLinearConvecDiff::Contribute(), TPZNLMat1d::Contribute(), TPZElasticityHybridMaterial::Contribute(), TPZMat2dLin::Contribute(), TPZMat1dLin::Contribute(), TPZElasticityMaterial::Contribute(), TPZElasticityAxiMaterial::Contribute(), TPZElasticity3D::Contribute(), TPZMixedPoisson::Contribute(), TPZMatMixedPoisson3D::Contribute(), TPZMixedElasticityMaterial::Contribute(), TPZDohrSubstructCondense< TTVar >::Contribute_v2_local(), TPZDohrSubstruct< TVar >::Contribute_v2_local(), TPZArtDiff::ContributeApproxImplDiff(), TPZElast3Dnlinear::ContributeBC(), TPZElasticity2DHybrid::ContributeBC(), TPZMat1dLin::ContributeBC(), TPZElasticityMaterial::ContributeBC(), TPZMixedElasticityMaterial::ContributeBC(), TPZEulerEquation::ContributeBCInterface(), TPZArtDiff::ContributeExplDiff(), TPZDohrSubstruct< TVar >::ContributeKU(), TPZDohrSubstructCondense< TTVar >::ContributeKULocal(), TPZDohrSubstruct< TVar >::ContributeKULocal(), TPZDohrSubstructCondense< TTVar >::ContributeRhs(), TPZDohrSubstruct< TVar >::ContributeTestV1(), TPZMatElasticity2D::ContributeVec(), TPZL2Projection::ContributeVecShape(), TPZElasticityMaterial::ContributeVecShape(), TPZElasticity3D::ContributeVecShape(), TPZElast3Dnlinear::ContributeVecShapeAux(), TPZElasticity3D::ContributeVecShapeBC(), TPZElasticityMaterial::ContributeVecShapeBC(), TPZElast3Dnlinear::ContributeVecShapeBCAux(), TPZInterpolationSpace::Convert2Axes(), TPZCompMesh::ConvertDiscontinuous2Continuous(), TPZSBMatrix< TVar >::Copy(), TPZSFMatrix< TVar >::CopyFrom(), TPZMatrix< STATE >::CopyFrom(), TPZFMatrix< STATE >::CopyFrom(), CopyTo(), TPZStructMatrixBase::CreateAssemble(), TPZStructMatrixST::CreateAssemble(), TPZStructMatrixGCTP::CreateAssemble(), TPZStructMatrixGC::CreateAssemble(), TPZStructMatrixCS::CreateAssemble(), TPZStructMatrixTBBFlow::CreateAssemble(), TPZStructMatrixOT::CreateAssemble(), TPZFMatrix< STATE >::Decompose_Cholesky(), TPZMatrix< STATE >::Decompose_Cholesky(), TPZSBMatrix< TVar >::Decompose_LDLt(), TPZFMatrix< STATE >::Decompose_LDLt(), TPZMatrix< STATE >::Decompose_LDLt(), TPZFMatrix< STATE >::Decompose_LU(), TPZMatrix< STATE >::Decompose_LU(), TPZArtDiff::Divergent(), TPZIncNavierStokesKEps::Dot(), Dot(), TPZMatDualHybridPoisson::Errors(), TPZElasticityMaterial::Errors(), TPZMixedElasticityMaterial::Errors(), TPZMultiphysicsCompEl< TGeometry >::EvaluateError(), TPZInterpolationSpace::EvaluateError(), TPZSubCompMesh::EvaluateError(), TPZConnect::ExpandShape(), TPZCompMesh::ExpandSolution(), TPZFlowCompMesh::ExpandSolution2(), TPZDohrAssembly< STATE >::Extract(), TPZDohrAssembly< STATE >::ExtractCoarse(), TPZSpMatrix< TVar >::fAdd(), TPZSpMatrix< TVar >::fCopy(), TPZSpMatrix< TVar >::fSub(), TPZFMatrix< STATE >::g(), TPZSparseBlockDiagonal< TVar >::Gather(), TPZSpMatrix< TVar >::Get(), TPZMatrix< STATE >::Get(), TPZMatrix< STATE >::GetSub(), TPZFMatrix< STATE >::GetVal(), pzgeom::TPZGeoCube::GradX(), pzgeom::TPZGeoQuad::GradX(), pzgeom::TPZQuadraticPrism::GradX(), pzgeom::TPZGeoPrism::GradX(), pzgeom::TPZGeoLinear::GradX(), pzgeom::TPZQuadraticPyramid::GradX(), pzgeom::TPZGeoTetrahedra::GradX(), pzgeom::TPZGeoPyramid::GradX(), pzgeom::TPZQuadraticCube::GradX(), pzgeom::TPZQuadraticTetra::GradX(), pzgeom::TPZGeoTriangle::GradX(), pzgeom::TPZWavyLine::GradX(), pzgeom::TPZQuadraticTrig::GradX(), pzgeom::TPZQuadraticLine::GradX(), pzgeom::TPZQuadraticQuad::GradX(), TPZGeoElSide::GradX(), pzgeom::TPZGeoBlend< TGeo >::GradX(), TPZFMatrix< STATE >::GramSchmidt(), TPZMatrix< STATE >::Identity(), TPZMixedElasticityMaterial::Inner(), TPZMatrix< STATE >::Input(), TPZBlock< STATE >::InsertBlock(), TPZMatrix< STATE >::InsertSub(), TPZGradientReconstruction::TPZGradientData::InsertWeights(), TPZMatrix< STATE >::Inverse(), pzgeom::TPZGeoBlend< TGeo >::Jacobian(), TPZGeoElSide::Jacobian(), TPZGeoEl::Jacobian(), TPZGeoEl::JacobianXYZ(), TPZProjectEllipse::LeastSquaresToGetEllipse(), TPZProjectEllipse::LeastSquaresToGetSimpleEllipse(), TPZSBFemElementGroup::LoadSolution(), TPZCompMesh::LoadSolution(), TPZMatPoisson3d::LocalNeumanContribute(), main(), TPZSubCompMesh::MakeExternal(), pzgeom::TPZGeoBlend< TGeo >::MapToNeighSide(), pztopology::TPZCube::MapToSide(), pztopology::TPZQuadrilateral::MapToSide(), TPZMatrix< STATE >::MatrixNorm(), TPZFMatrix< STATE >::MemoryFootprint(), TPZSparseBlockDiagonal< TVar >::MultAdd(), TPZBlockDiagonal< STATE >::MultAdd(), TPZSBMatrix< TVar >::MultAdd(), TPZTransfer< TVar >::MultAdd(), TPZFBMatrix< TVar >::MultAdd(), TPZSYsmpMatrix< TVar >::MultAdd(), TPZSkylNSymMatrix< TVar >::MultAdd(), TPZVerySparseMatrix< TVar >::MultAdd(), TPZDohrPrecond< TVar, TSubStruct >::MultAdd(), TPZFYsmpMatrix< TVar >::MultAdd(), TPZSpMatrix< TVar >::MultAdd(), TPZDohrMatrix< TVar, TSubStruct >::MultAdd(), TPZMatrix< STATE >::MultAdd(), TPZFMatrix< STATE >::MultAdd(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::MultAdd(), TPZSkylMatrix< TVar >::MultAdd(), TPZFYsmpMatrix< TVar >::MultAddMT(), TPZTransfer< TVar >::MultAddScalar(), TPZDohrPrecond< TVar, TSubStruct >::MultAddTBB(), TPZDohrMatrix< TVar, TSubStruct >::MultAddTBB(), TPZMatrix< STATE >::Multiply(), TPZTransfer< TVar >::MultiplyScalar(), NormalVector(), TPZArtDiff::ODotOperator(), TPZMatrix< STATE >::operator()(), TPZFMatrix< STATE >::operator()(), TPZGenAMatrix< TObj >::operator*(), operator*(), TPZFMatrix< STATE >::operator*(), TPZFMatrix< STATE >::operator*=(), TPZGenAMatrix< TObj >::operator+(), operator+(), TPZFMatrix< STATE >::operator+(), TPZFMatrix< STATE >::operator+=(), TPZGenAMatrix< TObj >::operator-(), operator-(), TPZFMatrix< STATE >::operator-(), TPZFMatrix< STATE >::operator-=(), TPZSFMatrix< TVar >::operator=(), TPZFMatrix< STATE >::operator=(), TPZElementMatrix::PermuteGather(), TPZDohrSubstructCondense< TTVar >::PermuteGather(), TPZDohrSubstructCondense< TTVar >::PermuteScatter(), TPZSBFemElementGroup::PhiReal(), TPZSBFemVolume::PhiReal(), TPZMatrix< STATE >::PrepareZ(), TPZTransfer< TVar >::Print(), TPZSBMatrix< TVar >::Print(), TPZElementMatrix::Print(), TPZSYsmpMatrix< TVar >::Print(), TPZFYsmpMatrix< TVar >::Print(), TPZMatrix< STATE >::Print(), TPZSBFemVolume::Print(), TPZProjectEllipse::PrintAxes(), TPZYCCamClayPV::ProjectSigma(), TPZYCDruckerPragerPV::ProjectSigma(), TPZYCMohrCoulombPV::ProjectSigma(), TPZSandlerExtended::ProjectSigma(), TPZSpMatrix< TVar >::Put(), TPZMatrix< STATE >::Put(), TPZMatrix< STATE >::PutSub(), PYBIND11_MODULE(), TPZGradientReconstruction::TPZGradientData::QRFactorization(), res_check(), TPZGenMatrix< TObj >::Resize(), TPZFMatrix< STATE >::Resize(), TPZInterpolatedElement::RestrainSide(), TPZVerySparseMatrix< TVar >::s(), TPZSparseBlockDiagonal< TVar >::Scatter(), TPZTransfer< TVar >::SetBlockMatrix(), pzgeom::TPZTriangleTorus::SetDataPhiTheta(), pzgeom::TPZQuadTorus::SetDataPhiTheta(), TPZCompMesh::SetElementSolution(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::SetF(), TPZTransientAnalysis< TRANSIENTCLASS >::SetInitialSolution(), TPZTransientAnalysis< TRANSIENTCLASS >::SetInitialSolutionAsZero(), TPZTransform< T >::SetMatrix(), TPZMixedDarcyFlow::SetPermeability(), TPZMatMixedPoisson3D::SetPermeabilityTensor(), TPZFMatrix< STATE >::SetSize(), pzshape::TPZShapePiram::Shape(), pzshape::TPZShapeTetra::Shape(), pzshape::TPZShapePrism::Shape(), pzshape::TPZShapeLinear::Shape(), TPZSBFemVolume::Shape(), pzshape::TPZShapeTriang::ShapeInternal(), pzshape::TPZShapeQuad::ShapeInternal(), TPZCompElHDivBound2< TSHAPE >::SideShapeFunction(), TPZVerySparseMatrix< TVar >::Simetrize(), TPZMatrix< STATE >::Simetrize(), TPZMatOrthotropic::Solution(), TPZMixedPoisson::Solution(), TPZCompEl::Solution(), TPZSequenceSolver< TVar >::Solve(), TPZMGSolver< TVar >::Solve(), TPZStepSolver< TVar >::Solve(), TPZMatrix< STATE >::SolveEigensystemJacobi(), TPZMatrix< STATE >::SolveEigenvaluesJacobi(), TPZMatrix< STATE >::SolveGMRES(), TPZFYsmpMatrix< TVar >::SolveJacobi(), TPZMatrix< STATE >::SolveJacobi(), TPZMatrix< STATE >::SolveSOR(), TPZSkylMatrix< TVar >::SolveSOR(), TPZSFMatrix< TVar >::Subst_Backward(), TPZSkylNSymMatrix< TVar >::Subst_Backward(), TPZSkylMatrix< TVar >::Subst_Backward(), TPZMatrix< STATE >::Subst_Backward(), TPZSSpMatrix< TVar >::Subst_Diag(), TPZSBMatrix< TVar >::Subst_Diag(), TPZSFMatrix< TVar >::Subst_Diag(), TPZSkylMatrix< TVar >::Subst_Diag(), TPZMatrix< STATE >::Subst_Diag(), TPZSSpMatrix< TVar >::Subst_Forward(), TPZSFMatrix< TVar >::Subst_Forward(), TPZSkylMatrix< TVar >::Subst_Forward(), TPZMatrix< STATE >::Subst_Forward(), TPZSBMatrix< TVar >::Subst_LBackward(), TPZSFMatrix< TVar >::Subst_LBackward(), TPZSkylMatrix< TVar >::Subst_LBackward(), TPZMatrix< STATE >::Subst_LBackward(), TPZSSpMatrix< TVar >::Subst_LForward(), TPZSBMatrix< TVar >::Subst_LForward(), TPZSFMatrix< TVar >::Subst_LForward(), TPZSkylNSymMatrix< TVar >::Subst_LForward(), TPZSkylMatrix< TVar >::Subst_LForward(), TPZMatrix< STATE >::Subst_LForward(), TPZSpBlockDiagPivot< TVar >::Substitution(), TPZSparseBlockDiagonal< TVar >::Substitution(), TPZBlockDiagonal< STATE >::Substitution(), TPZFYsmpMatrix< TVar >::Substitution(), TPZFMatrix< STATE >::Substitution(), TPZMatrix< STATE >::Substitution(), TPZSpBlockDiagPivot< TVar >::Substitution2(), TPZMatrix< STATE >::Substract(), TPZDohrThreadMultList< TVar, TSubStruct >::ThreadWork(), TPZCheckConvergence(), TPZTensor< STATE >::TPZTensor(), TPZMixedElasticityMaterial::Tr(), TPZSubCompMesh::TransferDependencies(), TPZMultiphysicsElement::TransferMultiphysicsElementSolution(), TPZTransfer< TVar >::TransferResidual(), TPZPostProcAnalysis::TransferSolution(), TPZTransfer< TVar >::TransferSolution(), TPZVerySparseMatrix< TVar >::Transpose(), TPZGenAMatrix< TObj >::Transpose(), TPZFBMatrix< TVar >::Transpose(), TPZMatrix< STATE >::Transpose(), TPZFMatrix< STATE >::Transpose(), TPZDohrSubstructCondense< TTVar >::UGlobal(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::UGlobal(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::UGlobal2(), TPZCoupledTransportDarcy::UpdateConvectionDirInterface(), TPZCompMesh::UpdatePreviousState(), TPZAxesTools< TVar >::VerifyAxes(), TPZInterpolatedElement::VerifyConstraintConsistency(), TPZMatrix< STATE >::VerifySymmetry(), VisualMatrixDX(), VisualMatrixVTK(), and TPZAxesTools< TVar >::XYZ2Axes().
|
overridevirtual |
Compare the object for identity with the object pointed to, eventually copy the object.
compare both objects bitwise for identity. Put an entry in the log file if different overwrite the calling object if the override flag is true
Reimplemented from TPZSavable.
Reimplemented in TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, and TPZFMatrix< STATE >.
Definition at line 1433 of file pzmatrix.cpp.
Referenced by TPZFMatrix< STATE >::Compare(), and TPZMatrix< STATE >::Decompose().
|
overridevirtual |
Compare the object for identity with the object pointed to, eventually copy the object.
compare both objects bitwise for identity. Put an entry in the log file if different overwrite the calling object if the override flag is true
Reimplemented from TPZSavable.
Reimplemented in TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, and TPZFMatrix< STATE >.
Definition at line 1458 of file pzmatrix.cpp.
Compare values of this to B, with a precision tolerance tol.
Definition at line 1532 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::Decompose(), and TPZMatrix< STATE >::VerifySymmetry().
TVar TPZMatrix< TVar >::ConditionNumber | ( | int | p, |
int64_t | numiter = 2000000 , |
||
REAL | tol = 1.e-10 |
||
) |
Computes the matrix condition number of this.
It is available p-norm = 1, 2 and infinity. p=1 is the maximum absolute column sum norm p=2 is the spectral norm wich is the square root of the maximum eigenvalue of Tranpose[this].this p=infinity is the maximum absolute row sum norm - p infinity is implemented with p = 0 These operations are defined on the website of the Mathematica software: http://mathworld.wolfram.com/MatrixNorm.html All norms require the computation of the inverse matrix. It has a high computational cost and a high memory requirement.
Definition at line 1902 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::PutVal().
|
inline |
Definition at line 96 of file pzmatrix.h.
Referenced by TPZSFMatrix< TVar >::CopyFrom(), TPZFBMatrix< TVar >::CopyFrom(), TPZSBMatrix< TVar >::CopyFrom(), TPZFMatrix< STATE >::CopyFrom(), and TPZSkylMatrix< TVar >::CopyFrom().
|
inlinevirtual |
decompose the system of equations acording to the decomposition scheme
Definition at line 572 of file pzmatrix.h.
|
virtual |
Decomposes the current matrix using Cholesky method. The current matrix has to be symmetric.
Reimplemented in TPZSkylMatrix< TVar >, TPZSkylMatrix< TVar >, TPZSkylMatrix< TVar >, TPZSkylMatrix< TVar >, TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, TPZFMatrix< STATE >, TPZSFMatrix< TVar >, TPZSSpMatrix< TVar >, and TPZSkylParMatrix< TVar >.
Definition at line 1252 of file pzmatrix.cpp.
Referenced by TPZSYsmpMatrix< TVar >::AutoFill(), TPZMatrix< STATE >::Decompose(), TPZSBMatrix< TVar >::GetBand(), TPZSYsmpMatrix< TVar >::JA(), TPZSBMatrix< TVar >::SetBand(), and TPZMatrix< STATE >::Solve_Cholesky().
|
virtual |
Decomposes the current matrix using Cholesky method.
singular |
Reimplemented in TPZSkylMatrix< TVar >, TPZSkylMatrix< TVar >, TPZSkylMatrix< TVar >, TPZSkylMatrix< TVar >, TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, TPZFMatrix< STATE >, TPZSFMatrix< TVar >, TPZSSpMatrix< TVar >, and TPZSkylParMatrix< TVar >.
Definition at line 1217 of file pzmatrix.cpp.
|
virtual |
Decomposes the current matrix using LDLt.
The current matrix has to be symmetric. "L" is lower triangular with 1.0 in its diagonal and "D" is a Diagonal matrix.
Reimplemented in TPZSkylMatrix< TVar >, TPZSFMatrix< TVar >, TPZSBMatrix< TVar >, TPZSSpMatrix< TVar >, and TPZSkylParMatrix< TVar >.
Definition at line 1180 of file pzmatrix.cpp.
|
virtual |
Decomposes the current matrix using LDLt.
Reimplemented in TPZSkylMatrix< TVar >, TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, TPZFMatrix< STATE >, TPZSFMatrix< TVar >, TPZSBMatrix< TVar >, TPZSSpMatrix< TVar >, and TPZSkylParMatrix< TVar >.
Definition at line 1184 of file pzmatrix.cpp.
Referenced by TPZSYsmpMatrix< TVar >::AutoFill(), TPZMatrix< STATE >::Decompose(), TPZMatrix< STATE >::Decompose_LDLt(), TPZSYsmpMatrix< TVar >::JA(), and TPZMatrix< STATE >::Solve_LDLt().
|
virtual |
Decomposes the current matrix using LU decomposition.
Reimplemented in TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, TPZFMatrix< STATE >, TPZFYsmpMatrix< TVar >, TPZBlockDiagonal< TVar >, TPZBlockDiagonal< STATE >, and TPZSpBlockDiagPivot< TVar >.
Definition at line 1122 of file pzmatrix.cpp.
|
virtual |
Reimplemented in TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, TPZFMatrix< STATE >, TPZFYsmpMatrix< TVar >, TPZSkylNSymMatrix< TVar >, TPZBlockDiagonal< TVar >, TPZBlockDiagonal< STATE >, and TPZSpBlockDiagPivot< TVar >.
Definition at line 1126 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::Decompose(), TPZMatrix< STATE >::Decompose_LU(), TPZFBMatrix< TVar >::GetBand(), TPZMatrix< STATE >::Solve_LU(), and TPZFBMatrix< TVar >::Transpose().
|
inlinevirtual |
Returns the dimension of the matrix if the matrix is square.
If the matrix is not square, returns an error
Reimplemented in TPZFBMatrix< TVar >, TPZBlockDiagonal< TVar >, and TPZBlockDiagonal< STATE >.
Definition at line 892 of file pzmatrix.h.
Referenced by TPZSkylMatrix< TVar >::AddKel(), TPZSkylParMatrix< TVar >::ColumnToWork(), TPZSBMatrix< TVar >::Copy(), TPZSkylNSymMatrix< TVar >::Copy(), TPZSkylMatrix< TVar >::Copy(), TPZSkylParMatrix< TVar >::Decompose_Cholesky(), TPZSSpMatrix< TVar >::Decompose_Cholesky(), TPZSFMatrix< TVar >::Decompose_Cholesky(), TPZFMatrix< STATE >::Decompose_Cholesky(), TPZSkylMatrix< TVar >::Decompose_Cholesky(), TPZMatrix< STATE >::Decompose_Cholesky(), TPZSkylMatrix< TVar >::Decompose_Cholesky_blk(), TPZSkylParMatrix< TVar >::Decompose_LDLt(), TPZSSpMatrix< TVar >::Decompose_LDLt(), TPZSBMatrix< TVar >::Decompose_LDLt(), TPZSFMatrix< TVar >::Decompose_LDLt(), TPZSkylMatrix< TVar >::Decompose_LDLt(), TPZSkylNSymMatrix< TVar >::Decompose_LU(), dump_matrix_stats(), TPZSkylNSymMatrix< TVar >::GetVal(), TPZSkylMatrix< TVar >::GetVal(), TPZSkylNSymMatrix< TVar >::GetValB(), TPZSkylNSymMatrix< TVar >::GetValSup(), main(), TPZSFMatrix< TVar >::operator*(), TPZSkylMatrix< TVar >::operator*(), TPZSkylMatrix< TVar >::operator*=(), TPZSSpMatrix< TVar >::operator+(), TPZSFMatrix< TVar >::operator+(), TPZSBMatrix< TVar >::operator+(), TPZSkylMatrix< TVar >::operator+(), TPZSSpMatrix< TVar >::operator+=(), TPZSFMatrix< TVar >::operator+=(), TPZSBMatrix< TVar >::operator+=(), TPZSkylMatrix< TVar >::operator+=(), TPZSSpMatrix< TVar >::operator-(), TPZSFMatrix< TVar >::operator-(), TPZSBMatrix< TVar >::operator-(), TPZSkylMatrix< TVar >::operator-(), TPZSSpMatrix< TVar >::operator-=(), TPZSFMatrix< TVar >::operator-=(), TPZSBMatrix< TVar >::operator-=(), TPZSkylMatrix< TVar >::operator-=(), TPZSSpMatrix< TVar >::operator=(), TPZSFMatrix< TVar >::operator=(), TPZSkylParMatrix< TVar >::ParallelCholesky(), TPZSkylParMatrix< TVar >::ParallelLDLt(), TPZSkylParMatrix< TVar >::ParallelLDLt2(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::Print(), TPZMatrix< STATE >::Print(), TPZSkylParMatrix< TVar >::PrintState(), TPZSBMatrix< TVar >::Redim(), TPZSFMatrix< TVar >::Redim(), TPZSkylMatrix< TVar >::Redim(), TPZSBMatrix< TVar >::Resize(), TPZSFMatrix< TVar >::Resize(), TPZSkylMatrix< TVar >::Resize(), TPZSBMatrix< TVar >::SetBand(), TPZSkylParMatrix< TVar >::SetSkyline(), TPZSFMatrix< TVar >::Size(), TPZSBMatrix< TVar >::Size(), TPZMatrix< STATE >::SolveJacobi(), TPZMatrix< STATE >::SolveSOR(), TPZSkylMatrix< TVar >::SolveSOR(), TPZSBMatrix< TVar >::Subst_Backward(), TPZSFMatrix< TVar >::Subst_Backward(), TPZSkylNSymMatrix< TVar >::Subst_Backward(), TPZSkylMatrix< TVar >::Subst_Backward(), TPZMatrix< STATE >::Subst_Backward(), TPZSSpMatrix< TVar >::Subst_Diag(), TPZSBMatrix< TVar >::Subst_Diag(), TPZSFMatrix< TVar >::Subst_Diag(), TPZSkylMatrix< TVar >::Subst_Diag(), TPZMatrix< STATE >::Subst_Diag(), TPZSSpMatrix< TVar >::Subst_Forward(), TPZSBMatrix< TVar >::Subst_Forward(), TPZSFMatrix< TVar >::Subst_Forward(), TPZSkylMatrix< TVar >::Subst_Forward(), TPZMatrix< STATE >::Subst_Forward(), TPZSBMatrix< TVar >::Subst_LBackward(), TPZSFMatrix< TVar >::Subst_LBackward(), TPZSkylMatrix< TVar >::Subst_LBackward(), TPZMatrix< STATE >::Subst_LBackward(), TPZSSpMatrix< TVar >::Subst_LForward(), TPZSBMatrix< TVar >::Subst_LForward(), TPZSFMatrix< TVar >::Subst_LForward(), TPZSkylNSymMatrix< TVar >::Subst_LForward(), TPZSkylMatrix< TVar >::Subst_LForward(), TPZMatrix< STATE >::Subst_LForward(), and TPZSFMatrix< TVar >::TPZSFMatrix().
|
static |
Returns error messages.
msg | First message. |
msg2 | Second message. |
Definition at line 1402 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::Add(), TPZMatrix< STATE >::AddSub(), TPZMatrix< STATE >::AutoFill(), TPZSkylNSymMatrix< TVar >::AutoFill(), TPZSBMatrix< TVar >::Copy(), TPZSSpMatrix< TVar >::Decompose_Cholesky(), TPZSFMatrix< TVar >::Decompose_Cholesky(), TPZSkylMatrix< TVar >::Decompose_Cholesky(), TPZMatrix< STATE >::Decompose_Cholesky(), TPZSkylMatrix< TVar >::Decompose_Cholesky_blk(), TPZSSpMatrix< TVar >::Decompose_LDLt(), TPZSBMatrix< TVar >::Decompose_LDLt(), TPZSFMatrix< TVar >::Decompose_LDLt(), TPZSkylMatrix< TVar >::Decompose_LDLt(), TPZMatrix< STATE >::Decompose_LDLt(), TPZBlockDiagonal< STATE >::Decompose_LU(), TPZSkylNSymMatrix< TVar >::Decompose_LU(), TPZMatrix< STATE >::Decompose_LU(), TPZMatrix< STATE >::Dim(), TPZBlockDiagonal< STATE >::Get(), TPZFBMatrix< TVar >::Get(), TPZSpMatrix< TVar >::Get(), TPZBlock< STATE >::Get(), TPZMatrix< STATE >::Get(), TPZMatrix< STATE >::GetSub(), TPZMatrix< STATE >::Identity(), TPZBlock< STATE >::InsertBlock(), TPZMatrix< STATE >::InsertSub(), TPZBlockDiagonal< STATE >::MultAdd(), TPZSBMatrix< TVar >::MultAdd(), TPZTransfer< TVar >::MultAdd(), TPZFBMatrix< TVar >::MultAdd(), TPZSkylNSymMatrix< TVar >::MultAdd(), TPZDohrPrecond< TVar, TSubStruct >::MultAdd(), TPZSpMatrix< TVar >::MultAdd(), TPZDohrMatrix< TVar, TSubStruct >::MultAdd(), TPZMatrix< STATE >::MultAdd(), TPZSkylMatrix< TVar >::MultAdd(), TPZTransfer< TVar >::MultAddScalar(), TPZDohrPrecond< TVar, TSubStruct >::MultAddTBB(), TPZDohrMatrix< TVar, TSubStruct >::MultAddTBB(), TPZMatrix< STATE >::Multiply(), TPZTransfer< TVar >::MultiplyScalar(), TPZSkylNSymMatrix< TVar >::operator()(), TPZMatrix< STATE >::operator()(), TPZSkylMatrix< TVar >::operator()(), TPZSBMatrix< TVar >::operator+=(), TPZSpMatrix< TVar >::operator+=(), TPZSBMatrix< TVar >::operator-(), TPZSBMatrix< TVar >::operator-=(), TPZSpMatrix< TVar >::operator-=(), TPZSFMatrix< TVar >::operator=(), TPZSpMatrix< TVar >::Put(), TPZBlock< STATE >::Put(), TPZMatrix< STATE >::Put(), TPZSkylNSymMatrix< TVar >::PutVal(), TPZSkylMatrix< TVar >::PutVal(), TPZFBMatrix< TVar >::Redim(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::Redim(), TPZSFMatrix< TVar >::Resize(), TPZFBMatrix< TVar >::Resize(), TPZVerySparseMatrix< TVar >::s(), TPZSBMatrix< TVar >::SetBand(), TPZFBMatrix< TVar >::SetBand(), TPZFMatrix< STATE >::SetSize(), TPZMatrix< STATE >::Simetrize(), TPZMatrix< STATE >::Solve_LU(), TPZMatrix< STATE >::SolveDirect(), TPZSBMatrix< TVar >::Subst_Backward(), TPZSkylNSymMatrix< TVar >::Subst_Backward(), TPZSkylMatrix< TVar >::Subst_Backward(), TPZSBMatrix< TVar >::Subst_Diag(), TPZMatrix< STATE >::Subst_Diag(), TPZSBMatrix< TVar >::Subst_Forward(), TPZSkylMatrix< TVar >::Subst_Forward(), TPZSBMatrix< TVar >::Subst_LBackward(), TPZSkylMatrix< TVar >::Subst_LBackward(), TPZMatrix< STATE >::Subst_LBackward(), TPZSBMatrix< TVar >::Subst_LForward(), TPZMatrix< STATE >::Subst_LForward(), TPZBlockDiagonal< STATE >::Substitution(), TPZMatrix< STATE >::Substitution(), TPZMatrix< STATE >::Substract(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::TPZMatRed(), TPZMatrix< STATE >::TPZMatrix(), TPZSFMatrix< TVar >::TPZSFMatrix(), TPZSpMatrix< TVar >::TPZSpMatrix(), and TPZFBMatrix< TVar >::Transpose().
|
inline |
Substitution for the () operator when const arguments are needed.
row | Row number. |
col | Column number. |
Definition at line 131 of file pzmatrix.h.
|
inlinevirtual |
Get value with bound checking.
row | Row number. |
col | Column number. |
Reimplemented in TPZSpMatrix< TVar >, TPZFBMatrix< TVar >, TPZBlockDiagonal< TVar >, TPZBlockDiagonal< STATE >, and TPZSparseBlockDiagonal< TVar >.
Definition at line 855 of file pzmatrix.h.
Referenced by TPZMatrix< STATE >::CompareValues(), TPZDohrSubstruct< TVar >::ContributeKU(), TPZDohrSubstruct< TVar >::ContributeKULocal(), TPZMatrix< STATE >::CopyFrom(), TPZTensor< STATE >::CopyFrom(), TPZFMatrix< STATE >::Decompose_LU(), TPZMatrix< STATE >::g(), TPZMatrix< STATE >::MatrixNorm(), TPZSFMatrix< TVar >::operator+(), TPZSFMatrix< TVar >::operator+=(), TPZSFMatrix< TVar >::operator-(), TPZSFMatrix< TVar >::operator-=(), TPZSFMatrix< TVar >::operator=(), TPZFMatrix< STATE >::operator=(), operator>>(), TPZMatrix< STATE >::Print(), TPZMatrix< STATE >::SolveEigensystemJacobi(), TPZFMatrix< STATE >::Substitution(), and TPZMatrix< STATE >::VerifySymmetry().
|
virtual |
Gets submatrix storing it on Target.
sRow | Specifies starting row on current object |
sCol | Specifies starting column on current object. |
rowSize | Specifies the amount of rows from sRow |
colSize | Specifies the amount of columns from sCol |
Target | The matrix to be aquired. |
Reimplemented in TPZFYsmpMatrix< TVar >.
Definition at line 602 of file pzmatrix.cpp.
Referenced by TPZSparseBlockDiagonal< TVar >::BuildFromMatrix(), TPZInterpolationSpace::BuildTransferMatrix(), TPZInterpolatedElement::BuildTransferMatrix(), TPZCompElDisc::BuildTransferMatrix(), TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZDohrSubstruct< TVar >::ContributeTestV1(), TPZMatrix< STATE >::Decompose(), and TPZMatrix< STATE >::Zero().
|
virtual |
Extract the block indicated by the indices from the matrix.
Reimplemented in TPZFYsmpMatrix< TVar >.
Definition at line 1478 of file pzmatrix.cpp.
|
virtual |
Get values without bounds checking
This method is faster than "Get" if DEBUG is defined.
Reimplemented in TPZSkylMatrix< TVar >, TPZSBMatrix< TVar >, TPZSBMatrix< TVar >, TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, TPZFMatrix< STATE >, TPZFYsmpMatrix< TVar >, TPZMatRed< TVar, TSideMatrix >, TPZMatRed< STATE, TPZFMatrix< STATE > >, TPZMatRed< TVar, TPZFMatrix< TVar > >, TPZMatRed< TTVar, TPZFMatrix< TTVar > >, TPZSpMatrix< TVar >, TPZFBMatrix< TVar >, TPZSkylNSymMatrix< TVar >, TPZSYsmpMatrix< TVar >, TPZVerySparseMatrix< TVar >, TPZSFMatrix< TVar >, TPZBlockDiagonal< TVar >, TPZBlockDiagonal< STATE >, TPZSBMatrix< TVar >, TPZSSpMatrix< TVar >, and TPZSparseBlockDiagonal< TVar >.
Definition at line 56 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::Add(), TPZMatrix< STATE >::AddSub(), TPZBlockDiagonal< STATE >::BuildFromMatrix(), TPZMatrix< STATE >::Get(), TPZMatrix< STATE >::PutVal(), TPZMatrix< STATE >::Substract(), TPZFMatrix< STATE >::TPZFMatrix(), and TPZSFMatrix< TVar >::TPZSFMatrix().
|
virtual |
Converts the matrix in an identity matrix.
Definition at line 199 of file pzmatrix.cpp.
Referenced by TPZSBFemVolume::AdjustAxes3D(), TPZSBFemElementGroup::CalcStiff(), TPZMixedElasticityMaterial::FillVecShapeIndex(), pztopology::TPZPyramid::MapToSide(), pztopology::TPZPrism::MapToSide(), pztopology::TPZTetrahedron::MapToSide(), pztopology::TPZTriangle::MapToSide(), TPZYCMohrCoulombPV::ProjectSigma(), TPZSandlerExtended::ProjectSigma(), TPZYCCamClayPV::ProjectSigmaDep(), TPZYCDruckerPragerPV::ProjectSigmaDep(), TPZSandlerExtended::ProjectSigmaDep(), TPZMatrix< STATE >::PutVal(), pzgeom::TPZCylinderMap< TGeo >::TPZCylinderMap(), TPZMatMixedPoisson3D::TPZMatMixedPoisson3D(), and TPZMixedPoisson::TPZMixedPoisson().
|
virtual |
Input operation.
Definition at line 227 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::Identity(), operator>>(), and TPZMatrix< STATE >::PutVal().
|
virtual |
Inserts a submatrix from current object on matrix *Target with no
redimentioning.
sRow | Specifies starting row on current object |
sCol | Specifies starting column on current object. |
rowSize | Specifies the amount of rows from sRow |
colSize | Specifies the amount of columns from sCol |
pRow | Specifies final row on current object |
pCol | Specifies final column on current object. |
Target | The matrix to be inserted. |
Definition at line 647 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::Zero().
int TPZMatrix< TVar >::Inverse | ( | TPZFMatrix< TVar > & | Inv, |
DecomposeType | dec | ||
) |
It makes Inv =[this]. IMPORTANT OBSERVATION –> The original matrix (calling object) no is more equal. It containts the some decomposition (LU or Cholesky or ...)
Definition at line 1929 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::ConditionNumber(), TPZMatrix< STATE >::PutVal(), and TPZMixedDarcyFlow::SetPermeability().
|
inline |
Checks if current matrix is already decomposed.
Definition at line 405 of file pzmatrix.h.
Referenced by TPZSYsmpMatrix< TVar >::AutoFill(), TPZMatrix< STATE >::CopyFrom(), TPZFYsmpMatrix< TVar >::Decompose_LU(), TPZSubMeshFrontalAnalysis::LoadSolution(), TPZSFMatrix< TVar >::operator=(), TPZSubMeshFrontalAnalysis::Run(), and TPZAnalysis::Solve().
|
inlinevirtual |
Checks if current matrix is definite positive.
Definition at line 403 of file pzmatrix.h.
Referenced by TPZMatrix< STATE >::CopyFrom(), and TPZSFMatrix< TVar >::operator=().
|
inlinevirtual |
Checks if the current matrix is symmetric.
Reimplemented in TPZSkylMatrix< TVar >, TPZSkylNSymMatrix< TVar >, TPZMatRed< TVar, TSideMatrix >, TPZMatRed< STATE, TPZFMatrix< STATE > >, TPZMatRed< TVar, TPZFMatrix< TVar > >, TPZMatRed< TTVar, TPZFMatrix< TTVar > >, TPZSYsmpMatrix< TVar >, TPZSBMatrix< TVar >, and TPZSFMatrix< TVar >.
Definition at line 394 of file pzmatrix.h.
Referenced by TPZDohrSubstructCondense< TTVar >::Contribute_Kc(), TPZMatrix< STATE >::Solve_LU(), TPZSFMatrix< TVar >::Subst_Backward(), TPZSFMatrix< TVar >::Subst_Forward(), TPZSFMatrix< TVar >::Subst_LBackward(), and TPZSFMatrix< TVar >::Subst_LForward().
|
inline |
Checks if current matrix is square.
Definition at line 396 of file pzmatrix.h.
Referenced by TPZMatrix< STATE >::Dim().
TVar TPZMatrix< TVar >::MatrixNorm | ( | int | p, |
int64_t | numiter = 2000000 , |
||
REAL | tol = 1.e-10 |
||
) | const |
Computes the matrix norm of this.
p | interpolation order |
numiter | is used by 2-norm calculation in the SolveEigenvaluesJacobi method required to compute the maximum eigenvalue |
tol | - same of numiter |
Definition at line 1839 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::ConditionNumber(), TPZMatrix< STATE >::PutVal(), and TPZMatrix< STATE >::SolveEigenvaluesJacobi().
|
inlinevirtual |
Returns the approximate size of the memory footprint (amount of memory required to store this object).
Reimplemented in TPZSkylMatrix< TVar >, TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, and TPZFMatrix< STATE >.
Definition at line 86 of file pzmatrix.h.
|
virtual |
It computes z = beta * y + alpha * opt(this)*x but z and x can not overlap in memory.
x | Is x on the above operation |
y | Is y on the above operation |
z | Is z on the above operation |
alpha | Is alpha on the above operation |
beta | Is beta on the above operation |
opt | Indicates if is Transpose or not |
Reimplemented in TPZSkylMatrix< TVar >, TPZMatRed< TVar, TSideMatrix >, TPZMatRed< STATE, TPZFMatrix< STATE > >, TPZMatRed< TVar, TPZFMatrix< TVar > >, TPZMatRed< TTVar, TPZFMatrix< TTVar > >, TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< STATE >, TPZDohrMatrix< TVar, TSubStruct >, TPZFYsmpMatrix< TVar >, TPZDohrPrecond< TVar, TSubStruct >, TPZVerySparseMatrix< TVar >, TPZSkylNSymMatrix< TVar >, TPZFBMatrix< TVar >, TPZSYsmpMatrix< TVar >, TPZTransfer< TVar >, TPZSBMatrix< TVar >, TPZBlockDiagonal< TVar >, TPZBlockDiagonal< STATE >, TPZSparseBlockDiagonal< TVar >, and TPZStencilMatrix< TVar >.
Definition at line 166 of file pzmatrix.cpp.
Referenced by TPZPlasticDiagnostic::CheckGlobal(), TPZMatrix< STATE >::Cols(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::MultAdd(), TPZMatrix< STATE >::PutVal(), and TPZMatrix< STATE >::Residual().
|
virtual |
It mutiplies itself by TPZMatrix<TVar>A putting the result in res.
A | TPZMatrix<TVar>object to multiplied to |
res | TPZFMatrix<TVar>containing the result |
opt | Indicates if is Transpose or not |
Definition at line 1916 of file pzmatrix.cpp.
Referenced by TPZSBFemVolume::AdjustAxes3D(), TPZAxesTools< TVar >::Axes2XYZ(), TPZSBFemElementGroup::CalcStiff(), CheckConvergence(), TPZMatElastoPlastic< T, TMEM >::CheckConvergence(), TPZSandlerExtended::ComputeCapCoVertexTangent(), TPZSandlerExtended::ComputeCapTangent(), TPZSandlerExtended::ComputeCapVertexTangent(), TPZMatElastoPlastic2D< T, TMEM >::ComputeDeltaStrainVector(), TPZMatElastoPlastic< T, TMEM >::ComputeDeltaStrainVector(), TPZMixedElasticityMaterial::ComputeDivergenceOnDeformed(), TPZSandlerExtended::ComputeFailureTangent(), TPZSBFemVolume::ComputeKMatrices(), TPZSBFemElementGroup::ComputeMassMatrix(), TPZCompElHDivPressure< TSHAPE >::ComputeSolutionPressureHDiv(), TPZPorousElasticResponse::ComputeStrain(), TPZGeoEl::ComputeXInverse(), TPZMatElastoPlastic2D< T, TMEM >::Contribute(), TPZMixedPoisson::Contribute(), TPZDohrSubstruct< TVar >::Contribute_rc(), TPZMatLaplacian::ContributeHDiv(), TPZMatPoisson3d::ContributeHDiv(), TPZDohrSubstructCondense< TTVar >::ContributeKULocal(), GetSideTransform(), pzgeom::TPZQuadSphere< GeomQuad >::GradX(), TPZGeoElSide::GradX(), pzgeom::TPZGeoBlend< TGeo >::GradX(), TPZFMatrix< STATE >::GramSchmidt(), pzgeom::TPZGeoBlend< TGeo >::Jacobian(), TPZSBFemElementGroup::LoadSolution(), TPZBlockDiagonal< STATE >::main(), pzgeom::TPZGeoBlend< TGeo >::MapToNeighSide(), TPZTransform< T >::Multiply(), operator*(), TPZSandlerExtended::ProjectCapCoVertex(), TPZSandlerExtended::ProjectCoVertex(), TPZSandlerExtended::ProjectF1(), TPZSandlerExtended::ProjectF2(), TPZYCCamClayPV::ProjectSigmaDep(), TPZYCDruckerPragerPV::ProjectSigmaDep(), TPZSandlerExtended::ProjectSigmaDep(), TPZMatrix< STATE >::PutVal(), TPZGradientReconstruction::TPZGradientData::QRFactorization(), TPZMatPlaca2::SetNAxes(), TPZMixedPoisson::Solution(), TPZPlasticStepPV< YC_t, ER_t >::TaylorCheck(), TPZSandlerExtended::TaylorCheckDDistF1(), TPZSandlerExtended::TaylorCheckDDistF1DSigtrial(), TPZSandlerExtended::TaylorCheckDDistF2(), TPZSandlerExtended::TaylorCheckDDistF2DSigtrial(), TPZSandlerExtended::TaylorCheckDF1Cart(), TPZSandlerExtended::TaylorCheckDF2Cart(), TPZSandlerExtended::TaylorCheckProjectSigma(), TPZGeoElMapped< TBase >::TGradX(), TPZCheckConvergence(), and TPZAxesTools< TVar >::XYZ2Axes().
|
inline |
The operators check on the bounds if the DEBUG variable is defined.
row | Row number. |
col | Column number. |
Definition at line 867 of file pzmatrix.h.
Referenced by ParallelAssembleTaskMatrix< TVar, TSubStruct >::addWorkItem(), ParallelAssembleTask< TVar, TSubStruct >::addWorkItem(), TPZMatrix< STATE >::g(), and TPZMatrix< STATE >::operator()().
|
inline |
The operators check on the bounds if the DEBUG variable is defined.
row | Row number. |
Definition at line 887 of file pzmatrix.h.
|
protected |
Is an auxiliar method used by MultiplyAdd.
Definition at line 135 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::Decompose(), TPZBlockDiagonal< STATE >::MultAdd(), TPZSBMatrix< TVar >::MultAdd(), TPZTransfer< TVar >::MultAdd(), TPZFBMatrix< TVar >::MultAdd(), TPZSkylNSymMatrix< TVar >::MultAdd(), TPZVerySparseMatrix< TVar >::MultAdd(), TPZDohrPrecond< TVar, TSubStruct >::MultAdd(), TPZSpMatrix< TVar >::MultAdd(), TPZDohrMatrix< TVar, TSubStruct >::MultAdd(), TPZMatrix< STATE >::MultAdd(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::MultAdd(), TPZSkylMatrix< TVar >::MultAdd(), TPZTransfer< TVar >::MultAddScalar(), TPZDohrPrecond< TVar, TSubStruct >::MultAddTBB(), and TPZDohrMatrix< TVar, TSubStruct >::MultAddTBB().
|
inlinevirtual |
Definition at line 253 of file pzmatrix.h.
Referenced by TPZSpaceTimeRichardsEq::AnalysisOfParameters(), TPZPlasticStepPV< YC_t, ER_t >::ApplyLoad(), TPZElementMatrix::ApplyOneShapeConstraints(), TPZPlasticStepPV< YC_t, ER_t >::ApplyStrainComputeDep(), TPZDohrAssembly< STATE >::Assemble(), TPZDohrAssembly< STATE >::AssembleCoarse(), TPZInterpolationSpace::BuildTransferMatrix(), TPZNonLinMultGridAnalysis::CalcResidual(), TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZSBFemElementGroup::CalcStiff(), TPZCondensedCompEl::CalcStiff(), TPZElementGroup::CalcStiff(), CG(), CheckElement(), TPZSBFemVolume::ComputeKMatrices(), TPZSBFemElementGroup::ComputeMatrices(), TPZCompElHDiv< TSHAPE >::ComputeRequiredData(), TPZSBFemVolume::ComputeSolution(), TPZDohrPrecond< TVar, TSubStruct >::ComputeV1(), TPZDohrPrecond< TVar, TSubStruct >::ComputeV2(), TPZElasticityAxiMaterial::Contribute(), TPZMatPorous< T, TMEM >::Contribute(), TPZDohrSubstructCondense< TTVar >::Contribute_v2_local(), TPZDohrSubstruct< TVar >::Contribute_v2_local(), TPZSwelling::ContributeBC(), TPZEulerConsLaw::ContributeBCInterface(), TPZMaterialCoupling::ContributeInterface(), TPZElasticityAxiMaterial::ContributeInterface(), TPZEulerConsLaw::ContributeInterface(), TPZMaterialCoupling::ContributeInterface2(), TPZDohrSubstruct< TVar >::ContributeKU(), TPZDohrSubstructCondense< TTVar >::ContributeKULocal(), TPZDohrSubstruct< TVar >::ContributeKULocal(), TPZDohrSubstructCondense< TTVar >::ContributeRhs(), TPZStructMatrixBase::CreateAssemble(), TPZStructMatrixST::CreateAssemble(), TPZStructMatrixGCTP::CreateAssemble(), TPZStructMatrixGC::CreateAssemble(), TPZStructMatrixCS::CreateAssemble(), TPZStructMatrixTBBFlow::CreateAssemble(), TPZStructMatrixOT::CreateAssemble(), TPZExtendGridDimension::DeformMesh(), TPZTensor< STATE >::EigenSystemJacobi(), TPZMixedPoisson::Errors(), TPZDohrAssembly< STATE >::Extract(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::F1Red(), TPZMatHybrid::Flux(), TPZMaterialTest::Flux(), TPZElasticityAxiMaterial::Flux(), TPZElasticityMaterial::Flux(), TPZMixedElasticityMaterial::Flux(), TPZFrontMatrix< TVar, store, front >::GetFront(), TPZFMatrix< STATE >::GramSchmidt(), TPZDohrMatrix< TVar, TSubStruct >::Initialize(), TPZCompElHDiv< TSHAPE >::InitMaterialData(), TPZElastoPlasticAnalysis::IterativeProcess(), pzgeom::TPZGeoBlend< TGeo >::Jacobian(), TPZGeoEl::Jacobian(), TPZElastoPlasticAnalysis::LineSearch(), TPZSubMeshAnalysis::LoadSolution(), TPZEqnArray< TVar >::main(), TPZFrontSym< TVar >::main(), TPZFileEqnStorage< TVar >::main(), TEulerDiffusivity::main(), TPZFrontNonSym< TVar >::main(), TPZBlockDiagonal< STATE >::main(), TPZAxesTools< TVar >::main(), TPZSkylParMatrix< TVar >::main_nada(), pzgeom::TPZGeoBlend< TGeo >::MapToNeighSide(), TPZDohrPrecond< TVar, TSubStruct >::MultAdd(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::MultAdd(), TPZStructMatrixGCTP::MultiThread_Assemble(), TPZStructMatrixGC::MultiThread_Assemble(), TPZStructMatrixCS::MultiThread_Assemble(), TPZStructMatrixOT::MultiThread_Assemble(), TPZStructMatrixOR::MultiThread_Assemble(), TPZYCSandlerDimaggio::NewtonF1(), TPZYCSandlerDimaggio::NewtonF2(), TPZYCSandlerDimaggio::NewtonF2L(), TPZYCSandlerDimaggio::NewtonF3(), TPZStructMatrixCS::ThreadData::NextElement(), TPZMatOrthotropic::Normalize(), operator<<(), TPZPlasticStep< YC_t, TF_t, ER_t >::PlasticLoop(), TPZAnalysis::PostProcessErrorSerial(), TPZMatOrthotropic::Print(), TPZMaterialTest3D::Print(), TPZTransfer< TVar >::Print(), TPZMixedDarcyFlow::Print(), TPZSBMatrix< TVar >::Print(), TPZElementMatrix::Print(), TPZSYsmpMatrix< TVar >::Print(), TPZBlockDiagonal< STATE >::Print(), TPZMaterialData::Print(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::Print(), pzgeom::TPZArc3D::Print(), TPZConnect::Print(), TPZMatrix< STATE >::Print(), TPZBndCond::Print(), TPZAnalysis::Print(), TPZSBFemVolume::Print(), TPZGeoElMapped< TBase >::Print(), TPZMaterialData::PrintMathematica(), TPZPlasticStep< YC_t, TF_t, ER_t >::ProcessLoad(), PYBIND11_MODULE(), TPZInterpolatedElement::RestrainSide(), TPZMohrCoulombPV::ReturnMapRightEdge(), TPZMohrCoulombNeto::ReturnMapRightEdge(), TPZTransientAnalysis< TRANSIENTCLASS >::SaveCurrentSolutionVec(), TPZStructMatrixGCTP::Serial_Assemble(), TPZStructMatrixGC::Serial_Assemble(), TPZStructMatrixCS::Serial_Assemble(), TPZStructMatrixOT::Serial_Assemble(), TPZStructMatrixOR::Serial_Assemble(), TPZPairStructMatrix::SerialAssemble(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::SetF(), TPZSBFemVolume::Shape(), TPZElasticityAxiMaterial::Solution(), TPZAnalysis::Solve(), TPZMatrix< STATE >::Solve_LDLt(), TPZFrontMatrix< TVar, store, front >::SolveDirect(), TPZDohrSubstruct< TVar >::SolveSystemPhi(), TPZTensor< T >::TPZDecomposed::TangentCheckConv(), TPZPlasticStepPV< YC_t, ER_t >::TaylorCheck(), TPZSandlerExtended::TaylorCheckDtbkDsigtrial(), TPZGeoElMapped< TBase >::TGradX(), TPZStructMatrixOR::ThreadData::ThreadAssembly(), TPZStructMatrixOR::ThreadData::ThreadWork(), TPZPairStructMatrix::ThreadData::ThreadWork(), TPZStructMatrixGC::ThreadData::ThreadWork(), TPZStructMatrixCS::ThreadData::ThreadWork(), TPZStructMatrixOT::ThreadData::ThreadWork(), TPZStructMatrixGC::ThreadData::ThreadWorkResidual(), TPZStructMatrixOT::ThreadData::ThreadWorkResidual(), TPZMultPlaca::TPZMultPlaca(), TPZSubCompMesh::TransferMultiphysicsElementSolution(), TPZDohrSubstructCondense< TTVar >::UGlobal(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::UGlobal(), TPZAxesTools< TVar >::VerifyAxes(), and TPZConnect::~TPZConnect().
|
virtual |
It prints the matrix data in a MatrixFormat Rows X Cols.
Reimplemented in TPZMatRed< TVar, TSideMatrix >, TPZMatRed< STATE, TPZFMatrix< STATE > >, TPZMatRed< TVar, TPZFMatrix< TVar > >, TPZMatRed< TTVar, TPZFMatrix< TTVar > >, TPZBlockDiagonal< TVar >, TPZBlockDiagonal< STATE >, TPZFYsmpMatrix< TVar >, TPZSYsmpMatrix< TVar >, TPZDohrMatrix< TVar, TSubStruct >, TPZFrontMatrix< TVar, store, front >, TPZSBMatrix< TVar >, TPZTransfer< TVar >, TPZStencilMatrix< TVar >, and TPZSparseBlockDiagonal< TVar >.
Definition at line 270 of file pzmatrix.cpp.
void TPZMatrix< std::complex< float > >::Print | ( | const char * | name, |
std::ostream & | out, | ||
const MatrixOutputFormat | form | ||
) | const |
Definition at line 367 of file pzmatrix.cpp.
void TPZMatrix< std::complex< double > >::Print | ( | const char * | name, |
std::ostream & | out, | ||
const MatrixOutputFormat | form | ||
) | const |
Definition at line 432 of file pzmatrix.cpp.
void TPZMatrix< std::complex< long double > >::Print | ( | const char * | name, |
std::ostream & | out, | ||
const MatrixOutputFormat | form | ||
) | const |
Definition at line 500 of file pzmatrix.cpp.
|
inlinevirtual |
Put values with bounds checking if DEBUG variable is defined.
row | Row number. |
col | Column number. |
value | Value being put. |
Reimplemented in TPZSpMatrix< TVar >, TPZFBMatrix< TVar >, TPZBlockDiagonal< TVar >, TPZBlockDiagonal< STATE >, and TPZSparseBlockDiagonal< TVar >.
Definition at line 836 of file pzmatrix.h.
Referenced by pzshape::TPZShapeLinear::Chebyshev(), TPZMatrix< STATE >::CopyFrom(), pzshape::TPZShapeLinear::Expo(), pzshape::TPZShapeLinear::Hermite(), TPZMatrix< STATE >::Input(), pzshape::TPZShapeLinear::Jacobi(), pzshape::TPZShapeDisc::Legendre(), pzshape::TPZShapeLinear::Legendre(), and RotationMatrix().
|
virtual |
It puts submatrix Source on actual matrix structure.
sRow | Specifies starting row on current object |
sCol | Specifies starting column on current object. |
Source | The matrix to be inserted |
Definition at line 574 of file pzmatrix.cpp.
Referenced by TPZDohrSubstruct< TVar >::ContributeTestV1(), and TPZMatrix< STATE >::Zero().
|
inlinevirtual |
Put values without bounds checking
This method is faster than "Put" if DEBUG is defined.
Reimplemented in TPZSkylMatrix< TVar >, TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< STATE >, TPZFYsmpMatrix< TVar >, TPZMatRed< TVar, TSideMatrix >, TPZMatRed< STATE, TPZFMatrix< STATE > >, TPZMatRed< TVar, TPZFMatrix< TVar > >, TPZMatRed< TTVar, TPZFMatrix< TTVar > >, TPZSpMatrix< TVar >, TPZFBMatrix< TVar >, TPZSYsmpMatrix< TVar >, TPZSkylNSymMatrix< TVar >, TPZVerySparseMatrix< TVar >, TPZSFMatrix< TVar >, TPZBlockDiagonal< TVar >, TPZBlockDiagonal< STATE >, TPZSBMatrix< TVar >, TPZSSpMatrix< TVar >, and TPZSparseBlockDiagonal< TVar >.
Definition at line 154 of file pzmatrix.h.
Referenced by TPZMatrix< STATE >::Add(), TPZMatrix< STATE >::AddSub(), TPZBlock< STATE >::InsertBlock(), TPZMatrix< STATE >::InsertSub(), TPZMatrix< STATE >::Put(), TPZMatrix< STATE >::Substract(), TPZBlockDiagonal< STATE >::Transpose(), TPZFBMatrix< TVar >::Transpose(), TPZMatrix< STATE >::Transpose(), and TPZFMatrix< STATE >::Transpose().
|
overridevirtual |
Unpacks the object structure from a stream of bytes.
buf | The buffer containing the object in a packed form |
context |
Reimplemented from TPZSavable.
Reimplemented in TPZFNMatrix< 9, T >, TPZFNMatrix< 3, T >, TPZFNMatrix< 30, std::complex< double > >, TPZSkylMatrix< TVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, TPZDohrMatrix< TVar, TSubStruct >, TPZDohrMatrix< TVar, TSubStruct >, TPZDohrMatrix< TVar, TSubStruct >, TPZDohrMatrix< TVar, TSubStruct >, TPZMatRed< TVar, TPZFMatrix< TVar > >, TPZSkylNSymMatrix< TVar >, TPZDohrMatrix< TVar, TSubStruct >, TPZDohrPrecond< TVar, TSubStruct >, and TPZVerySparseMatrix< TVar >.
Definition at line 1413 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::Decompose(), main(), TPZDohrPrecond< TVar, TSubStruct >::Read(), TPZDohrMatrix< TVar, TSubStruct >::Read(), TPZSkylNSymMatrix< TVar >::Read(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::Read(), TPZFMatrix< STATE >::Read(), and TPZSkylMatrix< TVar >::Read().
|
inlinevirtual |
Redimensions the matrix reinitializing it with zero.
newRows | Specifies the new number of rows in matrix. |
newCols | Specifies the new number of Columns in matrix. |
Reimplemented in TPZSkylMatrix< TVar >, TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, TPZFMatrix< STATE >, TPZMatRed< TVar, TSideMatrix >, TPZMatRed< STATE, TPZFMatrix< STATE > >, TPZMatRed< TVar, TPZFMatrix< TVar > >, TPZMatRed< TTVar, TPZFMatrix< TTVar > >, TPZSpMatrix< TVar >, TPZFBMatrix< TVar >, TPZSFMatrix< TVar >, TPZSBMatrix< TVar >, and TPZSSpMatrix< TVar >.
Definition at line 289 of file pzmatrix.h.
Referenced by TPZMatrix< STATE >::Add(), TPZSubMeshAnalysis::Assemble(), TPZSkylMatrix< TVar >::AutoFill(), TPZCondensedCompEl::CalcStiff(), TPZYCMohrCoulombPV::ComputeLeftEdgeTangent(), TPZYCMohrCoulombPV::ComputePlaneTangent(), TPZYCMohrCoulombPV::ComputeRightEdgeTangent(), TPZMatrixMarket::Read(), TPZSBMatrix< TVar >::Redim(), TPZFBMatrix< TVar >::Redim(), TPZCondensedCompEl::Resequence(), and TPZMatRed< TTVar, TPZFMatrix< TTVar > >::Zero().
|
inlinevirtual |
Computes res = rhs - this * x.
Definition at line 827 of file pzmatrix.h.
Referenced by CheckConvergence(), TPZMatrix< STATE >::Cols(), TPZMatrix< STATE >::PutVal(), TPZMGAnalysis::Solve(), TPZAnalysis::Solve(), TPZFYsmpMatrix< TVar >::SolveJacobi(), TPZMatrix< STATE >::SolveJacobi(), TPZFYsmpMatrix< TVar >::SolveSOR(), TPZMatrix< STATE >::SolveSOR(), and TPZSkylMatrix< TVar >::SolveSOR().
|
inlinevirtual |
Redimensions a matriz keeping the previous values.
newRows | Specifies the new number of rows in matrix |
newCols | Specifies the new number of Columns in matrix |
Reimplemented in TPZSkylMatrix< TVar >, TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, TPZFMatrix< STATE >, TPZSpMatrix< TVar >, TPZFBMatrix< TVar >, TPZSFMatrix< TVar >, TPZSBMatrix< TVar >, and TPZSSpMatrix< TVar >.
Definition at line 278 of file pzmatrix.h.
Referenced by TPZSYsmpMatrix< TVar >::AutoFill(), TPZFYsmpMatrix< TVar >::AutoFill(), TPZMatrix< STATE >::AutoFill(), TPZSkylNSymMatrix< TVar >::AutoFill(), TPZDohrStructMatrix::Create(), TPZGenSubStruct::InitializeDohr(), TPZGenSubStruct::InitializeDohrCondense(), TPZFrontMatrix< TVar, store, front >::SetNumElConnected(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::SetReduced(), TPZMatrix< STATE >::Substract(), TPZBlockDiagonal< STATE >::Transpose(), TPZVerySparseMatrix< TVar >::Transpose(), TPZFBMatrix< TVar >::Transpose(), TPZMatrix< STATE >::Transpose(), and TPZFMatrix< STATE >::Transpose().
|
static |
Retorna o valor mais proximo a "val" (exceto valores no intervalo -tol <= val <= +tol) contido no vetor Vec.
Definition at line 1560 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::CompareValues(), TPZMatrix< STATE >::Decompose(), and TPZMatrix< STATE >::SolveEigensystemJacobi().
|
inline |
Returns number of rows.
Definition at line 803 of file pzmatrix.h.
Referenced by TPZHWTools::A2x2Inverse(), TPZHWTools::A3x3Inverse(), TPZPoroElastoPlasticAnalysis::AcceptSolution(), TPZMatrix< STATE >::Add(), TPZCheckRestraint::AddDependency(), TPZConnect::AddDependency(), TPZFMatrix< STATE >::AddFel(), TPZParFrontMatrix< TVar, store, front >::AddKel(), TPZFYsmpMatrix< TVar >::AddKel(), TPZMatrix< STATE >::AddKel(), TPZMatrix< STATE >::AddSub(), ParallelAssembleTaskMatrix< TVar, TSubStruct >::addWorkItem(), TPZInterpolatedElement::AdjustPreferredSideOrder(), AdjustSolutionDerivatives(), TPZProjectEllipse::AlmostZeroToZero(), TPZAnalysis::AnimateRun(), TPZCompElHDivPressure< TSHAPE >::Append(), TPZCompElHDiv< TSHAPE >::Append(), Append(), TPZCompElDisc::AppendExternalShapeFunctions(), TPZElementMatrix::ApplyConstraints(), TPZMatElastoPlastic2D< T, TMEM >::ApplyDeltaStrain(), TPZMatElastoPlastic2D< T, TMEM >::ApplyDeltaStrainComputeDep(), TPZElementMatrix::ApplyOneShapeConstraints(), TPZMultiphase::ApplyPN(), TPZMultiphase::ApplyQnD(), TPZMultiphase::ApplySigmaN(), TPZMultiphase::ApplySin(), TPZMultiphase::ApplySout(), TPZPorousElasticCriterion::ApplyStrainComputeSigma(), TPZElasticCriterion::ApplyStrainComputeSigma(), TPZPlasticStep< YC_t, TF_t, ER_t >::ApplyStrainComputeSigma(), TPZPlasticStepPV< YC_t, ER_t >::ApplyStrainComputeSigma(), TPZSandlerExtended::ApplyStrainComputeSigma(), TPZPlasticStepPV< YC_t, ER_t >::ApplyStressComputeStrain(), TPZMultiphase::ApplyUxD(), TPZMultiphase::ApplyUyD(), TPZTransientAnalysis< TRANSIENTCLASS >::Assemble(), TPZStructMatrixGCTP::Assemble(), TPZStructMatrixGC::Assemble(), TPZStructMatrixST::Assemble(), TPZStructMatrixCS::Assemble(), TPZStructMatrixTBBFlow::Assemble(), TPZStructMatrixOT::Assemble(), TPZStructMatrixOR::Assemble(), TPZAnalysis::Assemble(), TPZSBMatrix< TVar >::AutoFill(), TPZMatrix< STATE >::AutoFill(), TPZSkylNSymMatrix< TVar >::AutoFill(), TPZAxesTools< TVar >::Axes2XYZ(), TPZMHMixedMeshChannelControl::BuildComputationalMesh(), TPZMHMixedHybridMeshControl::BuildComputationalMesh(), TPZMHMixedMeshControl::BuildComputationalMesh(), TPZMHMeshControl::BuildComputationalMesh(), TPZBlockDiagonal< STATE >::BuildFromMatrix(), TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZCondensedCompEl::CalcResidual(), TPZSBFemElementGroup::CalcStiff(), TPZCondensedCompEl::CalcStiff(), TPZCheckMesh::CheckConstraintDimension(), CheckConvergence(), TPZConnect::CheckDependency(), TPZSBFemElementGroup::CoeficientsReal(), TPZSBFemVolume::CoeficientsReal(), TPZMatrix< STATE >::CompareValues(), TPZMatElastoPlastic2D< T, TMEM >::ComputeDeltaStrainVector(), TPZElementMatrix::ComputeDestinationIndices(), TPZSYsmpMatrix< TVar >::ComputeDiagonal(), TPZFYsmpMatrix< TVar >::ComputeDiagonal(), TPZTransientAnalysis< TRANSIENTCLASS >::ComputeFluxOnly(), TPZMaterialData::ComputeFunctionDivergence(), TPZGradientReconstruction::TPZGradientData::ComputeGradient(), TPZAxesTools< TVar >::ComputeGradX(), pztopology::TPZTriangle::ComputeHCurlDirections(), pztopology::TPZQuadrilateral::ComputeHCurlDirections(), TPZSBFemVolume::ComputeKMatrices(), TPZSBFemElementGroup::ComputeMatrices(), TPZSkylNSymMatrix< TVar >::ComputeMaxSkyline(), TPZSkylMatrix< TVar >::ComputeMaxSkyline(), TPZInterpolationSpace::ComputeRequiredData(), TPZCompElDisc::ComputeShape(), TPZMatElasticity2D::ComputeSigma(), TPZReducedSpace::ComputeSolution(), TPZSBFemVolume::ComputeSolution(), TPZCompElDisc::ComputeSolution(), TPZCompElHDiv< TSHAPE >::ComputeSolutionHDiv(), TPZCompElHDivPressure< TSHAPE >::ComputeSolutionPressureHDiv(), TPZSubMeshFrontalAnalysis::CondensedSolution(), TPZMatHybrid::Contribute(), TPZElast3Dnlinear::Contribute(), TPZLinearConvection::Contribute(), TPZViscoelastic::Contribute(), TPZPlaca::Contribute(), TPZMaterialTest::Contribute(), TPZMatOrthotropic::Contribute(), TPZMatPlaca2::Contribute(), TPZMaterialTest3D::Contribute(), TPZElasticity2DHybrid::Contribute(), TPZNonLinearPoisson3d::Contribute(), TPZBiharmonic::Contribute(), TPZMatHyperElastic::Contribute(), TPZConsLawTest::Contribute(), TPZEuler::Contribute(), TPZLinearConvecDiff::Contribute(), TPZNLMat1d::Contribute(), TPZNonLinBiharmonic::Contribute(), TPZElasticityHybridMaterial::Contribute(), TPZReynoldsFlow::Contribute(), TPZSpaceTimeRichardsEq::Contribute(), TPZMat2dLin::Contribute(), TPZMatDualHybridPoisson::Contribute(), TPZL2Projection::Contribute(), TPZMat1dLin::Contribute(), TPZMatElastoPlastic2D< T, TMEM >::Contribute(), TPZMultiphase::Contribute(), TPZIncNavierStokesKEps::Contribute(), TPZPrimalPoisson::Contribute(), TPZElasticityMaterial::Contribute(), TPZMixedPoissonParabolic::Contribute(), TPZTracerFlow::Contribute(), TPZMixedDarcyFlow::Contribute(), TPZElasticityAxiMaterial::Contribute(), TPZPostProcMat::Contribute(), TPZMatElastoPlastic< T, TMEM >::Contribute(), TPZBndCondWithMem< TMEM >::Contribute(), TPZElasticity3D::Contribute(), TPZMatPorous< T, TMEM >::Contribute(), TPZDualPoisson::Contribute(), TPZNullMaterial::Contribute(), TPZLagrangeMultiplier::Contribute(), TPZMatConvectionProblem::Contribute(), TPZMixedPoisson::Contribute(), TPZVecL2::Contribute(), TPZMatMixedPoisson3D::Contribute(), TPZMatLaplacian::Contribute(), TPZMixedElasticityMaterial::Contribute(), TPZMatPoisson3d::Contribute(), TPZMatElasticity2D::Contribute(), TPZMaterial::Contribute(), TPZDohrSubstructCondense< TTVar >::Contribute_v2_local(), TPZEulerConsLaw::ContributeApproxImplConvFace(), TPZMatHybrid::ContributeBC(), TPZElast3Dnlinear::ContributeBC(), TPZLinearConvection::ContributeBC(), TPZTransientMaterial< TBASEMAT >::ContributeBC(), TPZPlaca::ContributeBC(), TPZMaterialTest3D::ContributeBC(), TPZMatOrthotropic::ContributeBC(), TPZMaterialTest::ContributeBC(), TPZMatPlaca2::ContributeBC(), TPZElasticity2DHybrid::ContributeBC(), TPZLinearConvecDiff::ContributeBC(), TPZMatHyperElastic::ContributeBC(), TPZEuler::ContributeBC(), TPZNonLinearPoisson3d::ContributeBC(), TPZConsLawTest::ContributeBC(), TPZSpaceTimeRichardsEq::ContributeBC(), TPZBurger::ContributeBC(), TPZMat2dLin::ContributeBC(), TPZMatDualHybridPoisson::ContributeBC(), TPZReynoldsFlow::ContributeBC(), TPZMat1dLin::ContributeBC(), TPZPrimalPoisson::ContributeBC(), TPZMatElastoPlastic2D< T, TMEM >::ContributeBC(), TPZElasticityAxiMaterial::ContributeBC(), TPZMixedDarcyFlow::ContributeBC(), TPZMixedPoissonParabolic::ContributeBC(), TPZL2Projection::ContributeBC(), TPZDualPoisson::ContributeBC(), TPZNullMaterial::ContributeBC(), TPZElasticity3D::ContributeBC(), TPZElasticityMaterial::ContributeBC(), TPZMixedPoisson::ContributeBC(), TPZSwelling::ContributeBC(), TPZVecL2::ContributeBC(), TPZMatLaplacian::ContributeBC(), TPZMatElasticity2D::ContributeBC(), TPZMixedElasticityMaterial::ContributeBC(), TPZMatMixedPoisson3D::ContributeBC(), TPZMatPoisson3d::ContributeBC(), TPZEulerConsLaw::ContributeBC(), TPZMaterial::ContributeBC(), TPZMatLaplacian::ContributeBCHDiv(), TPZMatPoisson3d::ContributeBCHDiv(), TPZBurger::ContributeBCInterface(), TPZNonLinearPoisson3d::ContributeBCInterface(), TPZMultiphase::ContributeBCInterface(), TPZTracerFlow::ContributeBCInterface(), TPZBiharmonic::ContributeBCInterface(), TPZNonLinBiharmonic::ContributeBCInterface(), TPZMatConvectionProblem::ContributeBCInterface(), TPZDiscontinuousGalerkin::ContributeBCInterface(), TPZEulerEquation::ContributeBCInterface(), TPZMatLaplacian::ContributeBCInterface(), TPZMatPoisson3d::ContributeBCInterface(), TPZBiharmonicEstimator::ContributeErrorsSimple(), TPZEulerConsLaw::ContributeExplConvFace(), TPZEulerConsLaw::ContributeExplConvVol(), TPZEulerConsLaw::ContributeExplT1(), TPZEulerConsLaw::ContributeExplT2(), TPZBurger::ContributeGradStab(), TPZMatLaplacian::ContributeHDiv(), TPZMatPoisson3d::ContributeHDiv(), TPZEulerConsLaw::ContributeImplConvVol(), TPZEulerConsLaw::ContributeImplT1(), TPZMaterialCoupling::ContributeInterface(), TPZConsLawTest::ContributeInterface(), TPZHybridPoisson::ContributeInterface(), TPZNonLinearPoisson3d::ContributeInterface(), TPZMatDualHybridPoisson::ContributeInterface(), TPZBurger::ContributeInterface(), TPZMultiphase::ContributeInterface(), TPZTracerFlow::ContributeInterface(), TPZBiharmonic::ContributeInterface(), TPZElasticityAxiMaterial::ContributeInterface(), TPZNonLinBiharmonic::ContributeInterface(), TPZDiscontinuousGalerkin::ContributeInterface(), TPZMatConvectionProblem::ContributeInterface(), TPZLagrangeMultiplier::ContributeInterface(), TPZMatLaplacian::ContributeInterface(), TPZMatPoisson3d::ContributeInterface(), TPZBndCond::ContributeInterface(), TPZMaterialCoupling::ContributeInterface2(), TPZBiharmonicEstimator::ContributeInterfaceBCErrorsSimple(), TPZBiharmonicEstimator::ContributeInterfaceErrorsSimple(), TPZDohrSubstruct< TVar >::ContributeKU(), TPZDohrSubstructCondense< TTVar >::ContributeKULocal(), TPZDohrSubstruct< TVar >::ContributeKULocal(), TPZTransientMaterial< TBASEMAT >::ContributeSolutionRhs(), TPZBurger::ContributeSUPG(), TPZTransientMaterial< TBASEMAT >::ContributeTangent(), TPZDohrSubstruct< TVar >::ContributeTestV1(), TPZThermicElast3D::ContributeThermalStress(), TPZMatElasticity2D::ContributeVec(), TPZL2Projection::ContributeVecShape(), TPZElasticityMaterial::ContributeVecShape(), TPZMatMixedPoisson3D::ContributeWithoutSecondIntegration(), TPZInterpolationSpace::Convert2Axes(), TPZSBMatrix< TVar >::Copy(), TPZSFMatrix< TVar >::CopyFrom(), TPZMatrix< STATE >::CopyFrom(), TPZFMatrix< STATE >::CopyFrom(), CopyTo(), TPZSBandStructMatrix::CreateAssemble(), TPZBandStructMatrix::CreateAssemble(), TPZParSkylineStructMatrix::CreateAssemble(), TPZCompElPostProc< TCOMPEL >::dataequal(), TPZFMatrix< STATE >::Decompose_Cholesky(), TPZSkylMatrix< TVar >::Decompose_Cholesky(), TPZMatrix< STATE >::Decompose_Cholesky(), TPZSBMatrix< TVar >::Decompose_LDLt(), TPZFMatrix< STATE >::Decompose_LDLt(), TPZSkylMatrix< TVar >::Decompose_LDLt(), TPZMatrix< STATE >::Decompose_LDLt(), TPZFYsmpMatrix< TVar >::Decompose_LU(), TPZFMatrix< STATE >::Decompose_LU(), TPZMatrix< STATE >::Decompose_LU(), TPZEulerConsLaw::Det(), TPZFMatrix< STATE >::DeterminantInverse(), pzgeom::GPr< TFather, Topology >::Diagnostic(), TPZBlockDiagonal< STATE >::Dim(), TPZFBMatrix< TVar >::Dim(), TPZMatrix< STATE >::Dim(), TPZIncNavierStokesKEps::Dot(), Dot(), TPZMaterialTest3D::Errors(), TPZMatOrthotropic::Errors(), TPZMatDualHybridPoisson::Errors(), TPZMatLaplacian::Errors(), TPZMixedElasticityMaterial::Errors(), TPZVecL2::ErrorsHdiv(), TPZMatLaplacian::ErrorsHdiv(), TPZMatPoisson3d::ErrorsHdiv(), TPZMeshSolution::Execute(), TPZConnect::ExpandShape(), TPZSBFemVolume::ExtendShapeFunctions(), TPZSpMatrix< TVar >::fAdd(), TPZSpMatrix< TVar >::fCopy(), TPZMatElastoPlastic2D< T, TMEM >::FillBoundaryConditionDataRequirement(), TPZMixedElasticityMaterial::FillVecShapeIndex(), TPZSpMatrix< TVar >::fMult(), TPZTracerFlow::FractureFactor(), TPZSpMatrix< TVar >::fSub(), TPZFMatrix< STATE >::g(), TPZEquationFilter::Gather(), TPZSpMatrix< TVar >::Get(), TPZMatrix< STATE >::Get(), TPZMatrix< STATE >::GetSub(), TPZFMatrix< STATE >::GetVal(), pzgeom::TPZGeoCube::GradX(), pzgeom::TPZGeoQuad::GradX(), pzgeom::TPZQuadraticPrism::GradX(), pzgeom::TPZGeoLinear::GradX(), pzgeom::TPZGeoPrism::GradX(), pzgeom::TPZGeoTetrahedra::GradX(), pzgeom::TPZQuadraticPyramid::GradX(), pzgeom::TPZGeoPyramid::GradX(), pzgeom::TPZQuadraticCube::GradX(), pzgeom::TPZQuadraticTetra::GradX(), pzgeom::TPZGeoTriangle::GradX(), pzgeom::TPZWavyLine::GradX(), pzgeom::TPZQuadraticTrig::GradX(), pzgeom::TPZQuadraticLine::GradX(), pzgeom::TPZQuadraticQuad::GradX(), TPZGeoElSide::GradX(), pzgeom::TPZGeoBlend< TGeo >::GradX(), TPZFMatrix< STATE >::GramSchmidt(), TPZMatrix< STATE >::Identity(), TPZDohrMatrix< TVar, TSubStruct >::Initialize(), TPZElementGroup::InitializeElementMatrix(), TPZMixedElasticityMaterial::Inner(), InnerVecOfMat(), TPZMatrix< STATE >::Input(), TPZBlock< STATE >::InsertBlock(), TPZMatrix< STATE >::InsertSub(), TPZGradientReconstruction::TPZGradientData::InsertWeights(), TPZMatPoisson3d::InterfaceErrors(), TPZBndCond::InterfaceJump(), TPZMatrix< STATE >::Inverse(), TPZNonLinearAnalysis::IterativeProcess(), TPZElastoPlasticAnalysis::IterativeProcess(), TPZDiffusionConsLaw::JacobFlux(), pzgeom::TPZGeoTriangle::Jacobian(), pzgeom::GPr< TFather, Topology >::Jacobian(), pzgeom::TPZGeoBlend< TGeo >::Jacobian(), TPZGeoElSide::Jacobian(), TPZGeoEl::Jacobian(), TPZGeoEl::JacobianXYZ(), TPZProjectEllipse::LeastSquaresToGetEllipse(), TPZProjectEllipse::LeastSquaresToGetSimpleEllipse(), TPZProjectEllipse::LeastSquaresToGetVerySimpleEllipse(), TPZNonLinearAnalysis::LineSearch(), TPZCondensedCompEl::LoadSolution(), TPZSBFemElementGroup::LoadSolution(), TPZCompMesh::LoadSolution(), TPZMatPoisson3d::LocalNeumanContribute(), TPZSubCompMesh::MakeExternal(), pzgeom::TPZGeoBlend< TGeo >::MapToNeighSide(), pztopology::TPZCube::MapToSide(), pztopology::TPZQuadrilateral::MapToSide(), TPZMatrix< STATE >::MatrixNorm(), TPZFMatrix< STATE >::MemoryFootprint(), TPZBlockDiagonal< STATE >::MultAdd(), TPZSBMatrix< TVar >::MultAdd(), TPZTransfer< TVar >::MultAdd(), TPZFBMatrix< TVar >::MultAdd(), TPZSYsmpMatrix< TVar >::MultAdd(), TPZSkylNSymMatrix< TVar >::MultAdd(), TPZVerySparseMatrix< TVar >::MultAdd(), TPZDohrPrecond< TVar, TSubStruct >::MultAdd(), TPZFYsmpMatrix< TVar >::MultAdd(), TPZSpMatrix< TVar >::MultAdd(), TPZDohrMatrix< TVar, TSubStruct >::MultAdd(), TPZMatrix< STATE >::MultAdd(), TPZFMatrix< STATE >::MultAdd(), TPZSkylMatrix< TVar >::MultAdd(), TPZFYsmpMatrix< TVar >::MultAddMT(), TPZTransfer< TVar >::MultAddScalar(), TPZDohrPrecond< TVar, TSubStruct >::MultAddTBB(), TPZDohrMatrix< TVar, TSubStruct >::MultAddTBB(), TPZMatrix< STATE >::Multiply(), TPZFYsmpMatrix< TVar >::MultiplyDummy(), TPZSBFemElementGroup::MultiplyingCoeficients(), TPZTransfer< TVar >::MultiplyScalar(), NormalVector(), NormVecOfMat(), TPZMat2dLin::NStateVariables(), TPZMat1dLin::NStateVariables(), TPZFYsmpMatrix< TVar >::NumTerms(), TPZMatrix< STATE >::operator()(), TPZFMatrix< STATE >::operator()(), TPZGenAMatrix< TObj >::operator*(), operator*(), TPZFMatrix< STATE >::operator*(), TPZFMatrix< STATE >::operator*=(), TPZGenAMatrix< TObj >::operator+(), operator+(), TPZFMatrix< STATE >::operator+(), TPZFMatrix< STATE >::operator+=(), TPZGenAMatrix< TObj >::operator-(), operator-(), TPZFMatrix< STATE >::operator-(), TPZFMatrix< STATE >::operator-=(), TPZSFMatrix< TVar >::operator=(), TPZFYsmpMatrix< TVar >::operator=(), TPZFMatrix< STATE >::operator=(), TPZBiharmonicEstimator::OrderSolution(), TPZBiharmonicEstimator::OrderSolutionLeft(), TPZBiharmonicEstimator::OrderSolutionRight(), TPZCompMesh::Permute(), TPZSBFemElementGroup::PhiReal(), TPZSBFemVolume::PhiReal(), TPZArtDiff::PrepareFastDiff(), TPZMatrix< STATE >::PrepareZ(), TPZTransfer< TVar >::Print(), TPZSBMatrix< TVar >::Print(), TPZSYsmpMatrix< TVar >::Print(), TPZFYsmpMatrix< TVar >::Print(), TPZMatrix< STATE >::Print(), TPZSBFemVolume::Print(), TPZProjectEllipse::PrintAxes(), TPZYCCamClayPV::ProjectSigma(), TPZYCDruckerPragerPV::ProjectSigma(), TPZYCMohrCoulombPV::ProjectSigma(), TPZSandlerExtended::ProjectSigma(), TPZSpMatrix< TVar >::Put(), TPZMatrix< STATE >::Put(), TPZMatrix< STATE >::PutSub(), TPZFMatrix< STATE >::PutVal(), PYBIND11_MODULE(), TPZGradientReconstruction::TPZGradientData::QRFactorization(), TPZSkylNSymMatrix< TVar >::Read(), TPZSkylMatrix< TVar >::Read(), TPZCondensedCompEl::Resequence(), TPZSpMatrix< TVar >::Reset(), TPZGenMatrix< TObj >::Resize(), TPZSpMatrix< TVar >::Resize(), TPZFMatrix< STATE >::Resize(), TPZInterpolatedElement::RestrainSide(), TPZEulerAnalysis::RunNewton(), TPZVerySparseMatrix< TVar >::s(), TPZEquationFilter::Scatter(), TPZStructMatrixGCTP::Serial_Assemble(), TPZStructMatrixGC::Serial_Assemble(), TPZStructMatrixCS::Serial_Assemble(), TPZStructMatrixOT::Serial_Assemble(), TPZStructMatrixOR::Serial_Assemble(), TPZPairStructMatrix::SerialAssemble(), TPZTransfer< TVar >::SetBlockMatrix(), TPZSBFemElementGroup::SetComputeOnlyMassMatrix(), TPZFYsmpMatrix< TVar >::SetData(), pzgeom::TPZTriangleTorus::SetDataPhiTheta(), pzgeom::TPZQuadTorus::SetDataPhiTheta(), TPZEulerConsLaw::SetDelta(), TPZTransientAnalysis< TRANSIENTCLASS >::SetInitialSolution(), TPZTransientAnalysis< TRANSIENTCLASS >::SetInitialSolutionAsZero(), TPZMat2dLin::SetMaterial(), TPZTransform< T >::SetMatrix(), TPZMixedDarcyFlow::SetPermeability(), TPZMixedPoisson::SetPermeabilityTensor(), TPZMatMixedPoisson3D::SetPermeabilityTensor(), TPZFMatrix< STATE >::SetSize(), TPZSkylMatrix< TVar >::SetSkyline(), pzshape::SPr< TFather >::Shape(), pzshape::TPZShapeLinear::Shape(), TPZSBFemVolume::Shape(), pzshape::TPZShapeTriang::ShapeInternal(), pzshape::TPZShapeQuad::ShapeInternal(), TPZReducedSpace::ShapeX(), TPZCompElHDivBound2< TSHAPE >::SideShapeFunction(), TPZVerySparseMatrix< TVar >::Simetrize(), TPZMatrix< STATE >::Simetrize(), TPZSkylMatrix< TVar >::Size(), TPZMaterialTest3D::Solution(), TPZMatOrthotropic::Solution(), TPZBiharmonic::Solution(), TPZNonLinBiharmonic::Solution(), TPZMixedPoisson::Solution(), TPZMaterial::Solution(), TPZSequenceSolver< TVar >::Solve(), TPZMGAnalysis::Solve(), TPZMGSolver< TVar >::Solve(), TPZStepSolver< TVar >::Solve(), TPZEulerAnalysis::Solve(), TPZAnalysis::Solve(), TPZMatrix< STATE >::SolveEigensystemJacobi(), TPZMatrix< STATE >::SolveEigenvaluesJacobi(), TPZMatrix< STATE >::SolveGMRES(), TPZFYsmpMatrix< TVar >::SolveJacobi(), TPZFYsmpMatrix< TVar >::SolveSOR(), TPZSBMatrix< TVar >::Subst_Backward(), TPZSFMatrix< TVar >::Subst_Backward(), TPZSkylNSymMatrix< TVar >::Subst_Backward(), TPZSkylMatrix< TVar >::Subst_Backward(), TPZMatrix< STATE >::Subst_Backward(), TPZSSpMatrix< TVar >::Subst_Diag(), TPZSBMatrix< TVar >::Subst_Diag(), TPZSFMatrix< TVar >::Subst_Diag(), TPZSkylMatrix< TVar >::Subst_Diag(), TPZMatrix< STATE >::Subst_Diag(), TPZSSpMatrix< TVar >::Subst_Forward(), TPZSBMatrix< TVar >::Subst_Forward(), TPZSFMatrix< TVar >::Subst_Forward(), TPZSkylMatrix< TVar >::Subst_Forward(), TPZMatrix< STATE >::Subst_Forward(), TPZSBMatrix< TVar >::Subst_LBackward(), TPZSFMatrix< TVar >::Subst_LBackward(), TPZSkylMatrix< TVar >::Subst_LBackward(), TPZMatrix< STATE >::Subst_LBackward(), TPZSSpMatrix< TVar >::Subst_LForward(), TPZSBMatrix< TVar >::Subst_LForward(), TPZSFMatrix< TVar >::Subst_LForward(), TPZSkylNSymMatrix< TVar >::Subst_LForward(), TPZSkylMatrix< TVar >::Subst_LForward(), TPZMatrix< STATE >::Subst_LForward(), TPZFYsmpMatrix< TVar >::Substitution(), TPZFMatrix< STATE >::Substitution(), TPZMatrix< STATE >::Substitution(), TPZMatrix< STATE >::Substract(), TPZDohrThreadMultList< TVar, TSubStruct >::ThreadWork(), TPZBlock< STATE >::TPZBlock(), TPZCheckConvergence(), TPZGenMatrix< TObj >::TPZGenMatrix(), TPZTensor< STATE >::TPZTensor(), TPZMixedElasticityMaterial::Tr(), TPZSubCompMesh::TransferDependencies(), TPZTransfer< TVar >::TransferResidual(), TPZTransfer< TVar >::TransferSolution(), TPZVerySparseMatrix< TVar >::Transpose(), TPZGenAMatrix< TObj >::Transpose(), TPZFBMatrix< TVar >::Transpose(), TPZMatrix< STATE >::Transpose(), TPZFMatrix< STATE >::Transpose(), TPZBndCond::UpdateBCValues(), TPZCoupledTransportDarcyBC::UpdateConvectionDirInterface(), TPZCoupledTransportDarcy::UpdateConvectionDirInterface(), TPZCompMesh::UpdatePreviousState(), TPZAxesTools< TVar >::VerifyAxes(), TPZInterpolatedElement::VerifyConstraintConsistency(), TPZMatrix< STATE >::VerifySymmetry(), VisualMatrixDX(), VisualMatrixVTK(), TPZSkylNSymMatrix< TVar >::Write(), TPZSkylMatrix< TVar >::Write(), pzgeom::TPZGeoQuad::X(), pzgeom::TPZGeoCube::X(), pzgeom::TPZQuadraticPrism::X(), pzgeom::TPZGeoLinear::X(), pzgeom::TPZGeoPrism::X(), pzgeom::TPZGeoTriangle::X(), pzgeom::TPZQuadraticPyramid::X(), pzgeom::TPZGeoTetrahedra::X(), pzgeom::TPZGeoPyramid::X(), pzgeom::TPZQuadraticCube::X(), pzgeom::TPZQuadraticTetra::X(), pzgeom::TPZGeoPoint::X(), pzgeom::GPr< TFather, Topology >::X(), pzgeom::TPZQuadraticQuad::X(), and TPZAxesTools< TVar >::XYZ2Axes().
|
inlinevirtual |
The operators check on the bounds if the DEBUG variable is defined.
row | Row number. |
col | Column number. |
Reimplemented in TPZSkylMatrix< TVar >, TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, TPZFMatrix< STATE >, TPZSkylNSymMatrix< TVar >, TPZMatRed< TVar, TSideMatrix >, TPZMatRed< STATE, TPZFMatrix< STATE > >, TPZMatRed< TVar, TPZFMatrix< TVar > >, TPZMatRed< TTVar, TPZFMatrix< TTVar > >, TPZFBMatrix< TVar >, TPZVerySparseMatrix< TVar >, TPZBlockDiagonal< TVar >, TPZBlockDiagonal< STATE >, and TPZSparseBlockDiagonal< TVar >.
Definition at line 879 of file pzmatrix.h.
Referenced by TPZMatrix< STATE >::g(), TPZMatrix< STATE >::operator()(), TPZSequenceSolver< TVar >::ResetMatrix(), TPZSequenceSolver< TVar >::ResetSolver(), TPZSequenceSolver< TVar >::Solve(), TPZSequenceSolver< TVar >::TPZSequenceSolver(), and TPZSequenceSolver< TVar >::UpdateFrom().
|
inline |
Sets current matrix to decomposed state.
Definition at line 410 of file pzmatrix.h.
Referenced by TPZSYsmpMatrix< TVar >::AutoFill(), TPZCondensedCompEl::CalcStiff(), TPZFYsmpMatrix< TVar >::Decompose_LU(), and TPZSFMatrix< TVar >::operator=().
|
virtual |
Simetrizes copies upper plan to the lower plan, making its data simetric.
Reimplemented in TPZVerySparseMatrix< TVar >.
Definition at line 90 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::IsSquare().
|
inlinevirtual |
Solves the linear system using Cholesky method
.
B | The right hand side of the system and where the solution is stored. |
Definition at line 919 of file pzmatrix.h.
Referenced by TPZMatrix< STATE >::Decompose(), and TPZMatrix< STATE >::SolveDirect().
|
inline |
Solves the linear system using Cholesky method
.
B | The right hand side of the system and where the solution is stored. |
singular |
Definition at line 927 of file pzmatrix.h.
int TPZMatrix< TVar >::Solve_LDLt | ( | TPZFMatrix< TVar > * | B, |
std::list< int64_t > & | singular | ||
) |
Solves the linear system using LDLt method
.
B | The right hand side of the system and where the solution is stored. |
singular |
Definition at line 1993 of file pzmatrix.cpp.
Referenced by TPZElasticCriterion::ApplyLoad(), TPZMatrix< STATE >::Decompose(), and TPZMatrix< STATE >::SolveDirect().
|
inline |
Solves the linear system using LDLt method
.
B | The right hand side of the system and where the solution is stored. |
Definition at line 937 of file pzmatrix.h.
|
inline |
Solves the linear system using LU method
.
B | The right hand side of the system and where the solution is stored. |
singular |
Definition at line 900 of file pzmatrix.h.
Referenced by TPZPlasticStepPV< YC_t, ER_t >::ApplyLoad(), TPZCompElPostProc< TCOMPEL >::CalcResidual(), TPZMatrix< STATE >::Decompose(), TPZFMatrix< STATE >::DeterminantInverse(), TPZBlockDiagonal< STATE >::main(), TPZSandlerExtended::ProjectBetaConstF2(), TPZSandlerExtended::ProjectRing(), TPZYCDruckerPragerPV::ProjectSigmaDep(), TPZYCCamClayPV::ProjectToSurface(), TPZYCCamClayPV::ProjectToSurfaceConstantBeta(), TPZYCDruckerPragerPV::ProjectToSurfaceF1(), TPZMatrix< STATE >::SolveDirect(), TPZMatrix< STATE >::SolveEigensystemJacobi(), and TPZSandlerExtended::TaylorCheckDtbkDsigtrial().
|
inline |
Solves the linear system using LU method
.
B | The right hand side of the system and where the solution is stored. |
Definition at line 907 of file pzmatrix.h.
|
virtual |
Solves the linear system using Bi-Conjugate Gradient method.
.
numiterations | The number of interations for the process. |
preconditioner | The preconditioner attribute used. |
F | The right hand side of the system. |
result | The solution. |
tol | The tolerance value. |
Definition at line 974 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::SetIsDecomposed(), and TPZMatrix< STATE >::SolveBICG().
void TPZMatrix< std::complex< float > >::SolveBICG | ( | int64_t & | numiterations, |
TPZSolver< std::complex< float > > & | preconditioner, | ||
const TPZFMatrix< std::complex< float > > & | F, | ||
TPZFMatrix< std::complex< float > > & | result, | ||
REAL & | tol | ||
) |
Definition at line 999 of file pzmatrix.cpp.
void TPZMatrix< std::complex< double > >::SolveBICG | ( | int64_t & | numiterations, |
TPZSolver< std::complex< double > > & | preconditioner, | ||
const TPZFMatrix< std::complex< double > > & | F, | ||
TPZFMatrix< std::complex< double > > & | result, | ||
REAL & | tol | ||
) |
Definition at line 1007 of file pzmatrix.cpp.
void TPZMatrix< std::complex< long double > >::SolveBICG | ( | int64_t & | numiterations, |
TPZSolver< std::complex< long double > > & | preconditioner, | ||
const TPZFMatrix< std::complex< long double > > & | F, | ||
TPZFMatrix< std::complex< long double > > & | result, | ||
REAL & | tol | ||
) |
Definition at line 1015 of file pzmatrix.cpp.
|
virtual |
Solves the linear system using Bi-Conjugate Gradient stabilized method.
.
numiterations | The number of interations for the process. |
preconditioner | The preconditioner attribute used. |
F | The right hand side of the system. |
result | The solution. |
residual | Returns F - A*U which is the solution residual. |
tol | The tolerance value. |
FromCurrent | It starts the solution based on FromCurrent. |
Definition at line 1024 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::SetIsDecomposed(), and TPZMatrix< STATE >::SolveBICGStab().
void TPZMatrix< std::complex< float > >::SolveBICGStab | ( | int64_t & | numiterations, |
TPZSolver< std::complex< float > > & | preconditioner, | ||
const TPZFMatrix< std::complex< float > > & | F, | ||
TPZFMatrix< std::complex< float > > & | result, | ||
TPZFMatrix< std::complex< float > > * | residual, | ||
REAL & | tol, | ||
const int | FromCurrent | ||
) |
Definition at line 1046 of file pzmatrix.cpp.
void TPZMatrix< std::complex< double > >::SolveBICGStab | ( | int64_t & | numiterations, |
TPZSolver< std::complex< double > > & | preconditioner, | ||
const TPZFMatrix< std::complex< double > > & | F, | ||
TPZFMatrix< std::complex< double > > & | result, | ||
TPZFMatrix< std::complex< double > > * | residual, | ||
REAL & | tol, | ||
const int | FromCurrent | ||
) |
Definition at line 1053 of file pzmatrix.cpp.
void TPZMatrix< std::complex< long double > >::SolveBICGStab | ( | int64_t & | numiterations, |
TPZSolver< std::complex< long double > > & | preconditioner, | ||
const TPZFMatrix< std::complex< long double > > & | F, | ||
TPZFMatrix< std::complex< long double > > & | result, | ||
TPZFMatrix< std::complex< long double > > * | residual, | ||
REAL & | tol, | ||
const int | FromCurrent | ||
) |
Definition at line 1060 of file pzmatrix.cpp.
|
virtual |
Solves the linear system using Conjugate Gradient method.
.
numiterations | The number of interations for the process. |
preconditioner | The preconditioner attribute used. |
F | The right hand side of the system. |
result | The solution. |
residual | Returns F - A*U which is the solution residual. |
tol | The tolerance value. |
FromCurrent | It starts the solution based on FromCurrent. |
Definition at line 850 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::SetIsDecomposed(), and TPZMatrix< STATE >::SolveCG().
void TPZMatrix< std::complex< float > >::SolveCG | ( | int64_t & | numiterations, |
TPZSolver< std::complex< float > > & | preconditioner, | ||
const TPZFMatrix< std::complex< float > > & | F, | ||
TPZFMatrix< std::complex< float > > & | result, | ||
TPZFMatrix< std::complex< float > > * | residual, | ||
REAL & | tol, | ||
const int | FromCurrent | ||
) |
Definition at line 873 of file pzmatrix.cpp.
void TPZMatrix< std::complex< double > >::SolveCG | ( | int64_t & | numiterations, |
TPZSolver< std::complex< double > > & | preconditioner, | ||
const TPZFMatrix< std::complex< double > > & | F, | ||
TPZFMatrix< std::complex< double > > & | result, | ||
TPZFMatrix< std::complex< double > > * | residual, | ||
REAL & | tol, | ||
const int | FromCurrent | ||
) |
Definition at line 880 of file pzmatrix.cpp.
void TPZMatrix< std::complex< long double > >::SolveCG | ( | int64_t & | numiterations, |
TPZSolver< std::complex< long double > > & | preconditioner, | ||
const TPZFMatrix< std::complex< long double > > & | F, | ||
TPZFMatrix< std::complex< long double > > & | result, | ||
TPZFMatrix< std::complex< long double > > * | residual, | ||
REAL & | tol, | ||
const int | FromCurrent | ||
) |
Definition at line 887 of file pzmatrix.cpp.
|
virtual |
Solves the linear system using Direct methods.
F | The right hand side of the system and where the solution is stored. |
dt | Indicates type of decomposition |
singular |
Reimplemented in TPZFrontMatrix< TVar, store, front >.
Definition at line 710 of file pzmatrix.cpp.
Referenced by TPZInterpolationSpace::BuildTransferMatrix(), TPZInterpolatedElement::BuildTransferMatrix(), TPZCompElDisc::BuildTransferMatrix(), TPZCondensedCompEl::CalcStiff(), TPZFrontMatrix< TVar, store, front >::Clone(), TPZGradientReconstruction::TPZGradientData::ComputeGradient(), TPZGeoEl::ComputeParamTrans(), TPZRefPattern::ComputeParamTransform(), TPZGeoEl::ComputeXInverse(), TPZSwelling::ContributeBC(), TPZInterpolationSpace::InterpolateSolution(), TPZMatrix< STATE >::Inverse(), TPZProjectEllipse::LeastSquaresToGetEllipse(), TPZProjectEllipse::LeastSquaresToGetSimpleEllipse(), TPZProjectEllipse::LeastSquaresToGetVerySimpleEllipse(), TPZFrontSym< TVar >::main(), TPZFrontNonSym< TVar >::main(), TPZYCSandlerDimaggio::NewtonF2(), TPZYCSandlerDimaggio::NewtonF2L(), TPZYCSandlerDimaggio::NewtonF3(), TPZAgglomerateElement::ProjectSolution(), TPZMatrix< STATE >::SetIsDecomposed(), and TPZMatRed< TTVar, TPZFMatrix< TTVar > >::U1().
|
virtual |
Solves the linear system using Direct methods.
F | The right hand side of the system and where the solution is stored. |
dt | Indicates type of decomposition |
Definition at line 726 of file pzmatrix.cpp.
|
virtual |
Compute Eigenvalues and Eigenvectors of this matrix.
This method is efficient only for small matrices.
numiterations | The number of interations for the process. |
tol | The tolerance value. |
Eigenvalues | ordered from big to small |
Eigenvectors | each row represent one eigenvector. It is in same order of eigenvalues. |
Making a copy of this
Compute Eigenvalues
Compute Eigenvectors
Normalizing Initial Eigenvec
Estimating Eigenvec
Normalizing Final Eigenvec
Copy values from AuxVector to Eigenvectors
Definition at line 1583 of file pzmatrix.cpp.
Referenced by TPZTensor< STATE >::EigenSystemJacobi(), TPZMatElastoPlastic< T, TMEM >::EigenVectors(), TPZElasticity3D::PrincipalDirection(), TPZMatrix< STATE >::ReturnNearestValue(), and TPZMatrix< STATE >::SetIsDecomposed().
|
virtual |
Transforms this matrix in a diagonal matrix, where the diagonal values are its eigenvalues. This method is efficient only for small matrices.
numiterations | The number of interations for the process. |
tol | The tolerance value. |
Sort | diagonal values from big to small |
First of all find the max value off diagonal
Check if max value off diagonal is lesser than required tolerance
Compute angle of rotation
Apply rotation
Sorting
Definition at line 1727 of file pzmatrix.cpp.
Referenced by TPZMatElastoPlastic< T, TMEM >::EigenValues(), TPZMatrix< STATE >::MatrixNorm(), TPZMatrix< STATE >::SetIsDecomposed(), TPZViscoelastic::Solution(), TPZElasticity3D::Solution(), TPZMatrix< STATE >::SolveEigensystemJacobi(), and TPZMatrix< STATE >::SolveEigenvaluesJacobi().
bool TPZMatrix< std::complex< float > >::SolveEigenvaluesJacobi | ( | int64_t & | numiterations, |
REAL & | tol, | ||
TPZVec< std::complex< float > > * | Sort | ||
) |
Definition at line 1701 of file pzmatrix.cpp.
bool TPZMatrix< std::complex< double > >::SolveEigenvaluesJacobi | ( | int64_t & | numiterations, |
REAL & | tol, | ||
TPZVec< std::complex< double > > * | Sort | ||
) |
Definition at line 1707 of file pzmatrix.cpp.
bool TPZMatrix< std::complex< long double > >::SolveEigenvaluesJacobi | ( | int64_t & | numiterations, |
REAL & | tol, | ||
TPZVec< std::complex< long double > > * | Sort | ||
) |
Definition at line 1713 of file pzmatrix.cpp.
|
virtual |
Solves the linear system using Generalized Minimal Residual (GMRES) method.
.
numiterations | The number of interations for the process. |
preconditioner | The preconditioner attribute used. |
H | The right hand side of the system |
numvectors | The number of vectors involved |
F | The right hand side of the system. |
result | The solution. |
residual | Returns F - A*U which is the solution residual. |
tol | The tolerance value. |
FromCurrent | It starts the solution based on FromCurrent. Obtaining solution FromCurrent + 1. |
Definition at line 896 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::SetIsDecomposed(), and TPZMatrix< STATE >::SolveGMRES().
void TPZMatrix< std::complex< float > >::SolveGMRES | ( | int64_t & | numiterations, |
TPZSolver< std::complex< float > > & | preconditioner, | ||
TPZFMatrix< std::complex< float > > & | H, | ||
int & | numvectors, | ||
const TPZFMatrix< std::complex< float > > & | F, | ||
TPZFMatrix< std::complex< float > > & | result, | ||
TPZFMatrix< std::complex< float > > * | residual, | ||
REAL & | tol, | ||
const int | FromCurrent | ||
) |
Definition at line 945 of file pzmatrix.cpp.
void TPZMatrix< std::complex< double > >::SolveGMRES | ( | int64_t & | numiterations, |
TPZSolver< std::complex< double > > & | preconditioner, | ||
TPZFMatrix< std::complex< double > > & | H, | ||
int & | numvectors, | ||
const TPZFMatrix< std::complex< double > > & | F, | ||
TPZFMatrix< std::complex< double > > & | result, | ||
TPZFMatrix< std::complex< double > > * | residual, | ||
REAL & | tol, | ||
const int | FromCurrent | ||
) |
Definition at line 954 of file pzmatrix.cpp.
void TPZMatrix< std::complex< long double > >::SolveGMRES | ( | int64_t & | numiterations, |
TPZSolver< std::complex< long double > > & | preconditioner, | ||
TPZFMatrix< std::complex< long double > > & | H, | ||
int & | numvectors, | ||
const TPZFMatrix< std::complex< long double > > & | F, | ||
TPZFMatrix< std::complex< long double > > & | result, | ||
TPZFMatrix< std::complex< long double > > * | residual, | ||
REAL & | tol, | ||
const int | FromCurrent | ||
) |
Definition at line 963 of file pzmatrix.cpp.
|
virtual |
Solves the linear system using IR method.
.
numiterations | The number of interations for the process. |
preconditioner | The preconditioner attribute used. |
F | The right hand side of the system. |
result | The solution. |
residual | Returns F - A*U which is the solution residual. |
tol | The tolerance value. |
FromCurrent | It starts the solution based on FromCurrent. Obtaining solution FromCurrent + 1. |
Definition at line 1070 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::SetIsDecomposed(), and TPZMatrix< STATE >::SolveIR().
void TPZMatrix< std::complex< float > >::SolveIR | ( | int64_t & | numiterations, |
TPZSolver< std::complex< float > > & | preconditioner, | ||
const TPZFMatrix< std::complex< float > > & | F, | ||
TPZFMatrix< std::complex< float > > & | result, | ||
TPZFMatrix< std::complex< float > > * | residual, | ||
REAL & | tol, | ||
const int | FromCurrent | ||
) |
Definition at line 1095 of file pzmatrix.cpp.
void TPZMatrix< std::complex< double > >::SolveIR | ( | int64_t & | numiterations, |
TPZSolver< std::complex< double > > & | preconditioner, | ||
const TPZFMatrix< std::complex< double > > & | F, | ||
TPZFMatrix< std::complex< double > > & | result, | ||
TPZFMatrix< std::complex< double > > * | residual, | ||
REAL & | tol, | ||
const int | FromCurrent | ||
) |
Definition at line 1103 of file pzmatrix.cpp.
void TPZMatrix< std::complex< long double > >::SolveIR | ( | int64_t & | numiterations, |
TPZSolver< std::complex< long double > > & | preconditioner, | ||
const TPZFMatrix< std::complex< long double > > & | F, | ||
TPZFMatrix< std::complex< long double > > & | result, | ||
TPZFMatrix< std::complex< long double > > * | residual, | ||
REAL & | tol, | ||
const int | FromCurrent | ||
) |
Definition at line 1111 of file pzmatrix.cpp.
|
virtual |
Solves the linear system using Jacobi method.
.
For symmetric decompositions lower triangular matrix is used.
Solves a system A*X = B returning X in B
numiterations | The number of interations for the process. |
F | The right hand side of the system. |
result | The solution. |
residual | Returns F - A*U which is the solution residual. |
scratch | Available manipulation area on memory. |
tol | The tolerance value. |
FromCurrent | It starts the solution based on FromCurrent. Obtaining solution FromCurrent + 1. |
Reimplemented in TPZFYsmpMatrix< TVar >.
Definition at line 743 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::SetIsDecomposed().
|
virtual |
Solves the linear system using Successive Over Relaxation method (Gauss Seidel).
.
numiterations | The number of interations for the process. |
F | The right hand side of the system. |
result | The solution. |
residual | Returns F - A*U which is the solution residual. |
scratch | Available manipulation area on memory. |
overrelax | The over relaxation parameter |
tol | The tolerance value.. |
FromCurrent | It starts the solution based on FromCurrent. Obtaining solution FromCurrent + 1. |
direction | Indicates interaction direction, from first to last (default 1) or from last to first (-1) |
Reimplemented in TPZSkylMatrix< TVar >, and TPZFYsmpMatrix< TVar >.
Definition at line 785 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::SetIsDecomposed(), TPZMatrix< STATE >::SolveJacobi(), and TPZMatrix< STATE >::SolveSSOR().
|
virtual |
Solves the linear system using Symmetric Successive Over Relaxation method (Gauss Seidel).
.
numiterations | The number of interations for the process. |
F | The right hand side of the system. |
result | The solution. |
residual | Returns F - A*U which is the solution residual. |
scratch | Available manipulation area on memory. |
overrelax | The over relaxation parameter |
tol | The tolerance value.. |
FromCurrent | It starts the solution based on FromCurrent. Obtaining solution FromCurrent + 1. |
Definition at line 828 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::SetIsDecomposed().
|
virtual |
Computes B = Y, where A*Y = B, A is upper triangular.
b | right hand side and result after all |
Reimplemented in TPZSkylMatrix< TVar >, TPZFrontMatrix< TVar, store, front >, TPZSkylNSymMatrix< TVar >, TPZSFMatrix< TVar >, and TPZSBMatrix< TVar >.
Definition at line 1309 of file pzmatrix.cpp.
Referenced by TPZSYsmpMatrix< TVar >::AutoFill(), TPZFrontMatrix< TVar, store, front >::Clone(), TPZMatrix< STATE >::Decompose(), TPZFMatrix< STATE >::Decompose_LDLt(), TPZSYsmpMatrix< TVar >::JA(), TPZSubMeshFrontalAnalysis::LoadSolution(), TPZFMatrix< STATE >::operator-=(), TPZMatrix< STATE >::Solve_Cholesky(), and TPZSBMatrix< TVar >::Subst_Backward().
|
virtual |
Computes B = Y, where A*Y = B, A is diagonal matrix.
b | right hand side and result after all |
Reimplemented in TPZSkylMatrix< TVar >, TPZSFMatrix< TVar >, TPZSBMatrix< TVar >, and TPZSSpMatrix< TVar >.
Definition at line 1384 of file pzmatrix.cpp.
Referenced by TPZSYsmpMatrix< TVar >::AutoFill(), TPZMatrix< STATE >::Decompose(), TPZFMatrix< STATE >::Decompose_LDLt(), TPZSYsmpMatrix< TVar >::JA(), TPZFMatrix< STATE >::operator-=(), and TPZMatrix< STATE >::Solve_LDLt().
|
virtual |
Computes B = Y, where A*Y = B, A is lower triangular.
b | right hand side and result after all |
Reimplemented in TPZSkylMatrix< TVar >, TPZFrontMatrix< TVar, store, front >, TPZSFMatrix< TVar >, TPZSBMatrix< TVar >, and TPZSSpMatrix< TVar >.
Definition at line 1284 of file pzmatrix.cpp.
Referenced by TPZSYsmpMatrix< TVar >::AutoFill(), TPZFrontMatrix< TVar, store, front >::Clone(), TPZMatrix< STATE >::Decompose(), TPZFMatrix< STATE >::Decompose_LDLt(), TPZSYsmpMatrix< TVar >::JA(), TPZEqnArray< TVar >::main(), TPZFMatrix< STATE >::operator-=(), TPZSubMeshFrontalAnalysis::Run(), TPZMatrix< STATE >::Solve_Cholesky(), and TPZSBMatrix< TVar >::Subst_Forward().
|
virtual |
Computes B = Y, where A*Y = B, A is upper triangular with A(i,i)=1.
b | right hand side and result after all |
Reimplemented in TPZSkylMatrix< TVar >, TPZSFMatrix< TVar >, and TPZSBMatrix< TVar >.
Definition at line 1358 of file pzmatrix.cpp.
Referenced by TPZSYsmpMatrix< TVar >::AutoFill(), TPZMatrix< STATE >::Decompose(), TPZFMatrix< STATE >::Decompose_LDLt(), TPZSYsmpMatrix< TVar >::JA(), TPZFMatrix< STATE >::operator-=(), and TPZMatrix< STATE >::Solve_LDLt().
|
virtual |
Computes B = Y, where A*Y = B, A is lower triangular with A(i,i)=1.
b | right hand side and result after all |
Reimplemented in TPZSkylMatrix< TVar >, TPZSkylNSymMatrix< TVar >, TPZSFMatrix< TVar >, TPZSBMatrix< TVar >, and TPZSSpMatrix< TVar >.
Definition at line 1333 of file pzmatrix.cpp.
Referenced by TPZSYsmpMatrix< TVar >::AutoFill(), TPZMatrix< STATE >::Decompose(), TPZFMatrix< STATE >::Decompose_LDLt(), TPZSYsmpMatrix< TVar >::JA(), TPZFMatrix< STATE >::operator-=(), and TPZMatrix< STATE >::Solve_LDLt().
|
virtual |
Computes Forward and Backward substitution for a "LU" decomposed matrix.
B | right hand side and result after all |
Reimplemented in TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< STATE >, TPZFYsmpMatrix< TVar >, TPZFrontMatrix< TVar, store, front >, TPZBlockDiagonal< TVar >, TPZBlockDiagonal< STATE >, TPZSparseBlockDiagonal< TVar >, TPZSpBlockDiagPivot< TVar >, and TPZFBMatrix< TVar >.
Definition at line 1151 of file pzmatrix.cpp.
Referenced by TPZFrontMatrix< TVar, store, front >::Clone(), TPZMatrix< STATE >::Decompose(), TPZMatrix< STATE >::Solve_LU(), and TPZFBMatrix< TVar >::Substitution().
|
virtual |
It substracts A from storing the result in result.
Definition at line 75 of file pzmatrix.cpp.
Referenced by operator-(), and TPZMatrix< STATE >::PutVal().
|
inlinestaticprotected |
Swaps contents of a in b and b in a.
Definition at line 949 of file pzmatrix.h.
Referenced by TPZSkylMatrix< TVar >::AddKel(), TPZMatrix< STATE >::Clear(), TPZSSpMatrix< TVar >::GetVal(), TPZSFMatrix< TVar >::GetVal(), TPZSBMatrix< TVar >::GetVal(), TPZSkylMatrix< TVar >::GetVal(), TPZSBMatrix< TVar >::operator()(), TPZSkylMatrix< TVar >::operator()(), TPZSSpMatrix< TVar >::PutVal(), TPZSFMatrix< TVar >::PutVal(), TPZSBMatrix< TVar >::PutVal(), and TPZSkylMatrix< TVar >::PutVal().
It makes *T the transpose of current matrix.
Reimplemented in TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< STATE >, TPZFBMatrix< TVar >, TPZVerySparseMatrix< TVar >, TPZBlockDiagonal< TVar >, and TPZBlockDiagonal< STATE >.
Definition at line 697 of file pzmatrix.cpp.
Referenced by TPZMatrix< STATE >::PutVal(), and TPZVerySparseMatrix< TVar >::Transpose().
|
inlinevirtual |
Updates the values of the matrix based on the values of the matrix.
Reimplemented in TPZSkylMatrix< TVar >, TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< STATE >, TPZSkylNSymMatrix< TVar >, TPZBlockDiagonal< TVar >, TPZBlockDiagonal< STATE >, and TPZSparseBlockDiagonal< TVar >.
Definition at line 387 of file pzmatrix.h.
|
virtual |
Checks if current matrix value is symmetric.
Definition at line 1501 of file pzmatrix.cpp.
Referenced by TPZNonLinearPoisson3d::Contribute(), TPZElasticity3D::Contribute(), TPZMatLaplacian::Contribute(), TPZMatPoisson3d::Contribute(), TPZNonLinearPoisson3d::ContributeBC(), TPZBurger::ContributeBC(), TPZMatLaplacian::ContributeBC(), TPZMatPoisson3d::ContributeBC(), TPZMatLaplacian::ContributeBCHDiv(), TPZMatPoisson3d::ContributeBCHDiv(), TPZBurger::ContributeBCInterface(), TPZNonLinearPoisson3d::ContributeBCInterface(), TPZMatLaplacian::ContributeBCInterface(), TPZMatPoisson3d::ContributeBCInterface(), TPZBurger::ContributeGradStab(), TPZNonLinearPoisson3d::ContributeInterface(), TPZBurger::ContributeInterface(), TPZMatLaplacian::ContributeInterface(), TPZMatPoisson3d::ContributeInterface(), TPZBurger::ContributeSUPG(), TPZMatrix< STATE >::CopyFrom(), TPZMatrix< STATE >::GetSub(), TPZMatrix< STATE >::SolveEigensystemJacobi(), and TPZMatrix< STATE >::SolveEigenvaluesJacobi().
|
overridevirtual |
Packs the object structure in a stream of bytes.
buf | Buffer which will receive the bytes |
withclassid |
Reimplemented from TPZSavable.
Reimplemented in TPZFNMatrix< 9, T >, TPZFNMatrix< 3, T >, TPZFNMatrix< 30, std::complex< double > >, TPZSkylMatrix< TVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, TPZDohrMatrix< TVar, TSubStruct >, TPZDohrMatrix< TVar, TSubStruct >, TPZDohrMatrix< TVar, TSubStruct >, TPZDohrMatrix< TVar, TSubStruct >, TPZMatRed< TVar, TPZFMatrix< TVar > >, TPZSkylNSymMatrix< TVar >, TPZDohrMatrix< TVar, TSubStruct >, TPZDohrPrecond< TVar, TSubStruct >, and TPZVerySparseMatrix< TVar >.
Definition at line 1420 of file pzmatrix.cpp.
Referenced by TPZSkylMatrix< TVar >::AutoFill(), TPZMatrix< STATE >::Decompose(), main(), TPZDohrPrecond< TVar, TSubStruct >::Write(), TPZDohrMatrix< TVar, TSubStruct >::Write(), TPZSkylNSymMatrix< TVar >::Write(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::Write(), TPZFMatrix< STATE >::Write(), and TPZSkylMatrix< TVar >::Write().
|
inlinevirtual |
Zeroes the matrix.
Reimplemented in TPZSkylMatrix< TVar >, TPZFMatrix< TVar >, TPZFMatrix< REAL >, TPZFMatrix< TTVar >, TPZFMatrix< int >, TPZFMatrix< T >, TPZFMatrix< std::complex< double > >, TPZFMatrix< STATE >, TPZSkylNSymMatrix< TVar >, TPZFYsmpMatrix< TVar >, TPZSpMatrix< TVar >, TPZFBMatrix< TVar >, TPZSFMatrix< TVar >, TPZSBMatrix< TVar >, TPZMatRed< TVar, TSideMatrix >, TPZMatRed< STATE, TPZFMatrix< STATE > >, TPZMatRed< TVar, TPZFMatrix< TVar > >, TPZMatRed< TTVar, TPZFMatrix< TTVar > >, TPZFrontMatrix< TVar, store, front >, TPZSSpMatrix< TVar >, TPZBlockDiagonal< TVar >, TPZBlockDiagonal< STATE >, and TPZSYsmpMatrix< TVar >.
Definition at line 296 of file pzmatrix.h.
Referenced by TPZTransientAnalysis< TRANSIENTCLASS >::Assemble(), TPZAnalysis::Assemble(), and TPZElastoPlasticAnalysis::UpdatePrecond().
|
friend |
Input operation.
Referenced by TPZMatrix< STATE >::PutVal().
|
protected |
Number of cols in matrix.
Definition at line 781 of file pzmatrix.h.
Referenced by TPZBlockDiagonal< STATE >::Clear(), TPZSFMatrix< TVar >::Clear(), TPZFBMatrix< TVar >::Clear(), TPZSBMatrix< TVar >::Clear(), TPZSkylNSymMatrix< TVar >::Clear(), TPZFMatrix< STATE >::Clear(), TPZSkylMatrix< TVar >::Clear(), TPZMatrix< STATE >::Cols(), TPZFMatrix< STATE >::Compare(), TPZMatrix< STATE >::Compare(), TPZSBMatrix< TVar >::Copy(), TPZSkylNSymMatrix< TVar >::Copy(), TPZSkylMatrix< TVar >::Copy(), TPZMatrix< STATE >::CopyFrom(), TPZSpMatrix< TVar >::fCopy(), TPZVerySparseMatrix< TVar >::GetVal(), TPZFBMatrix< TVar >::GetVal(), TPZMatrix< STATE >::IsSquare(), TPZFMatrix< STATE >::operator-=(), TPZSSpMatrix< TVar >::operator=(), TPZSFMatrix< TVar >::operator=(), TPZFMatrix< STATE >::operator=(), operator>>(), TPZVerySparseMatrix< TVar >::PutVal(), TPZVerySparseMatrix< TVar >::Read(), TPZFMatrix< STATE >::Read(), TPZMatrix< STATE >::Read(), TPZSSpMatrix< TVar >::Redim(), TPZSFMatrix< TVar >::Redim(), TPZSpMatrix< TVar >::Redim(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::Redim(), TPZFMatrix< STATE >::Redim(), TPZMatrix< STATE >::Redim(), TPZSkylMatrix< TVar >::Redim(), TPZFMatrix< STATE >::Remodel(), TPZSSpMatrix< TVar >::Resize(), TPZSFMatrix< TVar >::Resize(), TPZSpMatrix< TVar >::Resize(), TPZFMatrix< STATE >::Resize(), TPZMatrix< STATE >::Resize(), TPZSkylMatrix< TVar >::Resize(), TPZTransfer< TVar >::SetBlocks(), TPZFMatrix< STATE >::SetSize(), TPZFMatrix< STATE >::TimesBetaPlusZ(), TPZBlockDiagonal< STATE >::TPZBlockDiagonal(), TPZFMatrix< STATE >::TPZFMatrix(), TPZMatrix< STATE >::TPZMatrix(), TPZSparseBlockDiagonal< TVar >::TPZSparseBlockDiagonal(), TPZVerySparseMatrix< TVar >::TPZVerySparseMatrix(), TPZVerySparseMatrix< TVar >::Write(), TPZFMatrix< STATE >::Write(), TPZMatrix< STATE >::Write(), TPZFMatrix< STATE >::ZAXPY(), TPZFMatrix< STATE >::Zero(), and TPZMatrix< STATE >::~TPZMatrix().
|
protected |
Decomposition type used to decompose the current matrix.
Definition at line 783 of file pzmatrix.h.
Referenced by TPZParFrontMatrix< TVar, store, front >::AddKel(), TPZBlockDiagonal< STATE >::Clear(), TPZSBMatrix< TVar >::Clear(), TPZSkylNSymMatrix< TVar >::Clear(), TPZSkylMatrix< TVar >::Clear(), TPZMatrix< STATE >::Compare(), TPZSkylNSymMatrix< TVar >::Copy(), TPZSkylMatrix< TVar >::Copy(), TPZMatrix< STATE >::CopyFrom(), TPZSkylParMatrix< TVar >::Decompose_Cholesky(), TPZSSpMatrix< TVar >::Decompose_Cholesky(), TPZSFMatrix< TVar >::Decompose_Cholesky(), TPZFMatrix< STATE >::Decompose_Cholesky(), TPZSkylMatrix< TVar >::Decompose_Cholesky(), TPZMatrix< STATE >::Decompose_Cholesky(), TPZSkylMatrix< TVar >::Decompose_Cholesky_blk(), TPZSkylParMatrix< TVar >::Decompose_LDLt(), TPZSSpMatrix< TVar >::Decompose_LDLt(), TPZSBMatrix< TVar >::Decompose_LDLt(), TPZSFMatrix< TVar >::Decompose_LDLt(), TPZFMatrix< STATE >::Decompose_LDLt(), TPZSkylMatrix< TVar >::Decompose_LDLt(), TPZMatrix< STATE >::Decompose_LDLt(), TPZSpBlockDiagPivot< TVar >::Decompose_LU(), TPZBlockDiagonal< STATE >::Decompose_LU(), TPZSkylNSymMatrix< TVar >::Decompose_LU(), TPZFYsmpMatrix< TVar >::Decompose_LU(), TPZFMatrix< STATE >::Decompose_LU(), TPZMatrix< STATE >::Decompose_LU(), TPZMatrix< STATE >::IsDecomposed(), TPZSkylMatrix< TVar >::MultAdd(), TPZSSpMatrix< TVar >::operator*=(), TPZSFMatrix< TVar >::operator*=(), TPZSkylMatrix< TVar >::operator*=(), TPZSSpMatrix< TVar >::operator+=(), TPZSFMatrix< TVar >::operator+=(), TPZSSpMatrix< TVar >::operator-=(), TPZSFMatrix< TVar >::operator-=(), TPZSSpMatrix< TVar >::operator=(), TPZSFMatrix< TVar >::operator=(), TPZFMatrix< STATE >::operator=(), TPZSSpMatrix< TVar >::PutVal(), TPZSFMatrix< TVar >::PutVal(), TPZSkylNSymMatrix< TVar >::PutVal(), TPZSBMatrix< TVar >::PutVal(), TPZSkylMatrix< TVar >::PutVal(), TPZVerySparseMatrix< TVar >::Read(), TPZMatrix< STATE >::Read(), TPZSBMatrix< TVar >::Redim(), TPZSFMatrix< TVar >::Redim(), TPZSkylMatrix< TVar >::Redim(), TPZSFMatrix< TVar >::Resize(), TPZSkylMatrix< TVar >::Resize(), TPZSBMatrix< TVar >::SetBand(), TPZMatrix< STATE >::SetIsDecomposed(), TPZSBMatrix< TVar >::Subst_Backward(), TPZSFMatrix< TVar >::Subst_Backward(), TPZSkylNSymMatrix< TVar >::Subst_Backward(), TPZSkylMatrix< TVar >::Subst_Backward(), TPZMatrix< STATE >::Subst_Backward(), TPZSSpMatrix< TVar >::Subst_Diag(), TPZSBMatrix< TVar >::Subst_Diag(), TPZSFMatrix< TVar >::Subst_Diag(), TPZSkylMatrix< TVar >::Subst_Diag(), TPZSSpMatrix< TVar >::Subst_Forward(), TPZSBMatrix< TVar >::Subst_Forward(), TPZSFMatrix< TVar >::Subst_Forward(), TPZSkylMatrix< TVar >::Subst_Forward(), TPZMatrix< STATE >::Subst_Forward(), TPZSBMatrix< TVar >::Subst_LBackward(), TPZSFMatrix< TVar >::Subst_LBackward(), TPZSkylMatrix< TVar >::Subst_LBackward(), TPZMatrix< STATE >::Subst_LBackward(), TPZSSpMatrix< TVar >::Subst_LForward(), TPZSBMatrix< TVar >::Subst_LForward(), TPZSFMatrix< TVar >::Subst_LForward(), TPZSkylNSymMatrix< TVar >::Subst_LForward(), TPZSkylMatrix< TVar >::Subst_LForward(), TPZMatrix< STATE >::Subst_LForward(), TPZFBMatrix< TVar >::Substitution(), TPZBlockDiagonal< STATE >::Substitution(), TPZFMatrix< STATE >::Substitution(), TPZSpBlockDiagPivot< TVar >::Substitution2(), TPZMatrix< STATE >::TPZMatrix(), TPZSSpMatrix< TVar >::TPZSSpMatrix(), TPZFBMatrix< TVar >::Transpose(), TPZFMatrix< STATE >::Transpose(), TPZSparseBlockDiagonal< TVar >::UpdateFrom(), TPZBlockDiagonal< STATE >::UpdateFrom(), TPZSkylNSymMatrix< TVar >::UpdateFrom(), TPZSkylMatrix< TVar >::UpdateFrom(), TPZVerySparseMatrix< TVar >::Write(), TPZMatrix< STATE >::Write(), TPZBlockDiagonal< STATE >::Zero(), TPZSBMatrix< TVar >::Zero(), TPZSFMatrix< TVar >::Zero(), TPZFBMatrix< TVar >::Zero(), TPZSpMatrix< TVar >::Zero(), TPZFMatrix< STATE >::Zero(), TPZSkylMatrix< TVar >::Zero(), and TPZMatrix< STATE >::~TPZMatrix().
|
protected |
Definite Posistiveness of current matrix.
Definition at line 785 of file pzmatrix.h.
Referenced by TPZSkylNSymMatrix< TVar >::Copy(), TPZSkylMatrix< TVar >::Copy(), TPZMatrix< STATE >::CopyFrom(), TPZSSpMatrix< TVar >::Decompose_Cholesky(), TPZSFMatrix< TVar >::Decompose_Cholesky(), TPZSkylMatrix< TVar >::Decompose_Cholesky(), TPZSkylMatrix< TVar >::Decompose_Cholesky_blk(), TPZSSpMatrix< TVar >::Decompose_LDLt(), TPZSBMatrix< TVar >::Decompose_LDLt(), TPZSFMatrix< TVar >::Decompose_LDLt(), TPZFMatrix< STATE >::Decompose_LDLt(), TPZSkylMatrix< TVar >::Decompose_LDLt(), TPZMatrix< STATE >::Decompose_LDLt(), TPZSkylNSymMatrix< TVar >::Decompose_LU(), TPZSSpMatrix< TVar >::operator=(), TPZSFMatrix< TVar >::operator=(), TPZVerySparseMatrix< TVar >::Read(), TPZMatrix< STATE >::Read(), TPZSBMatrix< TVar >::Redim(), TPZSFMatrix< TVar >::Redim(), TPZSBMatrix< TVar >::SetBand(), TPZFMatrix< STATE >::Substitution(), TPZMatrix< STATE >::TPZMatrix(), TPZSSpMatrix< TVar >::TPZSSpMatrix(), TPZSkylNSymMatrix< TVar >::UpdateFrom(), TPZSkylMatrix< TVar >::UpdateFrom(), TPZVerySparseMatrix< TVar >::Write(), TPZMatrix< STATE >::Write(), TPZSBMatrix< TVar >::Zero(), TPZSFMatrix< TVar >::Zero(), TPZSkylMatrix< TVar >::Zero(), and TPZMatrix< STATE >::~TPZMatrix().
|
protected |
Number of rows in matrix.
Definition at line 779 of file pzmatrix.h.
Referenced by TPZBlockDiagonal< STATE >::Clear(), TPZSFMatrix< TVar >::Clear(), TPZFBMatrix< TVar >::Clear(), TPZSBMatrix< TVar >::Clear(), TPZSkylNSymMatrix< TVar >::Clear(), TPZFMatrix< STATE >::Clear(), TPZFMatrix< STATE >::Compare(), TPZMatrix< STATE >::Compare(), TPZSBMatrix< TVar >::Copy(), TPZSkylNSymMatrix< TVar >::Copy(), TPZMatrix< STATE >::CopyFrom(), TPZSpMatrix< TVar >::fCopy(), TPZFMatrix< STATE >::g(), TPZVerySparseMatrix< TVar >::GetVal(), TPZFBMatrix< TVar >::GetVal(), TPZFMatrix< STATE >::GetVal(), TPZMatrix< STATE >::IsSquare(), TPZFMatrix< STATE >::operator()(), TPZSkylMatrix< TVar >::operator-(), TPZFMatrix< STATE >::operator-=(), TPZSSpMatrix< TVar >::operator=(), TPZSFMatrix< TVar >::operator=(), TPZFMatrix< STATE >::operator=(), operator>>(), TPZVerySparseMatrix< TVar >::PutVal(), TPZVerySparseMatrix< TVar >::Read(), TPZFMatrix< STATE >::Read(), TPZMatrix< STATE >::Read(), TPZSSpMatrix< TVar >::Redim(), TPZSFMatrix< TVar >::Redim(), TPZSpMatrix< TVar >::Redim(), TPZMatRed< TTVar, TPZFMatrix< TTVar > >::Redim(), TPZFMatrix< STATE >::Redim(), TPZMatrix< STATE >::Redim(), TPZFMatrix< STATE >::Remodel(), TPZSSpMatrix< TVar >::Resize(), TPZSFMatrix< TVar >::Resize(), TPZSpMatrix< TVar >::Resize(), TPZFMatrix< STATE >::Resize(), TPZMatrix< STATE >::Resize(), TPZMatrix< STATE >::Rows(), TPZTransfer< TVar >::SetBlocks(), TPZFMatrix< STATE >::SetSize(), TPZFMatrix< STATE >::TimesBetaPlusZ(), TPZBlockDiagonal< STATE >::TPZBlockDiagonal(), TPZFMatrix< STATE >::TPZFMatrix(), TPZMatrix< STATE >::TPZMatrix(), TPZSparseBlockDiagonal< TVar >::TPZSparseBlockDiagonal(), TPZVerySparseMatrix< TVar >::TPZVerySparseMatrix(), TPZVerySparseMatrix< TVar >::Write(), TPZFMatrix< STATE >::Write(), TPZMatrix< STATE >::Write(), TPZFMatrix< STATE >::ZAXPY(), TPZSpMatrix< TVar >::Zero(), TPZFMatrix< STATE >::Zero(), and TPZMatrix< STATE >::~TPZMatrix().
|
staticprotected |
Initializing value to static variable.
Definition at line 786 of file pzmatrix.h.
Referenced by TPZSparseBlockDiagonal< TVar >::Get(), TPZSparseBlockDiagonal< TVar >::GetVal(), TPZVerySparseMatrix< TVar >::GetVal(), TPZSYsmpMatrix< TVar >::GetVal(), TPZSkylNSymMatrix< TVar >::GetVal(), TPZFYsmpMatrix< TVar >::GetVal(), TPZMatrix< STATE >::GetVal(), TPZSBMatrix< TVar >::GetVal(), TPZSkylMatrix< TVar >::GetVal(), TPZSkylNSymMatrix< TVar >::GetValB(), TPZSkylNSymMatrix< TVar >::GetValSup(), TPZSparseBlockDiagonal< TVar >::operator()(), TPZSBMatrix< TVar >::operator()(), TPZSBMatrix< TVar >::PutVal(), TPZVerySparseMatrix< TVar >::Read(), TPZSparseBlockDiagonal< TVar >::s(), TPZSkylMatrix< TVar >::SolveSOR(), and TPZVerySparseMatrix< TVar >::Write().