]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix tests
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Mon, 5 Sep 2016 17:22:48 +0000 (19:22 +0200)
committerDaniel Arndt <d.arndt@math.uni-goettingen.de>
Mon, 5 Sep 2016 20:28:55 +0000 (22:28 +0200)
82 files changed:
tests/bits/step-16.cc
tests/dofs/block_info.cc
tests/dofs/block_info_02.cc
tests/dofs/block_list.h
tests/dofs/block_list_05.cc
tests/dofs/dof_renumbering.cc
tests/dofs/dof_renumbering_02.cc
tests/dofs/dof_renumbering_07.cc
tests/dofs/dof_renumbering_08.cc
tests/dofs/extract_dofs_by_component_01_mg.cc
tests/dofs/extract_dofs_by_component_02_mg.cc
tests/fe/transfer.cc
tests/integrators/assembler_simple_mgmatrix_03.cc
tests/integrators/assembler_simple_mgmatrix_04.cc
tests/integrators/cells_and_faces_01.cc
tests/integrators/functional_01.cc
tests/integrators/mesh_worker_01.cc
tests/integrators/mesh_worker_02.cc
tests/integrators/mesh_worker_03.cc
tests/matrix_free/matrix_vector_mg.cc
tests/matrix_free/parallel_multigrid.cc
tests/matrix_free/parallel_multigrid_adaptive.cc
tests/matrix_free/parallel_multigrid_adaptive_mf.cc
tests/matrix_free/parallel_multigrid_mf.cc
tests/matrix_free/step-37.cc
tests/mpi/mg_02.cc
tests/mpi/mg_03.cc
tests/mpi/mg_04.cc
tests/mpi/mg_05.cc
tests/mpi/mg_06.cc
tests/mpi/mg_ghost_dofs_periodic_01.cc
tests/mpi/mg_ghost_dofs_periodic_02.cc
tests/mpi/mg_ghost_dofs_periodic_03.cc
tests/mpi/mg_ghost_dofs_periodic_04.cc
tests/multigrid/boundary_01.cc
tests/multigrid/constrained_dofs_01.cc
tests/multigrid/constrained_dofs_02.cc
tests/multigrid/constrained_dofs_03.cc
tests/multigrid/count_01.cc
tests/multigrid/distribute_bug_01.cc
tests/multigrid/dof_01.cc
tests/multigrid/dof_02.cc
tests/multigrid/dof_03.cc
tests/multigrid/dof_04.cc
tests/multigrid/dof_05.cc
tests/multigrid/renumbering_01.cc
tests/multigrid/renumbering_02.cc
tests/multigrid/renumbering_03.cc
tests/multigrid/renumbering_04.cc
tests/multigrid/step-39-02.cc
tests/multigrid/step-39-02.output
tests/multigrid/step-39-02a.cc
tests/multigrid/step-39-02a.output
tests/multigrid/step-39-03.cc
tests/multigrid/step-39-03.output
tests/multigrid/step-39.cc
tests/multigrid/step-39.output
tests/multigrid/transfer_01.cc
tests/multigrid/transfer_02.cc
tests/multigrid/transfer_04.cc
tests/multigrid/transfer_04a.cc
tests/multigrid/transfer_block.cc
tests/multigrid/transfer_block_select.cc
tests/multigrid/transfer_compare_01.cc
tests/multigrid/transfer_prebuilt_01.cc
tests/multigrid/transfer_prebuilt_02.cc
tests/multigrid/transfer_prebuilt_03.cc
tests/multigrid/transfer_select.cc
tests/multigrid/transfer_system_01.cc
tests/multigrid/transfer_system_02.cc
tests/multigrid/transfer_system_03.cc
tests/multigrid/transfer_system_04.cc
tests/multigrid/transfer_system_05.cc
tests/multigrid/transfer_system_adaptive_01.cc
tests/multigrid/transfer_system_adaptive_02.cc
tests/multigrid/transfer_system_adaptive_03.cc
tests/multigrid/transfer_system_adaptive_04.cc
tests/multigrid/transfer_system_adaptive_05.cc
tests/multigrid/transfer_system_adaptive_06.cc
tests/multigrid/transfer_system_adaptive_07.cc
tests/multigrid/transfer_system_adaptive_08.cc
tests/multigrid/transfer_system_adaptive_09.cc

index 63adbc035ec536a091036d37575a6c016691aca7..8e812073eebd1fca46b91bc6d9b3cacc8a218cec 100644 (file)
@@ -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 <int dim>
 LaplaceProblem<dim>::LaplaceProblem () :
+  triangulation(limit_level_difference_at_vertices),
   fe (1),
   mg_dof_handler (triangulation)
 {}
index 51bafaae6142fc432b2dfafe0fffd3e9ce3c2dbe..42e288e61b26be63732986ea08552cbcd4ae13e8 100644 (file)
@@ -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<dim> &tr,
 template<int dim>
 void test_fe (const FiniteElement<dim> &fe)
 {
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(5-dim);
   test_grid(tr, fe);
index b74fa7b9db5a1e874c19ce59c5e327f72476d914..11bd1f38dd90d6d6cd79a566da431c72f414c894 100644 (file)
@@ -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<dim> &tr,
 template<int dim>
 void test_fe (const FiniteElement<dim> &fe)
 {
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(5-dim);
   test_grid(tr, fe);
index 594fabbf355ed3f17b5345e483119dc0c456de26..49df30ce34b57ae85322fea96ddab446fb290eb5 100644 (file)
@@ -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<TR::dimension> &fe))
 {
   const unsigned int dim=TR::dimension;
-  TR trc, trl;
+  TR trc(Triangulation<dim>::limit_level_difference_at_vertices);
+  TR trl(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(trc);
   trc.refine_global(2);
   GridGenerator::hyper_L(trl);
index a4d1d698a16fa22985e0b3c165dd06b8c7fc45a7..363a88ac9790387458c644824977336db85d296f 100644 (file)
@@ -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 <int dim>
 void test_global_refinement(
   void (*test_block_list)(const Triangulation<dim> &tr, const FiniteElement<dim> &fe))
 {
-  Triangulation<dim> trc, trl;
+  Triangulation<dim> trc(Triangulation<dim>::limit_level_difference_at_vertices);
+  Triangulation<dim> trl(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(trc);
   trc.refine_global(2);
   GridGenerator::hyper_L(trl);
index 0eb632f4a7d51ca746847576825c72699e5309b5..6ab13b4d0d63112d7e846ca84edf69b9ee218cc0 100644 (file)
@@ -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 <int dim>
 void
 check ()
 {
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   if (dim==2)
     GridGenerator::hyper_ball(tr, Point<dim>(), 1);
   else
index 6ad723b75b258ab352bc16a5e86752d6ad08b28d..49d923c7949a3818622465b15e5ab3d98de37ec0 100644 (file)
@@ -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 <int dim>
 void
 check ()
 {
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr, -1., 1.);
   tr.refine_global (1);
   tr.begin_active()->set_refine_flag ();
index d85d22e7e9f27dddfaaa814422a83c7dc29693ec..280c88a5e8dc70e0627cd02c57463028108d5094 100644 (file)
@@ -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 <int dim>
 void
 check ()
 {
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr, -1., 1.);
   tr.refine_global (1);
   tr.begin_active()->set_refine_flag ();
index 94c8b709c5c058ede516d6407c8dfc67e3350654..95b2194920a8ec0b8dff37ed851c7cb184f6a54c 100644 (file)
@@ -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 <int dim>
 void
 check ()
 {
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr, -1., 1.);
   tr.refine_global (1);
   tr.begin_active()->set_refine_flag ();
index 980d09ffa0a52b31205ff5a86977e7385ed68a00..2496a6820d76518bb13f97d42d4647fd8cb5dc02 100644 (file)
@@ -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 <int dim>
 void
 check ()
 {
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>:: limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr, -1,1);
   tr.refine_global (1);
   tr.begin_active()->set_refine_flag();
index 277522ff5722ae1365a05d3bbbe78cd64fc5cc34..28d4b06b00ae255ef29f2f4b51870bdc7cf482ba 100644 (file)
@@ -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 <int dim>
 void
 check ()
 {
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>:: limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr, -1,1);
   tr.refine_global (1);
   tr.begin_active()->set_refine_flag();
index 9b30b01d7bd447798a42484660097a2586cc5dce..ab3e70df15c59c6d7efa537fc2df77115920331c 100644 (file)
@@ -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);
index cb6ca1d9db97111ac814f1650257fc5d682de399..172e67d6cf6ec88a3d9083a113ce2dde77593721 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>:: limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(1);
 
index ab23a6efc3e37291b812e7cec6a765914ea7c9a6..9c2624ce9d65fd652308ef131b964ac5dd070196 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>:: limit_level_difference_at_vertices);
   std::vector<unsigned int> repititions (dim, 1);
   repititions[0] = 2;
   const Point<dim> p1 = (dim == 1 ? Point<dim> (-1.) : (dim == 2 ? Point<dim>(-1.,-1.) : Point<dim> (-1.,-1.,-1.)));
index f648a168fa4dba8279e450f49ae568aa13fb4b91..412793fa7aa175f3cde122799ef401dcda53c06b 100644 (file)
@@ -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<int dim>
 void
 test(const FiniteElement<dim> &fe)
 {
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   DoFHandler<dim> dofs(tr);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(1);
index ecd6f34d5737d580133844389a46a91b1dec8614..3b8a6592d82bb5bb434f97d971bd47619031b12f 100644 (file)
@@ -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<int dim>
 void
 test(const FiniteElement<dim> &fe)
 {
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   DoFHandler<dim> dofs(tr);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(1);
index e2e4846849ffc4e1f32bb3c73e0f2f712459cb0c..117c36160500740fae9489316d3b96565bfb68be 100644 (file)
@@ -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<int dim>
 void
 test(const FiniteElement<dim> &fe)
 {
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(1);
   tr.begin(1)->set_refine_flag();
index 0ef5716b84831c1ff29a68d760c832bcc3192e2e..e647a463493379744a9faba143848377f59d0db9 100644 (file)
@@ -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<int dim>
 void
 test(const FiniteElement<dim> &fe)
 {
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_L(tr);
   tr.begin()->set_refine_flag();
   tr.execute_coarsening_and_refinement();
index 0f40de6ba27c2ab679edfd2b99ae51ba7dd017bc..249ea2ace6bfffb04c6639b278f2374a4d00f7e0 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_L(tr);
   tr.begin()->set_refine_flag();
   tr.execute_coarsening_and_refinement();
index 1f84da8844d4fbcecffe7b4953a72af7f6f8ebe4..57341791a60288f2b8b8efa090683e90958873a2 100644 (file)
@@ -35,7 +35,7 @@ template <int dim, int fe_degree>
 void test ()
 {
   const SphericalManifold<dim> manifold;
-  Triangulation<dim> tria;
+  Triangulation<dim> tria(Triangulation<dim>:: limit_level_difference_at_vertices);
   GridGenerator::hyper_ball (tria);
   typename Triangulation<dim>::active_cell_iterator
   cell = tria.begin_active (),
index 56a50999345171a73d7234a80a773aa76775c0ba..238c87db0617a6bd5c71961cdc2dd690de3cdb7e 100644 (file)
@@ -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<dim> tria(MPI_COMM_WORLD,
-                                                     dealii::Triangulation<dim>::none,parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
+                                                     Triangulation<dim>::limit_level_difference_at_vertices,
+                                                     parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
       GridGenerator::hyper_cube (tria);
       tria.refine_global(i-dim);
 
index b134b460b5fcf386d7995820d2153566dc404990..0de815ad43f6182ddbd8762eb58907040389abf7 100644 (file)
@@ -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 <int dim, int fe_degree>
 void test ()
 {
   parallel::distributed::Triangulation<dim> tria(MPI_COMM_WORLD,
-                                                 dealii::Triangulation<dim>::none,parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
+                                                 Triangulation<dim>::limit_level_difference_at_vertices,
+                                                 parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
   GridGenerator::hyper_cube (tria);
   tria.refine_global(6-dim);
   const unsigned int n_runs = fe_degree == 1 ? 6-dim : 5-dim;
index bcd35df53dd61582e825a12e303b21395c1bb083..746302e2072a443fd5f4cb3106cae31c59aa9e75 100644 (file)
@@ -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 <int dim, int fe_degree, typename Number>
 void test ()
 {
   parallel::distributed::Triangulation<dim> tria(MPI_COMM_WORLD,
-                                                 dealii::Triangulation<dim>::none,parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
+                                                 Triangulation<dim>::limit_level_difference_at_vertices,
+                                                 parallel::distributed::Triangulation<dim>::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;
index 5ff611f1cf685000a89e174d9d46e2ed1371fea1..3a81c512f40f0a61a83b8b30b67693518d484ae5 100644 (file)
@@ -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<dim> tria(MPI_COMM_WORLD,
-                                                     dealii::Triangulation<dim>::none,parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
+                                                     Triangulation<dim>::limit_level_difference_at_vertices,
+                                                     parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
       GridGenerator::hyper_cube (tria);
       tria.refine_global(i-dim);
 
index eddfcfbf3795fe93f8f46982034d6eff1e7ae964..14347b08fcd710424e2b9569476732434d37208c 100644 (file)
@@ -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 <int dim>
   LaplaceProblem<dim>::LaplaceProblem ()
     :
+    triangulation (Triangulation<dim>::limit_level_difference_at_vertices),
     fe (degree_finite_element),
     dof_handler (triangulation)
   {}
index e9f21d363ad9f1f02f7c86854a5e66c59978ed11..a3385c9b3feb70f82334d0c84f14f8d22509a919 100644 (file)
@@ -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<dim> tr(MPI_COMM_WORLD,
-                                               Triangulation<dim>::none,
+                                               Triangulation<dim>:: limit_level_difference_at_vertices,
                                                parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
 
   GridGenerator::hyper_cube(tr);
index 93edccb637691506a338dcfa571b74568b88ca63..80b6f2b99733cedc41b2672372370449125e33cf 100644 (file)
@@ -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<dim> tr(MPI_COMM_WORLD,
-                                               Triangulation<dim>::none,
+                                               Triangulation<dim>:: limit_level_difference_at_vertices,
                                                parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
 
   GridGenerator::hyper_cube(tr);
index 47785f1c945e5871f2a6602a8368edd51456605c..df2f558c267c2e0cd2023da9f33f78b37ebcb3d1 100644 (file)
@@ -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<dim> tr(MPI_COMM_WORLD,
-                                               Triangulation<dim>::none,
+                                               Triangulation<dim>:: limit_level_difference_at_vertices,
                                                parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(2);
index 1133fdf1d91d6008a696a94a2dcd20bcdb0535a8..b511f2cc91ef8b2033a3d5b45819258d303b1c18 100644 (file)
@@ -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<dim> tr(MPI_COMM_WORLD,
-                                               Triangulation<dim>::none,
+                                               Triangulation<dim>:: limit_level_difference_at_vertices,
                                                parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(3);
index 272b96560f19febd144a1d2f8d1cb56593364a3b..3b8006362bd675c408a0f397671f890a97819fa3 100644 (file)
@@ -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<dim> tr(MPI_COMM_WORLD,
-                                               Triangulation<dim>::none,
+                                               Triangulation<dim>:: limit_level_difference_at_vertices,
                                                parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
   GridGenerator::hyper_cube_slit(tr,-1,1);
   tr.refine_global(2);
index 257040a8b551a9d9539091decdabde167a93b6c6..00d9a2d350f17c809ae0591bdc61e681007ab2b2 100644 (file)
@@ -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 <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tria(MPI_COMM_WORLD,
-                                                 Triangulation<dim>::none,
+                                                 Triangulation<dim>:: limit_level_difference_at_vertices,
                                                  parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
   std::vector<unsigned int> subdivisions(dim);
   Point<dim> p1, p2;
index ac5fcee52e6b33e9976bccd6eb53309720384d6d..1a29d568de4f7172f8e4fffc05db7bafd2d4d7b4 100644 (file)
@@ -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<dim> tria(MPI_COMM_WORLD,
-                                                 Triangulation<dim>::none,
+                                                 Triangulation<dim>:: limit_level_difference_at_vertices,
                                                  parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
   GridGenerator::hyper_cube(tria, 0, 1);
   for (unsigned int face=2; face<GeometryInfo<dim>::faces_per_cell; ++face)
index 589c3364a836af844d12a6811e302032d82be31a..d536442dd513ef796ddfd3a160028a6fd43d3610 100644 (file)
@@ -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<dim> tria(MPI_COMM_WORLD,
-                                                 Triangulation<dim>::none,
+                                                 Triangulation<dim>:: limit_level_difference_at_vertices,
                                                  parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
   for (unsigned int run=0; run<2; ++run)
     {
index d5f4c6e0d48f7af7b412af221d2159e2635bea78..096f16c6e3b97133ebc119e9a35ab8e22d95b520 100644 (file)
@@ -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 <int dim>
 void test()
 {
   parallel::distributed::Triangulation<dim> tria(MPI_COMM_WORLD,
-                                                 Triangulation<dim>::none,
+                                                 Triangulation<dim>:: limit_level_difference_at_vertices,
                                                  parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
   std::vector<unsigned int> subdivisions(dim);
   Point<dim> p1, p2;
index c2ac00d4783f55ee93ae425cddc0a334e2307f4c..7b5b4822829d02a8eee01d7459a86e41827021f0 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(2);
   ZeroFunction<dim> zero;
index 062d4be507b26c86e23cb74d072e97753ca372b1..f06b9f5f47dfd45121353b8e3007fe6228d88cd4 100644 (file)
@@ -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<dim> &fe)
   deallog << fe.get_name() << std::endl;
 
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD,
-                                               Triangulation<dim>::none,
+                                               Triangulation<dim>::limit_level_difference_at_vertices,
                                                parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
   setup_tria(tr);
 
@@ -79,7 +79,7 @@ void check_fe(FiniteElement<dim> &fe)
   {
     // reorder
     parallel::distributed::Triangulation<dim> tr(MPI_COMM_SELF,
-                                                 Triangulation<dim>::none,
+                                                 Triangulation<dim>::limit_level_difference_at_vertices,
                                                  parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
     setup_tria(tr);
 
index 87777538c11bb85de6fb0528fa97b0be8b92f995..023b07d657a3b3eef361d038b2158817b7e94486 100644 (file)
@@ -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<dim> &fe)
   deallog << fe.get_name() << std::endl;
 
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD,
-                                               Triangulation<dim>::none,
+                                               Triangulation<dim>::limit_level_difference_at_vertices,
                                                parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
   setup_tria(tr);
 
@@ -135,7 +135,7 @@ void check_fe(FiniteElement<dim> &fe)
   {
     // reorder
     parallel::distributed::Triangulation<dim> tr(MPI_COMM_SELF,
-                                                 Triangulation<dim>::none,
+                                                 Triangulation<dim>::limit_level_difference_at_vertices,
                                                  parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
     setup_tria(tr);
 
index 4ce74154d83fad1ac10670b6745b28750b51cc25..31e0784658357fb66eba18ef42cb1523c01af7ca 100644 (file)
@@ -47,7 +47,7 @@ void check_fe(FiniteElement<dim> &fe, ComponentMask &component_mask)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(1);
 
index b89511b601a381017d5c3bca61be17ff0f763fd1..7a3071181991715a2ee9634b52fd3336fb677877 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(1);
   tr.begin_active()->set_refine_flag();
index 47c0323de6f97d40411daab97d2b7eb53e2e3f42..5417e2406a3de3188f0d042e7226f68930b26fab 100644 (file)
@@ -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<dim> triangulation
   (MPI_COMM_WORLD,
-   Triangulation<dim>::none,
+   Triangulation<dim>::limit_level_difference_at_vertices,
    parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
 
   GridGenerator::subdivided_hyper_cube (triangulation, 1, -1, 1);
index 1cc4916d7f0872b8c3307f0af6c75ffb64ad6fdf..eba0b46587aca05be1be38b6f36d6be4147970c8 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(2);
   ZeroFunction<dim> zero;
index dabbaad16b8980eefaf3f76e80610d5c497f6cac..991b47638dc9b4394fafa57d8f893b2f6c616212 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(2);
   ZeroFunction<dim> zero;
index 19f4e0350786561fa3c0fd1d1c286c1376348ca7..b3aa930f32d0010b91da59c21dcde5e08f543cef 100644 (file)
@@ -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<dim> fe(1);
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(1);
 
index d6eb7b11f082569d0025f1c9d956e3c991b27a6a..2f1b50d1f1f71341b9f8b5fd8f71d2d1021a7cbe 100644 (file)
@@ -32,7 +32,7 @@ void check()
   // need cubic polynomials that have two dofs on lines
   FE_Q<dim> fe(3);
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   if (dim > 1)
     GridGenerator::hyper_shell(tr, Point<dim>(), 0.5, 1, 12);
   else
index 86e2a217781341073763180660eee29574362152..7e88eabf6337e378a2a1ab7669d5d6272e3e0f63 100644 (file)
@@ -32,7 +32,7 @@ void check()
   // need cubic polynomials that have two dofs on lines
   FE_Q<dim> fe(3);
 
-  parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD, Triangulation<dim>::none,
+  parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD, Triangulation<dim>::limit_level_difference_at_vertices,
                                                parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
   GridGenerator::hyper_shell(tr, Point<dim>(), 0.5, 1, 12);
   tr.refine_global(1);
index 4b816b1a2ec1720d8038c290b27302cd0496c87b..e53fe90e344734361d8b77e56f7362e30aa8d14c 100644 (file)
@@ -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<dim> fe(FE_DGP<dim>(1), 1, FE_DGQ<dim>(2), 2, FE_Q<dim>(3), 1);
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(1);
   tr.begin_active()->set_refine_flag();
index 85ff9bbeb3e282caceaa3478de441eb9d6fa17f9..224cefe188858c2e20421197c88a09f4fc502c47 100644 (file)
@@ -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<dim> fe(1);
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tria;
+  Triangulation<dim> tria(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tria);
   tria.refine_global(2);
   typename Triangulation<dim>::active_cell_iterator cell=tria.begin_active();
index 048c5afc53f8fb96611507e3e1d1cf9b23f95be3..04e363ed659ad516fb4a9acb1406557242f29c1d 100644 (file)
@@ -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<dim> fe(3);
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tria;
+  Triangulation<dim> tria(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tria);
   tria.refine_global(2);
   typename Triangulation<dim>::active_cell_iterator cell=tria.begin_active();
index 50f7b2827c84ded50f3438cf02270117cc794155..cccc6265585c3dd903d0f11fd39890e4215c556a 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << std::endl << "**** " << fe.get_name() << std::endl;
 
-  Triangulation<dim> tria;
+  Triangulation<dim> tria(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tria);
   tria.refine_global(1);
   tria.begin_active()->set_refine_flag();
index 2dd1e8fd5bb37ea1c41c2a0ffde63dad3605570f..a2ea0a8d3111e131ac5758eb6805a0a7a5f4f518 100644 (file)
@@ -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 <int dim>
   InteriorPenaltyProblem<dim>::InteriorPenaltyProblem(const FiniteElement<dim> &fe)
     :
+    triangulation(Triangulation<dim>::limit_level_difference_at_vertices),
     mapping(1),
     fe(fe),
     dof_handler(triangulation),
index 0af72150d352dfecd03a5328608d331d173b7179..7b8335ea4cbe7b6021a867b2f9e2e8b70a200220 100644 (file)
@@ -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
index b3847ebb8bc4cdf23312f9fa27bfdcf5fff968c1..6d06e84545386486f16c4fc8eff0584a5106c1e2 100644 (file)
@@ -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 <int dim>
   InteriorPenaltyProblem<dim>::InteriorPenaltyProblem(const FiniteElement<dim> &fe)
     :
+    triangulation(Triangulation<dim>::limit_level_difference_at_vertices),
     mapping(1),
     fe(fe),
     dof_handler(triangulation),
index 0af72150d352dfecd03a5328608d331d173b7179..7b8335ea4cbe7b6021a867b2f9e2e8b70a200220 100644 (file)
@@ -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
index e486418a21ece8e4bcfede9453b3ab8433823a8c..f082fb49dffa4f1cfd430118fcb149b741514c73 100644 (file)
@@ -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 <int dim>
   InteriorPenaltyProblem<dim>::InteriorPenaltyProblem(const FiniteElement<dim> &fe)
     :
+    triangulation(Triangulation<dim>::limit_level_difference_at_vertices),
     mapping(1),
     fe(fe),
     dof_handler(triangulation),
index fe82684886dd0005b2c1c87d247eb319b1fa6b1d..002798281bd7041aa97b1a9aac1cc70982112b5e 100644 (file)
@@ -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 <sol-02.gnuplot>...
 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 <sol-03.gnuplot>...
 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 <sol-04.gnuplot>...
 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 <sol-05.gnuplot>...
 DEAL::
index 093240d7172d49785e170e29b4f9400c686aa3ca..07d6afa24767e65f043f9aa0e63623bfb970c254 100644 (file)
@@ -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 <int dim>
   InteriorPenaltyProblem<dim>::InteriorPenaltyProblem(const FiniteElement<dim> &fe)
     :
+    triangulation(Triangulation<dim>::limit_level_difference_at_vertices),
     mapping(1),
     fe(fe),
     dof_handler(triangulation),
index 0af72150d352dfecd03a5328608d331d173b7179..7b8335ea4cbe7b6021a867b2f9e2e8b70a200220 100644 (file)
@@ -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
index a4f980b975686cf4527e69b2d35dc0ac272e6d54..21720e47d88d13ed5590ddff2562b61e3a11467d 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(2);
 
index fa451388b9c85dcb607efb93ed11cd9293a97935..1e03bc08f3899a6f927c20dc71cba2523fdc22b5 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   refine_mesh(tr);
   refine_mesh(tr);
index cdfd22b820c445590ce22f3cf8b8eef0577a80b2..055d9bdbc2353e382baeb971091959aa1ef6a554 100644 (file)
@@ -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<dim> &fe)
   deallog << fe.get_name() << std::endl;
 
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD,
-                                               Triangulation<dim>::none,
+                                               Triangulation<dim>::limit_level_difference_at_vertices,
                                                parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
   setup_tria(tr);
 
index ee4f830a9eb76ff5faa16fe48cf546876f02e7c5..ae960c893abaeccfc68ff423c3da36a25946a6a4 100644 (file)
@@ -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<dim> &fe)
   deallog << fe.get_name() << std::endl;
 
   parallel::distributed::Triangulation<dim> tr(MPI_COMM_WORLD,
-                                               Triangulation<dim>::none,
+                                               Triangulation<dim>::limit_level_difference_at_vertices,
                                                parallel::distributed::Triangulation<dim>::construct_multigrid_hierarchy);
   setup_tria(tr);
 
index 36cf2562e80637fd9d97dc73b73d5983284351fc..dffbae0d25548282d7fce05a998ed72a41c325cc 100644 (file)
@@ -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<dim> &fe,
       deallog << ' ' << i;
   deallog << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(2);
 
index 9c1a02f24e04561a5a766017db5a74be75789df4..75cc7427fdb1341983ed983c833e5118f3415c85 100644 (file)
@@ -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<dim> &fe, unsigned int selected)
   deallog << fe.get_name()
           << " select " << selected << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(2);
 
index 60d6b8b6f18585d55722c84a57af05e9ef4f4fee..46970ad3adced774c78379b1e695f5697f63da08 100644 (file)
@@ -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<dim> &fe)
   deallog << fe.get_name() << std::endl;
   std::vector<bool> selected(fe.n_blocks(), true);
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(2);
 
index 10df422dbf8dc802846d70494836d4326c30bd16..e6ead2cf6f2c502276cdd475bd7d8490b3b1abb7 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(1);
   tr.begin_active()->set_refine_flag();
index 37b18869fd897993f7578a8781b84f67537d082e..e16f840aef7b7dc3c0aaf928a7e3a25d89777247 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(1);
   tr.begin_active()->set_refine_flag();
index d533a99c1d18c2d8fd6291b8e3cdc965a65582f8..56011f1aea38b3b694b7d69fa63027d9e101383e 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(1);
   tr.begin_active()->set_refine_flag();
index fc3586ef3105d8785712a123dcd519411e96be25..6563e1611d064320bbdfc10e509d8959bf2c5282 100644 (file)
@@ -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<dim> &fe,
           << " (global) and " << mg_selected
           << " (mg)" << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(2);
 
index f8cb7fc65b0fb24d2ad0e7f550fa0850e829de4c..04b959abc16b523ba870f0ee705f5adf08c4c7f5 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(2);
 
index 8e00bd955d02de65ca42df0f3d8b5a14c1e7ebe6..149f97ad2ac925fd70db93b347219a79f9eda953 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(2);
 
index e1b35e07ddfa6bad5d8860d587a8fcb121da329a..2e027bc1ca102080ecc7e6e182311b1a24d8e93c 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(2);
 
index f79a5d88dede07b0c0015408f64183550c1c2643..cf0d6af4f6c49ad118286998284431acb03eb282 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(2);
 
index 71e4b2955b3ddce7eeabd94d5c0155308a5d1a21..c87eb0cbb8b8b76466b87b0f6837d304db8abaa8 100644 (file)
@@ -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<dim> &fe, const unsigned int selected_block)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   GridGenerator::hyper_cube(tr);
   tr.refine_global(2);
 
index 3e1a0400e81f082e35a4ff17a5263176098a5d70..8a667b1f4bcf15c980aece732cb94e91f6a05129 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
 
   std::vector<unsigned int> subdivisions (dim, 1);
   subdivisions[0] = 2;
index f16f59e471bf0f60298e1fab2ec9e20e4ec66ded..f9d920ac120b3644688388b7792efda954944c83 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
 
   std::vector<unsigned int> subdivisions (dim, 1);
   subdivisions[0] = 2;
index 447f220b6ad12adb82571930fa77f66ad9b4f076..1a33ab8b9582dd4955b92349cd31f10fac74ec69 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
 
   std::vector<unsigned int> subdivisions (dim, 1);
   subdivisions[0] = 2;
index d20ef1ddd8272869c8e1a47e4a80b4f30a696f33..ed78526c3506b81b0df80260c0377234881ebf96 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
 
   std::vector<unsigned int> subdivisions (dim, 1);
   subdivisions[0] = 2;
index c52e319586e0a41d1a15a4c5e46661f5928d71f6..ab5d52109e6d2e23ebb5e22cc708b2567b336ffb 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
 
   std::vector<unsigned int> subdivisions (dim, 1);
   subdivisions[0] = 2;
index 9f77c0d8bdcaf2ed1fb4d6db25fb01c6a3b6414f..df006f786ba88ca755222009dc386443a80fde7e 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
 
   std::vector<unsigned int> subdivisions (dim, 1);
   subdivisions[0] = 2;
index 042788f2436906da3ce2835264e68f384b8fede3..46df3a16a95c08e6f2b1aa8344784dde908fcc48 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
 
   std::vector<unsigned int> subdivisions (dim, 1);
   subdivisions[0] = 2;
index 270e5cb74d6dea88449c5e8c056c930895f984f7..ed00bd0b8621a8eb07ba07718c5638ab84b6f3c9 100644 (file)
@@ -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<dim> &fe)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
 
   std::vector<unsigned int> subdivisions (dim, 1);
   subdivisions[0] = 2;
index 6d7cfaf43d5f6e88570a6cc29852b66f01d100c1..ba794e42a321bcb2c23964326d5016fddbc9ed0d 100644 (file)
@@ -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<dim> &fe, const unsigned int selected_block)
 {
   deallog << fe.get_name() << std::endl;
 
-  Triangulation<dim> tr;
+  Triangulation<dim> tr(Triangulation<dim>::limit_level_difference_at_vertices);
   std::vector<unsigned int> subdivisions (dim, 1);
   subdivisions[0] = 2;
 

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.