From 4f509d9d279ecae508b9b2efaffaa8030bb6638a Mon Sep 17 00:00:00 2001 From: bangerth Date: Tue, 20 Nov 2012 04:33:40 +0000 Subject: [PATCH] One more test. git-svn-id: https://svn.dealii.org/trunk@27583 0785d39b-7218-0410-832d-ea1e28bc413d --- .../petsc/solver_03_precondition_parasails.cc | 90 +++++++++++++++++++ .../cmp/generic | 6 ++ 2 files changed, 96 insertions(+) create mode 100644 tests/petsc/solver_03_precondition_parasails.cc create mode 100644 tests/petsc/solver_03_precondition_parasails/cmp/generic diff --git a/tests/petsc/solver_03_precondition_parasails.cc b/tests/petsc/solver_03_precondition_parasails.cc new file mode 100644 index 0000000000..27db1117a1 --- /dev/null +++ b/tests/petsc/solver_03_precondition_parasails.cc @@ -0,0 +1,90 @@ +//---------------------------- petsc_solver_03_precondition_parasails.cc --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 2004, 2005, 2010, 2012 by the deal.II authors +// +// This file is subject to QPL and may not be distributed +// without copyright and license information. Please refer +// to the file deal.II/doc/license.html for the text and +// further information on this license. +// +//---------------------------- petsc_solver_03_precondition_parasails.cc --------------------------- + +// test the PETSc CG solver + + +#include "../tests.h" +#include "../lac/testmatrix.h" +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include + +template +void +check_solve( SOLVER& solver, const MATRIX& A, + VECTOR& u, VECTOR& f, const PRECONDITION& P) +{ + deallog << "Solver type: " << typeid(solver).name() << std::endl; + + u = 0.; + f = 1.; + try + { + solver.solve(A,u,f,P); + } + catch (std::exception& e) + { + deallog << e.what() << std::endl; + abort (); + } + + deallog << "Solver stopped after " << solver.control().last_step() + << " iterations" << std::endl; +} + + +int main(int argc, char **argv) +{ + std::ofstream logfile("solver_03_precondition_parasails/output"); + deallog.attach(logfile); + deallog << std::setprecision(4); + deallog.depth_console(0); + deallog.threshold_double(1.e-10); + + PetscInitialize(&argc,&argv,0,0); + { + SolverControl control(100, 1.e-3); + + const unsigned int size = 32; + unsigned int dim = (size-1)*(size-1); + + deallog << "Size " << size << " Unknowns " << dim << std::endl; + + // Make matrix + FDMatrix testproblem(size, size); + PETScWrappers::SparseMatrix A(dim, dim, 5); + testproblem.five_point(A); + + PETScWrappers::Vector f(dim); + PETScWrappers::Vector u(dim); + f = 1.; + A.compress (); + f.compress (); + u.compress (); + + PETScWrappers::SolverCG solver(control); + PETScWrappers::PreconditionParaSails preconditioner(A); + check_solve (solver, A,u,f, preconditioner); + } + PetscFinalize (); +} + diff --git a/tests/petsc/solver_03_precondition_parasails/cmp/generic b/tests/petsc/solver_03_precondition_parasails/cmp/generic new file mode 100644 index 0000000000..26fa018149 --- /dev/null +++ b/tests/petsc/solver_03_precondition_parasails/cmp/generic @@ -0,0 +1,6 @@ + +DEAL::Size 32 Unknowns 961 +DEAL::Solver type: N6dealii13PETScWrappers8SolverCGE +DEAL::Starting value 36.94 +DEAL::Convergence step 19 value 0.0008561 +DEAL::Solver stopped after 19 iterations -- 2.39.5