From: bangerth Date: Fri, 15 Oct 2010 21:47:18 +0000 (+0000) Subject: Delete tests that apparently never worked successfully. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=6790c38e71b09e8415cb357bd1612d9b955f530c;p=dealii-svn.git Delete tests that apparently never worked successfully. git-svn-id: https://svn.dealii.org/trunk@22352 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/tests/trilinos/solver_06.cc b/tests/trilinos/solver_06.cc deleted file mode 100644 index 29e5436701..0000000000 --- a/tests/trilinos/solver_06.cc +++ /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 -#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_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 index fadfbe5752..0000000000 --- a/tests/trilinos/solver_06/cmp/generic +++ /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 index 644832843d..0000000000 --- a/tests/trilinos/solver_06/cmp/i386-apple-darwin8.10.1+gcc4.0 +++ /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 index d06770b469..0000000000 --- a/tests/trilinos/solver_06/cmp/powerpc-apple-darwin8.10.0+gcc4.0 +++ /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 index 643bbbe1c7..0000000000 --- a/tests/trilinos/solver_08.cc +++ /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 -#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_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 index 5fb0124e55..0000000000 --- a/tests/trilinos/solver_08/cmp/generic +++ /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