#include "ml_config.h"
#include "ml_common.h"
#if defined(HAVE_ML_MLAPI) && defined(HAVE_ML_GALERI)
using namespace Teuchos;
using namespace MLAPI;
int main(int argc, char *argv[])
{
#ifdef HAVE_MPI
MPI_Init(&argc,&argv);
#endif
try {
int NumGlobalElements = 100;
Space FineSpace(NumGlobalElements);
LHS = 0.0;
RHS = 1.0;
MLList.
set(
"max levels",2);
MLList.
set(
"increasing or decreasing",
"increasing");
MLList.
set(
"aggregation: type",
"Uncoupled");
MLList.
set(
"aggregation: damping factor", 0.0);
MLList.
set(
"smoother: type",
"symmetric Gauss-Seidel");
MLList.
set(
"smoother: sweeps",1);
MLList.
set(
"smoother: damping factor",1.0);
MLList.
set(
"coarse: max size",3);
MLList.
set(
"smoother: pre or post",
"both");
MLList.
set(
"coarse: type",
"Amesos-KLU");
MLList.
set(
"krylov: solver",
"gmres");
MLList.
set(
"krylov: max iterations", 1550);
MLList.
set(
"krylov: tolerance", 1e-9);
MLList.
set(
"krylov: output level", 10);
Krylov(FineMatrix, LHS, RHS, Prec, MLList);
std::cout << Prec;
}
catch (const int e) {
std::cerr << "Caught exception, code = " << e << std::endl;
}
catch (...) {
std::cerr << "Caught exception..." << std::endl;
}
#ifdef HAVE_MPI
MPI_Finalize();
#endif
return(0);
}
#else
#include "ml_include.h"
int main(int argc, char *argv[])
{
#ifdef HAVE_MPI
MPI_Init(&argc,&argv);
#endif
puts("This MLAPI example requires the following configuration options:");
puts("\t--enable-epetra");
puts("\t--enable-teuchos");
puts("\t--enable-ifpack");
puts("\t--enable-amesos");
puts("\t--enable-galeri");
puts("Please check your configure line.");
#ifdef HAVE_MPI
MPI_Finalize();
#endif
return(0);
}
#endif // #if defined(HAVE_ML_MLAPI)