ML  Version of the Day
 All Classes Namespaces Files Functions Variables Typedefs Enumerations Enumerator Friends Groups Pages
Functions
ml_MultiLevelPreconditioner_Smoothers.cpp File Reference

ML black-box preconditioner for Epetra_RowMatrix derived classes. More...

#include "ml_common.h"
#include "ml_include.h"
#include <algorithm>
#include "Epetra_Map.h"
#include "Epetra_Vector.h"
#include "Epetra_FECrsMatrix.h"
#include "Epetra_VbrMatrix.h"
#include "Epetra_SerialDenseMatrix.h"
#include "Epetra_SerialDenseVector.h"
#include "Epetra_SerialDenseSolver.h"
#include "Epetra_Import.h"
#include "Epetra_Time.h"
#include "Epetra_RowMatrix.h"
#include "Epetra_MpiComm.h"
#include "ml_ifpack_wrap.h"
#include "ml_self_wrap.h"
#include "Teuchos_ParameterList.hpp"
#include "Teuchos_RefCountPtr.hpp"
#include "ml_epetra.h"
#include "ml_epetra_utils.h"
#include "ml_MultiLevelPreconditioner.h"
#include "ml_viz_stats.h"
#include "ml_utils.h"
#include "Ifpack_Preconditioner.h"
#include "Ifpack_Chebyshev.h"
#include "ml_petsc.h"
Include dependency graph for ml_MultiLevelPreconditioner_Smoothers.cpp:

Functions

int ML_Anasazi_Get_SpectralNorm_Anasazi (ML_Operator *Amat, ML_Smoother *Smoother, int MaxIters, double Tolerance, int IsProblemSymmetric, int UseDiagonalScaling, double *LambdaMax)
 
double ML_Smoother_ChebyshevAlpha (double, ML *, int, int)
 
void ML_Operator_Blocked_Getrow (ML_Operator *Amat, int block_size, int requested_block_row, int allocated_space, int columns[], double values[], int row_lengths[])
 
void local_automatic_line_search (ML *ml, int currentLevel, int NumEqns, int *blockIndices, int last, int next, int LineID, double tol, int *itemp, double *dtemp)
 
int ML_Compute_Blocks_AutoLine (ML *ml, int currentLevel, int NumEqns, double tol, int *blockIndices)
 

Detailed Description

ML black-box preconditioner for Epetra_RowMatrix derived classes.

Authors
Marzio Sala, Ray Tuminaro, Jonathan Hu, Michael Gee, Chris Siefert