]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Restrict a bunch of tests to only run if all requirements are fulfilled
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Wed, 15 Aug 2018 08:52:40 +0000 (10:52 +0200)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Wed, 15 Aug 2018 11:11:20 +0000 (13:11 +0200)
22 files changed:
tests/base/derivative_forms_01.with_trilinos=true.with_trilinos_with_sacado=true.output [moved from tests/base/derivative_forms_01.with_trilinos=on.output with 100% similarity]
tests/fe/fe_enriched_color_02.with_mpi=true.with_trilinos=true.with_trilinos_with_zoltan=true.output [moved from tests/fe/fe_enriched_color_02.with_mpi=true.output with 100% similarity]
tests/fe/fe_enriched_color_03.with_mpi=true.with_trilinos=true.with_trilinos_with_zoltan=true.output [moved from tests/fe/fe_enriched_color_03.with_mpi=true.output with 100% similarity]
tests/fe/fe_enriched_color_04.with_mpi=true.with_trilinos=true.with_trilinos_with_zoltan=true.output [moved from tests/fe/fe_enriched_color_04.with_mpi=true.output with 100% similarity]
tests/fe/fe_enriched_color_05.with_mpi=true.with_trilinos=true.with_trilinos_with_zoltan=true.output [moved from tests/fe/fe_enriched_color_05.with_mpi=true.output with 100% similarity]
tests/fe/fe_enriched_color_06.with_trilinos=true.with_trilinos_wiith_zoltan=true.with_gsl=true.with_mpi=true.output [moved from tests/fe/fe_enriched_color_06.with_gsl=true.with_mpi=true.output with 100% similarity]
tests/fe/fe_enriched_color_07.cc
tests/fe/fe_enriched_color_07.with_trilinos=true.with_trilinos_with_zoltan=true.with_petsc=true.with_petsc_with_complex=false.with_gsl=true.with_mpi=true.mpirun=2.output [moved from tests/fe/fe_enriched_color_07.with_gsl=true.with_mpi=true.mpirun=2.output with 100% similarity]
tests/fe/fe_enriched_color_08.with_mpi=true.with_trilinos=true.with_trilinos_with_zoltan=true.output [moved from tests/fe/fe_enriched_color_08.with_mpi=true.output with 100% similarity]
tests/fe/fe_values_view_get_function_from_local_dof_values_02.with_trilinos=true.with_trilinos_with_sacado=true.output [moved from tests/fe/fe_values_view_get_function_from_local_dof_values_02.with_trilinos=true.output with 100% similarity]
tests/hp/solution_transfer_14.cc
tests/hp/solution_transfer_14.with_trilinos=true.with_trilinos_with_zoltan=true.mpirun=2.output [moved from tests/hp/solution_transfer_14.with_trilinos=true.mpirun=2.output with 100% similarity]
tests/hp/solution_transfer_14.with_trilinos=true.with_trilinos_with_zoltan=true.output [moved from tests/hp/solution_transfer_14.with_trilinos=true.output with 100% similarity]
tests/hp/solution_transfer_15.cc
tests/hp/solution_transfer_15.with_trilinos=true.with_trilinos_with_zoltan=true.mpirun=2.output [moved from tests/hp/solution_transfer_15.with_trilinos=true.mpirun=2.output with 100% similarity]
tests/hp/solution_transfer_15.with_trilinos=true.with_trilinos_with_zoltan=true.output [moved from tests/hp/solution_transfer_15.with_trilinos=true.output with 100% similarity]
tests/mpi/solution_transfer_02.cc
tests/mpi/solution_transfer_02.with_trilinos=true.with_trilinos_with_zoltan=true.mpirun=2.output [moved from tests/mpi/solution_transfer_02.with_trilinos=true.mpirun=2.output with 100% similarity]
tests/mpi/solution_transfer_02.with_trilinos=true.with_trilinos_with_zoltan=true.output [moved from tests/mpi/solution_transfer_02.with_trilinos=true.output with 100% similarity]
tests/mpi/solution_transfer_03.cc
tests/mpi/solution_transfer_03.with_trilinos=true.with_trilinos_with_zoltan=true.mpirun=2.output [moved from tests/mpi/solution_transfer_03.with_trilinos=true.mpirun=2.output with 100% similarity]
tests/mpi/solution_transfer_03.with_trilinos=true.with_trilinos_with_zoltan=true.output [moved from tests/mpi/solution_transfer_03.with_trilinos=true.output with 100% similarity]

index 827d7e3675b6d325ff4c9fb2e03af88a0c64a76f..407d68b9f4575c316baf18d661e0d87aba54de9d 100644 (file)
@@ -1047,7 +1047,6 @@ template <int dim>
 class LaplaceProblem
 {
 public:
-  LaplaceProblem();
   LaplaceProblem(const ParameterCollection &prm);
   virtual ~LaplaceProblem();
   void
@@ -1126,26 +1125,6 @@ protected:
 
 
 
-template <int dim>
-LaplaceProblem<dim>::LaplaceProblem()
-  : prm()
-  , n_enriched_cells(0)
-  , dof_handler(triangulation)
-  , fe_base(prm.fe_base_degree)
-  , fe_enriched(prm.fe_enriched_degree)
-  , fe_nothing(1, true)
-  , mpi_communicator(MPI_COMM_WORLD)
-  , n_mpi_processes(Utilities::MPI::n_mpi_processes(mpi_communicator))
-  , this_mpi_process(Utilities::MPI::this_mpi_process(mpi_communicator))
-  , pcout(std::cout, (this_mpi_process == 0))
-{
-  prm.print();
-
-  pcout << "...default parameters set" << std::endl;
-}
-
-
-
 template <int dim>
 LaplaceProblem<dim>::LaplaceProblem(const ParameterCollection &_par)
   : prm(_par)
index 5be629c0f3fcfad9d65bfd8becffb4bf8fe22e66..e203b3ad30cd746a03a2953fe2c7e66130a25d59 100644 (file)
@@ -53,8 +53,10 @@ transfer(const MPI_Comm &mpi_communicator)
   Triangulation<dim> tria;
   GridGenerator::hyper_cube(tria);
   tria.refine_global(1);
-  GridTools::partition_triangulation(
-    Utilities::MPI::n_mpi_processes(mpi_communicator), tria);
+  GridTools::partition_triangulation(Utilities::MPI::n_mpi_processes(
+                                       mpi_communicator),
+                                     tria,
+                                     SparsityTools::Partitioner::zoltan);
 
   hp::FECollection<dim> fe;
   fe.push_back(FE_Q<dim>(1));
index 99d5458f4052fd79fe33db695f0a50f130c1de19..20eb8b35480818d3b61302febbc204a782c63ed7 100644 (file)
@@ -98,8 +98,10 @@ transfer(const MPI_Comm &mpi_communicator)
   Triangulation<dim> tria;
   GridGenerator::hyper_cube(tria);
   tria.refine_global(1);
-  GridTools::partition_triangulation(
-    Utilities::MPI::n_mpi_processes(mpi_communicator), tria);
+  GridTools::partition_triangulation(Utilities::MPI::n_mpi_processes(
+                                       mpi_communicator),
+                                     tria,
+                                     SparsityTools::Partitioner::zoltan);
 
   hp::FECollection<dim> fe;
   fe.push_back(FESystem<dim>(FE_Q<dim>(1), 1, FE_Q<dim>(1), 1));
index 49f84584167e6ce3d1301ed0ed680c6e14b05a56..1e3bbbed423a0ff69ee3aedf77c834a1b2e0a04c 100644 (file)
@@ -52,8 +52,10 @@ transfer(const MPI_Comm &mpi_communicator)
   Triangulation<dim> tria;
   GridGenerator::hyper_cube(tria);
   tria.refine_global(1);
-  GridTools::partition_triangulation(
-    Utilities::MPI::n_mpi_processes(mpi_communicator), tria);
+  GridTools::partition_triangulation(Utilities::MPI::n_mpi_processes(
+                                       mpi_communicator),
+                                     tria,
+                                     SparsityTools::Partitioner::zoltan);
 
   const FE_Q<dim> fe(2);
 
index 79cd90e0854e7f38ae1d26142ee5813b7899bad3..738bbe74eb6429a4d2ec978c77425116bc9a274e 100644 (file)
@@ -96,8 +96,10 @@ transfer(const MPI_Comm &mpi_communicator)
   Triangulation<dim> tria;
   GridGenerator::hyper_cube(tria);
   tria.refine_global(1);
-  GridTools::partition_triangulation(
-    Utilities::MPI::n_mpi_processes(mpi_communicator), tria);
+  GridTools::partition_triangulation(Utilities::MPI::n_mpi_processes(
+                                       mpi_communicator),
+                                     tria,
+                                     SparsityTools::Partitioner::zoltan);
 
   const FESystem<dim>             fe(FE_Q<dim>(2), 1, FE_Q<dim>(1), 1);
   const std::vector<unsigned int> block_component({0, 1});

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.