From: Matthias Maier Date: Sun, 11 Jan 2015 14:16:12 +0000 (+0100) Subject: Testsuite: Remove mumps related tests X-Git-Tag: v8.3.0-rc1~558^2~2 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=25f457d0baf428e7b3d547b54022030acaa1f781;p=dealii.git Testsuite: Remove mumps related tests --- diff --git a/tests/CMakeLists.txt b/tests/CMakeLists.txt index 67678d6fab..6879a5caf3 100644 --- a/tests/CMakeLists.txt +++ b/tests/CMakeLists.txt @@ -1,6 +1,6 @@ ## --------------------------------------------------------------------- ## -## Copyright (C) 2013 - 2014 by the deal.II authors +## Copyright (C) 2013 - 2015 by the deal.II authors ## ## This file is part of the deal.II library. ## @@ -61,8 +61,8 @@ ENDFOREACH() SET(_categories a-framework algorithms all-headers aniso arpack base bits build_tests codim_one deal.II distributed_grids fe gla grid hp integrators lac lapack - manifold matrix_free mesh_converter metis mpi multigrid mumps opencascade - petsc serialization slepc trilinos umfpack + manifold matrix_free mesh_converter metis mpi multigrid opencascade petsc + serialization slepc trilinos umfpack ) # diff --git a/tests/mumps/CMakeLists.txt b/tests/mumps/CMakeLists.txt deleted file mode 100644 index a6be545481..0000000000 --- a/tests/mumps/CMakeLists.txt +++ /dev/null @@ -1,7 +0,0 @@ -CMAKE_MINIMUM_REQUIRED(VERSION 2.8.9) -INCLUDE(${DEAL_II_SOURCE_DIR}/tests/setup_testsubproject.cmake) -PROJECT(testsuite CXX) -INCLUDE(${DEAL_II_TARGET_CONFIG}) -IF(DEAL_II_WITH_MUMPS) - DEAL_II_PICKUP_TESTS() -ENDIF() diff --git a/tests/mumps/mumps_01.cc b/tests/mumps/mumps_01.cc deleted file mode 100644 index 1904495e64..0000000000 --- a/tests/mumps/mumps_01.cc +++ /dev/null @@ -1,149 +0,0 @@ -// --------------------------------------------------------------------- -// -// Copyright (C) 2002 - 2013 by the deal.II authors -// -// This file is part of the deal.II library. -// -// The deal.II library is free software; you can use it, redistribute -// it, and/or modify it under the terms of the GNU Lesser General -// Public License as published by the Free Software Foundation; either -// version 2.1 of the License, or (at your option) any later version. -// The full text of the license can be found in the file LICENSE at -// the top level of the deal.II distribution. -// -// --------------------------------------------------------------------- - - -// test the mumps sparse direct solver on a mass matrix -// - check several ways to solve - -#include "../tests.h" -#include -#include -#include - -#include -#include - -#include -#include - -#include - -#include -#include -#include -#include - -#include -#include - -#include -#include - - -void solve_and_check(const SparseMatrix & M, - const Vector & rhs, - const Vector & solution) -{ - { - SparseDirectMUMPS solver; - solver.initialize (M); - Vector dst(rhs.size()); - solver.vmult(dst, rhs); - dst -= solution; - Assert(dst.l2_norm() < 1e-9, ExcInternalError()); - } - { - SparseDirectMUMPS solver; - solver.initialize (M, rhs); - Vector dst(rhs.size()); - solver.solve(dst); - dst -= solution; - Assert(dst.l2_norm() < 1e-9, ExcInternalError()); - } -} - - - -template -void test () -{ - deallog << dim << 'd' << std::endl; - - Triangulation tria; - GridGenerator::hyper_cube (tria,0,1); - tria.refine_global (1); - - // destroy the uniformity of the matrix by - // refining one cell - tria.begin_active()->set_refine_flag (); - tria.execute_coarsening_and_refinement (); - tria.refine_global(8-2*dim); - - FE_Q fe (1); - DoFHandler dof_handler (tria); - dof_handler.distribute_dofs (fe); - - deallog << "Number of dofs = " << dof_handler.n_dofs() << std::endl; - - SparsityPattern sparsity_pattern; - sparsity_pattern.reinit (dof_handler.n_dofs(), - dof_handler.n_dofs(), - dof_handler.max_couplings_between_dofs()); - DoFTools::make_sparsity_pattern (dof_handler, sparsity_pattern); - sparsity_pattern.compress (); - - SparseMatrix B; - B.reinit (sparsity_pattern); - - QGauss qr (2); - MatrixTools::create_mass_matrix (dof_handler, qr, B); - - // compute a decomposition of the matrix - SparseDirectMUMPS Binv; - Binv.initialize (B); - - // for a number of different solution - // vectors, make up a matching rhs vector - // and check what the solver finds - for (unsigned int i=0; i<3; ++i) - { - Vector solution (dof_handler.n_dofs()); - Vector x (dof_handler.n_dofs()); - Vector b (dof_handler.n_dofs()); - - for (unsigned int j=0; j -#include -#include - -#include -#include - -#include -#include - -#include - -#include -#include -#include -#include - -#include -#include - -#include -#include - - -template -void test () -{ - deallog << dim << 'd' << std::endl; - - Triangulation tria; - GridGenerator::hyper_cube (tria,0,1); - tria.refine_global (1); - - // destroy the uniformity of the matrix by - // refining one cell - tria.begin_active()->set_refine_flag (); - tria.execute_coarsening_and_refinement (); - tria.refine_global(8-2*dim); - - FE_Q fe (1); - DoFHandler dof_handler (tria); - dof_handler.distribute_dofs (fe); - - deallog << "Number of dofs = " << dof_handler.n_dofs() << std::endl; - - SparsityPattern sparsity_pattern; - sparsity_pattern.reinit (dof_handler.n_dofs(), - dof_handler.n_dofs(), - dof_handler.max_couplings_between_dofs()); - DoFTools::make_sparsity_pattern (dof_handler, sparsity_pattern); - sparsity_pattern.compress (); - - SparseMatrix B; - B.reinit (sparsity_pattern); - - QGauss qr (2); - MatrixTools::create_mass_matrix (dof_handler, qr, B); - - // for a number of different solution - // vectors, make up a matching rhs vector - // and check what the solver finds - for (unsigned int i=0; i<3; ++i) - { - Vector solution (dof_handler.n_dofs()); - Vector x (dof_handler.n_dofs()); - Vector b (dof_handler.n_dofs()); - - for (unsigned int j=0; j (); - test<2> (); - test<3> (); -} diff --git a/tests/mumps/mumps_02.output b/tests/mumps/mumps_02.output deleted file mode 100644 index 8df3f884c1..0000000000 --- a/tests/mumps/mumps_02.output +++ /dev/null @@ -1,25 +0,0 @@ - -DEAL::1d -DEAL::Number of dofs = 193 -DEAL::relative norm distance = 0 -DEAL::absolute norms = 0 3084.00 -DEAL::relative norm distance = 0 -DEAL::absolute norms = 0 7709.99 -DEAL::relative norm distance = 0 -DEAL::absolute norms = 0 15420.0 -DEAL::2d -DEAL::Number of dofs = 1889 -DEAL::relative norm distance = 0 -DEAL::absolute norms = 0 94764.3 -DEAL::relative norm distance = 0 -DEAL::absolute norms = 0 236911. -DEAL::relative norm distance = 0 -DEAL::absolute norms = 0 473822. -DEAL::3d -DEAL::Number of dofs = 1333 -DEAL::relative norm distance = 0 -DEAL::absolute norms = 0 56165.6 -DEAL::relative norm distance = 0 -DEAL::absolute norms = 0 140414. -DEAL::relative norm distance = 0 -DEAL::absolute norms = 0 280828. diff --git a/tests/run_testsuite.cmake b/tests/run_testsuite.cmake index 7339eaa1d5..124ef6249b 100644 --- a/tests/run_testsuite.cmake +++ b/tests/run_testsuite.cmake @@ -268,7 +268,7 @@ GET_CMAKE_PROPERTY(_variables VARIABLES) FOREACH(_var ${_variables}) IF( _var MATCHES "^(TEST|DEAL_II|ALLOW|WITH|FORCE|COMPONENT)_" OR _var MATCHES "^(COMPAT_FILES|DOCUMENTATION|EXAMPLES|MESH_CONVERTER|PARAMETER_GUI)" OR - _var MATCHES "^(ARPACK|BOOST|OPENCASCADE|MUPARSER|HDF5|METIS|MPI|MUMPS)_" OR + _var MATCHES "^(ARPACK|BOOST|OPENCASCADE|MUPARSER|HDF5|METIS|MPI)_" OR _var MATCHES "^(NETCDF|P4EST|PETSC|SLEPC|THREADS|TBB|TRILINOS)_" OR _var MATCHES "^(UMFPACK|ZLIB|LAPACK|MUPARSER)_" OR _var MATCHES "^(CMAKE|DEAL_II)_(C|CXX|Fortran|BUILD)_(COMPILER|FLAGS)" OR