From: bangerth Date: Fri, 31 May 2013 04:51:41 +0000 (+0000) Subject: Remove tests that now no longer make sense. X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=1de199b4e5e6ac420db283f606e5976a690ac5ac;p=dealii-svn.git Remove tests that now no longer make sense. git-svn-id: https://svn.dealii.org/trunk@29676 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/tests/mpi/petsc_distribute_02.cc b/tests/mpi/petsc_distribute_02.cc deleted file mode 100644 index 6656008f9c..0000000000 --- a/tests/mpi/petsc_distribute_02.cc +++ /dev/null @@ -1,142 +0,0 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ -// -// Copyright (C) 2009, 2010, 2012, 2013 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. -// -//--------------------------------------------------------------------------- - - -// check ConstraintMatrix.distribute() for a petsc vector -// -// we do this by creating a vector where each processor has 100 -// elements but no ghost elements. then we add constraints on each -// processor that constrain elements within each processor's local -// range to ones outside. these have to be added on all -// processors. then call distribute() and verify that the result is -// true. -// -// we use constraints of the form x_i = x_j with sequentially growing -// x_j's so that we can verify the correctness analytically -// -// compared to the _01 test, here the ConstraintMatrix object acts on an index -// set that only includes the locally owned vector elements, without any -// overlap. this means that the owners of a source DoF in a constraint -// do not know about the constraint if the constrained DoF is owned by -// another processor. This is not allowed, and should trigger an -// exception. - - -#include "../tests.h" -#include -#include -#include - -#include -#include - - - -void test() -{ - const unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD); - const unsigned int n_processes = Utilities::MPI::n_mpi_processes (MPI_COMM_WORLD); - - // create a vector that consists of elements indexed from 0 to n - PETScWrappers::MPI::Vector vec (MPI_COMM_WORLD, 100 * n_processes, 100); - Assert (vec.local_size() == 100, ExcInternalError()); - Assert (vec.local_range().first == 100*myid, ExcInternalError()); - Assert (vec.local_range().second == 100*myid+100, ExcInternalError()); - for (unsigned int i=vec.local_range().first; i 1) - Assert (exception_caught == true, ExcInternalError()); - - if (myid == 0) - deallog << "OK" << std::endl; -} - - -int main(int argc, char *argv[]) -{ - Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - - unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD); - - - deallog.push(Utilities::int_to_string(myid)); - - if (myid == 0) - { - std::ofstream logfile(output_file_for_mpi("petsc_distribute_02").c_str()); - deallog.attach(logfile); - deallog.depth_console(0); - deallog.threshold_double(1.e-10); - - test(); - } - else - test(); - -} diff --git a/tests/mpi/petsc_distribute_02/ncpu_1/cmp/generic b/tests/mpi/petsc_distribute_02/ncpu_1/cmp/generic deleted file mode 100644 index be8d055f86..0000000000 --- a/tests/mpi/petsc_distribute_02/ncpu_1/cmp/generic +++ /dev/null @@ -1,2 +0,0 @@ - -DEAL:0::OK diff --git a/tests/mpi/petsc_distribute_02/ncpu_10/cmp/generic b/tests/mpi/petsc_distribute_02/ncpu_10/cmp/generic deleted file mode 100644 index be8d055f86..0000000000 --- a/tests/mpi/petsc_distribute_02/ncpu_10/cmp/generic +++ /dev/null @@ -1,2 +0,0 @@ - -DEAL:0::OK diff --git a/tests/mpi/petsc_distribute_02/ncpu_2/cmp/generic b/tests/mpi/petsc_distribute_02/ncpu_2/cmp/generic deleted file mode 100644 index be8d055f86..0000000000 --- a/tests/mpi/petsc_distribute_02/ncpu_2/cmp/generic +++ /dev/null @@ -1,2 +0,0 @@ - -DEAL:0::OK diff --git a/tests/mpi/petsc_distribute_02/ncpu_4/cmp/generic b/tests/mpi/petsc_distribute_02/ncpu_4/cmp/generic deleted file mode 100644 index be8d055f86..0000000000 --- a/tests/mpi/petsc_distribute_02/ncpu_4/cmp/generic +++ /dev/null @@ -1,2 +0,0 @@ - -DEAL:0::OK diff --git a/tests/mpi/trilinos_distribute_02.cc b/tests/mpi/trilinos_distribute_02.cc deleted file mode 100644 index bc0ab1f2de..0000000000 --- a/tests/mpi/trilinos_distribute_02.cc +++ /dev/null @@ -1,147 +0,0 @@ -//--------------------------------------------------------------------------- -// $Id$ -// Version: $Name$ -// -// Copyright (C) 2009, 2010, 2012, 2013 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. -// -//--------------------------------------------------------------------------- - - -// check ConstraintMatrix.distribute() for a trilinos vector -// -// we do this by creating a vector where each processor has 100 -// elements but no ghost elements. then we add constraints on each -// processor that constrain elements within each processor's local -// range to ones outside. these have to be added on all -// processors. then call distribute() and verify that the result is -// true. -// -// we use constraints of the form x_i = x_j with sequentially growing -// x_j's so that we can verify the correctness analytically -// -// compared to the _01 test, here the ConstraintMatrix object acts on an index -// set that only includes the locally owned vector elements, without any -// overlap. this means that the owners of a source DoF in a constraint -// do not know about the constraint if the constrained DoF is owned by -// another processor. This is not allowed, and should trigger an -// exception. - - -#include "../tests.h" -#include -#include -#include - -#include -#include - - - -void test() -{ - const unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD); - const unsigned int n_processes = Utilities::MPI::n_mpi_processes (MPI_COMM_WORLD); - - // create a vector that consists of elements indexed from 0 to n - TrilinosWrappers::MPI::Vector vec; - { - IndexSet is (100*n_processes); - is.add_range (100*myid, 100*myid+100); - vec.reinit (is, MPI_COMM_WORLD); - } - Assert (vec.local_size() == 100, ExcInternalError()); - Assert (vec.local_range().first == 100*myid, ExcInternalError()); - Assert (vec.local_range().second == 100*myid+100, ExcInternalError()); - for (unsigned int i=vec.local_range().first; i 1) - Assert (exception_caught == true, ExcInternalError()); - - if (myid == 0) - deallog << "OK" << std::endl; -} - - -int main(int argc, char *argv[]) -{ - Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv, 1); - - unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD); - - - deallog.push(Utilities::int_to_string(myid)); - - if (myid == 0) - { - std::ofstream logfile(output_file_for_mpi("trilinos_distribute_02").c_str()); - deallog.attach(logfile); - deallog.depth_console(0); - deallog.threshold_double(1.e-10); - - test(); - } - else - test(); - -} diff --git a/tests/mpi/trilinos_distribute_02/ncpu_1/cmp/generic b/tests/mpi/trilinos_distribute_02/ncpu_1/cmp/generic deleted file mode 100644 index be8d055f86..0000000000 --- a/tests/mpi/trilinos_distribute_02/ncpu_1/cmp/generic +++ /dev/null @@ -1,2 +0,0 @@ - -DEAL:0::OK diff --git a/tests/mpi/trilinos_distribute_02/ncpu_10/cmp/generic b/tests/mpi/trilinos_distribute_02/ncpu_10/cmp/generic deleted file mode 100644 index be8d055f86..0000000000 --- a/tests/mpi/trilinos_distribute_02/ncpu_10/cmp/generic +++ /dev/null @@ -1,2 +0,0 @@ - -DEAL:0::OK diff --git a/tests/mpi/trilinos_distribute_02/ncpu_2/cmp/generic b/tests/mpi/trilinos_distribute_02/ncpu_2/cmp/generic deleted file mode 100644 index be8d055f86..0000000000 --- a/tests/mpi/trilinos_distribute_02/ncpu_2/cmp/generic +++ /dev/null @@ -1,2 +0,0 @@ - -DEAL:0::OK diff --git a/tests/mpi/trilinos_distribute_02/ncpu_4/cmp/generic b/tests/mpi/trilinos_distribute_02/ncpu_4/cmp/generic deleted file mode 100644 index be8d055f86..0000000000 --- a/tests/mpi/trilinos_distribute_02/ncpu_4/cmp/generic +++ /dev/null @@ -1,2 +0,0 @@ - -DEAL:0::OK