1This file is out of date. It has not been refactored to use
Amesos_Status.
120#ifndef _AMESOS_MERIKOS_H_
121#define _AMESOS_MERIKOS_H_
125#include "Epetra_LinearProblem.h"
126#include "Epetra_Time.h"
128#include "Epetra_MpiComm.h"
130#include "Epetra_Comm.h"
132#include "Epetra_CrsGraph.h"
Amesos_BaseSolver: A pure virtual class for direct solution of real-valued double-precision operators...
Amesos_Merikos: A parallel divide and conquer solver.
int SetParameters(Teuchos::ParameterList &ParameterList)
Updates internal variables.
Amesos_Merikos(const Epetra_LinearProblem &LinearProblem)
Amesos_Merikos Constructor.
Epetra_Map * ScaLAPACK1DMap_
std::vector< double > DenseA_
int SetUseTranspose(bool UseTranspose)
SetUseTranpose() controls whether to compute AX=B or ATX = B.
const Epetra_Comm & Comm() const
Returns a pointer to the Epetra_Comm communicator associated with this matrix.
int Solve()
Solves A X = B.
int NumericFactorization()
Performs NumericFactorization on the matrix A.
int NumSolve() const
Returns the number of solves performed by this object.
int NumNumericFact() const
Returns the number of numeric factorizations performed by this object.
Epetra_CrsMatrix * FatOut_
const Epetra_LinearProblem * Problem_
int SymbolicFactorization()
Performs SymbolicFactorization on the matrix A.
int PerformNumericFactorization()
const Epetra_LinearProblem * GetProblem() const
Get a pointer to the Problem.
int RedistributeA()
Performs SymbolicFactorization on the matrix A.
~Amesos_Merikos(void)
Amesos_Merikos Destructor.
int LSolve()
Solves L X = B.
bool MatrixShapeOK() const
Returns true if MERIKOS can handle this matrix shape.
int USolve()
Solves U X = B.
bool ComputeTrueResidual_
void PrintTiming()
Print timing information.
Epetra_CrsMatrix * ScaLAPACK1DMatrix_
void PrintStatus()
Print information about the factorization and solution phases.
int NumSymbolicFact() const
Returns the number of symbolic factorizations performed by this object.
bool UseTranspose() const
Returns the current UseTranspose setting.
Amesos_Status: Container for some status variables.