Amesos Development
|
Amesos_Klu: A serial, unblocked code ideal for getting started and for very sparse matrices, such as circuit matrces. More...
#include <Amesos_Umfpack.h>
Public Member Functions | |
Amesos_Klu (const Epetra_LinearProblem &LinearProblem) | |
Amesos_Klu Constructor. | |
~Amesos_Klu (void) | |
Amesos_Klu Destructor. | |
int | SymbolicFactorization () |
Performs SymbolicFactorization on the matrix A. | |
int | NumericFactorization () |
Performs NumericFactorization on the matrix A. | |
int | Solve () |
Solves A X = B (or AT x = B) | |
const Epetra_LinearProblem * | GetProblem () const |
Get a pointer to the Problem. | |
bool | MatrixShapeOK () const |
Returns true if KLU can handle this matrix shape. | |
int | SetUseTranspose (bool UseTranspose_in) |
SetUseTranpose(true) is more efficient in Amesos_Klu. | |
bool | UseTranspose () const |
Returns the current UseTranspose setting. | |
const Epetra_Comm & | Comm () const |
Returns a pointer to the Epetra_Comm communicator associated with this operator. | |
int | SetParameters (Teuchos::ParameterList &ParameterList) |
Updates internal variables. | |
int | NumSymbolicFact () const |
Returns the number of symbolic factorizations performed by this object. | |
int | NumNumericFact () const |
Returns the number of numeric factorizations performed by this object. | |
int | NumSolve () const |
Returns the number of solves performed by this object. | |
void | PrintTiming () const |
Prints timing information. | |
void | PrintStatus () const |
Prints information about the factorization and solution phases. | |
void | GetTiming (Teuchos::ParameterList &TimingParameterList) const |
Extracts timing information and places in parameter list. | |
![]() | |
virtual | ~Amesos_BaseSolver () |
Destructor. | |
virtual int | SymbolicFactorization ()=0 |
Performs SymbolicFactorization on the matrix A. | |
virtual int | NumericFactorization ()=0 |
Performs NumericFactorization on the matrix A. | |
virtual int | Solve ()=0 |
Solves A X = B (or AT x = B) | |
virtual int | SetUseTranspose (bool UseTranspose)=0 |
If set true, X will be set to the solution of AT X = B (not A X = B) | |
virtual bool | UseTranspose () const =0 |
Returns the current UseTranspose setting. | |
virtual int | SetParameters (Teuchos::ParameterList &ParameterList)=0 |
Updates internal variables. | |
virtual const Epetra_LinearProblem * | GetProblem () const =0 |
Returns the Epetra_LinearProblem. | |
virtual bool | MatrixShapeOK () const =0 |
Returns true if the solver can handle this matrix shape. | |
virtual const Epetra_Comm & | Comm () const =0 |
Returns a pointer to the Epetra_Comm communicator associated with this operator. | |
virtual int | NumSymbolicFact () const =0 |
Returns the number of symbolic factorizations performed by this object. | |
virtual int | NumNumericFact () const =0 |
Returns the number of numeric factorizations performed by this object. | |
virtual int | NumSolve () const =0 |
Returns the number of solves performed by this object. | |
virtual void | PrintStatus () const =0 |
Prints status information about the current solver. | |
virtual void | PrintTiming () const =0 |
Prints timing information about the current solver. | |
virtual void | setParameterList (Teuchos::RCP< Teuchos::ParameterList > const ¶mList) |
Redefined from Teuchos::ParameterListAcceptor (Does Not Work) | |
virtual Teuchos::RCP< Teuchos::ParameterList > | getNonconstParameterList () |
This is an empty stub. | |
virtual Teuchos::RCP< Teuchos::ParameterList > | unsetParameterList () |
This is an empty stub. | |
virtual void | GetTiming (Teuchos::ParameterList &TimingParameterList) const |
Extracts timing information from the current solver and places it in the parameter list. (Does Not Work) | |
Amesos_Klu: A serial, unblocked code ideal for getting started and for very sparse matrices, such as circuit matrces.
Interface to UMFPACK.
Interface to KLU internal solver.
Class Amesos_Klu is an object-oriented wrapper for KLU. KLU, whose sources are distributed within Amesos, is a serial solver for sparse matrices. KLU will solve a linear system of equations: A
is an Epetra_RowMatrix and X
and B
are Epetra_MultiVector objects.
Amesos_Klu computes
KLU is Tim Davis' implementation of Gilbert-Peierl's left-looking sparse partial pivoting algorithm, with Eisenstat & Liu's symmetric pruning. Gilbert's version appears as [L,U,P]=lu(A) in MATLAB. It doesn't exploit dense matrix kernels, but it is the only sparse LU factorization algorithm known to be asymptotically optimal, in the sense that it takes time proportional to the number of floating-point operations. It is the precursor to SuperLU, thus the name ("clark Kent LU"). For very sparse matrices that do not suffer much fill-in (such as most circuit matrices when permuted properly) dense matrix kernels do not help, and the asymptotic run-time is of practical importance.
The klu_btf
code first permutes the matrix to upper block triangular form (using two algorithms by Duff and Reid, MC13 and MC21, in the ACM Collected Algorithms). It then permutes each block via a symmetric minimum degree ordering (AMD, by Amestoy, Davis, and Duff). This ordering phase can be done just once for a sequence of matrices. Next, it factorizes each reordered block via the klu routine, which also attempts to preserve diagonal pivoting, but allows for partial pivoting if the diagonal is to small.
Amesos_Klu::Amesos_Klu | ( | const Epetra_LinearProblem & | LinearProblem | ) |
Amesos_Klu Constructor.
Creates an Amesos_Klu instance, using an Epetra_LinearProblem, passing in an already-defined Epetra_LinearProblem object.
Note: The operator in LinearProblem must be an Epetra_RowMatrix.
References SetParameters().
|
inlinevirtual |
Returns a pointer to the Epetra_Comm communicator associated with this operator.
Implements Amesos_BaseSolver.
References Comm(), and GetProblem().
Referenced by Comm(), and SymbolicFactorization().
|
inlinevirtual |
Get a pointer to the Problem.
Implements Amesos_BaseSolver.
Referenced by Comm(), and MatrixShapeOK().
|
inlinevirtual |
Extracts timing information and places in parameter list.
Reimplemented from Amesos_BaseSolver.
References Amesos_Time::GetTiming().
|
virtual |
Returns true if KLU can handle this matrix shape.
Returns true if the matrix shape is one that KLU can handle. KLU only works with square matrices.
Implements Amesos_BaseSolver.
References GetProblem().
|
virtual |
Performs NumericFactorization on the matrix A.
In addition to performing numeric factorization on the matrix A, the call to NumericFactorization() implies that no change will be made to the underlying matrix without a subsequent call to NumericFactorization().
<br >Preconditions:
<br >Postconditions:
Implements Amesos_BaseSolver.
References Amesos_Time::AddTime(), Amesos_Control::AddZeroToDiag_, Amesos_Status::IsNumericFactorizationOK_, Amesos_Status::IsSymbolicFactorizationOK_, Amesos_Status::NumNumericFact_, Amesos_Time::ResetTimer(), and SymbolicFactorization().
Referenced by Solve().
|
inlinevirtual |
Returns the number of numeric factorizations performed by this object.
Implements Amesos_BaseSolver.
References Amesos_Status::NumNumericFact_.
|
inlinevirtual |
Returns the number of solves performed by this object.
Implements Amesos_BaseSolver.
References Amesos_Status::NumSolve_.
|
inlinevirtual |
Returns the number of symbolic factorizations performed by this object.
Implements Amesos_BaseSolver.
References Amesos_Status::NumSymbolicFact_.
|
virtual |
Prints information about the factorization and solution phases.
Implements Amesos_BaseSolver.
References Amesos_Utils::PrintLine().
Referenced by ~Amesos_Klu().
|
virtual |
Prints timing information.
Implements Amesos_BaseSolver.
References Amesos_Time::GetTime(), Amesos_Status::NumNumericFact_, Amesos_Status::NumSolve_, Amesos_Status::NumSymbolicFact_, and Amesos_Utils::PrintLine().
Referenced by ~Amesos_Klu().
|
virtual |
Updates internal variables.
<br \>Preconditions:<ul> <li>None.</li> </ul> <br \>Postconditions:<ul> <li>Internal variables controlling the factorization and solve will be updated and take effect on all subseuent calls to NumericFactorization() and Solve().</li> <li>All parameters whose value are to differ from the default values must
be included in ParameterList. Parameters not specified in ParameterList revert to their default values.
Implements Amesos_BaseSolver.
Referenced by Amesos_Klu().
|
inlinevirtual |
SetUseTranpose(true) is more efficient in Amesos_Klu.
If SetUseTranspose() is set to true,
Implements Amesos_BaseSolver.
|
virtual |
Solves A X = B (or AT x = B)
<br >Preconditions:
<br >Postconditions:
Implements Amesos_BaseSolver.
References Amesos_Time::AddTime(), Amesos_Utils::ComputeTrueResidual(), Amesos_Status::ComputeTrueResidual_, Amesos_Utils::ComputeVectorNorms(), Amesos_Status::ComputeVectorNorms_, Amesos_Status::IsNumericFactorizationOK_, NumericFactorization(), Amesos_Status::NumSolve_, Amesos_Control::Reindex_, Amesos_Time::ResetTimer(), and UseTranspose().
|
virtual |
Performs SymbolicFactorization on the matrix A.
In addition to performing symbolic factorization on the matrix A, the call to SymbolicFactorization() implies that no change will be made to the non-zero structure of the underlying matrix without a subsequent call to SymbolicFactorization().
<br >Preconditions:
<br >Postconditions:
Implements Amesos_BaseSolver.
References Amesos_Time::AddTime(), Comm(), Amesos_Time::CreateTimer(), Amesos_Status::IsNumericFactorizationOK_, Amesos_Status::IsSymbolicFactorizationOK_, Amesos_Status::NumSymbolicFact_, Amesos_Control::Reindex_, and Amesos_Time::ResetTimer().
Referenced by NumericFactorization().
|
inlinevirtual |