]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Remove a test that checks PETSc's Richardson solver but that has never worked and...
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 29 Nov 2012 16:16:47 +0000 (16:16 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Thu, 29 Nov 2012 16:16:47 +0000 (16:16 +0000)
git-svn-id: https://svn.dealii.org/trunk@27704 0785d39b-7218-0410-832d-ea1e28bc413d

tests/petsc/deal_solver_06.cc [deleted file]
tests/petsc/deal_solver_06/cmp/generic [deleted file]
tests/petsc/deal_solver_06/cmp/i386-apple-darwin8.10.1+gcc4.0 [deleted file]
tests/petsc/deal_solver_06/cmp/x86_64-unknown-linux-gnu+gcc4.1 [deleted file]

diff --git a/tests/petsc/deal_solver_06.cc b/tests/petsc/deal_solver_06.cc
deleted file mode 100644 (file)
index 768aad6..0000000
+++ /dev/null
@@ -1,95 +0,0 @@
-//----------------------------  petsc_deal_solver_06.cc  ---------------------------
-//    $Id$
-//    Version: $Name$
-//
-//    Copyright (C) 2004, 2005, 2010 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_deal_solver_06.cc  ---------------------------
-
-// test the Richardson solver using the PETSc matrix and vector classes
-
-
-#include "../tests.h"
-#include "../lac/testmatrix.h"
-#include <cmath>
-#include <fstream>
-#include <iostream>
-#include <iomanip>
-#include <deal.II/base/logstream.h>
-#include <deal.II/lac/petsc_sparse_matrix.h>
-#include <deal.II/lac/petsc_vector.h>
-#include <deal.II/lac/solver_control.h>
-#include <deal.II/lac/solver_cg.h>
-#include <deal.II/lac/solver_gmres.h>
-#include <deal.II/lac/solver_bicgstab.h>
-#include <deal.II/lac/solver_richardson.h>
-#include <deal.II/lac/solver_qmrs.h>
-#include <deal.II/lac/precondition.h>
-#include <deal.II/lac/vector_memory.h>
-#include <typeinfo>
-
-template<class SOLVER, class MATRIX, class VECTOR, class PRECONDITION>
-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;
-    }
-
-  deallog << "Solver stopped after " << solver.control().last_step()
-          << " iterations" << std::endl;
-}
-
-
-int main(int argc, char **argv)
-{
-  std::ofstream logfile("deal_solver_06/output");
-  logfile.precision(4);
-  deallog.attach(logfile);
-  deallog.depth_console(0);
-  deallog.threshold_double(1.e-10);
-
-  PetscInitialize(&argc,&argv,0,0);
-  {
-    const unsigned int size = 32;
-    unsigned int dim = (size-1)*(size-1);
-    SolverControl control(10000, 1.e-3);
-
-    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 ();
-
-    GrowingVectorMemory<PETScWrappers::Vector> mem;
-    SolverRichardson<PETScWrappers::Vector> solver(control,mem);
-    PreconditionIdentity preconditioner;
-    check_solve (solver, A,u,f, preconditioner);
-  }
-  GrowingVectorMemory<PETScWrappers::Vector>::release_unused_memory ();
-  PetscFinalize ();
-}
-
diff --git a/tests/petsc/deal_solver_06/cmp/generic b/tests/petsc/deal_solver_06/cmp/generic
deleted file mode 100644 (file)
index 6ec093f..0000000
+++ /dev/null
@@ -1,7 +0,0 @@
-
-DEAL::Size 32 Unknowns 961
-DEAL::Solver type: N6dealii16SolverRichardsonINS_13PETScWrappers6VectorEEE
-DEAL:Richardson::Starting value 31.0000
-DEAL:Richardson::Failure step 372 value nan
-DEAL::Iterative method reported convergence failure in step 372 with residual nan
-DEAL::Solver stopped after 372 iterations
diff --git a/tests/petsc/deal_solver_06/cmp/i386-apple-darwin8.10.1+gcc4.0 b/tests/petsc/deal_solver_06/cmp/i386-apple-darwin8.10.1+gcc4.0
deleted file mode 100644 (file)
index de4c75b..0000000
+++ /dev/null
@@ -1,9 +0,0 @@
-
-DEAL::Size 32 Unknowns 961
-DEAL::Solver type: N6dealii16SolverRichardsonINS_13PETScWrappers6VectorEEE
-DEAL:Richardson::Starting value 31.00
-DEAL:Richardson::Failure step 10000 value nan
-DEAL::Iterative method reported convergence failure in step 10000 with residual nan
-DEAL::Solver stopped after 10000 iterations
-DEAL::GrowingVectorMemory:Overall allocated vectors: 2
-DEAL::GrowingVectorMemory:Maximum allocated vectors: 2
diff --git a/tests/petsc/deal_solver_06/cmp/x86_64-unknown-linux-gnu+gcc4.1 b/tests/petsc/deal_solver_06/cmp/x86_64-unknown-linux-gnu+gcc4.1
deleted file mode 100644 (file)
index 06d10a0..0000000
+++ /dev/null
@@ -1,7 +0,0 @@
-
-DEAL::Size 32 Unknowns 961
-DEAL::Solver type: N6dealii16SolverRichardsonINS_13PETScWrappers6VectorEEE
-DEAL:Richardson::Starting value 31.0000
-DEAL:Richardson::Failure step 374 value nan
-DEAL::Iterative method reported convergence failure in step 374 with residual nan
-DEAL::Solver stopped after 374 iterations

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.