]> https://gitweb.dealii.org/ - dealii.git/commitdiff
tests: remove with_threads 10427/head
authorTimo Heister <timo.heister@gmail.com>
Sun, 31 May 2020 13:03:16 +0000 (09:03 -0400)
committerTimo Heister <timo.heister@gmail.com>
Sun, 31 May 2020 13:03:16 +0000 (09:03 -0400)
- delete tests/lac/intel-15-bug: depends on TBB and tests an old intel
compiler version
- remove with_threads from tests/*output (no test depends on TBB)

12 files changed:
tests/lac/intel-15-bug.cc [deleted file]
tests/lac/intel-15-bug.with_threads=on.output [deleted file]
tests/mpi/no_flux_constraints_02.with_trilinos=true.mpirun=1.output.no_md5sum [moved from tests/mpi/no_flux_constraints_02.with_threads=true.with_trilinos=true.mpirun=1.output.no_md5sum with 100% similarity]
tests/mpi/no_flux_constraints_02.with_trilinos=true.mpirun=1.with_p4est=true.output [moved from tests/mpi/no_flux_constraints_02.with_threads=true.with_trilinos=true.mpirun=1.with_p4est=true.output with 100% similarity]
tests/mpi/no_flux_constraints_02.with_trilinos=true.mpirun=9.output.no_md5sum [moved from tests/mpi/no_flux_constraints_02.with_threads=true.with_trilinos=true.mpirun=9.output.no_md5sum with 100% similarity]
tests/mpi/no_flux_constraints_02.with_trilinos=true.mpirun=9.with_p4est=true.output [moved from tests/mpi/no_flux_constraints_02.with_threads=true.with_trilinos=true.mpirun=9.with_p4est=true.output with 100% similarity]
tests/mpi/no_flux_constraints_03.with_trilinos=true.mpirun=1.output.no_md5sum [moved from tests/mpi/no_flux_constraints_03.with_threads=true.with_trilinos=true.mpirun=1.output.no_md5sum with 100% similarity]
tests/mpi/no_flux_constraints_03.with_trilinos=true.mpirun=1.with_p4est=true.output [moved from tests/mpi/no_flux_constraints_03.with_threads=true.with_trilinos=true.mpirun=1.with_p4est=true.output with 100% similarity]
tests/mpi/no_flux_constraints_03.with_trilinos=true.mpirun=9.output.no_md5sum [moved from tests/mpi/no_flux_constraints_03.with_threads=true.with_trilinos=true.mpirun=9.output.no_md5sum with 100% similarity]
tests/mpi/no_flux_constraints_03.with_trilinos=true.mpirun=9.with_p4est=true.output [moved from tests/mpi/no_flux_constraints_03.with_threads=true.with_trilinos=true.mpirun=9.with_p4est=true.output with 100% similarity]
tests/mpi/trilinos_01.mpirun=4.output [moved from tests/mpi/trilinos_01.with_threads=true.with_trilinos=true.mpirun=4.output with 100% similarity]
tests/mpi/trilinos_01.with_trilinos=true.mpirun=10.output [moved from tests/mpi/trilinos_01.with_threads=true.with_trilinos=true.mpirun=10.output with 100% similarity]

diff --git a/tests/lac/intel-15-bug.cc b/tests/lac/intel-15-bug.cc
deleted file mode 100644 (file)
index 3a9a400..0000000
+++ /dev/null
@@ -1,94 +0,0 @@
-// ---------------------------------------------------------------------
-//
-// Copyright (C) 1998 - 2018 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.md at
-// the top level directory of deal.II.
-//
-// ---------------------------------------------------------------------
-
-// intel 15.0 compiler bug. This is a simplification of tests/lac/vector-vector
-// It only triggers when using TBB (it will use two threads) and only with
-// SIMD for long double. We now use
-// dealii::parallel::internal::EnableOpenMPSimdFor so the test passes.
-
-#include <deal.II/base/parallel.h>
-
-#include <deal.II/lac/vector.h>
-
-#include "../tests.h"
-
-typedef int size_type;
-
-template <typename Number>
-struct Vectorization_add_v
-{
-  Number *val;
-  Number *v_val;
-
-  void
-  operator()(const tbb::blocked_range<size_type> &range) const
-  {
-    if (dealii::parallel::internal::EnableOpenMPSimdFor<Number>::value)
-      {
-        DEAL_II_OPENMP_SIMD_PRAGMA
-        for (size_type i = range.begin(); i < range.end(); ++i)
-          val[i] += v_val[i];
-      }
-    else
-      {
-        for (size_type i = range.begin(); i < range.end(); ++i)
-          val[i] += v_val[i];
-      }
-  }
-};
-
-const unsigned int N = 3;
-
-void
-check()
-{
-  std::vector<long double> d1(N), d2(N);
-  for (unsigned int i = 0; i < N; ++i)
-    {
-      d1[i] = 1.0;
-      d2[i] = i;
-    };
-
-  Vectorization_add_v<long double> vector_add;
-  vector_add.val   = &d1[0];
-  vector_add.v_val = &d2[0];
-
-  if (1)
-    {
-      // fails:
-      tbb::parallel_for(tbb::blocked_range<size_type>(0, N, 2),
-                        vector_add,
-                        tbb::auto_partitioner());
-    }
-  else
-    {
-      // works:
-      vector_add(tbb::blocked_range<int>(0, 1, 2));
-      vector_add(tbb::blocked_range<int>(1, 3, 2));
-    }
-
-  deallog << "result: " << d1[N - 1] << " should be 3" << std::endl;
-}
-
-int
-main()
-{
-  std::ofstream logfile("output");
-  deallog << std::fixed;
-  deallog << std::setprecision(2);
-  deallog.attach(logfile);
-
-  check();
-}
diff --git a/tests/lac/intel-15-bug.with_threads=on.output b/tests/lac/intel-15-bug.with_threads=on.output
deleted file mode 100644 (file)
index d92c1c6..0000000
+++ /dev/null
@@ -1,2 +0,0 @@
-
-DEAL::result: 3.00 should be 3

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.