]> https://gitweb.dealii.org/ - dealii.git/commitdiff
remove test that is no longer needed
authorTimo Heister <timo.heister@gmail.com>
Fri, 15 Feb 2013 23:16:05 +0000 (23:16 +0000)
committerTimo Heister <timo.heister@gmail.com>
Fri, 15 Feb 2013 23:16:05 +0000 (23:16 +0000)
git-svn-id: https://svn.dealii.org/trunk@28420 0785d39b-7218-0410-832d-ea1e28bc413d

tests/mpi/trilinos_ghost_03.cc
tests/mpi/trilinos_ghost_04.cc [deleted file]
tests/mpi/trilinos_ghost_04/ncpu_10/cmp/generic [deleted file]
tests/mpi/trilinos_ghost_04/ncpu_4/cmp/generic [deleted file]

index 0d29fade50277101c8caa0d4eceefb9febb2b4fb..1a092634a3e73e5ec898b6b392e22d334efe427a 100644 (file)
@@ -12,8 +12,8 @@
 //----------------------------  trilinos_ghost_03.cc  ---------------------------
 
 
-// check correct behaviour of Trilinos ghosted vectors and l2_norm().  The
-// test now checks that l2_norm() is disabled.
+// check correct behaviour of Trilinos ghosted vectors.  The
+// test now checks that v.l2_norm() and v(idx)=... is disabled.
 
 #include "../tests.h" 
 #include <deal.II/base/utilities.h>
@@ -63,6 +63,13 @@ void test ()
   catch (...)
     {
     }
+  try
+    {
+      v_tmp(0)=3.0;
+    }
+  catch (...)
+    {
+    }
   
   if (Utilities::MPI::this_mpi_process (MPI_COMM_WORLD) == 0)
     deallog << "OK" << std::endl;
diff --git a/tests/mpi/trilinos_ghost_04.cc b/tests/mpi/trilinos_ghost_04.cc
deleted file mode 100644 (file)
index 857c8cb..0000000
+++ /dev/null
@@ -1,96 +0,0 @@
-//----------------------------  trilinos_vector_equality_4.cc  ---------------------------
-//    $Id$
-//    Version: $Name$ 
-//
-//    Copyright (C) 2004, 2005, 2008, 2010 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_vector_equality_4.cc  ---------------------------
-
-
-// check correct behaviour of Trilinos ghosted vectors document bug: assigning
-// local values into a ghosted vector does not transfer it to other machines.
-// update: we now disallow changing vectors which have ghost elements. Check
-// that we get that Assert().
-
-#include "../tests.h" 
-#include <deal.II/base/utilities.h>
-#include <deal.II/base/index_set.h>
-#include <deal.II/lac/trilinos_vector.h>    
-#include <fstream>
-#include <iostream>
-#include <vector>
-
-
-void test ()
-{
-  unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD);
-  unsigned int numproc = Utilities::MPI::n_mpi_processes (MPI_COMM_WORLD);
-
-  if (myid==0) deallog << "numproc=" << numproc << std::endl;
-
-  unsigned int ghostel=(numproc>1)?2:1;
-
-                                  // each processor owns 2 indices and all
-                                   // are ghosting one element
-  IndexSet local_active(numproc*2);
-  local_active.add_range(myid*2,myid*2+2);
-  IndexSet local_relevant(numproc*2);
-  local_relevant = local_active;
-  local_relevant.add_range(ghostel,ghostel+1);
-
-  TrilinosWrappers::MPI::Vector v(local_relevant, MPI_COMM_WORLD);
-  
-
-                                     // set local values
-  deal_II_exceptions::disable_abort_on_exception();
-  v(myid*2)=myid*2.0;
-  v(myid*2+1)=myid*2.0+1.0;
-
-  v.compress();
-  v*=2.0;
-
-  if (myid == 0)
-    {
-      deallog << myid*2 << ":" << v(myid*2) << std::endl;
-      deallog << myid*2+1 << ":" << v(myid*2+1) << std::endl;
-    }
-  
-  Assert(v(myid*2) == myid*4.0, ExcInternalError());
-  Assert(v(myid*2+1) == myid*4.0+2.0, ExcInternalError());
-
-                                  // check ghost values
-  if (myid == 0)
-    deallog << "ghost: " << v(ghostel) << std::endl;
-  
-  if (myid == 0)
-    deallog << "OK" << std::endl;
-}
-
-
-
-int main (int argc, char **argv)
-{
-  Utilities::MPI::MPI_InitFinalize mpi_initialization(argc, argv);
-
-  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_ghost_04").c_str());
-      deallog.attach(logfile);
-      deallog << std::setprecision(4);
-      deallog.depth_console(0);
-      deallog.threshold_double(1.e-10);
-
-      test();
-    }
-  else
-    test();
-
-}
diff --git a/tests/mpi/trilinos_ghost_04/ncpu_10/cmp/generic b/tests/mpi/trilinos_ghost_04/ncpu_10/cmp/generic
deleted file mode 100644 (file)
index d690b52..0000000
+++ /dev/null
@@ -1,8 +0,0 @@
-
-DEAL:0::numproc=10
-DEAL:0::ExcGhostsPresent()
-DEAL:0::ExcGhostsPresent()
-DEAL:0::0:0.000
-DEAL:0::1:2.000
-DEAL:0::ghost: 0.000
-DEAL:0::OK
diff --git a/tests/mpi/trilinos_ghost_04/ncpu_4/cmp/generic b/tests/mpi/trilinos_ghost_04/ncpu_4/cmp/generic
deleted file mode 100644 (file)
index 6946b5e..0000000
+++ /dev/null
@@ -1,8 +0,0 @@
-
-DEAL:0::numproc=4
-DEAL:0::ExcGhostsPresent()
-DEAL:0::ExcGhostsPresent()
-DEAL:0::0:0.000
-DEAL:0::1:2.000
-DEAL:0::ghost: 0.000
-DEAL:0::OK

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.