]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Delete tests that apparently never worked successfully.
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 15 Oct 2010 21:47:18 +0000 (21:47 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 15 Oct 2010 21:47:18 +0000 (21:47 +0000)
git-svn-id: https://svn.dealii.org/trunk@22352 0785d39b-7218-0410-832d-ea1e28bc413d

tests/trilinos/solver_06.cc [deleted file]
tests/trilinos/solver_06/cmp/generic [deleted file]
tests/trilinos/solver_06/cmp/i386-apple-darwin8.10.1+gcc4.0 [deleted file]
tests/trilinos/solver_06/cmp/powerpc-apple-darwin8.10.0+gcc4.0 [deleted file]
tests/trilinos/solver_08.cc [deleted file]
tests/trilinos/solver_08/cmp/generic [deleted file]

diff --git a/tests/trilinos/solver_06.cc b/tests/trilinos/solver_06.cc
deleted file mode 100644 (file)
index 29e5436..0000000
+++ /dev/null
@@ -1,96 +0,0 @@
-//----------------------------  trilinos_solver_06.cc  ---------------------------
-//    $Id$
-//    Version: $Name$ 
-//
-//    Copyright (C) 2004, 2005, 2008 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.
-//
-//----------------------------  trilinos_solver_06.cc  ---------------------------
-
-// test the Trilinos Bicgstab solver
-
-
-#include "../tests.h" 
-#include <base/utilities.h>
-#include "../lac/testmatrix.h"
-#include <cmath>
-#include <fstream>
-#include <iostream>
-#include <iomanip>
-#include <base/logstream.h>
-#include <lac/trilinos_sparse_matrix.h>
-#include <lac/trilinos_vector.h>
-#include <lac/trilinos_solver.h>
-#include <lac/trilinos_precondition.h>
-#include <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;
-      abort ();
-    }
-
-  deallog << "Solver stopped after " << solver.control().last_step()
-          << " iterations" << std::endl;
-}
-
-
-int main(int argc, char **argv)
-{
-  std::ofstream logfile("solver_06/output");
-  logfile.precision(4);
-  deallog.attach(logfile);
-  deallog.depth_console(0);
-  deallog.threshold_double(1.e-10); 
-
-  Utilities::System::MPI_InitFinalize mpi_initialization (argc, argv);
-
-  
-  {
-    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);
-    CompressedSimpleSparsityPattern csp (dim, dim);
-    testproblem.five_point_structure(csp);
-    TrilinosWrappers::SparseMatrix  A;
-    A.reinit(csp);
-    testproblem.five_point(A);
-
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u(dim);
-    f = 1.;
-    A.compress ();
-    f.compress ();
-    u.compress ();
-
-    TrilinosWrappers::SolverBicgstab solver(control);
-    TrilinosWrappers::PreconditionJacobi preconditioner;
-    preconditioner.initialize(A);
-    check_solve (solver, A,u,f, preconditioner);
-  }
-}
-
diff --git a/tests/trilinos/solver_06/cmp/generic b/tests/trilinos/solver_06/cmp/generic
deleted file mode 100644 (file)
index fadfbe5..0000000
+++ /dev/null
@@ -1,6 +0,0 @@
-
-DEAL::Size 32 Unknowns 961
-DEAL::Solver type: N6dealii13TrilinosWrappers14SolverBicgstabE
-DEAL::Starting value 7.750
-DEAL::Convergence step 33 value 0.0005745
-DEAL::Solver stopped after 33 iterations
diff --git a/tests/trilinos/solver_06/cmp/i386-apple-darwin8.10.1+gcc4.0 b/tests/trilinos/solver_06/cmp/i386-apple-darwin8.10.1+gcc4.0
deleted file mode 100644 (file)
index 6448328..0000000
+++ /dev/null
@@ -1,6 +0,0 @@
-
-DEAL::Size 32 Unknowns 961
-DEAL::Solver type: N6dealii13TrilinosWrappers14SolverBicgstabE
-DEAL::Starting value 7.750
-DEAL::Convergence step 33 value 0.0005777
-DEAL::Solver stopped after 33 iterations
diff --git a/tests/trilinos/solver_06/cmp/powerpc-apple-darwin8.10.0+gcc4.0 b/tests/trilinos/solver_06/cmp/powerpc-apple-darwin8.10.0+gcc4.0
deleted file mode 100644 (file)
index d06770b..0000000
+++ /dev/null
@@ -1,6 +0,0 @@
-
-DEAL::Size 32 Unknowns 961
-DEAL::Solver type: N6dealii13TrilinosWrappers14SolverBicgstabE
-DEAL::Starting value 7.750
-DEAL::Convergence step 33 value 0.0005766
-DEAL::Solver stopped after 33 iterations
diff --git a/tests/trilinos/solver_08.cc b/tests/trilinos/solver_08.cc
deleted file mode 100644 (file)
index 643bbbe..0000000
+++ /dev/null
@@ -1,96 +0,0 @@
-//----------------------------  trilinos_solver_08.cc  ---------------------------
-//    $Id$
-//    Version: $Name$ 
-//
-//    Copyright (C) 2004, 2005, 2008 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.
-//
-//----------------------------  trilinos_solver_08.cc  ---------------------------
-
-// test the Trilinos TFQMR solver
-
-
-#include "../tests.h" 
-#include <base/utilities.h>
-#include "../lac/testmatrix.h"
-#include <cmath>
-#include <fstream>
-#include <iostream>
-#include <iomanip>
-#include <base/logstream.h>
-#include <lac/trilinos_sparse_matrix.h>
-#include <lac/trilinos_vector.h>
-#include <lac/trilinos_solver.h>
-#include <lac/trilinos_precondition.h>
-#include <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;
-      abort ();
-    }
-
-  deallog << "Solver stopped after " << solver.control().last_step()
-          << " iterations" << std::endl;
-}
-
-
-int main(int argc, char **argv)
-{
-  std::ofstream logfile("solver_08/output");
-  logfile.precision(4);
-  deallog.attach(logfile);
-  deallog.depth_console(0);
-  deallog.threshold_double(1.e-10); 
-
-  Utilities::System::MPI_InitFinalize mpi_initialization (argc, argv);
-
-  
-  {
-    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);
-    CompressedSimpleSparsityPattern csp (dim, dim);
-    testproblem.five_point_structure(csp);
-    TrilinosWrappers::SparseMatrix  A;
-    A.reinit(csp);
-    testproblem.five_point(A);
-
-    TrilinosWrappers::Vector  f(dim);
-    TrilinosWrappers::Vector  u(dim);
-    f = 1.;
-    A.compress ();
-    f.compress ();
-    u.compress ();
-
-    TrilinosWrappers::SolverTFQMR solver(control);
-    TrilinosWrappers::PreconditionJacobi preconditioner;
-    preconditioner.initialize(A);
-    check_solve (solver, A,u,f, preconditioner);
-  }
-}
-
diff --git a/tests/trilinos/solver_08/cmp/generic b/tests/trilinos/solver_08/cmp/generic
deleted file mode 100644 (file)
index 5fb0124..0000000
+++ /dev/null
@@ -1,6 +0,0 @@
-
-DEAL::Size 32 Unknowns 961
-DEAL::Solver type: N6dealii13TrilinosWrappers11SolverTFQMRE
-DEAL::Starting value 7.750
-DEAL::Convergence step 40 value 0.0008680
-DEAL::Solver stopped after 40 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.