assemble_system();
void
- solve_base();
+ solve_base(const unsigned int cycle);
void
- solve_cg();
+ solve_cg(const unsigned int cycle);
void
- solve_cgs();
+ solve_cgs(const unsigned int cycle);
void
- solve_gmres();
+ solve_gmres(const unsigned int cycle);
void
- solve_bicgstab();
+ solve_bicgstab(const unsigned int cycle);
void
- solve_tfqmr();
+ solve_tfqmr(const unsigned int cycle);
void
refine_grid();
LA::MPI::Vector locally_relevant_solution;
LA::MPI::Vector system_rhs;
- ConditionalOStream pcout;
- TimerOutput timer;
+ ConditionalOStream pcout_timer;
+
+ TimerOutput timer;
};
Test_Solver_Output::Test_Solver_Output()
Triangulation<2>::smoothing_on_coarsening))
, dof_handler(triangulation)
, fe(1)
- , pcout(std::cout, (Utilities::MPI::this_mpi_process(mpi_comm) == 0))
- ,
- // pcout(deallog.get_file_stream(),
- // (Utilities::MPI::this_mpi_process(mpi_comm) == 0)),
- timer(mpi_comm, pcout, TimerOutput::never, TimerOutput::wall_times)
+ , pcout_timer(std::cout, (Utilities::MPI::this_mpi_process(mpi_comm) == 0))
+ , timer(mpi_comm, pcout_timer, TimerOutput::never, TimerOutput::wall_times)
{}
Test_Solver_Output::~Test_Solver_Output()
const unsigned int n_cycles = 2;
for (unsigned int cycle = 0; cycle < n_cycles; ++cycle)
{
- pcout << " Cycle: " << cycle << std::endl;
+ deallog << " Cycle: " << cycle << std::endl;
if (cycle == 0)
{
make_grid();
setup_system();
- pcout << " Number of active cells: "
- << triangulation.n_global_active_cells() << std::endl
- << " Number of degrees of freedom: " << dof_handler.n_dofs()
- << std::endl;
+ deallog << " Number of active cells: "
+ << triangulation.n_global_active_cells() << std::endl
+ << " Number of degrees of freedom: " << dof_handler.n_dofs()
+ << std::endl;
assemble_system();
- solve_base();
- solve_cg();
- solve_cgs();
- solve_gmres();
- solve_bicgstab();
- solve_tfqmr();
+ solve_base(cycle);
+ solve_cg(cycle);
+ solve_cgs(cycle);
+ solve_gmres(cycle);
+ solve_bicgstab(cycle);
+ solve_tfqmr(cycle);
// {
// TimerOutput::Scope t(timer, "output");
// timer.print_summary();
// timer.reset();
- pcout << std::endl << std::endl << std::endl;
+ deallog << std::endl << std::endl << std::endl;
}
}
}
void
-Test_Solver_Output::solve_base()
+Test_Solver_Output::solve_base(const unsigned int cycle)
{
TimerOutput::Scope t(timer, "solve_base");
- pcout << "Solving using SolverBase" << std::endl;
+ deallog << "Solving using SolverBase" << std::endl;
LA::MPI::Vector completely_distributed_solution(locally_owned_dofs, mpi_comm);
TrilinosWrappers::SolverBase solver(TrilinosWrappers::SolverBase::cg,
solver_control,
solver_data);
- solver.solve(system_matrix,
- completely_distributed_solution,
- system_rhs,
- prec);
-
- pcout << " Solved in " << solver_control.last_step() << " iterations."
- << std::endl;
+ check_solver_within_range(solver.solve(system_matrix,
+ completely_distributed_solution,
+ system_rhs,
+ prec),
+ solver_control.last_step(),
+ (cycle == 0 ? 1 : 11),
+ (cycle == 0 ? 2 : 15));
constraints.distribute(completely_distributed_solution);
locally_relevant_solution = completely_distributed_solution;
}
void
-Test_Solver_Output::solve_cg()
+Test_Solver_Output::solve_cg(const unsigned int cycle)
{
TimerOutput::Scope t(timer, "solve_cg");
- pcout << "Solving using SolverCG" << std::endl;
+ deallog << "Solving using SolverCG" << std::endl;
LA::MPI::Vector completely_distributed_solution(locally_owned_dofs, mpi_comm);
SolverControl solver_control(100, 1e-12);
LA::SolverCG::AdditionalData solver_data(true);
LA::SolverCG solver(solver_control, solver_data);
- solver.solve(system_matrix,
- completely_distributed_solution,
- system_rhs,
- prec);
-
- pcout << " Solved in " << solver_control.last_step() << " iterations."
- << std::endl;
+ check_solver_within_range(solver.solve(system_matrix,
+ completely_distributed_solution,
+ system_rhs,
+ prec),
+ solver_control.last_step(),
+ (cycle == 0 ? 1 : 11),
+ (cycle == 0 ? 2 : 15));
constraints.distribute(completely_distributed_solution);
locally_relevant_solution = completely_distributed_solution;
}
void
-Test_Solver_Output::solve_cgs()
+Test_Solver_Output::solve_cgs(const unsigned int cycle)
{
TimerOutput::Scope t(timer, "solve_cgs");
- pcout << "Solving using SolverCGS" << std::endl;
+ deallog << "Solving using SolverCGS" << std::endl;
LA::MPI::Vector completely_distributed_solution(locally_owned_dofs, mpi_comm);
SolverControl solver_control(100, 1e-12);
TrilinosWrappers::SolverCGS::AdditionalData solver_data(true);
TrilinosWrappers::SolverCGS solver(solver_control, solver_data);
- solver.solve(system_matrix,
- completely_distributed_solution,
- system_rhs,
- prec);
-
- pcout << " Solved in " << solver_control.last_step() << " iterations."
- << std::endl;
+ check_solver_within_range(solver.solve(system_matrix,
+ completely_distributed_solution,
+ system_rhs,
+ prec),
+ solver_control.last_step(),
+ (cycle == 0 ? 1 : 5),
+ (cycle == 0 ? 2 : 9));
constraints.distribute(completely_distributed_solution);
locally_relevant_solution = completely_distributed_solution;
}
void
-Test_Solver_Output::solve_gmres()
+Test_Solver_Output::solve_gmres(const unsigned int cycle)
{
TimerOutput::Scope t(timer, "solve_gmres");
- pcout << "Solving using SolverGMRES" << std::endl;
+ deallog << "Solving using SolverGMRES" << std::endl;
LA::MPI::Vector completely_distributed_solution(locally_owned_dofs, mpi_comm);
SolverControl solver_control(100, 1e-12);
LA::SolverGMRES::AdditionalData solver_data(true, 25);
LA::SolverGMRES solver(solver_control, solver_data);
- solver.solve(system_matrix,
- completely_distributed_solution,
- system_rhs,
- prec);
-
- pcout << " Solved in " << solver_control.last_step() << " iterations."
- << std::endl;
+ check_solver_within_range(solver.solve(system_matrix,
+ completely_distributed_solution,
+ system_rhs,
+ prec),
+ solver_control.last_step(),
+ (cycle == 0 ? 1 : 11),
+ (cycle == 0 ? 2 : 15));
constraints.distribute(completely_distributed_solution);
locally_relevant_solution = completely_distributed_solution;
}
void
-Test_Solver_Output::solve_bicgstab()
+Test_Solver_Output::solve_bicgstab(const unsigned int cycle)
{
TimerOutput::Scope t(timer, "solve_bicgstab");
- pcout << "Solving using SolverBicgstab" << std::endl;
+ deallog << "Solving using SolverBicgstab" << std::endl;
LA::MPI::Vector completely_distributed_solution(locally_owned_dofs, mpi_comm);
SolverControl solver_control(100, 1e-12);
TrilinosWrappers::SolverBicgstab::AdditionalData solver_data(true);
TrilinosWrappers::SolverBicgstab solver(solver_control, solver_data);
- solver.solve(system_matrix,
- completely_distributed_solution,
- system_rhs,
- prec);
-
- pcout << " Solved in " << solver_control.last_step() << " iterations."
- << std::endl;
+ check_solver_within_range(solver.solve(system_matrix,
+ completely_distributed_solution,
+ system_rhs,
+ prec),
+ solver_control.last_step(),
+ (cycle == 0 ? 1 : 5),
+ (cycle == 0 ? 2 : 9));
constraints.distribute(completely_distributed_solution);
locally_relevant_solution = completely_distributed_solution;
}
void
-Test_Solver_Output::solve_tfqmr()
+Test_Solver_Output::solve_tfqmr(const unsigned int cycle)
{
TimerOutput::Scope t(timer, "solve_tfqmr");
- pcout << "Solving using SolverTFQMR" << std::endl;
+ deallog << "Solving using SolverTFQMR" << std::endl;
LA::MPI::Vector completely_distributed_solution(locally_owned_dofs, mpi_comm);
SolverControl solver_control(100, 1e-12);
TrilinosWrappers::SolverTFQMR::AdditionalData solver_data(true);
TrilinosWrappers::SolverTFQMR solver(solver_control, solver_data);
- solver.solve(system_matrix,
- completely_distributed_solution,
- system_rhs,
- prec);
-
- pcout << " Solved in " << solver_control.last_step() << " iterations."
- << std::endl;
+ check_solver_within_range(solver.solve(system_matrix,
+ completely_distributed_solution,
+ system_rhs,
+ prec),
+ solver_control.last_step(),
+ (cycle == 0 ? 1 : 5),
+ (cycle == 0 ? 2 : 9));
constraints.distribute(completely_distributed_solution);
locally_relevant_solution = completely_distributed_solution;
Test_Solver_Output problem;
problem.run();
-
- // Trilinos dumps the output into std::cout
- // We catch this output and it is written to the stdout logfile
- // Since we're interested in this output we read it back in and
- // write parts of it to the logstream
- // We can only do this reliably if we are not running in parallel (sometimes
- // stdout is not written yet otherwise)
- if (Utilities::MPI::n_mpi_processes(MPI_COMM_WORLD) == 1)
- {
- std::ifstream inputfile;
- inputfile.open("stdout");
- Assert(inputfile.good() && inputfile.is_open(), ExcIO());
- std::string line;
- const std::string key = "*****";
- while (std::getline(inputfile, line))
- {
- if (line.find(key) != std::string::npos)
- deallog << line << std::endl;
- }
- inputfile.close();
- }
- deallog << "OK" << std::endl;
-
- return 0;
}
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=1, ~/Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=1, ~/Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CGS solution
-DEAL:: ***** ML (L=1, ~/Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned GMRES solution
-DEAL:: ***** ML (L=1, ~/Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned BICGSTAB solution
-DEAL:: ***** ML (L=1, ~/Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned TFQMR solution
-DEAL:: ***** ML (L=1, ~/Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=2, Cheby_pre0/Cheby_post0, ~/Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=2, Cheby_pre0/Cheby_post0, ~/Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CGS solution
-DEAL:: ***** ML (L=2, Cheby_pre0/Cheby_post0, ~/Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned GMRES solution
-DEAL:: ***** ML (L=2, Cheby_pre0/Cheby_post0, ~/Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned BICGSTAB solution
-DEAL:: ***** ML (L=2, Cheby_pre0/Cheby_post0, ~/Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned TFQMR solution
-DEAL:: ***** ML (L=2, Cheby_pre0/Cheby_post0, ~/Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL::OK
+DEAL:: Cycle: 0
+DEAL:: Number of active cells: 1024
+DEAL:: Number of degrees of freedom: 1089
+DEAL::Solving using SolverBase
+DEAL::Solver stopped within 1 - 2 iterations
+DEAL::Solving using SolverCG
+DEAL::Solver stopped within 1 - 2 iterations
+DEAL::Solving using SolverCGS
+DEAL::Solver stopped within 1 - 2 iterations
+DEAL::Solving using SolverGMRES
+DEAL::Solver stopped within 1 - 2 iterations
+DEAL::Solving using SolverBicgstab
+DEAL::Solver stopped within 1 - 2 iterations
+DEAL::Solving using SolverTFQMR
+DEAL::Solver stopped within 1 - 2 iterations
+DEAL::
+DEAL::
+DEAL::
+DEAL:: Cycle: 1
+DEAL:: Number of active cells: 1960
+DEAL:: Number of degrees of freedom: 2153
+DEAL::Solving using SolverBase
+DEAL::Solver stopped within 11 - 15 iterations
+DEAL::Solving using SolverCG
+DEAL::Solver stopped within 11 - 15 iterations
+DEAL::Solving using SolverCGS
+DEAL::Solver stopped within 5 - 9 iterations
+DEAL::Solving using SolverGMRES
+DEAL::Solver stopped within 11 - 15 iterations
+DEAL::Solving using SolverBicgstab
+DEAL::Solver stopped within 5 - 9 iterations
+DEAL::Solving using SolverTFQMR
+DEAL::Solver stopped within 5 - 9 iterations
+DEAL::
+DEAL::
+DEAL::
+++ /dev/null
-
-DEAL::OK
+++ /dev/null
-
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=1, /Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=1, /Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CGS solution
-DEAL:: ***** ML (L=1, /Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned GMRES solution
-DEAL:: ***** ML (L=1, /Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned BICGSTAB solution
-DEAL:: ***** ML (L=1, /Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned TFQMR solution
-DEAL:: ***** ML (L=1, /Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=2, /Cheby_post0, /Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=2, /Cheby_post0, /Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CGS solution
-DEAL:: ***** ML (L=2, /Cheby_post0, /Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned GMRES solution
-DEAL:: ***** ML (L=2, /Cheby_post0, /Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned BICGSTAB solution
-DEAL:: ***** ML (L=2, /Cheby_post0, /Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned TFQMR solution
-DEAL:: ***** ML (L=2, /Cheby_post0, /Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL::OK
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=1, ~/Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=1, ~/Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CGS solution
-DEAL:: ***** ML (L=1, ~/Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned GMRES solution
-DEAL:: ***** ML (L=1, ~/Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned BICGSTAB solution
-DEAL:: ***** ML (L=1, ~/Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned TFQMR solution
-DEAL:: ***** ML (L=1, ~/Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=2, Cheby_pre0/Cheby_post0, ~/Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=2, Cheby_pre0/Cheby_post0, ~/Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CGS solution
-DEAL:: ***** ML (L=2, Cheby_pre0/Cheby_post0, ~/Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned GMRES solution
-DEAL:: ***** ML (L=2, Cheby_pre0/Cheby_post0, ~/Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned BICGSTAB solution
-DEAL:: ***** ML (L=2, Cheby_pre0/Cheby_post0, ~/Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned TFQMR solution
-DEAL:: ***** ML (L=2, Cheby_pre0/Cheby_post0, ~/Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL::OK
+DEAL:: Cycle: 0
+DEAL:: Number of active cells: 1024
+DEAL:: Number of degrees of freedom: 1089
+DEAL::Solving using SolverBase
+DEAL::Solver stopped within 1 - 2 iterations
+DEAL::Solving using SolverCG
+DEAL::Solver stopped within 1 - 2 iterations
+DEAL::Solving using SolverCGS
+DEAL::Solver stopped within 1 - 2 iterations
+DEAL::Solving using SolverGMRES
+DEAL::Solver stopped within 1 - 2 iterations
+DEAL::Solving using SolverBicgstab
+DEAL::Solver stopped within 1 - 2 iterations
+DEAL::Solving using SolverTFQMR
+DEAL::Solver stopped within 1 - 2 iterations
+DEAL::
+DEAL::
+DEAL::
+DEAL:: Cycle: 1
+DEAL:: Number of active cells: 1960
+DEAL:: Number of degrees of freedom: 2153
+DEAL::Solving using SolverBase
+DEAL::Solver stopped within 11 - 15 iterations
+DEAL::Solving using SolverCG
+DEAL::Solver stopped within 11 - 15 iterations
+DEAL::Solving using SolverCGS
+DEAL::Solver stopped within 5 - 9 iterations
+DEAL::Solving using SolverGMRES
+DEAL::Solver stopped within 11 - 15 iterations
+DEAL::Solving using SolverBicgstab
+DEAL::Solver stopped within 5 - 9 iterations
+DEAL::Solving using SolverTFQMR
+DEAL::Solver stopped within 5 - 9 iterations
+DEAL::
+DEAL::
+DEAL::
+++ /dev/null
-
-DEAL::OK
+++ /dev/null
-
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=1, /Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=1, /Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CGS solution
-DEAL:: ***** ML (L=1, /Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned GMRES solution
-DEAL:: ***** ML (L=1, /Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned BICGSTAB solution
-DEAL:: ***** ML (L=1, /Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned TFQMR solution
-DEAL:: ***** ML (L=1, /Amesos_KLU_0, )
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=2, /Cheby_post0, /Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CG solution
-DEAL:: ***** ML (L=2, /Cheby_post0, /Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned CGS solution
-DEAL:: ***** ML (L=2, /Cheby_post0, /Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned GMRES solution
-DEAL:: ***** ML (L=2, /Cheby_post0, /Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned BICGSTAB solution
-DEAL:: ***** ML (L=2, /Cheby_post0, /Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL:: *******************************************************
-DEAL:: ***** Problem: Epetra::CrsMatrix
-DEAL:: ***** Preconditioned TFQMR solution
-DEAL:: ***** ML (L=2, /Cheby_post0, /Amesos_KLU_1)
-DEAL:: ***** No scaling
-DEAL:: *******************************************************
-DEAL::OK