]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Fix test for Hessians on faces with MatrixFree 12742/head
authorMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Sat, 4 Sep 2021 14:26:21 +0000 (16:26 +0200)
committerMartin Kronbichler <kronbichler@lnm.mw.tum.de>
Sat, 4 Sep 2021 14:26:21 +0000 (16:26 +0200)
tests/matrix_free/matrix_vector_hessians_faces.cc
tests/matrix_free/matrix_vector_hessians_faces.output

index 801271e2179dbc081ef1698a1e8cc843bd8ed16c..a465d3f0839fa9d0e71745d65cb9e33dd4c7b762 100644 (file)
@@ -19,6 +19,7 @@
 #include <deal.II/distributed/tria.h>
 
 #include <deal.II/dofs/dof_handler.h>
+#include <deal.II/dofs/dof_tools.h>
 
 #include <deal.II/fe/fe_dgq.h>
 #include <deal.II/fe/fe_q.h>
@@ -52,22 +53,20 @@ test_hessians(const unsigned int                             degree,
 
   Triangulation<dim> tria;
   GridGenerator::hyper_cube(tria);
-  tria.refine_global(3);
+  tria.refine_global(4 - dim);
 
-  // TODO: make Hessians work for adaptive refinement
-
-  //  unsigned int counter = 0;
-  //  for (auto cell = tria.begin_active(); cell != tria.end(); ++cell,
-  //  ++counter)
-  //    if (cell->is_locally_owned() && counter % 3 == 0)
-  //      cell->set_refine_flag();
-  //  tria.execute_coarsening_and_refinement();
+  unsigned int counter = 0;
+  for (auto cell = tria.begin_active(); cell != tria.end(); ++cell, ++counter)
+    if (cell->is_locally_owned() && counter % 3 == 0)
+      cell->set_refine_flag();
+  tria.execute_coarsening_and_refinement();
 
   DoFHandler<dim> dof_handler(tria);
   dof_handler.distribute_dofs(fe);
   MappingQGeneric<dim> mapping(1);
 
   AffineConstraints<double> constraints;
+  DoFTools::make_hanging_node_constraints(dof_handler, constraints);
   VectorTools::interpolate_boundary_values(
     mapping, dof_handler, 0, Functions::ZeroFunction<dim>(), constraints);
   constraints.close();
@@ -95,29 +94,35 @@ test_hessians(const unsigned int                             degree,
   matrix_free.initialize_dof_vector(dst2);
 
   // Setup FEFaceValues
-  QGauss<dim - 1>                      quad(degree + 1);
-  FEFaceValues<dim>                    fe_face_values_m(mapping,
-                                     fe,
-                                     quad,
-                                     update_values | update_gradients |
-                                       update_hessians | update_JxW_values);
-  FEFaceValues<dim>                    fe_face_values_p(mapping,
+  QGauss<dim - 1>             quad(degree + 1);
+  FEFaceValues<dim>           fe_face_values_m(mapping,
                                      fe,
                                      quad,
                                      update_values | update_gradients |
                                        update_hessians | update_JxW_values);
-  Vector<double>                       solution_values_m(fe.dofs_per_cell);
-  Vector<double>                       solution_values_p(fe.dofs_per_cell);
-  std::vector<Tensor<2, dim>>          solution_hessians(quad.size());
-  std::vector<Tensor<1, dim>>          solution_gradients(quad.size());
-  std::vector<double>                  solution_values(quad.size());
+  FEFaceValues<dim>           fe_regface_values_p(mapping,
+                                        fe,
+                                        quad,
+                                        update_values | update_gradients |
+                                          update_hessians | update_JxW_values);
+  FESubfaceValues<dim>        fe_subface_values_p(mapping,
+                                           fe,
+                                           quad,
+                                           update_values | update_gradients |
+                                             update_hessians |
+                                             update_JxW_values);
+  Vector<double>              solution_values_m(fe.dofs_per_cell);
+  Vector<double>              solution_values_p(fe.dofs_per_cell);
+  std::vector<Tensor<2, dim>> solution_hessians(quad.size());
+  std::vector<Tensor<1, dim>> solution_gradients(quad.size());
+  std::vector<double>         solution_values(quad.size());
+
   std::vector<types::global_dof_index> dof_indices_m(fe.dofs_per_cell);
   std::vector<types::global_dof_index> dof_indices_p(fe.dofs_per_cell);
   src.update_ghost_values();
   dst2 = 0;
 
 
-
   matrix_free.template loop<LinearAlgebra::distributed::Vector<double>,
                             LinearAlgebra::distributed::Vector<double>>(
     [&](
@@ -177,8 +182,22 @@ test_hessians(const unsigned int                             degree,
               fe_face_values_m.reinit(face_accessor_inside.first,
                                       face_accessor_inside.second);
 
-              fe_face_values_p.reinit(face_accessor_outside.first,
-                                      face_accessor_outside.second);
+              const FEValuesBase<dim> *fe_face_values_p = nullptr;
+              if (matrix_free.get_face_info(face).subface_index <
+                  GeometryInfo<dim>::max_children_per_cell)
+                {
+                  fe_subface_values_p.reinit(
+                    face_accessor_outside.first,
+                    face_accessor_outside.second,
+                    matrix_free.get_face_info(face).subface_index);
+                  fe_face_values_p = &fe_subface_values_p;
+                }
+              else
+                {
+                  fe_regface_values_p.reinit(face_accessor_outside.first,
+                                             face_accessor_outside.second);
+                  fe_face_values_p = &fe_regface_values_p;
+                }
 
               face_accessor_inside.first->get_dof_indices(dof_indices_m);
               face_accessor_outside.first->get_dof_indices(dof_indices_p);
@@ -247,17 +266,17 @@ test_hessians(const unsigned int                             degree,
                     {
                       if (evaluation_flags & EvaluationFlags::hessians)
                         hessians += solution_values_p(i) *
-                                    fe_face_values_p.shape_hessian(i, q);
+                                    fe_face_values_p->shape_hessian(i, q);
                       if (evaluation_flags & EvaluationFlags::gradients)
                         gradients += solution_values_p(i) *
-                                     fe_face_values_p.shape_grad(i, q);
+                                     fe_face_values_p->shape_grad(i, q);
                       if (evaluation_flags & EvaluationFlags::values)
                         values += solution_values_p(i) *
-                                  fe_face_values_p.shape_value(i, q);
+                                  fe_face_values_p->shape_value(i, q);
                     }
-                  solution_hessians[q]  = hessians * fe_face_values_p.JxW(q);
-                  solution_gradients[q] = gradients * fe_face_values_p.JxW(q);
-                  solution_values[q]    = values * fe_face_values_p.JxW(q);
+                  solution_hessians[q]  = hessians * fe_face_values_p->JxW(q);
+                  solution_gradients[q] = gradients * fe_face_values_p->JxW(q);
+                  solution_values[q]    = values * fe_face_values_p->JxW(q);
                 }
               for (unsigned int i = 0; i < fe.dofs_per_cell; ++i)
                 {
@@ -269,13 +288,13 @@ test_hessians(const unsigned int                             degree,
                       if (evaluation_flags & EvaluationFlags::hessians)
                         sum_hessians += double_contract<0, 0, 1, 1>(
                           solution_hessians[q],
-                          fe_face_values_p.shape_hessian(i, q));
+                          fe_face_values_p->shape_hessian(i, q));
                       if (evaluation_flags & EvaluationFlags::gradients)
                         sum_gradients += solution_gradients[q] *
-                                         fe_face_values_p.shape_grad(i, q);
+                                         fe_face_values_p->shape_grad(i, q);
                       if (evaluation_flags & EvaluationFlags::values)
                         sum_values += solution_values[q] *
-                                      fe_face_values_p.shape_value(i, q);
+                                      fe_face_values_p->shape_value(i, q);
                     }
                   solution_values_p(i) =
                     sum_hessians + sum_gradients + sum_values;
index a3ad9ef2e9669115a512bacf23aafca7d12129a6..7da60d53d64c6bb71cb2fe8bc4d56da8b0d24ed9 100644 (file)
 
 DEAL::test_hessians_only
-DEAL::Working with FE_Q<1>(1) and 9 dofs
+DEAL::Working with FE_Q<1>(1) and 12 dofs
 DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 
 DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 
 DEAL::FEValues verification: 0.000000000
 DEAL::
-DEAL::Working with FE_Q<2>(1) and 81 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 -3961.844511 0.000000000 3975.516664 0.000000000 2180.676992 4279.873135 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 -3961.844511 0.000000000 3975.516664 0.000000000 2180.676992 4279.873135 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_Q<2>(1) and 51 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 433.1043183 409.4555305 0.000000000 0.000000000 -833.5079518 0.000000000 -2366.466439 
+DEAL::dst FEV: 0.000000000 0.000000000 433.1043183 409.4555305 0.000000000 0.000000000 -833.5079518 0.000000000 -2366.466439 
+DEAL::FEValues verification: 2.250697855e-16
 DEAL::
-DEAL::Working with FE_Q<3>(1) and 729 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 2671.158976 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 2671.158976 0.000000000 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_Q<3>(1) and 81 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 135.0670835 0.000000000 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 135.0670835 0.000000000 0.000000000 
+DEAL::FEValues verification: 1.755511386e-16
 DEAL::
-DEAL::Working with FE_DGQ<1>(1) and 16 dofs
+DEAL::Working with FE_DGQ<1>(1) and 22 dofs
 DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 
 DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 
 DEAL::FEValues verification: 0.000000000
 DEAL::
-DEAL::Working with FE_DGQ<2>(1) and 256 dofs
-DEAL::dst FEE: 186.7674628 -186.7674628 -186.7674628 186.7674628 1095.845132 -1095.845132 -1095.845132 1095.845132 -1770.726878 
-DEAL::dst FEV: 186.7674628 -186.7674628 -186.7674628 186.7674628 1095.845132 -1095.845132 -1095.845132 1095.845132 -1770.726878 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_DGQ<2>(1) and 136 dofs
+DEAL::dst FEE: -68.83363316 68.83363316 68.83363316 -68.83363316 659.3735362 -659.3735362 -659.3735362 659.3735362 246.5581996 
+DEAL::dst FEV: -68.83363316 68.83363316 68.83363316 -68.83363316 659.3735362 -659.3735362 -659.3735362 659.3735362 246.5581996 
+DEAL::FEValues verification: 1.684429480e-16
 DEAL::
-DEAL::Working with FE_DGQ<3>(1) and 4096 dofs
-DEAL::dst FEE: -41.82729979 116.7876889 -72.84484080 -2.115548314 24.66611142 -99.62650053 90.00602917 -15.04564006 -135.6029421 
-DEAL::dst FEV: -41.82729979 116.7876889 -72.84484080 -2.115548314 24.66611142 -99.62650053 90.00602917 -15.04564006 -135.6029421 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_DGQ<3>(1) and 232 dofs
+DEAL::dst FEE: 15.12101078 6.822265777 -21.15023562 -0.7930409353 -21.94460691 0.001330357046 27.97383175 -6.030555199 -2.723848858 
+DEAL::dst FEV: 15.12101078 6.822265777 -21.15023562 -0.7930409353 -21.94460691 0.001330357046 27.97383175 -6.030555199 -2.723848858 
+DEAL::FEValues verification: 2.899663584e-16
 DEAL::
-DEAL::Working with FE_Q<1>(2) and 17 dofs
-DEAL::dst FEE: 0.000000000 67338.98941 16221.91627 174612.5300 -150899.8951 93741.61943 -198325.1649 100444.2774 10841.92603 
-DEAL::dst FEV: 0.000000000 67338.98941 16221.91627 174612.5300 -150899.8951 93741.61943 -198325.1649 100444.2774 10841.92603 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_Q<1>(2) and 23 dofs
+DEAL::dst FEE: 1465345.061 40571.23729 11202.30012 186184.9221 -92344.77470 1048204.969 49574.60308 10790.27125 666909.3801 
+DEAL::dst FEV: 1465345.061 40571.23729 11202.30012 186184.9221 -92344.77470 1048204.969 49574.60308 10790.27125 666909.3801 
+DEAL::FEValues verification: 7.822681648e-17
 DEAL::
-DEAL::Working with FE_Q<2>(2) and 289 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 -104920.8906 0.000000000 -49521.70596 0.000000000 150903.6170 6452.694464 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 -104920.8906 0.000000000 -49521.70596 0.000000000 150903.6170 6452.694464 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_Q<2>(2) and 181 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 -28773.02739 -32468.47646 -52351.52189 -10817.58044 0.000000000 1063.289268 18963.71251 
+DEAL::dst FEV: 0.000000000 0.000000000 -28773.02739 -32468.47646 -52351.52189 -10817.58044 0.000000000 1063.289268 18963.71251 
+DEAL::FEValues verification: 1.961675702e-16
 DEAL::
-DEAL::Working with FE_Q<3>(2) and 4913 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 31698.05993 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 31698.05993 0.000000000 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_Q<3>(2) and 446 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 701.6139507 0.000000000 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 701.6139507 0.000000000 0.000000000 
+DEAL::FEValues verification: 1.771630576e-16
 DEAL::
-DEAL::Working with FE_DGQ<1>(2) and 24 dofs
-DEAL::dst FEE: -57370.44455 114740.8891 -57370.44455 -130179.7286 260359.4573 -130179.7286 -132118.6579 264237.3158 -132118.657
-DEAL::dst FEV: -57370.44455 114740.8891 -57370.44455 -130179.7286 260359.4573 -130179.7286 -132118.6579 264237.3158 -132118.657
+DEAL::Working with FE_DGQ<1>(2) and 33 dofs
+DEAL::dst FEE: 9211.388432 -18422.77686 9211.388432 49499.63824 -98999.27647 49499.63824 -11803.61329 23607.22657 -11803.6132
+DEAL::dst FEV: 9211.388432 -18422.77686 9211.388432 49499.63824 -98999.27647 49499.63824 -11803.61329 23607.22657 -11803.6132
 DEAL::FEValues verification: 0.000000000
 DEAL::
-DEAL::Working with FE_DGQ<2>(2) and 576 dofs
-DEAL::dst FEE: 2621.950491 -1575.677282 -3332.535102 -31645.71115 63719.74128 -27501.50635 24104.29342 -52305.12954 25914.57422 
-DEAL::dst FEV: 2621.950491 -1575.677282 -3332.535102 -31645.71115 63719.74128 -27501.50635 24104.29342 -52305.12954 25914.57422 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_DGQ<2>(2) and 306 dofs
+DEAL::dst FEE: -5601.840168 10463.03330 -7613.122500 13812.57530 -27019.12298 18710.40643 -8924.454807 17983.52904 -11811.00360 
+DEAL::dst FEV: -5601.840168 10463.03330 -7613.122500 13812.57530 -27019.12298 18710.40643 -8924.454807 17983.52904 -11811.00360 
+DEAL::FEValues verification: 1.924140986e-16
 DEAL::
-DEAL::Working with FE_DGQ<3>(2) and 13824 dofs
-DEAL::dst FEE: 50.88230764 -830.0219522 -818.2722402 -1019.544361 3222.190645 -744.7435660 811.4995692 1670.530726 -893.6889450 
-DEAL::dst FEV: 50.88230764 -830.0219522 -818.2722402 -1019.544361 3222.190645 -744.7435660 811.4995692 1670.530726 -893.6889450 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_DGQ<3>(2) and 783 dofs
+DEAL::dst FEE: 14.42496131 -3.879361521 -17.58395870 81.09495822 -5.721990093 34.60225396 -82.56302389 -81.93779791 18.77140939 
+DEAL::dst FEV: 14.42496131 -3.879361521 -17.58395870 81.09495822 -5.721990093 34.60225396 -82.56302389 -81.93779791 18.77140939 
+DEAL::FEValues verification: 1.467132760e-16
 DEAL::
-DEAL::Working with FE_Q<1>(3) and 25 dofs
-DEAL::dst FEE: 0.000000000 -737280.1891 -22080.92721 29817.48585 -1201734.837 1302772.885 -799181.1739 -1342610.859 3103193.420 
-DEAL::dst FEV: 0.000000000 -737280.1891 -22080.92721 29817.48585 -1201734.837 1302772.885 -799181.1739 -1342610.859 3103193.420 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_Q<1>(3) and 34 dofs
+DEAL::dst FEE: -3906649.155 2430599.363 730128.6085 -985945.8908 7857112.965 -3697943.002 2738460.602 2286270.761 996037.6045 
+DEAL::dst FEV: -3906649.155 2430599.363 730128.6085 -985945.8908 7857112.965 -3697943.002 2738460.602 2286270.761 996037.6045 
+DEAL::FEValues verification: 8.463180587e-17
 DEAL::
-DEAL::Working with FE_Q<2>(3) and 625 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 -1547335.199 0.000000000 0.000000000 368454.5924 67296.69792 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 -1547335.199 0.000000000 0.000000000 368454.5924 67296.69792 0.000000000 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_Q<2>(3) and 379 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 272932.1181 -485771.9579 -121367.7077 -23574.33304 -53597.57800 90941.12920 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 272932.1181 -485771.9579 -121367.7077 -23574.33304 -53597.57800 90941.12920 0.000000000 
+DEAL::FEValues verification: 8.736773184e-16
 DEAL::
-DEAL::Working with FE_Q<3>(3) and 15625 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 70210.21641 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 70210.21641 0.000000000 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_Q<3>(3) and 1255 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 826.7872389 0.000000000 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 826.7872389 0.000000000 0.000000000 
+DEAL::FEValues verification: 1.813207331e-15
 DEAL::
-DEAL::Working with FE_DGQ<1>(3) and 32 dofs
-DEAL::dst FEE: -254241.5072 725631.1855 -979872.6927 508483.0143 369638.5526 -633813.2719 321979.8414 -57805.12216 -296675.7776 
-DEAL::dst FEV: -254241.5072 725631.1855 -979872.6927 508483.0143 369638.5526 -633813.2719 321979.8414 -57805.12216 -296675.7776 
+DEAL::Working with FE_DGQ<1>(3) and 44 dofs
+DEAL::dst FEE: -1040216.852 2968884.961 -4009101.813 2080433.703 -758835.5215 1462314.738 -1082896.977 379417.7608 -487423.8876 
+DEAL::dst FEV: -1040216.852 2968884.961 -4009101.813 2080433.703 -758835.5215 1462314.738 -1082896.977 379417.7608 -487423.8876 
 DEAL::FEValues verification: 0.000000000
 DEAL::
-DEAL::Working with FE_DGQ<2>(3) and 1024 dofs
-DEAL::dst FEE: 19404.30284 11401.17609 53539.65109 -156046.9045 -56073.49671 -37352.39201 -103984.8509 359118.5689 51864.00926 
-DEAL::dst FEV: 19404.30284 11401.17609 53539.65109 -156046.9045 -56073.49671 -37352.39201 -103984.8509 359118.5689 51864.00926 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_DGQ<2>(3) and 544 dofs
+DEAL::dst FEE: 15741.93968 -2748.862860 -24081.59292 18027.71389 -68133.07987 78029.46822 -19164.26626 -2665.696772 37906.49239 
+DEAL::dst FEV: 15741.93968 -2748.862860 -24081.59292 18027.71389 -68133.07987 78029.46822 -19164.26626 -2665.696772 37906.49239 
+DEAL::FEValues verification: 1.016123726e-15
 DEAL::
-DEAL::Working with FE_DGQ<3>(3) and 32768 dofs
-DEAL::dst FEE: 118.4885551 -4107.177606 1812.382519 -363.6809581 -2068.812140 9700.899062 -6925.304917 4256.899099 -2307.998977 
-DEAL::dst FEV: 118.4885551 -4107.177606 1812.382519 -363.6809581 -2068.812140 9700.899062 -6925.304917 4256.899099 -2307.998977 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_DGQ<3>(3) and 1856 dofs
+DEAL::dst FEE: 91.29952737 -91.21541079 7.371715608 -24.51738272 1350.172359 -1714.416251 459.3900051 -98.10156306 -1295.490069 
+DEAL::dst FEV: 91.29952737 -91.21541079 7.371715608 -24.51738272 1350.172359 -1714.416251 459.3900051 -98.10156306 -1295.490069 
+DEAL::FEValues verification: 1.745784298e-15
 DEAL::
 DEAL::test_hessians_with_values
-DEAL::Working with FE_Q<1>(1) and 9 dofs
-DEAL::dst FEE: 0.000000000 1.485241358 0.4717695818 1.336048384 0.09186878712 0.5541558529 0.6274125085 0.1848661360 0.000000000 
-DEAL::dst FEV: 0.000000000 1.485241358 0.4717695818 1.336048384 0.09186878712 0.5541558529 0.6274125085 0.1848661360 0.000000000 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<2>(1) and 81 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 1070.969383 0.000000000 2878.096119 0.000000000 -3268.391675 -412.5247158 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 1070.969383 0.000000000 2878.096119 0.000000000 -3268.391675 -412.5247158 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<3>(1) and 729 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 3500.106392 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 3500.106392 0.000000000 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<1>(1) and 16 dofs
-DEAL::dst FEE: 0.000000000 0.9178876015 0.3258156191 0.6197056345 0.1537631360 0.2945842553 0.3555839413 0.1329097907 0.707002615
-DEAL::dst FEV: 0.000000000 0.9178876015 0.3258156191 0.6197056345 0.1537631360 0.2945842553 0.3555839413 0.1329097907 0.707002615
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<2>(1) and 256 dofs
-DEAL::dst FEE: -569.5871632 569.6347435 569.6092785 -569.5287350 -1511.130148 1511.164480 1511.202041 -1511.108327 -2579.882528 
-DEAL::dst FEV: -569.5871632 569.6347435 569.6092785 -569.5287350 -1511.130148 1511.164480 1511.202041 -1511.108327 -2579.882528 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<3>(1) and 4096 dofs
-DEAL::dst FEE: 7.424074176 241.6432657 -274.2813513 25.22374027 79.00171305 -328.0612417 187.8648553 61.21168368 78.30753564 
-DEAL::dst FEV: 7.424074176 241.6432657 -274.2813513 25.22374027 79.00171305 -328.0612417 187.8648553 61.21168368 78.30753564 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<1>(2) and 17 dofs
-DEAL::dst FEE: 0.000000000 -167135.6577 229538.9869 -97797.09182 104732.8852 -39369.24028 90862.39763 -109611.4362 -12122.77601 
-DEAL::dst FEV: 0.000000000 -167135.6577 229538.9869 -97797.09182 104732.8852 -39369.24028 90862.39763 -109611.4362 -12122.77601 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<2>(2) and 289 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 60209.63375 0.000000000 69766.67093 0.000000000 -58791.04965 -39753.16339 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 60209.63375 0.000000000 69766.67093 0.000000000 -58791.04965 -39753.16339 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<3>(2) and 4913 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 12306.73607 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 12306.73607 0.000000000 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<1>(2) and 24 dofs
-DEAL::dst FEE: 47813.68795 -95627.37590 47814.42813 -96189.12898 192379.2740 -96189.51817 55225.52064 -110450.7480 55226.32803 
-DEAL::dst FEV: 47813.68795 -95627.37590 47814.42813 -96189.12898 192379.2740 -96189.51817 55225.52064 -110450.7480 55226.32803 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<2>(2) and 576 dofs
-DEAL::dst FEE: -5287.684869 6572.726856 -20184.16775 24229.94350 -48365.22252 61933.61384 -25037.39476 53982.83575 -47844.48685 
-DEAL::dst FEV: -5287.684869 6572.726856 -20184.16775 24229.94350 -48365.22252 61933.61384 -25037.39476 53982.83575 -47844.48685 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<3>(2) and 13824 dofs
-DEAL::dst FEE: 370.0566403 -292.3081868 -720.4052507 -622.7558219 238.6508182 1862.634403 281.8888045 2091.765602 -1871.063632 
-DEAL::dst FEV: 370.0566403 -292.3081868 -720.4052507 -622.7558219 238.6508182 1862.634403 281.8888045 2091.765602 -1871.063632 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<1>(3) and 25 dofs
-DEAL::dst FEE: 0.000000000 299377.0807 289587.9028 -391051.6578 -3248169.708 -134872.5658 4149.691300 2108415.055 7239160.344 
-DEAL::dst FEV: 0.000000000 299377.0807 289587.9028 -391051.6578 -3248169.708 -134872.5658 4149.691300 2108415.055 7239160.344 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<2>(3) and 625 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 -293073.3740 0.000000000 0.000000000 675561.0838 -427952.8498 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 -293073.3740 0.000000000 0.000000000 675561.0838 -427952.8498 0.000000000 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<3>(3) and 15625 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -85712.86767 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -85712.86767 0.000000000 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<1>(3) and 32 dofs
-DEAL::dst FEE: -252775.6199 721447.3938 -974223.0137 505551.7303 1611958.374 -3761443.564 4015469.154 -1865982.968 -51596.77459 
-DEAL::dst FEV: -252775.6199 721447.3938 -974223.0137 505551.7303 1611958.374 -3761443.564 4015469.154 -1865982.968 -51596.77459 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<2>(3) and 1024 dofs
-DEAL::dst FEE: -10040.20263 53844.53594 -182876.7764 97992.24016 38492.66295 -176621.9667 403072.9022 -164030.7460 150191.7481 
-DEAL::dst FEV: -10040.20263 53844.53594 -182876.7764 97992.24016 38492.66295 -176621.9667 403072.9022 -164030.7460 150191.7481 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<3>(3) and 32768 dofs
-DEAL::dst FEE: -674.3169640 814.0460283 -4216.899024 5057.280398 2850.106346 -2615.447288 14600.65907 -8650.675187 -3053.71811
-DEAL::dst FEV: -674.3169640 814.0460283 -4216.899024 5057.280398 2850.106346 -2615.447288 14600.65907 -8650.675187 -3053.71811
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_Q<1>(1) and 12 dofs
+DEAL::dst FEE: 0.000000000 1.807167101 0.000000000 0.000000000 0.6599475642 0.000000000 0.000000000 0.000000000 0.000000000 
+DEAL::dst FEV: 0.000000000 1.807167101 0.000000000 0.000000000 0.6599475642 0.000000000 0.000000000 0.000000000 0.000000000 
+DEAL::FEValues verification: 0.000000000
+DEAL::
+DEAL::Working with FE_Q<2>(1) and 51 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 -2613.803043 -134.6663564 0.000000000 0.000000000 622.3486346 0.000000000 818.1755152 
+DEAL::dst FEV: 0.000000000 0.000000000 -2613.803043 -134.6663564 0.000000000 0.000000000 622.3486346 0.000000000 818.1755152 
+DEAL::FEValues verification: 1.301148834e-16
+DEAL::
+DEAL::Working with FE_Q<3>(1) and 81 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -48.44817149 0.000000000 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -48.44817149 0.000000000 0.000000000 
+DEAL::FEValues verification: 8.136896768e-17
+DEAL::
+DEAL::Working with FE_DGQ<1>(1) and 22 dofs
+DEAL::dst FEE: 0.000000000 0.5510875338 0.2423168105 0.000000000 0.000000000 0.2484545304 0.1771846871 0.000000000 0.00000000
+DEAL::dst FEV: 0.000000000 0.5510875338 0.2423168105 0.000000000 0.000000000 0.2484545304 0.1771846871 0.000000000 0.00000000
+DEAL::FEValues verification: 0.000000000
+DEAL::
+DEAL::Working with FE_DGQ<2>(1) and 136 dofs
+DEAL::dst FEE: 58.84947668 -58.81632022 -58.77940556 58.85866920 -537.4694793 537.6769786 537.5871007 -537.4498227 -310.8105087 
+DEAL::dst FEV: 58.84947668 -58.81632022 -58.77940556 58.85866920 -537.4694793 537.6769786 537.5871007 -537.4498227 -310.8105087 
+DEAL::FEValues verification: 2.910843296e-16
+DEAL::
+DEAL::Working with FE_DGQ<3>(1) and 232 dofs
+DEAL::dst FEE: -16.77534059 5.707210800 28.79188796 -17.61980372 6.516624752 4.633464799 -18.35926653 7.353763639 -5.260887822 
+DEAL::dst FEV: -16.77534059 5.707210800 28.79188796 -17.61980372 6.516624752 4.633464799 -18.35926653 7.353763639 -5.260887822 
+DEAL::FEValues verification: 3.168779687e-16
+DEAL::
+DEAL::Working with FE_Q<1>(2) and 23 dofs
+DEAL::dst FEE: 353239.1967 -117611.2418 55721.21041 -39740.23598 179502.7454 8675.810978 1906.995703 -68111.30948 -807615.4423 
+DEAL::dst FEV: 353239.1967 -117611.2418 55721.21041 -39740.23598 179502.7454 8675.810978 1906.995703 -68111.30948 -807615.4423 
+DEAL::FEValues verification: 1.393697288e-16
+DEAL::
+DEAL::Working with FE_Q<2>(2) and 181 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 -27809.54772 -21242.09627 19283.96978 22835.67351 0.000000000 -64351.00008 -14013.29948 
+DEAL::dst FEV: 0.000000000 0.000000000 -27809.54772 -21242.09627 19283.96978 22835.67351 0.000000000 -64351.00008 -14013.29948 
+DEAL::FEValues verification: 3.719983382e-16
+DEAL::
+DEAL::Working with FE_Q<3>(2) and 446 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 757.6113771 0.000000000 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 757.6113771 0.000000000 0.000000000 
+DEAL::FEValues verification: 1.753147939e-16
+DEAL::
+DEAL::Working with FE_DGQ<1>(2) and 33 dofs
+DEAL::dst FEE: 21537.92808 -43075.85616 21538.63514 -69582.48204 139165.9954 -69582.99768 -76137.65763 152275.3153 -76137.21800 
+DEAL::dst FEV: 21537.92808 -43075.85616 21538.63514 -69582.48204 139165.9954 -69582.99768 -76137.65763 152275.3153 -76137.21800 
+DEAL::FEValues verification: 0.000000000
+DEAL::
+DEAL::Working with FE_DGQ<2>(2) and 306 dofs
+DEAL::dst FEE: -2056.727525 1019.142493 -318.2283993 7246.610316 -8061.741045 3527.063995 -4593.733841 5850.579848 -2612.634461 
+DEAL::dst FEV: -2056.727525 1019.142493 -318.2283993 7246.610316 -8061.741045 3527.063995 -4593.733841 5850.579848 -2612.634461 
+DEAL::FEValues verification: 2.264755522e-16
+DEAL::
+DEAL::Working with FE_DGQ<3>(2) and 783 dofs
+DEAL::dst FEE: 2.106657784 1.900906966 2.852536663 58.86897377 -1.151200860 27.04449896 -70.34951749 -109.6686723 100.1358735 
+DEAL::dst FEV: 2.106657784 1.900906966 2.852536663 58.86897377 -1.151200860 27.04449896 -70.34951749 -109.6686723 100.1358735 
+DEAL::FEValues verification: 1.504578088e-16
+DEAL::
+DEAL::Working with FE_Q<1>(3) and 34 dofs
+DEAL::dst FEE: -6365543.281 1160538.561 691169.2629 -933336.2461 -20016444.40 -1303077.094 964975.7397 -4046344.830 4176027.848 
+DEAL::dst FEV: -6365543.281 1160538.561 691169.2629 -933336.2461 -20016444.40 -1303077.094 964975.7397 -4046344.830 4176027.848 
+DEAL::FEValues verification: 8.054047922e-17
+DEAL::
+DEAL::Working with FE_Q<2>(3) and 379 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 -295590.3869 270716.0606 114636.5236 467511.6916 -36209.35935 -10295.94463 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 -295590.3869 270716.0606 114636.5236 467511.6916 -36209.35935 -10295.94463 0.000000000 
+DEAL::FEValues verification: 9.243892897e-16
+DEAL::
+DEAL::Working with FE_Q<3>(3) and 1255 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -8280.603157 0.000000000 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -8280.603157 0.000000000 0.000000000 
+DEAL::FEValues verification: 1.836837877e-15
+DEAL::
+DEAL::Working with FE_DGQ<1>(3) and 44 dofs
+DEAL::dst FEE: -587442.4527 1676620.659 -2264063.112 1174885.575 1204349.693 -2320841.860 1718667.377 -602174.4833 122478.7245 
+DEAL::dst FEV: -587442.4527 1676620.659 -2264063.112 1174885.575 1204349.693 -2320841.860 1718667.377 -602174.4833 122478.7245 
+DEAL::FEValues verification: 5.123769461e-17
+DEAL::
+DEAL::Working with FE_DGQ<2>(3) and 544 dofs
+DEAL::dst FEE: -1276.546381 -2935.008522 7053.752589 -10936.43324 -16031.31698 38742.36156 -39420.81653 35855.56624 66143.53309 
+DEAL::dst FEV: -1276.546381 -2935.008522 7053.752589 -10936.43324 -16031.31698 38742.36156 -39420.81653 35855.56624 66143.53309 
+DEAL::FEValues verification: 9.274364930e-16
+DEAL::
+DEAL::Working with FE_DGQ<3>(3) and 1856 dofs
+DEAL::dst FEE: -337.1928885 133.0611399 30.78124686 44.08178972 270.9176202 294.8097998 -602.0427883 -107.5755526 198.434492
+DEAL::dst FEV: -337.1928885 133.0611399 30.78124686 44.08178972 270.9176202 294.8097998 -602.0427883 -107.5755526 198.434492
+DEAL::FEValues verification: 1.827357405e-15
 DEAL::
 DEAL::test_hessians_with_gradients
-DEAL::Working with FE_Q<1>(1) and 9 dofs
-DEAL::dst FEE: 0.000000000 64.15179569 36.90356960 -40.28644325 -68.37967620 39.09859355 46.88549312 -62.19046491 31.72474919 
-DEAL::dst FEV: 0.000000000 64.15179569 36.90356960 -40.28644325 -68.37967620 39.09859355 46.88549312 -62.19046491 31.72474919 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<2>(1) and 81 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 442.0107683 0.000000000 3542.943855 0.000000000 -9575.588132 7499.03158
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 442.0107683 0.000000000 3542.943855 0.000000000 -9575.588132 7499.03158
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<3>(1) and 729 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -2821.551619 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -2821.551619 0.000000000 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<1>(1) and 16 dofs
-DEAL::dst FEE: 10.06237412 -10.06237412 -27.76560022 27.76560022 34.04355665 -34.04355665 -21.65914739 21.65914739 -7.379041318 
-DEAL::dst FEV: 10.06237412 -10.06237412 -27.76560022 27.76560022 34.04355665 -34.04355665 -21.65914739 21.65914739 -7.379041318 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<2>(1) and 256 dofs
-DEAL::dst FEE: -1170.185020 1177.791704 1171.983635 -1179.590319 -370.5322257 366.0001104 361.6813287 -357.1492134 373.2952228 
-DEAL::dst FEV: -1170.185020 1177.791704 1171.983635 -1179.590319 -370.5322257 366.0001104 361.6813287 -357.1492134 373.2952228 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<3>(1) and 4096 dofs
-DEAL::dst FEE: -21.58586802 226.0914318 181.3343315 -385.5024982 28.95060815 -234.0415895 -189.5067703 394.2603544 -219.6450550 
-DEAL::dst FEV: -21.58586802 226.0914318 181.3343315 -385.5024982 28.95060815 -234.0415895 -189.5067703 394.2603544 -219.6450550 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<1>(2) and 17 dofs
-DEAL::dst FEE: 0.000000000 22439.52331 189626.7649 11978.51334 -234916.2278 -265869.0386 211155.8797 -262006.1754 320433.1750 
-DEAL::dst FEV: 0.000000000 22439.52331 189626.7649 11978.51334 -234916.2278 -265869.0386 211155.8797 -262006.1754 320433.1750 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<2>(2) and 289 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 -10856.65148 0.000000000 -25321.75472 0.000000000 95280.37568 4511.212957 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 -10856.65148 0.000000000 -25321.75472 0.000000000 95280.37568 4511.212957 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<3>(2) and 4913 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 9080.423198 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 9080.423198 0.000000000 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<1>(2) and 24 dofs
-DEAL::dst FEE: 9696.728295 -19428.05746 9731.329162 -57259.37641 114443.5555 -57184.17906 159527.5899 -319143.7449 159616.1550 
-DEAL::dst FEV: 9696.728295 -19428.05746 9731.329162 -57259.37641 114443.5555 -57184.17906 159527.5899 -319143.7449 159616.1550 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<2>(2) and 576 dofs
-DEAL::dst FEE: 10194.28422 -35453.44115 24293.82892 -45055.92628 130503.0063 -83489.42850 30711.39427 -86727.69612 55023.97831 
-DEAL::dst FEV: 10194.28422 -35453.44115 24293.82892 -45055.92628 130503.0063 -83489.42850 30711.39427 -86727.69612 55023.97831 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<3>(2) and 13824 dofs
-DEAL::dst FEE: 448.1446413 -510.9189963 1634.494590 755.7615764 -6223.772600 800.6586105 529.4850620 1959.380310 711.9024984 
-DEAL::dst FEV: 448.1446413 -510.9189963 1634.494590 755.7615764 -6223.772600 800.6586105 529.4850620 1959.380310 711.9024984 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<1>(3) and 25 dofs
-DEAL::dst FEE: 0.000000000 2252292.265 1573930.091 -2126197.154 -174516.4842 -2501369.733 2393718.162 -640706.0941 -2054230.48
-DEAL::dst FEV: 0.000000000 2252292.265 1573930.091 -2126197.154 -174516.4842 -2501369.733 2393718.162 -640706.0941 -2054230.48
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<2>(3) and 625 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 -1317837.470 0.000000000 0.000000000 -264992.6854 1082118.987 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 -1317837.470 0.000000000 0.000000000 -264992.6854 1082118.987 0.000000000 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<3>(3) and 15625 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -65742.12001 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -65742.12001 0.000000000 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<1>(3) and 32 dofs
-DEAL::dst FEE: 607362.1400 -1733480.886 2340968.548 -1214849.802 -1047359.729 2045725.963 -1566917.253 568551.0199 -3864497.016 
-DEAL::dst FEV: 607362.1400 -1733480.886 2340968.548 -1214849.802 -1047359.729 2045725.963 -1566917.253 568551.0199 -3864497.016 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<2>(3) and 1024 dofs
-DEAL::dst FEE: -27040.61278 3573.267393 57805.44291 58432.19141 166809.4545 -257530.0470 225343.1275 -358312.5442 -334186.2219 
-DEAL::dst FEV: -27040.61278 3573.267393 57805.44291 58432.19141 166809.4545 -257530.0470 225343.1275 -358312.5442 -334186.2219 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<3>(3) and 32768 dofs
-DEAL::dst FEE: -464.3635240 2028.142271 763.8205053 -549.6966376 327.0786350 -596.5268953 -20821.36159 10310.01212 -817.8506617 
-DEAL::dst FEV: -464.3635240 2028.142271 763.8205053 -549.6966376 327.0786350 -596.5268953 -20821.36159 10310.01212 -817.8506617 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_Q<1>(1) and 12 dofs
+DEAL::dst FEE: 45.96670192 -1.685969622 77.24826578 78.52481113 -58.09568703 -10.94109008 -103.3312021 0.000000000 0.000000000 
+DEAL::dst FEV: 45.96670192 -1.685969622 77.24826578 78.52481113 -58.09568703 -10.94109008 -103.3312021 0.000000000 0.000000000 
+DEAL::FEValues verification: 0.000000000
+DEAL::
+DEAL::Working with FE_Q<2>(1) and 51 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 -3165.085638 -1014.477234 0.000000000 0.000000000 390.2999479 0.000000000 793.722893
+DEAL::dst FEV: 0.000000000 0.000000000 -3165.085638 -1014.477234 0.000000000 0.000000000 390.2999479 0.000000000 793.722893
+DEAL::FEValues verification: 2.493310731e-16
+DEAL::
+DEAL::Working with FE_Q<3>(1) and 81 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -212.1597356 0.000000000 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -212.1597356 0.000000000 0.000000000 
+DEAL::FEValues verification: 6.574515365e-17
+DEAL::
+DEAL::Working with FE_DGQ<1>(1) and 22 dofs
+DEAL::dst FEE: 17.68234251 -17.68234251 10.80007458 -10.80007458 -28.40604527 28.40604527 4.814864697 -4.814864697 0.000000000 
+DEAL::dst FEV: 17.68234251 -17.68234251 10.80007458 -10.80007458 -28.40604527 28.40604527 4.814864697 -4.814864697 0.000000000 
+DEAL::FEValues verification: 0.000000000
+DEAL::
+DEAL::Working with FE_DGQ<2>(1) and 136 dofs
+DEAL::dst FEE: 147.3068345 -145.8533826 -152.4621192 151.0086673 415.4443412 -413.5180746 -414.0133018 412.0870352 -184.9286473 
+DEAL::dst FEV: 147.3068345 -145.8533826 -152.4621192 151.0086673 415.4443412 -413.5180746 -414.0133018 412.0870352 -184.9286473 
+DEAL::FEValues verification: 2.133688743e-16
+DEAL::
+DEAL::Working with FE_DGQ<3>(1) and 232 dofs
+DEAL::dst FEE: -14.23709373 -0.4045199727 17.99385207 -2.767427992 14.93022530 0.06184037863 -18.26307899 2.686202930 -6.848401809 
+DEAL::dst FEV: -14.23709373 -0.4045199727 17.99385207 -2.767427992 14.93022530 0.06184037863 -18.26307899 2.686202930 -6.848401809 
+DEAL::FEValues verification: 2.929013532e-16
+DEAL::
+DEAL::Working with FE_Q<1>(2) and 23 dofs
+DEAL::dst FEE: 1065434.769 -66767.79940 26081.81876 -1111723.263 107270.9888 166599.6694 -68868.59620 56012.46137 845950.2191 
+DEAL::dst FEV: 1065434.769 -66767.79940 26081.81876 -1111723.263 107270.9888 166599.6694 -68868.59620 56012.46137 845950.2191 
+DEAL::FEValues verification: 2.567712554e-17
+DEAL::
+DEAL::Working with FE_Q<2>(2) and 181 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 96649.32347 -41405.84314 -3412.639649 15029.78890 0.000000000 -29103.76855 4367.043765 
+DEAL::dst FEV: 0.000000000 0.000000000 96649.32347 -41405.84314 -3412.639649 15029.78890 0.000000000 -29103.76855 4367.043765 
+DEAL::FEValues verification: 2.489841339e-16
+DEAL::
+DEAL::Working with FE_Q<3>(2) and 446 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 1583.509647 0.000000000 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 1583.509647 0.000000000 0.000000000 
+DEAL::FEValues verification: 1.603770434e-16
+DEAL::
+DEAL::Working with FE_DGQ<1>(2) and 33 dofs
+DEAL::dst FEE: -24255.50118 48580.42438 -24324.92320 -64064.04919 127930.3890 -63866.33982 -80595.69654 161545.3860 -80949.68947 
+DEAL::dst FEV: -24255.50118 48580.42438 -24324.92320 -64064.04919 127930.3890 -63866.33982 -80595.69654 161545.3860 -80949.68947 
+DEAL::FEValues verification: 0.000000000
+DEAL::
+DEAL::Working with FE_DGQ<2>(2) and 306 dofs
+DEAL::dst FEE: 2448.919726 -5897.308290 2379.859925 -8405.571844 17520.55898 -6968.804680 5134.095331 -9978.363121 3766.613968 
+DEAL::dst FEV: 2448.919726 -5897.308290 2379.859925 -8405.571844 17520.55898 -6968.804680 5134.095331 -9978.363121 3766.613968 
+DEAL::FEValues verification: 2.552400510e-16
+DEAL::
+DEAL::Working with FE_DGQ<3>(2) and 783 dofs
+DEAL::dst FEE: 22.73920236 -84.60153849 32.87405867 94.34811872 -79.01543748 -28.99031850 -22.01144122 43.18215647 77.55487231 
+DEAL::dst FEV: 22.73920236 -84.60153849 32.87405867 94.34811872 -79.01543748 -28.99031850 -22.01144122 43.18215647 77.55487231 
+DEAL::FEValues verification: 1.638886035e-16
+DEAL::
+DEAL::Working with FE_Q<1>(3) and 34 dofs
+DEAL::dst FEE: -19483301.72 -1677606.453 -2171378.360 2933179.776 -7053677.138 298634.4470 -221045.7107 -8318171.743 2799170.95
+DEAL::dst FEV: -19483301.72 -1677606.453 -2171378.360 2933179.776 -7053677.138 298634.4470 -221045.7107 -8318171.743 2799170.95
+DEAL::FEValues verification: 1.441258284e-16
+DEAL::
+DEAL::Working with FE_Q<2>(3) and 379 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 -620551.3751 20451.05242 54965.84658 363001.1702 63750.71390 -169838.1018 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 -620551.3751 20451.05242 54965.84658 363001.1702 63750.71390 -169838.1018 0.000000000 
+DEAL::FEValues verification: 8.559997896e-16
+DEAL::
+DEAL::Working with FE_Q<3>(3) and 1255 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -9058.541346 0.000000000 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -9058.541346 0.000000000 0.000000000 
+DEAL::FEValues verification: 1.780380040e-15
+DEAL::
+DEAL::Working with FE_DGQ<1>(3) and 44 dofs
+DEAL::dst FEE: -627711.7187 1791576.817 -2419687.847 1255822.749 1843279.109 -3551413.238 2629382.236 -921248.1064 700432.0779 
+DEAL::dst FEV: -627711.7187 1791576.817 -2419687.847 1255822.749 1843279.109 -3551413.238 2629382.236 -921248.1064 700432.0779 
+DEAL::FEValues verification: 5.944615878e-17
+DEAL::
+DEAL::Working with FE_DGQ<2>(3) and 544 dofs
+DEAL::dst FEE: -34654.51279 60172.53842 -34400.57913 15734.69595 63002.65647 -118702.4067 52959.34581 -18995.78076 -24342.73565 
+DEAL::dst FEV: -34654.51279 60172.53842 -34400.57913 15734.69595 63002.65647 -118702.4067 52959.34581 -18995.78076 -24342.73565 
+DEAL::FEValues verification: 9.364978229e-16
+DEAL::
+DEAL::Working with FE_DGQ<3>(3) and 1856 dofs
+DEAL::dst FEE: 375.4738170 -266.9737939 210.2972645 -83.53758689 -1079.121346 1029.805088 -474.5269070 133.9501764 -278.2277443 
+DEAL::dst FEV: 375.4738170 -266.9737939 210.2972645 -83.53758689 -1079.121346 1029.805088 -474.5269070 133.9501764 -278.2277443 
+DEAL::FEValues verification: 1.778550494e-15
 DEAL::
 DEAL::test_hessians_with_gradients_and_values
-DEAL::Working with FE_Q<1>(1) and 9 dofs
-DEAL::dst FEE: 0.000000000 -37.00478557 48.59625945 0.8581540048 -7.323365868 59.63530424 -26.02881961 -15.72262317 -0.3217377366 
-DEAL::dst FEV: 0.000000000 -37.00478557 48.59625945 0.8581540048 -7.323365868 59.63530424 -26.02881961 -15.72262317 -0.3217377366 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<2>(1) and 81 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 9507.556791 0.000000000 -7321.070916 0.000000000 -12431.59166 12502.87908 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 9507.556791 0.000000000 -7321.070916 0.000000000 -12431.59166 12502.87908 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<3>(1) and 729 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 280.4491881 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 280.4491881 0.000000000 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<1>(1) and 16 dofs
-DEAL::dst FEE: 39.29021196 -39.01623275 -9.963182797 11.39805324 -15.84908361 16.43351670 80.59747247 -79.58483093 53.75457114 
-DEAL::dst FEV: 39.29021196 -39.01623275 -9.963182797 11.39805324 -15.84908361 16.43351670 80.59747247 -79.58483093 53.75457114 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<2>(1) and 256 dofs
-DEAL::dst FEE: 1516.712105 -1527.764366 -1523.902913 1535.086538 -1666.971584 1682.840844 1665.583768 -1681.331729 -76.9121842
-DEAL::dst FEV: 1516.712105 -1527.764366 -1523.902913 1535.086538 -1666.971584 1682.840844 1665.583768 -1681.331729 -76.9121842
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<3>(1) and 4096 dofs
-DEAL::dst FEE: -1.189912404 234.8477478 180.7860225 -413.6249483 -121.5440256 -112.1298409 -57.51853159 290.3907440 289.0256656 
-DEAL::dst FEV: -1.189912404 234.8477478 180.7860225 -413.6249483 -121.5440256 -112.1298409 -57.51853159 290.3907440 289.0256656 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<1>(2) and 17 dofs
-DEAL::dst FEE: 0.000000000 29141.70579 65351.23242 -37541.71163 -123874.9385 15975.67678 199194.1660 179480.0205 -231343.3646 
-DEAL::dst FEV: 0.000000000 29141.70579 65351.23242 -37541.71163 -123874.9385 15975.67678 199194.1660 179480.0205 -231343.3646 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<2>(2) and 289 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 5622.410746 0.000000000 -124785.4497 0.000000000 -28083.28907 140221.5951 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 5622.410746 0.000000000 -124785.4497 0.000000000 -28083.28907 140221.5951 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<3>(2) and 4913 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 4030.831352 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 4030.831352 0.000000000 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<1>(2) and 24 dofs
-DEAL::dst FEE: 1260.253162 -2590.873853 1331.260025 -26516.06494 53162.96332 -26645.70214 192196.9013 -384333.9650 192138.6030 
-DEAL::dst FEV: 1260.253162 -2590.873853 1331.260025 -26516.06494 53162.96332 -26645.70214 192196.9013 -384333.9650 192138.6030 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<2>(2) and 576 dofs
-DEAL::dst FEE: -5169.333357 29063.34663 -23105.45307 24704.96903 -97773.79532 71498.06891 -4767.981572 39154.65283 -33604.35418 
-DEAL::dst FEV: -5169.333357 29063.34663 -23105.45307 24704.96903 -97773.79532 71498.06891 -4767.981572 39154.65283 -33604.35418 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<3>(2) and 13824 dofs
-DEAL::dst FEE: -95.58676656 1276.489009 -1334.575175 274.9405999 -4042.776356 2530.457071 1137.743263 1405.963407 -1676.022846 
-DEAL::dst FEV: -95.58676656 1276.489009 -1334.575175 274.9405999 -4042.776356 2530.457071 1137.743263 1405.963407 -1676.022846 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<1>(3) and 25 dofs
-DEAL::dst FEE: 0.000000000 -3677129.436 -674168.6624 910870.7211 167797.2252 7072904.503 -6925910.014 1212429.567 6407996.850 
-DEAL::dst FEV: 0.000000000 -3677129.436 -674168.6624 910870.7211 167797.2252 7072904.503 -6925910.014 1212429.567 6407996.850 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<2>(3) and 625 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 901522.2209 0.000000000 0.000000000 497122.6409 -783742.6748 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 901522.2209 0.000000000 0.000000000 497122.6409 -783742.6748 0.000000000 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_Q<3>(3) and 15625 dofs
-DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 61931.57932 0.000000000 
-DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 61931.57932 0.000000000 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<1>(3) and 32 dofs
-DEAL::dst FEE: -561890.2156 1603751.370 -2166648.089 1124787.675 -928689.6365 1915272.283 -1654708.155 668125.8408 -2711210.037 
-DEAL::dst FEV: -561890.2156 1603751.370 -2166648.089 1124787.675 -928689.6365 1915272.283 -1654708.155 668125.8408 -2711210.037 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<2>(3) and 1024 dofs
-DEAL::dst FEE: -2674.684464 105342.7462 -38524.91232 -48556.52335 48969.79796 -415911.0458 256625.4211 38926.74483 -131829.3972 
-DEAL::dst FEV: -2674.684464 105342.7462 -38524.91232 -48556.52335 48969.79796 -415911.0458 256625.4211 38926.74483 -131829.3972 
-DEAL::FEValues verification: 0.000000000
-DEAL::
-DEAL::Working with FE_DGQ<3>(3) and 32768 dofs
-DEAL::dst FEE: 692.2851052 972.7257414 820.4660691 1018.320908 -949.9325546 -10318.08673 14538.53642 -19371.16378 5741.320571 
-DEAL::dst FEV: 692.2851052 972.7257414 820.4660691 1018.320908 -949.9325546 -10318.08673 14538.53642 -19371.16378 5741.320571 
-DEAL::FEValues verification: 0.000000000
+DEAL::Working with FE_Q<1>(1) and 12 dofs
+DEAL::dst FEE: 117.6789266 -65.95609570 186.6801510 180.5311447 -17.05540299 165.5319325 101.7861375 0.000000000 0.000000000 
+DEAL::dst FEV: 117.6789266 -65.95609570 186.6801510 180.5311447 -17.05540299 165.5319325 101.7861375 0.000000000 0.000000000 
+DEAL::FEValues verification: 0.000000000
+DEAL::
+DEAL::Working with FE_Q<2>(1) and 51 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 -1050.854043 1565.761338 0.000000000 0.000000000 389.1523768 0.000000000 -991.8996672 
+DEAL::dst FEV: 0.000000000 0.000000000 -1050.854043 1565.761338 0.000000000 0.000000000 389.1523768 0.000000000 -991.8996672 
+DEAL::FEValues verification: 4.393202110e-16
+DEAL::
+DEAL::Working with FE_Q<3>(1) and 81 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -52.92819596 0.000000000 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -52.92819596 0.000000000 0.000000000 
+DEAL::FEValues verification: 4.316286200e-16
+DEAL::
+DEAL::Working with FE_DGQ<1>(1) and 22 dofs
+DEAL::dst FEE: -8.523790870 9.509199065 22.23462068 -21.33603759 23.26070796 -22.81747802 -29.62593349 29.75402458 0.000000000 
+DEAL::dst FEV: -8.523790870 9.509199065 22.23462068 -21.33603759 23.26070796 -22.81747802 -29.62593349 29.75402458 0.000000000 
+DEAL::FEValues verification: 0.000000000
+DEAL::
+DEAL::Working with FE_DGQ<2>(1) and 136 dofs
+DEAL::dst FEE: 676.0376631 -675.9954880 -679.3181713 679.6652056 253.5302144 -254.9661640 -253.7768680 255.3965815 -305.678667
+DEAL::dst FEV: 676.0376631 -675.9954880 -679.3181713 679.6652056 253.5302144 -254.9661640 -253.7768680 255.3965815 -305.678667
+DEAL::FEValues verification: 3.105379831e-16
+DEAL::
+DEAL::Working with FE_DGQ<3>(1) and 232 dofs
+DEAL::dst FEE: -23.98447539 9.810053611 34.51046276 -19.83546853 30.09607200 -15.80103897 -41.01398337 26.54901367 -3.160056394 
+DEAL::dst FEV: -23.98447539 9.810053611 34.51046276 -19.83546853 30.09607200 -15.80103897 -41.01398337 26.54901367 -3.160056394 
+DEAL::FEValues verification: 3.136379387e-16
+DEAL::
+DEAL::Working with FE_Q<1>(2) and 23 dofs
+DEAL::dst FEE: 1503794.239 -50130.31898 100006.8617 72674.62607 -2.543915869 -55544.10172 -154564.6259 243463.7291 -826529.4518 
+DEAL::dst FEV: 1503794.239 -50130.31898 100006.8617 72674.62607 -2.543915869 -55544.10172 -154564.6259 243463.7291 -826529.4518 
+DEAL::FEValues verification: 1.333213421e-18
+DEAL::
+DEAL::Working with FE_Q<2>(2) and 181 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 -38188.66763 -8180.913173 -3272.052915 -18810.10207 0.000000000 -13783.65988 25416.84134 
+DEAL::dst FEV: 0.000000000 0.000000000 -38188.66763 -8180.913173 -3272.052915 -18810.10207 0.000000000 -13783.65988 25416.84134 
+DEAL::FEValues verification: 2.747460711e-16
+DEAL::
+DEAL::Working with FE_Q<3>(2) and 446 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -649.2366621 0.000000000 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -649.2366621 0.000000000 0.000000000 
+DEAL::FEValues verification: 1.831341031e-16
+DEAL::
+DEAL::Working with FE_DGQ<1>(2) and 33 dofs
+DEAL::dst FEE: 5541.555950 -11106.32200 5565.477537 37530.71560 -74989.85145 37459.18074 56526.44744 -113356.1837 56830.50646 
+DEAL::dst FEV: 5541.555950 -11106.32200 5565.477537 37530.71560 -74989.85145 37459.18074 56526.44744 -113356.1837 56830.50646 
+DEAL::FEValues verification: 4.659014023e-17
+DEAL::
+DEAL::Working with FE_DGQ<2>(2) and 306 dofs
+DEAL::dst FEE: 2267.828876 -4298.962162 1970.695297 -5710.388281 12043.19895 -6201.217222 2830.230875 -6520.329369 3619.080662 
+DEAL::dst FEV: 2267.828876 -4298.962162 1970.695297 -5710.388281 12043.19895 -6201.217222 2830.230875 -6520.329369 3619.080662 
+DEAL::FEValues verification: 1.986598937e-16
+DEAL::
+DEAL::Working with FE_DGQ<3>(2) and 783 dofs
+DEAL::dst FEE: -1.079376460 89.40808533 0.7996118750 25.65297720 -324.9621084 25.27100001 71.41576118 135.3133609 -25.56984574 
+DEAL::dst FEV: -1.079376460 89.40808533 0.7996118750 25.65297720 -324.9621084 25.27100001 71.41576118 135.3133609 -25.56984574 
+DEAL::FEValues verification: 1.637165022e-16
+DEAL::
+DEAL::Working with FE_Q<1>(3) and 34 dofs
+DEAL::dst FEE: 3764159.177 -579923.7318 244401.0599 -329937.4551 -2582029.398 1446826.140 -1070949.952 23073986.22 -120056.8250 
+DEAL::dst FEV: 3764159.177 -579923.7318 244401.0599 -329937.4551 -2582029.398 1446826.140 -1070949.952 23073986.22 -120056.8250 
+DEAL::FEValues verification: 1.532409555e-16
+DEAL::
+DEAL::Working with FE_Q<2>(3) and 379 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 -345162.1557 712459.2763 145081.6219 -96632.94896 140707.6372 -148662.3424 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 -345162.1557 712459.2763 145081.6219 -96632.94896 140707.6372 -148662.3424 0.000000000 
+DEAL::FEValues verification: 9.197031597e-16
+DEAL::
+DEAL::Working with FE_Q<3>(3) and 1255 dofs
+DEAL::dst FEE: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -4090.212195 0.000000000 0.000000000 
+DEAL::dst FEV: 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 0.000000000 -4090.212195 0.000000000 0.000000000 
+DEAL::FEValues verification: 1.844320427e-15
+DEAL::
+DEAL::Working with FE_DGQ<1>(3) and 44 dofs
+DEAL::dst FEE: 244580.4286 -698057.9819 942646.8773 -489168.5892 -119687.0523 231031.1932 -171409.8509 60066.57406 -52416.70246 
+DEAL::dst FEV: 244580.4286 -698057.9819 942646.8773 -489168.5892 -119687.0523 231031.1932 -171409.8509 60066.57406 -52416.70246 
+DEAL::FEValues verification: 7.930124943e-17
+DEAL::
+DEAL::Working with FE_DGQ<2>(3) and 544 dofs
+DEAL::dst FEE: 7465.794708 -3551.410147 9374.513298 -8378.472180 580.0818997 -8375.531627 -28041.18632 27209.18345 -88433.89108 
+DEAL::dst FEV: 7465.794708 -3551.410147 9374.513298 -8378.472180 580.0818997 -8375.531627 -28041.18632 27209.18345 -88433.89108 
+DEAL::FEValues verification: 9.891995021e-16
+DEAL::
+DEAL::Working with FE_DGQ<3>(3) and 1856 dofs
+DEAL::dst FEE: 317.5283459 -263.9769617 250.2090596 -58.64507279 -482.2613703 498.3940843 -510.3936067 27.98633678 -1008.894377 
+DEAL::dst FEV: 317.5283459 -263.9769617 250.2090596 -58.64507279 -482.2613703 498.3940843 -510.3936067 27.98633678 -1008.894377 
+DEAL::FEValues verification: 1.844904033e-15
 DEAL::

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.