From 3976d9caf6dc171e64c453647bef854a65416aaf Mon Sep 17 00:00:00 2001 From: Daniel Arndt Date: Mon, 5 Sep 2016 19:22:48 +0200 Subject: [PATCH] Fix tests --- tests/bits/step-16.cc | 3 +- tests/dofs/block_info.cc | 4 +- tests/dofs/block_info_02.cc | 4 +- tests/dofs/block_list.h | 5 +- tests/dofs/block_list_05.cc | 5 +- tests/dofs/dof_renumbering.cc | 4 +- tests/dofs/dof_renumbering_02.cc | 4 +- tests/dofs/dof_renumbering_07.cc | 4 +- tests/dofs/dof_renumbering_08.cc | 4 +- tests/dofs/extract_dofs_by_component_01_mg.cc | 4 +- tests/dofs/extract_dofs_by_component_02_mg.cc | 4 +- tests/fe/transfer.cc | 6 +-- .../assembler_simple_mgmatrix_03.cc | 4 +- .../assembler_simple_mgmatrix_04.cc | 4 +- tests/integrators/cells_and_faces_01.cc | 4 +- tests/integrators/functional_01.cc | 4 +- tests/integrators/mesh_worker_01.cc | 4 +- tests/integrators/mesh_worker_02.cc | 4 +- tests/integrators/mesh_worker_03.cc | 4 +- tests/matrix_free/matrix_vector_mg.cc | 2 +- tests/matrix_free/parallel_multigrid.cc | 5 +- .../parallel_multigrid_adaptive.cc | 5 +- .../parallel_multigrid_adaptive_mf.cc | 5 +- tests/matrix_free/parallel_multigrid_mf.cc | 5 +- tests/matrix_free/step-37.cc | 3 +- tests/mpi/mg_02.cc | 4 +- tests/mpi/mg_03.cc | 4 +- tests/mpi/mg_04.cc | 4 +- tests/mpi/mg_05.cc | 4 +- tests/mpi/mg_06.cc | 4 +- tests/mpi/mg_ghost_dofs_periodic_01.cc | 4 +- tests/mpi/mg_ghost_dofs_periodic_02.cc | 4 +- tests/mpi/mg_ghost_dofs_periodic_03.cc | 4 +- tests/mpi/mg_ghost_dofs_periodic_04.cc | 4 +- tests/multigrid/boundary_01.cc | 4 +- tests/multigrid/constrained_dofs_01.cc | 6 +-- tests/multigrid/constrained_dofs_02.cc | 6 +-- tests/multigrid/constrained_dofs_03.cc | 2 +- tests/multigrid/count_01.cc | 4 +- tests/multigrid/distribute_bug_01.cc | 4 +- tests/multigrid/dof_01.cc | 4 +- tests/multigrid/dof_02.cc | 4 +- tests/multigrid/dof_03.cc | 4 +- tests/multigrid/dof_04.cc | 2 +- tests/multigrid/dof_05.cc | 2 +- tests/multigrid/renumbering_01.cc | 4 +- tests/multigrid/renumbering_02.cc | 4 +- tests/multigrid/renumbering_03.cc | 4 +- tests/multigrid/renumbering_04.cc | 4 +- tests/multigrid/step-39-02.cc | 3 +- tests/multigrid/step-39-02.output | 44 ++++++++--------- tests/multigrid/step-39-02a.cc | 3 +- tests/multigrid/step-39-02a.output | 44 ++++++++--------- tests/multigrid/step-39-03.cc | 3 +- tests/multigrid/step-39-03.output | 48 +++++++++---------- tests/multigrid/step-39.cc | 3 +- tests/multigrid/step-39.output | 44 ++++++++--------- tests/multigrid/transfer_01.cc | 4 +- tests/multigrid/transfer_02.cc | 4 +- tests/multigrid/transfer_04.cc | 4 +- tests/multigrid/transfer_04a.cc | 4 +- tests/multigrid/transfer_block.cc | 4 +- tests/multigrid/transfer_block_select.cc | 4 +- tests/multigrid/transfer_compare_01.cc | 4 +- tests/multigrid/transfer_prebuilt_01.cc | 4 +- tests/multigrid/transfer_prebuilt_02.cc | 4 +- tests/multigrid/transfer_prebuilt_03.cc | 4 +- tests/multigrid/transfer_select.cc | 4 +- tests/multigrid/transfer_system_01.cc | 4 +- tests/multigrid/transfer_system_02.cc | 4 +- tests/multigrid/transfer_system_03.cc | 4 +- tests/multigrid/transfer_system_04.cc | 4 +- tests/multigrid/transfer_system_05.cc | 4 +- .../multigrid/transfer_system_adaptive_01.cc | 4 +- .../multigrid/transfer_system_adaptive_02.cc | 4 +- .../multigrid/transfer_system_adaptive_03.cc | 4 +- .../multigrid/transfer_system_adaptive_04.cc | 4 +- .../multigrid/transfer_system_adaptive_05.cc | 4 +- .../multigrid/transfer_system_adaptive_06.cc | 4 +- .../multigrid/transfer_system_adaptive_07.cc | 4 +- .../multigrid/transfer_system_adaptive_08.cc | 4 +- .../multigrid/transfer_system_adaptive_09.cc | 4 +- 82 files changed, 251 insertions(+), 239 deletions(-) diff --git a/tests/bits/step-16.cc b/tests/bits/step-16.cc index 63adbc035e..8e812073ee 100644 --- a/tests/bits/step-16.cc +++ b/tests/bits/step-16.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2005 - 2015 by the deal.II authors +// Copyright (C) 2005 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -88,6 +88,7 @@ private: template LaplaceProblem::LaplaceProblem () : + triangulation(limit_level_difference_at_vertices), fe (1), mg_dof_handler (triangulation) {} diff --git a/tests/dofs/block_info.cc b/tests/dofs/block_info.cc index 51bafaae61..42e288e61b 100644 --- a/tests/dofs/block_info.cc +++ b/tests/dofs/block_info.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2009 - 2015 by the deal.II authors +// Copyright (C) 2009 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -75,7 +75,7 @@ void test_grid(const Triangulation &tr, template void test_fe (const FiniteElement &fe) { - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(5-dim); test_grid(tr, fe); diff --git a/tests/dofs/block_info_02.cc b/tests/dofs/block_info_02.cc index b74fa7b9db..11bd1f38dd 100644 --- a/tests/dofs/block_info_02.cc +++ b/tests/dofs/block_info_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2009 - 2015 by the deal.II authors +// Copyright (C) 2009 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -78,7 +78,7 @@ void test_grid(const Triangulation &tr, template void test_fe (const FiniteElement &fe) { - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(5-dim); test_grid(tr, fe); diff --git a/tests/dofs/block_list.h b/tests/dofs/block_list.h index 594fabbf35..49df30ce34 100644 --- a/tests/dofs/block_list.h +++ b/tests/dofs/block_list.h @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2011 - 2015 by the deal.II authors +// Copyright (C) 2011 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -57,7 +57,8 @@ void test_global_refinement( void (*test_block_list)(const TR &tr, const FiniteElement &fe)) { const unsigned int dim=TR::dimension; - TR trc, trl; + TR trc(Triangulation::limit_level_difference_at_vertices); + TR trl(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(trc); trc.refine_global(2); GridGenerator::hyper_L(trl); diff --git a/tests/dofs/block_list_05.cc b/tests/dofs/block_list_05.cc index a4d1d698a1..363a88ac97 100644 --- a/tests/dofs/block_list_05.cc +++ b/tests/dofs/block_list_05.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2009 - 2015 by the deal.II authors +// Copyright (C) 2009 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -136,7 +136,8 @@ template void test_global_refinement( void (*test_block_list)(const Triangulation &tr, const FiniteElement &fe)) { - Triangulation trc, trl; + Triangulation trc(Triangulation::limit_level_difference_at_vertices); + Triangulation trl(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(trc); trc.refine_global(2); GridGenerator::hyper_L(trl); diff --git a/tests/dofs/dof_renumbering.cc b/tests/dofs/dof_renumbering.cc index 0eb632f4a7..6ab13b4d0d 100644 --- a/tests/dofs/dof_renumbering.cc +++ b/tests/dofs/dof_renumbering.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -150,7 +150,7 @@ template void check () { - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); if (dim==2) GridGenerator::hyper_ball(tr, Point(), 1); else diff --git a/tests/dofs/dof_renumbering_02.cc b/tests/dofs/dof_renumbering_02.cc index 6ad723b75b..49d923c794 100644 --- a/tests/dofs/dof_renumbering_02.cc +++ b/tests/dofs/dof_renumbering_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -148,7 +148,7 @@ template void check () { - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr, -1., 1.); tr.refine_global (1); tr.begin_active()->set_refine_flag (); diff --git a/tests/dofs/dof_renumbering_07.cc b/tests/dofs/dof_renumbering_07.cc index d85d22e7e9..280c88a5e8 100644 --- a/tests/dofs/dof_renumbering_07.cc +++ b/tests/dofs/dof_renumbering_07.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -88,7 +88,7 @@ template void check () { - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr, -1., 1.); tr.refine_global (1); tr.begin_active()->set_refine_flag (); diff --git a/tests/dofs/dof_renumbering_08.cc b/tests/dofs/dof_renumbering_08.cc index 94c8b709c5..95b2194920 100644 --- a/tests/dofs/dof_renumbering_08.cc +++ b/tests/dofs/dof_renumbering_08.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -86,7 +86,7 @@ template void check () { - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr, -1., 1.); tr.refine_global (1); tr.begin_active()->set_refine_flag (); diff --git a/tests/dofs/extract_dofs_by_component_01_mg.cc b/tests/dofs/extract_dofs_by_component_01_mg.cc index 980d09ffa0..2496a6820d 100644 --- a/tests/dofs/extract_dofs_by_component_01_mg.cc +++ b/tests/dofs/extract_dofs_by_component_01_mg.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -44,7 +44,7 @@ template void check () { - Triangulation tr; + Triangulation tr(Triangulation:: limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr, -1,1); tr.refine_global (1); tr.begin_active()->set_refine_flag(); diff --git a/tests/dofs/extract_dofs_by_component_02_mg.cc b/tests/dofs/extract_dofs_by_component_02_mg.cc index 277522ff57..28d4b06b00 100644 --- a/tests/dofs/extract_dofs_by_component_02_mg.cc +++ b/tests/dofs/extract_dofs_by_component_02_mg.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -45,7 +45,7 @@ template void check () { - Triangulation tr; + Triangulation tr(Triangulation:: limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr, -1,1); tr.refine_global (1); tr.begin_active()->set_refine_flag(); diff --git a/tests/fe/transfer.cc b/tests/fe/transfer.cc index 9b30b01d7b..ab3e70df15 100644 --- a/tests/fe/transfer.cc +++ b/tests/fe/transfer.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 1998 - 2015 by the deal.II authors +// Copyright (C) 1998 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -79,12 +79,12 @@ main() deallog << std::setprecision(7); deallog.threshold_double(1.e-10); - Triangulation<2> tr2; + Triangulation<2> tr2(Triangulation<2>::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr2, -1., 1.); tr2.refine_global(2); - Triangulation<3> tr3; + Triangulation<3> tr3(Triangulation<3>::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr3, -1., 1.); tr3.refine_global(3); diff --git a/tests/integrators/assembler_simple_mgmatrix_03.cc b/tests/integrators/assembler_simple_mgmatrix_03.cc index cb6ca1d9db..172e67d6cf 100644 --- a/tests/integrators/assembler_simple_mgmatrix_03.cc +++ b/tests/integrators/assembler_simple_mgmatrix_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2012 - 2015 by the deal.II authors +// Copyright (C) 2012 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -62,7 +62,7 @@ void test(FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation:: limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(1); diff --git a/tests/integrators/assembler_simple_mgmatrix_04.cc b/tests/integrators/assembler_simple_mgmatrix_04.cc index ab23a6efc3..9c2624ce9d 100644 --- a/tests/integrators/assembler_simple_mgmatrix_04.cc +++ b/tests/integrators/assembler_simple_mgmatrix_04.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2012 - 2015 by the deal.II authors +// Copyright (C) 2012 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -148,7 +148,7 @@ void test(FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation:: limit_level_difference_at_vertices); std::vector repititions (dim, 1); repititions[0] = 2; const Point p1 = (dim == 1 ? Point (-1.) : (dim == 2 ? Point(-1.,-1.) : Point (-1.,-1.,-1.))); diff --git a/tests/integrators/cells_and_faces_01.cc b/tests/integrators/cells_and_faces_01.cc index f648a168fa..412793fa7a 100644 --- a/tests/integrators/cells_and_faces_01.cc +++ b/tests/integrators/cells_and_faces_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -160,7 +160,7 @@ template void test(const FiniteElement &fe) { - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); DoFHandler dofs(tr); GridGenerator::hyper_cube(tr); tr.refine_global(1); diff --git a/tests/integrators/functional_01.cc b/tests/integrators/functional_01.cc index ecd6f34d57..3b8a6592d8 100644 --- a/tests/integrators/functional_01.cc +++ b/tests/integrators/functional_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -133,7 +133,7 @@ template void test(const FiniteElement &fe) { - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); DoFHandler dofs(tr); GridGenerator::hyper_cube(tr); tr.refine_global(1); diff --git a/tests/integrators/mesh_worker_01.cc b/tests/integrators/mesh_worker_01.cc index e2e4846849..117c361605 100644 --- a/tests/integrators/mesh_worker_01.cc +++ b/tests/integrators/mesh_worker_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -169,7 +169,7 @@ template void test(const FiniteElement &fe) { - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(1); tr.begin(1)->set_refine_flag(); diff --git a/tests/integrators/mesh_worker_02.cc b/tests/integrators/mesh_worker_02.cc index 0ef5716b84..e647a46349 100644 --- a/tests/integrators/mesh_worker_02.cc +++ b/tests/integrators/mesh_worker_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -261,7 +261,7 @@ template void test(const FiniteElement &fe) { - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_L(tr); tr.begin()->set_refine_flag(); tr.execute_coarsening_and_refinement(); diff --git a/tests/integrators/mesh_worker_03.cc b/tests/integrators/mesh_worker_03.cc index 0f40de6ba2..249ea2ace6 100644 --- a/tests/integrators/mesh_worker_03.cc +++ b/tests/integrators/mesh_worker_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -275,7 +275,7 @@ void test(const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_L(tr); tr.begin()->set_refine_flag(); tr.execute_coarsening_and_refinement(); diff --git a/tests/matrix_free/matrix_vector_mg.cc b/tests/matrix_free/matrix_vector_mg.cc index 1f84da8844..57341791a6 100644 --- a/tests/matrix_free/matrix_vector_mg.cc +++ b/tests/matrix_free/matrix_vector_mg.cc @@ -35,7 +35,7 @@ template void test () { const SphericalManifold manifold; - Triangulation tria; + Triangulation tria(Triangulation:: limit_level_difference_at_vertices); GridGenerator::hyper_ball (tria); typename Triangulation::active_cell_iterator cell = tria.begin_active (), diff --git a/tests/matrix_free/parallel_multigrid.cc b/tests/matrix_free/parallel_multigrid.cc index 56a5099934..238c87db06 100644 --- a/tests/matrix_free/parallel_multigrid.cc +++ b/tests/matrix_free/parallel_multigrid.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2014 - 2016-2015 by the deal.II authors +// Copyright (C) 2014 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -397,7 +397,8 @@ void test () for (unsigned int i=5; i<8; ++i) { parallel::distributed::Triangulation tria(MPI_COMM_WORLD, - dealii::Triangulation::none,parallel::distributed::Triangulation::construct_multigrid_hierarchy); + Triangulation::limit_level_difference_at_vertices, + parallel::distributed::Triangulation::construct_multigrid_hierarchy); GridGenerator::hyper_cube (tria); tria.refine_global(i-dim); diff --git a/tests/matrix_free/parallel_multigrid_adaptive.cc b/tests/matrix_free/parallel_multigrid_adaptive.cc index b134b460b5..0de815ad43 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2014 - 2016-2015 by the deal.II authors +// Copyright (C) 2014 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -548,7 +548,8 @@ template void test () { parallel::distributed::Triangulation tria(MPI_COMM_WORLD, - dealii::Triangulation::none,parallel::distributed::Triangulation::construct_multigrid_hierarchy); + Triangulation::limit_level_difference_at_vertices, + parallel::distributed::Triangulation::construct_multigrid_hierarchy); GridGenerator::hyper_cube (tria); tria.refine_global(6-dim); const unsigned int n_runs = fe_degree == 1 ? 6-dim : 5-dim; diff --git a/tests/matrix_free/parallel_multigrid_adaptive_mf.cc b/tests/matrix_free/parallel_multigrid_adaptive_mf.cc index bcd35df53d..746302e207 100644 --- a/tests/matrix_free/parallel_multigrid_adaptive_mf.cc +++ b/tests/matrix_free/parallel_multigrid_adaptive_mf.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2014 - 2016-2016 by the deal.II authors +// Copyright (C) 2014 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -537,7 +537,8 @@ template void test () { parallel::distributed::Triangulation tria(MPI_COMM_WORLD, - dealii::Triangulation::none,parallel::distributed::Triangulation::construct_multigrid_hierarchy); + Triangulation::limit_level_difference_at_vertices, + parallel::distributed::Triangulation::construct_multigrid_hierarchy); GridGenerator::hyper_cube (tria); tria.refine_global(8-2*dim); const unsigned int n_runs = fe_degree == 1 ? 6-dim : 5-dim; diff --git a/tests/matrix_free/parallel_multigrid_mf.cc b/tests/matrix_free/parallel_multigrid_mf.cc index 5ff611f1cf..3a81c512f4 100644 --- a/tests/matrix_free/parallel_multigrid_mf.cc +++ b/tests/matrix_free/parallel_multigrid_mf.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2014 - 2016-2016 by the deal.II authors +// Copyright (C) 2014 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -397,7 +397,8 @@ void test () for (unsigned int i=5; i<8; ++i) { parallel::distributed::Triangulation tria(MPI_COMM_WORLD, - dealii::Triangulation::none,parallel::distributed::Triangulation::construct_multigrid_hierarchy); + Triangulation::limit_level_difference_at_vertices, + parallel::distributed::Triangulation::construct_multigrid_hierarchy); GridGenerator::hyper_cube (tria); tria.refine_global(i-dim); diff --git a/tests/matrix_free/step-37.cc b/tests/matrix_free/step-37.cc index eddfcfbf37..14347b08fc 100644 --- a/tests/matrix_free/step-37.cc +++ b/tests/matrix_free/step-37.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2012 - 2015 by the deal.II authors +// Copyright (C) 2012 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -395,6 +395,7 @@ namespace Step37 template LaplaceProblem::LaplaceProblem () : + triangulation (Triangulation::limit_level_difference_at_vertices), fe (degree_finite_element), dof_handler (triangulation) {} diff --git a/tests/mpi/mg_02.cc b/tests/mpi/mg_02.cc index e9f21d363a..a3385c9b3f 100644 --- a/tests/mpi/mg_02.cc +++ b/tests/mpi/mg_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2009 - 2015 by the deal.II authors +// Copyright (C) 2009 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -47,7 +47,7 @@ void test() deallog << "hyper_cube" << std::endl; parallel::distributed::Triangulation tr(MPI_COMM_WORLD, - Triangulation::none, + Triangulation:: limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); GridGenerator::hyper_cube(tr); diff --git a/tests/mpi/mg_03.cc b/tests/mpi/mg_03.cc index 93edccb637..80b6f2b997 100644 --- a/tests/mpi/mg_03.cc +++ b/tests/mpi/mg_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2009 - 2015 by the deal.II authors +// Copyright (C) 2009 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -71,7 +71,7 @@ void test() deallog << "hyper_cube" << std::endl; parallel::distributed::Triangulation tr(MPI_COMM_WORLD, - Triangulation::none, + Triangulation:: limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); GridGenerator::hyper_cube(tr); diff --git a/tests/mpi/mg_04.cc b/tests/mpi/mg_04.cc index 47785f1c94..df2f558c26 100644 --- a/tests/mpi/mg_04.cc +++ b/tests/mpi/mg_04.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2009 - 2015 by the deal.II authors +// Copyright (C) 2009 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -68,7 +68,7 @@ void test() deallog << "hyper_cube" << std::endl; parallel::distributed::Triangulation tr(MPI_COMM_WORLD, - Triangulation::none, + Triangulation:: limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); GridGenerator::hyper_cube(tr); tr.refine_global(2); diff --git a/tests/mpi/mg_05.cc b/tests/mpi/mg_05.cc index 1133fdf1d9..b511f2cc91 100644 --- a/tests/mpi/mg_05.cc +++ b/tests/mpi/mg_05.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2009 - 2015 by the deal.II authors +// Copyright (C) 2009 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -87,7 +87,7 @@ void test() unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD); parallel::distributed::Triangulation tr(MPI_COMM_WORLD, - Triangulation::none, + Triangulation:: limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); GridGenerator::hyper_cube(tr); tr.refine_global(3); diff --git a/tests/mpi/mg_06.cc b/tests/mpi/mg_06.cc index 272b96560f..3b8006362b 100644 --- a/tests/mpi/mg_06.cc +++ b/tests/mpi/mg_06.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2009 - 2015 by the deal.II authors +// Copyright (C) 2009 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -87,7 +87,7 @@ void test() unsigned int myid = Utilities::MPI::this_mpi_process (MPI_COMM_WORLD); parallel::distributed::Triangulation tr(MPI_COMM_WORLD, - Triangulation::none, + Triangulation:: limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); GridGenerator::hyper_cube_slit(tr,-1,1); tr.refine_global(2); diff --git a/tests/mpi/mg_ghost_dofs_periodic_01.cc b/tests/mpi/mg_ghost_dofs_periodic_01.cc index 257040a8b5..00d9a2d350 100644 --- a/tests/mpi/mg_ghost_dofs_periodic_01.cc +++ b/tests/mpi/mg_ghost_dofs_periodic_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2015 - 2015 by the deal.II authors +// Copyright (C) 2015 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -29,7 +29,7 @@ template void test() { parallel::distributed::Triangulation tria(MPI_COMM_WORLD, - Triangulation::none, + Triangulation:: limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); std::vector subdivisions(dim); Point p1, p2; diff --git a/tests/mpi/mg_ghost_dofs_periodic_02.cc b/tests/mpi/mg_ghost_dofs_periodic_02.cc index ac5fcee52e..1a29d568de 100644 --- a/tests/mpi/mg_ghost_dofs_periodic_02.cc +++ b/tests/mpi/mg_ghost_dofs_periodic_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2015 - 2015 by the deal.II authors +// Copyright (C) 2015 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -32,7 +32,7 @@ void test() { Assert(dim == 3, ExcNotImplemented()); parallel::distributed::Triangulation tria(MPI_COMM_WORLD, - Triangulation::none, + Triangulation:: limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); GridGenerator::hyper_cube(tria, 0, 1); for (unsigned int face=2; face::faces_per_cell; ++face) diff --git a/tests/mpi/mg_ghost_dofs_periodic_03.cc b/tests/mpi/mg_ghost_dofs_periodic_03.cc index 589c3364a8..d536442dd5 100644 --- a/tests/mpi/mg_ghost_dofs_periodic_03.cc +++ b/tests/mpi/mg_ghost_dofs_periodic_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2015 - 2015 by the deal.II authors +// Copyright (C) 2015 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -32,7 +32,7 @@ void test() { Assert(dim == 2, ExcNotImplemented()); parallel::distributed::Triangulation tria(MPI_COMM_WORLD, - Triangulation::none, + Triangulation:: limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); for (unsigned int run=0; run<2; ++run) { diff --git a/tests/mpi/mg_ghost_dofs_periodic_04.cc b/tests/mpi/mg_ghost_dofs_periodic_04.cc index d5f4c6e0d4..096f16c6e3 100644 --- a/tests/mpi/mg_ghost_dofs_periodic_04.cc +++ b/tests/mpi/mg_ghost_dofs_periodic_04.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2015 - 2015 by the deal.II authors +// Copyright (C) 2015 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -30,7 +30,7 @@ template void test() { parallel::distributed::Triangulation tria(MPI_COMM_WORLD, - Triangulation::none, + Triangulation:: limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); std::vector subdivisions(dim); Point p1, p2; diff --git a/tests/multigrid/boundary_01.cc b/tests/multigrid/boundary_01.cc index c2ac00d478..7b5b482282 100644 --- a/tests/multigrid/boundary_01.cc +++ b/tests/multigrid/boundary_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2006 - 2015 by the deal.II authors +// Copyright (C) 2006 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -58,7 +58,7 @@ void check_fe(FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); ZeroFunction zero; diff --git a/tests/multigrid/constrained_dofs_01.cc b/tests/multigrid/constrained_dofs_01.cc index 062d4be507..f06b9f5f47 100644 --- a/tests/multigrid/constrained_dofs_01.cc +++ b/tests/multigrid/constrained_dofs_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2006 - 2015 by the deal.II authors +// Copyright (C) 2006 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -63,7 +63,7 @@ void check_fe(FiniteElement &fe) deallog << fe.get_name() << std::endl; parallel::distributed::Triangulation tr(MPI_COMM_WORLD, - Triangulation::none, + Triangulation::limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); setup_tria(tr); @@ -79,7 +79,7 @@ void check_fe(FiniteElement &fe) { // reorder parallel::distributed::Triangulation tr(MPI_COMM_SELF, - Triangulation::none, + Triangulation::limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); setup_tria(tr); diff --git a/tests/multigrid/constrained_dofs_02.cc b/tests/multigrid/constrained_dofs_02.cc index 87777538c1..023b07d657 100644 --- a/tests/multigrid/constrained_dofs_02.cc +++ b/tests/multigrid/constrained_dofs_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2006 - 2015 by the deal.II authors +// Copyright (C) 2006 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -119,7 +119,7 @@ void check_fe(FiniteElement &fe) deallog << fe.get_name() << std::endl; parallel::distributed::Triangulation tr(MPI_COMM_WORLD, - Triangulation::none, + Triangulation::limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); setup_tria(tr); @@ -135,7 +135,7 @@ void check_fe(FiniteElement &fe) { // reorder parallel::distributed::Triangulation tr(MPI_COMM_SELF, - Triangulation::none, + Triangulation::limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); setup_tria(tr); diff --git a/tests/multigrid/constrained_dofs_03.cc b/tests/multigrid/constrained_dofs_03.cc index 4ce74154d8..31e0784658 100644 --- a/tests/multigrid/constrained_dofs_03.cc +++ b/tests/multigrid/constrained_dofs_03.cc @@ -47,7 +47,7 @@ void check_fe(FiniteElement &fe, ComponentMask &component_mask) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(1); diff --git a/tests/multigrid/count_01.cc b/tests/multigrid/count_01.cc index b89511b601..7a30711819 100644 --- a/tests/multigrid/count_01.cc +++ b/tests/multigrid/count_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2006 - 2015 by the deal.II authors +// Copyright (C) 2006 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -53,7 +53,7 @@ void check_fe(FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(1); tr.begin_active()->set_refine_flag(); diff --git a/tests/multigrid/distribute_bug_01.cc b/tests/multigrid/distribute_bug_01.cc index 47c0323de6..5417e2406a 100644 --- a/tests/multigrid/distribute_bug_01.cc +++ b/tests/multigrid/distribute_bug_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2006 - 2015 by the deal.II authors +// Copyright (C) 2006 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -54,7 +54,7 @@ void do_test () deallog << "Testing " << fe.get_name() << std::endl << std::endl; parallel::distributed::Triangulation triangulation (MPI_COMM_WORLD, - Triangulation::none, + Triangulation::limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); GridGenerator::subdivided_hyper_cube (triangulation, 1, -1, 1); diff --git a/tests/multigrid/dof_01.cc b/tests/multigrid/dof_01.cc index 1cc4916d7f..eba0b46587 100644 --- a/tests/multigrid/dof_01.cc +++ b/tests/multigrid/dof_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2006 - 2015 by the deal.II authors +// Copyright (C) 2006 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -70,7 +70,7 @@ void check_fe(FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); ZeroFunction zero; diff --git a/tests/multigrid/dof_02.cc b/tests/multigrid/dof_02.cc index dabbaad16b..991b47638d 100644 --- a/tests/multigrid/dof_02.cc +++ b/tests/multigrid/dof_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2006 - 2015 by the deal.II authors +// Copyright (C) 2006 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -75,7 +75,7 @@ void check_fe(FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); ZeroFunction zero; diff --git a/tests/multigrid/dof_03.cc b/tests/multigrid/dof_03.cc index 19f4e03507..b3aa930f32 100644 --- a/tests/multigrid/dof_03.cc +++ b/tests/multigrid/dof_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2006 - 2015 by the deal.II authors +// Copyright (C) 2006 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -37,7 +37,7 @@ void check() { FE_Q fe(1); - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(1); diff --git a/tests/multigrid/dof_04.cc b/tests/multigrid/dof_04.cc index d6eb7b11f0..2f1b50d1f1 100644 --- a/tests/multigrid/dof_04.cc +++ b/tests/multigrid/dof_04.cc @@ -32,7 +32,7 @@ void check() // need cubic polynomials that have two dofs on lines FE_Q fe(3); - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); if (dim > 1) GridGenerator::hyper_shell(tr, Point(), 0.5, 1, 12); else diff --git a/tests/multigrid/dof_05.cc b/tests/multigrid/dof_05.cc index 86e2a21778..7e88eabf63 100644 --- a/tests/multigrid/dof_05.cc +++ b/tests/multigrid/dof_05.cc @@ -32,7 +32,7 @@ void check() // need cubic polynomials that have two dofs on lines FE_Q fe(3); - parallel::distributed::Triangulation tr(MPI_COMM_WORLD, Triangulation::none, + parallel::distributed::Triangulation tr(MPI_COMM_WORLD, Triangulation::limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); GridGenerator::hyper_shell(tr, Point(), 0.5, 1, 12); tr.refine_global(1); diff --git a/tests/multigrid/renumbering_01.cc b/tests/multigrid/renumbering_01.cc index 4b816b1a2e..e53fe90e34 100644 --- a/tests/multigrid/renumbering_01.cc +++ b/tests/multigrid/renumbering_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -43,7 +43,7 @@ void check() FESystem fe(FE_DGP(1), 1, FE_DGQ(2), 2, FE_Q(3), 1); deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(1); tr.begin_active()->set_refine_flag(); diff --git a/tests/multigrid/renumbering_02.cc b/tests/multigrid/renumbering_02.cc index 85ff9bbeb3..224cefe188 100644 --- a/tests/multigrid/renumbering_02.cc +++ b/tests/multigrid/renumbering_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -44,7 +44,7 @@ void check() FE_DGQ fe(1); deallog << fe.get_name() << std::endl; - Triangulation tria; + Triangulation tria(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tria); tria.refine_global(2); typename Triangulation::active_cell_iterator cell=tria.begin_active(); diff --git a/tests/multigrid/renumbering_03.cc b/tests/multigrid/renumbering_03.cc index 048c5afc53..04e363ed65 100644 --- a/tests/multigrid/renumbering_03.cc +++ b/tests/multigrid/renumbering_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -46,7 +46,7 @@ void check() FE_Q fe(3); deallog << fe.get_name() << std::endl; - Triangulation tria; + Triangulation tria(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tria); tria.refine_global(2); typename Triangulation::active_cell_iterator cell=tria.begin_active(); diff --git a/tests/multigrid/renumbering_04.cc b/tests/multigrid/renumbering_04.cc index 50f7b2827c..cccc626558 100644 --- a/tests/multigrid/renumbering_04.cc +++ b/tests/multigrid/renumbering_04.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -42,7 +42,7 @@ void check(FiniteElement &fe) { deallog << std::endl << "**** " << fe.get_name() << std::endl; - Triangulation tria; + Triangulation tria(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tria); tria.refine_global(1); tria.begin_active()->set_refine_flag(); diff --git a/tests/multigrid/step-39-02.cc b/tests/multigrid/step-39-02.cc index 2dd1e8fd5b..a2ea0a8d31 100644 --- a/tests/multigrid/step-39-02.cc +++ b/tests/multigrid/step-39-02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2013 - 2015 by the deal.II authors +// Copyright (C) 2013 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -379,6 +379,7 @@ namespace Step39 template InteriorPenaltyProblem::InteriorPenaltyProblem(const FiniteElement &fe) : + triangulation(Triangulation::limit_level_difference_at_vertices), mapping(1), fe(fe), dof_handler(triangulation), diff --git a/tests/multigrid/step-39-02.output b/tests/multigrid/step-39-02.output index 0af72150d3..7b8335ea4c 100644 --- a/tests/multigrid/step-39-02.output +++ b/tests/multigrid/step-39-02.output @@ -20,7 +20,7 @@ DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve DEAL:cg::Starting value 23.0730 -DEAL:cg::Convergence step 11 value 9.37499e-13 +DEAL:cg::Convergence step 11 value 9.09099e-13 DEAL::energy-error: 0.332582 DEAL::L2-error: 0.00548996 DEAL::Estimate 0.838060 @@ -32,43 +32,43 @@ DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve DEAL:cg::Starting value 23.0730 -DEAL:cg::Convergence step 12 value 3.41649e-13 +DEAL:cg::Convergence step 12 value 1.66147e-13 DEAL::energy-error: 0.237705 DEAL::L2-error: 0.00250869 DEAL::Estimate 0.611449 DEAL::Step 3 -DEAL::Triangulation 58 cells, 5 levels -DEAL::DoFHandler 522 dofs, level dofs 36 144 180 180 144 +DEAL::Triangulation 64 cells, 5 levels +DEAL::DoFHandler 576 dofs, level dofs 36 144 216 216 144 DEAL::Assemble matrix DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve -DEAL:cg::Starting value 23.4898 -DEAL:cg::Convergence step 12 value 5.58516e-13 -DEAL::energy-error: 0.170860 -DEAL::L2-error: 0.00120805 -DEAL::Estimate 0.452418 +DEAL:cg::Starting value 24.1546 +DEAL:cg::Convergence step 13 value 2.19190e-13 +DEAL::energy-error: 0.170175 +DEAL::L2-error: 0.00120328 +DEAL::Estimate 0.448676 DEAL::Step 4 -DEAL::Triangulation 85 cells, 6 levels -DEAL::DoFHandler 765 dofs, level dofs 36 144 360 180 180 108 +DEAL::Triangulation 91 cells, 6 levels +DEAL::DoFHandler 819 dofs, level dofs 36 144 396 216 180 108 DEAL::Assemble matrix DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve -DEAL:cg::Starting value 25.9490 -DEAL:cg::Convergence step 13 value 2.71720e-13 -DEAL::energy-error: 0.122755 -DEAL::L2-error: 0.000602816 -DEAL::Estimate 0.332525 +DEAL:cg::Starting value 26.5522 +DEAL:cg::Convergence step 13 value 2.44978e-13 +DEAL::energy-error: 0.121878 +DEAL::L2-error: 0.000591777 +DEAL::Estimate 0.327296 DEAL::Step 5 -DEAL::Triangulation 130 cells, 7 levels -DEAL::DoFHandler 1170 dofs, level dofs 36 144 432 432 180 180 144 +DEAL::Triangulation 142 cells, 7 levels +DEAL::DoFHandler 1278 dofs, level dofs 36 144 432 432 288 216 144 DEAL::Assemble matrix DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve DEAL:cg::Starting value 27.1421 -DEAL:cg::Convergence step 13 value 2.50045e-13 -DEAL::energy-error: 0.0869445 -DEAL::L2-error: 0.000292783 -DEAL::Estimate 0.236647 +DEAL:cg::Convergence step 13 value 3.08737e-13 +DEAL::energy-error: 0.0863235 +DEAL::L2-error: 0.000292807 +DEAL::Estimate 0.232279 diff --git a/tests/multigrid/step-39-02a.cc b/tests/multigrid/step-39-02a.cc index b3847ebb8b..6d06e84545 100644 --- a/tests/multigrid/step-39-02a.cc +++ b/tests/multigrid/step-39-02a.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2013 - 2015 by the deal.II authors +// Copyright (C) 2013 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -381,6 +381,7 @@ namespace Step39 template InteriorPenaltyProblem::InteriorPenaltyProblem(const FiniteElement &fe) : + triangulation(Triangulation::limit_level_difference_at_vertices), mapping(1), fe(fe), dof_handler(triangulation), diff --git a/tests/multigrid/step-39-02a.output b/tests/multigrid/step-39-02a.output index 0af72150d3..7b8335ea4c 100644 --- a/tests/multigrid/step-39-02a.output +++ b/tests/multigrid/step-39-02a.output @@ -20,7 +20,7 @@ DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve DEAL:cg::Starting value 23.0730 -DEAL:cg::Convergence step 11 value 9.37499e-13 +DEAL:cg::Convergence step 11 value 9.09099e-13 DEAL::energy-error: 0.332582 DEAL::L2-error: 0.00548996 DEAL::Estimate 0.838060 @@ -32,43 +32,43 @@ DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve DEAL:cg::Starting value 23.0730 -DEAL:cg::Convergence step 12 value 3.41649e-13 +DEAL:cg::Convergence step 12 value 1.66147e-13 DEAL::energy-error: 0.237705 DEAL::L2-error: 0.00250869 DEAL::Estimate 0.611449 DEAL::Step 3 -DEAL::Triangulation 58 cells, 5 levels -DEAL::DoFHandler 522 dofs, level dofs 36 144 180 180 144 +DEAL::Triangulation 64 cells, 5 levels +DEAL::DoFHandler 576 dofs, level dofs 36 144 216 216 144 DEAL::Assemble matrix DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve -DEAL:cg::Starting value 23.4898 -DEAL:cg::Convergence step 12 value 5.58516e-13 -DEAL::energy-error: 0.170860 -DEAL::L2-error: 0.00120805 -DEAL::Estimate 0.452418 +DEAL:cg::Starting value 24.1546 +DEAL:cg::Convergence step 13 value 2.19190e-13 +DEAL::energy-error: 0.170175 +DEAL::L2-error: 0.00120328 +DEAL::Estimate 0.448676 DEAL::Step 4 -DEAL::Triangulation 85 cells, 6 levels -DEAL::DoFHandler 765 dofs, level dofs 36 144 360 180 180 108 +DEAL::Triangulation 91 cells, 6 levels +DEAL::DoFHandler 819 dofs, level dofs 36 144 396 216 180 108 DEAL::Assemble matrix DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve -DEAL:cg::Starting value 25.9490 -DEAL:cg::Convergence step 13 value 2.71720e-13 -DEAL::energy-error: 0.122755 -DEAL::L2-error: 0.000602816 -DEAL::Estimate 0.332525 +DEAL:cg::Starting value 26.5522 +DEAL:cg::Convergence step 13 value 2.44978e-13 +DEAL::energy-error: 0.121878 +DEAL::L2-error: 0.000591777 +DEAL::Estimate 0.327296 DEAL::Step 5 -DEAL::Triangulation 130 cells, 7 levels -DEAL::DoFHandler 1170 dofs, level dofs 36 144 432 432 180 180 144 +DEAL::Triangulation 142 cells, 7 levels +DEAL::DoFHandler 1278 dofs, level dofs 36 144 432 432 288 216 144 DEAL::Assemble matrix DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve DEAL:cg::Starting value 27.1421 -DEAL:cg::Convergence step 13 value 2.50045e-13 -DEAL::energy-error: 0.0869445 -DEAL::L2-error: 0.000292783 -DEAL::Estimate 0.236647 +DEAL:cg::Convergence step 13 value 3.08737e-13 +DEAL::energy-error: 0.0863235 +DEAL::L2-error: 0.000292807 +DEAL::Estimate 0.232279 diff --git a/tests/multigrid/step-39-03.cc b/tests/multigrid/step-39-03.cc index e486418a21..f082fb49df 100644 --- a/tests/multigrid/step-39-03.cc +++ b/tests/multigrid/step-39-03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2013 - 2015 by the deal.II authors +// Copyright (C) 2013 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -385,6 +385,7 @@ namespace Step39 template InteriorPenaltyProblem::InteriorPenaltyProblem(const FiniteElement &fe) : + triangulation(Triangulation::limit_level_difference_at_vertices), mapping(1), fe(fe), dof_handler(triangulation), diff --git a/tests/multigrid/step-39-03.output b/tests/multigrid/step-39-03.output index fe82684886..002798281b 100644 --- a/tests/multigrid/step-39-03.output +++ b/tests/multigrid/step-39-03.output @@ -8,7 +8,7 @@ DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve DEAL:GMRES::Starting value 9.41508 -DEAL:GMRES::Convergence step 10 value 7.45877e-13 +DEAL:GMRES::Convergence step 10 value 7.45878e-13 DEAL::energy-error: 0.439211 DEAL::L2-error: 0.0109342 DEAL::Estimate 0.979555 @@ -22,7 +22,7 @@ DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve DEAL:GMRES::Starting value 10.0041 -DEAL:GMRES::Convergence step 21 value 1.79028e-13 +DEAL:GMRES::Convergence step 21 value 1.79039e-13 DEAL::energy-error: 0.332582 DEAL::L2-error: 0.00548996 DEAL::Estimate 0.838060 @@ -36,51 +36,51 @@ DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve DEAL:GMRES::Starting value 10.8018 -DEAL:GMRES::Convergence step 28 value 2.71140e-13 +DEAL:GMRES::Convergence step 28 value 2.71098e-13 DEAL::energy-error: 0.237705 DEAL::L2-error: 0.00250869 DEAL::Estimate 0.611449 DEAL::Writing solution to ... DEAL:: DEAL::Step 3 -DEAL::Triangulation 58 cells, 5 levels -DEAL::DoFHandler 840 dofs, level dofs 63 229 285 285 233 +DEAL::Triangulation 64 cells, 5 levels +DEAL::DoFHandler 917 dofs, level dofs 63 229 337 337 233 DEAL::Assemble matrix DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve -DEAL:GMRES::Starting value 12.2055 -DEAL:GMRES::Convergence step 33 value 8.68786e-13 -DEAL::energy-error: 0.170860 -DEAL::L2-error: 0.00120805 -DEAL::Estimate 0.452418 +DEAL:GMRES::Starting value 13.4185 +DEAL:GMRES::Convergence step 32 value 6.11150e-13 +DEAL::energy-error: 0.170175 +DEAL::L2-error: 0.00120328 +DEAL::Estimate 0.448676 DEAL::Writing solution to ... DEAL:: DEAL::Step 4 -DEAL::Triangulation 85 cells, 6 levels -DEAL::DoFHandler 1218 dofs, level dofs 63 229 561 285 285 177 +DEAL::Triangulation 91 cells, 6 levels +DEAL::DoFHandler 1295 dofs, level dofs 63 229 613 337 285 177 DEAL::Assemble matrix DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve -DEAL:GMRES::Starting value 15.5679 -DEAL:GMRES::Convergence step 34 value 7.55616e-13 -DEAL::energy-error: 0.122755 -DEAL::L2-error: 0.000602816 -DEAL::Estimate 0.332525 +DEAL:GMRES::Starting value 16.6112 +DEAL:GMRES::Convergence step 32 value 7.81623e-13 +DEAL::energy-error: 0.121878 +DEAL::L2-error: 0.000591777 +DEAL::Estimate 0.327296 DEAL::Writing solution to ... DEAL:: DEAL::Step 5 -DEAL::Triangulation 130 cells, 7 levels -DEAL::DoFHandler 1841 dofs, level dofs 63 229 665 665 285 285 233 +DEAL::Triangulation 142 cells, 7 levels +DEAL::DoFHandler 2005 dofs, level dofs 63 229 665 665 449 337 233 DEAL::Assemble matrix DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve -DEAL:GMRES::Starting value 18.7682 -DEAL:GMRES::Convergence step 33 value 8.65709e-13 -DEAL::energy-error: 0.0869445 -DEAL::L2-error: 0.000292783 -DEAL::Estimate 0.236647 +DEAL:GMRES::Starting value 19.3095 +DEAL:GMRES::Convergence step 31 value 8.40512e-13 +DEAL::energy-error: 0.0863235 +DEAL::L2-error: 0.000292807 +DEAL::Estimate 0.232279 DEAL::Writing solution to ... DEAL:: diff --git a/tests/multigrid/step-39.cc b/tests/multigrid/step-39.cc index 093240d717..07d6afa247 100644 --- a/tests/multigrid/step-39.cc +++ b/tests/multigrid/step-39.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2010 - 2015 by the deal.II authors +// Copyright (C) 2010 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -379,6 +379,7 @@ namespace Step39 template InteriorPenaltyProblem::InteriorPenaltyProblem(const FiniteElement &fe) : + triangulation(Triangulation::limit_level_difference_at_vertices), mapping(1), fe(fe), dof_handler(triangulation), diff --git a/tests/multigrid/step-39.output b/tests/multigrid/step-39.output index 0af72150d3..7b8335ea4c 100644 --- a/tests/multigrid/step-39.output +++ b/tests/multigrid/step-39.output @@ -20,7 +20,7 @@ DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve DEAL:cg::Starting value 23.0730 -DEAL:cg::Convergence step 11 value 9.37499e-13 +DEAL:cg::Convergence step 11 value 9.09099e-13 DEAL::energy-error: 0.332582 DEAL::L2-error: 0.00548996 DEAL::Estimate 0.838060 @@ -32,43 +32,43 @@ DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve DEAL:cg::Starting value 23.0730 -DEAL:cg::Convergence step 12 value 3.41649e-13 +DEAL:cg::Convergence step 12 value 1.66147e-13 DEAL::energy-error: 0.237705 DEAL::L2-error: 0.00250869 DEAL::Estimate 0.611449 DEAL::Step 3 -DEAL::Triangulation 58 cells, 5 levels -DEAL::DoFHandler 522 dofs, level dofs 36 144 180 180 144 +DEAL::Triangulation 64 cells, 5 levels +DEAL::DoFHandler 576 dofs, level dofs 36 144 216 216 144 DEAL::Assemble matrix DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve -DEAL:cg::Starting value 23.4898 -DEAL:cg::Convergence step 12 value 5.58516e-13 -DEAL::energy-error: 0.170860 -DEAL::L2-error: 0.00120805 -DEAL::Estimate 0.452418 +DEAL:cg::Starting value 24.1546 +DEAL:cg::Convergence step 13 value 2.19190e-13 +DEAL::energy-error: 0.170175 +DEAL::L2-error: 0.00120328 +DEAL::Estimate 0.448676 DEAL::Step 4 -DEAL::Triangulation 85 cells, 6 levels -DEAL::DoFHandler 765 dofs, level dofs 36 144 360 180 180 108 +DEAL::Triangulation 91 cells, 6 levels +DEAL::DoFHandler 819 dofs, level dofs 36 144 396 216 180 108 DEAL::Assemble matrix DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve -DEAL:cg::Starting value 25.9490 -DEAL:cg::Convergence step 13 value 2.71720e-13 -DEAL::energy-error: 0.122755 -DEAL::L2-error: 0.000602816 -DEAL::Estimate 0.332525 +DEAL:cg::Starting value 26.5522 +DEAL:cg::Convergence step 13 value 2.44978e-13 +DEAL::energy-error: 0.121878 +DEAL::L2-error: 0.000591777 +DEAL::Estimate 0.327296 DEAL::Step 5 -DEAL::Triangulation 130 cells, 7 levels -DEAL::DoFHandler 1170 dofs, level dofs 36 144 432 432 180 180 144 +DEAL::Triangulation 142 cells, 7 levels +DEAL::DoFHandler 1278 dofs, level dofs 36 144 432 432 288 216 144 DEAL::Assemble matrix DEAL::Assemble multilevel matrix DEAL::Assemble right hand side DEAL::Solve DEAL:cg::Starting value 27.1421 -DEAL:cg::Convergence step 13 value 2.50045e-13 -DEAL::energy-error: 0.0869445 -DEAL::L2-error: 0.000292783 -DEAL::Estimate 0.236647 +DEAL:cg::Convergence step 13 value 3.08737e-13 +DEAL::energy-error: 0.0863235 +DEAL::L2-error: 0.000292807 +DEAL::Estimate 0.232279 diff --git a/tests/multigrid/transfer_01.cc b/tests/multigrid/transfer_01.cc index a4f980b975..21720e47d8 100644 --- a/tests/multigrid/transfer_01.cc +++ b/tests/multigrid/transfer_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -60,7 +60,7 @@ void check_simple(const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); diff --git a/tests/multigrid/transfer_02.cc b/tests/multigrid/transfer_02.cc index fa451388b9..1e03bc08f3 100644 --- a/tests/multigrid/transfer_02.cc +++ b/tests/multigrid/transfer_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -89,7 +89,7 @@ void check_simple(const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); refine_mesh(tr); refine_mesh(tr); diff --git a/tests/multigrid/transfer_04.cc b/tests/multigrid/transfer_04.cc index cdfd22b820..055d9bdbc2 100644 --- a/tests/multigrid/transfer_04.cc +++ b/tests/multigrid/transfer_04.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2006 - 2015 by the deal.II authors +// Copyright (C) 2006 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -94,7 +94,7 @@ void check_fe(FiniteElement &fe) deallog << fe.get_name() << std::endl; parallel::distributed::Triangulation tr(MPI_COMM_WORLD, - Triangulation::none, + Triangulation::limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); setup_tria(tr); diff --git a/tests/multigrid/transfer_04a.cc b/tests/multigrid/transfer_04a.cc index ee4f830a9e..ae960c893a 100644 --- a/tests/multigrid/transfer_04a.cc +++ b/tests/multigrid/transfer_04a.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2006 - 2015 by the deal.II authors +// Copyright (C) 2006 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -93,7 +93,7 @@ void check_fe(FiniteElement &fe) deallog << fe.get_name() << std::endl; parallel::distributed::Triangulation tr(MPI_COMM_WORLD, - Triangulation::none, + Triangulation::limit_level_difference_at_vertices, parallel::distributed::Triangulation::construct_multigrid_hierarchy); setup_tria(tr); diff --git a/tests/multigrid/transfer_block.cc b/tests/multigrid/transfer_block.cc index 36cf2562e8..dffbae0d25 100644 --- a/tests/multigrid/transfer_block.cc +++ b/tests/multigrid/transfer_block.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -91,7 +91,7 @@ void check_block(const FiniteElement &fe, deallog << ' ' << i; deallog << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); diff --git a/tests/multigrid/transfer_block_select.cc b/tests/multigrid/transfer_block_select.cc index 9c1a02f24e..75cc7427fd 100644 --- a/tests/multigrid/transfer_block_select.cc +++ b/tests/multigrid/transfer_block_select.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -77,7 +77,7 @@ void check_select(const FiniteElement &fe, unsigned int selected) deallog << fe.get_name() << " select " << selected << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); diff --git a/tests/multigrid/transfer_compare_01.cc b/tests/multigrid/transfer_compare_01.cc index 60d6b8b6f1..46970ad3ad 100644 --- a/tests/multigrid/transfer_compare_01.cc +++ b/tests/multigrid/transfer_compare_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -123,7 +123,7 @@ void check_block(const FiniteElement &fe) deallog << fe.get_name() << std::endl; std::vector selected(fe.n_blocks(), true); - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); diff --git a/tests/multigrid/transfer_prebuilt_01.cc b/tests/multigrid/transfer_prebuilt_01.cc index 10df422dbf..e6ead2cf6f 100644 --- a/tests/multigrid/transfer_prebuilt_01.cc +++ b/tests/multigrid/transfer_prebuilt_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -45,7 +45,7 @@ void check_simple(const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(1); tr.begin_active()->set_refine_flag(); diff --git a/tests/multigrid/transfer_prebuilt_02.cc b/tests/multigrid/transfer_prebuilt_02.cc index 37b18869fd..e16f840aef 100644 --- a/tests/multigrid/transfer_prebuilt_02.cc +++ b/tests/multigrid/transfer_prebuilt_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -46,7 +46,7 @@ void check_simple(const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(1); tr.begin_active()->set_refine_flag(); diff --git a/tests/multigrid/transfer_prebuilt_03.cc b/tests/multigrid/transfer_prebuilt_03.cc index d533a99c1d..56011f1aea 100644 --- a/tests/multigrid/transfer_prebuilt_03.cc +++ b/tests/multigrid/transfer_prebuilt_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -47,7 +47,7 @@ void check_simple(const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(1); tr.begin_active()->set_refine_flag(); diff --git a/tests/multigrid/transfer_select.cc b/tests/multigrid/transfer_select.cc index fc3586ef31..6563e1611d 100644 --- a/tests/multigrid/transfer_select.cc +++ b/tests/multigrid/transfer_select.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -50,7 +50,7 @@ void check_select(const FiniteElement &fe, << " (global) and " << mg_selected << " (mg)" << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); diff --git a/tests/multigrid/transfer_system_01.cc b/tests/multigrid/transfer_system_01.cc index f8cb7fc65b..04b959abc1 100644 --- a/tests/multigrid/transfer_system_01.cc +++ b/tests/multigrid/transfer_system_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -90,7 +90,7 @@ void check (const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); diff --git a/tests/multigrid/transfer_system_02.cc b/tests/multigrid/transfer_system_02.cc index 8e00bd955d..149f97ad2a 100644 --- a/tests/multigrid/transfer_system_02.cc +++ b/tests/multigrid/transfer_system_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -91,7 +91,7 @@ void check (const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); diff --git a/tests/multigrid/transfer_system_03.cc b/tests/multigrid/transfer_system_03.cc index e1b35e07dd..2e027bc1ca 100644 --- a/tests/multigrid/transfer_system_03.cc +++ b/tests/multigrid/transfer_system_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -91,7 +91,7 @@ void check (const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); diff --git a/tests/multigrid/transfer_system_04.cc b/tests/multigrid/transfer_system_04.cc index f79a5d88de..cf0d6af4f6 100644 --- a/tests/multigrid/transfer_system_04.cc +++ b/tests/multigrid/transfer_system_04.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -91,7 +91,7 @@ void check (const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); diff --git a/tests/multigrid/transfer_system_05.cc b/tests/multigrid/transfer_system_05.cc index 71e4b2955b..c87eb0cbb8 100644 --- a/tests/multigrid/transfer_system_05.cc +++ b/tests/multigrid/transfer_system_05.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -44,7 +44,7 @@ void check (const FiniteElement &fe, const unsigned int selected_block) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); GridGenerator::hyper_cube(tr); tr.refine_global(2); diff --git a/tests/multigrid/transfer_system_adaptive_01.cc b/tests/multigrid/transfer_system_adaptive_01.cc index 3e1a0400e8..8a667b1f4b 100644 --- a/tests/multigrid/transfer_system_adaptive_01.cc +++ b/tests/multigrid/transfer_system_adaptive_01.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -117,7 +117,7 @@ void check (const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); std::vector subdivisions (dim, 1); subdivisions[0] = 2; diff --git a/tests/multigrid/transfer_system_adaptive_02.cc b/tests/multigrid/transfer_system_adaptive_02.cc index f16f59e471..f9d920ac12 100644 --- a/tests/multigrid/transfer_system_adaptive_02.cc +++ b/tests/multigrid/transfer_system_adaptive_02.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -117,7 +117,7 @@ void check (const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); std::vector subdivisions (dim, 1); subdivisions[0] = 2; diff --git a/tests/multigrid/transfer_system_adaptive_03.cc b/tests/multigrid/transfer_system_adaptive_03.cc index 447f220b6a..1a33ab8b95 100644 --- a/tests/multigrid/transfer_system_adaptive_03.cc +++ b/tests/multigrid/transfer_system_adaptive_03.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -118,7 +118,7 @@ void check (const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); std::vector subdivisions (dim, 1); subdivisions[0] = 2; diff --git a/tests/multigrid/transfer_system_adaptive_04.cc b/tests/multigrid/transfer_system_adaptive_04.cc index d20ef1ddd8..ed78526c35 100644 --- a/tests/multigrid/transfer_system_adaptive_04.cc +++ b/tests/multigrid/transfer_system_adaptive_04.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -117,7 +117,7 @@ void check (const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); std::vector subdivisions (dim, 1); subdivisions[0] = 2; diff --git a/tests/multigrid/transfer_system_adaptive_05.cc b/tests/multigrid/transfer_system_adaptive_05.cc index c52e319586..ab5d52109e 100644 --- a/tests/multigrid/transfer_system_adaptive_05.cc +++ b/tests/multigrid/transfer_system_adaptive_05.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -118,7 +118,7 @@ void check (const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); std::vector subdivisions (dim, 1); subdivisions[0] = 2; diff --git a/tests/multigrid/transfer_system_adaptive_06.cc b/tests/multigrid/transfer_system_adaptive_06.cc index 9f77c0d8bd..df006f786b 100644 --- a/tests/multigrid/transfer_system_adaptive_06.cc +++ b/tests/multigrid/transfer_system_adaptive_06.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -117,7 +117,7 @@ void check (const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); std::vector subdivisions (dim, 1); subdivisions[0] = 2; diff --git a/tests/multigrid/transfer_system_adaptive_07.cc b/tests/multigrid/transfer_system_adaptive_07.cc index 042788f243..46df3a16a9 100644 --- a/tests/multigrid/transfer_system_adaptive_07.cc +++ b/tests/multigrid/transfer_system_adaptive_07.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -119,7 +119,7 @@ void check (const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); std::vector subdivisions (dim, 1); subdivisions[0] = 2; diff --git a/tests/multigrid/transfer_system_adaptive_08.cc b/tests/multigrid/transfer_system_adaptive_08.cc index 270e5cb74d..ed00bd0b86 100644 --- a/tests/multigrid/transfer_system_adaptive_08.cc +++ b/tests/multigrid/transfer_system_adaptive_08.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -118,7 +118,7 @@ void check (const FiniteElement &fe) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); std::vector subdivisions (dim, 1); subdivisions[0] = 2; diff --git a/tests/multigrid/transfer_system_adaptive_09.cc b/tests/multigrid/transfer_system_adaptive_09.cc index 6d7cfaf43d..ba794e42a3 100644 --- a/tests/multigrid/transfer_system_adaptive_09.cc +++ b/tests/multigrid/transfer_system_adaptive_09.cc @@ -1,6 +1,6 @@ // --------------------------------------------------------------------- // -// Copyright (C) 2000 - 2015 by the deal.II authors +// Copyright (C) 2000 - 2016 by the deal.II authors // // This file is part of the deal.II library. // @@ -71,7 +71,7 @@ void check (const FiniteElement &fe, const unsigned int selected_block) { deallog << fe.get_name() << std::endl; - Triangulation tr; + Triangulation tr(Triangulation::limit_level_difference_at_vertices); std::vector subdivisions (dim, 1); subdivisions[0] = 2; -- 2.39.5