EpetraExt  Development
Public Member Functions | Protected Member Functions | Protected Attributes | List of all members
EpetraExt::LinearProblem_CrsSingletonFilter Class Reference

Epetra_CrsSingletonFilter: A class for explicitly eliminating matrix rows and columns. More...

#include <EpetraExt_CrsSingletonFilter_LinearProblem.h>

Inheritance diagram for EpetraExt::LinearProblem_CrsSingletonFilter:
Inheritance graph
[legend]

Public Member Functions

NewTypeRef operator() (OriginalTypeRef orig)
 
bool analyze (OriginalTypeRef orig)
 
NewTypeRef construct ()
 Construction of new object as a result of the transform. More...
 
bool fwd ()
 Forward transfer of data from orig object input in the operator() method call to the new object created in this same call. More...
 
bool rvs ()
 Reverse transfer of data from new object created in the operator() method call to the orig object input to this same method. More...
 
- Public Member Functions inherited from EpetraExt::SameTypeTransform< Epetra_LinearProblem >
virtual ~SameTypeTransform ()
 
- Public Member Functions inherited from EpetraExt::Transform< Epetra_LinearProblem, Epetra_LinearProblem >
virtual ~Transform ()
 
virtual NewTypeRef operator() (OriginalTypeRef orig)=0
 Analysis of transform operation on original object and construction of new object. More...
 
virtual bool analyze (OriginalTypeRef orig)
 Initial analysis phase of transform. More...
 
virtual bool isConstructed ()
 Check for whether transformed object has been constructed. More...
 

Protected Member Functions

Epetra_CrsMatrix * FullCrsMatrix () const
 
const Epetra_Map & FullMatrixRowMap () const
 
const Epetra_Map & FullMatrixColMap () const
 
const Epetra_Map & FullMatrixDomainMap () const
 
const Epetra_Map & FullMatrixRangeMap () const
 
void InitializeDefaults ()
 
int ComputeEliminateMaps ()
 
int Setup (Epetra_LinearProblem *Problem)
 
int InitFullMatrixAccess ()
 
int GetRow (int Row, int &NumIndices, int *&Indices)
 
int GetRow (int Row, int &NumIndices, double *&Values, int *&Indices)
 
int GetRowGCIDs (int Row, int &NumIndices, double *&Values, int *&GlobalIndices)
 
int GetRowGCIDs (int Row, int &NumIndices, double *&Values, long long *&GlobalIndices)
 
int CreatePostSolveArrays (const Epetra_IntVector &RowIDs, const Epetra_MapColoring &RowMapColors, const Epetra_IntVector &ColProfiles, const Epetra_IntVector &NewColProfiles, const Epetra_IntVector &ColHasRowWithSingleton)
 
int ConstructRedistributeExporter (Epetra_Map *SourceMap, Epetra_Map *TargetMap, Epetra_Export *&RedistributeExporter, Epetra_Map *&RedistributeMap)
 
- Protected Member Functions inherited from EpetraExt::Transform< Epetra_LinearProblem, Epetra_LinearProblem >
 Transform ()
 Default constructor, protected to allow only derived classes to use. More...
 

Protected Attributes

Epetra_LinearProblem * FullProblem_
 
Teuchos::RCP< Epetra_LinearProblem > ReducedProblem_
 
Epetra_RowMatrix * FullMatrix_
 
Epetra_CrsMatrix * FullCrsMatrix_
 
Teuchos::RCP< Epetra_CrsMatrix > ReducedMatrix_
 
Epetra_MultiVector * ReducedRHS_
 
Epetra_MultiVector * ReducedLHS_
 
Epetra_Map * ReducedMatrixRowMap_
 
Epetra_Map * ReducedMatrixColMap_
 
Epetra_Map * ReducedMatrixDomainMap_
 
Epetra_Map * ReducedMatrixRangeMap_
 
Epetra_Map * OrigReducedMatrixDomainMap_
 
Epetra_Import * Full2ReducedRHSImporter_
 
Epetra_Import * Full2ReducedLHSImporter_
 
Epetra_Export * RedistributeDomainExporter_
 
int * ColSingletonRowLIDs_
 
int * ColSingletonColLIDs_
 
int * ColSingletonPivotLIDs_
 
double * ColSingletonPivots_
 
int AbsoluteThreshold_
 
double RelativeThreshold_
 
int NumMyRowSingletons_
 
int NumMyColSingletons_
 
int NumGlobalRowSingletons_
 
int NumGlobalColSingletons_
 
double RatioOfDimensions_
 
double RatioOfNonzeros_
 
bool HaveReducedProblem_
 
bool UserDefinedEliminateMaps_
 
bool AnalysisDone_
 
bool SymmetricElimination_
 
Epetra_MultiVector * tempExportX_
 
Epetra_MultiVector * tempX_
 
Epetra_MultiVector * tempB_
 
Epetra_MultiVector * RedistributeReducedLHS_
 
int * Indices_int_
 
long long * Indices_LL_
 
Epetra_SerialDenseVector Values_
 
Epetra_MapColoring * RowMapColors_
 
Epetra_MapColoring * ColMapColors_
 
bool FullMatrixIsCrsMatrix_
 
int MaxNumMyEntries_
 
bool verbose_
 
- Protected Attributes inherited from EpetraExt::Transform< Epetra_LinearProblem, Epetra_LinearProblem >
OriginalTypePtr origObj_
 
NewTypePtr newObj_
 
 LinearProblem_CrsSingletonFilter (bool verbose=false)
 Epetra_CrsSingletonFilter default constructor. More...
 
virtual ~LinearProblem_CrsSingletonFilter ()
 Epetra_CrsSingletonFilter Destructor. More...
 
int Analyze (Epetra_RowMatrix *FullMatrix)
 Analyze the input matrix, removing row/column pairs that have singletons. More...
 
bool SingletonsDetected () const
 Returns true if singletons were detected in this matrix (must be called after Analyze() to be effective). More...
 
int ConstructReducedProblem (Epetra_LinearProblem *Problem)
 Return a reduced linear problem based on results of Analyze(). More...
 
int UpdateReducedProblem (Epetra_LinearProblem *Problem)
 Update a reduced linear problem using new values. More...
 
int ComputeFullSolution ()
 Compute a solution for the full problem using the solution of the reduced problem, put in LHS of FullProblem(). More...
 
int NumRowSingletons () const
 Return number of rows that contain a single entry, returns -1 if Analysis not performed yet. More...
 
int NumColSingletons () const
 Return number of columns that contain a single entry that are not associated with singleton row, returns -1 if Analysis not performed yet. More...
 
int NumSingletons () const
 Return total number of singletons detected, returns -1 if Analysis not performed yet. More...
 
double RatioOfDimensions () const
 Returns ratio of reduced system to full system dimensions, returns -1.0 if reduced problem not constructed. More...
 
double RatioOfNonzeros () const
 Returns ratio of reduced system to full system nonzero count, returns -1.0 if reduced problem not constructed. More...
 
Epetra_LinearProblem * FullProblem () const
 Returns pointer to the original unreduced Epetra_LinearProblem. More...
 
Epetra_LinearProblem * ReducedProblem () const
 Returns pointer to the derived reduced Epetra_LinearProblem. More...
 
Epetra_RowMatrix * FullMatrix () const
 Returns pointer to Epetra_CrsMatrix from full problem. More...
 
Epetra_CrsMatrix * ReducedMatrix () const
 Returns pointer to Epetra_CrsMatrix from full problem. More...
 
Epetra_MapColoring * RowMapColors () const
 Returns pointer to Epetra_MapColoring object: color 0 rows are part of reduced system. More...
 
Epetra_MapColoring * ColMapColors () const
 Returns pointer to Epetra_MapColoring object: color 0 columns are part of reduced system. More...
 
Epetra_Map * ReducedMatrixRowMap () const
 Returns pointer to Epetra_Map describing the reduced system row distribution. More...
 
Epetra_Map * ReducedMatrixColMap () const
 Returns pointer to Epetra_Map describing the reduced system column distribution. More...
 
Epetra_Map * ReducedMatrixDomainMap () const
 Returns pointer to Epetra_Map describing the domain map for the reduced system. More...
 
Epetra_Map * ReducedMatrixRangeMap () const
 Returns pointer to Epetra_Map describing the range map for the reduced system. More...
 

Additional Inherited Members

- Public Types inherited from EpetraExt::SameTypeTransform< Epetra_LinearProblem >
typedef Epetra_LinearProblem TransformType
 
typedef Epetra_LinearProblem * TransformTypePtr
 
typedef Epetra_LinearProblem & TransformTypeRef
 
- Public Types inherited from EpetraExt::Transform< Epetra_LinearProblem, Epetra_LinearProblem >
typedef Epetra_LinearProblem OriginalType
 
typedef Epetra_LinearProblem * OriginalTypePtr
 
typedef Teuchos::RCP< Epetra_LinearProblem > OriginalTypeRCP
 
typedef Epetra_LinearProblem & OriginalTypeRef
 
typedef Epetra_LinearProblem NewType
 
typedef Epetra_LinearProblem * NewTypePtr
 
typedef Teuchos::RCP< Epetra_LinearProblem > NewTypeRCP
 
typedef Epetra_LinearProblem & NewTypeRef
 

Detailed Description

Epetra_CrsSingletonFilter: A class for explicitly eliminating matrix rows and columns.

The Epetra_CrsSingletonFilter class takes an existing Epetra_LinearProblem object, analyzes it structure and explicitly eliminates singleton rows and columns from the matrix and appropriately modifies the RHS and LHS of the linear problem. The result of this process is a reduced system of equations that is itself an Epetra_LinearProblem object. The reduced system can then be solved using any solver that is understands an Epetra_LinearProblem. The solution for the full system is obtained by calling ComputeFullSolution().

Singleton rows are defined to be rows that have a single nonzero entry in the matrix. The equation associated with this row can be explicitly eliminated because it involved only one variable. For example if row i has a single nonzero value in column j, call it A(i,j), we can explicitly solve for x(j) = b(i)/A(i,j), where b(i) is the ith entry of the RHS and x(j) is the jth entry of the LHS.

Singleton columns are defined to be columns that have a single nonzero entry in the matrix. The variable associated with this column is fully dependent, meaning that the solution for all other variables does not depend on it. If this entry is A(i,j) then the ith row and jth column can be removed from the system and x(j) can be solved after the solution for all other variables is determined.

By removing singleton rows and columns, we can often produce a reduced system that is smaller and far less dense, and in general having better numerical properties.

The basic procedure for using this class is as follows:

  1. Construct full problem: Construct and Epetra_LinearProblem containing the "full" matrix, RHS and LHS. This is done outside of Epetra_CrsSingletonFilter class. Presumably, you have some reason to believe that this system may contain singletons.
  2. Construct an Epetra_CrsSingletonFilter instance: Constructor needs no arguments.
  3. Analyze matrix: Invoke the Analyze() method, passing in the Epetra_RowMatrix object from your full linear problem mentioned in the first step above.
  4. Go/No Go decision to construct reduced problem: Query the results of the Analyze method using the SingletonsDetected() method. This method returns "true" if there were singletons found in the matrix. You can also query any of the other methods in the Filter Statistics section to determine if you want to proceed with the construction of the reduced system.
  5. Construct reduced problem: If, in the previous step, you determine that you want to proceed with the construction of the reduced problem, you should next call the ConstructReducedProblem() method, passing in the full linear problem object from the first step. This method will use the information from the Analyze() method to construct a reduce problem that has explicitly eliminated the singleton rows, solved for the corresponding LHS values and updated the RHS. This step will also remove singleton columns from the reduced system. Once the solution of the reduced problem is is computed (via any solver that understands an Epetra_LinearProblem), you should call the ComputeFullSolution() method to compute the LHS values assocaited with the singleton columns.
  6. Solve reduced problem: Obtain a pointer to the reduced problem using the ReducedProblem() method. Using the solver of your choice, solve the reduced system.
  7. Compute solution to full problem: Once the solution the reduced problem is determined, the ComputeFullSolution() method will place the reduced solution values into the appropriate locations of the full solution LHS and then compute the values associated with column singletons. At this point, you have a complete solution to the original full problem.
  8. Solve a subsequent full problem that differs from the original problem only in values: It is often the case that the structure of a problem will be the same for a sequence of linear problems. In this case, the UpdateReducedProblem() method can be useful. After going through the above process one time, if you have a linear problem that is structural identical to the previous problem, you can minimize memory and time costs by using the UpdateReducedProblem() method, passing in the subsequent problem. Once you have called the UpdateReducedProblem() method, you can then solve the reduce problem problem as you wish, and then compute the full solution as before. The pointer generated by ReducedProblem() will not change when UpdateReducedProblem() is called.

Definition at line 120 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

Constructor & Destructor Documentation

◆ LinearProblem_CrsSingletonFilter()

EpetraExt::LinearProblem_CrsSingletonFilter::LinearProblem_CrsSingletonFilter ( bool  verbose = false)

Epetra_CrsSingletonFilter default constructor.

Definition at line 60 of file EpetraExt_CrsSingletonFilter_LinearProblem.cpp.

◆ ~LinearProblem_CrsSingletonFilter()

EpetraExt::LinearProblem_CrsSingletonFilter::~LinearProblem_CrsSingletonFilter ( )
virtual

Epetra_CrsSingletonFilter Destructor.

Definition at line 67 of file EpetraExt_CrsSingletonFilter_LinearProblem.cpp.

Member Function Documentation

◆ operator()()

LinearProblem_CrsSingletonFilter::NewTypeRef EpetraExt::LinearProblem_CrsSingletonFilter::operator() ( OriginalTypeRef  orig)

◆ analyze()

bool EpetraExt::LinearProblem_CrsSingletonFilter::analyze ( OriginalTypeRef  orig)

◆ construct()

LinearProblem_CrsSingletonFilter::NewTypeRef EpetraExt::LinearProblem_CrsSingletonFilter::construct ( )
virtual

Construction of new object as a result of the transform.

Preconditions:

Invariants:

Postconditions:

The default implementation returns internal attribute newObj_.

Reimplemented from EpetraExt::Transform< Epetra_LinearProblem, Epetra_LinearProblem >.

Definition at line 159 of file EpetraExt_CrsSingletonFilter_LinearProblem.cpp.

◆ fwd()

bool EpetraExt::LinearProblem_CrsSingletonFilter::fwd ( )
virtual

Forward transfer of data from orig object input in the operator() method call to the new object created in this same call.

Returns true is operation is successful.

Preconditions:

Invariants:

Postconditions:

Implements EpetraExt::Transform< Epetra_LinearProblem, Epetra_LinearProblem >.

Definition at line 187 of file EpetraExt_CrsSingletonFilter_LinearProblem.cpp.

◆ rvs()

bool EpetraExt::LinearProblem_CrsSingletonFilter::rvs ( )
virtual

Reverse transfer of data from new object created in the operator() method call to the orig object input to this same method.

Returns true if operation is successful.

Preconditions:

Invariants:

Postconditions:

Implements EpetraExt::Transform< Epetra_LinearProblem, Epetra_LinearProblem >.

Definition at line 196 of file EpetraExt_CrsSingletonFilter_LinearProblem.cpp.

◆ Analyze()

int EpetraExt::LinearProblem_CrsSingletonFilter::Analyze ( Epetra_RowMatrix *  FullMatrix)

Analyze the input matrix, removing row/column pairs that have singletons.

Analyzes the user's input matrix to determine rows and columns that should be explicitly eliminated to create the reduced system. Look for rows and columns that have single entries.
These rows/columns can easily be removed from the problem.
The results of calling this method are two MapColoring objects accessible via RowMapColors() and ColMapColors() accessor methods. All rows/columns that would be eliminated in the reduced system have a color of 1 in the corresponding RowMapColors/ColMapColors object. All kept rows/cols have a color of 0.

Definition at line 259 of file EpetraExt_CrsSingletonFilter_LinearProblem.cpp.

◆ SingletonsDetected()

bool EpetraExt::LinearProblem_CrsSingletonFilter::SingletonsDetected ( ) const
inline

Returns true if singletons were detected in this matrix (must be called after Analyze() to be effective).

Definition at line 161 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ ConstructReducedProblem()

int EpetraExt::LinearProblem_CrsSingletonFilter::ConstructReducedProblem ( Epetra_LinearProblem *  Problem)

Return a reduced linear problem based on results of Analyze().

Creates a new Epetra_LinearProblem object based on the results of the Analyze phase. A pointer to the reduced problem is obtained via a call to ReducedProblem().

Returns
Error code, set to 0 if no error.

Definition at line 569 of file EpetraExt_CrsSingletonFilter_LinearProblem.cpp.

◆ UpdateReducedProblem()

int EpetraExt::LinearProblem_CrsSingletonFilter::UpdateReducedProblem ( Epetra_LinearProblem *  Problem)

Update a reduced linear problem using new values.

Updates an existing Epetra_LinearProblem object using new matrix, LHS and RHS values. The matrix structure must be identical to the matrix that was used to construct the original reduced problem.

Returns
Error code, set to 0 if no error.

Definition at line 692 of file EpetraExt_CrsSingletonFilter_LinearProblem.cpp.

◆ ComputeFullSolution()

int EpetraExt::LinearProblem_CrsSingletonFilter::ComputeFullSolution ( )

Compute a solution for the full problem using the solution of the reduced problem, put in LHS of FullProblem().

After solving the reduced linear system, this method can be called to compute the solution to the original problem, assuming the solution for the reduced system is valid. The solution of the unreduced, original problem will be in the LHS of the original Epetra_LinearProblem.

Definition at line 768 of file EpetraExt_CrsSingletonFilter_LinearProblem.cpp.

◆ NumRowSingletons()

int EpetraExt::LinearProblem_CrsSingletonFilter::NumRowSingletons ( ) const
inline

Return number of rows that contain a single entry, returns -1 if Analysis not performed yet.

Definition at line 193 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ NumColSingletons()

int EpetraExt::LinearProblem_CrsSingletonFilter::NumColSingletons ( ) const
inline

Return number of columns that contain a single entry that are not associated with singleton row, returns -1 if Analysis not performed yet.

Definition at line 196 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ NumSingletons()

int EpetraExt::LinearProblem_CrsSingletonFilter::NumSingletons ( ) const
inline

Return total number of singletons detected, returns -1 if Analysis not performed yet.

Return total number of singletons detected across all processors. This method will not return a valid result until after the Analyze() method is called. The dimension of the reduced system can be computed by subtracting this number from dimension of full system.

Warning
This method returns -1 if Analyze() method has not been called.

Definition at line 204 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ RatioOfDimensions()

double EpetraExt::LinearProblem_CrsSingletonFilter::RatioOfDimensions ( ) const
inline

Returns ratio of reduced system to full system dimensions, returns -1.0 if reduced problem not constructed.

Definition at line 207 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ RatioOfNonzeros()

double EpetraExt::LinearProblem_CrsSingletonFilter::RatioOfNonzeros ( ) const
inline

Returns ratio of reduced system to full system nonzero count, returns -1.0 if reduced problem not constructed.

Definition at line 210 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ FullProblem()

Epetra_LinearProblem* EpetraExt::LinearProblem_CrsSingletonFilter::FullProblem ( ) const
inline

Returns pointer to the original unreduced Epetra_LinearProblem.

Definition at line 216 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ ReducedProblem()

Epetra_LinearProblem* EpetraExt::LinearProblem_CrsSingletonFilter::ReducedProblem ( ) const
inline

Returns pointer to the derived reduced Epetra_LinearProblem.

Definition at line 219 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ FullMatrix()

Epetra_RowMatrix* EpetraExt::LinearProblem_CrsSingletonFilter::FullMatrix ( ) const
inline

Returns pointer to Epetra_CrsMatrix from full problem.

Definition at line 222 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ ReducedMatrix()

Epetra_CrsMatrix* EpetraExt::LinearProblem_CrsSingletonFilter::ReducedMatrix ( ) const
inline

Returns pointer to Epetra_CrsMatrix from full problem.

Definition at line 225 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ RowMapColors()

Epetra_MapColoring* EpetraExt::LinearProblem_CrsSingletonFilter::RowMapColors ( ) const
inline

Returns pointer to Epetra_MapColoring object: color 0 rows are part of reduced system.

Definition at line 228 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ ColMapColors()

Epetra_MapColoring* EpetraExt::LinearProblem_CrsSingletonFilter::ColMapColors ( ) const
inline

Returns pointer to Epetra_MapColoring object: color 0 columns are part of reduced system.

Definition at line 231 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ ReducedMatrixRowMap()

Epetra_Map* EpetraExt::LinearProblem_CrsSingletonFilter::ReducedMatrixRowMap ( ) const
inline

Returns pointer to Epetra_Map describing the reduced system row distribution.

Definition at line 234 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ ReducedMatrixColMap()

Epetra_Map* EpetraExt::LinearProblem_CrsSingletonFilter::ReducedMatrixColMap ( ) const
inline

Returns pointer to Epetra_Map describing the reduced system column distribution.

Definition at line 237 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ ReducedMatrixDomainMap()

Epetra_Map* EpetraExt::LinearProblem_CrsSingletonFilter::ReducedMatrixDomainMap ( ) const
inline

Returns pointer to Epetra_Map describing the domain map for the reduced system.

Definition at line 240 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ ReducedMatrixRangeMap()

Epetra_Map* EpetraExt::LinearProblem_CrsSingletonFilter::ReducedMatrixRangeMap ( ) const
inline

Returns pointer to Epetra_Map describing the range map for the reduced system.

Definition at line 243 of file EpetraExt_CrsSingletonFilter_LinearProblem.h.

◆ FullCrsMatrix()

Epetra_CrsMatrix* EpetraExt::LinearProblem_CrsSingletonFilter::FullCrsMatrix ( ) const
inlineprotected

◆ FullMatrixRowMap()

const Epetra_Map& EpetraExt::LinearProblem_CrsSingletonFilter::FullMatrixRowMap ( ) const
inlineprotected

◆ FullMatrixColMap()

const Epetra_Map& EpetraExt::LinearProblem_CrsSingletonFilter::FullMatrixColMap ( ) const
inlineprotected

◆ FullMatrixDomainMap()

const Epetra_Map& EpetraExt::LinearProblem_CrsSingletonFilter::FullMatrixDomainMap ( ) const
inlineprotected

◆ FullMatrixRangeMap()

const Epetra_Map& EpetraExt::LinearProblem_CrsSingletonFilter::FullMatrixRangeMap ( ) const
inlineprotected

◆ InitializeDefaults()

void EpetraExt::LinearProblem_CrsSingletonFilter::InitializeDefaults ( )
protected

◆ ComputeEliminateMaps()

int EpetraExt::LinearProblem_CrsSingletonFilter::ComputeEliminateMaps ( )
protected

◆ Setup()

int EpetraExt::LinearProblem_CrsSingletonFilter::Setup ( Epetra_LinearProblem *  Problem)
protected

◆ InitFullMatrixAccess()

int EpetraExt::LinearProblem_CrsSingletonFilter::InitFullMatrixAccess ( )
protected

◆ GetRow() [1/2]

int EpetraExt::LinearProblem_CrsSingletonFilter::GetRow ( int  Row,
int &  NumIndices,
int *&  Indices 
)
protected

◆ GetRow() [2/2]

int EpetraExt::LinearProblem_CrsSingletonFilter::GetRow ( int  Row,
int &  NumIndices,
double *&  Values,
int *&  Indices 
)
protected

◆ GetRowGCIDs() [1/2]

int EpetraExt::LinearProblem_CrsSingletonFilter::GetRowGCIDs ( int  Row,
int &  NumIndices,
double *&  Values,
int *&  GlobalIndices 
)
protected

◆ GetRowGCIDs() [2/2]

int EpetraExt::LinearProblem_CrsSingletonFilter::GetRowGCIDs ( int  Row,
int &  NumIndices,
double *&  Values,
long long *&  GlobalIndices 
)
protected

◆ CreatePostSolveArrays()

int EpetraExt::LinearProblem_CrsSingletonFilter::CreatePostSolveArrays ( const Epetra_IntVector &  RowIDs,
const Epetra_MapColoring &  RowMapColors,
const Epetra_IntVector &  ColProfiles,
const Epetra_IntVector &  NewColProfiles,
const Epetra_IntVector &  ColHasRowWithSingleton 
)
protected

◆ ConstructRedistributeExporter()

int EpetraExt::LinearProblem_CrsSingletonFilter::ConstructRedistributeExporter ( Epetra_Map *  SourceMap,
Epetra_Map *  TargetMap,
Epetra_Export *&  RedistributeExporter,
Epetra_Map *&  RedistributeMap 
)
protected

Member Data Documentation

◆ FullProblem_

Epetra_LinearProblem* EpetraExt::LinearProblem_CrsSingletonFilter::FullProblem_
protected

◆ ReducedProblem_

Teuchos::RCP<Epetra_LinearProblem> EpetraExt::LinearProblem_CrsSingletonFilter::ReducedProblem_
protected

◆ FullMatrix_

Epetra_RowMatrix* EpetraExt::LinearProblem_CrsSingletonFilter::FullMatrix_
protected

◆ FullCrsMatrix_

Epetra_CrsMatrix* EpetraExt::LinearProblem_CrsSingletonFilter::FullCrsMatrix_
protected

◆ ReducedMatrix_

Teuchos::RCP<Epetra_CrsMatrix> EpetraExt::LinearProblem_CrsSingletonFilter::ReducedMatrix_
protected

◆ ReducedRHS_

Epetra_MultiVector* EpetraExt::LinearProblem_CrsSingletonFilter::ReducedRHS_
protected

◆ ReducedLHS_

Epetra_MultiVector* EpetraExt::LinearProblem_CrsSingletonFilter::ReducedLHS_
protected

◆ ReducedMatrixRowMap_

Epetra_Map* EpetraExt::LinearProblem_CrsSingletonFilter::ReducedMatrixRowMap_
protected

◆ ReducedMatrixColMap_

Epetra_Map* EpetraExt::LinearProblem_CrsSingletonFilter::ReducedMatrixColMap_
protected

◆ ReducedMatrixDomainMap_

Epetra_Map* EpetraExt::LinearProblem_CrsSingletonFilter::ReducedMatrixDomainMap_
protected

◆ ReducedMatrixRangeMap_

Epetra_Map* EpetraExt::LinearProblem_CrsSingletonFilter::ReducedMatrixRangeMap_
protected

◆ OrigReducedMatrixDomainMap_

Epetra_Map* EpetraExt::LinearProblem_CrsSingletonFilter::OrigReducedMatrixDomainMap_
protected

◆ Full2ReducedRHSImporter_

Epetra_Import* EpetraExt::LinearProblem_CrsSingletonFilter::Full2ReducedRHSImporter_
protected

◆ Full2ReducedLHSImporter_

Epetra_Import* EpetraExt::LinearProblem_CrsSingletonFilter::Full2ReducedLHSImporter_
protected

◆ RedistributeDomainExporter_

Epetra_Export* EpetraExt::LinearProblem_CrsSingletonFilter::RedistributeDomainExporter_
protected

◆ ColSingletonRowLIDs_

int* EpetraExt::LinearProblem_CrsSingletonFilter::ColSingletonRowLIDs_
protected

◆ ColSingletonColLIDs_

int* EpetraExt::LinearProblem_CrsSingletonFilter::ColSingletonColLIDs_
protected

◆ ColSingletonPivotLIDs_

int* EpetraExt::LinearProblem_CrsSingletonFilter::ColSingletonPivotLIDs_
protected

◆ ColSingletonPivots_

double* EpetraExt::LinearProblem_CrsSingletonFilter::ColSingletonPivots_
protected

◆ AbsoluteThreshold_

int EpetraExt::LinearProblem_CrsSingletonFilter::AbsoluteThreshold_
protected

◆ RelativeThreshold_

double EpetraExt::LinearProblem_CrsSingletonFilter::RelativeThreshold_
protected

◆ NumMyRowSingletons_

int EpetraExt::LinearProblem_CrsSingletonFilter::NumMyRowSingletons_
protected

◆ NumMyColSingletons_

int EpetraExt::LinearProblem_CrsSingletonFilter::NumMyColSingletons_
protected

◆ NumGlobalRowSingletons_

int EpetraExt::LinearProblem_CrsSingletonFilter::NumGlobalRowSingletons_
protected

◆ NumGlobalColSingletons_

int EpetraExt::LinearProblem_CrsSingletonFilter::NumGlobalColSingletons_
protected

◆ RatioOfDimensions_

double EpetraExt::LinearProblem_CrsSingletonFilter::RatioOfDimensions_
protected

◆ RatioOfNonzeros_

double EpetraExt::LinearProblem_CrsSingletonFilter::RatioOfNonzeros_
protected

◆ HaveReducedProblem_

bool EpetraExt::LinearProblem_CrsSingletonFilter::HaveReducedProblem_
protected

◆ UserDefinedEliminateMaps_

bool EpetraExt::LinearProblem_CrsSingletonFilter::UserDefinedEliminateMaps_
protected

◆ AnalysisDone_

bool EpetraExt::LinearProblem_CrsSingletonFilter::AnalysisDone_
protected

◆ SymmetricElimination_

bool EpetraExt::LinearProblem_CrsSingletonFilter::SymmetricElimination_
protected

◆ tempExportX_

Epetra_MultiVector* EpetraExt::LinearProblem_CrsSingletonFilter::tempExportX_
protected

◆ tempX_

Epetra_MultiVector* EpetraExt::LinearProblem_CrsSingletonFilter::tempX_
protected

◆ tempB_

Epetra_MultiVector* EpetraExt::LinearProblem_CrsSingletonFilter::tempB_
protected

◆ RedistributeReducedLHS_

Epetra_MultiVector* EpetraExt::LinearProblem_CrsSingletonFilter::RedistributeReducedLHS_
protected

◆ Indices_int_

int* EpetraExt::LinearProblem_CrsSingletonFilter::Indices_int_
protected

◆ Indices_LL_

long long* EpetraExt::LinearProblem_CrsSingletonFilter::Indices_LL_
protected

◆ Values_

Epetra_SerialDenseVector EpetraExt::LinearProblem_CrsSingletonFilter::Values_
protected

◆ RowMapColors_

Epetra_MapColoring* EpetraExt::LinearProblem_CrsSingletonFilter::RowMapColors_
protected

◆ ColMapColors_

Epetra_MapColoring* EpetraExt::LinearProblem_CrsSingletonFilter::ColMapColors_
protected

◆ FullMatrixIsCrsMatrix_

bool EpetraExt::LinearProblem_CrsSingletonFilter::FullMatrixIsCrsMatrix_
protected

◆ MaxNumMyEntries_

int EpetraExt::LinearProblem_CrsSingletonFilter::MaxNumMyEntries_
protected

◆ verbose_

bool EpetraExt::LinearProblem_CrsSingletonFilter::verbose_
protected

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