From: Daniel Arndt Date: Wed, 15 Aug 2018 08:52:40 +0000 (+0200) Subject: Restrict a bunch of tests to only run if all requirements are fulfilled X-Git-Tag: v9.1.0-rc1~819^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=225b0148e25964a7b0d8f5b896eec922d0421ac9;p=dealii.git Restrict a bunch of tests to only run if all requirements are fulfilled --- diff --git a/tests/base/derivative_forms_01.with_trilinos=on.output b/tests/base/derivative_forms_01.with_trilinos=true.with_trilinos_with_sacado=true.output similarity index 100% rename from tests/base/derivative_forms_01.with_trilinos=on.output rename to tests/base/derivative_forms_01.with_trilinos=true.with_trilinos_with_sacado=true.output diff --git a/tests/fe/fe_enriched_color_02.with_mpi=true.output b/tests/fe/fe_enriched_color_02.with_mpi=true.with_trilinos=true.with_trilinos_with_zoltan=true.output similarity index 100% rename from tests/fe/fe_enriched_color_02.with_mpi=true.output rename to tests/fe/fe_enriched_color_02.with_mpi=true.with_trilinos=true.with_trilinos_with_zoltan=true.output diff --git a/tests/fe/fe_enriched_color_03.with_mpi=true.output b/tests/fe/fe_enriched_color_03.with_mpi=true.with_trilinos=true.with_trilinos_with_zoltan=true.output similarity index 100% rename from tests/fe/fe_enriched_color_03.with_mpi=true.output rename to tests/fe/fe_enriched_color_03.with_mpi=true.with_trilinos=true.with_trilinos_with_zoltan=true.output diff --git a/tests/fe/fe_enriched_color_04.with_mpi=true.output b/tests/fe/fe_enriched_color_04.with_mpi=true.with_trilinos=true.with_trilinos_with_zoltan=true.output similarity index 100% rename from tests/fe/fe_enriched_color_04.with_mpi=true.output rename to tests/fe/fe_enriched_color_04.with_mpi=true.with_trilinos=true.with_trilinos_with_zoltan=true.output diff --git a/tests/fe/fe_enriched_color_05.with_mpi=true.output b/tests/fe/fe_enriched_color_05.with_mpi=true.with_trilinos=true.with_trilinos_with_zoltan=true.output similarity index 100% rename from tests/fe/fe_enriched_color_05.with_mpi=true.output rename to tests/fe/fe_enriched_color_05.with_mpi=true.with_trilinos=true.with_trilinos_with_zoltan=true.output diff --git a/tests/fe/fe_enriched_color_06.with_gsl=true.with_mpi=true.output b/tests/fe/fe_enriched_color_06.with_trilinos=true.with_trilinos_wiith_zoltan=true.with_gsl=true.with_mpi=true.output similarity index 100% rename from tests/fe/fe_enriched_color_06.with_gsl=true.with_mpi=true.output rename to tests/fe/fe_enriched_color_06.with_trilinos=true.with_trilinos_wiith_zoltan=true.with_gsl=true.with_mpi=true.output diff --git a/tests/fe/fe_enriched_color_07.cc b/tests/fe/fe_enriched_color_07.cc index 827d7e3675..407d68b9f4 100644 --- a/tests/fe/fe_enriched_color_07.cc +++ b/tests/fe/fe_enriched_color_07.cc @@ -1047,7 +1047,6 @@ template class LaplaceProblem { public: - LaplaceProblem(); LaplaceProblem(const ParameterCollection &prm); virtual ~LaplaceProblem(); void @@ -1126,26 +1125,6 @@ protected: -template -LaplaceProblem::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 LaplaceProblem::LaplaceProblem(const ParameterCollection &_par) : prm(_par) diff --git a/tests/fe/fe_enriched_color_07.with_gsl=true.with_mpi=true.mpirun=2.output b/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 similarity index 100% rename from tests/fe/fe_enriched_color_07.with_gsl=true.with_mpi=true.mpirun=2.output rename to 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 diff --git a/tests/fe/fe_enriched_color_08.with_mpi=true.output b/tests/fe/fe_enriched_color_08.with_mpi=true.with_trilinos=true.with_trilinos_with_zoltan=true.output similarity index 100% rename from tests/fe/fe_enriched_color_08.with_mpi=true.output rename to tests/fe/fe_enriched_color_08.with_mpi=true.with_trilinos=true.with_trilinos_with_zoltan=true.output diff --git a/tests/fe/fe_values_view_get_function_from_local_dof_values_02.with_trilinos=true.output b/tests/fe/fe_values_view_get_function_from_local_dof_values_02.with_trilinos=true.with_trilinos_with_sacado=true.output similarity index 100% rename from tests/fe/fe_values_view_get_function_from_local_dof_values_02.with_trilinos=true.output rename to tests/fe/fe_values_view_get_function_from_local_dof_values_02.with_trilinos=true.with_trilinos_with_sacado=true.output diff --git a/tests/hp/solution_transfer_14.cc b/tests/hp/solution_transfer_14.cc index 5be629c0f3..e203b3ad30 100644 --- a/tests/hp/solution_transfer_14.cc +++ b/tests/hp/solution_transfer_14.cc @@ -53,8 +53,10 @@ transfer(const MPI_Comm &mpi_communicator) Triangulation 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 fe; fe.push_back(FE_Q(1)); diff --git a/tests/hp/solution_transfer_14.with_trilinos=true.mpirun=2.output b/tests/hp/solution_transfer_14.with_trilinos=true.with_trilinos_with_zoltan=true.mpirun=2.output similarity index 100% rename from tests/hp/solution_transfer_14.with_trilinos=true.mpirun=2.output rename to tests/hp/solution_transfer_14.with_trilinos=true.with_trilinos_with_zoltan=true.mpirun=2.output diff --git a/tests/hp/solution_transfer_14.with_trilinos=true.output b/tests/hp/solution_transfer_14.with_trilinos=true.with_trilinos_with_zoltan=true.output similarity index 100% rename from tests/hp/solution_transfer_14.with_trilinos=true.output rename to tests/hp/solution_transfer_14.with_trilinos=true.with_trilinos_with_zoltan=true.output diff --git a/tests/hp/solution_transfer_15.cc b/tests/hp/solution_transfer_15.cc index 99d5458f40..20eb8b3548 100644 --- a/tests/hp/solution_transfer_15.cc +++ b/tests/hp/solution_transfer_15.cc @@ -98,8 +98,10 @@ transfer(const MPI_Comm &mpi_communicator) Triangulation 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 fe; fe.push_back(FESystem(FE_Q(1), 1, FE_Q(1), 1)); diff --git a/tests/hp/solution_transfer_15.with_trilinos=true.mpirun=2.output b/tests/hp/solution_transfer_15.with_trilinos=true.with_trilinos_with_zoltan=true.mpirun=2.output similarity index 100% rename from tests/hp/solution_transfer_15.with_trilinos=true.mpirun=2.output rename to tests/hp/solution_transfer_15.with_trilinos=true.with_trilinos_with_zoltan=true.mpirun=2.output diff --git a/tests/hp/solution_transfer_15.with_trilinos=true.output b/tests/hp/solution_transfer_15.with_trilinos=true.with_trilinos_with_zoltan=true.output similarity index 100% rename from tests/hp/solution_transfer_15.with_trilinos=true.output rename to tests/hp/solution_transfer_15.with_trilinos=true.with_trilinos_with_zoltan=true.output diff --git a/tests/mpi/solution_transfer_02.cc b/tests/mpi/solution_transfer_02.cc index 49f8458416..1e3bbbed42 100644 --- a/tests/mpi/solution_transfer_02.cc +++ b/tests/mpi/solution_transfer_02.cc @@ -52,8 +52,10 @@ transfer(const MPI_Comm &mpi_communicator) Triangulation 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 fe(2); diff --git a/tests/mpi/solution_transfer_02.with_trilinos=true.mpirun=2.output b/tests/mpi/solution_transfer_02.with_trilinos=true.with_trilinos_with_zoltan=true.mpirun=2.output similarity index 100% rename from tests/mpi/solution_transfer_02.with_trilinos=true.mpirun=2.output rename to tests/mpi/solution_transfer_02.with_trilinos=true.with_trilinos_with_zoltan=true.mpirun=2.output diff --git a/tests/mpi/solution_transfer_02.with_trilinos=true.output b/tests/mpi/solution_transfer_02.with_trilinos=true.with_trilinos_with_zoltan=true.output similarity index 100% rename from tests/mpi/solution_transfer_02.with_trilinos=true.output rename to tests/mpi/solution_transfer_02.with_trilinos=true.with_trilinos_with_zoltan=true.output diff --git a/tests/mpi/solution_transfer_03.cc b/tests/mpi/solution_transfer_03.cc index 79cd90e085..738bbe74eb 100644 --- a/tests/mpi/solution_transfer_03.cc +++ b/tests/mpi/solution_transfer_03.cc @@ -96,8 +96,10 @@ transfer(const MPI_Comm &mpi_communicator) Triangulation 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 fe(FE_Q(2), 1, FE_Q(1), 1); const std::vector block_component({0, 1}); diff --git a/tests/mpi/solution_transfer_03.with_trilinos=true.mpirun=2.output b/tests/mpi/solution_transfer_03.with_trilinos=true.with_trilinos_with_zoltan=true.mpirun=2.output similarity index 100% rename from tests/mpi/solution_transfer_03.with_trilinos=true.mpirun=2.output rename to tests/mpi/solution_transfer_03.with_trilinos=true.with_trilinos_with_zoltan=true.mpirun=2.output diff --git a/tests/mpi/solution_transfer_03.with_trilinos=true.output b/tests/mpi/solution_transfer_03.with_trilinos=true.with_trilinos_with_zoltan=true.output similarity index 100% rename from tests/mpi/solution_transfer_03.with_trilinos=true.output rename to tests/mpi/solution_transfer_03.with_trilinos=true.with_trilinos_with_zoltan=true.output