| 
    Amesos Development
    
   | 
 
Amesos_CssMKL: Interface to the CSSMKL package. More...
#include <Amesos_CssMKL.h>


Public Member Functions | |
| Amesos_CssMKL (const Epetra_LinearProblem &LinearProblem) | |
| Constructor.  | |
| ~Amesos_CssMKL () | |
| 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 CSSMKL can handle this matrix shape.   | |
| int | SetUseTranspose (bool UseTranspose) | 
| SetUseTranpose()   | |
| bool | UseTranspose () const | 
| Returns the current UseTranspose setting.   | |
| const Epetra_Comm & | Comm () const | 
| Returns a pointer to the Epetra_Comm communicator associated with this matrix.   | |
| int | SetParameters (Teuchos::ParameterList &ParameterList) | 
| Set parameters from the input parameters list, returns 0 if successful.   | |
| 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 from the current solver and places it in the parameter list.   | |
  Public Member Functions inherited from Amesos_BaseSolver | |
| virtual | ~Amesos_BaseSolver () | 
| Destructor.  | |
| 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.   | |
Amesos_CssMKL: Interface to the CSSMKL package.
      
  | 
  inlinevirtual | 
Returns a pointer to the Epetra_Comm communicator associated with this matrix.
Implements Amesos_BaseSolver.
References Comm(), and GetProblem().
Referenced by Comm(), PrintStatus(), PrintTiming(), Solve(), and SymbolicFactorization().
      
  | 
  inlinevirtual | 
Get a pointer to the Problem.
Implements Amesos_BaseSolver.
Referenced by Comm(), and MatrixShapeOK().
      
  | 
  inlinevirtual | 
Extracts timing information from the current solver and places it in the parameter list.
Reimplemented from Amesos_BaseSolver.
References Amesos_Time::GetTiming().
      
  | 
  virtual | 
Returns true if CSSMKL can handle this matrix shape.
Returns true if the matrix shape is one that CSSMKL can handle. CSSMKL only works with square matrices. 
 
Implements Amesos_BaseSolver.
References GetProblem().
      
  | 
  virtual | 
Performs NumericFactorization on the matrix A.
Implements Amesos_BaseSolver.
References Amesos_Status::IsNumericFactorizationOK_, Amesos_Status::IsSymbolicFactorizationOK_, Amesos_Status::NumNumericFact_, 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 Comm(), and Amesos_Utils::PrintLine().
Referenced by ~Amesos_CssMKL().
      
  | 
  virtual | 
Prints timing information.
Implements Amesos_BaseSolver.
References Comm(), Amesos_Time::GetTime(), Amesos_Status::NumNumericFact_, Amesos_Status::NumSolve_, Amesos_Status::NumSymbolicFact_, and Amesos_Utils::PrintLine().
Referenced by ~Amesos_CssMKL().
      
  | 
  virtual | 
Set parameters from the input parameters list, returns 0 if successful.
Implements Amesos_BaseSolver.
      
  | 
  inlinevirtual | 
SetUseTranpose()
If SetUseTranspose() is set to true, 
Implements Amesos_BaseSolver.
References UseTranspose().
      
  | 
  virtual | 
Solves A X = B (or AT X = B)
Implements Amesos_BaseSolver.
References Amesos_Time::AddTime(), Comm(), Amesos_Utils::ComputeTrueResidual(), Amesos_Status::ComputeTrueResidual_, Amesos_Utils::ComputeVectorNorms(), Amesos_Status::ComputeVectorNorms_, Amesos_Status::IsNumericFactorizationOK_, NumericFactorization(), Amesos_Status::NumSolve_, Amesos_Time::ResetTimer(), and UseTranspose().
      
  | 
  virtual | 
Performs SymbolicFactorization on the matrix A.
Implements Amesos_BaseSolver.
References Comm(), Amesos_Time::CreateTimer(), Amesos_Status::IsNumericFactorizationOK_, Amesos_Status::IsSymbolicFactorizationOK_, and Amesos_Status::NumSymbolicFact_.
Referenced by NumericFactorization().
      
  | 
  inlinevirtual | 
Returns the current UseTranspose setting.
Implements Amesos_BaseSolver.
Referenced by SetUseTranspose(), and Solve().