]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Remove a test I accidentally added in an unrelated commit :-(
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 13 May 2011 05:10:25 +0000 (05:10 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Fri, 13 May 2011 05:10:25 +0000 (05:10 +0000)
git-svn-id: https://svn.dealii.org/trunk@23694 0785d39b-7218-0410-832d-ea1e28bc413d

tests/mpi/habib_01.cc [deleted file]
tests/mpi/habib_01/ncpu_10/cmp/generic [deleted file]
tests/mpi/habib_01/ncpu_3/cmp/generic [deleted file]
tests/mpi/habib_01/ncpu_4/cmp/generic [deleted file]

diff --git a/tests/mpi/habib_01.cc b/tests/mpi/habib_01.cc
deleted file mode 100644 (file)
index 1219d57..0000000
+++ /dev/null
@@ -1,87 +0,0 @@
-//---------------------------------------------------------------------------
-//    $Id$
-//    Version: $Name$
-//
-//    Copyright (C) 2009 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.
-//
-//---------------------------------------------------------------------------
-
-
-//
-
-#include "../tests.h"
-#include <base/logstream.h>
-#include <base/utilities.h>
-
-#include <fstream>
-//#include <mpi.h>
-
-
-void test_mpi()
-{
-  Assert( Utilities::System::job_supports_mpi(), ExcInternalError());
-
-
-  unsigned int myid = Utilities::System::get_this_mpi_process (MPI_COMM_WORLD);
-  const unsigned int numprocs = Utilities::System::get_n_mpi_processes (MPI_COMM_WORLD);
-
-  if (myid==0)
-    deallog << "Running on " << numprocs << " CPU(s)." << std::endl;
-
-  for (unsigned int i=1;i<numprocs;++i)
-    {
-      MPI_Barrier(MPI_COMM_WORLD);
-//      system("sleep 1");
-
-      if (myid==0)
-       {
-         unsigned int buf=numbers::invalid_unsigned_int;
-         MPI_Status status;
-         MPI_Recv(&buf, 1, MPI_UNSIGNED, i, 1, MPI_COMM_WORLD, &status);
-         deallog << "got message '" << buf << "' from CPU " << i+1 << "!" << std::endl;
-         Assert(buf == i, ExcInternalError());
-
-       }
-      else if (myid==i )
-       {
-         MPI_Send(&myid, 1, MPI_INT, 0, 1, MPI_COMM_WORLD);
-       }
-
-
-    }
-  if (myid==0)
-    deallog << "done" << std::endl;
-
-}
-
-
-int main(int argc, char *argv[])
-{
-#ifdef DEAL_II_COMPILER_SUPPORTS_MPI
-  Utilities::System::MPI_InitFinalize mpi (argc, argv);
-#else
-  (void)argc;
-  (void)argv;
-  compile_time_error;
-
-#endif
-
-  if (Utilities::System::get_this_mpi_process (MPI_COMM_WORLD) == 0)
-    {
-      std::ofstream logfile(output_file_for_mpi("simple_mpi_01").c_str());
-      deallog.attach(logfile);
-      deallog.depth_console(0);
-      deallog.threshold_double(1.e-10);
-
-      deallog.push("mpi");
-      test_mpi();
-      deallog.pop();
-    }
-  else
-    test_mpi();
-}
diff --git a/tests/mpi/habib_01/ncpu_10/cmp/generic b/tests/mpi/habib_01/ncpu_10/cmp/generic
deleted file mode 100644 (file)
index 30b5ea4..0000000
+++ /dev/null
@@ -1,12 +0,0 @@
-
-DEAL:mpi::Running on 10 CPU(s).
-DEAL:mpi::got message '1' from CPU 2!
-DEAL:mpi::got message '2' from CPU 3!
-DEAL:mpi::got message '3' from CPU 4!
-DEAL:mpi::got message '4' from CPU 5!
-DEAL:mpi::got message '5' from CPU 6!
-DEAL:mpi::got message '6' from CPU 7!
-DEAL:mpi::got message '7' from CPU 8!
-DEAL:mpi::got message '8' from CPU 9!
-DEAL:mpi::got message '9' from CPU 10!
-DEAL:mpi::done
diff --git a/tests/mpi/habib_01/ncpu_3/cmp/generic b/tests/mpi/habib_01/ncpu_3/cmp/generic
deleted file mode 100644 (file)
index 588f4ae..0000000
+++ /dev/null
@@ -1,5 +0,0 @@
-
-DEAL:mpi::Running on 3 CPU(s).
-DEAL:mpi::got message '1' from CPU 2!
-DEAL:mpi::got message '2' from CPU 3!
-DEAL:mpi::done
diff --git a/tests/mpi/habib_01/ncpu_4/cmp/generic b/tests/mpi/habib_01/ncpu_4/cmp/generic
deleted file mode 100644 (file)
index 8dcacbe..0000000
+++ /dev/null
@@ -1,6 +0,0 @@
-
-DEAL:mpi::Running on 4 CPU(s).
-DEAL:mpi::got message '1' from CPU 2!
-DEAL:mpi::got message '2' from CPU 3!
-DEAL:mpi::got message '3' from CPU 4!
-DEAL:mpi::done

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.