Ifpack_DropFilter: Filter based on matrix entries.
More...
#include <Ifpack_DropFilter.h>
Inherits Epetra_RowMatrix.
|
| Ifpack_DropFilter (const Teuchos::RefCountPtr< Epetra_RowMatrix > &Matrix, double DropTol) |
| Constructor. More...
|
|
virtual | ~Ifpack_DropFilter () |
| Destructor. More...
|
|
virtual int | NumMyRowEntries (int MyRow, int &NumEntries) const |
| Returns the number of entries in MyRow. More...
|
|
virtual int | MaxNumEntries () const |
| Returns the maximum number of entries. More...
|
|
virtual int | ExtractMyRowCopy (int MyRow, int Length, int &NumEntries, double *Values, int *Indices) const |
|
virtual int | ExtractDiagonalCopy (Epetra_Vector &Diagonal) const |
|
virtual int | Multiply (bool TransA, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
|
virtual int | Solve (bool Upper, bool Trans, bool UnitDiagonal, const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
|
virtual int | Apply (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
|
virtual int | ApplyInverse (const Epetra_MultiVector &X, Epetra_MultiVector &Y) const |
|
virtual int | InvRowSums (Epetra_Vector &x) const |
|
virtual int | LeftScale (const Epetra_Vector &x) |
|
virtual int | InvColSums (Epetra_Vector &x) const |
|
virtual int | RightScale (const Epetra_Vector &x) |
|
virtual bool | Filled () const |
|
virtual double | NormInf () const |
|
virtual double | NormOne () const |
|
virtual int | NumGlobalNonzeros () const |
|
virtual int | NumGlobalRows () const |
|
virtual int | NumGlobalCols () const |
|
virtual int | NumGlobalDiagonals () const |
|
virtual long long | NumGlobalNonzeros64 () const |
|
virtual long long | NumGlobalRows64 () const |
|
virtual long long | NumGlobalCols64 () const |
|
virtual long long | NumGlobalDiagonals64 () const |
|
virtual int | NumMyNonzeros () const |
|
virtual int | NumMyRows () const |
|
virtual int | NumMyCols () const |
|
virtual int | NumMyDiagonals () const |
|
virtual bool | LowerTriangular () const |
|
virtual bool | UpperTriangular () const |
|
virtual const Epetra_Map & | RowMatrixRowMap () const |
|
virtual const Epetra_Map & | RowMatrixColMap () const |
|
virtual const Epetra_Import * | RowMatrixImporter () const |
|
int | SetUseTranspose (bool useTranspose) |
|
bool | UseTranspose () const |
|
bool | HasNormInf () const |
|
const Epetra_Comm & | Comm () const |
|
const Epetra_Map & | OperatorDomainMap () const |
|
const Epetra_Map & | OperatorRangeMap () const |
|
const Epetra_BlockMap & | Map () const |
|
const char * | Label () const |
|
Ifpack_DropFilter: Filter based on matrix entries.
Ifpack_DropFilter enables the dropping of all elements whose absolute value is below a specified threshold.
A typical use is as follows:
Teuchos::RefCountPtr<Epetra_RowMatrix>
A;
double DropTol = 1e-5;
It is supposed that Ifpack_DropFilter is used on localized matrices.
- Author
- Marzio Sala, SNL 9214.
Last modified: Oct-04.
Definition at line 81 of file Ifpack_DropFilter.h.
◆ Ifpack_DropFilter()
Ifpack_DropFilter::Ifpack_DropFilter |
( |
const Teuchos::RefCountPtr< Epetra_RowMatrix > & |
Matrix, |
|
|
double |
DropTol |
|
) |
| |
◆ ~Ifpack_DropFilter()
virtual Ifpack_DropFilter::~Ifpack_DropFilter |
( |
| ) |
|
|
inlinevirtual |
◆ NumMyRowEntries()
virtual int Ifpack_DropFilter::NumMyRowEntries |
( |
int |
MyRow, |
|
|
int & |
NumEntries |
|
) |
| const |
|
inlinevirtual |
◆ MaxNumEntries()
virtual int Ifpack_DropFilter::MaxNumEntries |
( |
| ) |
const |
|
inlinevirtual |
◆ ExtractMyRowCopy()
int Ifpack_DropFilter::ExtractMyRowCopy |
( |
int |
MyRow, |
|
|
int |
Length, |
|
|
int & |
NumEntries, |
|
|
double * |
Values, |
|
|
int * |
Indices |
|
) |
| const |
|
virtual |
◆ ExtractDiagonalCopy()
int Ifpack_DropFilter::ExtractDiagonalCopy |
( |
Epetra_Vector & |
Diagonal | ) |
const |
|
virtual |
◆ Multiply()
int Ifpack_DropFilter::Multiply |
( |
bool |
TransA, |
|
|
const Epetra_MultiVector & |
X, |
|
|
Epetra_MultiVector & |
Y |
|
) |
| const |
|
virtual |
◆ Solve()
int Ifpack_DropFilter::Solve |
( |
bool |
Upper, |
|
|
bool |
Trans, |
|
|
bool |
UnitDiagonal, |
|
|
const Epetra_MultiVector & |
X, |
|
|
Epetra_MultiVector & |
Y |
|
) |
| const |
|
virtual |
◆ Apply()
int Ifpack_DropFilter::Apply |
( |
const Epetra_MultiVector & |
X, |
|
|
Epetra_MultiVector & |
Y |
|
) |
| const |
|
virtual |
◆ ApplyInverse()
int Ifpack_DropFilter::ApplyInverse |
( |
const Epetra_MultiVector & |
X, |
|
|
Epetra_MultiVector & |
Y |
|
) |
| const |
|
virtual |
◆ InvRowSums()
int Ifpack_DropFilter::InvRowSums |
( |
Epetra_Vector & |
x | ) |
const |
|
virtual |
◆ LeftScale()
virtual int Ifpack_DropFilter::LeftScale |
( |
const Epetra_Vector & |
x | ) |
|
|
inlinevirtual |
◆ InvColSums()
int Ifpack_DropFilter::InvColSums |
( |
Epetra_Vector & |
x | ) |
const |
|
virtual |
◆ RightScale()
virtual int Ifpack_DropFilter::RightScale |
( |
const Epetra_Vector & |
x | ) |
|
|
inlinevirtual |
◆ Filled()
virtual bool Ifpack_DropFilter::Filled |
( |
| ) |
const |
|
inlinevirtual |
◆ NormInf()
virtual double Ifpack_DropFilter::NormInf |
( |
| ) |
const |
|
inlinevirtual |
◆ NormOne()
virtual double Ifpack_DropFilter::NormOne |
( |
| ) |
const |
|
inlinevirtual |
◆ NumGlobalNonzeros()
virtual int Ifpack_DropFilter::NumGlobalNonzeros |
( |
| ) |
const |
|
inlinevirtual |
◆ NumGlobalRows()
virtual int Ifpack_DropFilter::NumGlobalRows |
( |
| ) |
const |
|
inlinevirtual |
◆ NumGlobalCols()
virtual int Ifpack_DropFilter::NumGlobalCols |
( |
| ) |
const |
|
inlinevirtual |
◆ NumGlobalDiagonals()
virtual int Ifpack_DropFilter::NumGlobalDiagonals |
( |
| ) |
const |
|
inlinevirtual |
◆ NumGlobalNonzeros64()
virtual long long Ifpack_DropFilter::NumGlobalNonzeros64 |
( |
| ) |
const |
|
inlinevirtual |
◆ NumGlobalRows64()
virtual long long Ifpack_DropFilter::NumGlobalRows64 |
( |
| ) |
const |
|
inlinevirtual |
◆ NumGlobalCols64()
virtual long long Ifpack_DropFilter::NumGlobalCols64 |
( |
| ) |
const |
|
inlinevirtual |
◆ NumGlobalDiagonals64()
virtual long long Ifpack_DropFilter::NumGlobalDiagonals64 |
( |
| ) |
const |
|
inlinevirtual |
◆ NumMyNonzeros()
virtual int Ifpack_DropFilter::NumMyNonzeros |
( |
| ) |
const |
|
inlinevirtual |
◆ NumMyRows()
virtual int Ifpack_DropFilter::NumMyRows |
( |
| ) |
const |
|
inlinevirtual |
◆ NumMyCols()
virtual int Ifpack_DropFilter::NumMyCols |
( |
| ) |
const |
|
inlinevirtual |
◆ NumMyDiagonals()
virtual int Ifpack_DropFilter::NumMyDiagonals |
( |
| ) |
const |
|
inlinevirtual |
◆ LowerTriangular()
virtual bool Ifpack_DropFilter::LowerTriangular |
( |
| ) |
const |
|
inlinevirtual |
◆ UpperTriangular()
virtual bool Ifpack_DropFilter::UpperTriangular |
( |
| ) |
const |
|
inlinevirtual |
◆ RowMatrixRowMap()
virtual const Epetra_Map& Ifpack_DropFilter::RowMatrixRowMap |
( |
| ) |
const |
|
inlinevirtual |
◆ RowMatrixColMap()
virtual const Epetra_Map& Ifpack_DropFilter::RowMatrixColMap |
( |
| ) |
const |
|
inlinevirtual |
◆ RowMatrixImporter()
virtual const Epetra_Import* Ifpack_DropFilter::RowMatrixImporter |
( |
| ) |
const |
|
inlinevirtual |
◆ SetUseTranspose()
int Ifpack_DropFilter::SetUseTranspose |
( |
bool |
useTranspose | ) |
|
|
inline |
◆ UseTranspose()
bool Ifpack_DropFilter::UseTranspose |
( |
| ) |
const |
|
inline |
◆ HasNormInf()
bool Ifpack_DropFilter::HasNormInf |
( |
| ) |
const |
|
inline |
◆ Comm()
const Epetra_Comm& Ifpack_DropFilter::Comm |
( |
| ) |
const |
|
inline |
◆ OperatorDomainMap()
const Epetra_Map& Ifpack_DropFilter::OperatorDomainMap |
( |
| ) |
const |
|
inline |
◆ OperatorRangeMap()
const Epetra_Map& Ifpack_DropFilter::OperatorRangeMap |
( |
| ) |
const |
|
inline |
◆ Map()
const Epetra_BlockMap& Ifpack_DropFilter::Map |
( |
| ) |
const |
|
inline |
◆ Label()
const char* Ifpack_DropFilter::Label |
( |
| ) |
const |
|
inline |
◆ A_
◆ DropTol_
double Ifpack_DropFilter::DropTol_ |
|
private |
◆ MaxNumEntries_
int Ifpack_DropFilter::MaxNumEntries_ |
|
private |
◆ MaxNumEntriesA_
int Ifpack_DropFilter::MaxNumEntriesA_ |
|
private |
◆ NumRows_
int Ifpack_DropFilter::NumRows_ |
|
private |
◆ NumNonzeros_
int Ifpack_DropFilter::NumNonzeros_ |
|
private |
◆ Indices_
std::vector<int> Ifpack_DropFilter::Indices_ |
|
mutableprivate |
◆ Values_
std::vector<double> Ifpack_DropFilter::Values_ |
|
mutableprivate |
◆ Label_
char Ifpack_DropFilter::Label_[80] |
|
private |
◆ NumEntries_
std::vector<int> Ifpack_DropFilter::NumEntries_ |
|
private |
The documentation for this class was generated from the following files: