]> https://gitweb.dealii.org/ - dealii.git/commitdiff
missing files
authorGuido Kanschat <dr.guido.kanschat@gmail.com>
Tue, 6 Mar 2001 22:58:16 +0000 (22:58 +0000)
committerGuido Kanschat <dr.guido.kanschat@gmail.com>
Tue, 6 Mar 2001 22:58:16 +0000 (22:58 +0000)
git-svn-id: https://svn.dealii.org/trunk@4134 0785d39b-7218-0410-832d-ea1e28bc413d

tests/deal.II/derivatives.cc [new file with mode: 0644]
tests/deal.II/derivatives.checked [new file with mode: 0644]
tests/fe/derivatives.checked [new file with mode: 0644]
tests/fe/shapes.checked [new file with mode: 0644]

diff --git a/tests/deal.II/derivatives.cc b/tests/deal.II/derivatives.cc
new file mode 100644 (file)
index 0000000..0852579
--- /dev/null
@@ -0,0 +1,232 @@
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// (c) 2001 the deal.II authors
+//
+// purpose of this test:
+//
+// check 1st and 2nd order derivatives of continuous elements.
+//
+//
+// Method:
+//
+// solve  (u,v) = (f,v)
+//
+// Compute L2, H1 and H2 norm of the errors. Does not use VectorTools.
+//
+// The logfile checked in for comparison does not contain the errors.
+// There, we compute the L^2-norm of the derivatives. Change the variable
+// errors below to true to compute errors.
+//
+//----------------------------------------------------------------------
+
+const bool errors = false;
+
+
+#include <base/quadrature_lib.h>
+#include <base/function_lib.h>
+#include <lac/vector.h>
+#include <lac/vector_memory.h>
+#include <lac/sparse_matrix.h>
+#include <lac/solver_cg.h>
+#include <lac/precondition.h>
+#include <grid/tria.h>
+#include <grid/tria_iterator.h>
+#include <dofs/dof_accessor.h>
+#include <dofs/dof_tools.h>
+#include <grid/grid_generator.h>
+#include <fe/fe_q.h>
+#include <fe/fe_dgq.h>
+#include <fe/fe_system.h>
+#include <fe/mapping_cartesian.h>
+#include <fe/mapping_q1.h>
+#include <fe/mapping_q.h>
+#include <fe/fe_values.h>
+#include <numerics/data_out.h>
+#include <vector>
+#include <fstream>
+#include <string>
+
+
+template <int dim>
+void
+check (const unsigned int level,
+       const Mapping<dim>& mapping,
+       const FiniteElement<dim>& element,
+       const Quadrature<dim>& quadrature)
+{
+  Triangulation<dim> tr;
+
+  CosineFunction<dim> cosine;
+  
+  DoFHandler<dim> dof(tr);
+  if (dim==2)
+    GridGenerator::hyper_ball(tr);
+  else
+    GridGenerator::hyper_cube(tr, -1,1);
+  
+  tr.refine_global (level);
+  
+  dof.distribute_dofs(element);
+
+  FEValues<dim> fe (mapping, element, quadrature,
+                   update_values
+                   | update_q_points | update_JxW_values);
+
+  vector <unsigned int> global_dofs (element.dofs_per_cell);
+  vector <double> function (quadrature.n_quadrature_points);
+
+  Vector<double> u (dof.n_dofs ());
+  Vector<double> f (dof.n_dofs ());
+
+  SparsityPattern A_pattern (dof.n_dofs (), dof.n_dofs (),
+                            dof.max_couplings_between_dofs());
+  DoFTools::make_sparsity_pattern(dof, A_pattern);
+  A_pattern.compress ();
+  
+  SparseMatrix<double> A(A_pattern);
+  
+  DoFHandler<dim>::active_cell_iterator cell = dof.begin_active();
+  const DoFHandler<dim>::cell_iterator end = dof.end();
+
+  for (; cell != end;++cell)
+    {
+      fe.reinit(cell);
+      cell->get_dof_indices (global_dofs);
+      cosine.value_list (fe.get_quadrature_points(), function);
+
+      for (unsigned int k=0;k<quadrature.n_quadrature_points;++k)
+       {
+         double dx = fe.JxW (k);
+
+         for (unsigned int i=0;i<element.dofs_per_cell;++i)
+           {
+             const double v = fe.shape_value (i,k);
+             double rhs = dx * v * (function[k]);
+
+             f(global_dofs[i]) += rhs;
+             for (unsigned int j=0;j<element.dofs_per_cell;++j)
+               {
+                 const double u = fe.shape_value (j,k);
+                 double el = dx * (u*v/* + (Du*Dv) */);
+                 A.add (global_dofs[i], global_dofs[j], el);
+               }
+           }
+       }
+    }
+
+  SolverControl control (1000, 1.e-10, false, false);
+  PrimitiveVectorMemory<Vector<double> > mem;
+  SolverCG<Vector<double> > solver (control, mem);
+  PreconditionIdentity prec;
+  
+  solver.solve (A, u, f, prec);
+
+  FEValues<dim> fe2 (mapping, element, quadrature,
+                    update_values | update_gradients
+                    | update_second_derivatives
+                    | update_q_points | update_JxW_values);
+
+  double l2 = 0.;
+  double h1 = 0.;
+  double h2 = 0.;
+
+  vector<double> u_local (quadrature.n_quadrature_points);
+  vector<Tensor<1,dim> > Du (quadrature.n_quadrature_points);
+  vector<Tensor<1,dim> > Df (quadrature.n_quadrature_points);
+  vector<Tensor<2,dim> > DDu (quadrature.n_quadrature_points);
+  vector<Tensor<2,dim> > DDf (quadrature.n_quadrature_points);
+  
+  for (cell = dof.begin_active(); cell != end;++cell)
+    {
+      fe2.reinit (cell);
+      
+      cosine.value_list (fe2.get_quadrature_points(), function);
+      cosine.gradient_list (fe2.get_quadrature_points(), Df);
+      cosine.hessian_list (fe2.get_quadrature_points(), DDf);
+      fe2.get_function_values (u, u_local);
+      fe2.get_function_grads (u, Du);
+      fe2.get_function_2nd_derivatives (u,DDu);
+      
+      for (unsigned int k=0;k<quadrature.n_quadrature_points;++k)
+       {
+         const double dx = fe.JxW (k);
+         double e =  u_local[k];
+         if (errors) e -= function[k];
+         l2 += dx*e*e;
+         for (unsigned int i=0;i<dim;++i)
+           {
+             e = Du[k][i];
+             if (errors) e -= Df[k][i];
+             h1 += dx*e*e;
+             for (unsigned int j=0;j<dim;++j)
+               {
+                 e = DDu[k][i][j];
+                 if (errors) e -= DDf[k][i][j];
+                 h2 += dx*e*e;
+               }
+           }
+       }
+    }
+      deallog << "L2: " << l2 << endl;
+      deallog << "H1: " << h1 << endl;
+      deallog << "H2: " << h2 << endl;  
+}
+
+template <int dim>
+void loop ()
+{
+  QGauss<dim> gauss((dim<3) ? 6 : 4);
+
+  vector<Mapping<dim>*> maps;
+//  maps.push_back (new MappingCartesian<dim>);
+  maps.push_back (new MappingQ1<dim>);
+  maps.push_back (new MappingQ<dim>(2));
+
+  vector<FiniteElement<dim>*> elements;
+  elements.push_back (new FE_Q<dim> (1));
+  elements.push_back (new FE_Q<dim> (2));
+  elements.push_back (new FE_Q<dim> (3));
+  if (dim<3)
+    {
+      elements.push_back (new FE_Q<dim> (4));
+      elements.push_back (new FE_Q<dim> (5));
+    }
+  
+  elements.push_back (new FE_DGQ<dim> (1));
+  elements.push_back (new FE_DGQ<dim> (2));
+  elements.push_back (new FE_DGQ<dim> (3));
+  if (dim<3)
+    {
+      elements.push_back (new FE_DGQ<dim> (4));
+      elements.push_back (new FE_DGQ<dim> (5));
+    }
+  
+  for (unsigned int m=0;m<maps.size();++m)
+    for (unsigned int e=0;e<elements.size();++e)
+    {
+      check (1, *maps[m], *elements[e], gauss);
+//      check (2, *maps[m], *elements[e], gauss);
+    }
+}
+
+
+int main ()
+{
+  ofstream logfile ("derivatives.output");
+  logfile.precision (2);
+  logfile.setf(ios::fixed);  
+  deallog.attach(logfile);
+  if (!errors) deallog.depth_console(0);
+
+  deallog.push ("1d");
+  loop<1> ();
+  deallog.pop ();
+  deallog.push ("2d");
+  loop<2> ();
+  deallog.pop ();
+  deallog.push ("3d");
+  loop<3> ();
+  deallog.pop ();
+}
diff --git a/tests/deal.II/derivatives.checked b/tests/deal.II/derivatives.checked
new file mode 100644 (file)
index 0000000..3a3d97e
--- /dev/null
@@ -0,0 +1,157 @@
+
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.53
+DEAL:1d::H2: 0.00
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.50
+DEAL:1d::H2: 5.78
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.47
+DEAL:1d::H2: 6.27
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.47
+DEAL:1d::H2: 6.09
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.47
+DEAL:1d::H2: 6.09
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.39
+DEAL:1d::H2: 0.00
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.52
+DEAL:1d::H2: 5.96
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.47
+DEAL:1d::H2: 6.26
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.47
+DEAL:1d::H2: 6.09
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.47
+DEAL:1d::H2: 6.09
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.53
+DEAL:1d::H2: 0.00
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.50
+DEAL:1d::H2: 5.78
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.47
+DEAL:1d::H2: 6.27
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.47
+DEAL:1d::H2: 6.09
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.47
+DEAL:1d::H2: 6.09
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.39
+DEAL:1d::H2: 0.00
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.52
+DEAL:1d::H2: 5.96
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.47
+DEAL:1d::H2: 6.26
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.47
+DEAL:1d::H2: 6.09
+DEAL:1d::L2: 1.00
+DEAL:1d::H1: 2.47
+DEAL:1d::H2: 6.09
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.76
+DEAL:2d::H2: 2.25
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.99
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.78
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.69
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.69
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.73
+DEAL:2d::H2: 2.27
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.90
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.78
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.69
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.69
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.76
+DEAL:2d::H2: 2.25
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.99
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.78
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.69
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.69
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.73
+DEAL:2d::H2: 2.27
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.90
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.78
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.69
+DEAL:2d::L2: 1.38
+DEAL:2d::H1: 2.71
+DEAL:2d::H2: 19.69
+DEAL:3d::L2: 1.00
+DEAL:3d::H1: 7.58
+DEAL:3d::H2: 38.35
+DEAL:3d::L2: 1.00
+DEAL:3d::H1: 7.49
+DEAL:3d::H2: 54.78
+DEAL:3d::L2: 1.00
+DEAL:3d::H1: 7.40
+DEAL:3d::H2: 55.34
+DEAL:3d::L2: 1.00
+DEAL:3d::H1: 7.17
+DEAL:3d::H2: 34.32
+DEAL:3d::L2: 1.00
+DEAL:3d::H1: 7.55
+DEAL:3d::H2: 55.86
+DEAL:3d::L2: 1.00
+DEAL:3d::H1: 7.40
+DEAL:3d::H2: 55.35
+DEAL:3d::L2: 1.00
+DEAL:3d::H1: 7.58
+DEAL:3d::H2: 38.35
+DEAL:3d::L2: 1.00
+DEAL:3d::H1: 7.49
+DEAL:3d::H2: 54.78
+DEAL:3d::L2: 1.00
+DEAL:3d::H1: 7.40
+DEAL:3d::H2: 55.34
+DEAL:3d::L2: 1.00
+DEAL:3d::H1: 7.17
+DEAL:3d::H2: 34.32
+DEAL:3d::L2: 1.00
+DEAL:3d::H1: 7.55
+DEAL:3d::H2: 55.86
+DEAL:3d::L2: 1.00
+DEAL:3d::H1: 7.40
+DEAL:3d::H2: 55.35
diff --git a/tests/fe/derivatives.checked b/tests/fe/derivatives.checked
new file mode 100644 (file)
index 0000000..dc0ff1f
--- /dev/null
@@ -0,0 +1,501 @@
+
+DEAL:1d:Q1::0.00
+DEAL:1d:Q1::   Grad -0.33      2nd 0.00
+DEAL:1d:Q1::   Grad 0.33       2nd 0.00
+DEAL:1d:Q1::1.00
+DEAL:1d:Q1::   Grad -0.33      2nd 0.00
+DEAL:1d:Q1::   Grad 0.33       2nd 0.00
+DEAL:1d:Q2::0.00
+DEAL:1d:Q2::   Grad -1.00      2nd 0.44
+DEAL:1d:Q2::   Grad -0.33      2nd 0.44
+DEAL:1d:Q2::   Grad 1.33       2nd -0.89
+DEAL:1d:Q2::1.00
+DEAL:1d:Q2::   Grad 0.33       2nd 0.44
+DEAL:1d:Q2::   Grad 1.00       2nd 0.44
+DEAL:1d:Q2::   Grad -1.33      2nd -0.89
+DEAL:1d:Q3::0.00
+DEAL:1d:Q3::   Grad -1.83      2nd 2.00
+DEAL:1d:Q3::   Grad 0.33       2nd -1.00
+DEAL:1d:Q3::   Grad 3.00       2nd -5.00
+DEAL:1d:Q3::   Grad -1.50      2nd 4.00
+DEAL:1d:Q3::1.00
+DEAL:1d:Q3::   Grad -0.33      2nd -1.00
+DEAL:1d:Q3::   Grad 1.83       2nd 2.00
+DEAL:1d:Q3::   Grad 1.50       2nd 4.00
+DEAL:1d:Q3::   Grad -3.00      2nd -5.00
+DEAL:1d:Q4::0.00
+DEAL:1d:Q4::   Grad -2.78      2nd 5.19
+DEAL:1d:Q4::   Grad -0.33      2nd 1.63
+DEAL:1d:Q4::   Grad 5.33       2nd -15.41
+DEAL:1d:Q4::   Grad -4.00      2nd 16.89
+DEAL:1d:Q4::   Grad 1.78       2nd -8.30
+DEAL:1d:Q4::1.00
+DEAL:1d:Q4::   Grad 0.33       2nd 1.63
+DEAL:1d:Q4::   Grad 2.78       2nd 5.19
+DEAL:1d:Q4::   Grad -1.78      2nd -8.30
+DEAL:1d:Q4::   Grad 4.00       2nd 16.89
+DEAL:1d:Q4::   Grad -5.33      2nd -15.41
+DEAL:2d:Q1::0.00 0.00
+DEAL:2d:Q1::   Grad -0.33 -0.33        2nd 0.00 0.11 0.11 0.00
+DEAL:2d:Q1::   Grad 0.33 0.00  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:Q1::   Grad 0.00 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:Q1::   Grad 0.00 0.33  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:Q1::0.00 1.00
+DEAL:2d:Q1::   Grad 0.00 -0.33 2nd 0.00 0.11 0.11 0.00
+DEAL:2d:Q1::   Grad 0.00 0.00  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:Q1::   Grad 0.33 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:Q1::   Grad -0.33 0.33 2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:Q1::1.00 0.00
+DEAL:2d:Q1::   Grad -0.33 0.00 2nd 0.00 0.11 0.11 0.00
+DEAL:2d:Q1::   Grad 0.33 -0.33 2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:Q1::   Grad 0.00 0.33  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:Q1::   Grad 0.00 0.00  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:Q1::1.00 1.00
+DEAL:2d:Q1::   Grad 0.00 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:Q1::   Grad 0.00 -0.33 2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:Q1::   Grad 0.33 0.33  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:Q1::   Grad -0.33 0.00 2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:Q2::0.00 0.00
+DEAL:2d:Q2::   Grad -1.00 -1.00        2nd 0.44 1.00 1.00 0.44
+DEAL:2d:Q2::   Grad -0.33 0.00 2nd 0.44 0.33 0.33 0.00
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:Q2::   Grad 0.00 -0.33 2nd 0.00 0.33 0.33 0.44
+DEAL:2d:Q2::   Grad 1.33 0.00  2nd -0.89 -1.33 -1.33 0.00
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 -0.44 -0.44 0.00
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 -0.44 -0.44 0.00
+DEAL:2d:Q2::   Grad 0.00 1.33  2nd 0.00 -1.33 -1.33 -0.89
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 1.78 1.78 0.00
+DEAL:2d:Q2::0.00 1.00
+DEAL:2d:Q2::   Grad 0.00 0.33  2nd 0.00 -0.33 -0.33 0.44
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:Q2::   Grad -0.33 0.00 2nd 0.44 -0.33 -0.33 0.00
+DEAL:2d:Q2::   Grad -1.00 1.00 2nd 0.44 -1.00 -1.00 0.44
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 0.44 0.44 0.00
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 0.44 0.44 0.00
+DEAL:2d:Q2::   Grad 1.33 0.00  2nd -0.89 1.33 1.33 0.00
+DEAL:2d:Q2::   Grad 0.00 -1.33 2nd 0.00 1.33 1.33 -0.89
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 -1.78 -1.78 0.00
+DEAL:2d:Q2::1.00 0.00
+DEAL:2d:Q2::   Grad 0.33 0.00  2nd 0.44 -0.33 -0.33 0.00
+DEAL:2d:Q2::   Grad 1.00 -1.00 2nd 0.44 -1.00 -1.00 0.44
+DEAL:2d:Q2::   Grad 0.00 -0.33 2nd 0.00 -0.33 -0.33 0.44
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:Q2::   Grad -1.33 0.00 2nd -0.89 1.33 1.33 0.00
+DEAL:2d:Q2::   Grad 0.00 1.33  2nd 0.00 1.33 1.33 -0.89
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 0.44 0.44 0.00
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 0.44 0.44 0.00
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 -1.78 -1.78 0.00
+DEAL:2d:Q2::1.00 1.00
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:Q2::   Grad 0.00 0.33  2nd 0.00 0.33 0.33 0.44
+DEAL:2d:Q2::   Grad 1.00 1.00  2nd 0.44 1.00 1.00 0.44
+DEAL:2d:Q2::   Grad 0.33 0.00  2nd 0.44 0.33 0.33 0.00
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 -0.44 -0.44 0.00
+DEAL:2d:Q2::   Grad 0.00 -1.33 2nd 0.00 -1.33 -1.33 -0.89
+DEAL:2d:Q2::   Grad -1.33 0.00 2nd -0.89 -1.33 -1.33 0.00
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 -0.44 -0.44 0.00
+DEAL:2d:Q2::   Grad 0.00 0.00  2nd 0.00 1.78 1.78 0.00
+DEAL:2d:Q3::0.00 0.00
+DEAL:2d:Q3::   Grad -1.83 -1.83        2nd 2.00 3.36 3.36 2.00
+DEAL:2d:Q3::   Grad 0.33 0.00  2nd -1.00 -0.61 -0.61 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:Q3::   Grad 0.00 0.33  2nd 0.00 -0.61 -0.61 -1.00
+DEAL:2d:Q3::   Grad 3.00 0.00  2nd -5.00 -5.50 -5.50 0.00
+DEAL:2d:Q3::   Grad -1.50 0.00 2nd 4.00 2.75 2.75 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 1.00 1.00 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -0.50 -0.50 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 1.00 1.00 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -0.50 -0.50 0.00
+DEAL:2d:Q3::   Grad 0.00 3.00  2nd 0.00 -5.50 -5.50 -5.00
+DEAL:2d:Q3::   Grad 0.00 -1.50 2nd 0.00 2.75 2.75 4.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 9.00 9.00 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -4.50 -4.50 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -4.50 -4.50 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 2.25 2.25 0.00
+DEAL:2d:Q3::0.00 1.00
+DEAL:2d:Q3::   Grad 0.00 -0.33 2nd 0.00 0.61 0.61 -1.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:Q3::   Grad 0.33 0.00  2nd -1.00 0.61 0.61 0.00
+DEAL:2d:Q3::   Grad -1.83 1.83 2nd 2.00 -3.36 -3.36 2.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -1.00 -1.00 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 0.50 0.50 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 0.50 0.50 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -1.00 -1.00 0.00
+DEAL:2d:Q3::   Grad 3.00 0.00  2nd -5.00 5.50 5.50 0.00
+DEAL:2d:Q3::   Grad -1.50 0.00 2nd 4.00 -2.75 -2.75 0.00
+DEAL:2d:Q3::   Grad 0.00 1.50  2nd 0.00 -2.75 -2.75 4.00
+DEAL:2d:Q3::   Grad 0.00 -3.00 2nd 0.00 5.50 5.50 -5.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 4.50 4.50 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -2.25 -2.25 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -9.00 -9.00 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 4.50 4.50 0.00
+DEAL:2d:Q3::1.00 0.00
+DEAL:2d:Q3::   Grad -0.33 0.00 2nd -1.00 0.61 0.61 0.00
+DEAL:2d:Q3::   Grad 1.83 -1.83 2nd 2.00 -3.36 -3.36 2.00
+DEAL:2d:Q3::   Grad 0.00 0.33  2nd 0.00 0.61 0.61 -1.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:Q3::   Grad 1.50 0.00  2nd 4.00 -2.75 -2.75 0.00
+DEAL:2d:Q3::   Grad -3.00 0.00 2nd -5.00 5.50 5.50 0.00
+DEAL:2d:Q3::   Grad 0.00 3.00  2nd 0.00 5.50 5.50 -5.00
+DEAL:2d:Q3::   Grad 0.00 -1.50 2nd 0.00 -2.75 -2.75 4.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 0.50 0.50 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -1.00 -1.00 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -1.00 -1.00 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 0.50 0.50 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 4.50 4.50 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -9.00 -9.00 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -2.25 -2.25 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 4.50 4.50 0.00
+DEAL:2d:Q3::1.00 1.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:Q3::   Grad 0.00 -0.33 2nd 0.00 -0.61 -0.61 -1.00
+DEAL:2d:Q3::   Grad 1.83 1.83  2nd 2.00 3.36 3.36 2.00
+DEAL:2d:Q3::   Grad -0.33 0.00 2nd -1.00 -0.61 -0.61 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -0.50 -0.50 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 1.00 1.00 0.00
+DEAL:2d:Q3::   Grad 0.00 1.50  2nd 0.00 2.75 2.75 4.00
+DEAL:2d:Q3::   Grad 0.00 -3.00 2nd 0.00 -5.50 -5.50 -5.00
+DEAL:2d:Q3::   Grad 1.50 0.00  2nd 4.00 2.75 2.75 0.00
+DEAL:2d:Q3::   Grad -3.00 0.00 2nd -5.00 -5.50 -5.50 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -0.50 -0.50 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 1.00 1.00 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 2.25 2.25 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -4.50 -4.50 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 -4.50 -4.50 0.00
+DEAL:2d:Q3::   Grad 0.00 0.00  2nd 0.00 9.00 9.00 0.00
+DEAL:2d:Q4::0.00 0.00
+DEAL:2d:Q4::   Grad -2.78 -2.78        2nd 5.19 7.72 7.72 5.19
+DEAL:2d:Q4::   Grad -0.33 0.00 2nd 1.63 0.93 0.93 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:Q4::   Grad 0.00 -0.33 2nd 0.00 0.93 0.93 1.63
+DEAL:2d:Q4::   Grad 5.33 0.00  2nd -15.41 -14.81 -14.81 0.00
+DEAL:2d:Q4::   Grad -4.00 0.00 2nd 16.89 11.11 11.11 0.00
+DEAL:2d:Q4::   Grad 1.78 0.00  2nd -8.30 -4.94 -4.94 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -1.78 -1.78 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 1.33 1.33 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -0.59 -0.59 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -1.78 -1.78 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 1.33 1.33 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -0.59 -0.59 0.00
+DEAL:2d:Q4::   Grad 0.00 5.33  2nd 0.00 -14.81 -14.81 -15.41
+DEAL:2d:Q4::   Grad 0.00 -4.00 2nd 0.00 11.11 11.11 16.89
+DEAL:2d:Q4::   Grad 0.00 1.78  2nd 0.00 -4.94 -4.94 -8.30
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 28.44 28.44 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -21.33 -21.33 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 9.48 9.48 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -21.33 -21.33 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 16.00 16.00 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -7.11 -7.11 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 9.48 9.48 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -7.11 -7.11 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 3.16 3.16 0.00
+DEAL:2d:Q4::0.00 1.00
+DEAL:2d:Q4::   Grad 0.00 0.33  2nd -0.00 -0.93 -0.93 1.63
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd -0.00 -0.11 -0.11 0.00
+DEAL:2d:Q4::   Grad -0.33 0.00 2nd 1.63 -0.93 -0.93 0.00
+DEAL:2d:Q4::   Grad -2.78 2.78 2nd 5.19 -7.72 -7.72 5.19
+DEAL:2d:Q4::   Grad -0.00 0.00 2nd 0.00 1.78 1.78 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd -0.00 -1.33 -1.33 0.00
+DEAL:2d:Q4::   Grad -0.00 0.00 2nd 0.00 0.59 0.59 0.00
+DEAL:2d:Q4::   Grad -0.00 0.00 2nd 0.00 0.59 0.59 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -1.33 -1.33 0.00
+DEAL:2d:Q4::   Grad -0.00 0.00 2nd 0.00 1.78 1.78 0.00
+DEAL:2d:Q4::   Grad 5.33 0.00  2nd -15.41 14.81 14.81 0.00
+DEAL:2d:Q4::   Grad -4.00 0.00 2nd 16.89 -11.11 -11.11 0.00
+DEAL:2d:Q4::   Grad 1.78 0.00  2nd -8.30 4.94 4.94 0.00
+DEAL:2d:Q4::   Grad -0.00 -1.78        2nd 0.00 4.94 4.94 -8.30
+DEAL:2d:Q4::   Grad 0.00 4.00  2nd 0.00 -11.11 -11.11 16.89
+DEAL:2d:Q4::   Grad -0.00 -5.33        2nd 0.00 14.81 14.81 -15.41
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd -0.00 -9.48 -9.48 0.00
+DEAL:2d:Q4::   Grad -0.00 0.00 2nd 0.00 7.11 7.11 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd -0.00 -3.16 -3.16 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 21.33 21.33 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -16.00 -16.00 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 7.11 7.11 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd -0.00 -28.44 -28.44 0.00
+DEAL:2d:Q4::   Grad -0.00 0.00 2nd 0.00 21.33 21.33 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd -0.00 -9.48 -9.48 0.00
+DEAL:2d:Q4::1.00 0.00
+DEAL:2d:Q4::   Grad 0.33 0.00  2nd 1.63 -0.93 -0.93 -0.00
+DEAL:2d:Q4::   Grad 2.78 -2.78 2nd 5.19 -7.72 -7.72 5.19
+DEAL:2d:Q4::   Grad 0.00 -0.33 2nd 0.00 -0.93 -0.93 1.63
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -0.11 -0.11 -0.00
+DEAL:2d:Q4::   Grad -1.78 -0.00        2nd -8.30 4.94 4.94 0.00
+DEAL:2d:Q4::   Grad 4.00 0.00  2nd 16.89 -11.11 -11.11 0.00
+DEAL:2d:Q4::   Grad -5.33 -0.00        2nd -15.41 14.81 14.81 0.00
+DEAL:2d:Q4::   Grad 0.00 5.33  2nd 0.00 14.81 14.81 -15.41
+DEAL:2d:Q4::   Grad 0.00 -4.00 2nd 0.00 -11.11 -11.11 16.89
+DEAL:2d:Q4::   Grad 0.00 1.78  2nd 0.00 4.94 4.94 -8.30
+DEAL:2d:Q4::   Grad 0.00 -0.00 2nd 0.00 0.59 0.59 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -1.33 -1.33 0.00
+DEAL:2d:Q4::   Grad 0.00 -0.00 2nd 0.00 1.78 1.78 0.00
+DEAL:2d:Q4::   Grad 0.00 -0.00 2nd 0.00 1.78 1.78 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -1.33 -1.33 -0.00
+DEAL:2d:Q4::   Grad 0.00 -0.00 2nd 0.00 0.59 0.59 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -9.48 -9.48 -0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 21.33 21.33 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -28.44 -28.44 -0.00
+DEAL:2d:Q4::   Grad 0.00 -0.00 2nd 0.00 7.11 7.11 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -16.00 -16.00 0.00
+DEAL:2d:Q4::   Grad 0.00 -0.00 2nd 0.00 21.33 21.33 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -3.16 -3.16 -0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 7.11 7.11 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -9.48 -9.48 -0.00
+DEAL:2d:Q4::1.00 1.00
+DEAL:2d:Q4::   Grad -0.00 -0.00        2nd -0.00 0.11 0.11 -0.00
+DEAL:2d:Q4::   Grad -0.00 0.33 2nd -0.00 0.93 0.93 1.63
+DEAL:2d:Q4::   Grad 2.78 2.78  2nd 5.19 7.72 7.72 5.19
+DEAL:2d:Q4::   Grad 0.33 -0.00 2nd 1.63 0.93 0.93 -0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -0.59 -0.59 0.00
+DEAL:2d:Q4::   Grad -0.00 0.00 2nd -0.00 1.33 1.33 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -1.78 -1.78 0.00
+DEAL:2d:Q4::   Grad 0.00 -1.78 2nd 0.00 -4.94 -4.94 -8.30
+DEAL:2d:Q4::   Grad 0.00 4.00  2nd 0.00 11.11 11.11 16.89
+DEAL:2d:Q4::   Grad 0.00 -5.33 2nd 0.00 -14.81 -14.81 -15.41
+DEAL:2d:Q4::   Grad -1.78 0.00 2nd -8.30 -4.94 -4.94 0.00
+DEAL:2d:Q4::   Grad 4.00 0.00  2nd 16.89 11.11 11.11 0.00
+DEAL:2d:Q4::   Grad -5.33 0.00 2nd -15.41 -14.81 -14.81 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -0.59 -0.59 0.00
+DEAL:2d:Q4::   Grad 0.00 -0.00 2nd 0.00 1.33 1.33 -0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -1.78 -1.78 0.00
+DEAL:2d:Q4::   Grad -0.00 -0.00        2nd -0.00 3.16 3.16 -0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -7.11 -7.11 0.00
+DEAL:2d:Q4::   Grad -0.00 -0.00        2nd -0.00 9.48 9.48 -0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -7.11 -7.11 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 16.00 16.00 0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -21.33 -21.33 0.00
+DEAL:2d:Q4::   Grad -0.00 -0.00        2nd -0.00 9.48 9.48 -0.00
+DEAL:2d:Q4::   Grad 0.00 0.00  2nd 0.00 -21.33 -21.33 0.00
+DEAL:2d:Q4::   Grad -0.00 -0.00        2nd -0.00 28.44 28.44 -0.00
+DEAL:2d:DGQ1::0.00 0.00
+DEAL:2d:DGQ1:: Grad -0.33 -0.33        2nd 0.00 0.11 0.11 0.00
+DEAL:2d:DGQ1:: Grad 0.33 0.00  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:DGQ1:: Grad 0.00 0.33  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:DGQ1:: Grad 0.00 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:DGQ1::0.00 1.00
+DEAL:2d:DGQ1:: Grad 0.00 -0.33 2nd 0.00 0.11 0.11 0.00
+DEAL:2d:DGQ1:: Grad 0.00 0.00  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:DGQ1:: Grad -0.33 0.33 2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:DGQ1:: Grad 0.33 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:DGQ1::1.00 0.00
+DEAL:2d:DGQ1:: Grad -0.33 0.00 2nd 0.00 0.11 0.11 0.00
+DEAL:2d:DGQ1:: Grad 0.33 -0.33 2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:DGQ1:: Grad 0.00 0.00  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:DGQ1:: Grad 0.00 0.33  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:DGQ1::1.00 1.00
+DEAL:2d:DGQ1:: Grad 0.00 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:DGQ1:: Grad 0.00 -0.33 2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:DGQ1:: Grad -0.33 0.00 2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:DGQ1:: Grad 0.33 0.33  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:DGQ2::0.00 0.00
+DEAL:2d:DGQ2:: Grad -1.00 -1.00        2nd 0.44 1.00 1.00 0.44
+DEAL:2d:DGQ2:: Grad 1.33 0.00  2nd -0.89 -1.33 -1.33 0.00
+DEAL:2d:DGQ2:: Grad -0.33 0.00 2nd 0.44 0.33 0.33 0.00
+DEAL:2d:DGQ2:: Grad 0.00 1.33  2nd 0.00 -1.33 -1.33 -0.89
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 1.78 1.78 0.00
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 -0.44 -0.44 0.00
+DEAL:2d:DGQ2:: Grad 0.00 -0.33 2nd 0.00 0.33 0.33 0.44
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 -0.44 -0.44 0.00
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:DGQ2::0.00 1.00
+DEAL:2d:DGQ2:: Grad 0.00 0.33  2nd 0.00 -0.33 -0.33 0.44
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 0.44 0.44 0.00
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:DGQ2:: Grad 0.00 -1.33 2nd 0.00 1.33 1.33 -0.89
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 -1.78 -1.78 0.00
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 0.44 0.44 0.00
+DEAL:2d:DGQ2:: Grad -1.00 1.00 2nd 0.44 -1.00 -1.00 0.44
+DEAL:2d:DGQ2:: Grad 1.33 0.00  2nd -0.89 1.33 1.33 0.00
+DEAL:2d:DGQ2:: Grad -0.33 0.00 2nd 0.44 -0.33 -0.33 0.00
+DEAL:2d:DGQ2::1.00 0.00
+DEAL:2d:DGQ2:: Grad 0.33 0.00  2nd 0.44 -0.33 -0.33 0.00
+DEAL:2d:DGQ2:: Grad -1.33 0.00 2nd -0.89 1.33 1.33 0.00
+DEAL:2d:DGQ2:: Grad 1.00 -1.00 2nd 0.44 -1.00 -1.00 0.44
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 0.44 0.44 0.00
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 -1.78 -1.78 0.00
+DEAL:2d:DGQ2:: Grad 0.00 1.33  2nd 0.00 1.33 1.33 -0.89
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 0.44 0.44 0.00
+DEAL:2d:DGQ2:: Grad 0.00 -0.33 2nd 0.00 -0.33 -0.33 0.44
+DEAL:2d:DGQ2::1.00 1.00
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 -0.44 -0.44 0.00
+DEAL:2d:DGQ2:: Grad 0.00 0.33  2nd 0.00 0.33 0.33 0.44
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 -0.44 -0.44 0.00
+DEAL:2d:DGQ2:: Grad 0.00 0.00  2nd 0.00 1.78 1.78 0.00
+DEAL:2d:DGQ2:: Grad 0.00 -1.33 2nd 0.00 -1.33 -1.33 -0.89
+DEAL:2d:DGQ2:: Grad 0.33 0.00  2nd 0.44 0.33 0.33 0.00
+DEAL:2d:DGQ2:: Grad -1.33 0.00 2nd -0.89 -1.33 -1.33 0.00
+DEAL:2d:DGQ2:: Grad 1.00 1.00  2nd 0.44 1.00 1.00 0.44
+DEAL:2d:DGQ3::0.00 0.00
+DEAL:2d:DGQ3:: Grad -1.83 -1.83        2nd 2.00 3.36 3.36 2.00
+DEAL:2d:DGQ3:: Grad 3.00 0.00  2nd -5.00 -5.50 -5.50 0.00
+DEAL:2d:DGQ3:: Grad -1.50 0.00 2nd 4.00 2.75 2.75 0.00
+DEAL:2d:DGQ3:: Grad 0.33 0.00  2nd -1.00 -0.61 -0.61 0.00
+DEAL:2d:DGQ3:: Grad 0.00 3.00  2nd 0.00 -5.50 -5.50 -5.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 9.00 9.00 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -4.50 -4.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 1.00 1.00 0.00
+DEAL:2d:DGQ3:: Grad 0.00 -1.50 2nd 0.00 2.75 2.75 4.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -4.50 -4.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 2.25 2.25 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -0.50 -0.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.33  2nd 0.00 -0.61 -0.61 -1.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 1.00 1.00 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -0.50 -0.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:DGQ3::0.00 1.00
+DEAL:2d:DGQ3:: Grad 0.00 -0.33 2nd 0.00 0.61 0.61 -1.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -1.00 -1.00 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 0.50 0.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:DGQ3:: Grad 0.00 1.50  2nd 0.00 -2.75 -2.75 4.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 4.50 4.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -2.25 -2.25 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 0.50 0.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 -3.00 2nd 0.00 5.50 5.50 -5.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -9.00 -9.00 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 4.50 4.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -1.00 -1.00 0.00
+DEAL:2d:DGQ3:: Grad -1.83 1.83 2nd 2.00 -3.36 -3.36 2.00
+DEAL:2d:DGQ3:: Grad 3.00 0.00  2nd -5.00 5.50 5.50 0.00
+DEAL:2d:DGQ3:: Grad -1.50 0.00 2nd 4.00 -2.75 -2.75 0.00
+DEAL:2d:DGQ3:: Grad 0.33 0.00  2nd -1.00 0.61 0.61 0.00
+DEAL:2d:DGQ3::1.00 0.00
+DEAL:2d:DGQ3:: Grad -0.33 0.00 2nd -1.00 0.61 0.61 0.00
+DEAL:2d:DGQ3:: Grad 1.50 0.00  2nd 4.00 -2.75 -2.75 0.00
+DEAL:2d:DGQ3:: Grad -3.00 0.00 2nd -5.00 5.50 5.50 0.00
+DEAL:2d:DGQ3:: Grad 1.83 -1.83 2nd 2.00 -3.36 -3.36 2.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -1.00 -1.00 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 4.50 4.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -9.00 -9.00 0.00
+DEAL:2d:DGQ3:: Grad 0.00 3.00  2nd 0.00 5.50 5.50 -5.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 0.50 0.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -2.25 -2.25 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 4.50 4.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 -1.50 2nd 0.00 -2.75 -2.75 4.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -0.11 -0.11 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 0.50 0.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -1.00 -1.00 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.33  2nd 0.00 0.61 0.61 -1.00
+DEAL:2d:DGQ3::1.00 1.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -0.50 -0.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 1.00 1.00 0.00
+DEAL:2d:DGQ3:: Grad 0.00 -0.33 2nd 0.00 -0.61 -0.61 -1.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -0.50 -0.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 2.25 2.25 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -4.50 -4.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 1.50  2nd 0.00 2.75 2.75 4.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 1.00 1.00 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 -4.50 -4.50 0.00
+DEAL:2d:DGQ3:: Grad 0.00 0.00  2nd 0.00 9.00 9.00 0.00
+DEAL:2d:DGQ3:: Grad 0.00 -3.00 2nd 0.00 -5.50 -5.50 -5.00
+DEAL:2d:DGQ3:: Grad -0.33 0.00 2nd -1.00 -0.61 -0.61 0.00
+DEAL:2d:DGQ3:: Grad 1.50 0.00  2nd 4.00 2.75 2.75 0.00
+DEAL:2d:DGQ3:: Grad -3.00 0.00 2nd -5.00 -5.50 -5.50 0.00
+DEAL:2d:DGQ3:: Grad 1.83 1.83  2nd 2.00 3.36 3.36 2.00
+DEAL:2d:DGQ4::0.00 0.00
+DEAL:2d:DGQ4:: Grad -2.78 -2.78        2nd 5.19 7.72 7.72 5.19
+DEAL:2d:DGQ4:: Grad 5.33 0.00  2nd -15.41 -14.81 -14.81 0.00
+DEAL:2d:DGQ4:: Grad -4.00 0.00 2nd 16.89 11.11 11.11 0.00
+DEAL:2d:DGQ4:: Grad 1.78 0.00  2nd -8.30 -4.94 -4.94 0.00
+DEAL:2d:DGQ4:: Grad -0.33 0.00 2nd 1.63 0.93 0.93 0.00
+DEAL:2d:DGQ4:: Grad 0.00 5.33  2nd 0.00 -14.81 -14.81 -15.41
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 28.44 28.44 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -21.33 -21.33 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 9.48 9.48 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -1.78 -1.78 0.00
+DEAL:2d:DGQ4:: Grad 0.00 -4.00 2nd 0.00 11.11 11.11 16.89
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -21.33 -21.33 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 16.00 16.00 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -7.11 -7.11 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 1.33 1.33 0.00
+DEAL:2d:DGQ4:: Grad 0.00 1.78  2nd 0.00 -4.94 -4.94 -8.30
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 9.48 9.48 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -7.11 -7.11 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 3.16 3.16 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -0.59 -0.59 0.00
+DEAL:2d:DGQ4:: Grad 0.00 -0.33 2nd 0.00 0.93 0.93 1.63
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -1.78 -1.78 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 1.33 1.33 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -0.59 -0.59 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 0.11 0.11 0.00
+DEAL:2d:DGQ4::0.00 1.00
+DEAL:2d:DGQ4:: Grad 0.00 0.33  2nd -0.00 -0.93 -0.93 1.63
+DEAL:2d:DGQ4:: Grad -0.00 0.00 2nd 0.00 1.78 1.78 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd -0.00 -1.33 -1.33 0.00
+DEAL:2d:DGQ4:: Grad -0.00 0.00 2nd 0.00 0.59 0.59 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd -0.00 -0.11 -0.11 0.00
+DEAL:2d:DGQ4:: Grad -0.00 -1.78        2nd 0.00 4.94 4.94 -8.30
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd -0.00 -9.48 -9.48 0.00
+DEAL:2d:DGQ4:: Grad -0.00 0.00 2nd 0.00 7.11 7.11 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd -0.00 -3.16 -3.16 0.00
+DEAL:2d:DGQ4:: Grad -0.00 0.00 2nd 0.00 0.59 0.59 0.00
+DEAL:2d:DGQ4:: Grad 0.00 4.00  2nd 0.00 -11.11 -11.11 16.89
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 21.33 21.33 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -16.00 -16.00 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 7.11 7.11 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -1.33 -1.33 0.00
+DEAL:2d:DGQ4:: Grad -0.00 -5.33        2nd 0.00 14.81 14.81 -15.41
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd -0.00 -28.44 -28.44 0.00
+DEAL:2d:DGQ4:: Grad -0.00 0.00 2nd 0.00 21.33 21.33 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd -0.00 -9.48 -9.48 0.00
+DEAL:2d:DGQ4:: Grad -0.00 0.00 2nd 0.00 1.78 1.78 0.00
+DEAL:2d:DGQ4:: Grad -2.78 2.78 2nd 5.19 -7.72 -7.72 5.19
+DEAL:2d:DGQ4:: Grad 5.33 0.00  2nd -15.41 14.81 14.81 0.00
+DEAL:2d:DGQ4:: Grad -4.00 0.00 2nd 16.89 -11.11 -11.11 0.00
+DEAL:2d:DGQ4:: Grad 1.78 0.00  2nd -8.30 4.94 4.94 0.00
+DEAL:2d:DGQ4:: Grad -0.33 0.00 2nd 1.63 -0.93 -0.93 0.00
+DEAL:2d:DGQ4::1.00 0.00
+DEAL:2d:DGQ4:: Grad 0.33 0.00  2nd 1.63 -0.93 -0.93 -0.00
+DEAL:2d:DGQ4:: Grad -1.78 -0.00        2nd -8.30 4.94 4.94 0.00
+DEAL:2d:DGQ4:: Grad 4.00 0.00  2nd 16.89 -11.11 -11.11 0.00
+DEAL:2d:DGQ4:: Grad -5.33 -0.00        2nd -15.41 14.81 14.81 0.00
+DEAL:2d:DGQ4:: Grad 2.78 -2.78 2nd 5.19 -7.72 -7.72 5.19
+DEAL:2d:DGQ4:: Grad 0.00 -0.00 2nd 0.00 1.78 1.78 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -9.48 -9.48 -0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 21.33 21.33 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -28.44 -28.44 -0.00
+DEAL:2d:DGQ4:: Grad 0.00 5.33  2nd 0.00 14.81 14.81 -15.41
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -1.33 -1.33 -0.00
+DEAL:2d:DGQ4:: Grad 0.00 -0.00 2nd 0.00 7.11 7.11 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -16.00 -16.00 0.00
+DEAL:2d:DGQ4:: Grad 0.00 -0.00 2nd 0.00 21.33 21.33 0.00
+DEAL:2d:DGQ4:: Grad 0.00 -4.00 2nd 0.00 -11.11 -11.11 16.89
+DEAL:2d:DGQ4:: Grad 0.00 -0.00 2nd 0.00 0.59 0.59 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -3.16 -3.16 -0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 7.11 7.11 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -9.48 -9.48 -0.00
+DEAL:2d:DGQ4:: Grad 0.00 1.78  2nd 0.00 4.94 4.94 -8.30
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -0.11 -0.11 -0.00
+DEAL:2d:DGQ4:: Grad 0.00 -0.00 2nd 0.00 0.59 0.59 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -1.33 -1.33 0.00
+DEAL:2d:DGQ4:: Grad 0.00 -0.00 2nd 0.00 1.78 1.78 0.00
+DEAL:2d:DGQ4:: Grad 0.00 -0.33 2nd 0.00 -0.93 -0.93 1.63
+DEAL:2d:DGQ4::1.00 1.00
+DEAL:2d:DGQ4:: Grad -0.00 -0.00        2nd -0.00 0.11 0.11 -0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -0.59 -0.59 0.00
+DEAL:2d:DGQ4:: Grad -0.00 0.00 2nd -0.00 1.33 1.33 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -1.78 -1.78 0.00
+DEAL:2d:DGQ4:: Grad -0.00 0.33 2nd -0.00 0.93 0.93 1.63
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -0.59 -0.59 0.00
+DEAL:2d:DGQ4:: Grad -0.00 -0.00        2nd -0.00 3.16 3.16 -0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -7.11 -7.11 0.00
+DEAL:2d:DGQ4:: Grad -0.00 -0.00        2nd -0.00 9.48 9.48 -0.00
+DEAL:2d:DGQ4:: Grad 0.00 -1.78 2nd 0.00 -4.94 -4.94 -8.30
+DEAL:2d:DGQ4:: Grad 0.00 -0.00 2nd 0.00 1.33 1.33 -0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -7.11 -7.11 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 16.00 16.00 0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -21.33 -21.33 0.00
+DEAL:2d:DGQ4:: Grad 0.00 4.00  2nd 0.00 11.11 11.11 16.89
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -1.78 -1.78 0.00
+DEAL:2d:DGQ4:: Grad -0.00 -0.00        2nd -0.00 9.48 9.48 -0.00
+DEAL:2d:DGQ4:: Grad 0.00 0.00  2nd 0.00 -21.33 -21.33 0.00
+DEAL:2d:DGQ4:: Grad -0.00 -0.00        2nd -0.00 28.44 28.44 -0.00
+DEAL:2d:DGQ4:: Grad 0.00 -5.33 2nd 0.00 -14.81 -14.81 -15.41
+DEAL:2d:DGQ4:: Grad 0.33 -0.00 2nd 1.63 0.93 0.93 -0.00
+DEAL:2d:DGQ4:: Grad -1.78 0.00 2nd -8.30 -4.94 -4.94 0.00
+DEAL:2d:DGQ4:: Grad 4.00 0.00  2nd 16.89 11.11 11.11 0.00
+DEAL:2d:DGQ4:: Grad -5.33 0.00 2nd -15.41 -14.81 -14.81 0.00
+DEAL:2d:DGQ4:: Grad 2.78 2.78  2nd 5.19 7.72 7.72 5.19
diff --git a/tests/fe/shapes.checked b/tests/fe/shapes.checked
new file mode 100644 (file)
index 0000000..8b13789
--- /dev/null
@@ -0,0 +1 @@
+

In the beginning the Universe was created. This has made a lot of people very angry and has been widely regarded as a bad move.

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.