]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Added support for inhomogeneous tangential and normal flow constraints
authordaniel.arndt <daniel.arndt@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 17 Mar 2014 00:27:06 +0000 (00:27 +0000)
committerdaniel.arndt <daniel.arndt@0785d39b-7218-0410-832d-ea1e28bc413d>
Mon, 17 Mar 2014 00:27:06 +0000 (00:27 +0000)
git-svn-id: https://svn.dealii.org/trunk@32662 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/doc/news/changes.h
deal.II/include/deal.II/numerics/vector_tools.h
deal.II/include/deal.II/numerics/vector_tools.templates.h
deal.II/source/numerics/vector_tools_constraints.inst.in
tests/deal.II/normal_flux_inhom_01.cc [new file with mode: 0644]
tests/deal.II/normal_flux_inhom_01.output [new file with mode: 0644]
tests/deal.II/tangential_flux_inhom_01.cc [new file with mode: 0644]
tests/deal.II/tangential_flux_inhom_01.output [new file with mode: 0644]

index 9a503c41dd28cd0938a1434ef3a792e037776405..4f58f53eeeccbb5d1e109c4aa4ac5bf124c29e74 100644 (file)
@@ -148,6 +148,13 @@ inconvenience this causes.
 <h3>Specific improvements</h3>
 
 <ol>
+  <li> Improved: Inhomogeneous tangential and normal flow constraints can
+       now be treated via VectorTools::compute_nonzero_normal_flux_constraints
+       and VectorTools::compute_nonzero_tangential_flux_constraints.
+  <br>
+  (Daniel Arndt, 2014/03/16)
+  </li>
+
   <li> Changed: Class TriaAccessor had a function parent_index(), but this function
   could only work for cell accessors. The function has consequently been moved
   to class CellAccessor.
index b1570b6c67ab2bed57bffe748b43da83b4b9fbab..59c74cfccc4e4d268139b4971de935298e2ad28f 100644 (file)
@@ -1471,17 +1471,18 @@ namespace VectorTools
 
 
   /**
-   * This function computes the constraints that correspond to boundary conditions of the
-   * form $\vec n \cdot \vec u=0$, i.e. no normal flux if $\vec u$ is a
-   * vector-valued quantity. These conditions have exactly the form handled by
-   * the ConstraintMatrix class, so instead of creating a map between boundary
-   * degrees of freedom and corresponding value, we here create a list of
-   * constraints that are written into a ConstraintMatrix. This object may
-   * already have some content, for example from hanging node constraints,
-   * that remains untouched. These constraints have to be applied to the
-   * linear system like any other such constraints, i.e. you have to condense
-   * the linear system with the constraints before solving, and you have to
-   * distribute the solution vector afterwards.
+   * This function computes the constraints that correspond to boundary
+   * conditions of the form $\vec u \cdot \vec n=\vec u_\Gamma \cdot \vec n$,
+   * i.e. normal flux constraints if $\vec u$ is a vector-valued quantity.
+   * These conditions have exactly the form handled by the ConstraintMatrix
+   * class, so instead of creating a map between boundary degrees of freedom
+   * and corresponding value, we here create a list of constraints that are
+   * written into a ConstraintMatrix. This object may already have some
+   * content, for example from hanging node constraints, that remains
+   * untouched. These constraints have to be applied to the linear system
+   * like any other such constraints, i.e. you have to condense the linear
+   * system with the constraints before solving, and you have to distribute
+   * the solution vector afterwards.
    *
    * The use of this function is explained in more detail in step-31. It
    * doesn't make much sense in 1d, so the function throws an exception in
@@ -1494,11 +1495,11 @@ namespace VectorTools
    * first_vector_component would be zero. On the other hand, if we solved the
    * Maxwell equations in 3d and the finite element has components
    * $(E_x,E_y,E_z,B_x,B_y,B_z)$ and we want the boundary condition $\vec
-   * n\cdot \vec B=0$, then @p first_vector_component would be 3. Vectors are
-   * implicitly assumed to have exactly <code>dim</code> components that are
-   * ordered in the same way as we usually order the coordinate directions,
-   * i.e. $x$-, $y$-, and finally $z$-component. The function assumes, but
-   * can't check, that the vector components in the range
+   * B\cdot \vec n=\vec B_\Gamma\cdot \vec n$, then @p first_vector_component
+   * would be 3. Vectors are implicitly assumed to have exactly <code>dim</code>
+   * components that are ordered in the same way as we usually order the
+   * coordinate directions, i.e. $x$-, $y$-, and finally $z$-component. The
+   * function assumes, but can't check, that the vector components in the range
    * <code>[first_vector_component,first_vector_component+dim)</code> come
    * from the same base finite element. For example, in the Stokes example
    * above, it would not make sense to use a
@@ -1515,6 +1516,9 @@ namespace VectorTools
    * call the function onces with the whole set of boundary indicators at
    * once.
    *
+   * The forth parameter describes the boundary function that is used for
+   * computing these constraints. 
+   *
    * The mapping argument is used to compute the boundary points where the
    * function needs to request the normal vector $\vec n$ from the boundary
    * description.
@@ -1542,20 +1546,22 @@ namespace VectorTools
    * right are meant to approximate a curved boundary (as indicated by the
    * dashed line), then neither of the two computed normal vectors are equal
    * to the exact normal vector (though they approximate it as the mesh is
-   * refined further). What is worse, if we constrain $\vec n \cdot \vec u=0$
-   * at the common vertex with the normal vector from both cells, then we
-   * constrain the vector $\vec u$ with respect to two linearly independent
-   * vectors; consequently, the constraint would be $\vec u=0$ at this point
-   * (i.e. <i>all</i> components of the vector), which is not what we wanted.
+   * refined further). What is worse, if we constrain $\vec u \cdot \vec n=
+   * \vec u_\Gamma \cdot \vec n$ at the common vertex with the normal vector
+   * from both cells, then we constrain the vector $\vec u$ with respect to
+   * two linearly independent vectors; consequently, the constraint would be
+   * $\vec u=\vec u_\Gamma$ at this point (i.e. <i>all</i> components of the
+   * vector), which is not what we wanted.
    *
    * To deal with this situation, the algorithm works in the following way: at
    * each point where we want to constrain $\vec u$, we first collect all
    * normal vectors that adjacent cells might compute at this point. We then
-   * do not constrain $\vec n \cdot \vec u=0$ for <i>each</i> of these normal
-   * vectors but only for the <i>average</i> of the normal vectors. In the
-   * example above, we therefore record only a single constraint $\vec n \cdot
-   * \vec {\bar u}=0$, where $\vec {\bar u}$ is the average of the two
-   * indicated normal vectors.
+   * do not constrain $\vec u \cdot \vec n=\vec u_\Gamma \cdot \vec n$ for
+   * <i>each</i> of these normal vectors but only for the <i>average</i> of
+   * the normal vectors. In the example above, we therefore record only a
+   * single constraint $\vec u \cdot \vec {\bar n}=\vec u_\Gamma \cdot \vec
+   * {\bar n}$, where $\vec {\bar n}$ is the average of the two indicated
+   * normal vectors.
    *
    * Unfortunately, this is not quite enough. Consider the situation here:
    *
@@ -1598,7 +1604,7 @@ namespace VectorTools
    * point per invocation (because we consider only one boundary part at a
    * time), with the result that the normal vectors will not be averaged. This
    * situation also needs to be taken into account when using this function
-   * around reentrant corners on Cartesian meshes. If no-normal-flux boundary
+   * around reentrant corners on Cartesian meshes. If normal-flux boundary
    * conditions are to be enforced on non-Cartesian meshes around reentrant
    * corners, one may even get cycles in the constraints as one will in
    * general constrain different components from the two sides. In that case,
@@ -1632,7 +1638,7 @@ namespace VectorTools
    * front faces of the left cell belong to the boundary selected whereas only
    * the top face of the right cell belongs to it, maybe indicating the the entire
    * front part of the domain is a smooth manifold whereas the top really forms
-   * two separate manifolds that meet in a ridge, and that no-flux boundary
+   * two separate manifolds that meet in a ridge, and that normal-flux boundary
    * conditions are only desired on the front manifold and the right one on top.
    * In cases like these, it's difficult to define what should happen. The
    * current implementation simply ignores the one contribution from the
@@ -1667,6 +1673,22 @@ namespace VectorTools
    */
   template <int dim, template <int, int> class DH, int spacedim>
   void
+  compute_nonzero_normal_flux_constraints (const DH<dim,spacedim>         &dof_handler,
+                                           const unsigned int     first_vector_component,
+                                           const std::set<types::boundary_id> &boundary_ids,
+                                           typename FunctionMap<spacedim>::type &function_map,
+                                           ConstraintMatrix      &constraints,
+                                           const Mapping<dim, spacedim>    &mapping = StaticMappingQ1<dim>::mapping);
+
+  /**
+   * Same as above for homogeneous normal-flux constraints.
+   *
+   * @ingroup constraints
+   *
+   * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
+   */
+  template <int dim, template <int, int> class DH, int spacedim>
+  void
   compute_no_normal_flux_constraints (const DH<dim,spacedim>         &dof_handler,
                                       const unsigned int     first_vector_component,
                                       const std::set<types::boundary_id> &boundary_ids,
@@ -1675,14 +1697,32 @@ namespace VectorTools
 
   /**
    * Compute the constraints that correspond to boundary conditions of the
-   * form $\vec n \times \vec u=0$. This corresponds to flow with no tangential
-   * component, i.e. flow is parallel to the normal vector to the boundary if $\vec
-   * u$ is a vector-valued quantity.
-   *
-   * This function constrains exactly those
-   * vector-valued components that are left unconstrained by
-   * compute_no_normal_flux_constraints, and leaves the one component
-   * unconstrained that is constrained by compute_no_normal_flux_constraints.
+   * form $\vec u \times \vec n=\vec u_\Gamma \times \vec n$, i.e. tangential
+   * flow constraints if $\vec u$ is a vector-valued quantity. This function
+   * constrains exactly those vector-valued components that are left
+   * unconstrained by compute_no_normal_flux_constraints, and leaves the one
+   * component unconstrained that is constrained by
+   * compute_no_normal_flux_constraints.
+   *
+   * @ingroup constraints
+   *
+   * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
+   */
+  template <int dim, template <int, int> class DH, int spacedim>
+  void
+  compute_nonzero_tangential_flux_constraints (const DH<dim,spacedim>         &dof_handler,
+                                               const unsigned int     first_vector_component,
+                                               const std::set<types::boundary_id> &boundary_ids,
+                                               typename FunctionMap<spacedim>::type &function_map,
+                                               ConstraintMatrix      &constraints,
+                                               const Mapping<dim, spacedim>    &mapping = StaticMappingQ1<dim>::mapping);
+  
+  /**
+   * Same as above for homogeneous tangential-flux constraints.
+   *
+   * @ingroup constraints
+   *
+   * @see @ref GlossBoundaryIndicator "Glossary entry on boundary indicators"
    */
   template <int dim, template <int, int> class DH, int spacedim>
   void
index cd33a7f5f2b0973f5f0bf62dcfda93494ca18a9a..6d5869bb34b091d09cb45ee24fdfed63ae2cb9d1 100644 (file)
@@ -67,6 +67,7 @@
 #include <cmath>
 #include <limits>
 #include <set>
+#include <list>
 
 DEAL_II_NAMESPACE_OPEN
 
@@ -1713,7 +1714,7 @@ namespace VectorTools
     // will be used
     template <class DH,
               template <int,int> class M_or_MC,
-             int dim_>
+                 int dim_>
     static inline
     void
     do_interpolate_boundary_values (const M_or_MC<DH::dimension, DH::space_dimension> &mapping,
@@ -2468,7 +2469,7 @@ namespace VectorTools
 
     /**
      * Add the constraint
-     * $\vec n \cdot \vec u = 0$
+     * $\vec n \cdot \vec u = inhom$
      * to the list of constraints.
      *
      * Here, $\vec u$ is represented
@@ -2485,7 +2486,8 @@ namespace VectorTools
     void
     add_constraint (const VectorDoFTuple<dim> &dof_indices,
                     const Tensor<1,dim>       &constraining_vector,
-                    ConstraintMatrix          &constraints)
+                    ConstraintMatrix          &constraints,
+                    const double              inhomogeneity=0)
     {
 
       // choose the DoF that has the
@@ -2566,6 +2568,11 @@ namespace VectorTools
                     constraints.add_entry (dof_indices.dof_indices[0],
                                            dof_indices.dof_indices[1],
                                            -constraining_vector[1]/constraining_vector[0]);
+                    
+                  if (std::fabs (inhomogeneity/constraining_vector[0])
+                      > std::numeric_limits<double>::epsilon())
+                    constraints.set_inhomogeneity(dof_indices.dof_indices[0],
+                                                  inhomogeneity/constraining_vector[0]);                  
                 }
             }
           else
@@ -2581,6 +2588,11 @@ namespace VectorTools
                     constraints.add_entry (dof_indices.dof_indices[1],
                                            dof_indices.dof_indices[0],
                                            -constraining_vector[0]/constraining_vector[1]);
+                    
+                  if (std::fabs (inhomogeneity/constraining_vector[1])
+                      > std::numeric_limits<double>::epsilon())
+                    constraints.set_inhomogeneity(dof_indices.dof_indices[1],
+                                                  inhomogeneity/constraining_vector[1]);                 
                 }
             }
           break;
@@ -2609,6 +2621,11 @@ namespace VectorTools
                     constraints.add_entry (dof_indices.dof_indices[0],
                                            dof_indices.dof_indices[2],
                                            -constraining_vector[2]/constraining_vector[0]);
+
+                  if (std::fabs (inhomogeneity/constraining_vector[0])
+                      > std::numeric_limits<double>::epsilon())
+                    constraints.set_inhomogeneity(dof_indices.dof_indices[0],
+                                                  inhomogeneity/constraining_vector[0]);
                 }
             }
           else if ((std::fabs(constraining_vector[1])+1e-10 >= std::fabs(constraining_vector[0]))
@@ -2632,6 +2649,11 @@ namespace VectorTools
                     constraints.add_entry (dof_indices.dof_indices[1],
                                            dof_indices.dof_indices[2],
                                            -constraining_vector[2]/constraining_vector[1]);
+
+                  if (std::fabs (inhomogeneity/constraining_vector[1])
+                      > std::numeric_limits<double>::epsilon())
+                    constraints.set_inhomogeneity(dof_indices.dof_indices[1],
+                                                  inhomogeneity/constraining_vector[1]);
                 }
             }
           else
@@ -2653,6 +2675,11 @@ namespace VectorTools
                     constraints.add_entry (dof_indices.dof_indices[2],
                                            dof_indices.dof_indices[1],
                                            -constraining_vector[1]/constraining_vector[2]);
+
+                  if (std::fabs (inhomogeneity/constraining_vector[2])
+                      > std::numeric_limits<double>::epsilon())
+                    constraints.set_inhomogeneity(dof_indices.dof_indices[2],
+                                                    inhomogeneity/constraining_vector[2]);
                 }
             }
 
@@ -2666,7 +2693,7 @@ namespace VectorTools
 
 
     /**
-     * Add the constraint $\vec u \|
+     * Add the constraint $(\vec u-\vec u_\Gamma) \|
      * \vec t$ to the list of
      * constraints. In 2d, this is a
      * single constraint, in 3d these
@@ -2684,9 +2711,11 @@ namespace VectorTools
      */
     template <int dim>
     void
-    add_tangentiality_constraints (const VectorDoFTuple<dim> &dof_indices,
-                                   const Tensor<1,dim>       &tangent_vector,
-                                   ConstraintMatrix          &constraints)
+    add_tangentiality_constraints
+      (const VectorDoFTuple<dim> &dof_indices,
+       const Tensor<1,dim>       &tangent_vector,
+       ConstraintMatrix          &constraints,
+       const Vector<double>      &b_values = Vector<double>(dim))
     {
 
       // choose the DoF that has the
@@ -2698,7 +2727,7 @@ namespace VectorTools
       // component 0 of the tangent
       // vector t is largest by
       // magnitude, then
-      // x1=t[1]/t[0]*x_0, etc.
+      // x1=(b[1]*t[0]-b[0]*t[1])/t[0]+t[1]/t[0]*x_0, etc.
       unsigned int largest_component = 0;
       for (unsigned int d=1; d<dim; ++d)
         if (std::fabs(tangent_vector[d]) > std::fabs(tangent_vector[largest_component]) + 1e-10)
@@ -2720,6 +2749,16 @@ namespace VectorTools
                 constraints.add_entry (dof_indices.dof_indices[d],
                                        dof_indices.dof_indices[largest_component],
                                        tangent_vector[d]/tangent_vector[largest_component]);
+
+              const double inhomogeneity
+                = (b_values(d)*tangent_vector[largest_component]
+                   -b_values(largest_component)*tangent_vector[d])
+                  /tangent_vector[largest_component];
+
+              if (std::fabs(inhomogeneity)
+                  > std::numeric_limits<double>::epsilon())
+                constraints.set_inhomogeneity(dof_indices.dof_indices[d],
+                                              inhomogeneity);
             }
     }
 
@@ -3114,7 +3153,11 @@ namespace VectorTools
                           + values[q_point] (first_vector_component + 1)
                           * tangentials[q_point] (1))
                        * (fe_values[vec].value (fe.face_to_cell_index (i, face), q_point)
-                          * tangentials[q_point]);
+                          * tangentials[q_point])
+                       / std::sqrt (jacobians[q_point][0][face_coordinate_direction[face]]
+                                    * jacobians[q_point][0][face_coordinate_direction[face]]
+                                    + jacobians[q_point][1][face_coordinate_direction[face]]
+                                    * jacobians[q_point][1][face_coordinate_direction[face]]);
 
                     if (q_point == 0)
                       dofs_processed[i] = true;
@@ -4264,6 +4307,29 @@ namespace VectorTools
                                       const std::set<types::boundary_id> &boundary_ids,
                                       ConstraintMatrix      &constraints,
                                       const Mapping<dim, spacedim>    &mapping)
+  {
+    ZeroFunction<dim>zero_function(dim);
+    typename FunctionMap<spacedim>::type function_map;
+    std::set<types::boundary_id>::const_iterator it
+      = boundary_ids.begin();
+    for (;it != boundary_ids.end(); ++it)
+      function_map[*it] = &zero_function;
+    compute_nonzero_normal_flux_constraints(dof_handler, 
+                                            first_vector_component, 
+                                            boundary_ids,
+                                            function_map,
+                                            constraints, 
+                                            mapping);
+  }
+  template <int dim, template <int, int> class DH, int spacedim>
+  void
+  compute_nonzero_normal_flux_constraints (const DH<dim,spacedim>         &dof_handler,
+                                           const unsigned int     first_vector_component,
+                                           const std::set<types::boundary_id> &boundary_ids,
+                                           typename FunctionMap<spacedim>::type &function_map,
+                                           ConstraintMatrix      &constraints,
+                                           const Mapping<dim, spacedim>    &mapping)
   {
     Assert (dim > 1,
             ExcMessage ("This function is not useful in 1d because it amounts "
@@ -4284,16 +4350,15 @@ namespace VectorTools
     // FE
     hp::QCollection<dim-1> face_quadrature_collection;
     for (unsigned int i=0; i<fe_collection.size(); ++i)
-      {
-        const std::vector<Point<dim-1> > &
-        unit_support_points = fe_collection[i].get_unit_face_support_points();
+    {
+      const std::vector<Point<dim-1> > &
+      unit_support_points = fe_collection[i].get_unit_face_support_points();
 
-        Assert (unit_support_points.size() == fe_collection[i].dofs_per_face,
-                ExcInternalError());
+      Assert (unit_support_points.size() == fe_collection[i].dofs_per_face,
+              ExcInternalError());
 
-        face_quadrature_collection
-        .push_back (Quadrature<dim-1> (unit_support_points));
-      }
+      face_quadrature_collection.push_back (Quadrature<dim-1> (unit_support_points));
+    }
 
     // now create the object with which we will generate the normal vectors
     hp::FEFaceValues<dim,spacedim> x_fe_face_values (mapping_collection,
@@ -4317,6 +4382,8 @@ namespace VectorTools
     std::multimap<internal::VectorDoFTuple<dim>,
         std::pair<Tensor<1,dim>, typename DH<dim,spacedim>::active_cell_iterator> >
         DoFToNormalsMap;
+    std::map<internal::VectorDoFTuple<dim>, Vector<double> >
+      dof_vector_to_b_values;
 
     DoFToNormalsMap dof_to_normals_map;
 
@@ -4324,129 +4391,136 @@ namespace VectorTools
     typename DH<dim,spacedim>::active_cell_iterator
     cell = dof_handler.begin_active(),
     endc = dof_handler.end();
+    std::set<types::boundary_id>::iterator b_id;
     for (; cell!=endc; ++cell)
       if (!cell->is_artificial())
         for (unsigned int face_no=0; face_no < GeometryInfo<dim>::faces_per_cell;
              ++face_no)
-          if (boundary_ids.find(cell->face(face_no)->boundary_indicator())
+          if ((b_id=boundary_ids.find(cell->face(face_no)->boundary_indicator()))
               != boundary_ids.end())
-            {
-              const FiniteElement<dim> &fe = cell->get_fe ();
-              typename DH<dim,spacedim>::face_iterator face = cell->face(face_no);
+          {
+            const FiniteElement<dim> &fe = cell->get_fe ();
+            typename DH<dim,spacedim>::face_iterator face = cell->face(face_no);
 
-              // get the indices of the dofs on this cell...
-              face_dofs.resize (fe.dofs_per_face);
-              face->get_dof_indices (face_dofs, cell->active_fe_index());
+            // get the indices of the dofs on this cell...
+            face_dofs.resize (fe.dofs_per_face);
+            face->get_dof_indices (face_dofs, cell->active_fe_index());
 
-              x_fe_face_values.reinit (cell, face_no);
-              const FEFaceValues<dim> &fe_values = x_fe_face_values.get_present_fe_values();
+            x_fe_face_values.reinit (cell, face_no);
+            const FEFaceValues<dim> &fe_values = x_fe_face_values.get_present_fe_values();
+
+            // then identify which of them correspond to the selected set of
+            // vector components
+            for (unsigned int i=0; i<face_dofs.size(); ++i)
+              if (fe.face_system_to_component_index(i).first ==
+                  first_vector_component)
+              {
+                // find corresponding other components of vector
+                internal::VectorDoFTuple<dim> vector_dofs;
+                vector_dofs.dof_indices[0] = face_dofs[i];
+                    
+                Assert(first_vector_component+dim<=fe.n_components(),
+                       ExcMessage("Error: the finite element does not have enough components "
+                                  "to define a normal direction."));
+                    
+                for (unsigned int k=0; k<fe.dofs_per_face; ++k)
+                  if ((k != i)
+                      &&
+                      (face_quadrature_collection[cell->active_fe_index()].point(k) ==
+                       face_quadrature_collection[cell->active_fe_index()].point(i))
+                      &&
+                      (fe.face_system_to_component_index(k).first >=
+                       first_vector_component)
+                      &&
+                      (fe.face_system_to_component_index(k).first <
+                       first_vector_component + dim))
+                    vector_dofs.dof_indices[fe.face_system_to_component_index(k).first -
+                                            first_vector_component]
+                      = face_dofs[k];
+
+                for (unsigned int d=0; d<dim; ++d)
+                  Assert (vector_dofs.dof_indices[d] < dof_handler.n_dofs(),
+                          ExcInternalError());
+
+                // we need the normal vector on this face. we know that it
+                // is a vector of length 1 but at least with higher order
+                // mappings it isn't always possible to guarantee that
+                // each component is exact up to zero tolerance. in
+                // particular, as shown in the deal.II/no_flux_06 test, if
+                // we just take the normal vector as given by the
+                // fe_values object, we can get entries in the normal
+                // vectors of the unit cube that have entries up to
+                // several times 1e-14.
+                //
+                // the problem with this is that this later yields
+                // constraints that are circular (e.g., in the testcase,
+                // we get constraints of the form
+                //
+                // x22 =  2.93099e-14*x21 + 2.93099e-14*x23
+                // x21 = -2.93099e-14*x22 + 2.93099e-14*x21
+                //
+                // in both of these constraints, the small numbers should
+                // be zero and the constraints should simply be
+                // x22 = x21 = 0
+                //
+                // to achieve this, we utilize that we know that the
+                // normal vector has (or should have) length 1 and that we
+                // can simply set small elements to zero (without having
+                // to check that they are small *relative to something
+                // else*). we do this and then normalize the length of the
+                // vector back to one, just to be on the safe side
+                //
+                // one more point: we would like to use the "real" normal
+                // vector here, as provided by the boundary description
+                // and as opposed to what we get from the FEValues object.
+                // we do this in the immediately next line, but as is
+                // obvious, the boundary only has a vague idea which side
+                // of a cell it is on -- indicated by the face number. in
+                // other words, it may provide the inner or outer normal.
+                // by and large, there is no harm from this, since the
+                // tangential vector we compute is still the same. however,
+                // we do average over normal vectors from adjacent cells
+                // and if they have recorded normal vectors from the inside
+                // once and from the outside the other time, then this
+                // averaging is going to run into trouble. as a consequence
+                // we ask the mapping after all for its normal vector,
+                // but we only ask it so that we can possibly correct the
+                // sign of the normal vector provided by the boundary
+                // if they should point in different directions. this is the
+                // case in tests/deal.II/no_flux_11.
+                Point<dim> normal_vector
+                  = (cell->face(face_no)->get_boundary().normal_vector
+                      (cell->face(face_no), fe_values.quadrature_point(i)));
+                if (normal_vector * fe_values.normal_vector(i) < 0)
+                  normal_vector *= -1;
+                Assert (std::fabs(normal_vector.norm() - 1) < 1e-14,
+                        ExcInternalError());
+                for (unsigned int d=0; d<dim; ++d)
+                  if (std::fabs(normal_vector[d]) < 1e-13)
+                    normal_vector[d] = 0;
+                normal_vector /= normal_vector.norm();
+
+                const Point<dim> point
+                  = fe_values.quadrature_point(i);                    
+                Vector<double> b_values(dim);
+                function_map[*b_id]->vector_value(point, b_values);
+
+                // now enter the (dofs,(normal_vector,cell)) entry into
+                // the map
+                dof_to_normals_map.insert
+                  (std::make_pair (vector_dofs,
+                                   std::make_pair (normal_vector,cell)));                                     
+                dof_vector_to_b_values.insert
+                  (std::make_pair(vector_dofs, b_values));
 
-              // then identify which of them correspond to the selected set of
-              // vector components
-              for (unsigned int i=0; i<face_dofs.size(); ++i)
-                if (fe.face_system_to_component_index(i).first ==
-                    first_vector_component)
-                  {
-                    // find corresponding other components of vector
-                    internal::VectorDoFTuple<dim> vector_dofs;
-                    vector_dofs.dof_indices[0] = face_dofs[i];
-
-                    Assert(first_vector_component+dim<=fe.n_components(),
-                           ExcMessage("Error: the finite element does not have enough components "
-                                      "to define a normal direction."));
-
-                    for (unsigned int k=0; k<fe.dofs_per_face; ++k)
-                      if ((k != i)
-                          &&
-                          (face_quadrature_collection[cell->active_fe_index()].point(k) ==
-                           face_quadrature_collection[cell->active_fe_index()].point(i))
-                          &&
-                          (fe.face_system_to_component_index(k).first >=
-                           first_vector_component)
-                          &&
-                          (fe.face_system_to_component_index(k).first <
-                           first_vector_component + dim))
-                        vector_dofs.dof_indices[fe.face_system_to_component_index(k).first -
-                                                first_vector_component]
-                          = face_dofs[k];
-
-                    for (unsigned int d=0; d<dim; ++d)
-                      Assert (vector_dofs.dof_indices[d] < dof_handler.n_dofs(),
-                              ExcInternalError());
-
-                    // we need the normal vector on this face. we know that it
-                    // is a vector of length 1 but at least with higher order
-                    // mappings it isn't always possible to guarantee that
-                    // each component is exact up to zero tolerance. in
-                    // particular, as shown in the deal.II/no_flux_06 test, if
-                    // we just take the normal vector as given by the
-                    // fe_values object, we can get entries in the normal
-                    // vectors of the unit cube that have entries up to
-                    // several times 1e-14.
-                    //
-                    // the problem with this is that this later yields
-                    // constraints that are circular (e.g., in the testcase,
-                    // we get constraints of the form
-                    //
-                    // x22 =  2.93099e-14*x21 + 2.93099e-14*x23
-                    // x21 = -2.93099e-14*x22 + 2.93099e-14*x21
-                    //
-                    // in both of these constraints, the small numbers should
-                    // be zero and the constraints should simply be
-                    // x22 = x21 = 0
-                    //
-                    // to achieve this, we utilize that we know that the
-                    // normal vector has (or should have) length 1 and that we
-                    // can simply set small elements to zero (without having
-                    // to check that they are small *relative to something
-                    // else*). we do this and then normalize the length of the
-                    // vector back to one, just to be on the safe side
-                    //
-                    // one more point: we would like to use the "real" normal
-                    // vector here, as provided by the boundary description
-                    // and as opposed to what we get from the FEValues object.
-                    // we do this in the immediately next line, but as is
-                    // obvious, the boundary only has a vague idea which side
-                    // of a cell it is on -- indicated by the face number. in
-                    // other words, it may provide the inner or outer normal.
-                    // by and large, there is no harm from this, since the
-                    // tangential vector we compute is still the same. however,
-                    // we do average over normal vectors from adjacent cells
-                    // and if they have recorded normal vectors from the inside
-                    // once and from the outside the other time, then this
-                    // averaging is going to run into trouble. as a consequence
-                    // we ask the mapping after all for its normal vector,
-                    // but we only ask it so that we can possibly correct the
-                    // sign of the normal vector provided by the boundary
-                    // if they should point in different directions. this is the
-                    // case in tests/deal.II/no_flux_11.
-                    Point<dim> normal_vector
-                      = (cell->face(face_no)->get_boundary()
-                         .normal_vector (cell->face(face_no),
-                                         fe_values.quadrature_point(i)));
-                    if (normal_vector * fe_values.normal_vector(i) < 0)
-                      normal_vector *= -1;
-                    Assert (std::fabs(normal_vector.norm() - 1) < 1e-14,
-                            ExcInternalError());
-                    for (unsigned int d=0; d<dim; ++d)
-                      if (std::fabs(normal_vector[d]) < 1e-13)
-                        normal_vector[d] = 0;
-                    normal_vector /= normal_vector.norm();
-
-                    // now enter the (dofs,(normal_vector,cell)) entry into
-                    // the map
-                    dof_to_normals_map
-                    .insert (std::make_pair (vector_dofs,
-                                             std::make_pair (normal_vector,
-                                                             cell)));
 #ifdef DEBUG_NO_NORMAL_FLUX
-                    std::cout << "Adding normal vector:" << std::endl
-                              << "   dofs=" << vector_dofs << std::endl
-                              << "   cell=" << cell << " at " << cell->center() << std::endl
-                              << "   normal=" << normal_vector << std::endl;
+                std::cout << "Adding normal vector:" << std::endl
+                          << "   dofs=" << vector_dofs << std::endl
+                          << "   cell=" << cell << " at " << cell->center() << std::endl
+                          << "   normal=" << normal_vector << std::endl;
 #endif
-                  }
-            }
+              }
+          }
 
     // Now do something with the collected information. To this end, loop
     // through all sets of pairs (dofs,normal_vector) and identify which
@@ -4457,332 +4531,338 @@ namespace VectorTools
     p = dof_to_normals_map.begin();
 
     while (p != dof_to_normals_map.end())
-      {
-        // first find the range of entries in the multimap that corresponds to
-        // the same vector-dof tuple. as usual, we define the range
-        // half-open. the first entry of course is 'p'
-        typename DoFToNormalsMap::const_iterator same_dof_range[2]
-          = { p };
-        for (++p; p != dof_to_normals_map.end(); ++p)
-          if (p->first != same_dof_range[0]->first)
-            {
-              same_dof_range[1] = p;
-              break;
-            }
-        if (p == dof_to_normals_map.end())
-          same_dof_range[1] = dof_to_normals_map.end();
+    {
+      // first find the range of entries in the multimap that corresponds to
+      // the same vector-dof tuple. as usual, we define the range
+      // half-open. the first entry of course is 'p'
+      typename DoFToNormalsMap::const_iterator same_dof_range[2] = { p };
+      for (++p; p != dof_to_normals_map.end(); ++p)
+        if (p->first != same_dof_range[0]->first)
+        {
+          same_dof_range[1] = p;
+          break;
+        }
+      if (p == dof_to_normals_map.end())
+        same_dof_range[1] = dof_to_normals_map.end();
 
 #ifdef DEBUG_NO_NORMAL_FLUX
-        std::cout << "For dof indices <" << p->first << ">, found the following normals"
+      std::cout << "For dof indices <" << p->first << ">, found the following normals"
+                << std::endl;
+      for (typename DoFToNormalsMap::const_iterator
+           q = same_dof_range[0];
+           q != same_dof_range[1]; ++q)
+        std::cout << "   " << q->second.first
+                  << " from cell " << q->second.second
                   << std::endl;
-        for (typename DoFToNormalsMap::const_iterator
-             q = same_dof_range[0];
-             q != same_dof_range[1]; ++q)
-          std::cout << "   " << q->second.first
-                    << " from cell " << q->second.second
-                    << std::endl;
 #endif
 
 
-        // now compute the reverse mapping: for each of the cells that
-        // contributed to the current set of vector dofs, add up the normal
-        // vectors. the values of the map are pairs of normal vectors and
-        // number of cells that have contributed
-        typedef
-        std::map
-        <typename DH<dim,spacedim>::active_cell_iterator,
-        std::pair<Tensor<1,dim>, unsigned int> >
+      // now compute the reverse mapping: for each of the cells that
+      // contributed to the current set of vector dofs, add up the normal
+      // vectors. the values of the map are pairs of normal vectors and
+      // number of cells that have contributed
+      typedef std::map<typename DH<dim,spacedim>::active_cell_iterator,
+                       std::pair<Tensor<1,dim>, unsigned int> >
         CellToNormalsMap;
 
-        CellToNormalsMap cell_to_normals_map;
-        for (typename DoFToNormalsMap::const_iterator
-             q = same_dof_range[0];
-             q != same_dof_range[1]; ++q)
-          if (cell_to_normals_map.find (q->second.second)
+      CellToNormalsMap cell_to_normals_map;
+      for (typename DoFToNormalsMap::const_iterator
+           q = same_dof_range[0];
+           q != same_dof_range[1]; ++q)
+        if (cell_to_normals_map.find (q->second.second)
               == cell_to_normals_map.end())
             cell_to_normals_map[q->second.second]
               = std::make_pair (q->second.first, 1U);
-          else
-            {
-              const Tensor<1,dim> old_normal
+        else
+        {
+          const Tensor<1,dim> old_normal
                 = cell_to_normals_map[q->second.second].first;
-              const unsigned int old_count
+          const unsigned int old_count
                 = cell_to_normals_map[q->second.second].second;
 
-              Assert (old_count > 0, ExcInternalError());
+          Assert (old_count > 0, ExcInternalError());
 
-              // in the same entry, store again the now averaged normal vector
-              // and the new count
-              cell_to_normals_map[q->second.second]
-                = std::make_pair ((old_normal * old_count + q->second.first) / (old_count + 1),
-                                  old_count + 1);
-            }
-        Assert (cell_to_normals_map.size() >= 1, ExcInternalError());
+          // in the same entry, store again the now averaged normal vector
+          // and the new count
+          cell_to_normals_map[q->second.second]
+            = std::make_pair ((old_normal * old_count + q->second.first) / (old_count + 1),
+                               old_count + 1);
+        }
+      Assert (cell_to_normals_map.size() >= 1, ExcInternalError());
 
 #ifdef DEBUG_NO_NORMAL_FLUX
-        std::cout << "   cell_to_normals_map:" << std::endl;
-        for (typename CellToNormalsMap::const_iterator
-             x = cell_to_normals_map.begin();
-             x != cell_to_normals_map.end(); ++x)
-          std::cout << "      " << x->first << " -> ("
-                    << x->second.first << ',' << x->second.second << ')'
-                    << std::endl;
+      std::cout << "   cell_to_normals_map:" << std::endl;
+      for (typename CellToNormalsMap::const_iterator
+           x = cell_to_normals_map.begin();
+           x != cell_to_normals_map.end(); ++x)
+        std::cout << "      " << x->first << " -> ("
+                  << x->second.first << ',' << x->second.second << ')'
+                  << std::endl;
 #endif
 
-        // count the maximum number of contributions from each cell
-        unsigned int max_n_contributions_per_cell = 1;
-        for (typename CellToNormalsMap::const_iterator
-             x = cell_to_normals_map.begin();
-             x != cell_to_normals_map.end(); ++x)
+      // count the maximum number of contributions from each cell
+      unsigned int max_n_contributions_per_cell = 1;
+      for (typename CellToNormalsMap::const_iterator
+           x = cell_to_normals_map.begin();
+           x != cell_to_normals_map.end(); ++x)
           max_n_contributions_per_cell
             = std::max (max_n_contributions_per_cell,
                         x->second.second);
 
-        // verify that each cell can have only contributed at most dim times,
-        // since that is the maximum number of faces that come together at a
-        // single place
-        Assert (max_n_contributions_per_cell <= dim, ExcInternalError());
-
-        switch (max_n_contributions_per_cell)
-          {
-          // first deal with the case that a number of cells all have
-          // registered that they have a normal vector defined at the
-          // location of a given vector dof, and that each of them have
-          // encountered this vector dof exactly once while looping over all
-          // their faces. as stated in the documentation, this is the case
-          // where we want to simply average over all normal vectors
-          //
-          // the typical case is in 2d where multiple cells meet at one
-          // vertex sitting on the boundary. same in 3d for a vertex that
-          // is associated with only one of the boundary indicators passed
-          // to this function
-          case 1:
-          {
-
-            // compute the average normal vector from all the ones that have
-            // the same set of dofs. we could add them up and divide them by
-            // the number of additions, or simply normalize them right away
-            // since we want them to have unit length anyway
-            Tensor<1,dim> normal;
-            for (typename CellToNormalsMap::const_iterator
-                 x = cell_to_normals_map.begin();
-                 x != cell_to_normals_map.end(); ++x)
-              normal += x->second.first;
-            normal /= normal.norm();
-
-            // normalize again
-            for (unsigned int d=0; d<dim; ++d)
-              if (std::fabs(normal[d]) < 1e-13)
-                normal[d] = 0;
-            normal /= normal.norm();
-
-            // then construct constraints from this:
-            const internal::VectorDoFTuple<dim> &
-            dof_indices = same_dof_range[0]->first;
-            internal::add_constraint (dof_indices, normal,
-                                      constraints);
+      // verify that each cell can have only contributed at most dim times,
+      // since that is the maximum number of faces that come together at a
+      // single place
+      Assert (max_n_contributions_per_cell <= dim, ExcInternalError());
 
-            break;
-          }
+      switch (max_n_contributions_per_cell)
+      {
+        // first deal with the case that a number of cells all have
+        // registered that they have a normal vector defined at the
+        // location of a given vector dof, and that each of them have
+        // encountered this vector dof exactly once while looping over all
+        // their faces. as stated in the documentation, this is the case
+        // where we want to simply average over all normal vectors
+        //
+        // the typical case is in 2d where multiple cells meet at one
+        // vertex sitting on the boundary. same in 3d for a vertex that
+        // is associated with only one of the boundary indicators passed
+        // to this function
+        case 1:
+        {
+          // compute the average normal vector from all the ones that have
+          // the same set of dofs. we could add them up and divide them by
+          // the number of additions, or simply normalize them right away
+          // since we want them to have unit length anyway
+          Tensor<1,dim> normal;
+          for (typename CellToNormalsMap::const_iterator
+               x = cell_to_normals_map.begin();
+               x != cell_to_normals_map.end(); ++x)
+            normal += x->second.first;
+          normal /= normal.norm();
+
+          // normalize again
+          for (unsigned int d=0; d<dim; ++d)
+            if (std::fabs(normal[d]) < 1e-13)
+              normal[d] = 0;
+          normal /= normal.norm();
+
+          // then construct constraints from this:
+          const internal::VectorDoFTuple<dim> &
+          dof_indices = same_dof_range[0]->first;
+          double normal_value = 0.;
+          const Vector<double> b_values = dof_vector_to_b_values[dof_indices];
+          for (unsigned int i=0; i<dim; ++i)
+            normal_value += b_values[i]*normal[i];
+          internal::add_constraint (dof_indices, normal,
+                                    constraints, normal_value);
+            
+          break;
+        }
 
+        // this is the slightly more complicated case that a single cell has
+        // contributed with exactly DIM normal vectors to the same set of
+        // vector dofs. this is what happens in a corner in 2d and 3d (but
+        // not on an edge in 3d, where we have only 2, i.e. <DIM,
+        // contributions. Here we do not want to average the normal
+        // vectors. Since we have DIM contributions, let's assume (and
+        // verify) that they are in fact all linearly independent; in that
+        // case, all vector components are constrained and we need to solve
+        // a linear equation
+        case dim:
+        {
+          // assert that indeed only a single cell has contributed
+          Assert (cell_to_normals_map.size() == 1,
+                  ExcInternalError());
 
-          // this is the slightly more complicated case that a single cell has
-          // contributed with exactly DIM normal vectors to the same set of
-          // vector dofs. this is what happens in a corner in 2d and 3d (but
-          // not on an edge in 3d, where we have only 2, i.e. <DIM,
-          // contributions. Here we do not want to average the normal
-          // vectors. Since we have DIM contributions, let's assume (and
-          // verify) that they are in fact all linearly independent; in that
-          // case, all vector components are constrained and we need to set
-          // them to zero
-          case dim:
+          // check linear independence by computing the determinant of the
+          // matrix created from all the normal vectors. if they are
+          // linearly independent, then the determinant is nonzero. if they
+          // are orthogonal, then the matrix is in fact equal to 1 (since
+          // they are all unit vectors); make sure the determinant is larger
+          // than 1e-3 to avoid cases where cells are degenerate
           {
-            // assert that indeed only a single cell has contributed
-            Assert (cell_to_normals_map.size() == 1,
-                    ExcInternalError());
+            Tensor<2,dim> t;
+              
+            typename DoFToNormalsMap::const_iterator x = same_dof_range[0];
+            for (unsigned int i=0; i<dim; ++i, ++x)
+              for (unsigned int j=0; j<dim; ++j)
+                t[i][j] = x->second.first[j];
+
+            Assert (std::fabs(determinant (t)) > 1e-3,
+                    ExcMessage("Found a set of normal vectors that are nearly collinear."));
+          }
 
-            // check linear independence by computing the determinant of the
-            // matrix created from all the normal vectors. if they are
-            // linearly independent, then the determinant is nonzero. if they
-            // are orthogonal, then the matrix is in fact equal to 1 (since
-            // they are all unit vectors); make sure the determinant is larger
-            // than 1e-3 to avoid cases where cells are degenerate
+          // so all components of this vector dof are constrained. enter
+          // this into the constraint matrix
+          //
+          // ignore dofs already constrained
+          const internal::VectorDoFTuple<dim> &
+          dof_indices = same_dof_range[0]->first;
+          const Vector<double> b_values = dof_vector_to_b_values[dof_indices];
+          for (unsigned int i=0; i<dim; ++i)
+            if (!constraints.is_constrained(same_dof_range[0]->first.dof_indices[i])
+                &&
+                constraints.can_store_line(same_dof_range[0]->first.dof_indices[i]))
             {
-              Tensor<2,dim> t;
-
-              typename DoFToNormalsMap::const_iterator x = same_dof_range[0];
-              for (unsigned int i=0; i<dim; ++i, ++x)
-                for (unsigned int j=0; j<dim; ++j)
-                  t[i][j] = x->second.first[j];
-
-              Assert (std::fabs(determinant (t)) > 1e-3,
-                      ExcMessage("Found a set of normal vectors that are nearly collinear."));
+              const types::global_dof_index line
+                = dof_indices.dof_indices[i];
+              constraints.add_line (line);
+              if (std::fabs(b_values[i])
+                  > std::numeric_limits<double>::epsilon())
+                constraints.set_inhomogeneity(line, b_values[i]);
+              // no add_entries here
             }
 
-            // so all components of this vector dof are constrained. enter
-            // this into the constraint matrix
-            //
-            // ignore dofs already constrained
-            for (unsigned int i=0; i<dim; ++i)
-              if (!constraints.is_constrained (same_dof_range[0]
-                                               ->first.dof_indices[i])
-                  &&
-                  constraints.can_store_line(
-                    same_dof_range[0]->first.dof_indices[i]))
-                {
-                  constraints.add_line (same_dof_range[0]->first.dof_indices[i]);
-                  // no add_entries here
-                }
-
             break;
           }
 
-
-          // this is the case of an edge contribution in 3d, i.e. the vector
-          // is constrained in two directions but not the third.
-          default:
-          {
-            Assert (dim >= 3, ExcNotImplemented());
-            Assert (max_n_contributions_per_cell == 2, ExcInternalError());
-
-            // as described in the documentation, let us first collect what
-            // each of the cells contributed at the current point. we use a
-            // std::list instead of a std::set (which would be more natural)
-            // because std::set requires that the stored elements are
-            // comparable with operator<
-            typedef
-            std::map<typename DH<dim,spacedim>::active_cell_iterator, std::list<Tensor<1,dim> > >
+        // this is the case of an edge contribution in 3d, i.e. the vector
+        // is constrained in two directions but not the third.
+        default:
+        {
+          Assert (dim >= 3, ExcNotImplemented());
+          Assert (max_n_contributions_per_cell == 2, ExcInternalError());
+
+          // as described in the documentation, let us first collect what
+          // each of the cells contributed at the current point. we use a
+          // std::list instead of a std::set (which would be more natural)
+          // because std::set requires that the stored elements are
+          // comparable with operator<
+          typedef std::map<typename DH<dim,spacedim>::active_cell_iterator,
+                           std::list<Tensor<1,dim> > >
             CellContributions;
-            CellContributions cell_contributions;
-
-            for (typename DoFToNormalsMap::const_iterator
-                 q = same_dof_range[0];
-                 q != same_dof_range[1]; ++q)
-              cell_contributions[q->second.second].push_back (q->second.first);
-            Assert (cell_contributions.size() >= 1, ExcInternalError());
-
-            // now for each cell that has contributed determine the number of
-            // normal vectors it has contributed. we currently only implement
-            // if this is dim-1 for all cells (if a single cell has
-            // contributed dim, or if all adjacent cells have contributed 1
-            // normal vector, this is already handled above).
-            //
-            // we only implement the case that all cells contribute
-            // dim-1 because we assume that we are following an edge
-            // of the domain (think: we are looking at a vertex
-            // located on one of the edges of a refined cube where the
-            // boundary indicators of the two adjacent faces of the
-            // cube are both listed in the set of boundary indicators
-            // passed to this function). in that case, all cells along
-            // that edge of the domain are assumed to have contributed
-            // dim-1 normal vectors. however, there are cases where
-            // this assumption is not justified (see the lengthy
-            // explanation in test no_flux_12.cc) and in those cases
-            // we simply ignore the cell that contributes only
-            // once. this is also discussed at length in the
-            // documentation of this function.
-            //
-            // for each contributing cell compute the tangential vector that
-            // remains unconstrained
-            std::list<Tensor<1,dim> > tangential_vectors;
-            for (typename CellContributions::const_iterator
-                 contribution = cell_contributions.begin();
-                 contribution != cell_contributions.end();
-                 ++contribution)
-              {
+          CellContributions cell_contributions;
+
+          for (typename DoFToNormalsMap::const_iterator
+               q = same_dof_range[0];
+               q != same_dof_range[1]; ++q)
+            cell_contributions[q->second.second].push_back (q->second.first);
+          Assert (cell_contributions.size() >= 1, ExcInternalError());
+
+          // now for each cell that has contributed determine the number of
+          // normal vectors it has contributed. we currently only implement
+          // if this is dim-1 for all cells (if a single cell has
+          // contributed dim, or if all adjacent cells have contributed 1
+          // normal vector, this is already handled above).
+          //
+          // we only implement the case that all cells contribute
+          // dim-1 because we assume that we are following an edge
+          // of the domain (think: we are looking at a vertex
+          // located on one of the edges of a refined cube where the
+          // boundary indicators of the two adjacent faces of the
+          // cube are both listed in the set of boundary indicators
+          // passed to this function). in that case, all cells along
+          // that edge of the domain are assumed to have contributed
+          // dim-1 normal vectors. however, there are cases where
+          // this assumption is not justified (see the lengthy
+          // explanation in test no_flux_12.cc) and in those cases
+          // we simply ignore the cell that contributes only
+          // once. this is also discussed at length in the
+          // documentation of this function.
+          //
+          // for each contributing cell compute the tangential vector that
+          // remains unconstrained
+          std::list<Tensor<1,dim> > tangential_vectors;
+          for (typename CellContributions::const_iterator
+               contribution = cell_contributions.begin();
+               contribution != cell_contributions.end();
+               ++contribution)
+          {
 #ifdef DEBUG_NO_NORMAL_FLUX
-                std::cout << "   Treating edge case with dim-1 contributions." << std::endl
-                          << "   Looking at cell " << contribution->first
-                          << " which has contributed these normal vectors:"
-                          << std::endl;
-                for (typename std::list<Tensor<1,dim> >::const_iterator
-                     t = contribution->second.begin();
-                     t != contribution->second.end();
-                     ++t)
-                  std::cout << "      " << *t << std::endl;
+            std::cout << "   Treating edge case with dim-1 contributions." << std::endl
+                      << "   Looking at cell " << contribution->first
+                      << " which has contributed these normal vectors:"
+                      << std::endl;
+            for (typename std::list<Tensor<1,dim> >::const_iterator
+                 t = contribution->second.begin();
+                 t != contribution->second.end();
+                 ++t)
+              std::cout << "      " << *t << std::endl;
 #endif
 
-                // as mentioned above, simply ignore cells that only
-                // contribute once
-                if (contribution->second.size() < dim-1)
-                  continue;
-
-                Tensor<1,dim> normals[dim-1];
-                {
-                  unsigned int index=0;
-                  for (typename std::list<Tensor<1,dim> >::const_iterator
-                       t = contribution->second.begin();
-                       t != contribution->second.end();
-                       ++t, ++index)
-                    normals[index] = *t;
-                  Assert (index == dim-1, ExcInternalError());
-                }
-
-                // calculate the tangent as the outer product of the normal
-                // vectors. since these vectors do not need to be orthogonal
-                // (think, for example, the case of the deal.II/no_flux_07
-                // test: a sheared cube in 3d, with Q2 elements, where we have
-                // constraints from the two normal vectors of two faces of the
-                // sheared cube that are not perpendicular to each other), we
-                // have to normalize the outer product
-                Tensor<1,dim> tangent;
-                switch (dim)
-                  {
-                  case 3:
-                    // take cross product between normals[0] and
-                    // normals[1]. write it in the current form (with [dim-2])
-                    // to make sure that compilers don't warn about
-                    // out-of-bounds accesses -- the warnings are bogus since
-                    // we get here only for dim==3, but at least one isn't
-                    // quite smart enough to notice this and warns when
-                    // compiling the function in 2d
-                    cross_product (tangent, normals[0], normals[dim-2]);
-                    break;
-                  default:
-                    Assert (false, ExcNotImplemented());
-                  }
-
-                Assert (std::fabs (tangent.norm()) > 1e-12,
-                        ExcMessage("Two normal vectors from adjacent faces are almost "
-                                   "parallel."));
-                tangent /= tangent.norm();
-
-                tangential_vectors.push_back (tangent);
-              }
+            // as mentioned above, simply ignore cells that only
+            // contribute once
+            if (contribution->second.size() < dim-1)
+              continue;
+              
+            Tensor<1,dim> normals[dim-1];
+            {
+              unsigned int index=0;
+              for (typename std::list<Tensor<1,dim> >::const_iterator
+                   t = contribution->second.begin();
+                   t != contribution->second.end();
+                   ++t, ++index)
+                normals[index] = *t;
+              Assert (index == dim-1, ExcInternalError());
+            }
 
-            // go through the list of tangents and make sure that they all
-            // roughly point in the same direction as the first one (i.e. have
-            // an angle less than 90 degrees); if they don't then flip their
-            // sign
+            // calculate the tangent as the outer product of the normal
+            // vectors. since these vectors do not need to be orthogonal
+            // (think, for example, the case of the deal.II/no_flux_07
+            // test: a sheared cube in 3d, with Q2 elements, where we have
+            // constraints from the two normal vectors of two faces of the
+            // sheared cube that are not perpendicular to each other), we
+            // have to normalize the outer product
+            Tensor<1,dim> tangent;
+            switch (dim)
             {
-              const Tensor<1,dim> first_tangent = tangential_vectors.front();
-              typename std::list<Tensor<1,dim> >::iterator
-              t = tangential_vectors.begin();
-              ++t;
-              for (; t != tangential_vectors.end(); ++t)
-                if (*t * first_tangent < 0)
-                  *t *= -1;
+              case 3:
+                // take cross product between normals[0] and
+                // normals[1]. write it in the current form (with [dim-2])
+                // to make sure that compilers don't warn about
+                // out-of-bounds accesses -- the warnings are bogus since
+                // we get here only for dim==3, but at least one isn't
+                // quite smart enough to notice this and warns when
+                // compiling the function in 2d
+                cross_product (tangent, normals[0], normals[dim-2]);
+                break;
+              default:
+                Assert (false, ExcNotImplemented());
             }
 
-            // now compute the average tangent and normalize it
-            Tensor<1,dim> average_tangent;
-            for (typename std::list<Tensor<1,dim> >::const_iterator
-                 t = tangential_vectors.begin();
-                 t != tangential_vectors.end();
-                 ++t)
-              average_tangent += *t;
-            average_tangent /= average_tangent.norm();
+            Assert (std::fabs (tangent.norm()) > 1e-12,
+                    ExcMessage("Two normal vectors from adjacent faces are almost "
+                               "parallel."));
+            tangent /= tangent.norm();
 
-            // now all that is left is that we add the constraints that the
-            // vector is parallel to the tangent
-            const internal::VectorDoFTuple<dim> &
-            dof_indices = same_dof_range[0]->first;
-            internal::add_tangentiality_constraints (dof_indices,
-                                                     average_tangent,
-                                                     constraints);
+            tangential_vectors.push_back (tangent);
           }
+
+          // go through the list of tangents and make sure that they all
+          // roughly point in the same direction as the first one (i.e. have
+          // an angle less than 90 degrees); if they don't then flip their
+          // sign
+          {
+            const Tensor<1,dim> first_tangent = tangential_vectors.front();
+            typename std::list<Tensor<1,dim> >::iterator
+              t = tangential_vectors.begin();
+            ++t;
+            for (; t != tangential_vectors.end(); ++t)
+              if (*t * first_tangent < 0)
+                *t *= -1;
           }
+
+          // now compute the average tangent and normalize it
+          Tensor<1,dim> average_tangent;
+          for (typename std::list<Tensor<1,dim> >::const_iterator
+               t = tangential_vectors.begin();
+               t != tangential_vectors.end();
+               ++t)
+            average_tangent += *t;
+          average_tangent /= average_tangent.norm();
+
+          // now all that is left is that we add the constraints that the
+          // vector is parallel to the tangent
+          const internal::VectorDoFTuple<dim> &
+            dof_indices = same_dof_range[0]->first;
+          const Vector<double> b_values = dof_vector_to_b_values[dof_indices];
+          internal::add_tangentiality_constraints (dof_indices,
+                                                   average_tangent,
+                                                   constraints,
+                                                   b_values);
+        }
       }
+    }
   }
 
 
@@ -4812,13 +4892,64 @@ namespace VectorTools
                                    const std::set<types::boundary_id> &boundary_ids,
                                    ConstraintMatrix      &constraints,
                                    const Mapping<dim, spacedim> &mapping)
+  {
+    ZeroFunction<dim>zero_function(dim);
+    typename FunctionMap<spacedim>::type function_map;
+    std::set<types::boundary_id>::const_iterator it
+      = boundary_ids.begin();
+    for (;it != boundary_ids.end(); ++it)
+      function_map[*it] = &zero_function;
+    compute_nonzero_tangential_flux_constraints(dof_handler,
+                                                first_vector_component,
+                                                boundary_ids,
+                                                function_map,
+                                                constraints,
+                                                mapping);
+  }
+
+  template <int dim, template <int, int> class DH, int spacedim>
+  void
+  compute_nonzero_tangential_flux_constraints (const DH<dim,spacedim> &dof_handler,
+                                               const unsigned int     first_vector_component,
+                                               const std::set<types::boundary_id> &boundary_ids,
+                                               typename FunctionMap<spacedim>::type &function_map,
+                                               ConstraintMatrix      &constraints,
+                                               const Mapping<dim, spacedim> &mapping)
   {
     ConstraintMatrix no_normal_flux_constraints(constraints.get_local_lines());
-    compute_no_normal_flux_constraints (dof_handler,
-                                        first_vector_component,
-                                        boundary_ids,
-                                        no_normal_flux_constraints,
-                                        mapping);
+    compute_nonzero_normal_flux_constraints (dof_handler,
+                                             first_vector_component,
+                                             boundary_ids,
+                                             function_map,
+                                             no_normal_flux_constraints,
+                                             mapping);
+
+    hp::FECollection<dim,spacedim>      fe_collection (dof_handler.get_fe());
+    hp::MappingCollection<dim,spacedim> mapping_collection;
+    for (unsigned int i=0; i<fe_collection.size(); ++i)
+      mapping_collection.push_back (mapping);
+    
+    // now also create a quadrature collection for the faces of a cell. fill
+    // it with a quadrature formula with the support points on faces for each
+    // FE
+    hp::QCollection<dim-1> face_quadrature_collection;
+    for (unsigned int i=0; i<fe_collection.size(); ++i)
+    {
+      const std::vector<Point<dim-1> > &
+      unit_support_points = fe_collection[i].get_unit_face_support_points();
+        
+      Assert (unit_support_points.size() == fe_collection[i].dofs_per_face,
+              ExcInternalError());
+       
+      face_quadrature_collection.push_back (Quadrature<dim-1> (unit_support_points));
+    }
+      
+    // now create the object with which we will generate the normal vectors
+    hp::FEFaceValues<dim,spacedim> x_fe_face_values (mapping_collection,
+                                                     fe_collection,
+                                                     face_quadrature_collection,
+                                                     update_q_points |
+                                                     update_normal_vectors);
 
     // Extract a list that collects all vector components that belong to the
     // same node (scalar basis function). When creating that list, we use an
@@ -4826,13 +4957,17 @@ namespace VectorTools
     std::set<std_cxx1x::array<types::global_dof_index,dim>, PointComparator<dim> > vector_dofs;
     std::vector<types::global_dof_index> face_dofs;
 
+    std::map<std_cxx1x::array<types::global_dof_index,dim>, Vector<double> >
+      dof_vector_to_b_values;
+
+    std::set<types::boundary_id>::iterator b_id;
     std::vector<std_cxx1x::array<types::global_dof_index,dim> > cell_vector_dofs;
     for (typename DH<dim,spacedim>::active_cell_iterator cell =
            dof_handler.begin_active(); cell != dof_handler.end(); ++cell)
       if (!cell->is_artificial())
         for (unsigned int face_no=0; face_no < GeometryInfo<dim>::faces_per_cell;
              ++face_no)
-          if (boundary_ids.find(cell->face(face_no)->boundary_indicator())
+          if ((b_id=boundary_ids.find(cell->face(face_no)->boundary_indicator()))
               != boundary_ids.end())
             {
               const FiniteElement<dim> &fe = cell->get_fe();
@@ -4842,25 +4977,50 @@ namespace VectorTools
               face_dofs.resize (fe.dofs_per_face);
               face->get_dof_indices (face_dofs, cell->active_fe_index());
 
+              x_fe_face_values.reinit (cell, face_no);
+              const FEFaceValues<dim> &fe_values = x_fe_face_values.get_present_fe_values();
+
+              std::map<types::global_dof_index, double> dof_to_b_value;
+              
               unsigned int n_scalar_indices = 0;
               cell_vector_dofs.resize(fe.dofs_per_face);
               for (unsigned int i=0; i<fe.dofs_per_face; ++i)
+              {
                 if (fe.face_system_to_component_index(i).first >= first_vector_component &&
                     fe.face_system_to_component_index(i).first < first_vector_component + dim)
-                  {
-                    n_scalar_indices =
-                      std::max(n_scalar_indices,
-                               fe.face_system_to_component_index(i).second+1);
-                    cell_vector_dofs[fe.face_system_to_component_index(i).second]
-                    [fe.face_system_to_component_index(i).first-first_vector_component]
-                      = face_dofs[i];
-                  }
+                {
+                  const unsigned int component
+                    = fe.face_system_to_component_index(i).first
+                      -first_vector_component;
+                  n_scalar_indices =
+                    std::max(n_scalar_indices,
+                             fe.face_system_to_component_index(i).second+1);
+                  cell_vector_dofs[fe.face_system_to_component_index(i).second]
+                    [component]
+                    = face_dofs[i];
+                
+                  const Point<dim> point
+                    = fe_values.quadrature_point(i);
+                  const double b_value
+                    = function_map[*b_id]->value(point, component);
+                  dof_to_b_value.insert
+                    (std::make_pair(face_dofs[i], b_value));
+                }
+              }
 
               // now we identified the vector indices on the cell, so next
               // insert them into the set (it would be expensive to directly
               // insert incomplete points into the set)
               for (unsigned int i=0; i<n_scalar_indices; ++i)
+              {
                 vector_dofs.insert(cell_vector_dofs[i]);
+                Vector<double> b_values(dim);
+                for (unsigned int j=0; j<dim; ++j)
+                  b_values[j]=dof_to_b_value[cell_vector_dofs[i][j]];
+                dof_vector_to_b_values.insert
+                  (std::make_pair(cell_vector_dofs[i], b_values));
+              }
+
             }
 
     // iterate over the list of all vector components we found and see if we
@@ -4886,11 +5046,15 @@ namespace VectorTools
             // if more than one no-flux constraint is present, we need to
             // constrain all vector degrees of freedom (we are in a corner
             // where several faces meet and to get a continuous FE solution we
-            // need to set all conditions to zero).
+            // need to set all conditions corresponding to the boundary function.).
             if (n_constraints > 1)
               {
+                const Vector<double> b_value = dof_vector_to_b_values[*it];
                 for (unsigned int d=0; d<dim; ++d)
+                {
                   constraints.add_line((*it)[d]);
+                  constraints.set_inhomogeneity((*it)[d], b_value(d));
+                }
                 continue;
               }
 
@@ -4921,6 +5085,7 @@ namespace VectorTools
                 Assert (index != -1, ExcInternalError());
                 normal[index] = (*constrained)[c].second;
               }
+            Vector<double> boundary_value = dof_vector_to_b_values[*it];
             for (unsigned int d=0; d<dim; ++d)
               {
                 if (is_constrained[d])
@@ -4932,6 +5097,7 @@ namespace VectorTools
                     if (std::abs(normal[d]) > 1e-13)
                       constraints.add_entry(new_index, (*it)[constrained_index],
                                             -normal[d]);
+                    constraints.set_inhomogeneity(new_index, boundary_value[d]);
                   }
               }
           }
index f3bfa2a7d34dfa5c187563df82b098997145d14d..4a1c6ab7daaf9608bc058d84418b9da877e87d84 100644 (file)
@@ -1,7 +1,7 @@
 // ---------------------------------------------------------------------
 // $Id$
 //
-// Copyright (C) 1998 - 2013 by the deal.II authors
+// Copyright (C) 1998 - 2014 by the deal.II authors
 //
 // This file is part of the deal.II library.
 //
 //TODO[SP]: replace <deal_II_dimension> by <deal_II_dimension, deal_II_space_dimension>
 // where applicable and move to codimension cases above also when applicable
 for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS)
-  {
-    namespace VectorTools \{
+{
+  namespace VectorTools \{
 
 #if deal_II_dimension == deal_II_space_dimension
 #if deal_II_dimension != 1
-      template
-        void
-        compute_no_normal_flux_constraints (const DoFHandler<deal_II_dimension> &dof_handler,
-                                            const unsigned int     first_vector_component,
-                                            const std::set<types::boundary_id> &boundary_ids,
-                                            ConstraintMatrix      &constraints,
-                                            const Mapping<deal_II_dimension>    &mapping);
-      template
-        void
-        compute_no_normal_flux_constraints (const hp::DoFHandler<deal_II_dimension> &dof_handler,
-                                            const unsigned int     first_vector_component,
-                                            const std::set<types::boundary_id> &boundary_ids,
-                                            ConstraintMatrix      &constraints,
-                                            const Mapping<deal_II_dimension>    &mapping);
+  template
+  void
+  compute_nonzero_normal_flux_constraints (const DoFHandler<deal_II_dimension> &dof_handler,
+                                           const unsigned int     first_vector_component,
+                                           const std::set<types::boundary_id> &boundary_ids,
+                                           typename FunctionMap<deal_II_dimension>::type &function_map,
+                                           ConstraintMatrix      &constraints,
+                                           const Mapping<deal_II_dimension>    &mapping);
 
-      template
-        void
-        compute_normal_flux_constraints (const DoFHandler<deal_II_dimension> &dof_handler,
-                                         const unsigned int     first_vector_component,
-                                         const std::set<types::boundary_id> &boundary_ids,
-                                         ConstraintMatrix      &constraints,
-                                         const Mapping<deal_II_dimension>    &mapping);
-      template
-        void
-        compute_normal_flux_constraints (const hp::DoFHandler<deal_II_dimension> &dof_handler,
-                                         const unsigned int     first_vector_component,
-                                         const std::set<types::boundary_id> &boundary_ids,
-                                         ConstraintMatrix      &constraints,
-                                         const Mapping<deal_II_dimension>    &mapping);
+  template
+  void
+  compute_nonzero_normal_flux_constraints (const hp::DoFHandler<deal_II_dimension> &dof_handler,
+                                           const unsigned int     first_vector_component,
+                                           const std::set<types::boundary_id> &boundary_ids,
+                                           typename FunctionMap<deal_II_dimension>::type &function_map,
+                                           ConstraintMatrix      &constraints,
+                                           const Mapping<deal_II_dimension>    &mapping);
+
+  template
+  void
+  compute_nonzero_tangential_flux_constraints (const DoFHandler<deal_II_dimension> &dof_handler,
+                                               const unsigned int     first_vector_component,
+                                               const std::set<types::boundary_id> &boundary_ids,
+                                               typename FunctionMap<deal_II_dimension>::type &function_map,
+                                               ConstraintMatrix      &constraints,
+                                               const Mapping<deal_II_dimension>    &mapping);
+  template
+  void
+  compute_nonzero_tangential_flux_constraints (const hp::DoFHandler<deal_II_dimension> &dof_handler,
+                                               const unsigned int     first_vector_component,
+                                               const std::set<types::boundary_id> &boundary_ids,
+                                               typename FunctionMap<deal_II_dimension>::type &function_map,
+                                               ConstraintMatrix      &constraints,
+                                               const Mapping<deal_II_dimension>    &mapping);
+    
+  template
+  void
+  compute_no_normal_flux_constraints (const DoFHandler<deal_II_dimension> &dof_handler,
+                                      const unsigned int     first_vector_component,
+                                      const std::set<types::boundary_id> &boundary_ids,
+                                      ConstraintMatrix      &constraints,
+                                      const Mapping<deal_II_dimension>    &mapping);
+
+  template
+  void
+  compute_no_normal_flux_constraints (const hp::DoFHandler<deal_II_dimension> &dof_handler,
+                                      const unsigned int     first_vector_component,
+                                      const std::set<types::boundary_id> &boundary_ids,
+                                      ConstraintMatrix      &constraints,
+                                      const Mapping<deal_II_dimension>    &mapping);
+    
+  template
+  void
+  compute_normal_flux_constraints (const DoFHandler<deal_II_dimension> &dof_handler,
+                                   const unsigned int     first_vector_component,
+                                   const std::set<types::boundary_id> &boundary_ids,
+                                   ConstraintMatrix      &constraints,
+                                   const Mapping<deal_II_dimension>    &mapping);
+
+  template
+  void
+  compute_normal_flux_constraints (const hp::DoFHandler<deal_II_dimension> &dof_handler,
+                                   const unsigned int     first_vector_component,
+                                   const std::set<types::boundary_id> &boundary_ids,
+                                   ConstraintMatrix      &constraints,
+                                   const Mapping<deal_II_dimension>    &mapping);
 #endif
 #endif
-      \}
-  }
+  \}
+}
\ No newline at end of file
diff --git a/tests/deal.II/normal_flux_inhom_01.cc b/tests/deal.II/normal_flux_inhom_01.cc
new file mode 100644 (file)
index 0000000..5d72528
--- /dev/null
@@ -0,0 +1,130 @@
+// ---------------------------------------------------------------------
+// $Id: no_flux_inhom_01.cc 31349 2013-10-20 19:07:06Z maier $
+//
+// Copyright (C) 2007 - 2013 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+
+
+// check the creation of inhomogeneous normal-flux boundary conditions 
+// for a finite element that consists of only a single set of vector 
+// components (i.e. it has dim components)
+
+#include "../tests.h"
+#include <deal.II/base/logstream.h>
+#include <deal.II/base/function.h>
+#include <deal.II/base/quadrature_lib.h>
+#include <deal.II/lac/vector.h>
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/dofs/dof_handler.h>
+#include <deal.II/lac/constraint_matrix.h>
+#include <deal.II/fe/fe_q.h>
+#include <deal.II/fe/fe_system.h>
+#include <deal.II/fe/mapping_q1.h>
+#include <deal.II/fe/fe_values.h>
+#include <deal.II/numerics/vector_tools.h>
+
+#include <fstream>
+
+
+template<int dim>
+void test (const Triangulation<dim> &tr,
+           const FiniteElement<dim> &fe)
+{
+  DoFHandler<dim> dof(tr);
+  dof.distribute_dofs(fe);
+  ConstantFunction<dim> constant_function(1.,dim);
+  typename FunctionMap<dim>::type function_map;
+  for (unsigned int j=0; j<GeometryInfo<dim>::faces_per_cell; ++j)
+    function_map[j] = &constant_function;
+  
+  for (unsigned int i=0; i<GeometryInfo<dim>::faces_per_cell; ++i)
+    {
+      deallog << "FE=" << fe.get_name()
+              << ", case=" << i
+              << std::endl;
+
+      std::set<types::boundary_id> boundary_ids;
+      for (unsigned int j=0; j<=i; ++j)
+        boundary_ids.insert (j);
+
+      ConstraintMatrix cm;
+      VectorTools::compute_nonzero_normal_flux_constraints
+        (dof, 0, boundary_ids, function_map,  cm);
+
+      cm.print (deallog.get_file_stream ());
+    }
+  //Get the location of all boundary dofs
+  std::vector<types::global_dof_index> face_dofs;
+  const std::vector<Point<dim-1> > &
+    unit_support_points = fe.get_unit_face_support_points();
+  Quadrature<dim-1> quadrature(unit_support_points);
+  FEFaceValues<dim, dim> fe_face_values(fe, quadrature, update_q_points);
+  typename DoFHandler<dim>::active_cell_iterator
+  cell = dof.begin_active(),
+  endc = dof.end();
+  for (; cell!=endc; ++cell)
+    for (unsigned int face_no=0; face_no < GeometryInfo<dim>::faces_per_cell;
+         ++face_no)
+      if (cell->face(face_no)->at_boundary())
+      {
+        typename DoFHandler<dim>::face_iterator face = cell->face(face_no);
+        face_dofs.resize (fe.dofs_per_face);
+        face->get_dof_indices (face_dofs);
+        
+        fe_face_values.reinit(cell, face_no);
+        for (unsigned int i=0; i<face_dofs.size(); ++i)
+        {
+          std::cout << face_dofs[i] << "\t"
+                    << fe_face_values.quadrature_point(i) << "\t"
+                    << fe.face_system_to_component_index(i).first
+                    << std::endl;
+        }
+      }
+
+    
+}
+
+
+template<int dim>
+void test_hyper_cube()
+{
+  Triangulation<dim> tr;
+  GridGenerator::hyper_cube(tr);
+
+  for (unsigned int i=0; i<GeometryInfo<dim>::faces_per_cell; ++i)
+    tr.begin_active()->face(i)->set_boundary_indicator (i);
+
+  tr.refine_global(2);
+
+  for (unsigned int degree=1; degree<4; ++degree)
+    {
+      FESystem<dim> fe (FE_Q<dim>(degree), dim);
+      test(tr, fe);
+    }
+}
+
+
+int main()
+{
+  std::ofstream logfile ("output");
+  deallog << std::setprecision (2);
+  deallog << std::fixed;
+  deallog.attach(logfile);
+  deallog.depth_console (0);
+  deallog.threshold_double(1.e-12);
+
+  test_hyper_cube<2>();
+  test_hyper_cube<3>();
+}
diff --git a/tests/deal.II/normal_flux_inhom_01.output b/tests/deal.II/normal_flux_inhom_01.output
new file mode 100644 (file)
index 0000000..02a4242
--- /dev/null
@@ -0,0 +1,6076 @@
+
+DEAL::FE=FESystem<2>[FE_Q<2>(1)^2], case=0
+    0 = 1.00000
+    4 = 1.00000
+    12 = 1.00000
+    30 = 1.00000
+    36 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(1)^2], case=1
+    0 = 1.00000
+    4 = 1.00000
+    12 = 1.00000
+    22 = 1.00000
+    24 = 1.00000
+    28 = 1.00000
+    30 = 1.00000
+    36 = 1.00000
+    44 = 1.00000
+    48 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(1)^2], case=2
+    0 = 1.00000
+    1 = 1.00000
+    3 = 1.00000
+    4 = 1.00000
+    9 = 1.00000
+    12 = 1.00000
+    19 = 1.00000
+    22 = 1.00000
+    23 = 1.00000
+    24 = 1.00000
+    28 = 1.00000
+    30 = 1.00000
+    36 = 1.00000
+    44 = 1.00000
+    48 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(1)^2], case=3
+    0 = 1.00000
+    1 = 1.00000
+    3 = 1.00000
+    4 = 1.00000
+    9 = 1.00000
+    12 = 1.00000
+    19 = 1.00000
+    22 = 1.00000
+    23 = 1.00000
+    24 = 1.00000
+    28 = 1.00000
+    30 = 1.00000
+    36 = 1.00000
+    37 = 1.00000
+    39 = 1.00000
+    41 = 1.00000
+    44 = 1.00000
+    47 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(2)^2], case=0
+    0 = 1.00000
+    4 = 1.00000
+    8 = 1.00000
+    30 = 1.00000
+    34 = 1.00000
+    90 = 1.00000
+    94 = 1.00000
+    110 = 1.00000
+    114 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(2)^2], case=1
+    0 = 1.00000
+    4 = 1.00000
+    8 = 1.00000
+    30 = 1.00000
+    34 = 1.00000
+    62 = 1.00000
+    64 = 1.00000
+    66 = 1.00000
+    82 = 1.00000
+    84 = 1.00000
+    90 = 1.00000
+    94 = 1.00000
+    110 = 1.00000
+    114 = 1.00000
+    138 = 1.00000
+    140 = 1.00000
+    154 = 1.00000
+    156 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(2)^2], case=2
+    0 = 1.00000
+    1 = 1.00000
+    3 = 1.00000
+    4 = 1.00000
+    8 = 1.00000
+    13 = 1.00000
+    19 = 1.00000
+    25 = 1.00000
+    30 = 1.00000
+    34 = 1.00000
+    51 = 1.00000
+    57 = 1.00000
+    62 = 1.00000
+    63 = 1.00000
+    64 = 1.00000
+    66 = 1.00000
+    69 = 1.00000
+    82 = 1.00000
+    84 = 1.00000
+    90 = 1.00000
+    94 = 1.00000
+    110 = 1.00000
+    114 = 1.00000
+    138 = 1.00000
+    140 = 1.00000
+    154 = 1.00000
+    156 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(2)^2], case=3
+    0 = 1.00000
+    1 = 1.00000
+    3 = 1.00000
+    4 = 1.00000
+    8 = 1.00000
+    13 = 1.00000
+    19 = 1.00000
+    25 = 1.00000
+    30 = 1.00000
+    34 = 1.00000
+    51 = 1.00000
+    57 = 1.00000
+    62 = 1.00000
+    63 = 1.00000
+    64 = 1.00000
+    66 = 1.00000
+    69 = 1.00000
+    82 = 1.00000
+    84 = 1.00000
+    90 = 1.00000
+    94 = 1.00000
+    110 = 1.00000
+    111 = 1.00000
+    113 = 1.00000
+    114 = 1.00000
+    119 = 1.00000
+    123 = 1.00000
+    127 = 1.00000
+    138 = 1.00000
+    140 = 1.00000
+    147 = 1.00000
+    151 = 1.00000
+    154 = 1.00000
+    155 = 1.00000
+    156 = 1.00000
+    159 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(3)^2], case=0
+    0 = 1.00000
+    4 = 1.00000
+    8 = 1.00000
+    9 = 1.00000
+    56 = 1.00000
+    60 = 1.00000
+    61 = 1.00000
+    182 = 1.00000
+    186 = 1.00000
+    187 = 1.00000
+    224 = 1.00000
+    228 = 1.00000
+    229 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(3)^2], case=1
+    0 = 1.00000
+    4 = 1.00000
+    8 = 1.00000
+    9 = 1.00000
+    56 = 1.00000
+    60 = 1.00000
+    61 = 1.00000
+    122 = 1.00000
+    124 = 1.00000
+    126 = 1.00000
+    127 = 1.00000
+    164 = 1.00000
+    166 = 1.00000
+    167 = 1.00000
+    182 = 1.00000
+    186 = 1.00000
+    187 = 1.00000
+    224 = 1.00000
+    228 = 1.00000
+    229 = 1.00000
+    284 = 1.00000
+    286 = 1.00000
+    287 = 1.00000
+    320 = 1.00000
+    322 = 1.00000
+    323 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(3)^2], case=2
+    0 = 1.00000
+    1 = 1.00000
+    3 = 1.00000
+    4 = 1.00000
+    8 = 1.00000
+    9 = 1.00000
+    18 = 1.00000
+    19 = 1.00000
+    33 = 1.00000
+    42 = 1.00000
+    43 = 1.00000
+    56 = 1.00000
+    60 = 1.00000
+    61 = 1.00000
+    99 = 1.00000
+    108 = 1.00000
+    109 = 1.00000
+    122 = 1.00000
+    123 = 1.00000
+    124 = 1.00000
+    126 = 1.00000
+    127 = 1.00000
+    132 = 1.00000
+    133 = 1.00000
+    164 = 1.00000
+    166 = 1.00000
+    167 = 1.00000
+    182 = 1.00000
+    186 = 1.00000
+    187 = 1.00000
+    224 = 1.00000
+    228 = 1.00000
+    229 = 1.00000
+    284 = 1.00000
+    286 = 1.00000
+    287 = 1.00000
+    320 = 1.00000
+    322 = 1.00000
+    323 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(3)^2], case=3
+    0 = 1.00000
+    1 = 1.00000
+    3 = 1.00000
+    4 = 1.00000
+    8 = 1.00000
+    9 = 1.00000
+    18 = 1.00000
+    19 = 1.00000
+    33 = 1.00000
+    42 = 1.00000
+    43 = 1.00000
+    56 = 1.00000
+    60 = 1.00000
+    61 = 1.00000
+    99 = 1.00000
+    108 = 1.00000
+    109 = 1.00000
+    122 = 1.00000
+    123 = 1.00000
+    124 = 1.00000
+    126 = 1.00000
+    127 = 1.00000
+    132 = 1.00000
+    133 = 1.00000
+    164 = 1.00000
+    166 = 1.00000
+    167 = 1.00000
+    182 = 1.00000
+    186 = 1.00000
+    187 = 1.00000
+    224 = 1.00000
+    225 = 1.00000
+    227 = 1.00000
+    228 = 1.00000
+    229 = 1.00000
+    238 = 1.00000
+    239 = 1.00000
+    249 = 1.00000
+    256 = 1.00000
+    257 = 1.00000
+    284 = 1.00000
+    286 = 1.00000
+    287 = 1.00000
+    303 = 1.00000
+    310 = 1.00000
+    311 = 1.00000
+    320 = 1.00000
+    321 = 1.00000
+    322 = 1.00000
+    323 = 1.00000
+    328 = 1.00000
+    329 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(1)^3], case=0
+    0 = 1.00000
+    6 = 1.00000
+    12 = 1.00000
+    18 = 1.00000
+    36 = 1.00000
+    42 = 1.00000
+    54 = 1.00000
+    60 = 1.00000
+    72 = 1.00000
+    135 = 1.00000
+    141 = 1.00000
+    153 = 1.00000
+    159 = 1.00000
+    171 = 1.00000
+    180 = 1.00000
+    225 = 1.00000
+    231 = 1.00000
+    243 = 1.00000
+    252 = 1.00000
+    258 = 1.00000
+    270 = 1.00000
+    315 = 1.00000
+    324 = 1.00000
+    333 = 1.00000
+    342 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(1)^3], case=1
+    0 = 1.00000
+    6 = 1.00000
+    12 = 1.00000
+    18 = 1.00000
+    36 = 1.00000
+    42 = 1.00000
+    54 = 1.00000
+    60 = 1.00000
+    72 = 1.00000
+    93 = 1.00000
+    96 = 1.00000
+    99 = 1.00000
+    102 = 1.00000
+    111 = 1.00000
+    114 = 1.00000
+    123 = 1.00000
+    126 = 1.00000
+    132 = 1.00000
+    135 = 1.00000
+    141 = 1.00000
+    153 = 1.00000
+    159 = 1.00000
+    171 = 1.00000
+    180 = 1.00000
+    195 = 1.00000
+    198 = 1.00000
+    207 = 1.00000
+    210 = 1.00000
+    216 = 1.00000
+    222 = 1.00000
+    225 = 1.00000
+    231 = 1.00000
+    243 = 1.00000
+    252 = 1.00000
+    258 = 1.00000
+    270 = 1.00000
+    285 = 1.00000
+    288 = 1.00000
+    294 = 1.00000
+    303 = 1.00000
+    306 = 1.00000
+    312 = 1.00000
+    315 = 1.00000
+    324 = 1.00000
+    333 = 1.00000
+    342 = 1.00000
+    354 = 1.00000
+    360 = 1.00000
+    366 = 1.00000
+    372 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(1)^3], case=2
+    0 = 1.00000
+    1 = 1.00000
+    4 = 1.00000
+    6 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    16 = 1.00000
+    18 = 1.00000
+    25 = 1.00000
+    31 = 1.00000
+    36 = 1.00000
+    42 = 1.00000
+    54 = 1.00000
+    55 = 1.00000
+    58 = 1.00000
+    60 = 1.00000
+    67 = 1.00000
+    72 = 1.00000
+    82 = 1.00000
+    88 = 1.00000
+    93 = 1.00000
+    94 = 1.00000
+    96 = 1.00000
+    99 = 1.00000
+    100 = 1.00000
+    102 = 1.00000
+    111 = 1.00000
+    114 = 1.00000
+    118 = 1.00000
+    123 = 1.00000
+    124 = 1.00000
+    126 = 1.00000
+    132 = 1.00000
+    135 = 1.00000
+    141 = 1.00000
+    153 = 1.00000
+    159 = 1.00000
+    171 = 1.00000
+    180 = 1.00000
+    195 = 1.00000
+    198 = 1.00000
+    207 = 1.00000
+    210 = 1.00000
+    216 = 1.00000
+    222 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    229 = 1.00000
+    231 = 1.00000
+    238 = 1.00000
+    243 = 1.00000
+    252 = 1.00000
+    253 = 1.00000
+    256 = 1.00000
+    258 = 1.00000
+    265 = 1.00000
+    270 = 1.00000
+    280 = 1.00000
+    285 = 1.00000
+    286 = 1.00000
+    288 = 1.00000
+    294 = 1.00000
+    298 = 1.00000
+    303 = 1.00000
+    304 = 1.00000
+    306 = 1.00000
+    312 = 1.00000
+    315 = 1.00000
+    324 = 1.00000
+    333 = 1.00000
+    342 = 1.00000
+    354 = 1.00000
+    360 = 1.00000
+    366 = 1.00000
+    372 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(1)^3], case=3
+    0 = 1.00000
+    1 = 1.00000
+    4 = 1.00000
+    6 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    16 = 1.00000
+    18 = 1.00000
+    25 = 1.00000
+    31 = 1.00000
+    36 = 1.00000
+    42 = 1.00000
+    54 = 1.00000
+    55 = 1.00000
+    58 = 1.00000
+    60 = 1.00000
+    67 = 1.00000
+    72 = 1.00000
+    82 = 1.00000
+    88 = 1.00000
+    93 = 1.00000
+    94 = 1.00000
+    96 = 1.00000
+    99 = 1.00000
+    100 = 1.00000
+    102 = 1.00000
+    111 = 1.00000
+    114 = 1.00000
+    118 = 1.00000
+    123 = 1.00000
+    124 = 1.00000
+    126 = 1.00000
+    132 = 1.00000
+    135 = 1.00000
+    141 = 1.00000
+    153 = 1.00000
+    154 = 1.00000
+    157 = 1.00000
+    159 = 1.00000
+    160 = 1.00000
+    163 = 1.00000
+    166 = 1.00000
+    169 = 1.00000
+    171 = 1.00000
+    180 = 1.00000
+    181 = 1.00000
+    184 = 1.00000
+    187 = 1.00000
+    195 = 1.00000
+    198 = 1.00000
+    202 = 1.00000
+    205 = 1.00000
+    207 = 1.00000
+    208 = 1.00000
+    210 = 1.00000
+    211 = 1.00000
+    216 = 1.00000
+    220 = 1.00000
+    222 = 1.00000
+    223 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    229 = 1.00000
+    231 = 1.00000
+    238 = 1.00000
+    243 = 1.00000
+    252 = 1.00000
+    253 = 1.00000
+    256 = 1.00000
+    258 = 1.00000
+    265 = 1.00000
+    270 = 1.00000
+    280 = 1.00000
+    285 = 1.00000
+    286 = 1.00000
+    288 = 1.00000
+    294 = 1.00000
+    298 = 1.00000
+    303 = 1.00000
+    304 = 1.00000
+    306 = 1.00000
+    312 = 1.00000
+    315 = 1.00000
+    324 = 1.00000
+    325 = 1.00000
+    328 = 1.00000
+    331 = 1.00000
+    333 = 1.00000
+    342 = 1.00000
+    343 = 1.00000
+    346 = 1.00000
+    349 = 1.00000
+    354 = 1.00000
+    358 = 1.00000
+    360 = 1.00000
+    361 = 1.00000
+    366 = 1.00000
+    370 = 1.00000
+    372 = 1.00000
+    373 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(1)^3], case=4
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    4 = 1.00000
+    5 = 1.00000
+    6 = 1.00000
+    8 = 1.00000
+    11 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    16 = 1.00000
+    18 = 1.00000
+    25 = 1.00000
+    26 = 1.00000
+    29 = 1.00000
+    31 = 1.00000
+    36 = 1.00000
+    38 = 1.00000
+    41 = 1.00000
+    42 = 1.00000
+    50 = 1.00000
+    54 = 1.00000
+    55 = 1.00000
+    58 = 1.00000
+    60 = 1.00000
+    67 = 1.00000
+    72 = 1.00000
+    82 = 1.00000
+    83 = 1.00000
+    86 = 1.00000
+    88 = 1.00000
+    93 = 1.00000
+    94 = 1.00000
+    95 = 1.00000
+    96 = 1.00000
+    98 = 1.00000
+    99 = 1.00000
+    100 = 1.00000
+    102 = 1.00000
+    107 = 1.00000
+    111 = 1.00000
+    113 = 1.00000
+    114 = 1.00000
+    118 = 1.00000
+    123 = 1.00000
+    124 = 1.00000
+    126 = 1.00000
+    132 = 1.00000
+    135 = 1.00000
+    137 = 1.00000
+    140 = 1.00000
+    141 = 1.00000
+    149 = 1.00000
+    153 = 1.00000
+    154 = 1.00000
+    155 = 1.00000
+    157 = 1.00000
+    158 = 1.00000
+    159 = 1.00000
+    160 = 1.00000
+    163 = 1.00000
+    166 = 1.00000
+    167 = 1.00000
+    169 = 1.00000
+    171 = 1.00000
+    180 = 1.00000
+    181 = 1.00000
+    184 = 1.00000
+    187 = 1.00000
+    191 = 1.00000
+    195 = 1.00000
+    197 = 1.00000
+    198 = 1.00000
+    202 = 1.00000
+    203 = 1.00000
+    205 = 1.00000
+    207 = 1.00000
+    208 = 1.00000
+    209 = 1.00000
+    210 = 1.00000
+    211 = 1.00000
+    216 = 1.00000
+    220 = 1.00000
+    222 = 1.00000
+    223 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    229 = 1.00000
+    231 = 1.00000
+    238 = 1.00000
+    243 = 1.00000
+    252 = 1.00000
+    253 = 1.00000
+    256 = 1.00000
+    258 = 1.00000
+    265 = 1.00000
+    270 = 1.00000
+    280 = 1.00000
+    285 = 1.00000
+    286 = 1.00000
+    288 = 1.00000
+    294 = 1.00000
+    298 = 1.00000
+    303 = 1.00000
+    304 = 1.00000
+    306 = 1.00000
+    312 = 1.00000
+    315 = 1.00000
+    324 = 1.00000
+    325 = 1.00000
+    328 = 1.00000
+    331 = 1.00000
+    333 = 1.00000
+    342 = 1.00000
+    343 = 1.00000
+    346 = 1.00000
+    349 = 1.00000
+    354 = 1.00000
+    358 = 1.00000
+    360 = 1.00000
+    361 = 1.00000
+    366 = 1.00000
+    370 = 1.00000
+    372 = 1.00000
+    373 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(1)^3], case=5
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    4 = 1.00000
+    5 = 1.00000
+    6 = 1.00000
+    8 = 1.00000
+    11 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    16 = 1.00000
+    18 = 1.00000
+    25 = 1.00000
+    26 = 1.00000
+    29 = 1.00000
+    31 = 1.00000
+    36 = 1.00000
+    38 = 1.00000
+    41 = 1.00000
+    42 = 1.00000
+    50 = 1.00000
+    54 = 1.00000
+    55 = 1.00000
+    58 = 1.00000
+    60 = 1.00000
+    67 = 1.00000
+    72 = 1.00000
+    82 = 1.00000
+    83 = 1.00000
+    86 = 1.00000
+    88 = 1.00000
+    93 = 1.00000
+    94 = 1.00000
+    95 = 1.00000
+    96 = 1.00000
+    98 = 1.00000
+    99 = 1.00000
+    100 = 1.00000
+    102 = 1.00000
+    107 = 1.00000
+    111 = 1.00000
+    113 = 1.00000
+    114 = 1.00000
+    118 = 1.00000
+    123 = 1.00000
+    124 = 1.00000
+    126 = 1.00000
+    132 = 1.00000
+    135 = 1.00000
+    137 = 1.00000
+    140 = 1.00000
+    141 = 1.00000
+    149 = 1.00000
+    153 = 1.00000
+    154 = 1.00000
+    155 = 1.00000
+    157 = 1.00000
+    158 = 1.00000
+    159 = 1.00000
+    160 = 1.00000
+    163 = 1.00000
+    166 = 1.00000
+    167 = 1.00000
+    169 = 1.00000
+    171 = 1.00000
+    180 = 1.00000
+    181 = 1.00000
+    184 = 1.00000
+    187 = 1.00000
+    191 = 1.00000
+    195 = 1.00000
+    197 = 1.00000
+    198 = 1.00000
+    202 = 1.00000
+    203 = 1.00000
+    205 = 1.00000
+    207 = 1.00000
+    208 = 1.00000
+    209 = 1.00000
+    210 = 1.00000
+    211 = 1.00000
+    216 = 1.00000
+    220 = 1.00000
+    222 = 1.00000
+    223 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    229 = 1.00000
+    231 = 1.00000
+    238 = 1.00000
+    243 = 1.00000
+    252 = 1.00000
+    253 = 1.00000
+    254 = 1.00000
+    256 = 1.00000
+    257 = 1.00000
+    258 = 1.00000
+    260 = 1.00000
+    263 = 1.00000
+    265 = 1.00000
+    266 = 1.00000
+    269 = 1.00000
+    270 = 1.00000
+    272 = 1.00000
+    275 = 1.00000
+    278 = 1.00000
+    280 = 1.00000
+    285 = 1.00000
+    286 = 1.00000
+    288 = 1.00000
+    294 = 1.00000
+    298 = 1.00000
+    299 = 1.00000
+    302 = 1.00000
+    303 = 1.00000
+    304 = 1.00000
+    305 = 1.00000
+    306 = 1.00000
+    308 = 1.00000
+    311 = 1.00000
+    312 = 1.00000
+    314 = 1.00000
+    315 = 1.00000
+    324 = 1.00000
+    325 = 1.00000
+    328 = 1.00000
+    331 = 1.00000
+    333 = 1.00000
+    335 = 1.00000
+    338 = 1.00000
+    341 = 1.00000
+    342 = 1.00000
+    343 = 1.00000
+    344 = 1.00000
+    346 = 1.00000
+    347 = 1.00000
+    349 = 1.00000
+    350 = 1.00000
+    354 = 1.00000
+    358 = 1.00000
+    360 = 1.00000
+    361 = 1.00000
+    365 = 1.00000
+    366 = 1.00000
+    368 = 1.00000
+    370 = 1.00000
+    371 = 1.00000
+    372 = 1.00000
+    373 = 1.00000
+    374 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(2)^3], case=0
+    0 = 1.00000
+    6 = 1.00000
+    12 = 1.00000
+    18 = 1.00000
+    24 = 1.00000
+    36 = 1.00000
+    48 = 1.00000
+    54 = 1.00000
+    60 = 1.00000
+    135 = 1.00000
+    141 = 1.00000
+    147 = 1.00000
+    156 = 1.00000
+    165 = 1.00000
+    171 = 1.00000
+    225 = 1.00000
+    231 = 1.00000
+    237 = 1.00000
+    249 = 1.00000
+    255 = 1.00000
+    261 = 1.00000
+    315 = 1.00000
+    321 = 1.00000
+    330 = 1.00000
+    336 = 1.00000
+    675 = 1.00000
+    681 = 1.00000
+    687 = 1.00000
+    696 = 1.00000
+    705 = 1.00000
+    711 = 1.00000
+    765 = 1.00000
+    771 = 1.00000
+    777 = 1.00000
+    786 = 1.00000
+    795 = 1.00000
+    801 = 1.00000
+    855 = 1.00000
+    861 = 1.00000
+    870 = 1.00000
+    876 = 1.00000
+    915 = 1.00000
+    921 = 1.00000
+    930 = 1.00000
+    936 = 1.00000
+    1215 = 1.00000
+    1221 = 1.00000
+    1227 = 1.00000
+    1239 = 1.00000
+    1245 = 1.00000
+    1251 = 1.00000
+    1305 = 1.00000
+    1311 = 1.00000
+    1320 = 1.00000
+    1326 = 1.00000
+    1365 = 1.00000
+    1371 = 1.00000
+    1377 = 1.00000
+    1389 = 1.00000
+    1395 = 1.00000
+    1401 = 1.00000
+    1455 = 1.00000
+    1461 = 1.00000
+    1470 = 1.00000
+    1476 = 1.00000
+    1755 = 1.00000
+    1761 = 1.00000
+    1770 = 1.00000
+    1776 = 1.00000
+    1815 = 1.00000
+    1821 = 1.00000
+    1830 = 1.00000
+    1836 = 1.00000
+    1875 = 1.00000
+    1881 = 1.00000
+    1890 = 1.00000
+    1896 = 1.00000
+    1935 = 1.00000
+    1941 = 1.00000
+    1950 = 1.00000
+    1956 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(2)^3], case=1
+    0 = 1.00000
+    6 = 1.00000
+    12 = 1.00000
+    18 = 1.00000
+    24 = 1.00000
+    36 = 1.00000
+    48 = 1.00000
+    54 = 1.00000
+    60 = 1.00000
+    135 = 1.00000
+    141 = 1.00000
+    147 = 1.00000
+    156 = 1.00000
+    165 = 1.00000
+    171 = 1.00000
+    225 = 1.00000
+    231 = 1.00000
+    237 = 1.00000
+    249 = 1.00000
+    255 = 1.00000
+    261 = 1.00000
+    315 = 1.00000
+    321 = 1.00000
+    330 = 1.00000
+    336 = 1.00000
+    429 = 1.00000
+    432 = 1.00000
+    435 = 1.00000
+    438 = 1.00000
+    441 = 1.00000
+    450 = 1.00000
+    459 = 1.00000
+    462 = 1.00000
+    465 = 1.00000
+    519 = 1.00000
+    522 = 1.00000
+    525 = 1.00000
+    531 = 1.00000
+    537 = 1.00000
+    540 = 1.00000
+    591 = 1.00000
+    594 = 1.00000
+    597 = 1.00000
+    606 = 1.00000
+    609 = 1.00000
+    612 = 1.00000
+    651 = 1.00000
+    654 = 1.00000
+    660 = 1.00000
+    663 = 1.00000
+    675 = 1.00000
+    681 = 1.00000
+    687 = 1.00000
+    696 = 1.00000
+    705 = 1.00000
+    711 = 1.00000
+    765 = 1.00000
+    771 = 1.00000
+    777 = 1.00000
+    786 = 1.00000
+    795 = 1.00000
+    801 = 1.00000
+    855 = 1.00000
+    861 = 1.00000
+    870 = 1.00000
+    876 = 1.00000
+    915 = 1.00000
+    921 = 1.00000
+    930 = 1.00000
+    936 = 1.00000
+    1011 = 1.00000
+    1014 = 1.00000
+    1017 = 1.00000
+    1023 = 1.00000
+    1029 = 1.00000
+    1032 = 1.00000
+    1083 = 1.00000
+    1086 = 1.00000
+    1089 = 1.00000
+    1095 = 1.00000
+    1101 = 1.00000
+    1104 = 1.00000
+    1143 = 1.00000
+    1146 = 1.00000
+    1152 = 1.00000
+    1155 = 1.00000
+    1191 = 1.00000
+    1194 = 1.00000
+    1200 = 1.00000
+    1203 = 1.00000
+    1215 = 1.00000
+    1221 = 1.00000
+    1227 = 1.00000
+    1239 = 1.00000
+    1245 = 1.00000
+    1251 = 1.00000
+    1305 = 1.00000
+    1311 = 1.00000
+    1320 = 1.00000
+    1326 = 1.00000
+    1365 = 1.00000
+    1371 = 1.00000
+    1377 = 1.00000
+    1389 = 1.00000
+    1395 = 1.00000
+    1401 = 1.00000
+    1455 = 1.00000
+    1461 = 1.00000
+    1470 = 1.00000
+    1476 = 1.00000
+    1551 = 1.00000
+    1554 = 1.00000
+    1557 = 1.00000
+    1566 = 1.00000
+    1569 = 1.00000
+    1572 = 1.00000
+    1611 = 1.00000
+    1614 = 1.00000
+    1620 = 1.00000
+    1623 = 1.00000
+    1671 = 1.00000
+    1674 = 1.00000
+    1677 = 1.00000
+    1686 = 1.00000
+    1689 = 1.00000
+    1692 = 1.00000
+    1731 = 1.00000
+    1734 = 1.00000
+    1740 = 1.00000
+    1743 = 1.00000
+    1755 = 1.00000
+    1761 = 1.00000
+    1770 = 1.00000
+    1776 = 1.00000
+    1815 = 1.00000
+    1821 = 1.00000
+    1830 = 1.00000
+    1836 = 1.00000
+    1875 = 1.00000
+    1881 = 1.00000
+    1890 = 1.00000
+    1896 = 1.00000
+    1935 = 1.00000
+    1941 = 1.00000
+    1950 = 1.00000
+    1956 = 1.00000
+    2019 = 1.00000
+    2022 = 1.00000
+    2028 = 1.00000
+    2031 = 1.00000
+    2067 = 1.00000
+    2070 = 1.00000
+    2076 = 1.00000
+    2079 = 1.00000
+    2115 = 1.00000
+    2118 = 1.00000
+    2124 = 1.00000
+    2127 = 1.00000
+    2163 = 1.00000
+    2166 = 1.00000
+    2172 = 1.00000
+    2175 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(2)^3], case=2
+    0 = 1.00000
+    1 = 1.00000
+    4 = 1.00000
+    6 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    16 = 1.00000
+    18 = 1.00000
+    24 = 1.00000
+    31 = 1.00000
+    36 = 1.00000
+    43 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    52 = 1.00000
+    54 = 1.00000
+    60 = 1.00000
+    67 = 1.00000
+    82 = 1.00000
+    88 = 1.00000
+    97 = 1.00000
+    106 = 1.00000
+    112 = 1.00000
+    121 = 1.00000
+    135 = 1.00000
+    141 = 1.00000
+    147 = 1.00000
+    156 = 1.00000
+    165 = 1.00000
+    171 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    229 = 1.00000
+    231 = 1.00000
+    237 = 1.00000
+    244 = 1.00000
+    249 = 1.00000
+    250 = 1.00000
+    253 = 1.00000
+    255 = 1.00000
+    261 = 1.00000
+    268 = 1.00000
+    280 = 1.00000
+    289 = 1.00000
+    295 = 1.00000
+    304 = 1.00000
+    315 = 1.00000
+    321 = 1.00000
+    330 = 1.00000
+    336 = 1.00000
+    376 = 1.00000
+    382 = 1.00000
+    391 = 1.00000
+    400 = 1.00000
+    406 = 1.00000
+    415 = 1.00000
+    429 = 1.00000
+    430 = 1.00000
+    432 = 1.00000
+    435 = 1.00000
+    436 = 1.00000
+    438 = 1.00000
+    441 = 1.00000
+    445 = 1.00000
+    450 = 1.00000
+    454 = 1.00000
+    459 = 1.00000
+    460 = 1.00000
+    462 = 1.00000
+    465 = 1.00000
+    469 = 1.00000
+    519 = 1.00000
+    522 = 1.00000
+    525 = 1.00000
+    531 = 1.00000
+    537 = 1.00000
+    540 = 1.00000
+    556 = 1.00000
+    565 = 1.00000
+    571 = 1.00000
+    580 = 1.00000
+    591 = 1.00000
+    592 = 1.00000
+    594 = 1.00000
+    597 = 1.00000
+    601 = 1.00000
+    606 = 1.00000
+    607 = 1.00000
+    609 = 1.00000
+    612 = 1.00000
+    616 = 1.00000
+    651 = 1.00000
+    654 = 1.00000
+    660 = 1.00000
+    663 = 1.00000
+    675 = 1.00000
+    681 = 1.00000
+    687 = 1.00000
+    696 = 1.00000
+    705 = 1.00000
+    711 = 1.00000
+    765 = 1.00000
+    771 = 1.00000
+    777 = 1.00000
+    786 = 1.00000
+    795 = 1.00000
+    801 = 1.00000
+    855 = 1.00000
+    861 = 1.00000
+    870 = 1.00000
+    876 = 1.00000
+    915 = 1.00000
+    921 = 1.00000
+    930 = 1.00000
+    936 = 1.00000
+    1011 = 1.00000
+    1014 = 1.00000
+    1017 = 1.00000
+    1023 = 1.00000
+    1029 = 1.00000
+    1032 = 1.00000
+    1083 = 1.00000
+    1086 = 1.00000
+    1089 = 1.00000
+    1095 = 1.00000
+    1101 = 1.00000
+    1104 = 1.00000
+    1143 = 1.00000
+    1146 = 1.00000
+    1152 = 1.00000
+    1155 = 1.00000
+    1191 = 1.00000
+    1194 = 1.00000
+    1200 = 1.00000
+    1203 = 1.00000
+    1215 = 1.00000
+    1216 = 1.00000
+    1219 = 1.00000
+    1221 = 1.00000
+    1227 = 1.00000
+    1234 = 1.00000
+    1239 = 1.00000
+    1240 = 1.00000
+    1243 = 1.00000
+    1245 = 1.00000
+    1251 = 1.00000
+    1258 = 1.00000
+    1270 = 1.00000
+    1279 = 1.00000
+    1285 = 1.00000
+    1294 = 1.00000
+    1305 = 1.00000
+    1311 = 1.00000
+    1320 = 1.00000
+    1326 = 1.00000
+    1365 = 1.00000
+    1366 = 1.00000
+    1369 = 1.00000
+    1371 = 1.00000
+    1377 = 1.00000
+    1384 = 1.00000
+    1389 = 1.00000
+    1390 = 1.00000
+    1393 = 1.00000
+    1395 = 1.00000
+    1401 = 1.00000
+    1408 = 1.00000
+    1420 = 1.00000
+    1429 = 1.00000
+    1435 = 1.00000
+    1444 = 1.00000
+    1455 = 1.00000
+    1461 = 1.00000
+    1470 = 1.00000
+    1476 = 1.00000
+    1516 = 1.00000
+    1525 = 1.00000
+    1531 = 1.00000
+    1540 = 1.00000
+    1551 = 1.00000
+    1552 = 1.00000
+    1554 = 1.00000
+    1557 = 1.00000
+    1561 = 1.00000
+    1566 = 1.00000
+    1567 = 1.00000
+    1569 = 1.00000
+    1572 = 1.00000
+    1576 = 1.00000
+    1611 = 1.00000
+    1614 = 1.00000
+    1620 = 1.00000
+    1623 = 1.00000
+    1636 = 1.00000
+    1645 = 1.00000
+    1651 = 1.00000
+    1660 = 1.00000
+    1671 = 1.00000
+    1672 = 1.00000
+    1674 = 1.00000
+    1677 = 1.00000
+    1681 = 1.00000
+    1686 = 1.00000
+    1687 = 1.00000
+    1689 = 1.00000
+    1692 = 1.00000
+    1696 = 1.00000
+    1731 = 1.00000
+    1734 = 1.00000
+    1740 = 1.00000
+    1743 = 1.00000
+    1755 = 1.00000
+    1761 = 1.00000
+    1770 = 1.00000
+    1776 = 1.00000
+    1815 = 1.00000
+    1821 = 1.00000
+    1830 = 1.00000
+    1836 = 1.00000
+    1875 = 1.00000
+    1881 = 1.00000
+    1890 = 1.00000
+    1896 = 1.00000
+    1935 = 1.00000
+    1941 = 1.00000
+    1950 = 1.00000
+    1956 = 1.00000
+    2019 = 1.00000
+    2022 = 1.00000
+    2028 = 1.00000
+    2031 = 1.00000
+    2067 = 1.00000
+    2070 = 1.00000
+    2076 = 1.00000
+    2079 = 1.00000
+    2115 = 1.00000
+    2118 = 1.00000
+    2124 = 1.00000
+    2127 = 1.00000
+    2163 = 1.00000
+    2166 = 1.00000
+    2172 = 1.00000
+    2175 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(2)^3], case=3
+    0 = 1.00000
+    1 = 1.00000
+    4 = 1.00000
+    6 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    16 = 1.00000
+    18 = 1.00000
+    24 = 1.00000
+    31 = 1.00000
+    36 = 1.00000
+    43 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    52 = 1.00000
+    54 = 1.00000
+    60 = 1.00000
+    67 = 1.00000
+    82 = 1.00000
+    88 = 1.00000
+    97 = 1.00000
+    106 = 1.00000
+    112 = 1.00000
+    121 = 1.00000
+    135 = 1.00000
+    141 = 1.00000
+    147 = 1.00000
+    156 = 1.00000
+    165 = 1.00000
+    171 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    229 = 1.00000
+    231 = 1.00000
+    237 = 1.00000
+    244 = 1.00000
+    249 = 1.00000
+    250 = 1.00000
+    253 = 1.00000
+    255 = 1.00000
+    261 = 1.00000
+    268 = 1.00000
+    280 = 1.00000
+    289 = 1.00000
+    295 = 1.00000
+    304 = 1.00000
+    315 = 1.00000
+    321 = 1.00000
+    330 = 1.00000
+    336 = 1.00000
+    376 = 1.00000
+    382 = 1.00000
+    391 = 1.00000
+    400 = 1.00000
+    406 = 1.00000
+    415 = 1.00000
+    429 = 1.00000
+    430 = 1.00000
+    432 = 1.00000
+    435 = 1.00000
+    436 = 1.00000
+    438 = 1.00000
+    441 = 1.00000
+    445 = 1.00000
+    450 = 1.00000
+    454 = 1.00000
+    459 = 1.00000
+    460 = 1.00000
+    462 = 1.00000
+    465 = 1.00000
+    469 = 1.00000
+    519 = 1.00000
+    522 = 1.00000
+    525 = 1.00000
+    531 = 1.00000
+    537 = 1.00000
+    540 = 1.00000
+    556 = 1.00000
+    565 = 1.00000
+    571 = 1.00000
+    580 = 1.00000
+    591 = 1.00000
+    592 = 1.00000
+    594 = 1.00000
+    597 = 1.00000
+    601 = 1.00000
+    606 = 1.00000
+    607 = 1.00000
+    609 = 1.00000
+    612 = 1.00000
+    616 = 1.00000
+    651 = 1.00000
+    654 = 1.00000
+    660 = 1.00000
+    663 = 1.00000
+    675 = 1.00000
+    681 = 1.00000
+    687 = 1.00000
+    696 = 1.00000
+    705 = 1.00000
+    711 = 1.00000
+    765 = 1.00000
+    766 = 1.00000
+    769 = 1.00000
+    771 = 1.00000
+    772 = 1.00000
+    775 = 1.00000
+    777 = 1.00000
+    784 = 1.00000
+    786 = 1.00000
+    793 = 1.00000
+    795 = 1.00000
+    796 = 1.00000
+    799 = 1.00000
+    801 = 1.00000
+    808 = 1.00000
+    820 = 1.00000
+    823 = 1.00000
+    829 = 1.00000
+    835 = 1.00000
+    838 = 1.00000
+    844 = 1.00000
+    855 = 1.00000
+    861 = 1.00000
+    870 = 1.00000
+    876 = 1.00000
+    915 = 1.00000
+    916 = 1.00000
+    919 = 1.00000
+    921 = 1.00000
+    928 = 1.00000
+    930 = 1.00000
+    931 = 1.00000
+    934 = 1.00000
+    936 = 1.00000
+    943 = 1.00000
+    952 = 1.00000
+    958 = 1.00000
+    961 = 1.00000
+    967 = 1.00000
+    1011 = 1.00000
+    1014 = 1.00000
+    1017 = 1.00000
+    1023 = 1.00000
+    1029 = 1.00000
+    1032 = 1.00000
+    1048 = 1.00000
+    1051 = 1.00000
+    1057 = 1.00000
+    1063 = 1.00000
+    1066 = 1.00000
+    1072 = 1.00000
+    1083 = 1.00000
+    1084 = 1.00000
+    1086 = 1.00000
+    1087 = 1.00000
+    1089 = 1.00000
+    1093 = 1.00000
+    1095 = 1.00000
+    1099 = 1.00000
+    1101 = 1.00000
+    1102 = 1.00000
+    1104 = 1.00000
+    1108 = 1.00000
+    1143 = 1.00000
+    1146 = 1.00000
+    1152 = 1.00000
+    1155 = 1.00000
+    1168 = 1.00000
+    1174 = 1.00000
+    1177 = 1.00000
+    1183 = 1.00000
+    1191 = 1.00000
+    1192 = 1.00000
+    1194 = 1.00000
+    1198 = 1.00000
+    1200 = 1.00000
+    1201 = 1.00000
+    1203 = 1.00000
+    1207 = 1.00000
+    1215 = 1.00000
+    1216 = 1.00000
+    1219 = 1.00000
+    1221 = 1.00000
+    1227 = 1.00000
+    1234 = 1.00000
+    1239 = 1.00000
+    1240 = 1.00000
+    1243 = 1.00000
+    1245 = 1.00000
+    1251 = 1.00000
+    1258 = 1.00000
+    1270 = 1.00000
+    1279 = 1.00000
+    1285 = 1.00000
+    1294 = 1.00000
+    1305 = 1.00000
+    1311 = 1.00000
+    1320 = 1.00000
+    1326 = 1.00000
+    1365 = 1.00000
+    1366 = 1.00000
+    1369 = 1.00000
+    1371 = 1.00000
+    1377 = 1.00000
+    1384 = 1.00000
+    1389 = 1.00000
+    1390 = 1.00000
+    1393 = 1.00000
+    1395 = 1.00000
+    1401 = 1.00000
+    1408 = 1.00000
+    1420 = 1.00000
+    1429 = 1.00000
+    1435 = 1.00000
+    1444 = 1.00000
+    1455 = 1.00000
+    1461 = 1.00000
+    1470 = 1.00000
+    1476 = 1.00000
+    1516 = 1.00000
+    1525 = 1.00000
+    1531 = 1.00000
+    1540 = 1.00000
+    1551 = 1.00000
+    1552 = 1.00000
+    1554 = 1.00000
+    1557 = 1.00000
+    1561 = 1.00000
+    1566 = 1.00000
+    1567 = 1.00000
+    1569 = 1.00000
+    1572 = 1.00000
+    1576 = 1.00000
+    1611 = 1.00000
+    1614 = 1.00000
+    1620 = 1.00000
+    1623 = 1.00000
+    1636 = 1.00000
+    1645 = 1.00000
+    1651 = 1.00000
+    1660 = 1.00000
+    1671 = 1.00000
+    1672 = 1.00000
+    1674 = 1.00000
+    1677 = 1.00000
+    1681 = 1.00000
+    1686 = 1.00000
+    1687 = 1.00000
+    1689 = 1.00000
+    1692 = 1.00000
+    1696 = 1.00000
+    1731 = 1.00000
+    1734 = 1.00000
+    1740 = 1.00000
+    1743 = 1.00000
+    1755 = 1.00000
+    1761 = 1.00000
+    1770 = 1.00000
+    1776 = 1.00000
+    1815 = 1.00000
+    1816 = 1.00000
+    1819 = 1.00000
+    1821 = 1.00000
+    1828 = 1.00000
+    1830 = 1.00000
+    1831 = 1.00000
+    1834 = 1.00000
+    1836 = 1.00000
+    1843 = 1.00000
+    1852 = 1.00000
+    1858 = 1.00000
+    1861 = 1.00000
+    1867 = 1.00000
+    1875 = 1.00000
+    1881 = 1.00000
+    1890 = 1.00000
+    1896 = 1.00000
+    1935 = 1.00000
+    1936 = 1.00000
+    1939 = 1.00000
+    1941 = 1.00000
+    1948 = 1.00000
+    1950 = 1.00000
+    1951 = 1.00000
+    1954 = 1.00000
+    1956 = 1.00000
+    1963 = 1.00000
+    1972 = 1.00000
+    1978 = 1.00000
+    1981 = 1.00000
+    1987 = 1.00000
+    2019 = 1.00000
+    2022 = 1.00000
+    2028 = 1.00000
+    2031 = 1.00000
+    2044 = 1.00000
+    2050 = 1.00000
+    2053 = 1.00000
+    2059 = 1.00000
+    2067 = 1.00000
+    2068 = 1.00000
+    2070 = 1.00000
+    2074 = 1.00000
+    2076 = 1.00000
+    2077 = 1.00000
+    2079 = 1.00000
+    2083 = 1.00000
+    2115 = 1.00000
+    2118 = 1.00000
+    2124 = 1.00000
+    2127 = 1.00000
+    2140 = 1.00000
+    2146 = 1.00000
+    2149 = 1.00000
+    2155 = 1.00000
+    2163 = 1.00000
+    2164 = 1.00000
+    2166 = 1.00000
+    2170 = 1.00000
+    2172 = 1.00000
+    2173 = 1.00000
+    2175 = 1.00000
+    2179 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(2)^3], case=4
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    4 = 1.00000
+    5 = 1.00000
+    6 = 1.00000
+    8 = 1.00000
+    11 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    16 = 1.00000
+    18 = 1.00000
+    24 = 1.00000
+    26 = 1.00000
+    29 = 1.00000
+    31 = 1.00000
+    32 = 1.00000
+    35 = 1.00000
+    36 = 1.00000
+    43 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    52 = 1.00000
+    54 = 1.00000
+    60 = 1.00000
+    67 = 1.00000
+    74 = 1.00000
+    82 = 1.00000
+    83 = 1.00000
+    86 = 1.00000
+    88 = 1.00000
+    95 = 1.00000
+    97 = 1.00000
+    98 = 1.00000
+    101 = 1.00000
+    106 = 1.00000
+    112 = 1.00000
+    121 = 1.00000
+    128 = 1.00000
+    135 = 1.00000
+    137 = 1.00000
+    140 = 1.00000
+    141 = 1.00000
+    147 = 1.00000
+    149 = 1.00000
+    152 = 1.00000
+    155 = 1.00000
+    156 = 1.00000
+    165 = 1.00000
+    171 = 1.00000
+    182 = 1.00000
+    191 = 1.00000
+    197 = 1.00000
+    200 = 1.00000
+    218 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    229 = 1.00000
+    231 = 1.00000
+    237 = 1.00000
+    244 = 1.00000
+    249 = 1.00000
+    250 = 1.00000
+    253 = 1.00000
+    255 = 1.00000
+    261 = 1.00000
+    268 = 1.00000
+    280 = 1.00000
+    289 = 1.00000
+    295 = 1.00000
+    304 = 1.00000
+    315 = 1.00000
+    321 = 1.00000
+    330 = 1.00000
+    336 = 1.00000
+    376 = 1.00000
+    377 = 1.00000
+    380 = 1.00000
+    382 = 1.00000
+    389 = 1.00000
+    391 = 1.00000
+    392 = 1.00000
+    395 = 1.00000
+    400 = 1.00000
+    406 = 1.00000
+    415 = 1.00000
+    422 = 1.00000
+    429 = 1.00000
+    430 = 1.00000
+    431 = 1.00000
+    432 = 1.00000
+    434 = 1.00000
+    435 = 1.00000
+    436 = 1.00000
+    438 = 1.00000
+    441 = 1.00000
+    443 = 1.00000
+    445 = 1.00000
+    446 = 1.00000
+    449 = 1.00000
+    450 = 1.00000
+    454 = 1.00000
+    459 = 1.00000
+    460 = 1.00000
+    462 = 1.00000
+    465 = 1.00000
+    469 = 1.00000
+    476 = 1.00000
+    485 = 1.00000
+    491 = 1.00000
+    494 = 1.00000
+    512 = 1.00000
+    519 = 1.00000
+    521 = 1.00000
+    522 = 1.00000
+    525 = 1.00000
+    527 = 1.00000
+    530 = 1.00000
+    531 = 1.00000
+    537 = 1.00000
+    540 = 1.00000
+    548 = 1.00000
+    556 = 1.00000
+    565 = 1.00000
+    571 = 1.00000
+    580 = 1.00000
+    591 = 1.00000
+    592 = 1.00000
+    594 = 1.00000
+    597 = 1.00000
+    601 = 1.00000
+    606 = 1.00000
+    607 = 1.00000
+    609 = 1.00000
+    612 = 1.00000
+    616 = 1.00000
+    651 = 1.00000
+    654 = 1.00000
+    660 = 1.00000
+    663 = 1.00000
+    675 = 1.00000
+    677 = 1.00000
+    680 = 1.00000
+    681 = 1.00000
+    687 = 1.00000
+    689 = 1.00000
+    692 = 1.00000
+    695 = 1.00000
+    696 = 1.00000
+    705 = 1.00000
+    711 = 1.00000
+    722 = 1.00000
+    731 = 1.00000
+    737 = 1.00000
+    740 = 1.00000
+    758 = 1.00000
+    765 = 1.00000
+    766 = 1.00000
+    767 = 1.00000
+    769 = 1.00000
+    770 = 1.00000
+    771 = 1.00000
+    772 = 1.00000
+    775 = 1.00000
+    777 = 1.00000
+    779 = 1.00000
+    782 = 1.00000
+    784 = 1.00000
+    785 = 1.00000
+    786 = 1.00000
+    793 = 1.00000
+    795 = 1.00000
+    796 = 1.00000
+    799 = 1.00000
+    801 = 1.00000
+    808 = 1.00000
+    812 = 1.00000
+    820 = 1.00000
+    821 = 1.00000
+    823 = 1.00000
+    827 = 1.00000
+    829 = 1.00000
+    830 = 1.00000
+    835 = 1.00000
+    838 = 1.00000
+    844 = 1.00000
+    848 = 1.00000
+    855 = 1.00000
+    861 = 1.00000
+    870 = 1.00000
+    876 = 1.00000
+    915 = 1.00000
+    916 = 1.00000
+    919 = 1.00000
+    921 = 1.00000
+    928 = 1.00000
+    930 = 1.00000
+    931 = 1.00000
+    934 = 1.00000
+    936 = 1.00000
+    943 = 1.00000
+    952 = 1.00000
+    958 = 1.00000
+    961 = 1.00000
+    967 = 1.00000
+    977 = 1.00000
+    983 = 1.00000
+    986 = 1.00000
+    1004 = 1.00000
+    1011 = 1.00000
+    1013 = 1.00000
+    1014 = 1.00000
+    1017 = 1.00000
+    1019 = 1.00000
+    1022 = 1.00000
+    1023 = 1.00000
+    1029 = 1.00000
+    1032 = 1.00000
+    1040 = 1.00000
+    1048 = 1.00000
+    1049 = 1.00000
+    1051 = 1.00000
+    1055 = 1.00000
+    1057 = 1.00000
+    1058 = 1.00000
+    1063 = 1.00000
+    1066 = 1.00000
+    1072 = 1.00000
+    1076 = 1.00000
+    1083 = 1.00000
+    1084 = 1.00000
+    1085 = 1.00000
+    1086 = 1.00000
+    1087 = 1.00000
+    1089 = 1.00000
+    1091 = 1.00000
+    1093 = 1.00000
+    1094 = 1.00000
+    1095 = 1.00000
+    1099 = 1.00000
+    1101 = 1.00000
+    1102 = 1.00000
+    1104 = 1.00000
+    1108 = 1.00000
+    1112 = 1.00000
+    1143 = 1.00000
+    1146 = 1.00000
+    1152 = 1.00000
+    1155 = 1.00000
+    1168 = 1.00000
+    1174 = 1.00000
+    1177 = 1.00000
+    1183 = 1.00000
+    1191 = 1.00000
+    1192 = 1.00000
+    1194 = 1.00000
+    1198 = 1.00000
+    1200 = 1.00000
+    1201 = 1.00000
+    1203 = 1.00000
+    1207 = 1.00000
+    1215 = 1.00000
+    1216 = 1.00000
+    1219 = 1.00000
+    1221 = 1.00000
+    1227 = 1.00000
+    1234 = 1.00000
+    1239 = 1.00000
+    1240 = 1.00000
+    1243 = 1.00000
+    1245 = 1.00000
+    1251 = 1.00000
+    1258 = 1.00000
+    1270 = 1.00000
+    1279 = 1.00000
+    1285 = 1.00000
+    1294 = 1.00000
+    1305 = 1.00000
+    1311 = 1.00000
+    1320 = 1.00000
+    1326 = 1.00000
+    1365 = 1.00000
+    1366 = 1.00000
+    1369 = 1.00000
+    1371 = 1.00000
+    1377 = 1.00000
+    1384 = 1.00000
+    1389 = 1.00000
+    1390 = 1.00000
+    1393 = 1.00000
+    1395 = 1.00000
+    1401 = 1.00000
+    1408 = 1.00000
+    1420 = 1.00000
+    1429 = 1.00000
+    1435 = 1.00000
+    1444 = 1.00000
+    1455 = 1.00000
+    1461 = 1.00000
+    1470 = 1.00000
+    1476 = 1.00000
+    1516 = 1.00000
+    1525 = 1.00000
+    1531 = 1.00000
+    1540 = 1.00000
+    1551 = 1.00000
+    1552 = 1.00000
+    1554 = 1.00000
+    1557 = 1.00000
+    1561 = 1.00000
+    1566 = 1.00000
+    1567 = 1.00000
+    1569 = 1.00000
+    1572 = 1.00000
+    1576 = 1.00000
+    1611 = 1.00000
+    1614 = 1.00000
+    1620 = 1.00000
+    1623 = 1.00000
+    1636 = 1.00000
+    1645 = 1.00000
+    1651 = 1.00000
+    1660 = 1.00000
+    1671 = 1.00000
+    1672 = 1.00000
+    1674 = 1.00000
+    1677 = 1.00000
+    1681 = 1.00000
+    1686 = 1.00000
+    1687 = 1.00000
+    1689 = 1.00000
+    1692 = 1.00000
+    1696 = 1.00000
+    1731 = 1.00000
+    1734 = 1.00000
+    1740 = 1.00000
+    1743 = 1.00000
+    1755 = 1.00000
+    1761 = 1.00000
+    1770 = 1.00000
+    1776 = 1.00000
+    1815 = 1.00000
+    1816 = 1.00000
+    1819 = 1.00000
+    1821 = 1.00000
+    1828 = 1.00000
+    1830 = 1.00000
+    1831 = 1.00000
+    1834 = 1.00000
+    1836 = 1.00000
+    1843 = 1.00000
+    1852 = 1.00000
+    1858 = 1.00000
+    1861 = 1.00000
+    1867 = 1.00000
+    1875 = 1.00000
+    1881 = 1.00000
+    1890 = 1.00000
+    1896 = 1.00000
+    1935 = 1.00000
+    1936 = 1.00000
+    1939 = 1.00000
+    1941 = 1.00000
+    1948 = 1.00000
+    1950 = 1.00000
+    1951 = 1.00000
+    1954 = 1.00000
+    1956 = 1.00000
+    1963 = 1.00000
+    1972 = 1.00000
+    1978 = 1.00000
+    1981 = 1.00000
+    1987 = 1.00000
+    2019 = 1.00000
+    2022 = 1.00000
+    2028 = 1.00000
+    2031 = 1.00000
+    2044 = 1.00000
+    2050 = 1.00000
+    2053 = 1.00000
+    2059 = 1.00000
+    2067 = 1.00000
+    2068 = 1.00000
+    2070 = 1.00000
+    2074 = 1.00000
+    2076 = 1.00000
+    2077 = 1.00000
+    2079 = 1.00000
+    2083 = 1.00000
+    2115 = 1.00000
+    2118 = 1.00000
+    2124 = 1.00000
+    2127 = 1.00000
+    2140 = 1.00000
+    2146 = 1.00000
+    2149 = 1.00000
+    2155 = 1.00000
+    2163 = 1.00000
+    2164 = 1.00000
+    2166 = 1.00000
+    2170 = 1.00000
+    2172 = 1.00000
+    2173 = 1.00000
+    2175 = 1.00000
+    2179 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(2)^3], case=5
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    4 = 1.00000
+    5 = 1.00000
+    6 = 1.00000
+    8 = 1.00000
+    11 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    16 = 1.00000
+    18 = 1.00000
+    24 = 1.00000
+    26 = 1.00000
+    29 = 1.00000
+    31 = 1.00000
+    32 = 1.00000
+    35 = 1.00000
+    36 = 1.00000
+    43 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    52 = 1.00000
+    54 = 1.00000
+    60 = 1.00000
+    67 = 1.00000
+    74 = 1.00000
+    82 = 1.00000
+    83 = 1.00000
+    86 = 1.00000
+    88 = 1.00000
+    95 = 1.00000
+    97 = 1.00000
+    98 = 1.00000
+    101 = 1.00000
+    106 = 1.00000
+    112 = 1.00000
+    121 = 1.00000
+    128 = 1.00000
+    135 = 1.00000
+    137 = 1.00000
+    140 = 1.00000
+    141 = 1.00000
+    147 = 1.00000
+    149 = 1.00000
+    152 = 1.00000
+    155 = 1.00000
+    156 = 1.00000
+    165 = 1.00000
+    171 = 1.00000
+    182 = 1.00000
+    191 = 1.00000
+    197 = 1.00000
+    200 = 1.00000
+    218 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    229 = 1.00000
+    231 = 1.00000
+    237 = 1.00000
+    244 = 1.00000
+    249 = 1.00000
+    250 = 1.00000
+    253 = 1.00000
+    255 = 1.00000
+    261 = 1.00000
+    268 = 1.00000
+    280 = 1.00000
+    289 = 1.00000
+    295 = 1.00000
+    304 = 1.00000
+    315 = 1.00000
+    321 = 1.00000
+    330 = 1.00000
+    336 = 1.00000
+    376 = 1.00000
+    377 = 1.00000
+    380 = 1.00000
+    382 = 1.00000
+    389 = 1.00000
+    391 = 1.00000
+    392 = 1.00000
+    395 = 1.00000
+    400 = 1.00000
+    406 = 1.00000
+    415 = 1.00000
+    422 = 1.00000
+    429 = 1.00000
+    430 = 1.00000
+    431 = 1.00000
+    432 = 1.00000
+    434 = 1.00000
+    435 = 1.00000
+    436 = 1.00000
+    438 = 1.00000
+    441 = 1.00000
+    443 = 1.00000
+    445 = 1.00000
+    446 = 1.00000
+    449 = 1.00000
+    450 = 1.00000
+    454 = 1.00000
+    459 = 1.00000
+    460 = 1.00000
+    462 = 1.00000
+    465 = 1.00000
+    469 = 1.00000
+    476 = 1.00000
+    485 = 1.00000
+    491 = 1.00000
+    494 = 1.00000
+    512 = 1.00000
+    519 = 1.00000
+    521 = 1.00000
+    522 = 1.00000
+    525 = 1.00000
+    527 = 1.00000
+    530 = 1.00000
+    531 = 1.00000
+    537 = 1.00000
+    540 = 1.00000
+    548 = 1.00000
+    556 = 1.00000
+    565 = 1.00000
+    571 = 1.00000
+    580 = 1.00000
+    591 = 1.00000
+    592 = 1.00000
+    594 = 1.00000
+    597 = 1.00000
+    601 = 1.00000
+    606 = 1.00000
+    607 = 1.00000
+    609 = 1.00000
+    612 = 1.00000
+    616 = 1.00000
+    651 = 1.00000
+    654 = 1.00000
+    660 = 1.00000
+    663 = 1.00000
+    675 = 1.00000
+    677 = 1.00000
+    680 = 1.00000
+    681 = 1.00000
+    687 = 1.00000
+    689 = 1.00000
+    692 = 1.00000
+    695 = 1.00000
+    696 = 1.00000
+    705 = 1.00000
+    711 = 1.00000
+    722 = 1.00000
+    731 = 1.00000
+    737 = 1.00000
+    740 = 1.00000
+    758 = 1.00000
+    765 = 1.00000
+    766 = 1.00000
+    767 = 1.00000
+    769 = 1.00000
+    770 = 1.00000
+    771 = 1.00000
+    772 = 1.00000
+    775 = 1.00000
+    777 = 1.00000
+    779 = 1.00000
+    782 = 1.00000
+    784 = 1.00000
+    785 = 1.00000
+    786 = 1.00000
+    793 = 1.00000
+    795 = 1.00000
+    796 = 1.00000
+    799 = 1.00000
+    801 = 1.00000
+    808 = 1.00000
+    812 = 1.00000
+    820 = 1.00000
+    821 = 1.00000
+    823 = 1.00000
+    827 = 1.00000
+    829 = 1.00000
+    830 = 1.00000
+    835 = 1.00000
+    838 = 1.00000
+    844 = 1.00000
+    848 = 1.00000
+    855 = 1.00000
+    861 = 1.00000
+    870 = 1.00000
+    876 = 1.00000
+    915 = 1.00000
+    916 = 1.00000
+    919 = 1.00000
+    921 = 1.00000
+    928 = 1.00000
+    930 = 1.00000
+    931 = 1.00000
+    934 = 1.00000
+    936 = 1.00000
+    943 = 1.00000
+    952 = 1.00000
+    958 = 1.00000
+    961 = 1.00000
+    967 = 1.00000
+    977 = 1.00000
+    983 = 1.00000
+    986 = 1.00000
+    1004 = 1.00000
+    1011 = 1.00000
+    1013 = 1.00000
+    1014 = 1.00000
+    1017 = 1.00000
+    1019 = 1.00000
+    1022 = 1.00000
+    1023 = 1.00000
+    1029 = 1.00000
+    1032 = 1.00000
+    1040 = 1.00000
+    1048 = 1.00000
+    1049 = 1.00000
+    1051 = 1.00000
+    1055 = 1.00000
+    1057 = 1.00000
+    1058 = 1.00000
+    1063 = 1.00000
+    1066 = 1.00000
+    1072 = 1.00000
+    1076 = 1.00000
+    1083 = 1.00000
+    1084 = 1.00000
+    1085 = 1.00000
+    1086 = 1.00000
+    1087 = 1.00000
+    1089 = 1.00000
+    1091 = 1.00000
+    1093 = 1.00000
+    1094 = 1.00000
+    1095 = 1.00000
+    1099 = 1.00000
+    1101 = 1.00000
+    1102 = 1.00000
+    1104 = 1.00000
+    1108 = 1.00000
+    1112 = 1.00000
+    1143 = 1.00000
+    1146 = 1.00000
+    1152 = 1.00000
+    1155 = 1.00000
+    1168 = 1.00000
+    1174 = 1.00000
+    1177 = 1.00000
+    1183 = 1.00000
+    1191 = 1.00000
+    1192 = 1.00000
+    1194 = 1.00000
+    1198 = 1.00000
+    1200 = 1.00000
+    1201 = 1.00000
+    1203 = 1.00000
+    1207 = 1.00000
+    1215 = 1.00000
+    1216 = 1.00000
+    1219 = 1.00000
+    1221 = 1.00000
+    1227 = 1.00000
+    1234 = 1.00000
+    1239 = 1.00000
+    1240 = 1.00000
+    1243 = 1.00000
+    1245 = 1.00000
+    1251 = 1.00000
+    1258 = 1.00000
+    1270 = 1.00000
+    1279 = 1.00000
+    1285 = 1.00000
+    1294 = 1.00000
+    1305 = 1.00000
+    1311 = 1.00000
+    1320 = 1.00000
+    1326 = 1.00000
+    1365 = 1.00000
+    1366 = 1.00000
+    1367 = 1.00000
+    1369 = 1.00000
+    1370 = 1.00000
+    1371 = 1.00000
+    1373 = 1.00000
+    1376 = 1.00000
+    1377 = 1.00000
+    1379 = 1.00000
+    1382 = 1.00000
+    1384 = 1.00000
+    1385 = 1.00000
+    1388 = 1.00000
+    1389 = 1.00000
+    1390 = 1.00000
+    1393 = 1.00000
+    1395 = 1.00000
+    1401 = 1.00000
+    1408 = 1.00000
+    1415 = 1.00000
+    1420 = 1.00000
+    1421 = 1.00000
+    1424 = 1.00000
+    1427 = 1.00000
+    1429 = 1.00000
+    1430 = 1.00000
+    1433 = 1.00000
+    1435 = 1.00000
+    1444 = 1.00000
+    1451 = 1.00000
+    1455 = 1.00000
+    1457 = 1.00000
+    1460 = 1.00000
+    1461 = 1.00000
+    1463 = 1.00000
+    1466 = 1.00000
+    1469 = 1.00000
+    1470 = 1.00000
+    1476 = 1.00000
+    1487 = 1.00000
+    1493 = 1.00000
+    1496 = 1.00000
+    1499 = 1.00000
+    1511 = 1.00000
+    1516 = 1.00000
+    1525 = 1.00000
+    1531 = 1.00000
+    1540 = 1.00000
+    1551 = 1.00000
+    1552 = 1.00000
+    1554 = 1.00000
+    1557 = 1.00000
+    1561 = 1.00000
+    1566 = 1.00000
+    1567 = 1.00000
+    1569 = 1.00000
+    1572 = 1.00000
+    1576 = 1.00000
+    1611 = 1.00000
+    1614 = 1.00000
+    1620 = 1.00000
+    1623 = 1.00000
+    1636 = 1.00000
+    1637 = 1.00000
+    1640 = 1.00000
+    1643 = 1.00000
+    1645 = 1.00000
+    1646 = 1.00000
+    1649 = 1.00000
+    1651 = 1.00000
+    1660 = 1.00000
+    1667 = 1.00000
+    1671 = 1.00000
+    1672 = 1.00000
+    1673 = 1.00000
+    1674 = 1.00000
+    1676 = 1.00000
+    1677 = 1.00000
+    1679 = 1.00000
+    1681 = 1.00000
+    1682 = 1.00000
+    1685 = 1.00000
+    1686 = 1.00000
+    1687 = 1.00000
+    1689 = 1.00000
+    1692 = 1.00000
+    1696 = 1.00000
+    1703 = 1.00000
+    1709 = 1.00000
+    1712 = 1.00000
+    1715 = 1.00000
+    1727 = 1.00000
+    1731 = 1.00000
+    1733 = 1.00000
+    1734 = 1.00000
+    1736 = 1.00000
+    1739 = 1.00000
+    1740 = 1.00000
+    1743 = 1.00000
+    1751 = 1.00000
+    1755 = 1.00000
+    1761 = 1.00000
+    1770 = 1.00000
+    1776 = 1.00000
+    1815 = 1.00000
+    1816 = 1.00000
+    1819 = 1.00000
+    1821 = 1.00000
+    1828 = 1.00000
+    1830 = 1.00000
+    1831 = 1.00000
+    1834 = 1.00000
+    1836 = 1.00000
+    1843 = 1.00000
+    1852 = 1.00000
+    1858 = 1.00000
+    1861 = 1.00000
+    1867 = 1.00000
+    1875 = 1.00000
+    1877 = 1.00000
+    1880 = 1.00000
+    1881 = 1.00000
+    1883 = 1.00000
+    1886 = 1.00000
+    1889 = 1.00000
+    1890 = 1.00000
+    1896 = 1.00000
+    1907 = 1.00000
+    1913 = 1.00000
+    1916 = 1.00000
+    1919 = 1.00000
+    1931 = 1.00000
+    1935 = 1.00000
+    1936 = 1.00000
+    1937 = 1.00000
+    1939 = 1.00000
+    1940 = 1.00000
+    1941 = 1.00000
+    1943 = 1.00000
+    1946 = 1.00000
+    1948 = 1.00000
+    1949 = 1.00000
+    1950 = 1.00000
+    1951 = 1.00000
+    1954 = 1.00000
+    1956 = 1.00000
+    1963 = 1.00000
+    1967 = 1.00000
+    1972 = 1.00000
+    1973 = 1.00000
+    1976 = 1.00000
+    1978 = 1.00000
+    1979 = 1.00000
+    1981 = 1.00000
+    1987 = 1.00000
+    1991 = 1.00000
+    2019 = 1.00000
+    2022 = 1.00000
+    2028 = 1.00000
+    2031 = 1.00000
+    2044 = 1.00000
+    2050 = 1.00000
+    2053 = 1.00000
+    2059 = 1.00000
+    2067 = 1.00000
+    2068 = 1.00000
+    2070 = 1.00000
+    2074 = 1.00000
+    2076 = 1.00000
+    2077 = 1.00000
+    2079 = 1.00000
+    2083 = 1.00000
+    2093 = 1.00000
+    2096 = 1.00000
+    2099 = 1.00000
+    2111 = 1.00000
+    2115 = 1.00000
+    2117 = 1.00000
+    2118 = 1.00000
+    2120 = 1.00000
+    2123 = 1.00000
+    2124 = 1.00000
+    2127 = 1.00000
+    2135 = 1.00000
+    2140 = 1.00000
+    2141 = 1.00000
+    2144 = 1.00000
+    2146 = 1.00000
+    2147 = 1.00000
+    2149 = 1.00000
+    2155 = 1.00000
+    2159 = 1.00000
+    2163 = 1.00000
+    2164 = 1.00000
+    2165 = 1.00000
+    2166 = 1.00000
+    2168 = 1.00000
+    2170 = 1.00000
+    2171 = 1.00000
+    2172 = 1.00000
+    2173 = 1.00000
+    2175 = 1.00000
+    2179 = 1.00000
+    2183 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(3)^3], case=0
+    0 = 1.00000
+    6 = 1.00000
+    12 = 1.00000
+    18 = 1.00000
+    24 = 1.00000
+    25 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    72 = 1.00000
+    73 = 1.00000
+    84 = 1.00000
+    85 = 1.00000
+    96 = 1.00000
+    97 = 1.00000
+    98 = 1.00000
+    99 = 1.00000
+    336 = 1.00000
+    342 = 1.00000
+    348 = 1.00000
+    349 = 1.00000
+    366 = 1.00000
+    367 = 1.00000
+    384 = 1.00000
+    385 = 1.00000
+    396 = 1.00000
+    397 = 1.00000
+    398 = 1.00000
+    399 = 1.00000
+    588 = 1.00000
+    594 = 1.00000
+    600 = 1.00000
+    601 = 1.00000
+    624 = 1.00000
+    625 = 1.00000
+    636 = 1.00000
+    637 = 1.00000
+    648 = 1.00000
+    649 = 1.00000
+    650 = 1.00000
+    651 = 1.00000
+    840 = 1.00000
+    846 = 1.00000
+    847 = 1.00000
+    864 = 1.00000
+    865 = 1.00000
+    876 = 1.00000
+    877 = 1.00000
+    878 = 1.00000
+    879 = 1.00000
+    1911 = 1.00000
+    1917 = 1.00000
+    1923 = 1.00000
+    1924 = 1.00000
+    1941 = 1.00000
+    1942 = 1.00000
+    1959 = 1.00000
+    1960 = 1.00000
+    1971 = 1.00000
+    1972 = 1.00000
+    1973 = 1.00000
+    1974 = 1.00000
+    2163 = 1.00000
+    2169 = 1.00000
+    2175 = 1.00000
+    2176 = 1.00000
+    2193 = 1.00000
+    2194 = 1.00000
+    2211 = 1.00000
+    2212 = 1.00000
+    2223 = 1.00000
+    2224 = 1.00000
+    2225 = 1.00000
+    2226 = 1.00000
+    2415 = 1.00000
+    2421 = 1.00000
+    2422 = 1.00000
+    2439 = 1.00000
+    2440 = 1.00000
+    2451 = 1.00000
+    2452 = 1.00000
+    2453 = 1.00000
+    2454 = 1.00000
+    2604 = 1.00000
+    2610 = 1.00000
+    2611 = 1.00000
+    2628 = 1.00000
+    2629 = 1.00000
+    2640 = 1.00000
+    2641 = 1.00000
+    2642 = 1.00000
+    2643 = 1.00000
+    3549 = 1.00000
+    3555 = 1.00000
+    3561 = 1.00000
+    3562 = 1.00000
+    3585 = 1.00000
+    3586 = 1.00000
+    3597 = 1.00000
+    3598 = 1.00000
+    3609 = 1.00000
+    3610 = 1.00000
+    3611 = 1.00000
+    3612 = 1.00000
+    3801 = 1.00000
+    3807 = 1.00000
+    3808 = 1.00000
+    3825 = 1.00000
+    3826 = 1.00000
+    3837 = 1.00000
+    3838 = 1.00000
+    3839 = 1.00000
+    3840 = 1.00000
+    3990 = 1.00000
+    3996 = 1.00000
+    4002 = 1.00000
+    4003 = 1.00000
+    4026 = 1.00000
+    4027 = 1.00000
+    4038 = 1.00000
+    4039 = 1.00000
+    4050 = 1.00000
+    4051 = 1.00000
+    4052 = 1.00000
+    4053 = 1.00000
+    4242 = 1.00000
+    4248 = 1.00000
+    4249 = 1.00000
+    4266 = 1.00000
+    4267 = 1.00000
+    4278 = 1.00000
+    4279 = 1.00000
+    4280 = 1.00000
+    4281 = 1.00000
+    5187 = 1.00000
+    5193 = 1.00000
+    5194 = 1.00000
+    5211 = 1.00000
+    5212 = 1.00000
+    5223 = 1.00000
+    5224 = 1.00000
+    5225 = 1.00000
+    5226 = 1.00000
+    5376 = 1.00000
+    5382 = 1.00000
+    5383 = 1.00000
+    5400 = 1.00000
+    5401 = 1.00000
+    5412 = 1.00000
+    5413 = 1.00000
+    5414 = 1.00000
+    5415 = 1.00000
+    5565 = 1.00000
+    5571 = 1.00000
+    5572 = 1.00000
+    5589 = 1.00000
+    5590 = 1.00000
+    5601 = 1.00000
+    5602 = 1.00000
+    5603 = 1.00000
+    5604 = 1.00000
+    5754 = 1.00000
+    5760 = 1.00000
+    5761 = 1.00000
+    5778 = 1.00000
+    5779 = 1.00000
+    5790 = 1.00000
+    5791 = 1.00000
+    5792 = 1.00000
+    5793 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(3)^3], case=1
+    0 = 1.00000
+    6 = 1.00000
+    12 = 1.00000
+    18 = 1.00000
+    24 = 1.00000
+    25 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    72 = 1.00000
+    73 = 1.00000
+    84 = 1.00000
+    85 = 1.00000
+    96 = 1.00000
+    97 = 1.00000
+    98 = 1.00000
+    99 = 1.00000
+    336 = 1.00000
+    342 = 1.00000
+    348 = 1.00000
+    349 = 1.00000
+    366 = 1.00000
+    367 = 1.00000
+    384 = 1.00000
+    385 = 1.00000
+    396 = 1.00000
+    397 = 1.00000
+    398 = 1.00000
+    399 = 1.00000
+    588 = 1.00000
+    594 = 1.00000
+    600 = 1.00000
+    601 = 1.00000
+    624 = 1.00000
+    625 = 1.00000
+    636 = 1.00000
+    637 = 1.00000
+    648 = 1.00000
+    649 = 1.00000
+    650 = 1.00000
+    651 = 1.00000
+    840 = 1.00000
+    846 = 1.00000
+    847 = 1.00000
+    864 = 1.00000
+    865 = 1.00000
+    876 = 1.00000
+    877 = 1.00000
+    878 = 1.00000
+    879 = 1.00000
+    1173 = 1.00000
+    1176 = 1.00000
+    1179 = 1.00000
+    1182 = 1.00000
+    1185 = 1.00000
+    1186 = 1.00000
+    1203 = 1.00000
+    1204 = 1.00000
+    1221 = 1.00000
+    1222 = 1.00000
+    1227 = 1.00000
+    1228 = 1.00000
+    1233 = 1.00000
+    1234 = 1.00000
+    1235 = 1.00000
+    1236 = 1.00000
+    1425 = 1.00000
+    1428 = 1.00000
+    1431 = 1.00000
+    1432 = 1.00000
+    1443 = 1.00000
+    1444 = 1.00000
+    1455 = 1.00000
+    1456 = 1.00000
+    1461 = 1.00000
+    1462 = 1.00000
+    1463 = 1.00000
+    1464 = 1.00000
+    1641 = 1.00000
+    1644 = 1.00000
+    1647 = 1.00000
+    1648 = 1.00000
+    1665 = 1.00000
+    1666 = 1.00000
+    1671 = 1.00000
+    1672 = 1.00000
+    1677 = 1.00000
+    1678 = 1.00000
+    1679 = 1.00000
+    1680 = 1.00000
+    1830 = 1.00000
+    1833 = 1.00000
+    1834 = 1.00000
+    1845 = 1.00000
+    1846 = 1.00000
+    1851 = 1.00000
+    1852 = 1.00000
+    1853 = 1.00000
+    1854 = 1.00000
+    1911 = 1.00000
+    1917 = 1.00000
+    1923 = 1.00000
+    1924 = 1.00000
+    1941 = 1.00000
+    1942 = 1.00000
+    1959 = 1.00000
+    1960 = 1.00000
+    1971 = 1.00000
+    1972 = 1.00000
+    1973 = 1.00000
+    1974 = 1.00000
+    2163 = 1.00000
+    2169 = 1.00000
+    2175 = 1.00000
+    2176 = 1.00000
+    2193 = 1.00000
+    2194 = 1.00000
+    2211 = 1.00000
+    2212 = 1.00000
+    2223 = 1.00000
+    2224 = 1.00000
+    2225 = 1.00000
+    2226 = 1.00000
+    2415 = 1.00000
+    2421 = 1.00000
+    2422 = 1.00000
+    2439 = 1.00000
+    2440 = 1.00000
+    2451 = 1.00000
+    2452 = 1.00000
+    2453 = 1.00000
+    2454 = 1.00000
+    2604 = 1.00000
+    2610 = 1.00000
+    2611 = 1.00000
+    2628 = 1.00000
+    2629 = 1.00000
+    2640 = 1.00000
+    2641 = 1.00000
+    2642 = 1.00000
+    2643 = 1.00000
+    2901 = 1.00000
+    2904 = 1.00000
+    2907 = 1.00000
+    2908 = 1.00000
+    2919 = 1.00000
+    2920 = 1.00000
+    2931 = 1.00000
+    2932 = 1.00000
+    2937 = 1.00000
+    2938 = 1.00000
+    2939 = 1.00000
+    2940 = 1.00000
+    3117 = 1.00000
+    3120 = 1.00000
+    3123 = 1.00000
+    3124 = 1.00000
+    3135 = 1.00000
+    3136 = 1.00000
+    3147 = 1.00000
+    3148 = 1.00000
+    3153 = 1.00000
+    3154 = 1.00000
+    3155 = 1.00000
+    3156 = 1.00000
+    3306 = 1.00000
+    3309 = 1.00000
+    3310 = 1.00000
+    3321 = 1.00000
+    3322 = 1.00000
+    3327 = 1.00000
+    3328 = 1.00000
+    3329 = 1.00000
+    3330 = 1.00000
+    3468 = 1.00000
+    3471 = 1.00000
+    3472 = 1.00000
+    3483 = 1.00000
+    3484 = 1.00000
+    3489 = 1.00000
+    3490 = 1.00000
+    3491 = 1.00000
+    3492 = 1.00000
+    3549 = 1.00000
+    3555 = 1.00000
+    3561 = 1.00000
+    3562 = 1.00000
+    3585 = 1.00000
+    3586 = 1.00000
+    3597 = 1.00000
+    3598 = 1.00000
+    3609 = 1.00000
+    3610 = 1.00000
+    3611 = 1.00000
+    3612 = 1.00000
+    3801 = 1.00000
+    3807 = 1.00000
+    3808 = 1.00000
+    3825 = 1.00000
+    3826 = 1.00000
+    3837 = 1.00000
+    3838 = 1.00000
+    3839 = 1.00000
+    3840 = 1.00000
+    3990 = 1.00000
+    3996 = 1.00000
+    4002 = 1.00000
+    4003 = 1.00000
+    4026 = 1.00000
+    4027 = 1.00000
+    4038 = 1.00000
+    4039 = 1.00000
+    4050 = 1.00000
+    4051 = 1.00000
+    4052 = 1.00000
+    4053 = 1.00000
+    4242 = 1.00000
+    4248 = 1.00000
+    4249 = 1.00000
+    4266 = 1.00000
+    4267 = 1.00000
+    4278 = 1.00000
+    4279 = 1.00000
+    4280 = 1.00000
+    4281 = 1.00000
+    4539 = 1.00000
+    4542 = 1.00000
+    4545 = 1.00000
+    4546 = 1.00000
+    4563 = 1.00000
+    4564 = 1.00000
+    4569 = 1.00000
+    4570 = 1.00000
+    4575 = 1.00000
+    4576 = 1.00000
+    4577 = 1.00000
+    4578 = 1.00000
+    4728 = 1.00000
+    4731 = 1.00000
+    4732 = 1.00000
+    4743 = 1.00000
+    4744 = 1.00000
+    4749 = 1.00000
+    4750 = 1.00000
+    4751 = 1.00000
+    4752 = 1.00000
+    4917 = 1.00000
+    4920 = 1.00000
+    4923 = 1.00000
+    4924 = 1.00000
+    4941 = 1.00000
+    4942 = 1.00000
+    4947 = 1.00000
+    4948 = 1.00000
+    4953 = 1.00000
+    4954 = 1.00000
+    4955 = 1.00000
+    4956 = 1.00000
+    5106 = 1.00000
+    5109 = 1.00000
+    5110 = 1.00000
+    5121 = 1.00000
+    5122 = 1.00000
+    5127 = 1.00000
+    5128 = 1.00000
+    5129 = 1.00000
+    5130 = 1.00000
+    5187 = 1.00000
+    5193 = 1.00000
+    5194 = 1.00000
+    5211 = 1.00000
+    5212 = 1.00000
+    5223 = 1.00000
+    5224 = 1.00000
+    5225 = 1.00000
+    5226 = 1.00000
+    5376 = 1.00000
+    5382 = 1.00000
+    5383 = 1.00000
+    5400 = 1.00000
+    5401 = 1.00000
+    5412 = 1.00000
+    5413 = 1.00000
+    5414 = 1.00000
+    5415 = 1.00000
+    5565 = 1.00000
+    5571 = 1.00000
+    5572 = 1.00000
+    5589 = 1.00000
+    5590 = 1.00000
+    5601 = 1.00000
+    5602 = 1.00000
+    5603 = 1.00000
+    5604 = 1.00000
+    5754 = 1.00000
+    5760 = 1.00000
+    5761 = 1.00000
+    5778 = 1.00000
+    5779 = 1.00000
+    5790 = 1.00000
+    5791 = 1.00000
+    5792 = 1.00000
+    5793 = 1.00000
+    6024 = 1.00000
+    6027 = 1.00000
+    6028 = 1.00000
+    6039 = 1.00000
+    6040 = 1.00000
+    6045 = 1.00000
+    6046 = 1.00000
+    6047 = 1.00000
+    6048 = 1.00000
+    6186 = 1.00000
+    6189 = 1.00000
+    6190 = 1.00000
+    6201 = 1.00000
+    6202 = 1.00000
+    6207 = 1.00000
+    6208 = 1.00000
+    6209 = 1.00000
+    6210 = 1.00000
+    6348 = 1.00000
+    6351 = 1.00000
+    6352 = 1.00000
+    6363 = 1.00000
+    6364 = 1.00000
+    6369 = 1.00000
+    6370 = 1.00000
+    6371 = 1.00000
+    6372 = 1.00000
+    6510 = 1.00000
+    6513 = 1.00000
+    6514 = 1.00000
+    6525 = 1.00000
+    6526 = 1.00000
+    6531 = 1.00000
+    6532 = 1.00000
+    6533 = 1.00000
+    6534 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(3)^3], case=2
+    0 = 1.00000
+    1 = 1.00000
+    4 = 1.00000
+    6 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    16 = 1.00000
+    18 = 1.00000
+    24 = 1.00000
+    25 = 1.00000
+    38 = 1.00000
+    39 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    62 = 1.00000
+    63 = 1.00000
+    72 = 1.00000
+    74 = 1.00000
+    73 = 1.00000
+    75 = 1.00000
+    80 = 1.00000
+    81 = 1.00000
+    84 = 1.00000
+    85 = 1.00000
+    96 = 1.00000
+    97 = 1.00000
+    98 = 1.00000
+    99 = 1.00000
+    124 = 1.00000
+    125 = 1.00000
+    126 = 1.00000
+    127 = 1.00000
+    193 = 1.00000
+    199 = 1.00000
+    212 = 1.00000
+    213 = 1.00000
+    230 = 1.00000
+    231 = 1.00000
+    242 = 1.00000
+    243 = 1.00000
+    268 = 1.00000
+    269 = 1.00000
+    270 = 1.00000
+    271 = 1.00000
+    336 = 1.00000
+    342 = 1.00000
+    348 = 1.00000
+    349 = 1.00000
+    366 = 1.00000
+    367 = 1.00000
+    384 = 1.00000
+    385 = 1.00000
+    396 = 1.00000
+    397 = 1.00000
+    398 = 1.00000
+    399 = 1.00000
+    588 = 1.00000
+    589 = 1.00000
+    592 = 1.00000
+    594 = 1.00000
+    600 = 1.00000
+    601 = 1.00000
+    614 = 1.00000
+    615 = 1.00000
+    624 = 1.00000
+    626 = 1.00000
+    625 = 1.00000
+    627 = 1.00000
+    632 = 1.00000
+    633 = 1.00000
+    636 = 1.00000
+    637 = 1.00000
+    648 = 1.00000
+    649 = 1.00000
+    650 = 1.00000
+    651 = 1.00000
+    676 = 1.00000
+    677 = 1.00000
+    678 = 1.00000
+    679 = 1.00000
+    733 = 1.00000
+    746 = 1.00000
+    747 = 1.00000
+    758 = 1.00000
+    759 = 1.00000
+    784 = 1.00000
+    785 = 1.00000
+    786 = 1.00000
+    787 = 1.00000
+    840 = 1.00000
+    846 = 1.00000
+    847 = 1.00000
+    864 = 1.00000
+    865 = 1.00000
+    876 = 1.00000
+    877 = 1.00000
+    878 = 1.00000
+    879 = 1.00000
+    1030 = 1.00000
+    1036 = 1.00000
+    1049 = 1.00000
+    1050 = 1.00000
+    1067 = 1.00000
+    1068 = 1.00000
+    1079 = 1.00000
+    1080 = 1.00000
+    1105 = 1.00000
+    1106 = 1.00000
+    1107 = 1.00000
+    1108 = 1.00000
+    1173 = 1.00000
+    1174 = 1.00000
+    1176 = 1.00000
+    1179 = 1.00000
+    1180 = 1.00000
+    1182 = 1.00000
+    1185 = 1.00000
+    1186 = 1.00000
+    1193 = 1.00000
+    1194 = 1.00000
+    1203 = 1.00000
+    1204 = 1.00000
+    1211 = 1.00000
+    1212 = 1.00000
+    1221 = 1.00000
+    1223 = 1.00000
+    1222 = 1.00000
+    1224 = 1.00000
+    1227 = 1.00000
+    1228 = 1.00000
+    1233 = 1.00000
+    1234 = 1.00000
+    1235 = 1.00000
+    1236 = 1.00000
+    1249 = 1.00000
+    1250 = 1.00000
+    1251 = 1.00000
+    1252 = 1.00000
+    1425 = 1.00000
+    1428 = 1.00000
+    1431 = 1.00000
+    1432 = 1.00000
+    1443 = 1.00000
+    1444 = 1.00000
+    1455 = 1.00000
+    1456 = 1.00000
+    1461 = 1.00000
+    1462 = 1.00000
+    1463 = 1.00000
+    1464 = 1.00000
+    1534 = 1.00000
+    1547 = 1.00000
+    1548 = 1.00000
+    1559 = 1.00000
+    1560 = 1.00000
+    1585 = 1.00000
+    1586 = 1.00000
+    1587 = 1.00000
+    1588 = 1.00000
+    1641 = 1.00000
+    1642 = 1.00000
+    1644 = 1.00000
+    1647 = 1.00000
+    1648 = 1.00000
+    1655 = 1.00000
+    1656 = 1.00000
+    1665 = 1.00000
+    1667 = 1.00000
+    1666 = 1.00000
+    1668 = 1.00000
+    1671 = 1.00000
+    1672 = 1.00000
+    1677 = 1.00000
+    1678 = 1.00000
+    1679 = 1.00000
+    1680 = 1.00000
+    1693 = 1.00000
+    1694 = 1.00000
+    1695 = 1.00000
+    1696 = 1.00000
+    1830 = 1.00000
+    1833 = 1.00000
+    1834 = 1.00000
+    1845 = 1.00000
+    1846 = 1.00000
+    1851 = 1.00000
+    1852 = 1.00000
+    1853 = 1.00000
+    1854 = 1.00000
+    1911 = 1.00000
+    1917 = 1.00000
+    1923 = 1.00000
+    1924 = 1.00000
+    1941 = 1.00000
+    1942 = 1.00000
+    1959 = 1.00000
+    1960 = 1.00000
+    1971 = 1.00000
+    1972 = 1.00000
+    1973 = 1.00000
+    1974 = 1.00000
+    2163 = 1.00000
+    2169 = 1.00000
+    2175 = 1.00000
+    2176 = 1.00000
+    2193 = 1.00000
+    2194 = 1.00000
+    2211 = 1.00000
+    2212 = 1.00000
+    2223 = 1.00000
+    2224 = 1.00000
+    2225 = 1.00000
+    2226 = 1.00000
+    2415 = 1.00000
+    2421 = 1.00000
+    2422 = 1.00000
+    2439 = 1.00000
+    2440 = 1.00000
+    2451 = 1.00000
+    2452 = 1.00000
+    2453 = 1.00000
+    2454 = 1.00000
+    2604 = 1.00000
+    2610 = 1.00000
+    2611 = 1.00000
+    2628 = 1.00000
+    2629 = 1.00000
+    2640 = 1.00000
+    2641 = 1.00000
+    2642 = 1.00000
+    2643 = 1.00000
+    2901 = 1.00000
+    2904 = 1.00000
+    2907 = 1.00000
+    2908 = 1.00000
+    2919 = 1.00000
+    2920 = 1.00000
+    2931 = 1.00000
+    2932 = 1.00000
+    2937 = 1.00000
+    2938 = 1.00000
+    2939 = 1.00000
+    2940 = 1.00000
+    3117 = 1.00000
+    3120 = 1.00000
+    3123 = 1.00000
+    3124 = 1.00000
+    3135 = 1.00000
+    3136 = 1.00000
+    3147 = 1.00000
+    3148 = 1.00000
+    3153 = 1.00000
+    3154 = 1.00000
+    3155 = 1.00000
+    3156 = 1.00000
+    3306 = 1.00000
+    3309 = 1.00000
+    3310 = 1.00000
+    3321 = 1.00000
+    3322 = 1.00000
+    3327 = 1.00000
+    3328 = 1.00000
+    3329 = 1.00000
+    3330 = 1.00000
+    3468 = 1.00000
+    3471 = 1.00000
+    3472 = 1.00000
+    3483 = 1.00000
+    3484 = 1.00000
+    3489 = 1.00000
+    3490 = 1.00000
+    3491 = 1.00000
+    3492 = 1.00000
+    3549 = 1.00000
+    3550 = 1.00000
+    3553 = 1.00000
+    3555 = 1.00000
+    3561 = 1.00000
+    3562 = 1.00000
+    3575 = 1.00000
+    3576 = 1.00000
+    3585 = 1.00000
+    3587 = 1.00000
+    3586 = 1.00000
+    3588 = 1.00000
+    3593 = 1.00000
+    3594 = 1.00000
+    3597 = 1.00000
+    3598 = 1.00000
+    3609 = 1.00000
+    3610 = 1.00000
+    3611 = 1.00000
+    3612 = 1.00000
+    3637 = 1.00000
+    3638 = 1.00000
+    3639 = 1.00000
+    3640 = 1.00000
+    3694 = 1.00000
+    3707 = 1.00000
+    3708 = 1.00000
+    3719 = 1.00000
+    3720 = 1.00000
+    3745 = 1.00000
+    3746 = 1.00000
+    3747 = 1.00000
+    3748 = 1.00000
+    3801 = 1.00000
+    3807 = 1.00000
+    3808 = 1.00000
+    3825 = 1.00000
+    3826 = 1.00000
+    3837 = 1.00000
+    3838 = 1.00000
+    3839 = 1.00000
+    3840 = 1.00000
+    3990 = 1.00000
+    3991 = 1.00000
+    3994 = 1.00000
+    3996 = 1.00000
+    4002 = 1.00000
+    4003 = 1.00000
+    4016 = 1.00000
+    4017 = 1.00000
+    4026 = 1.00000
+    4028 = 1.00000
+    4027 = 1.00000
+    4029 = 1.00000
+    4034 = 1.00000
+    4035 = 1.00000
+    4038 = 1.00000
+    4039 = 1.00000
+    4050 = 1.00000
+    4051 = 1.00000
+    4052 = 1.00000
+    4053 = 1.00000
+    4078 = 1.00000
+    4079 = 1.00000
+    4080 = 1.00000
+    4081 = 1.00000
+    4135 = 1.00000
+    4148 = 1.00000
+    4149 = 1.00000
+    4160 = 1.00000
+    4161 = 1.00000
+    4186 = 1.00000
+    4187 = 1.00000
+    4188 = 1.00000
+    4189 = 1.00000
+    4242 = 1.00000
+    4248 = 1.00000
+    4249 = 1.00000
+    4266 = 1.00000
+    4267 = 1.00000
+    4278 = 1.00000
+    4279 = 1.00000
+    4280 = 1.00000
+    4281 = 1.00000
+    4432 = 1.00000
+    4445 = 1.00000
+    4446 = 1.00000
+    4457 = 1.00000
+    4458 = 1.00000
+    4483 = 1.00000
+    4484 = 1.00000
+    4485 = 1.00000
+    4486 = 1.00000
+    4539 = 1.00000
+    4540 = 1.00000
+    4542 = 1.00000
+    4545 = 1.00000
+    4546 = 1.00000
+    4553 = 1.00000
+    4554 = 1.00000
+    4563 = 1.00000
+    4565 = 1.00000
+    4564 = 1.00000
+    4566 = 1.00000
+    4569 = 1.00000
+    4570 = 1.00000
+    4575 = 1.00000
+    4576 = 1.00000
+    4577 = 1.00000
+    4578 = 1.00000
+    4591 = 1.00000
+    4592 = 1.00000
+    4593 = 1.00000
+    4594 = 1.00000
+    4728 = 1.00000
+    4731 = 1.00000
+    4732 = 1.00000
+    4743 = 1.00000
+    4744 = 1.00000
+    4749 = 1.00000
+    4750 = 1.00000
+    4751 = 1.00000
+    4752 = 1.00000
+    4810 = 1.00000
+    4823 = 1.00000
+    4824 = 1.00000
+    4835 = 1.00000
+    4836 = 1.00000
+    4861 = 1.00000
+    4862 = 1.00000
+    4863 = 1.00000
+    4864 = 1.00000
+    4917 = 1.00000
+    4918 = 1.00000
+    4920 = 1.00000
+    4923 = 1.00000
+    4924 = 1.00000
+    4931 = 1.00000
+    4932 = 1.00000
+    4941 = 1.00000
+    4943 = 1.00000
+    4942 = 1.00000
+    4944 = 1.00000
+    4947 = 1.00000
+    4948 = 1.00000
+    4953 = 1.00000
+    4954 = 1.00000
+    4955 = 1.00000
+    4956 = 1.00000
+    4969 = 1.00000
+    4970 = 1.00000
+    4971 = 1.00000
+    4972 = 1.00000
+    5106 = 1.00000
+    5109 = 1.00000
+    5110 = 1.00000
+    5121 = 1.00000
+    5122 = 1.00000
+    5127 = 1.00000
+    5128 = 1.00000
+    5129 = 1.00000
+    5130 = 1.00000
+    5187 = 1.00000
+    5193 = 1.00000
+    5194 = 1.00000
+    5211 = 1.00000
+    5212 = 1.00000
+    5223 = 1.00000
+    5224 = 1.00000
+    5225 = 1.00000
+    5226 = 1.00000
+    5376 = 1.00000
+    5382 = 1.00000
+    5383 = 1.00000
+    5400 = 1.00000
+    5401 = 1.00000
+    5412 = 1.00000
+    5413 = 1.00000
+    5414 = 1.00000
+    5415 = 1.00000
+    5565 = 1.00000
+    5571 = 1.00000
+    5572 = 1.00000
+    5589 = 1.00000
+    5590 = 1.00000
+    5601 = 1.00000
+    5602 = 1.00000
+    5603 = 1.00000
+    5604 = 1.00000
+    5754 = 1.00000
+    5760 = 1.00000
+    5761 = 1.00000
+    5778 = 1.00000
+    5779 = 1.00000
+    5790 = 1.00000
+    5791 = 1.00000
+    5792 = 1.00000
+    5793 = 1.00000
+    6024 = 1.00000
+    6027 = 1.00000
+    6028 = 1.00000
+    6039 = 1.00000
+    6040 = 1.00000
+    6045 = 1.00000
+    6046 = 1.00000
+    6047 = 1.00000
+    6048 = 1.00000
+    6186 = 1.00000
+    6189 = 1.00000
+    6190 = 1.00000
+    6201 = 1.00000
+    6202 = 1.00000
+    6207 = 1.00000
+    6208 = 1.00000
+    6209 = 1.00000
+    6210 = 1.00000
+    6348 = 1.00000
+    6351 = 1.00000
+    6352 = 1.00000
+    6363 = 1.00000
+    6364 = 1.00000
+    6369 = 1.00000
+    6370 = 1.00000
+    6371 = 1.00000
+    6372 = 1.00000
+    6510 = 1.00000
+    6513 = 1.00000
+    6514 = 1.00000
+    6525 = 1.00000
+    6526 = 1.00000
+    6531 = 1.00000
+    6532 = 1.00000
+    6533 = 1.00000
+    6534 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(3)^3], case=3
+    0 = 1.00000
+    1 = 1.00000
+    4 = 1.00000
+    6 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    16 = 1.00000
+    18 = 1.00000
+    24 = 1.00000
+    25 = 1.00000
+    38 = 1.00000
+    39 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    62 = 1.00000
+    63 = 1.00000
+    72 = 1.00000
+    74 = 1.00000
+    73 = 1.00000
+    75 = 1.00000
+    80 = 1.00000
+    81 = 1.00000
+    84 = 1.00000
+    85 = 1.00000
+    96 = 1.00000
+    97 = 1.00000
+    98 = 1.00000
+    99 = 1.00000
+    124 = 1.00000
+    125 = 1.00000
+    126 = 1.00000
+    127 = 1.00000
+    193 = 1.00000
+    199 = 1.00000
+    212 = 1.00000
+    213 = 1.00000
+    230 = 1.00000
+    231 = 1.00000
+    242 = 1.00000
+    243 = 1.00000
+    268 = 1.00000
+    269 = 1.00000
+    270 = 1.00000
+    271 = 1.00000
+    336 = 1.00000
+    342 = 1.00000
+    348 = 1.00000
+    349 = 1.00000
+    366 = 1.00000
+    367 = 1.00000
+    384 = 1.00000
+    385 = 1.00000
+    396 = 1.00000
+    397 = 1.00000
+    398 = 1.00000
+    399 = 1.00000
+    588 = 1.00000
+    589 = 1.00000
+    592 = 1.00000
+    594 = 1.00000
+    600 = 1.00000
+    601 = 1.00000
+    614 = 1.00000
+    615 = 1.00000
+    624 = 1.00000
+    626 = 1.00000
+    625 = 1.00000
+    627 = 1.00000
+    632 = 1.00000
+    633 = 1.00000
+    636 = 1.00000
+    637 = 1.00000
+    648 = 1.00000
+    649 = 1.00000
+    650 = 1.00000
+    651 = 1.00000
+    676 = 1.00000
+    677 = 1.00000
+    678 = 1.00000
+    679 = 1.00000
+    733 = 1.00000
+    746 = 1.00000
+    747 = 1.00000
+    758 = 1.00000
+    759 = 1.00000
+    784 = 1.00000
+    785 = 1.00000
+    786 = 1.00000
+    787 = 1.00000
+    840 = 1.00000
+    846 = 1.00000
+    847 = 1.00000
+    864 = 1.00000
+    865 = 1.00000
+    876 = 1.00000
+    877 = 1.00000
+    878 = 1.00000
+    879 = 1.00000
+    1030 = 1.00000
+    1036 = 1.00000
+    1049 = 1.00000
+    1050 = 1.00000
+    1067 = 1.00000
+    1068 = 1.00000
+    1079 = 1.00000
+    1080 = 1.00000
+    1105 = 1.00000
+    1106 = 1.00000
+    1107 = 1.00000
+    1108 = 1.00000
+    1173 = 1.00000
+    1174 = 1.00000
+    1176 = 1.00000
+    1179 = 1.00000
+    1180 = 1.00000
+    1182 = 1.00000
+    1185 = 1.00000
+    1186 = 1.00000
+    1193 = 1.00000
+    1194 = 1.00000
+    1203 = 1.00000
+    1204 = 1.00000
+    1211 = 1.00000
+    1212 = 1.00000
+    1221 = 1.00000
+    1223 = 1.00000
+    1222 = 1.00000
+    1224 = 1.00000
+    1227 = 1.00000
+    1228 = 1.00000
+    1233 = 1.00000
+    1234 = 1.00000
+    1235 = 1.00000
+    1236 = 1.00000
+    1249 = 1.00000
+    1250 = 1.00000
+    1251 = 1.00000
+    1252 = 1.00000
+    1425 = 1.00000
+    1428 = 1.00000
+    1431 = 1.00000
+    1432 = 1.00000
+    1443 = 1.00000
+    1444 = 1.00000
+    1455 = 1.00000
+    1456 = 1.00000
+    1461 = 1.00000
+    1462 = 1.00000
+    1463 = 1.00000
+    1464 = 1.00000
+    1534 = 1.00000
+    1547 = 1.00000
+    1548 = 1.00000
+    1559 = 1.00000
+    1560 = 1.00000
+    1585 = 1.00000
+    1586 = 1.00000
+    1587 = 1.00000
+    1588 = 1.00000
+    1641 = 1.00000
+    1642 = 1.00000
+    1644 = 1.00000
+    1647 = 1.00000
+    1648 = 1.00000
+    1655 = 1.00000
+    1656 = 1.00000
+    1665 = 1.00000
+    1667 = 1.00000
+    1666 = 1.00000
+    1668 = 1.00000
+    1671 = 1.00000
+    1672 = 1.00000
+    1677 = 1.00000
+    1678 = 1.00000
+    1679 = 1.00000
+    1680 = 1.00000
+    1693 = 1.00000
+    1694 = 1.00000
+    1695 = 1.00000
+    1696 = 1.00000
+    1830 = 1.00000
+    1833 = 1.00000
+    1834 = 1.00000
+    1845 = 1.00000
+    1846 = 1.00000
+    1851 = 1.00000
+    1852 = 1.00000
+    1853 = 1.00000
+    1854 = 1.00000
+    1911 = 1.00000
+    1917 = 1.00000
+    1923 = 1.00000
+    1924 = 1.00000
+    1941 = 1.00000
+    1942 = 1.00000
+    1959 = 1.00000
+    1960 = 1.00000
+    1971 = 1.00000
+    1972 = 1.00000
+    1973 = 1.00000
+    1974 = 1.00000
+    2163 = 1.00000
+    2164 = 1.00000
+    2167 = 1.00000
+    2169 = 1.00000
+    2170 = 1.00000
+    2173 = 1.00000
+    2175 = 1.00000
+    2176 = 1.00000
+    2189 = 1.00000
+    2190 = 1.00000
+    2193 = 1.00000
+    2194 = 1.00000
+    2207 = 1.00000
+    2208 = 1.00000
+    2211 = 1.00000
+    2213 = 1.00000
+    2212 = 1.00000
+    2214 = 1.00000
+    2219 = 1.00000
+    2220 = 1.00000
+    2223 = 1.00000
+    2224 = 1.00000
+    2225 = 1.00000
+    2226 = 1.00000
+    2251 = 1.00000
+    2252 = 1.00000
+    2253 = 1.00000
+    2254 = 1.00000
+    2308 = 1.00000
+    2311 = 1.00000
+    2321 = 1.00000
+    2322 = 1.00000
+    2333 = 1.00000
+    2334 = 1.00000
+    2339 = 1.00000
+    2340 = 1.00000
+    2359 = 1.00000
+    2360 = 1.00000
+    2361 = 1.00000
+    2362 = 1.00000
+    2415 = 1.00000
+    2421 = 1.00000
+    2422 = 1.00000
+    2439 = 1.00000
+    2440 = 1.00000
+    2451 = 1.00000
+    2452 = 1.00000
+    2453 = 1.00000
+    2454 = 1.00000
+    2604 = 1.00000
+    2605 = 1.00000
+    2608 = 1.00000
+    2610 = 1.00000
+    2611 = 1.00000
+    2624 = 1.00000
+    2625 = 1.00000
+    2628 = 1.00000
+    2630 = 1.00000
+    2629 = 1.00000
+    2631 = 1.00000
+    2636 = 1.00000
+    2637 = 1.00000
+    2640 = 1.00000
+    2641 = 1.00000
+    2642 = 1.00000
+    2643 = 1.00000
+    2668 = 1.00000
+    2669 = 1.00000
+    2670 = 1.00000
+    2671 = 1.00000
+    2713 = 1.00000
+    2723 = 1.00000
+    2724 = 1.00000
+    2729 = 1.00000
+    2730 = 1.00000
+    2749 = 1.00000
+    2750 = 1.00000
+    2751 = 1.00000
+    2752 = 1.00000
+    2901 = 1.00000
+    2904 = 1.00000
+    2907 = 1.00000
+    2908 = 1.00000
+    2919 = 1.00000
+    2920 = 1.00000
+    2931 = 1.00000
+    2932 = 1.00000
+    2937 = 1.00000
+    2938 = 1.00000
+    2939 = 1.00000
+    2940 = 1.00000
+    3010 = 1.00000
+    3013 = 1.00000
+    3023 = 1.00000
+    3024 = 1.00000
+    3035 = 1.00000
+    3036 = 1.00000
+    3041 = 1.00000
+    3042 = 1.00000
+    3061 = 1.00000
+    3062 = 1.00000
+    3063 = 1.00000
+    3064 = 1.00000
+    3117 = 1.00000
+    3118 = 1.00000
+    3120 = 1.00000
+    3121 = 1.00000
+    3123 = 1.00000
+    3124 = 1.00000
+    3131 = 1.00000
+    3132 = 1.00000
+    3135 = 1.00000
+    3136 = 1.00000
+    3143 = 1.00000
+    3144 = 1.00000
+    3147 = 1.00000
+    3149 = 1.00000
+    3148 = 1.00000
+    3150 = 1.00000
+    3153 = 1.00000
+    3154 = 1.00000
+    3155 = 1.00000
+    3156 = 1.00000
+    3169 = 1.00000
+    3170 = 1.00000
+    3171 = 1.00000
+    3172 = 1.00000
+    3306 = 1.00000
+    3309 = 1.00000
+    3310 = 1.00000
+    3321 = 1.00000
+    3322 = 1.00000
+    3327 = 1.00000
+    3328 = 1.00000
+    3329 = 1.00000
+    3330 = 1.00000
+    3388 = 1.00000
+    3398 = 1.00000
+    3399 = 1.00000
+    3404 = 1.00000
+    3405 = 1.00000
+    3424 = 1.00000
+    3425 = 1.00000
+    3426 = 1.00000
+    3427 = 1.00000
+    3468 = 1.00000
+    3469 = 1.00000
+    3471 = 1.00000
+    3472 = 1.00000
+    3479 = 1.00000
+    3480 = 1.00000
+    3483 = 1.00000
+    3485 = 1.00000
+    3484 = 1.00000
+    3486 = 1.00000
+    3489 = 1.00000
+    3490 = 1.00000
+    3491 = 1.00000
+    3492 = 1.00000
+    3505 = 1.00000
+    3506 = 1.00000
+    3507 = 1.00000
+    3508 = 1.00000
+    3549 = 1.00000
+    3550 = 1.00000
+    3553 = 1.00000
+    3555 = 1.00000
+    3561 = 1.00000
+    3562 = 1.00000
+    3575 = 1.00000
+    3576 = 1.00000
+    3585 = 1.00000
+    3587 = 1.00000
+    3586 = 1.00000
+    3588 = 1.00000
+    3593 = 1.00000
+    3594 = 1.00000
+    3597 = 1.00000
+    3598 = 1.00000
+    3609 = 1.00000
+    3610 = 1.00000
+    3611 = 1.00000
+    3612 = 1.00000
+    3637 = 1.00000
+    3638 = 1.00000
+    3639 = 1.00000
+    3640 = 1.00000
+    3694 = 1.00000
+    3707 = 1.00000
+    3708 = 1.00000
+    3719 = 1.00000
+    3720 = 1.00000
+    3745 = 1.00000
+    3746 = 1.00000
+    3747 = 1.00000
+    3748 = 1.00000
+    3801 = 1.00000
+    3807 = 1.00000
+    3808 = 1.00000
+    3825 = 1.00000
+    3826 = 1.00000
+    3837 = 1.00000
+    3838 = 1.00000
+    3839 = 1.00000
+    3840 = 1.00000
+    3990 = 1.00000
+    3991 = 1.00000
+    3994 = 1.00000
+    3996 = 1.00000
+    4002 = 1.00000
+    4003 = 1.00000
+    4016 = 1.00000
+    4017 = 1.00000
+    4026 = 1.00000
+    4028 = 1.00000
+    4027 = 1.00000
+    4029 = 1.00000
+    4034 = 1.00000
+    4035 = 1.00000
+    4038 = 1.00000
+    4039 = 1.00000
+    4050 = 1.00000
+    4051 = 1.00000
+    4052 = 1.00000
+    4053 = 1.00000
+    4078 = 1.00000
+    4079 = 1.00000
+    4080 = 1.00000
+    4081 = 1.00000
+    4135 = 1.00000
+    4148 = 1.00000
+    4149 = 1.00000
+    4160 = 1.00000
+    4161 = 1.00000
+    4186 = 1.00000
+    4187 = 1.00000
+    4188 = 1.00000
+    4189 = 1.00000
+    4242 = 1.00000
+    4248 = 1.00000
+    4249 = 1.00000
+    4266 = 1.00000
+    4267 = 1.00000
+    4278 = 1.00000
+    4279 = 1.00000
+    4280 = 1.00000
+    4281 = 1.00000
+    4432 = 1.00000
+    4445 = 1.00000
+    4446 = 1.00000
+    4457 = 1.00000
+    4458 = 1.00000
+    4483 = 1.00000
+    4484 = 1.00000
+    4485 = 1.00000
+    4486 = 1.00000
+    4539 = 1.00000
+    4540 = 1.00000
+    4542 = 1.00000
+    4545 = 1.00000
+    4546 = 1.00000
+    4553 = 1.00000
+    4554 = 1.00000
+    4563 = 1.00000
+    4565 = 1.00000
+    4564 = 1.00000
+    4566 = 1.00000
+    4569 = 1.00000
+    4570 = 1.00000
+    4575 = 1.00000
+    4576 = 1.00000
+    4577 = 1.00000
+    4578 = 1.00000
+    4591 = 1.00000
+    4592 = 1.00000
+    4593 = 1.00000
+    4594 = 1.00000
+    4728 = 1.00000
+    4731 = 1.00000
+    4732 = 1.00000
+    4743 = 1.00000
+    4744 = 1.00000
+    4749 = 1.00000
+    4750 = 1.00000
+    4751 = 1.00000
+    4752 = 1.00000
+    4810 = 1.00000
+    4823 = 1.00000
+    4824 = 1.00000
+    4835 = 1.00000
+    4836 = 1.00000
+    4861 = 1.00000
+    4862 = 1.00000
+    4863 = 1.00000
+    4864 = 1.00000
+    4917 = 1.00000
+    4918 = 1.00000
+    4920 = 1.00000
+    4923 = 1.00000
+    4924 = 1.00000
+    4931 = 1.00000
+    4932 = 1.00000
+    4941 = 1.00000
+    4943 = 1.00000
+    4942 = 1.00000
+    4944 = 1.00000
+    4947 = 1.00000
+    4948 = 1.00000
+    4953 = 1.00000
+    4954 = 1.00000
+    4955 = 1.00000
+    4956 = 1.00000
+    4969 = 1.00000
+    4970 = 1.00000
+    4971 = 1.00000
+    4972 = 1.00000
+    5106 = 1.00000
+    5109 = 1.00000
+    5110 = 1.00000
+    5121 = 1.00000
+    5122 = 1.00000
+    5127 = 1.00000
+    5128 = 1.00000
+    5129 = 1.00000
+    5130 = 1.00000
+    5187 = 1.00000
+    5193 = 1.00000
+    5194 = 1.00000
+    5211 = 1.00000
+    5212 = 1.00000
+    5223 = 1.00000
+    5224 = 1.00000
+    5225 = 1.00000
+    5226 = 1.00000
+    5376 = 1.00000
+    5377 = 1.00000
+    5380 = 1.00000
+    5382 = 1.00000
+    5383 = 1.00000
+    5396 = 1.00000
+    5397 = 1.00000
+    5400 = 1.00000
+    5402 = 1.00000
+    5401 = 1.00000
+    5403 = 1.00000
+    5408 = 1.00000
+    5409 = 1.00000
+    5412 = 1.00000
+    5413 = 1.00000
+    5414 = 1.00000
+    5415 = 1.00000
+    5440 = 1.00000
+    5441 = 1.00000
+    5442 = 1.00000
+    5443 = 1.00000
+    5485 = 1.00000
+    5495 = 1.00000
+    5496 = 1.00000
+    5501 = 1.00000
+    5502 = 1.00000
+    5521 = 1.00000
+    5522 = 1.00000
+    5523 = 1.00000
+    5524 = 1.00000
+    5565 = 1.00000
+    5571 = 1.00000
+    5572 = 1.00000
+    5589 = 1.00000
+    5590 = 1.00000
+    5601 = 1.00000
+    5602 = 1.00000
+    5603 = 1.00000
+    5604 = 1.00000
+    5754 = 1.00000
+    5755 = 1.00000
+    5758 = 1.00000
+    5760 = 1.00000
+    5761 = 1.00000
+    5774 = 1.00000
+    5775 = 1.00000
+    5778 = 1.00000
+    5780 = 1.00000
+    5779 = 1.00000
+    5781 = 1.00000
+    5786 = 1.00000
+    5787 = 1.00000
+    5790 = 1.00000
+    5791 = 1.00000
+    5792 = 1.00000
+    5793 = 1.00000
+    5818 = 1.00000
+    5819 = 1.00000
+    5820 = 1.00000
+    5821 = 1.00000
+    5863 = 1.00000
+    5873 = 1.00000
+    5874 = 1.00000
+    5879 = 1.00000
+    5880 = 1.00000
+    5899 = 1.00000
+    5900 = 1.00000
+    5901 = 1.00000
+    5902 = 1.00000
+    6024 = 1.00000
+    6027 = 1.00000
+    6028 = 1.00000
+    6039 = 1.00000
+    6040 = 1.00000
+    6045 = 1.00000
+    6046 = 1.00000
+    6047 = 1.00000
+    6048 = 1.00000
+    6106 = 1.00000
+    6116 = 1.00000
+    6117 = 1.00000
+    6122 = 1.00000
+    6123 = 1.00000
+    6142 = 1.00000
+    6143 = 1.00000
+    6144 = 1.00000
+    6145 = 1.00000
+    6186 = 1.00000
+    6187 = 1.00000
+    6189 = 1.00000
+    6190 = 1.00000
+    6197 = 1.00000
+    6198 = 1.00000
+    6201 = 1.00000
+    6203 = 1.00000
+    6202 = 1.00000
+    6204 = 1.00000
+    6207 = 1.00000
+    6208 = 1.00000
+    6209 = 1.00000
+    6210 = 1.00000
+    6223 = 1.00000
+    6224 = 1.00000
+    6225 = 1.00000
+    6226 = 1.00000
+    6348 = 1.00000
+    6351 = 1.00000
+    6352 = 1.00000
+    6363 = 1.00000
+    6364 = 1.00000
+    6369 = 1.00000
+    6370 = 1.00000
+    6371 = 1.00000
+    6372 = 1.00000
+    6430 = 1.00000
+    6440 = 1.00000
+    6441 = 1.00000
+    6446 = 1.00000
+    6447 = 1.00000
+    6466 = 1.00000
+    6467 = 1.00000
+    6468 = 1.00000
+    6469 = 1.00000
+    6510 = 1.00000
+    6511 = 1.00000
+    6513 = 1.00000
+    6514 = 1.00000
+    6521 = 1.00000
+    6522 = 1.00000
+    6525 = 1.00000
+    6527 = 1.00000
+    6526 = 1.00000
+    6528 = 1.00000
+    6531 = 1.00000
+    6532 = 1.00000
+    6533 = 1.00000
+    6534 = 1.00000
+    6547 = 1.00000
+    6548 = 1.00000
+    6549 = 1.00000
+    6550 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(3)^3], case=4
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    4 = 1.00000
+    5 = 1.00000
+    6 = 1.00000
+    8 = 1.00000
+    11 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    16 = 1.00000
+    18 = 1.00000
+    24 = 1.00000
+    28 = 1.00000
+    25 = 1.00000
+    29 = 1.00000
+    34 = 1.00000
+    35 = 1.00000
+    38 = 1.00000
+    40 = 1.00000
+    39 = 1.00000
+    41 = 1.00000
+    46 = 1.00000
+    47 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    62 = 1.00000
+    63 = 1.00000
+    72 = 1.00000
+    74 = 1.00000
+    73 = 1.00000
+    75 = 1.00000
+    80 = 1.00000
+    81 = 1.00000
+    84 = 1.00000
+    85 = 1.00000
+    96 = 1.00000
+    97 = 1.00000
+    98 = 1.00000
+    99 = 1.00000
+    124 = 1.00000
+    125 = 1.00000
+    126 = 1.00000
+    127 = 1.00000
+    152 = 1.00000
+    153 = 1.00000
+    154 = 1.00000
+    155 = 1.00000
+    193 = 1.00000
+    194 = 1.00000
+    197 = 1.00000
+    199 = 1.00000
+    208 = 1.00000
+    209 = 1.00000
+    212 = 1.00000
+    214 = 1.00000
+    213 = 1.00000
+    215 = 1.00000
+    220 = 1.00000
+    221 = 1.00000
+    230 = 1.00000
+    231 = 1.00000
+    242 = 1.00000
+    243 = 1.00000
+    268 = 1.00000
+    269 = 1.00000
+    270 = 1.00000
+    271 = 1.00000
+    296 = 1.00000
+    297 = 1.00000
+    298 = 1.00000
+    299 = 1.00000
+    336 = 1.00000
+    338 = 1.00000
+    341 = 1.00000
+    342 = 1.00000
+    348 = 1.00000
+    352 = 1.00000
+    349 = 1.00000
+    353 = 1.00000
+    358 = 1.00000
+    359 = 1.00000
+    364 = 1.00000
+    365 = 1.00000
+    366 = 1.00000
+    367 = 1.00000
+    384 = 1.00000
+    385 = 1.00000
+    396 = 1.00000
+    397 = 1.00000
+    398 = 1.00000
+    399 = 1.00000
+    440 = 1.00000
+    441 = 1.00000
+    442 = 1.00000
+    443 = 1.00000
+    482 = 1.00000
+    490 = 1.00000
+    491 = 1.00000
+    496 = 1.00000
+    497 = 1.00000
+    548 = 1.00000
+    549 = 1.00000
+    550 = 1.00000
+    551 = 1.00000
+    588 = 1.00000
+    589 = 1.00000
+    592 = 1.00000
+    594 = 1.00000
+    600 = 1.00000
+    601 = 1.00000
+    614 = 1.00000
+    615 = 1.00000
+    624 = 1.00000
+    626 = 1.00000
+    625 = 1.00000
+    627 = 1.00000
+    632 = 1.00000
+    633 = 1.00000
+    636 = 1.00000
+    637 = 1.00000
+    648 = 1.00000
+    649 = 1.00000
+    650 = 1.00000
+    651 = 1.00000
+    676 = 1.00000
+    677 = 1.00000
+    678 = 1.00000
+    679 = 1.00000
+    733 = 1.00000
+    746 = 1.00000
+    747 = 1.00000
+    758 = 1.00000
+    759 = 1.00000
+    784 = 1.00000
+    785 = 1.00000
+    786 = 1.00000
+    787 = 1.00000
+    840 = 1.00000
+    846 = 1.00000
+    847 = 1.00000
+    864 = 1.00000
+    865 = 1.00000
+    876 = 1.00000
+    877 = 1.00000
+    878 = 1.00000
+    879 = 1.00000
+    1030 = 1.00000
+    1031 = 1.00000
+    1034 = 1.00000
+    1036 = 1.00000
+    1045 = 1.00000
+    1046 = 1.00000
+    1049 = 1.00000
+    1051 = 1.00000
+    1050 = 1.00000
+    1052 = 1.00000
+    1057 = 1.00000
+    1058 = 1.00000
+    1067 = 1.00000
+    1068 = 1.00000
+    1079 = 1.00000
+    1080 = 1.00000
+    1105 = 1.00000
+    1106 = 1.00000
+    1107 = 1.00000
+    1108 = 1.00000
+    1133 = 1.00000
+    1134 = 1.00000
+    1135 = 1.00000
+    1136 = 1.00000
+    1173 = 1.00000
+    1174 = 1.00000
+    1175 = 1.00000
+    1176 = 1.00000
+    1178 = 1.00000
+    1179 = 1.00000
+    1180 = 1.00000
+    1182 = 1.00000
+    1185 = 1.00000
+    1189 = 1.00000
+    1186 = 1.00000
+    1190 = 1.00000
+    1193 = 1.00000
+    1195 = 1.00000
+    1194 = 1.00000
+    1196 = 1.00000
+    1201 = 1.00000
+    1202 = 1.00000
+    1203 = 1.00000
+    1204 = 1.00000
+    1211 = 1.00000
+    1212 = 1.00000
+    1221 = 1.00000
+    1223 = 1.00000
+    1222 = 1.00000
+    1224 = 1.00000
+    1227 = 1.00000
+    1228 = 1.00000
+    1233 = 1.00000
+    1234 = 1.00000
+    1235 = 1.00000
+    1236 = 1.00000
+    1249 = 1.00000
+    1250 = 1.00000
+    1251 = 1.00000
+    1252 = 1.00000
+    1277 = 1.00000
+    1278 = 1.00000
+    1279 = 1.00000
+    1280 = 1.00000
+    1319 = 1.00000
+    1327 = 1.00000
+    1328 = 1.00000
+    1333 = 1.00000
+    1334 = 1.00000
+    1385 = 1.00000
+    1386 = 1.00000
+    1387 = 1.00000
+    1388 = 1.00000
+    1425 = 1.00000
+    1427 = 1.00000
+    1428 = 1.00000
+    1431 = 1.00000
+    1435 = 1.00000
+    1432 = 1.00000
+    1436 = 1.00000
+    1441 = 1.00000
+    1442 = 1.00000
+    1443 = 1.00000
+    1444 = 1.00000
+    1455 = 1.00000
+    1456 = 1.00000
+    1461 = 1.00000
+    1462 = 1.00000
+    1463 = 1.00000
+    1464 = 1.00000
+    1493 = 1.00000
+    1494 = 1.00000
+    1495 = 1.00000
+    1496 = 1.00000
+    1534 = 1.00000
+    1547 = 1.00000
+    1548 = 1.00000
+    1559 = 1.00000
+    1560 = 1.00000
+    1585 = 1.00000
+    1586 = 1.00000
+    1587 = 1.00000
+    1588 = 1.00000
+    1641 = 1.00000
+    1642 = 1.00000
+    1644 = 1.00000
+    1647 = 1.00000
+    1648 = 1.00000
+    1655 = 1.00000
+    1656 = 1.00000
+    1665 = 1.00000
+    1667 = 1.00000
+    1666 = 1.00000
+    1668 = 1.00000
+    1671 = 1.00000
+    1672 = 1.00000
+    1677 = 1.00000
+    1678 = 1.00000
+    1679 = 1.00000
+    1680 = 1.00000
+    1693 = 1.00000
+    1694 = 1.00000
+    1695 = 1.00000
+    1696 = 1.00000
+    1830 = 1.00000
+    1833 = 1.00000
+    1834 = 1.00000
+    1845 = 1.00000
+    1846 = 1.00000
+    1851 = 1.00000
+    1852 = 1.00000
+    1853 = 1.00000
+    1854 = 1.00000
+    1911 = 1.00000
+    1913 = 1.00000
+    1916 = 1.00000
+    1917 = 1.00000
+    1923 = 1.00000
+    1927 = 1.00000
+    1924 = 1.00000
+    1928 = 1.00000
+    1933 = 1.00000
+    1934 = 1.00000
+    1939 = 1.00000
+    1940 = 1.00000
+    1941 = 1.00000
+    1942 = 1.00000
+    1959 = 1.00000
+    1960 = 1.00000
+    1971 = 1.00000
+    1972 = 1.00000
+    1973 = 1.00000
+    1974 = 1.00000
+    2015 = 1.00000
+    2016 = 1.00000
+    2017 = 1.00000
+    2018 = 1.00000
+    2057 = 1.00000
+    2065 = 1.00000
+    2066 = 1.00000
+    2071 = 1.00000
+    2072 = 1.00000
+    2123 = 1.00000
+    2124 = 1.00000
+    2125 = 1.00000
+    2126 = 1.00000
+    2163 = 1.00000
+    2164 = 1.00000
+    2165 = 1.00000
+    2167 = 1.00000
+    2168 = 1.00000
+    2169 = 1.00000
+    2170 = 1.00000
+    2173 = 1.00000
+    2175 = 1.00000
+    2179 = 1.00000
+    2176 = 1.00000
+    2180 = 1.00000
+    2185 = 1.00000
+    2186 = 1.00000
+    2189 = 1.00000
+    2191 = 1.00000
+    2190 = 1.00000
+    2192 = 1.00000
+    2193 = 1.00000
+    2194 = 1.00000
+    2207 = 1.00000
+    2208 = 1.00000
+    2211 = 1.00000
+    2213 = 1.00000
+    2212 = 1.00000
+    2214 = 1.00000
+    2219 = 1.00000
+    2220 = 1.00000
+    2223 = 1.00000
+    2224 = 1.00000
+    2225 = 1.00000
+    2226 = 1.00000
+    2251 = 1.00000
+    2252 = 1.00000
+    2253 = 1.00000
+    2254 = 1.00000
+    2267 = 1.00000
+    2268 = 1.00000
+    2269 = 1.00000
+    2270 = 1.00000
+    2308 = 1.00000
+    2309 = 1.00000
+    2311 = 1.00000
+    2317 = 1.00000
+    2318 = 1.00000
+    2321 = 1.00000
+    2323 = 1.00000
+    2322 = 1.00000
+    2324 = 1.00000
+    2333 = 1.00000
+    2334 = 1.00000
+    2339 = 1.00000
+    2340 = 1.00000
+    2359 = 1.00000
+    2360 = 1.00000
+    2361 = 1.00000
+    2362 = 1.00000
+    2375 = 1.00000
+    2376 = 1.00000
+    2377 = 1.00000
+    2378 = 1.00000
+    2415 = 1.00000
+    2421 = 1.00000
+    2422 = 1.00000
+    2439 = 1.00000
+    2440 = 1.00000
+    2451 = 1.00000
+    2452 = 1.00000
+    2453 = 1.00000
+    2454 = 1.00000
+    2604 = 1.00000
+    2605 = 1.00000
+    2608 = 1.00000
+    2610 = 1.00000
+    2611 = 1.00000
+    2624 = 1.00000
+    2625 = 1.00000
+    2628 = 1.00000
+    2630 = 1.00000
+    2629 = 1.00000
+    2631 = 1.00000
+    2636 = 1.00000
+    2637 = 1.00000
+    2640 = 1.00000
+    2641 = 1.00000
+    2642 = 1.00000
+    2643 = 1.00000
+    2668 = 1.00000
+    2669 = 1.00000
+    2670 = 1.00000
+    2671 = 1.00000
+    2713 = 1.00000
+    2723 = 1.00000
+    2724 = 1.00000
+    2729 = 1.00000
+    2730 = 1.00000
+    2749 = 1.00000
+    2750 = 1.00000
+    2751 = 1.00000
+    2752 = 1.00000
+    2795 = 1.00000
+    2803 = 1.00000
+    2804 = 1.00000
+    2809 = 1.00000
+    2810 = 1.00000
+    2861 = 1.00000
+    2862 = 1.00000
+    2863 = 1.00000
+    2864 = 1.00000
+    2901 = 1.00000
+    2903 = 1.00000
+    2904 = 1.00000
+    2907 = 1.00000
+    2911 = 1.00000
+    2908 = 1.00000
+    2912 = 1.00000
+    2917 = 1.00000
+    2918 = 1.00000
+    2919 = 1.00000
+    2920 = 1.00000
+    2931 = 1.00000
+    2932 = 1.00000
+    2937 = 1.00000
+    2938 = 1.00000
+    2939 = 1.00000
+    2940 = 1.00000
+    2969 = 1.00000
+    2970 = 1.00000
+    2971 = 1.00000
+    2972 = 1.00000
+    3010 = 1.00000
+    3011 = 1.00000
+    3013 = 1.00000
+    3019 = 1.00000
+    3020 = 1.00000
+    3023 = 1.00000
+    3025 = 1.00000
+    3024 = 1.00000
+    3026 = 1.00000
+    3035 = 1.00000
+    3036 = 1.00000
+    3041 = 1.00000
+    3042 = 1.00000
+    3061 = 1.00000
+    3062 = 1.00000
+    3063 = 1.00000
+    3064 = 1.00000
+    3077 = 1.00000
+    3078 = 1.00000
+    3079 = 1.00000
+    3080 = 1.00000
+    3117 = 1.00000
+    3118 = 1.00000
+    3119 = 1.00000
+    3120 = 1.00000
+    3121 = 1.00000
+    3123 = 1.00000
+    3127 = 1.00000
+    3124 = 1.00000
+    3128 = 1.00000
+    3131 = 1.00000
+    3133 = 1.00000
+    3132 = 1.00000
+    3134 = 1.00000
+    3135 = 1.00000
+    3136 = 1.00000
+    3143 = 1.00000
+    3144 = 1.00000
+    3147 = 1.00000
+    3149 = 1.00000
+    3148 = 1.00000
+    3150 = 1.00000
+    3153 = 1.00000
+    3154 = 1.00000
+    3155 = 1.00000
+    3156 = 1.00000
+    3169 = 1.00000
+    3170 = 1.00000
+    3171 = 1.00000
+    3172 = 1.00000
+    3185 = 1.00000
+    3186 = 1.00000
+    3187 = 1.00000
+    3188 = 1.00000
+    3306 = 1.00000
+    3309 = 1.00000
+    3310 = 1.00000
+    3321 = 1.00000
+    3322 = 1.00000
+    3327 = 1.00000
+    3328 = 1.00000
+    3329 = 1.00000
+    3330 = 1.00000
+    3388 = 1.00000
+    3398 = 1.00000
+    3399 = 1.00000
+    3404 = 1.00000
+    3405 = 1.00000
+    3424 = 1.00000
+    3425 = 1.00000
+    3426 = 1.00000
+    3427 = 1.00000
+    3468 = 1.00000
+    3469 = 1.00000
+    3471 = 1.00000
+    3472 = 1.00000
+    3479 = 1.00000
+    3480 = 1.00000
+    3483 = 1.00000
+    3485 = 1.00000
+    3484 = 1.00000
+    3486 = 1.00000
+    3489 = 1.00000
+    3490 = 1.00000
+    3491 = 1.00000
+    3492 = 1.00000
+    3505 = 1.00000
+    3506 = 1.00000
+    3507 = 1.00000
+    3508 = 1.00000
+    3549 = 1.00000
+    3550 = 1.00000
+    3553 = 1.00000
+    3555 = 1.00000
+    3561 = 1.00000
+    3562 = 1.00000
+    3575 = 1.00000
+    3576 = 1.00000
+    3585 = 1.00000
+    3587 = 1.00000
+    3586 = 1.00000
+    3588 = 1.00000
+    3593 = 1.00000
+    3594 = 1.00000
+    3597 = 1.00000
+    3598 = 1.00000
+    3609 = 1.00000
+    3610 = 1.00000
+    3611 = 1.00000
+    3612 = 1.00000
+    3637 = 1.00000
+    3638 = 1.00000
+    3639 = 1.00000
+    3640 = 1.00000
+    3694 = 1.00000
+    3707 = 1.00000
+    3708 = 1.00000
+    3719 = 1.00000
+    3720 = 1.00000
+    3745 = 1.00000
+    3746 = 1.00000
+    3747 = 1.00000
+    3748 = 1.00000
+    3801 = 1.00000
+    3807 = 1.00000
+    3808 = 1.00000
+    3825 = 1.00000
+    3826 = 1.00000
+    3837 = 1.00000
+    3838 = 1.00000
+    3839 = 1.00000
+    3840 = 1.00000
+    3990 = 1.00000
+    3991 = 1.00000
+    3994 = 1.00000
+    3996 = 1.00000
+    4002 = 1.00000
+    4003 = 1.00000
+    4016 = 1.00000
+    4017 = 1.00000
+    4026 = 1.00000
+    4028 = 1.00000
+    4027 = 1.00000
+    4029 = 1.00000
+    4034 = 1.00000
+    4035 = 1.00000
+    4038 = 1.00000
+    4039 = 1.00000
+    4050 = 1.00000
+    4051 = 1.00000
+    4052 = 1.00000
+    4053 = 1.00000
+    4078 = 1.00000
+    4079 = 1.00000
+    4080 = 1.00000
+    4081 = 1.00000
+    4135 = 1.00000
+    4148 = 1.00000
+    4149 = 1.00000
+    4160 = 1.00000
+    4161 = 1.00000
+    4186 = 1.00000
+    4187 = 1.00000
+    4188 = 1.00000
+    4189 = 1.00000
+    4242 = 1.00000
+    4248 = 1.00000
+    4249 = 1.00000
+    4266 = 1.00000
+    4267 = 1.00000
+    4278 = 1.00000
+    4279 = 1.00000
+    4280 = 1.00000
+    4281 = 1.00000
+    4432 = 1.00000
+    4445 = 1.00000
+    4446 = 1.00000
+    4457 = 1.00000
+    4458 = 1.00000
+    4483 = 1.00000
+    4484 = 1.00000
+    4485 = 1.00000
+    4486 = 1.00000
+    4539 = 1.00000
+    4540 = 1.00000
+    4542 = 1.00000
+    4545 = 1.00000
+    4546 = 1.00000
+    4553 = 1.00000
+    4554 = 1.00000
+    4563 = 1.00000
+    4565 = 1.00000
+    4564 = 1.00000
+    4566 = 1.00000
+    4569 = 1.00000
+    4570 = 1.00000
+    4575 = 1.00000
+    4576 = 1.00000
+    4577 = 1.00000
+    4578 = 1.00000
+    4591 = 1.00000
+    4592 = 1.00000
+    4593 = 1.00000
+    4594 = 1.00000
+    4728 = 1.00000
+    4731 = 1.00000
+    4732 = 1.00000
+    4743 = 1.00000
+    4744 = 1.00000
+    4749 = 1.00000
+    4750 = 1.00000
+    4751 = 1.00000
+    4752 = 1.00000
+    4810 = 1.00000
+    4823 = 1.00000
+    4824 = 1.00000
+    4835 = 1.00000
+    4836 = 1.00000
+    4861 = 1.00000
+    4862 = 1.00000
+    4863 = 1.00000
+    4864 = 1.00000
+    4917 = 1.00000
+    4918 = 1.00000
+    4920 = 1.00000
+    4923 = 1.00000
+    4924 = 1.00000
+    4931 = 1.00000
+    4932 = 1.00000
+    4941 = 1.00000
+    4943 = 1.00000
+    4942 = 1.00000
+    4944 = 1.00000
+    4947 = 1.00000
+    4948 = 1.00000
+    4953 = 1.00000
+    4954 = 1.00000
+    4955 = 1.00000
+    4956 = 1.00000
+    4969 = 1.00000
+    4970 = 1.00000
+    4971 = 1.00000
+    4972 = 1.00000
+    5106 = 1.00000
+    5109 = 1.00000
+    5110 = 1.00000
+    5121 = 1.00000
+    5122 = 1.00000
+    5127 = 1.00000
+    5128 = 1.00000
+    5129 = 1.00000
+    5130 = 1.00000
+    5187 = 1.00000
+    5193 = 1.00000
+    5194 = 1.00000
+    5211 = 1.00000
+    5212 = 1.00000
+    5223 = 1.00000
+    5224 = 1.00000
+    5225 = 1.00000
+    5226 = 1.00000
+    5376 = 1.00000
+    5377 = 1.00000
+    5380 = 1.00000
+    5382 = 1.00000
+    5383 = 1.00000
+    5396 = 1.00000
+    5397 = 1.00000
+    5400 = 1.00000
+    5402 = 1.00000
+    5401 = 1.00000
+    5403 = 1.00000
+    5408 = 1.00000
+    5409 = 1.00000
+    5412 = 1.00000
+    5413 = 1.00000
+    5414 = 1.00000
+    5415 = 1.00000
+    5440 = 1.00000
+    5441 = 1.00000
+    5442 = 1.00000
+    5443 = 1.00000
+    5485 = 1.00000
+    5495 = 1.00000
+    5496 = 1.00000
+    5501 = 1.00000
+    5502 = 1.00000
+    5521 = 1.00000
+    5522 = 1.00000
+    5523 = 1.00000
+    5524 = 1.00000
+    5565 = 1.00000
+    5571 = 1.00000
+    5572 = 1.00000
+    5589 = 1.00000
+    5590 = 1.00000
+    5601 = 1.00000
+    5602 = 1.00000
+    5603 = 1.00000
+    5604 = 1.00000
+    5754 = 1.00000
+    5755 = 1.00000
+    5758 = 1.00000
+    5760 = 1.00000
+    5761 = 1.00000
+    5774 = 1.00000
+    5775 = 1.00000
+    5778 = 1.00000
+    5780 = 1.00000
+    5779 = 1.00000
+    5781 = 1.00000
+    5786 = 1.00000
+    5787 = 1.00000
+    5790 = 1.00000
+    5791 = 1.00000
+    5792 = 1.00000
+    5793 = 1.00000
+    5818 = 1.00000
+    5819 = 1.00000
+    5820 = 1.00000
+    5821 = 1.00000
+    5863 = 1.00000
+    5873 = 1.00000
+    5874 = 1.00000
+    5879 = 1.00000
+    5880 = 1.00000
+    5899 = 1.00000
+    5900 = 1.00000
+    5901 = 1.00000
+    5902 = 1.00000
+    6024 = 1.00000
+    6027 = 1.00000
+    6028 = 1.00000
+    6039 = 1.00000
+    6040 = 1.00000
+    6045 = 1.00000
+    6046 = 1.00000
+    6047 = 1.00000
+    6048 = 1.00000
+    6106 = 1.00000
+    6116 = 1.00000
+    6117 = 1.00000
+    6122 = 1.00000
+    6123 = 1.00000
+    6142 = 1.00000
+    6143 = 1.00000
+    6144 = 1.00000
+    6145 = 1.00000
+    6186 = 1.00000
+    6187 = 1.00000
+    6189 = 1.00000
+    6190 = 1.00000
+    6197 = 1.00000
+    6198 = 1.00000
+    6201 = 1.00000
+    6203 = 1.00000
+    6202 = 1.00000
+    6204 = 1.00000
+    6207 = 1.00000
+    6208 = 1.00000
+    6209 = 1.00000
+    6210 = 1.00000
+    6223 = 1.00000
+    6224 = 1.00000
+    6225 = 1.00000
+    6226 = 1.00000
+    6348 = 1.00000
+    6351 = 1.00000
+    6352 = 1.00000
+    6363 = 1.00000
+    6364 = 1.00000
+    6369 = 1.00000
+    6370 = 1.00000
+    6371 = 1.00000
+    6372 = 1.00000
+    6430 = 1.00000
+    6440 = 1.00000
+    6441 = 1.00000
+    6446 = 1.00000
+    6447 = 1.00000
+    6466 = 1.00000
+    6467 = 1.00000
+    6468 = 1.00000
+    6469 = 1.00000
+    6510 = 1.00000
+    6511 = 1.00000
+    6513 = 1.00000
+    6514 = 1.00000
+    6521 = 1.00000
+    6522 = 1.00000
+    6525 = 1.00000
+    6527 = 1.00000
+    6526 = 1.00000
+    6528 = 1.00000
+    6531 = 1.00000
+    6532 = 1.00000
+    6533 = 1.00000
+    6534 = 1.00000
+    6547 = 1.00000
+    6548 = 1.00000
+    6549 = 1.00000
+    6550 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(3)^3], case=5
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    4 = 1.00000
+    5 = 1.00000
+    6 = 1.00000
+    8 = 1.00000
+    11 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    16 = 1.00000
+    18 = 1.00000
+    24 = 1.00000
+    28 = 1.00000
+    25 = 1.00000
+    29 = 1.00000
+    34 = 1.00000
+    35 = 1.00000
+    38 = 1.00000
+    40 = 1.00000
+    39 = 1.00000
+    41 = 1.00000
+    46 = 1.00000
+    47 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    62 = 1.00000
+    63 = 1.00000
+    72 = 1.00000
+    74 = 1.00000
+    73 = 1.00000
+    75 = 1.00000
+    80 = 1.00000
+    81 = 1.00000
+    84 = 1.00000
+    85 = 1.00000
+    96 = 1.00000
+    97 = 1.00000
+    98 = 1.00000
+    99 = 1.00000
+    124 = 1.00000
+    125 = 1.00000
+    126 = 1.00000
+    127 = 1.00000
+    152 = 1.00000
+    153 = 1.00000
+    154 = 1.00000
+    155 = 1.00000
+    193 = 1.00000
+    194 = 1.00000
+    197 = 1.00000
+    199 = 1.00000
+    208 = 1.00000
+    209 = 1.00000
+    212 = 1.00000
+    214 = 1.00000
+    213 = 1.00000
+    215 = 1.00000
+    220 = 1.00000
+    221 = 1.00000
+    230 = 1.00000
+    231 = 1.00000
+    242 = 1.00000
+    243 = 1.00000
+    268 = 1.00000
+    269 = 1.00000
+    270 = 1.00000
+    271 = 1.00000
+    296 = 1.00000
+    297 = 1.00000
+    298 = 1.00000
+    299 = 1.00000
+    336 = 1.00000
+    338 = 1.00000
+    341 = 1.00000
+    342 = 1.00000
+    348 = 1.00000
+    352 = 1.00000
+    349 = 1.00000
+    353 = 1.00000
+    358 = 1.00000
+    359 = 1.00000
+    364 = 1.00000
+    365 = 1.00000
+    366 = 1.00000
+    367 = 1.00000
+    384 = 1.00000
+    385 = 1.00000
+    396 = 1.00000
+    397 = 1.00000
+    398 = 1.00000
+    399 = 1.00000
+    440 = 1.00000
+    441 = 1.00000
+    442 = 1.00000
+    443 = 1.00000
+    482 = 1.00000
+    490 = 1.00000
+    491 = 1.00000
+    496 = 1.00000
+    497 = 1.00000
+    548 = 1.00000
+    549 = 1.00000
+    550 = 1.00000
+    551 = 1.00000
+    588 = 1.00000
+    589 = 1.00000
+    592 = 1.00000
+    594 = 1.00000
+    600 = 1.00000
+    601 = 1.00000
+    614 = 1.00000
+    615 = 1.00000
+    624 = 1.00000
+    626 = 1.00000
+    625 = 1.00000
+    627 = 1.00000
+    632 = 1.00000
+    633 = 1.00000
+    636 = 1.00000
+    637 = 1.00000
+    648 = 1.00000
+    649 = 1.00000
+    650 = 1.00000
+    651 = 1.00000
+    676 = 1.00000
+    677 = 1.00000
+    678 = 1.00000
+    679 = 1.00000
+    733 = 1.00000
+    746 = 1.00000
+    747 = 1.00000
+    758 = 1.00000
+    759 = 1.00000
+    784 = 1.00000
+    785 = 1.00000
+    786 = 1.00000
+    787 = 1.00000
+    840 = 1.00000
+    846 = 1.00000
+    847 = 1.00000
+    864 = 1.00000
+    865 = 1.00000
+    876 = 1.00000
+    877 = 1.00000
+    878 = 1.00000
+    879 = 1.00000
+    1030 = 1.00000
+    1031 = 1.00000
+    1034 = 1.00000
+    1036 = 1.00000
+    1045 = 1.00000
+    1046 = 1.00000
+    1049 = 1.00000
+    1051 = 1.00000
+    1050 = 1.00000
+    1052 = 1.00000
+    1057 = 1.00000
+    1058 = 1.00000
+    1067 = 1.00000
+    1068 = 1.00000
+    1079 = 1.00000
+    1080 = 1.00000
+    1105 = 1.00000
+    1106 = 1.00000
+    1107 = 1.00000
+    1108 = 1.00000
+    1133 = 1.00000
+    1134 = 1.00000
+    1135 = 1.00000
+    1136 = 1.00000
+    1173 = 1.00000
+    1174 = 1.00000
+    1175 = 1.00000
+    1176 = 1.00000
+    1178 = 1.00000
+    1179 = 1.00000
+    1180 = 1.00000
+    1182 = 1.00000
+    1185 = 1.00000
+    1189 = 1.00000
+    1186 = 1.00000
+    1190 = 1.00000
+    1193 = 1.00000
+    1195 = 1.00000
+    1194 = 1.00000
+    1196 = 1.00000
+    1201 = 1.00000
+    1202 = 1.00000
+    1203 = 1.00000
+    1204 = 1.00000
+    1211 = 1.00000
+    1212 = 1.00000
+    1221 = 1.00000
+    1223 = 1.00000
+    1222 = 1.00000
+    1224 = 1.00000
+    1227 = 1.00000
+    1228 = 1.00000
+    1233 = 1.00000
+    1234 = 1.00000
+    1235 = 1.00000
+    1236 = 1.00000
+    1249 = 1.00000
+    1250 = 1.00000
+    1251 = 1.00000
+    1252 = 1.00000
+    1277 = 1.00000
+    1278 = 1.00000
+    1279 = 1.00000
+    1280 = 1.00000
+    1319 = 1.00000
+    1327 = 1.00000
+    1328 = 1.00000
+    1333 = 1.00000
+    1334 = 1.00000
+    1385 = 1.00000
+    1386 = 1.00000
+    1387 = 1.00000
+    1388 = 1.00000
+    1425 = 1.00000
+    1427 = 1.00000
+    1428 = 1.00000
+    1431 = 1.00000
+    1435 = 1.00000
+    1432 = 1.00000
+    1436 = 1.00000
+    1441 = 1.00000
+    1442 = 1.00000
+    1443 = 1.00000
+    1444 = 1.00000
+    1455 = 1.00000
+    1456 = 1.00000
+    1461 = 1.00000
+    1462 = 1.00000
+    1463 = 1.00000
+    1464 = 1.00000
+    1493 = 1.00000
+    1494 = 1.00000
+    1495 = 1.00000
+    1496 = 1.00000
+    1534 = 1.00000
+    1547 = 1.00000
+    1548 = 1.00000
+    1559 = 1.00000
+    1560 = 1.00000
+    1585 = 1.00000
+    1586 = 1.00000
+    1587 = 1.00000
+    1588 = 1.00000
+    1641 = 1.00000
+    1642 = 1.00000
+    1644 = 1.00000
+    1647 = 1.00000
+    1648 = 1.00000
+    1655 = 1.00000
+    1656 = 1.00000
+    1665 = 1.00000
+    1667 = 1.00000
+    1666 = 1.00000
+    1668 = 1.00000
+    1671 = 1.00000
+    1672 = 1.00000
+    1677 = 1.00000
+    1678 = 1.00000
+    1679 = 1.00000
+    1680 = 1.00000
+    1693 = 1.00000
+    1694 = 1.00000
+    1695 = 1.00000
+    1696 = 1.00000
+    1830 = 1.00000
+    1833 = 1.00000
+    1834 = 1.00000
+    1845 = 1.00000
+    1846 = 1.00000
+    1851 = 1.00000
+    1852 = 1.00000
+    1853 = 1.00000
+    1854 = 1.00000
+    1911 = 1.00000
+    1913 = 1.00000
+    1916 = 1.00000
+    1917 = 1.00000
+    1923 = 1.00000
+    1927 = 1.00000
+    1924 = 1.00000
+    1928 = 1.00000
+    1933 = 1.00000
+    1934 = 1.00000
+    1939 = 1.00000
+    1940 = 1.00000
+    1941 = 1.00000
+    1942 = 1.00000
+    1959 = 1.00000
+    1960 = 1.00000
+    1971 = 1.00000
+    1972 = 1.00000
+    1973 = 1.00000
+    1974 = 1.00000
+    2015 = 1.00000
+    2016 = 1.00000
+    2017 = 1.00000
+    2018 = 1.00000
+    2057 = 1.00000
+    2065 = 1.00000
+    2066 = 1.00000
+    2071 = 1.00000
+    2072 = 1.00000
+    2123 = 1.00000
+    2124 = 1.00000
+    2125 = 1.00000
+    2126 = 1.00000
+    2163 = 1.00000
+    2164 = 1.00000
+    2165 = 1.00000
+    2167 = 1.00000
+    2168 = 1.00000
+    2169 = 1.00000
+    2170 = 1.00000
+    2173 = 1.00000
+    2175 = 1.00000
+    2179 = 1.00000
+    2176 = 1.00000
+    2180 = 1.00000
+    2185 = 1.00000
+    2186 = 1.00000
+    2189 = 1.00000
+    2191 = 1.00000
+    2190 = 1.00000
+    2192 = 1.00000
+    2193 = 1.00000
+    2194 = 1.00000
+    2207 = 1.00000
+    2208 = 1.00000
+    2211 = 1.00000
+    2213 = 1.00000
+    2212 = 1.00000
+    2214 = 1.00000
+    2219 = 1.00000
+    2220 = 1.00000
+    2223 = 1.00000
+    2224 = 1.00000
+    2225 = 1.00000
+    2226 = 1.00000
+    2251 = 1.00000
+    2252 = 1.00000
+    2253 = 1.00000
+    2254 = 1.00000
+    2267 = 1.00000
+    2268 = 1.00000
+    2269 = 1.00000
+    2270 = 1.00000
+    2308 = 1.00000
+    2309 = 1.00000
+    2311 = 1.00000
+    2317 = 1.00000
+    2318 = 1.00000
+    2321 = 1.00000
+    2323 = 1.00000
+    2322 = 1.00000
+    2324 = 1.00000
+    2333 = 1.00000
+    2334 = 1.00000
+    2339 = 1.00000
+    2340 = 1.00000
+    2359 = 1.00000
+    2360 = 1.00000
+    2361 = 1.00000
+    2362 = 1.00000
+    2375 = 1.00000
+    2376 = 1.00000
+    2377 = 1.00000
+    2378 = 1.00000
+    2415 = 1.00000
+    2421 = 1.00000
+    2422 = 1.00000
+    2439 = 1.00000
+    2440 = 1.00000
+    2451 = 1.00000
+    2452 = 1.00000
+    2453 = 1.00000
+    2454 = 1.00000
+    2604 = 1.00000
+    2605 = 1.00000
+    2608 = 1.00000
+    2610 = 1.00000
+    2611 = 1.00000
+    2624 = 1.00000
+    2625 = 1.00000
+    2628 = 1.00000
+    2630 = 1.00000
+    2629 = 1.00000
+    2631 = 1.00000
+    2636 = 1.00000
+    2637 = 1.00000
+    2640 = 1.00000
+    2641 = 1.00000
+    2642 = 1.00000
+    2643 = 1.00000
+    2668 = 1.00000
+    2669 = 1.00000
+    2670 = 1.00000
+    2671 = 1.00000
+    2713 = 1.00000
+    2723 = 1.00000
+    2724 = 1.00000
+    2729 = 1.00000
+    2730 = 1.00000
+    2749 = 1.00000
+    2750 = 1.00000
+    2751 = 1.00000
+    2752 = 1.00000
+    2795 = 1.00000
+    2803 = 1.00000
+    2804 = 1.00000
+    2809 = 1.00000
+    2810 = 1.00000
+    2861 = 1.00000
+    2862 = 1.00000
+    2863 = 1.00000
+    2864 = 1.00000
+    2901 = 1.00000
+    2903 = 1.00000
+    2904 = 1.00000
+    2907 = 1.00000
+    2911 = 1.00000
+    2908 = 1.00000
+    2912 = 1.00000
+    2917 = 1.00000
+    2918 = 1.00000
+    2919 = 1.00000
+    2920 = 1.00000
+    2931 = 1.00000
+    2932 = 1.00000
+    2937 = 1.00000
+    2938 = 1.00000
+    2939 = 1.00000
+    2940 = 1.00000
+    2969 = 1.00000
+    2970 = 1.00000
+    2971 = 1.00000
+    2972 = 1.00000
+    3010 = 1.00000
+    3011 = 1.00000
+    3013 = 1.00000
+    3019 = 1.00000
+    3020 = 1.00000
+    3023 = 1.00000
+    3025 = 1.00000
+    3024 = 1.00000
+    3026 = 1.00000
+    3035 = 1.00000
+    3036 = 1.00000
+    3041 = 1.00000
+    3042 = 1.00000
+    3061 = 1.00000
+    3062 = 1.00000
+    3063 = 1.00000
+    3064 = 1.00000
+    3077 = 1.00000
+    3078 = 1.00000
+    3079 = 1.00000
+    3080 = 1.00000
+    3117 = 1.00000
+    3118 = 1.00000
+    3119 = 1.00000
+    3120 = 1.00000
+    3121 = 1.00000
+    3123 = 1.00000
+    3127 = 1.00000
+    3124 = 1.00000
+    3128 = 1.00000
+    3131 = 1.00000
+    3133 = 1.00000
+    3132 = 1.00000
+    3134 = 1.00000
+    3135 = 1.00000
+    3136 = 1.00000
+    3143 = 1.00000
+    3144 = 1.00000
+    3147 = 1.00000
+    3149 = 1.00000
+    3148 = 1.00000
+    3150 = 1.00000
+    3153 = 1.00000
+    3154 = 1.00000
+    3155 = 1.00000
+    3156 = 1.00000
+    3169 = 1.00000
+    3170 = 1.00000
+    3171 = 1.00000
+    3172 = 1.00000
+    3185 = 1.00000
+    3186 = 1.00000
+    3187 = 1.00000
+    3188 = 1.00000
+    3306 = 1.00000
+    3309 = 1.00000
+    3310 = 1.00000
+    3321 = 1.00000
+    3322 = 1.00000
+    3327 = 1.00000
+    3328 = 1.00000
+    3329 = 1.00000
+    3330 = 1.00000
+    3388 = 1.00000
+    3398 = 1.00000
+    3399 = 1.00000
+    3404 = 1.00000
+    3405 = 1.00000
+    3424 = 1.00000
+    3425 = 1.00000
+    3426 = 1.00000
+    3427 = 1.00000
+    3468 = 1.00000
+    3469 = 1.00000
+    3471 = 1.00000
+    3472 = 1.00000
+    3479 = 1.00000
+    3480 = 1.00000
+    3483 = 1.00000
+    3485 = 1.00000
+    3484 = 1.00000
+    3486 = 1.00000
+    3489 = 1.00000
+    3490 = 1.00000
+    3491 = 1.00000
+    3492 = 1.00000
+    3505 = 1.00000
+    3506 = 1.00000
+    3507 = 1.00000
+    3508 = 1.00000
+    3549 = 1.00000
+    3550 = 1.00000
+    3553 = 1.00000
+    3555 = 1.00000
+    3561 = 1.00000
+    3562 = 1.00000
+    3575 = 1.00000
+    3576 = 1.00000
+    3585 = 1.00000
+    3587 = 1.00000
+    3586 = 1.00000
+    3588 = 1.00000
+    3593 = 1.00000
+    3594 = 1.00000
+    3597 = 1.00000
+    3598 = 1.00000
+    3609 = 1.00000
+    3610 = 1.00000
+    3611 = 1.00000
+    3612 = 1.00000
+    3637 = 1.00000
+    3638 = 1.00000
+    3639 = 1.00000
+    3640 = 1.00000
+    3694 = 1.00000
+    3707 = 1.00000
+    3708 = 1.00000
+    3719 = 1.00000
+    3720 = 1.00000
+    3745 = 1.00000
+    3746 = 1.00000
+    3747 = 1.00000
+    3748 = 1.00000
+    3801 = 1.00000
+    3807 = 1.00000
+    3808 = 1.00000
+    3825 = 1.00000
+    3826 = 1.00000
+    3837 = 1.00000
+    3838 = 1.00000
+    3839 = 1.00000
+    3840 = 1.00000
+    3990 = 1.00000
+    3991 = 1.00000
+    3992 = 1.00000
+    3994 = 1.00000
+    3995 = 1.00000
+    3996 = 1.00000
+    3998 = 1.00000
+    4001 = 1.00000
+    4002 = 1.00000
+    4006 = 1.00000
+    4003 = 1.00000
+    4007 = 1.00000
+    4012 = 1.00000
+    4013 = 1.00000
+    4016 = 1.00000
+    4018 = 1.00000
+    4017 = 1.00000
+    4019 = 1.00000
+    4024 = 1.00000
+    4025 = 1.00000
+    4026 = 1.00000
+    4028 = 1.00000
+    4027 = 1.00000
+    4029 = 1.00000
+    4034 = 1.00000
+    4035 = 1.00000
+    4038 = 1.00000
+    4039 = 1.00000
+    4050 = 1.00000
+    4051 = 1.00000
+    4052 = 1.00000
+    4053 = 1.00000
+    4078 = 1.00000
+    4079 = 1.00000
+    4080 = 1.00000
+    4081 = 1.00000
+    4106 = 1.00000
+    4107 = 1.00000
+    4108 = 1.00000
+    4109 = 1.00000
+    4135 = 1.00000
+    4136 = 1.00000
+    4139 = 1.00000
+    4144 = 1.00000
+    4145 = 1.00000
+    4148 = 1.00000
+    4150 = 1.00000
+    4149 = 1.00000
+    4151 = 1.00000
+    4156 = 1.00000
+    4157 = 1.00000
+    4160 = 1.00000
+    4161 = 1.00000
+    4186 = 1.00000
+    4187 = 1.00000
+    4188 = 1.00000
+    4189 = 1.00000
+    4214 = 1.00000
+    4215 = 1.00000
+    4216 = 1.00000
+    4217 = 1.00000
+    4242 = 1.00000
+    4244 = 1.00000
+    4247 = 1.00000
+    4248 = 1.00000
+    4252 = 1.00000
+    4249 = 1.00000
+    4253 = 1.00000
+    4258 = 1.00000
+    4259 = 1.00000
+    4264 = 1.00000
+    4265 = 1.00000
+    4266 = 1.00000
+    4267 = 1.00000
+    4278 = 1.00000
+    4279 = 1.00000
+    4280 = 1.00000
+    4281 = 1.00000
+    4322 = 1.00000
+    4323 = 1.00000
+    4324 = 1.00000
+    4325 = 1.00000
+    4352 = 1.00000
+    4357 = 1.00000
+    4358 = 1.00000
+    4363 = 1.00000
+    4364 = 1.00000
+    4403 = 1.00000
+    4404 = 1.00000
+    4405 = 1.00000
+    4406 = 1.00000
+    4432 = 1.00000
+    4445 = 1.00000
+    4446 = 1.00000
+    4457 = 1.00000
+    4458 = 1.00000
+    4483 = 1.00000
+    4484 = 1.00000
+    4485 = 1.00000
+    4486 = 1.00000
+    4539 = 1.00000
+    4540 = 1.00000
+    4542 = 1.00000
+    4545 = 1.00000
+    4546 = 1.00000
+    4553 = 1.00000
+    4554 = 1.00000
+    4563 = 1.00000
+    4565 = 1.00000
+    4564 = 1.00000
+    4566 = 1.00000
+    4569 = 1.00000
+    4570 = 1.00000
+    4575 = 1.00000
+    4576 = 1.00000
+    4577 = 1.00000
+    4578 = 1.00000
+    4591 = 1.00000
+    4592 = 1.00000
+    4593 = 1.00000
+    4594 = 1.00000
+    4728 = 1.00000
+    4731 = 1.00000
+    4732 = 1.00000
+    4743 = 1.00000
+    4744 = 1.00000
+    4749 = 1.00000
+    4750 = 1.00000
+    4751 = 1.00000
+    4752 = 1.00000
+    4810 = 1.00000
+    4811 = 1.00000
+    4814 = 1.00000
+    4819 = 1.00000
+    4820 = 1.00000
+    4823 = 1.00000
+    4825 = 1.00000
+    4824 = 1.00000
+    4826 = 1.00000
+    4831 = 1.00000
+    4832 = 1.00000
+    4835 = 1.00000
+    4836 = 1.00000
+    4861 = 1.00000
+    4862 = 1.00000
+    4863 = 1.00000
+    4864 = 1.00000
+    4889 = 1.00000
+    4890 = 1.00000
+    4891 = 1.00000
+    4892 = 1.00000
+    4917 = 1.00000
+    4918 = 1.00000
+    4919 = 1.00000
+    4920 = 1.00000
+    4922 = 1.00000
+    4923 = 1.00000
+    4927 = 1.00000
+    4924 = 1.00000
+    4928 = 1.00000
+    4931 = 1.00000
+    4933 = 1.00000
+    4932 = 1.00000
+    4934 = 1.00000
+    4939 = 1.00000
+    4940 = 1.00000
+    4941 = 1.00000
+    4943 = 1.00000
+    4942 = 1.00000
+    4944 = 1.00000
+    4947 = 1.00000
+    4948 = 1.00000
+    4953 = 1.00000
+    4954 = 1.00000
+    4955 = 1.00000
+    4956 = 1.00000
+    4969 = 1.00000
+    4970 = 1.00000
+    4971 = 1.00000
+    4972 = 1.00000
+    4997 = 1.00000
+    4998 = 1.00000
+    4999 = 1.00000
+    5000 = 1.00000
+    5027 = 1.00000
+    5032 = 1.00000
+    5033 = 1.00000
+    5038 = 1.00000
+    5039 = 1.00000
+    5078 = 1.00000
+    5079 = 1.00000
+    5080 = 1.00000
+    5081 = 1.00000
+    5106 = 1.00000
+    5108 = 1.00000
+    5109 = 1.00000
+    5113 = 1.00000
+    5110 = 1.00000
+    5114 = 1.00000
+    5119 = 1.00000
+    5120 = 1.00000
+    5121 = 1.00000
+    5122 = 1.00000
+    5127 = 1.00000
+    5128 = 1.00000
+    5129 = 1.00000
+    5130 = 1.00000
+    5159 = 1.00000
+    5160 = 1.00000
+    5161 = 1.00000
+    5162 = 1.00000
+    5187 = 1.00000
+    5193 = 1.00000
+    5194 = 1.00000
+    5211 = 1.00000
+    5212 = 1.00000
+    5223 = 1.00000
+    5224 = 1.00000
+    5225 = 1.00000
+    5226 = 1.00000
+    5376 = 1.00000
+    5377 = 1.00000
+    5380 = 1.00000
+    5382 = 1.00000
+    5383 = 1.00000
+    5396 = 1.00000
+    5397 = 1.00000
+    5400 = 1.00000
+    5402 = 1.00000
+    5401 = 1.00000
+    5403 = 1.00000
+    5408 = 1.00000
+    5409 = 1.00000
+    5412 = 1.00000
+    5413 = 1.00000
+    5414 = 1.00000
+    5415 = 1.00000
+    5440 = 1.00000
+    5441 = 1.00000
+    5442 = 1.00000
+    5443 = 1.00000
+    5485 = 1.00000
+    5495 = 1.00000
+    5496 = 1.00000
+    5501 = 1.00000
+    5502 = 1.00000
+    5521 = 1.00000
+    5522 = 1.00000
+    5523 = 1.00000
+    5524 = 1.00000
+    5565 = 1.00000
+    5567 = 1.00000
+    5570 = 1.00000
+    5571 = 1.00000
+    5575 = 1.00000
+    5572 = 1.00000
+    5576 = 1.00000
+    5581 = 1.00000
+    5582 = 1.00000
+    5587 = 1.00000
+    5588 = 1.00000
+    5589 = 1.00000
+    5590 = 1.00000
+    5601 = 1.00000
+    5602 = 1.00000
+    5603 = 1.00000
+    5604 = 1.00000
+    5645 = 1.00000
+    5646 = 1.00000
+    5647 = 1.00000
+    5648 = 1.00000
+    5675 = 1.00000
+    5680 = 1.00000
+    5681 = 1.00000
+    5686 = 1.00000
+    5687 = 1.00000
+    5726 = 1.00000
+    5727 = 1.00000
+    5728 = 1.00000
+    5729 = 1.00000
+    5754 = 1.00000
+    5755 = 1.00000
+    5756 = 1.00000
+    5758 = 1.00000
+    5759 = 1.00000
+    5760 = 1.00000
+    5764 = 1.00000
+    5761 = 1.00000
+    5765 = 1.00000
+    5770 = 1.00000
+    5771 = 1.00000
+    5774 = 1.00000
+    5776 = 1.00000
+    5775 = 1.00000
+    5777 = 1.00000
+    5778 = 1.00000
+    5780 = 1.00000
+    5779 = 1.00000
+    5781 = 1.00000
+    5786 = 1.00000
+    5787 = 1.00000
+    5790 = 1.00000
+    5791 = 1.00000
+    5792 = 1.00000
+    5793 = 1.00000
+    5818 = 1.00000
+    5819 = 1.00000
+    5820 = 1.00000
+    5821 = 1.00000
+    5834 = 1.00000
+    5835 = 1.00000
+    5836 = 1.00000
+    5837 = 1.00000
+    5863 = 1.00000
+    5864 = 1.00000
+    5869 = 1.00000
+    5870 = 1.00000
+    5873 = 1.00000
+    5875 = 1.00000
+    5874 = 1.00000
+    5876 = 1.00000
+    5879 = 1.00000
+    5880 = 1.00000
+    5899 = 1.00000
+    5900 = 1.00000
+    5901 = 1.00000
+    5902 = 1.00000
+    5915 = 1.00000
+    5916 = 1.00000
+    5917 = 1.00000
+    5918 = 1.00000
+    6024 = 1.00000
+    6027 = 1.00000
+    6028 = 1.00000
+    6039 = 1.00000
+    6040 = 1.00000
+    6045 = 1.00000
+    6046 = 1.00000
+    6047 = 1.00000
+    6048 = 1.00000
+    6106 = 1.00000
+    6116 = 1.00000
+    6117 = 1.00000
+    6122 = 1.00000
+    6123 = 1.00000
+    6142 = 1.00000
+    6143 = 1.00000
+    6144 = 1.00000
+    6145 = 1.00000
+    6186 = 1.00000
+    6187 = 1.00000
+    6189 = 1.00000
+    6190 = 1.00000
+    6197 = 1.00000
+    6198 = 1.00000
+    6201 = 1.00000
+    6203 = 1.00000
+    6202 = 1.00000
+    6204 = 1.00000
+    6207 = 1.00000
+    6208 = 1.00000
+    6209 = 1.00000
+    6210 = 1.00000
+    6223 = 1.00000
+    6224 = 1.00000
+    6225 = 1.00000
+    6226 = 1.00000
+    6269 = 1.00000
+    6274 = 1.00000
+    6275 = 1.00000
+    6280 = 1.00000
+    6281 = 1.00000
+    6320 = 1.00000
+    6321 = 1.00000
+    6322 = 1.00000
+    6323 = 1.00000
+    6348 = 1.00000
+    6350 = 1.00000
+    6351 = 1.00000
+    6355 = 1.00000
+    6352 = 1.00000
+    6356 = 1.00000
+    6361 = 1.00000
+    6362 = 1.00000
+    6363 = 1.00000
+    6364 = 1.00000
+    6369 = 1.00000
+    6370 = 1.00000
+    6371 = 1.00000
+    6372 = 1.00000
+    6401 = 1.00000
+    6402 = 1.00000
+    6403 = 1.00000
+    6404 = 1.00000
+    6430 = 1.00000
+    6431 = 1.00000
+    6436 = 1.00000
+    6437 = 1.00000
+    6440 = 1.00000
+    6442 = 1.00000
+    6441 = 1.00000
+    6443 = 1.00000
+    6446 = 1.00000
+    6447 = 1.00000
+    6466 = 1.00000
+    6467 = 1.00000
+    6468 = 1.00000
+    6469 = 1.00000
+    6482 = 1.00000
+    6483 = 1.00000
+    6484 = 1.00000
+    6485 = 1.00000
+    6510 = 1.00000
+    6511 = 1.00000
+    6512 = 1.00000
+    6513 = 1.00000
+    6517 = 1.00000
+    6514 = 1.00000
+    6518 = 1.00000
+    6521 = 1.00000
+    6523 = 1.00000
+    6522 = 1.00000
+    6524 = 1.00000
+    6525 = 1.00000
+    6527 = 1.00000
+    6526 = 1.00000
+    6528 = 1.00000
+    6531 = 1.00000
+    6532 = 1.00000
+    6533 = 1.00000
+    6534 = 1.00000
+    6547 = 1.00000
+    6548 = 1.00000
+    6549 = 1.00000
+    6550 = 1.00000
+    6563 = 1.00000
+    6564 = 1.00000
+    6565 = 1.00000
+    6566 = 1.00000
diff --git a/tests/deal.II/tangential_flux_inhom_01.cc b/tests/deal.II/tangential_flux_inhom_01.cc
new file mode 100644 (file)
index 0000000..808cd5d
--- /dev/null
@@ -0,0 +1,129 @@
+// ---------------------------------------------------------------------
+// $Id: normal_flux_01.cc 31349 2013-10-20 19:07:06Z maier $
+//
+// Copyright (C) 2007 - 2013 by the deal.II authors
+//
+// This file is part of the deal.II library.
+//
+// The deal.II library is free software; you can use it, redistribute
+// it, and/or modify it under the terms of the GNU Lesser General
+// Public License as published by the Free Software Foundation; either
+// version 2.1 of the License, or (at your option) any later version.
+// The full text of the license can be found in the file LICENSE at
+// the top level of the deal.II distribution.
+//
+// ---------------------------------------------------------------------
+
+
+
+// check the creation of tangential flux boundary conditions for a finite
+// element that consists of only a single set of vector components
+// (i.e. it has dim components). Similar as the normal-flux test in 
+// normal_flux_inhom_01.cc
+
+#include "../tests.h"
+#include <deal.II/base/logstream.h>
+#include <deal.II/base/function.h>
+#include <deal.II/base/quadrature_lib.h>
+#include <deal.II/lac/vector.h>
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/dofs/dof_handler.h>
+#include <deal.II/lac/constraint_matrix.h>
+#include <deal.II/fe/fe_q.h>
+#include <deal.II/fe/fe_system.h>
+#include <deal.II/fe/mapping_q1.h>
+#include <deal.II/fe/fe_values.h>
+#include <deal.II/numerics/vector_tools.h>
+
+#include <fstream>
+
+
+template<int dim>
+void test (const Triangulation<dim> &tr,
+           const FiniteElement<dim> &fe)
+{
+  DoFHandler<dim> dof(tr);
+  dof.distribute_dofs(fe);
+
+  ConstantFunction<dim> constant_function(1.,dim);
+  typename FunctionMap<dim>::type function_map;
+  for (unsigned int j=0; j<GeometryInfo<dim>::faces_per_cell; ++j)
+    function_map[j] = &constant_function;
+
+  for (unsigned int i=0; i<GeometryInfo<dim>::faces_per_cell; ++i)
+    {
+      deallog << "FE=" << fe.get_name()
+              << ", case=" << i
+              << std::endl;
+
+      std::set<types::boundary_id> boundary_ids;
+      for (unsigned int j=0; j<=i; ++j)
+        boundary_ids.insert (j);
+
+      ConstraintMatrix cm;
+      VectorTools::compute_nonzero_tangential_flux_constraints
+        (dof, 0, boundary_ids, function_map, cm);
+
+      cm.print (deallog.get_file_stream ());
+    }
+    //Get the location of all boundary dofs
+    std::vector<types::global_dof_index> face_dofs;
+    const std::vector<Point<dim-1> > &
+      unit_support_points = fe.get_unit_face_support_points();
+    Quadrature<dim-1> quadrature(unit_support_points);
+    FEFaceValues<dim, dim> fe_face_values(fe, quadrature, update_q_points);
+    typename DoFHandler<dim>::active_cell_iterator
+    cell = dof.begin_active(),
+    endc = dof.end();
+    for (; cell!=endc; ++cell)
+      for (unsigned int face_no=0; face_no < GeometryInfo<dim>::faces_per_cell;
+           ++face_no)
+        if (cell->face(face_no)->at_boundary())
+        {
+          typename DoFHandler<dim>::face_iterator face = cell->face(face_no);
+          face_dofs.resize (fe.dofs_per_face);
+          face->get_dof_indices (face_dofs);
+         
+          fe_face_values.reinit(cell, face_no);
+          for (unsigned int i=0; i<face_dofs.size(); ++i)
+          {
+            std::cout << face_dofs[i] << "\t"
+                      << fe_face_values.quadrature_point(i) << "\t"
+                      << fe.face_system_to_component_index(i).first
+                      << std::endl;
+          }
+        }
+}
+
+
+template<int dim>
+void test_hyper_cube()
+{
+  Triangulation<dim> tr;
+  GridGenerator::hyper_cube(tr);
+
+  for (unsigned int i=0; i<GeometryInfo<dim>::faces_per_cell; ++i)
+    tr.begin_active()->face(i)->set_boundary_indicator (i);
+
+  tr.refine_global(2);
+
+  for (unsigned int degree=1; degree<4; ++degree)
+    {
+      FESystem<dim> fe (FE_Q<dim>(degree), dim);
+      test(tr, fe);
+    }
+}
+
+
+int main()
+{
+  std::ofstream logfile ("output");
+  deallog << std::setprecision (2);
+  deallog << std::fixed;
+  deallog.attach(logfile);
+  deallog.depth_console (0);
+  deallog.threshold_double(1.e-12);
+
+  test_hyper_cube<2>();
+  test_hyper_cube<3>();
+}
diff --git a/tests/deal.II/tangential_flux_inhom_01.output b/tests/deal.II/tangential_flux_inhom_01.output
new file mode 100644 (file)
index 0000000..368ee28
--- /dev/null
@@ -0,0 +1,11149 @@
+
+DEAL::FE=FESystem<2>[FE_Q<2>(1)^2], case=0
+    1 = 1.00000
+    5 = 1.00000
+    13 = 1.00000
+    31 = 1.00000
+    37 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(1)^2], case=1
+    1 = 1.00000
+    5 = 1.00000
+    13 = 1.00000
+    23 = 1.00000
+    25 = 1.00000
+    29 = 1.00000
+    31 = 1.00000
+    37 = 1.00000
+    45 = 1.00000
+    49 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(1)^2], case=2
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    5 = 1.00000
+    8 = 1.00000
+    13 = 1.00000
+    18 = 1.00000
+    22 = 1.00000
+    23 = 1.00000
+    25 = 1.00000
+    29 = 1.00000
+    31 = 1.00000
+    37 = 1.00000
+    45 = 1.00000
+    49 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(1)^2], case=3
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    5 = 1.00000
+    8 = 1.00000
+    13 = 1.00000
+    18 = 1.00000
+    22 = 1.00000
+    23 = 1.00000
+    25 = 1.00000
+    29 = 1.00000
+    31 = 1.00000
+    36 = 1.00000
+    37 = 1.00000
+    38 = 1.00000
+    40 = 1.00000
+    45 = 1.00000
+    46 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(2)^2], case=0
+    1 = 1.00000
+    5 = 1.00000
+    9 = 1.00000
+    31 = 1.00000
+    35 = 1.00000
+    91 = 1.00000
+    95 = 1.00000
+    111 = 1.00000
+    115 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(2)^2], case=1
+    1 = 1.00000
+    5 = 1.00000
+    9 = 1.00000
+    31 = 1.00000
+    35 = 1.00000
+    63 = 1.00000
+    65 = 1.00000
+    67 = 1.00000
+    83 = 1.00000
+    85 = 1.00000
+    91 = 1.00000
+    95 = 1.00000
+    111 = 1.00000
+    115 = 1.00000
+    139 = 1.00000
+    141 = 1.00000
+    155 = 1.00000
+    157 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(2)^2], case=2
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    5 = 1.00000
+    9 = 1.00000
+    12 = 1.00000
+    18 = 1.00000
+    24 = 1.00000
+    31 = 1.00000
+    35 = 1.00000
+    50 = 1.00000
+    56 = 1.00000
+    62 = 1.00000
+    63 = 1.00000
+    65 = 1.00000
+    67 = 1.00000
+    68 = 1.00000
+    83 = 1.00000
+    85 = 1.00000
+    91 = 1.00000
+    95 = 1.00000
+    111 = 1.00000
+    115 = 1.00000
+    139 = 1.00000
+    141 = 1.00000
+    155 = 1.00000
+    157 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(2)^2], case=3
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    5 = 1.00000
+    9 = 1.00000
+    12 = 1.00000
+    18 = 1.00000
+    24 = 1.00000
+    31 = 1.00000
+    35 = 1.00000
+    50 = 1.00000
+    56 = 1.00000
+    62 = 1.00000
+    63 = 1.00000
+    65 = 1.00000
+    67 = 1.00000
+    68 = 1.00000
+    83 = 1.00000
+    85 = 1.00000
+    91 = 1.00000
+    95 = 1.00000
+    110 = 1.00000
+    111 = 1.00000
+    112 = 1.00000
+    115 = 1.00000
+    118 = 1.00000
+    122 = 1.00000
+    126 = 1.00000
+    139 = 1.00000
+    141 = 1.00000
+    146 = 1.00000
+    150 = 1.00000
+    154 = 1.00000
+    155 = 1.00000
+    157 = 1.00000
+    158 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(3)^2], case=0
+    1 = 1.00000
+    5 = 1.00000
+    10 = 1.00000
+    11 = 1.00000
+    57 = 1.00000
+    62 = 1.00000
+    63 = 1.00000
+    183 = 1.00000
+    188 = 1.00000
+    189 = 1.00000
+    225 = 1.00000
+    230 = 1.00000
+    231 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(3)^2], case=1
+    1 = 1.00000
+    5 = 1.00000
+    10 = 1.00000
+    11 = 1.00000
+    57 = 1.00000
+    62 = 1.00000
+    63 = 1.00000
+    123 = 1.00000
+    125 = 1.00000
+    128 = 1.00000
+    129 = 1.00000
+    165 = 1.00000
+    168 = 1.00000
+    169 = 1.00000
+    183 = 1.00000
+    188 = 1.00000
+    189 = 1.00000
+    225 = 1.00000
+    230 = 1.00000
+    231 = 1.00000
+    285 = 1.00000
+    288 = 1.00000
+    289 = 1.00000
+    321 = 1.00000
+    324 = 1.00000
+    325 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(3)^2], case=2
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    5 = 1.00000
+    10 = 1.00000
+    11 = 1.00000
+    16 = 1.00000
+    17 = 1.00000
+    32 = 1.00000
+    40 = 1.00000
+    41 = 1.00000
+    57 = 1.00000
+    62 = 1.00000
+    63 = 1.00000
+    98 = 1.00000
+    106 = 1.00000
+    107 = 1.00000
+    122 = 1.00000
+    123 = 1.00000
+    125 = 1.00000
+    128 = 1.00000
+    129 = 1.00000
+    130 = 1.00000
+    131 = 1.00000
+    165 = 1.00000
+    168 = 1.00000
+    169 = 1.00000
+    183 = 1.00000
+    188 = 1.00000
+    189 = 1.00000
+    225 = 1.00000
+    230 = 1.00000
+    231 = 1.00000
+    285 = 1.00000
+    288 = 1.00000
+    289 = 1.00000
+    321 = 1.00000
+    324 = 1.00000
+    325 = 1.00000
+DEAL::FE=FESystem<2>[FE_Q<2>(3)^2], case=3
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    5 = 1.00000
+    10 = 1.00000
+    11 = 1.00000
+    16 = 1.00000
+    17 = 1.00000
+    32 = 1.00000
+    40 = 1.00000
+    41 = 1.00000
+    57 = 1.00000
+    62 = 1.00000
+    63 = 1.00000
+    98 = 1.00000
+    106 = 1.00000
+    107 = 1.00000
+    122 = 1.00000
+    123 = 1.00000
+    125 = 1.00000
+    128 = 1.00000
+    129 = 1.00000
+    130 = 1.00000
+    131 = 1.00000
+    165 = 1.00000
+    168 = 1.00000
+    169 = 1.00000
+    183 = 1.00000
+    188 = 1.00000
+    189 = 1.00000
+    224 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    230 = 1.00000
+    231 = 1.00000
+    236 = 1.00000
+    237 = 1.00000
+    248 = 1.00000
+    254 = 1.00000
+    255 = 1.00000
+    285 = 1.00000
+    288 = 1.00000
+    289 = 1.00000
+    302 = 1.00000
+    308 = 1.00000
+    309 = 1.00000
+    320 = 1.00000
+    321 = 1.00000
+    324 = 1.00000
+    325 = 1.00000
+    326 = 1.00000
+    327 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(1)^3], case=0
+    1 = 1.00000
+    2 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    37 = 1.00000
+    38 = 1.00000
+    43 = 1.00000
+    44 = 1.00000
+    55 = 1.00000
+    56 = 1.00000
+    61 = 1.00000
+    62 = 1.00000
+    73 = 1.00000
+    74 = 1.00000
+    136 = 1.00000
+    137 = 1.00000
+    142 = 1.00000
+    143 = 1.00000
+    154 = 1.00000
+    155 = 1.00000
+    160 = 1.00000
+    161 = 1.00000
+    172 = 1.00000
+    173 = 1.00000
+    181 = 1.00000
+    182 = 1.00000
+    226 = 1.00000
+    227 = 1.00000
+    232 = 1.00000
+    233 = 1.00000
+    244 = 1.00000
+    245 = 1.00000
+    253 = 1.00000
+    254 = 1.00000
+    259 = 1.00000
+    260 = 1.00000
+    271 = 1.00000
+    272 = 1.00000
+    316 = 1.00000
+    317 = 1.00000
+    325 = 1.00000
+    326 = 1.00000
+    334 = 1.00000
+    335 = 1.00000
+    343 = 1.00000
+    344 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(1)^3], case=1
+    1 = 1.00000
+    2 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    37 = 1.00000
+    38 = 1.00000
+    43 = 1.00000
+    44 = 1.00000
+    55 = 1.00000
+    56 = 1.00000
+    61 = 1.00000
+    62 = 1.00000
+    73 = 1.00000
+    74 = 1.00000
+    94 = 1.00000
+    95 = 1.00000
+    97 = 1.00000
+    98 = 1.00000
+    100 = 1.00000
+    101 = 1.00000
+    103 = 1.00000
+    104 = 1.00000
+    112 = 1.00000
+    113 = 1.00000
+    115 = 1.00000
+    116 = 1.00000
+    124 = 1.00000
+    125 = 1.00000
+    127 = 1.00000
+    128 = 1.00000
+    133 = 1.00000
+    134 = 1.00000
+    136 = 1.00000
+    137 = 1.00000
+    142 = 1.00000
+    143 = 1.00000
+    154 = 1.00000
+    155 = 1.00000
+    160 = 1.00000
+    161 = 1.00000
+    172 = 1.00000
+    173 = 1.00000
+    181 = 1.00000
+    182 = 1.00000
+    196 = 1.00000
+    197 = 1.00000
+    199 = 1.00000
+    200 = 1.00000
+    208 = 1.00000
+    209 = 1.00000
+    211 = 1.00000
+    212 = 1.00000
+    217 = 1.00000
+    218 = 1.00000
+    223 = 1.00000
+    224 = 1.00000
+    226 = 1.00000
+    227 = 1.00000
+    232 = 1.00000
+    233 = 1.00000
+    244 = 1.00000
+    245 = 1.00000
+    253 = 1.00000
+    254 = 1.00000
+    259 = 1.00000
+    260 = 1.00000
+    271 = 1.00000
+    272 = 1.00000
+    286 = 1.00000
+    287 = 1.00000
+    289 = 1.00000
+    290 = 1.00000
+    295 = 1.00000
+    296 = 1.00000
+    304 = 1.00000
+    305 = 1.00000
+    307 = 1.00000
+    308 = 1.00000
+    313 = 1.00000
+    314 = 1.00000
+    316 = 1.00000
+    317 = 1.00000
+    325 = 1.00000
+    326 = 1.00000
+    334 = 1.00000
+    335 = 1.00000
+    343 = 1.00000
+    344 = 1.00000
+    355 = 1.00000
+    356 = 1.00000
+    361 = 1.00000
+    362 = 1.00000
+    367 = 1.00000
+    368 = 1.00000
+    373 = 1.00000
+    374 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(1)^3], case=2
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    3 = 1.00000
+    5 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    15 = 1.00000
+    17 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    24 = 1.00000
+    26 = 1.00000
+    30 = 1.00000
+    32 = 1.00000
+    37 = 1.00000
+    38 = 1.00000
+    43 = 1.00000
+    44 = 1.00000
+    54 = 1.00000
+    55 = 1.00000
+    56 = 1.00000
+    57 = 1.00000
+    59 = 1.00000
+    61 = 1.00000
+    62 = 1.00000
+    66 = 1.00000
+    68 = 1.00000
+    73 = 1.00000
+    74 = 1.00000
+    81 = 1.00000
+    83 = 1.00000
+    87 = 1.00000
+    89 = 1.00000
+    93 = 1.00000
+    94 = 1.00000
+    95 = 1.00000
+    97 = 1.00000
+    98 = 1.00000
+    99 = 1.00000
+    100 = 1.00000
+    101 = 1.00000
+    103 = 1.00000
+    104 = 1.00000
+    112 = 1.00000
+    113 = 1.00000
+    115 = 1.00000
+    116 = 1.00000
+    117 = 1.00000
+    119 = 1.00000
+    123 = 1.00000
+    124 = 1.00000
+    125 = 1.00000
+    127 = 1.00000
+    128 = 1.00000
+    133 = 1.00000
+    134 = 1.00000
+    136 = 1.00000
+    137 = 1.00000
+    142 = 1.00000
+    143 = 1.00000
+    154 = 1.00000
+    155 = 1.00000
+    160 = 1.00000
+    161 = 1.00000
+    172 = 1.00000
+    173 = 1.00000
+    181 = 1.00000
+    182 = 1.00000
+    196 = 1.00000
+    197 = 1.00000
+    199 = 1.00000
+    200 = 1.00000
+    208 = 1.00000
+    209 = 1.00000
+    211 = 1.00000
+    212 = 1.00000
+    217 = 1.00000
+    218 = 1.00000
+    223 = 1.00000
+    224 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    227 = 1.00000
+    228 = 1.00000
+    230 = 1.00000
+    232 = 1.00000
+    233 = 1.00000
+    237 = 1.00000
+    239 = 1.00000
+    244 = 1.00000
+    245 = 1.00000
+    252 = 1.00000
+    253 = 1.00000
+    254 = 1.00000
+    255 = 1.00000
+    257 = 1.00000
+    259 = 1.00000
+    260 = 1.00000
+    264 = 1.00000
+    266 = 1.00000
+    271 = 1.00000
+    272 = 1.00000
+    279 = 1.00000
+    281 = 1.00000
+    285 = 1.00000
+    286 = 1.00000
+    287 = 1.00000
+    289 = 1.00000
+    290 = 1.00000
+    295 = 1.00000
+    296 = 1.00000
+    297 = 1.00000
+    299 = 1.00000
+    303 = 1.00000
+    304 = 1.00000
+    305 = 1.00000
+    307 = 1.00000
+    308 = 1.00000
+    313 = 1.00000
+    314 = 1.00000
+    316 = 1.00000
+    317 = 1.00000
+    325 = 1.00000
+    326 = 1.00000
+    334 = 1.00000
+    335 = 1.00000
+    343 = 1.00000
+    344 = 1.00000
+    355 = 1.00000
+    356 = 1.00000
+    361 = 1.00000
+    362 = 1.00000
+    367 = 1.00000
+    368 = 1.00000
+    373 = 1.00000
+    374 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(1)^3], case=3
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    3 = 1.00000
+    5 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    15 = 1.00000
+    17 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    24 = 1.00000
+    26 = 1.00000
+    30 = 1.00000
+    32 = 1.00000
+    37 = 1.00000
+    38 = 1.00000
+    43 = 1.00000
+    44 = 1.00000
+    54 = 1.00000
+    55 = 1.00000
+    56 = 1.00000
+    57 = 1.00000
+    59 = 1.00000
+    61 = 1.00000
+    62 = 1.00000
+    66 = 1.00000
+    68 = 1.00000
+    73 = 1.00000
+    74 = 1.00000
+    81 = 1.00000
+    83 = 1.00000
+    87 = 1.00000
+    89 = 1.00000
+    93 = 1.00000
+    94 = 1.00000
+    95 = 1.00000
+    97 = 1.00000
+    98 = 1.00000
+    99 = 1.00000
+    100 = 1.00000
+    101 = 1.00000
+    103 = 1.00000
+    104 = 1.00000
+    112 = 1.00000
+    113 = 1.00000
+    115 = 1.00000
+    116 = 1.00000
+    117 = 1.00000
+    119 = 1.00000
+    123 = 1.00000
+    124 = 1.00000
+    125 = 1.00000
+    127 = 1.00000
+    128 = 1.00000
+    133 = 1.00000
+    134 = 1.00000
+    136 = 1.00000
+    137 = 1.00000
+    142 = 1.00000
+    143 = 1.00000
+    153 = 1.00000
+    154 = 1.00000
+    155 = 1.00000
+    156 = 1.00000
+    158 = 1.00000
+    159 = 1.00000
+    160 = 1.00000
+    161 = 1.00000
+    162 = 1.00000
+    164 = 1.00000
+    165 = 1.00000
+    167 = 1.00000
+    168 = 1.00000
+    170 = 1.00000
+    172 = 1.00000
+    173 = 1.00000
+    180 = 1.00000
+    181 = 1.00000
+    182 = 1.00000
+    183 = 1.00000
+    185 = 1.00000
+    186 = 1.00000
+    188 = 1.00000
+    196 = 1.00000
+    197 = 1.00000
+    199 = 1.00000
+    200 = 1.00000
+    201 = 1.00000
+    203 = 1.00000
+    204 = 1.00000
+    206 = 1.00000
+    207 = 1.00000
+    208 = 1.00000
+    209 = 1.00000
+    210 = 1.00000
+    211 = 1.00000
+    212 = 1.00000
+    217 = 1.00000
+    218 = 1.00000
+    219 = 1.00000
+    221 = 1.00000
+    222 = 1.00000
+    223 = 1.00000
+    224 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    227 = 1.00000
+    228 = 1.00000
+    230 = 1.00000
+    232 = 1.00000
+    233 = 1.00000
+    237 = 1.00000
+    239 = 1.00000
+    244 = 1.00000
+    245 = 1.00000
+    252 = 1.00000
+    253 = 1.00000
+    254 = 1.00000
+    255 = 1.00000
+    257 = 1.00000
+    259 = 1.00000
+    260 = 1.00000
+    264 = 1.00000
+    266 = 1.00000
+    271 = 1.00000
+    272 = 1.00000
+    279 = 1.00000
+    281 = 1.00000
+    285 = 1.00000
+    286 = 1.00000
+    287 = 1.00000
+    289 = 1.00000
+    290 = 1.00000
+    295 = 1.00000
+    296 = 1.00000
+    297 = 1.00000
+    299 = 1.00000
+    303 = 1.00000
+    304 = 1.00000
+    305 = 1.00000
+    307 = 1.00000
+    308 = 1.00000
+    313 = 1.00000
+    314 = 1.00000
+    316 = 1.00000
+    317 = 1.00000
+    324 = 1.00000
+    325 = 1.00000
+    326 = 1.00000
+    327 = 1.00000
+    329 = 1.00000
+    330 = 1.00000
+    332 = 1.00000
+    334 = 1.00000
+    335 = 1.00000
+    342 = 1.00000
+    343 = 1.00000
+    344 = 1.00000
+    345 = 1.00000
+    347 = 1.00000
+    348 = 1.00000
+    350 = 1.00000
+    355 = 1.00000
+    356 = 1.00000
+    357 = 1.00000
+    359 = 1.00000
+    360 = 1.00000
+    361 = 1.00000
+    362 = 1.00000
+    367 = 1.00000
+    368 = 1.00000
+    369 = 1.00000
+    371 = 1.00000
+    372 = 1.00000
+    373 = 1.00000
+    374 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(1)^3], case=4
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    3 = 1.00000
+    4 = 1.00000
+    5 = 1.00000
+    6 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    9 = 1.00000
+    10 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    15 = 1.00000
+    17 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    24 = 1.00000
+    25 = 1.00000
+    26 = 1.00000
+    27 = 1.00000
+    28 = 1.00000
+    30 = 1.00000
+    32 = 1.00000
+    36 = 1.00000
+    37 = 1.00000
+    38 = 1.00000
+    39 = 1.00000
+    40 = 1.00000
+    43 = 1.00000
+    44 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    54 = 1.00000
+    55 = 1.00000
+    56 = 1.00000
+    57 = 1.00000
+    59 = 1.00000
+    61 = 1.00000
+    62 = 1.00000
+    66 = 1.00000
+    68 = 1.00000
+    73 = 1.00000
+    74 = 1.00000
+    81 = 1.00000
+    82 = 1.00000
+    83 = 1.00000
+    84 = 1.00000
+    85 = 1.00000
+    87 = 1.00000
+    89 = 1.00000
+    93 = 1.00000
+    94 = 1.00000
+    95 = 1.00000
+    96 = 1.00000
+    97 = 1.00000
+    98 = 1.00000
+    99 = 1.00000
+    100 = 1.00000
+    101 = 1.00000
+    103 = 1.00000
+    104 = 1.00000
+    105 = 1.00000
+    106 = 1.00000
+    111 = 1.00000
+    112 = 1.00000
+    113 = 1.00000
+    115 = 1.00000
+    116 = 1.00000
+    117 = 1.00000
+    119 = 1.00000
+    123 = 1.00000
+    124 = 1.00000
+    125 = 1.00000
+    127 = 1.00000
+    128 = 1.00000
+    133 = 1.00000
+    134 = 1.00000
+    135 = 1.00000
+    136 = 1.00000
+    137 = 1.00000
+    138 = 1.00000
+    139 = 1.00000
+    142 = 1.00000
+    143 = 1.00000
+    147 = 1.00000
+    148 = 1.00000
+    153 = 1.00000
+    154 = 1.00000
+    155 = 1.00000
+    156 = 1.00000
+    157 = 1.00000
+    158 = 1.00000
+    159 = 1.00000
+    160 = 1.00000
+    161 = 1.00000
+    162 = 1.00000
+    164 = 1.00000
+    165 = 1.00000
+    166 = 1.00000
+    167 = 1.00000
+    168 = 1.00000
+    170 = 1.00000
+    172 = 1.00000
+    173 = 1.00000
+    180 = 1.00000
+    181 = 1.00000
+    182 = 1.00000
+    183 = 1.00000
+    185 = 1.00000
+    186 = 1.00000
+    188 = 1.00000
+    189 = 1.00000
+    190 = 1.00000
+    195 = 1.00000
+    196 = 1.00000
+    197 = 1.00000
+    199 = 1.00000
+    200 = 1.00000
+    201 = 1.00000
+    202 = 1.00000
+    203 = 1.00000
+    204 = 1.00000
+    206 = 1.00000
+    207 = 1.00000
+    208 = 1.00000
+    209 = 1.00000
+    210 = 1.00000
+    211 = 1.00000
+    212 = 1.00000
+    217 = 1.00000
+    218 = 1.00000
+    219 = 1.00000
+    221 = 1.00000
+    222 = 1.00000
+    223 = 1.00000
+    224 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    227 = 1.00000
+    228 = 1.00000
+    230 = 1.00000
+    232 = 1.00000
+    233 = 1.00000
+    237 = 1.00000
+    239 = 1.00000
+    244 = 1.00000
+    245 = 1.00000
+    252 = 1.00000
+    253 = 1.00000
+    254 = 1.00000
+    255 = 1.00000
+    257 = 1.00000
+    259 = 1.00000
+    260 = 1.00000
+    264 = 1.00000
+    266 = 1.00000
+    271 = 1.00000
+    272 = 1.00000
+    279 = 1.00000
+    281 = 1.00000
+    285 = 1.00000
+    286 = 1.00000
+    287 = 1.00000
+    289 = 1.00000
+    290 = 1.00000
+    295 = 1.00000
+    296 = 1.00000
+    297 = 1.00000
+    299 = 1.00000
+    303 = 1.00000
+    304 = 1.00000
+    305 = 1.00000
+    307 = 1.00000
+    308 = 1.00000
+    313 = 1.00000
+    314 = 1.00000
+    316 = 1.00000
+    317 = 1.00000
+    324 = 1.00000
+    325 = 1.00000
+    326 = 1.00000
+    327 = 1.00000
+    329 = 1.00000
+    330 = 1.00000
+    332 = 1.00000
+    334 = 1.00000
+    335 = 1.00000
+    342 = 1.00000
+    343 = 1.00000
+    344 = 1.00000
+    345 = 1.00000
+    347 = 1.00000
+    348 = 1.00000
+    350 = 1.00000
+    355 = 1.00000
+    356 = 1.00000
+    357 = 1.00000
+    359 = 1.00000
+    360 = 1.00000
+    361 = 1.00000
+    362 = 1.00000
+    367 = 1.00000
+    368 = 1.00000
+    369 = 1.00000
+    371 = 1.00000
+    372 = 1.00000
+    373 = 1.00000
+    374 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(1)^3], case=5
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    3 = 1.00000
+    4 = 1.00000
+    5 = 1.00000
+    6 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    9 = 1.00000
+    10 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    15 = 1.00000
+    17 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    24 = 1.00000
+    25 = 1.00000
+    26 = 1.00000
+    27 = 1.00000
+    28 = 1.00000
+    30 = 1.00000
+    32 = 1.00000
+    36 = 1.00000
+    37 = 1.00000
+    38 = 1.00000
+    39 = 1.00000
+    40 = 1.00000
+    43 = 1.00000
+    44 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    54 = 1.00000
+    55 = 1.00000
+    56 = 1.00000
+    57 = 1.00000
+    59 = 1.00000
+    61 = 1.00000
+    62 = 1.00000
+    66 = 1.00000
+    68 = 1.00000
+    73 = 1.00000
+    74 = 1.00000
+    81 = 1.00000
+    82 = 1.00000
+    83 = 1.00000
+    84 = 1.00000
+    85 = 1.00000
+    87 = 1.00000
+    89 = 1.00000
+    93 = 1.00000
+    94 = 1.00000
+    95 = 1.00000
+    96 = 1.00000
+    97 = 1.00000
+    98 = 1.00000
+    99 = 1.00000
+    100 = 1.00000
+    101 = 1.00000
+    103 = 1.00000
+    104 = 1.00000
+    105 = 1.00000
+    106 = 1.00000
+    111 = 1.00000
+    112 = 1.00000
+    113 = 1.00000
+    115 = 1.00000
+    116 = 1.00000
+    117 = 1.00000
+    119 = 1.00000
+    123 = 1.00000
+    124 = 1.00000
+    125 = 1.00000
+    127 = 1.00000
+    128 = 1.00000
+    133 = 1.00000
+    134 = 1.00000
+    135 = 1.00000
+    136 = 1.00000
+    137 = 1.00000
+    138 = 1.00000
+    139 = 1.00000
+    142 = 1.00000
+    143 = 1.00000
+    147 = 1.00000
+    148 = 1.00000
+    153 = 1.00000
+    154 = 1.00000
+    155 = 1.00000
+    156 = 1.00000
+    157 = 1.00000
+    158 = 1.00000
+    159 = 1.00000
+    160 = 1.00000
+    161 = 1.00000
+    162 = 1.00000
+    164 = 1.00000
+    165 = 1.00000
+    166 = 1.00000
+    167 = 1.00000
+    168 = 1.00000
+    170 = 1.00000
+    172 = 1.00000
+    173 = 1.00000
+    180 = 1.00000
+    181 = 1.00000
+    182 = 1.00000
+    183 = 1.00000
+    185 = 1.00000
+    186 = 1.00000
+    188 = 1.00000
+    189 = 1.00000
+    190 = 1.00000
+    195 = 1.00000
+    196 = 1.00000
+    197 = 1.00000
+    199 = 1.00000
+    200 = 1.00000
+    201 = 1.00000
+    202 = 1.00000
+    203 = 1.00000
+    204 = 1.00000
+    206 = 1.00000
+    207 = 1.00000
+    208 = 1.00000
+    209 = 1.00000
+    210 = 1.00000
+    211 = 1.00000
+    212 = 1.00000
+    217 = 1.00000
+    218 = 1.00000
+    219 = 1.00000
+    221 = 1.00000
+    222 = 1.00000
+    223 = 1.00000
+    224 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    227 = 1.00000
+    228 = 1.00000
+    230 = 1.00000
+    232 = 1.00000
+    233 = 1.00000
+    237 = 1.00000
+    239 = 1.00000
+    244 = 1.00000
+    245 = 1.00000
+    252 = 1.00000
+    253 = 1.00000
+    254 = 1.00000
+    255 = 1.00000
+    256 = 1.00000
+    257 = 1.00000
+    258 = 1.00000
+    259 = 1.00000
+    260 = 1.00000
+    261 = 1.00000
+    262 = 1.00000
+    264 = 1.00000
+    265 = 1.00000
+    266 = 1.00000
+    267 = 1.00000
+    268 = 1.00000
+    270 = 1.00000
+    271 = 1.00000
+    272 = 1.00000
+    273 = 1.00000
+    274 = 1.00000
+    276 = 1.00000
+    277 = 1.00000
+    279 = 1.00000
+    281 = 1.00000
+    285 = 1.00000
+    286 = 1.00000
+    287 = 1.00000
+    289 = 1.00000
+    290 = 1.00000
+    295 = 1.00000
+    296 = 1.00000
+    297 = 1.00000
+    298 = 1.00000
+    299 = 1.00000
+    300 = 1.00000
+    301 = 1.00000
+    303 = 1.00000
+    304 = 1.00000
+    305 = 1.00000
+    306 = 1.00000
+    307 = 1.00000
+    308 = 1.00000
+    309 = 1.00000
+    310 = 1.00000
+    312 = 1.00000
+    313 = 1.00000
+    314 = 1.00000
+    316 = 1.00000
+    317 = 1.00000
+    324 = 1.00000
+    325 = 1.00000
+    326 = 1.00000
+    327 = 1.00000
+    329 = 1.00000
+    330 = 1.00000
+    332 = 1.00000
+    333 = 1.00000
+    334 = 1.00000
+    335 = 1.00000
+    336 = 1.00000
+    337 = 1.00000
+    339 = 1.00000
+    340 = 1.00000
+    342 = 1.00000
+    343 = 1.00000
+    344 = 1.00000
+    345 = 1.00000
+    346 = 1.00000
+    347 = 1.00000
+    348 = 1.00000
+    349 = 1.00000
+    350 = 1.00000
+    355 = 1.00000
+    356 = 1.00000
+    357 = 1.00000
+    359 = 1.00000
+    360 = 1.00000
+    361 = 1.00000
+    362 = 1.00000
+    363 = 1.00000
+    364 = 1.00000
+    366 = 1.00000
+    367 = 1.00000
+    368 = 1.00000
+    369 = 1.00000
+    370 = 1.00000
+    371 = 1.00000
+    372 = 1.00000
+    373 = 1.00000
+    374 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(2)^3], case=0
+    1 = 1.00000
+    2 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    25 = 1.00000
+    26 = 1.00000
+    37 = 1.00000
+    38 = 1.00000
+    49 = 1.00000
+    50 = 1.00000
+    55 = 1.00000
+    56 = 1.00000
+    61 = 1.00000
+    62 = 1.00000
+    136 = 1.00000
+    137 = 1.00000
+    142 = 1.00000
+    143 = 1.00000
+    148 = 1.00000
+    149 = 1.00000
+    157 = 1.00000
+    158 = 1.00000
+    166 = 1.00000
+    167 = 1.00000
+    172 = 1.00000
+    173 = 1.00000
+    226 = 1.00000
+    227 = 1.00000
+    232 = 1.00000
+    233 = 1.00000
+    238 = 1.00000
+    239 = 1.00000
+    250 = 1.00000
+    251 = 1.00000
+    256 = 1.00000
+    257 = 1.00000
+    262 = 1.00000
+    263 = 1.00000
+    316 = 1.00000
+    317 = 1.00000
+    322 = 1.00000
+    323 = 1.00000
+    331 = 1.00000
+    332 = 1.00000
+    337 = 1.00000
+    338 = 1.00000
+    676 = 1.00000
+    677 = 1.00000
+    682 = 1.00000
+    683 = 1.00000
+    688 = 1.00000
+    689 = 1.00000
+    697 = 1.00000
+    698 = 1.00000
+    706 = 1.00000
+    707 = 1.00000
+    712 = 1.00000
+    713 = 1.00000
+    766 = 1.00000
+    767 = 1.00000
+    772 = 1.00000
+    773 = 1.00000
+    778 = 1.00000
+    779 = 1.00000
+    787 = 1.00000
+    788 = 1.00000
+    796 = 1.00000
+    797 = 1.00000
+    802 = 1.00000
+    803 = 1.00000
+    856 = 1.00000
+    857 = 1.00000
+    862 = 1.00000
+    863 = 1.00000
+    871 = 1.00000
+    872 = 1.00000
+    877 = 1.00000
+    878 = 1.00000
+    916 = 1.00000
+    917 = 1.00000
+    922 = 1.00000
+    923 = 1.00000
+    931 = 1.00000
+    932 = 1.00000
+    937 = 1.00000
+    938 = 1.00000
+    1216 = 1.00000
+    1217 = 1.00000
+    1222 = 1.00000
+    1223 = 1.00000
+    1228 = 1.00000
+    1229 = 1.00000
+    1240 = 1.00000
+    1241 = 1.00000
+    1246 = 1.00000
+    1247 = 1.00000
+    1252 = 1.00000
+    1253 = 1.00000
+    1306 = 1.00000
+    1307 = 1.00000
+    1312 = 1.00000
+    1313 = 1.00000
+    1321 = 1.00000
+    1322 = 1.00000
+    1327 = 1.00000
+    1328 = 1.00000
+    1366 = 1.00000
+    1367 = 1.00000
+    1372 = 1.00000
+    1373 = 1.00000
+    1378 = 1.00000
+    1379 = 1.00000
+    1390 = 1.00000
+    1391 = 1.00000
+    1396 = 1.00000
+    1397 = 1.00000
+    1402 = 1.00000
+    1403 = 1.00000
+    1456 = 1.00000
+    1457 = 1.00000
+    1462 = 1.00000
+    1463 = 1.00000
+    1471 = 1.00000
+    1472 = 1.00000
+    1477 = 1.00000
+    1478 = 1.00000
+    1756 = 1.00000
+    1757 = 1.00000
+    1762 = 1.00000
+    1763 = 1.00000
+    1771 = 1.00000
+    1772 = 1.00000
+    1777 = 1.00000
+    1778 = 1.00000
+    1816 = 1.00000
+    1817 = 1.00000
+    1822 = 1.00000
+    1823 = 1.00000
+    1831 = 1.00000
+    1832 = 1.00000
+    1837 = 1.00000
+    1838 = 1.00000
+    1876 = 1.00000
+    1877 = 1.00000
+    1882 = 1.00000
+    1883 = 1.00000
+    1891 = 1.00000
+    1892 = 1.00000
+    1897 = 1.00000
+    1898 = 1.00000
+    1936 = 1.00000
+    1937 = 1.00000
+    1942 = 1.00000
+    1943 = 1.00000
+    1951 = 1.00000
+    1952 = 1.00000
+    1957 = 1.00000
+    1958 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(2)^3], case=1
+    1 = 1.00000
+    2 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    25 = 1.00000
+    26 = 1.00000
+    37 = 1.00000
+    38 = 1.00000
+    49 = 1.00000
+    50 = 1.00000
+    55 = 1.00000
+    56 = 1.00000
+    61 = 1.00000
+    62 = 1.00000
+    136 = 1.00000
+    137 = 1.00000
+    142 = 1.00000
+    143 = 1.00000
+    148 = 1.00000
+    149 = 1.00000
+    157 = 1.00000
+    158 = 1.00000
+    166 = 1.00000
+    167 = 1.00000
+    172 = 1.00000
+    173 = 1.00000
+    226 = 1.00000
+    227 = 1.00000
+    232 = 1.00000
+    233 = 1.00000
+    238 = 1.00000
+    239 = 1.00000
+    250 = 1.00000
+    251 = 1.00000
+    256 = 1.00000
+    257 = 1.00000
+    262 = 1.00000
+    263 = 1.00000
+    316 = 1.00000
+    317 = 1.00000
+    322 = 1.00000
+    323 = 1.00000
+    331 = 1.00000
+    332 = 1.00000
+    337 = 1.00000
+    338 = 1.00000
+    430 = 1.00000
+    431 = 1.00000
+    433 = 1.00000
+    434 = 1.00000
+    436 = 1.00000
+    437 = 1.00000
+    439 = 1.00000
+    440 = 1.00000
+    442 = 1.00000
+    443 = 1.00000
+    451 = 1.00000
+    452 = 1.00000
+    460 = 1.00000
+    461 = 1.00000
+    463 = 1.00000
+    464 = 1.00000
+    466 = 1.00000
+    467 = 1.00000
+    520 = 1.00000
+    521 = 1.00000
+    523 = 1.00000
+    524 = 1.00000
+    526 = 1.00000
+    527 = 1.00000
+    532 = 1.00000
+    533 = 1.00000
+    538 = 1.00000
+    539 = 1.00000
+    541 = 1.00000
+    542 = 1.00000
+    592 = 1.00000
+    593 = 1.00000
+    595 = 1.00000
+    596 = 1.00000
+    598 = 1.00000
+    599 = 1.00000
+    607 = 1.00000
+    608 = 1.00000
+    610 = 1.00000
+    611 = 1.00000
+    613 = 1.00000
+    614 = 1.00000
+    652 = 1.00000
+    653 = 1.00000
+    655 = 1.00000
+    656 = 1.00000
+    661 = 1.00000
+    662 = 1.00000
+    664 = 1.00000
+    665 = 1.00000
+    676 = 1.00000
+    677 = 1.00000
+    682 = 1.00000
+    683 = 1.00000
+    688 = 1.00000
+    689 = 1.00000
+    697 = 1.00000
+    698 = 1.00000
+    706 = 1.00000
+    707 = 1.00000
+    712 = 1.00000
+    713 = 1.00000
+    766 = 1.00000
+    767 = 1.00000
+    772 = 1.00000
+    773 = 1.00000
+    778 = 1.00000
+    779 = 1.00000
+    787 = 1.00000
+    788 = 1.00000
+    796 = 1.00000
+    797 = 1.00000
+    802 = 1.00000
+    803 = 1.00000
+    856 = 1.00000
+    857 = 1.00000
+    862 = 1.00000
+    863 = 1.00000
+    871 = 1.00000
+    872 = 1.00000
+    877 = 1.00000
+    878 = 1.00000
+    916 = 1.00000
+    917 = 1.00000
+    922 = 1.00000
+    923 = 1.00000
+    931 = 1.00000
+    932 = 1.00000
+    937 = 1.00000
+    938 = 1.00000
+    1012 = 1.00000
+    1013 = 1.00000
+    1015 = 1.00000
+    1016 = 1.00000
+    1018 = 1.00000
+    1019 = 1.00000
+    1024 = 1.00000
+    1025 = 1.00000
+    1030 = 1.00000
+    1031 = 1.00000
+    1033 = 1.00000
+    1034 = 1.00000
+    1084 = 1.00000
+    1085 = 1.00000
+    1087 = 1.00000
+    1088 = 1.00000
+    1090 = 1.00000
+    1091 = 1.00000
+    1096 = 1.00000
+    1097 = 1.00000
+    1102 = 1.00000
+    1103 = 1.00000
+    1105 = 1.00000
+    1106 = 1.00000
+    1144 = 1.00000
+    1145 = 1.00000
+    1147 = 1.00000
+    1148 = 1.00000
+    1153 = 1.00000
+    1154 = 1.00000
+    1156 = 1.00000
+    1157 = 1.00000
+    1192 = 1.00000
+    1193 = 1.00000
+    1195 = 1.00000
+    1196 = 1.00000
+    1201 = 1.00000
+    1202 = 1.00000
+    1204 = 1.00000
+    1205 = 1.00000
+    1216 = 1.00000
+    1217 = 1.00000
+    1222 = 1.00000
+    1223 = 1.00000
+    1228 = 1.00000
+    1229 = 1.00000
+    1240 = 1.00000
+    1241 = 1.00000
+    1246 = 1.00000
+    1247 = 1.00000
+    1252 = 1.00000
+    1253 = 1.00000
+    1306 = 1.00000
+    1307 = 1.00000
+    1312 = 1.00000
+    1313 = 1.00000
+    1321 = 1.00000
+    1322 = 1.00000
+    1327 = 1.00000
+    1328 = 1.00000
+    1366 = 1.00000
+    1367 = 1.00000
+    1372 = 1.00000
+    1373 = 1.00000
+    1378 = 1.00000
+    1379 = 1.00000
+    1390 = 1.00000
+    1391 = 1.00000
+    1396 = 1.00000
+    1397 = 1.00000
+    1402 = 1.00000
+    1403 = 1.00000
+    1456 = 1.00000
+    1457 = 1.00000
+    1462 = 1.00000
+    1463 = 1.00000
+    1471 = 1.00000
+    1472 = 1.00000
+    1477 = 1.00000
+    1478 = 1.00000
+    1552 = 1.00000
+    1553 = 1.00000
+    1555 = 1.00000
+    1556 = 1.00000
+    1558 = 1.00000
+    1559 = 1.00000
+    1567 = 1.00000
+    1568 = 1.00000
+    1570 = 1.00000
+    1571 = 1.00000
+    1573 = 1.00000
+    1574 = 1.00000
+    1612 = 1.00000
+    1613 = 1.00000
+    1615 = 1.00000
+    1616 = 1.00000
+    1621 = 1.00000
+    1622 = 1.00000
+    1624 = 1.00000
+    1625 = 1.00000
+    1672 = 1.00000
+    1673 = 1.00000
+    1675 = 1.00000
+    1676 = 1.00000
+    1678 = 1.00000
+    1679 = 1.00000
+    1687 = 1.00000
+    1688 = 1.00000
+    1690 = 1.00000
+    1691 = 1.00000
+    1693 = 1.00000
+    1694 = 1.00000
+    1732 = 1.00000
+    1733 = 1.00000
+    1735 = 1.00000
+    1736 = 1.00000
+    1741 = 1.00000
+    1742 = 1.00000
+    1744 = 1.00000
+    1745 = 1.00000
+    1756 = 1.00000
+    1757 = 1.00000
+    1762 = 1.00000
+    1763 = 1.00000
+    1771 = 1.00000
+    1772 = 1.00000
+    1777 = 1.00000
+    1778 = 1.00000
+    1816 = 1.00000
+    1817 = 1.00000
+    1822 = 1.00000
+    1823 = 1.00000
+    1831 = 1.00000
+    1832 = 1.00000
+    1837 = 1.00000
+    1838 = 1.00000
+    1876 = 1.00000
+    1877 = 1.00000
+    1882 = 1.00000
+    1883 = 1.00000
+    1891 = 1.00000
+    1892 = 1.00000
+    1897 = 1.00000
+    1898 = 1.00000
+    1936 = 1.00000
+    1937 = 1.00000
+    1942 = 1.00000
+    1943 = 1.00000
+    1951 = 1.00000
+    1952 = 1.00000
+    1957 = 1.00000
+    1958 = 1.00000
+    2020 = 1.00000
+    2021 = 1.00000
+    2023 = 1.00000
+    2024 = 1.00000
+    2029 = 1.00000
+    2030 = 1.00000
+    2032 = 1.00000
+    2033 = 1.00000
+    2068 = 1.00000
+    2069 = 1.00000
+    2071 = 1.00000
+    2072 = 1.00000
+    2077 = 1.00000
+    2078 = 1.00000
+    2080 = 1.00000
+    2081 = 1.00000
+    2116 = 1.00000
+    2117 = 1.00000
+    2119 = 1.00000
+    2120 = 1.00000
+    2125 = 1.00000
+    2126 = 1.00000
+    2128 = 1.00000
+    2129 = 1.00000
+    2164 = 1.00000
+    2165 = 1.00000
+    2167 = 1.00000
+    2168 = 1.00000
+    2173 = 1.00000
+    2174 = 1.00000
+    2176 = 1.00000
+    2177 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(2)^3], case=2
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    3 = 1.00000
+    5 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    15 = 1.00000
+    17 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    25 = 1.00000
+    26 = 1.00000
+    30 = 1.00000
+    32 = 1.00000
+    37 = 1.00000
+    38 = 1.00000
+    42 = 1.00000
+    44 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    50 = 1.00000
+    51 = 1.00000
+    53 = 1.00000
+    55 = 1.00000
+    56 = 1.00000
+    61 = 1.00000
+    62 = 1.00000
+    66 = 1.00000
+    68 = 1.00000
+    81 = 1.00000
+    83 = 1.00000
+    87 = 1.00000
+    89 = 1.00000
+    96 = 1.00000
+    98 = 1.00000
+    105 = 1.00000
+    107 = 1.00000
+    111 = 1.00000
+    113 = 1.00000
+    120 = 1.00000
+    122 = 1.00000
+    136 = 1.00000
+    137 = 1.00000
+    142 = 1.00000
+    143 = 1.00000
+    148 = 1.00000
+    149 = 1.00000
+    157 = 1.00000
+    158 = 1.00000
+    166 = 1.00000
+    167 = 1.00000
+    172 = 1.00000
+    173 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    227 = 1.00000
+    228 = 1.00000
+    230 = 1.00000
+    232 = 1.00000
+    233 = 1.00000
+    238 = 1.00000
+    239 = 1.00000
+    243 = 1.00000
+    245 = 1.00000
+    249 = 1.00000
+    250 = 1.00000
+    251 = 1.00000
+    252 = 1.00000
+    254 = 1.00000
+    256 = 1.00000
+    257 = 1.00000
+    262 = 1.00000
+    263 = 1.00000
+    267 = 1.00000
+    269 = 1.00000
+    279 = 1.00000
+    281 = 1.00000
+    288 = 1.00000
+    290 = 1.00000
+    294 = 1.00000
+    296 = 1.00000
+    303 = 1.00000
+    305 = 1.00000
+    316 = 1.00000
+    317 = 1.00000
+    322 = 1.00000
+    323 = 1.00000
+    331 = 1.00000
+    332 = 1.00000
+    337 = 1.00000
+    338 = 1.00000
+    375 = 1.00000
+    377 = 1.00000
+    381 = 1.00000
+    383 = 1.00000
+    390 = 1.00000
+    392 = 1.00000
+    399 = 1.00000
+    401 = 1.00000
+    405 = 1.00000
+    407 = 1.00000
+    414 = 1.00000
+    416 = 1.00000
+    429 = 1.00000
+    430 = 1.00000
+    431 = 1.00000
+    433 = 1.00000
+    434 = 1.00000
+    435 = 1.00000
+    436 = 1.00000
+    437 = 1.00000
+    439 = 1.00000
+    440 = 1.00000
+    442 = 1.00000
+    443 = 1.00000
+    444 = 1.00000
+    446 = 1.00000
+    451 = 1.00000
+    452 = 1.00000
+    453 = 1.00000
+    455 = 1.00000
+    459 = 1.00000
+    460 = 1.00000
+    461 = 1.00000
+    463 = 1.00000
+    464 = 1.00000
+    466 = 1.00000
+    467 = 1.00000
+    468 = 1.00000
+    470 = 1.00000
+    520 = 1.00000
+    521 = 1.00000
+    523 = 1.00000
+    524 = 1.00000
+    526 = 1.00000
+    527 = 1.00000
+    532 = 1.00000
+    533 = 1.00000
+    538 = 1.00000
+    539 = 1.00000
+    541 = 1.00000
+    542 = 1.00000
+    555 = 1.00000
+    557 = 1.00000
+    564 = 1.00000
+    566 = 1.00000
+    570 = 1.00000
+    572 = 1.00000
+    579 = 1.00000
+    581 = 1.00000
+    591 = 1.00000
+    592 = 1.00000
+    593 = 1.00000
+    595 = 1.00000
+    596 = 1.00000
+    598 = 1.00000
+    599 = 1.00000
+    600 = 1.00000
+    602 = 1.00000
+    606 = 1.00000
+    607 = 1.00000
+    608 = 1.00000
+    610 = 1.00000
+    611 = 1.00000
+    613 = 1.00000
+    614 = 1.00000
+    615 = 1.00000
+    617 = 1.00000
+    652 = 1.00000
+    653 = 1.00000
+    655 = 1.00000
+    656 = 1.00000
+    661 = 1.00000
+    662 = 1.00000
+    664 = 1.00000
+    665 = 1.00000
+    676 = 1.00000
+    677 = 1.00000
+    682 = 1.00000
+    683 = 1.00000
+    688 = 1.00000
+    689 = 1.00000
+    697 = 1.00000
+    698 = 1.00000
+    706 = 1.00000
+    707 = 1.00000
+    712 = 1.00000
+    713 = 1.00000
+    766 = 1.00000
+    767 = 1.00000
+    772 = 1.00000
+    773 = 1.00000
+    778 = 1.00000
+    779 = 1.00000
+    787 = 1.00000
+    788 = 1.00000
+    796 = 1.00000
+    797 = 1.00000
+    802 = 1.00000
+    803 = 1.00000
+    856 = 1.00000
+    857 = 1.00000
+    862 = 1.00000
+    863 = 1.00000
+    871 = 1.00000
+    872 = 1.00000
+    877 = 1.00000
+    878 = 1.00000
+    916 = 1.00000
+    917 = 1.00000
+    922 = 1.00000
+    923 = 1.00000
+    931 = 1.00000
+    932 = 1.00000
+    937 = 1.00000
+    938 = 1.00000
+    1012 = 1.00000
+    1013 = 1.00000
+    1015 = 1.00000
+    1016 = 1.00000
+    1018 = 1.00000
+    1019 = 1.00000
+    1024 = 1.00000
+    1025 = 1.00000
+    1030 = 1.00000
+    1031 = 1.00000
+    1033 = 1.00000
+    1034 = 1.00000
+    1084 = 1.00000
+    1085 = 1.00000
+    1087 = 1.00000
+    1088 = 1.00000
+    1090 = 1.00000
+    1091 = 1.00000
+    1096 = 1.00000
+    1097 = 1.00000
+    1102 = 1.00000
+    1103 = 1.00000
+    1105 = 1.00000
+    1106 = 1.00000
+    1144 = 1.00000
+    1145 = 1.00000
+    1147 = 1.00000
+    1148 = 1.00000
+    1153 = 1.00000
+    1154 = 1.00000
+    1156 = 1.00000
+    1157 = 1.00000
+    1192 = 1.00000
+    1193 = 1.00000
+    1195 = 1.00000
+    1196 = 1.00000
+    1201 = 1.00000
+    1202 = 1.00000
+    1204 = 1.00000
+    1205 = 1.00000
+    1215 = 1.00000
+    1216 = 1.00000
+    1217 = 1.00000
+    1218 = 1.00000
+    1220 = 1.00000
+    1222 = 1.00000
+    1223 = 1.00000
+    1228 = 1.00000
+    1229 = 1.00000
+    1233 = 1.00000
+    1235 = 1.00000
+    1239 = 1.00000
+    1240 = 1.00000
+    1241 = 1.00000
+    1242 = 1.00000
+    1244 = 1.00000
+    1246 = 1.00000
+    1247 = 1.00000
+    1252 = 1.00000
+    1253 = 1.00000
+    1257 = 1.00000
+    1259 = 1.00000
+    1269 = 1.00000
+    1271 = 1.00000
+    1278 = 1.00000
+    1280 = 1.00000
+    1284 = 1.00000
+    1286 = 1.00000
+    1293 = 1.00000
+    1295 = 1.00000
+    1306 = 1.00000
+    1307 = 1.00000
+    1312 = 1.00000
+    1313 = 1.00000
+    1321 = 1.00000
+    1322 = 1.00000
+    1327 = 1.00000
+    1328 = 1.00000
+    1365 = 1.00000
+    1366 = 1.00000
+    1367 = 1.00000
+    1368 = 1.00000
+    1370 = 1.00000
+    1372 = 1.00000
+    1373 = 1.00000
+    1378 = 1.00000
+    1379 = 1.00000
+    1383 = 1.00000
+    1385 = 1.00000
+    1389 = 1.00000
+    1390 = 1.00000
+    1391 = 1.00000
+    1392 = 1.00000
+    1394 = 1.00000
+    1396 = 1.00000
+    1397 = 1.00000
+    1402 = 1.00000
+    1403 = 1.00000
+    1407 = 1.00000
+    1409 = 1.00000
+    1419 = 1.00000
+    1421 = 1.00000
+    1428 = 1.00000
+    1430 = 1.00000
+    1434 = 1.00000
+    1436 = 1.00000
+    1443 = 1.00000
+    1445 = 1.00000
+    1456 = 1.00000
+    1457 = 1.00000
+    1462 = 1.00000
+    1463 = 1.00000
+    1471 = 1.00000
+    1472 = 1.00000
+    1477 = 1.00000
+    1478 = 1.00000
+    1515 = 1.00000
+    1517 = 1.00000
+    1524 = 1.00000
+    1526 = 1.00000
+    1530 = 1.00000
+    1532 = 1.00000
+    1539 = 1.00000
+    1541 = 1.00000
+    1551 = 1.00000
+    1552 = 1.00000
+    1553 = 1.00000
+    1555 = 1.00000
+    1556 = 1.00000
+    1558 = 1.00000
+    1559 = 1.00000
+    1560 = 1.00000
+    1562 = 1.00000
+    1566 = 1.00000
+    1567 = 1.00000
+    1568 = 1.00000
+    1570 = 1.00000
+    1571 = 1.00000
+    1573 = 1.00000
+    1574 = 1.00000
+    1575 = 1.00000
+    1577 = 1.00000
+    1612 = 1.00000
+    1613 = 1.00000
+    1615 = 1.00000
+    1616 = 1.00000
+    1621 = 1.00000
+    1622 = 1.00000
+    1624 = 1.00000
+    1625 = 1.00000
+    1635 = 1.00000
+    1637 = 1.00000
+    1644 = 1.00000
+    1646 = 1.00000
+    1650 = 1.00000
+    1652 = 1.00000
+    1659 = 1.00000
+    1661 = 1.00000
+    1671 = 1.00000
+    1672 = 1.00000
+    1673 = 1.00000
+    1675 = 1.00000
+    1676 = 1.00000
+    1678 = 1.00000
+    1679 = 1.00000
+    1680 = 1.00000
+    1682 = 1.00000
+    1686 = 1.00000
+    1687 = 1.00000
+    1688 = 1.00000
+    1690 = 1.00000
+    1691 = 1.00000
+    1693 = 1.00000
+    1694 = 1.00000
+    1695 = 1.00000
+    1697 = 1.00000
+    1732 = 1.00000
+    1733 = 1.00000
+    1735 = 1.00000
+    1736 = 1.00000
+    1741 = 1.00000
+    1742 = 1.00000
+    1744 = 1.00000
+    1745 = 1.00000
+    1756 = 1.00000
+    1757 = 1.00000
+    1762 = 1.00000
+    1763 = 1.00000
+    1771 = 1.00000
+    1772 = 1.00000
+    1777 = 1.00000
+    1778 = 1.00000
+    1816 = 1.00000
+    1817 = 1.00000
+    1822 = 1.00000
+    1823 = 1.00000
+    1831 = 1.00000
+    1832 = 1.00000
+    1837 = 1.00000
+    1838 = 1.00000
+    1876 = 1.00000
+    1877 = 1.00000
+    1882 = 1.00000
+    1883 = 1.00000
+    1891 = 1.00000
+    1892 = 1.00000
+    1897 = 1.00000
+    1898 = 1.00000
+    1936 = 1.00000
+    1937 = 1.00000
+    1942 = 1.00000
+    1943 = 1.00000
+    1951 = 1.00000
+    1952 = 1.00000
+    1957 = 1.00000
+    1958 = 1.00000
+    2020 = 1.00000
+    2021 = 1.00000
+    2023 = 1.00000
+    2024 = 1.00000
+    2029 = 1.00000
+    2030 = 1.00000
+    2032 = 1.00000
+    2033 = 1.00000
+    2068 = 1.00000
+    2069 = 1.00000
+    2071 = 1.00000
+    2072 = 1.00000
+    2077 = 1.00000
+    2078 = 1.00000
+    2080 = 1.00000
+    2081 = 1.00000
+    2116 = 1.00000
+    2117 = 1.00000
+    2119 = 1.00000
+    2120 = 1.00000
+    2125 = 1.00000
+    2126 = 1.00000
+    2128 = 1.00000
+    2129 = 1.00000
+    2164 = 1.00000
+    2165 = 1.00000
+    2167 = 1.00000
+    2168 = 1.00000
+    2173 = 1.00000
+    2174 = 1.00000
+    2176 = 1.00000
+    2177 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(2)^3], case=3
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    3 = 1.00000
+    5 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    15 = 1.00000
+    17 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    25 = 1.00000
+    26 = 1.00000
+    30 = 1.00000
+    32 = 1.00000
+    37 = 1.00000
+    38 = 1.00000
+    42 = 1.00000
+    44 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    50 = 1.00000
+    51 = 1.00000
+    53 = 1.00000
+    55 = 1.00000
+    56 = 1.00000
+    61 = 1.00000
+    62 = 1.00000
+    66 = 1.00000
+    68 = 1.00000
+    81 = 1.00000
+    83 = 1.00000
+    87 = 1.00000
+    89 = 1.00000
+    96 = 1.00000
+    98 = 1.00000
+    105 = 1.00000
+    107 = 1.00000
+    111 = 1.00000
+    113 = 1.00000
+    120 = 1.00000
+    122 = 1.00000
+    136 = 1.00000
+    137 = 1.00000
+    142 = 1.00000
+    143 = 1.00000
+    148 = 1.00000
+    149 = 1.00000
+    157 = 1.00000
+    158 = 1.00000
+    166 = 1.00000
+    167 = 1.00000
+    172 = 1.00000
+    173 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    227 = 1.00000
+    228 = 1.00000
+    230 = 1.00000
+    232 = 1.00000
+    233 = 1.00000
+    238 = 1.00000
+    239 = 1.00000
+    243 = 1.00000
+    245 = 1.00000
+    249 = 1.00000
+    250 = 1.00000
+    251 = 1.00000
+    252 = 1.00000
+    254 = 1.00000
+    256 = 1.00000
+    257 = 1.00000
+    262 = 1.00000
+    263 = 1.00000
+    267 = 1.00000
+    269 = 1.00000
+    279 = 1.00000
+    281 = 1.00000
+    288 = 1.00000
+    290 = 1.00000
+    294 = 1.00000
+    296 = 1.00000
+    303 = 1.00000
+    305 = 1.00000
+    316 = 1.00000
+    317 = 1.00000
+    322 = 1.00000
+    323 = 1.00000
+    331 = 1.00000
+    332 = 1.00000
+    337 = 1.00000
+    338 = 1.00000
+    375 = 1.00000
+    377 = 1.00000
+    381 = 1.00000
+    383 = 1.00000
+    390 = 1.00000
+    392 = 1.00000
+    399 = 1.00000
+    401 = 1.00000
+    405 = 1.00000
+    407 = 1.00000
+    414 = 1.00000
+    416 = 1.00000
+    429 = 1.00000
+    430 = 1.00000
+    431 = 1.00000
+    433 = 1.00000
+    434 = 1.00000
+    435 = 1.00000
+    436 = 1.00000
+    437 = 1.00000
+    439 = 1.00000
+    440 = 1.00000
+    442 = 1.00000
+    443 = 1.00000
+    444 = 1.00000
+    446 = 1.00000
+    451 = 1.00000
+    452 = 1.00000
+    453 = 1.00000
+    455 = 1.00000
+    459 = 1.00000
+    460 = 1.00000
+    461 = 1.00000
+    463 = 1.00000
+    464 = 1.00000
+    466 = 1.00000
+    467 = 1.00000
+    468 = 1.00000
+    470 = 1.00000
+    520 = 1.00000
+    521 = 1.00000
+    523 = 1.00000
+    524 = 1.00000
+    526 = 1.00000
+    527 = 1.00000
+    532 = 1.00000
+    533 = 1.00000
+    538 = 1.00000
+    539 = 1.00000
+    541 = 1.00000
+    542 = 1.00000
+    555 = 1.00000
+    557 = 1.00000
+    564 = 1.00000
+    566 = 1.00000
+    570 = 1.00000
+    572 = 1.00000
+    579 = 1.00000
+    581 = 1.00000
+    591 = 1.00000
+    592 = 1.00000
+    593 = 1.00000
+    595 = 1.00000
+    596 = 1.00000
+    598 = 1.00000
+    599 = 1.00000
+    600 = 1.00000
+    602 = 1.00000
+    606 = 1.00000
+    607 = 1.00000
+    608 = 1.00000
+    610 = 1.00000
+    611 = 1.00000
+    613 = 1.00000
+    614 = 1.00000
+    615 = 1.00000
+    617 = 1.00000
+    652 = 1.00000
+    653 = 1.00000
+    655 = 1.00000
+    656 = 1.00000
+    661 = 1.00000
+    662 = 1.00000
+    664 = 1.00000
+    665 = 1.00000
+    676 = 1.00000
+    677 = 1.00000
+    682 = 1.00000
+    683 = 1.00000
+    688 = 1.00000
+    689 = 1.00000
+    697 = 1.00000
+    698 = 1.00000
+    706 = 1.00000
+    707 = 1.00000
+    712 = 1.00000
+    713 = 1.00000
+    765 = 1.00000
+    766 = 1.00000
+    767 = 1.00000
+    768 = 1.00000
+    770 = 1.00000
+    771 = 1.00000
+    772 = 1.00000
+    773 = 1.00000
+    774 = 1.00000
+    776 = 1.00000
+    778 = 1.00000
+    779 = 1.00000
+    783 = 1.00000
+    785 = 1.00000
+    787 = 1.00000
+    788 = 1.00000
+    792 = 1.00000
+    794 = 1.00000
+    795 = 1.00000
+    796 = 1.00000
+    797 = 1.00000
+    798 = 1.00000
+    800 = 1.00000
+    802 = 1.00000
+    803 = 1.00000
+    807 = 1.00000
+    809 = 1.00000
+    819 = 1.00000
+    821 = 1.00000
+    822 = 1.00000
+    824 = 1.00000
+    828 = 1.00000
+    830 = 1.00000
+    834 = 1.00000
+    836 = 1.00000
+    837 = 1.00000
+    839 = 1.00000
+    843 = 1.00000
+    845 = 1.00000
+    856 = 1.00000
+    857 = 1.00000
+    862 = 1.00000
+    863 = 1.00000
+    871 = 1.00000
+    872 = 1.00000
+    877 = 1.00000
+    878 = 1.00000
+    915 = 1.00000
+    916 = 1.00000
+    917 = 1.00000
+    918 = 1.00000
+    920 = 1.00000
+    922 = 1.00000
+    923 = 1.00000
+    927 = 1.00000
+    929 = 1.00000
+    930 = 1.00000
+    931 = 1.00000
+    932 = 1.00000
+    933 = 1.00000
+    935 = 1.00000
+    937 = 1.00000
+    938 = 1.00000
+    942 = 1.00000
+    944 = 1.00000
+    951 = 1.00000
+    953 = 1.00000
+    957 = 1.00000
+    959 = 1.00000
+    960 = 1.00000
+    962 = 1.00000
+    966 = 1.00000
+    968 = 1.00000
+    1012 = 1.00000
+    1013 = 1.00000
+    1015 = 1.00000
+    1016 = 1.00000
+    1018 = 1.00000
+    1019 = 1.00000
+    1024 = 1.00000
+    1025 = 1.00000
+    1030 = 1.00000
+    1031 = 1.00000
+    1033 = 1.00000
+    1034 = 1.00000
+    1047 = 1.00000
+    1049 = 1.00000
+    1050 = 1.00000
+    1052 = 1.00000
+    1056 = 1.00000
+    1058 = 1.00000
+    1062 = 1.00000
+    1064 = 1.00000
+    1065 = 1.00000
+    1067 = 1.00000
+    1071 = 1.00000
+    1073 = 1.00000
+    1083 = 1.00000
+    1084 = 1.00000
+    1085 = 1.00000
+    1086 = 1.00000
+    1087 = 1.00000
+    1088 = 1.00000
+    1090 = 1.00000
+    1091 = 1.00000
+    1092 = 1.00000
+    1094 = 1.00000
+    1096 = 1.00000
+    1097 = 1.00000
+    1098 = 1.00000
+    1100 = 1.00000
+    1101 = 1.00000
+    1102 = 1.00000
+    1103 = 1.00000
+    1105 = 1.00000
+    1106 = 1.00000
+    1107 = 1.00000
+    1109 = 1.00000
+    1144 = 1.00000
+    1145 = 1.00000
+    1147 = 1.00000
+    1148 = 1.00000
+    1153 = 1.00000
+    1154 = 1.00000
+    1156 = 1.00000
+    1157 = 1.00000
+    1167 = 1.00000
+    1169 = 1.00000
+    1173 = 1.00000
+    1175 = 1.00000
+    1176 = 1.00000
+    1178 = 1.00000
+    1182 = 1.00000
+    1184 = 1.00000
+    1191 = 1.00000
+    1192 = 1.00000
+    1193 = 1.00000
+    1195 = 1.00000
+    1196 = 1.00000
+    1197 = 1.00000
+    1199 = 1.00000
+    1200 = 1.00000
+    1201 = 1.00000
+    1202 = 1.00000
+    1204 = 1.00000
+    1205 = 1.00000
+    1206 = 1.00000
+    1208 = 1.00000
+    1215 = 1.00000
+    1216 = 1.00000
+    1217 = 1.00000
+    1218 = 1.00000
+    1220 = 1.00000
+    1222 = 1.00000
+    1223 = 1.00000
+    1228 = 1.00000
+    1229 = 1.00000
+    1233 = 1.00000
+    1235 = 1.00000
+    1239 = 1.00000
+    1240 = 1.00000
+    1241 = 1.00000
+    1242 = 1.00000
+    1244 = 1.00000
+    1246 = 1.00000
+    1247 = 1.00000
+    1252 = 1.00000
+    1253 = 1.00000
+    1257 = 1.00000
+    1259 = 1.00000
+    1269 = 1.00000
+    1271 = 1.00000
+    1278 = 1.00000
+    1280 = 1.00000
+    1284 = 1.00000
+    1286 = 1.00000
+    1293 = 1.00000
+    1295 = 1.00000
+    1306 = 1.00000
+    1307 = 1.00000
+    1312 = 1.00000
+    1313 = 1.00000
+    1321 = 1.00000
+    1322 = 1.00000
+    1327 = 1.00000
+    1328 = 1.00000
+    1365 = 1.00000
+    1366 = 1.00000
+    1367 = 1.00000
+    1368 = 1.00000
+    1370 = 1.00000
+    1372 = 1.00000
+    1373 = 1.00000
+    1378 = 1.00000
+    1379 = 1.00000
+    1383 = 1.00000
+    1385 = 1.00000
+    1389 = 1.00000
+    1390 = 1.00000
+    1391 = 1.00000
+    1392 = 1.00000
+    1394 = 1.00000
+    1396 = 1.00000
+    1397 = 1.00000
+    1402 = 1.00000
+    1403 = 1.00000
+    1407 = 1.00000
+    1409 = 1.00000
+    1419 = 1.00000
+    1421 = 1.00000
+    1428 = 1.00000
+    1430 = 1.00000
+    1434 = 1.00000
+    1436 = 1.00000
+    1443 = 1.00000
+    1445 = 1.00000
+    1456 = 1.00000
+    1457 = 1.00000
+    1462 = 1.00000
+    1463 = 1.00000
+    1471 = 1.00000
+    1472 = 1.00000
+    1477 = 1.00000
+    1478 = 1.00000
+    1515 = 1.00000
+    1517 = 1.00000
+    1524 = 1.00000
+    1526 = 1.00000
+    1530 = 1.00000
+    1532 = 1.00000
+    1539 = 1.00000
+    1541 = 1.00000
+    1551 = 1.00000
+    1552 = 1.00000
+    1553 = 1.00000
+    1555 = 1.00000
+    1556 = 1.00000
+    1558 = 1.00000
+    1559 = 1.00000
+    1560 = 1.00000
+    1562 = 1.00000
+    1566 = 1.00000
+    1567 = 1.00000
+    1568 = 1.00000
+    1570 = 1.00000
+    1571 = 1.00000
+    1573 = 1.00000
+    1574 = 1.00000
+    1575 = 1.00000
+    1577 = 1.00000
+    1612 = 1.00000
+    1613 = 1.00000
+    1615 = 1.00000
+    1616 = 1.00000
+    1621 = 1.00000
+    1622 = 1.00000
+    1624 = 1.00000
+    1625 = 1.00000
+    1635 = 1.00000
+    1637 = 1.00000
+    1644 = 1.00000
+    1646 = 1.00000
+    1650 = 1.00000
+    1652 = 1.00000
+    1659 = 1.00000
+    1661 = 1.00000
+    1671 = 1.00000
+    1672 = 1.00000
+    1673 = 1.00000
+    1675 = 1.00000
+    1676 = 1.00000
+    1678 = 1.00000
+    1679 = 1.00000
+    1680 = 1.00000
+    1682 = 1.00000
+    1686 = 1.00000
+    1687 = 1.00000
+    1688 = 1.00000
+    1690 = 1.00000
+    1691 = 1.00000
+    1693 = 1.00000
+    1694 = 1.00000
+    1695 = 1.00000
+    1697 = 1.00000
+    1732 = 1.00000
+    1733 = 1.00000
+    1735 = 1.00000
+    1736 = 1.00000
+    1741 = 1.00000
+    1742 = 1.00000
+    1744 = 1.00000
+    1745 = 1.00000
+    1756 = 1.00000
+    1757 = 1.00000
+    1762 = 1.00000
+    1763 = 1.00000
+    1771 = 1.00000
+    1772 = 1.00000
+    1777 = 1.00000
+    1778 = 1.00000
+    1815 = 1.00000
+    1816 = 1.00000
+    1817 = 1.00000
+    1818 = 1.00000
+    1820 = 1.00000
+    1822 = 1.00000
+    1823 = 1.00000
+    1827 = 1.00000
+    1829 = 1.00000
+    1830 = 1.00000
+    1831 = 1.00000
+    1832 = 1.00000
+    1833 = 1.00000
+    1835 = 1.00000
+    1837 = 1.00000
+    1838 = 1.00000
+    1842 = 1.00000
+    1844 = 1.00000
+    1851 = 1.00000
+    1853 = 1.00000
+    1857 = 1.00000
+    1859 = 1.00000
+    1860 = 1.00000
+    1862 = 1.00000
+    1866 = 1.00000
+    1868 = 1.00000
+    1876 = 1.00000
+    1877 = 1.00000
+    1882 = 1.00000
+    1883 = 1.00000
+    1891 = 1.00000
+    1892 = 1.00000
+    1897 = 1.00000
+    1898 = 1.00000
+    1935 = 1.00000
+    1936 = 1.00000
+    1937 = 1.00000
+    1938 = 1.00000
+    1940 = 1.00000
+    1942 = 1.00000
+    1943 = 1.00000
+    1947 = 1.00000
+    1949 = 1.00000
+    1950 = 1.00000
+    1951 = 1.00000
+    1952 = 1.00000
+    1953 = 1.00000
+    1955 = 1.00000
+    1957 = 1.00000
+    1958 = 1.00000
+    1962 = 1.00000
+    1964 = 1.00000
+    1971 = 1.00000
+    1973 = 1.00000
+    1977 = 1.00000
+    1979 = 1.00000
+    1980 = 1.00000
+    1982 = 1.00000
+    1986 = 1.00000
+    1988 = 1.00000
+    2020 = 1.00000
+    2021 = 1.00000
+    2023 = 1.00000
+    2024 = 1.00000
+    2029 = 1.00000
+    2030 = 1.00000
+    2032 = 1.00000
+    2033 = 1.00000
+    2043 = 1.00000
+    2045 = 1.00000
+    2049 = 1.00000
+    2051 = 1.00000
+    2052 = 1.00000
+    2054 = 1.00000
+    2058 = 1.00000
+    2060 = 1.00000
+    2067 = 1.00000
+    2068 = 1.00000
+    2069 = 1.00000
+    2071 = 1.00000
+    2072 = 1.00000
+    2073 = 1.00000
+    2075 = 1.00000
+    2076 = 1.00000
+    2077 = 1.00000
+    2078 = 1.00000
+    2080 = 1.00000
+    2081 = 1.00000
+    2082 = 1.00000
+    2084 = 1.00000
+    2116 = 1.00000
+    2117 = 1.00000
+    2119 = 1.00000
+    2120 = 1.00000
+    2125 = 1.00000
+    2126 = 1.00000
+    2128 = 1.00000
+    2129 = 1.00000
+    2139 = 1.00000
+    2141 = 1.00000
+    2145 = 1.00000
+    2147 = 1.00000
+    2148 = 1.00000
+    2150 = 1.00000
+    2154 = 1.00000
+    2156 = 1.00000
+    2163 = 1.00000
+    2164 = 1.00000
+    2165 = 1.00000
+    2167 = 1.00000
+    2168 = 1.00000
+    2169 = 1.00000
+    2171 = 1.00000
+    2172 = 1.00000
+    2173 = 1.00000
+    2174 = 1.00000
+    2176 = 1.00000
+    2177 = 1.00000
+    2178 = 1.00000
+    2180 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(2)^3], case=4
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    3 = 1.00000
+    4 = 1.00000
+    5 = 1.00000
+    6 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    9 = 1.00000
+    10 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    15 = 1.00000
+    17 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    24 = 1.00000
+    25 = 1.00000
+    26 = 1.00000
+    27 = 1.00000
+    28 = 1.00000
+    30 = 1.00000
+    31 = 1.00000
+    32 = 1.00000
+    33 = 1.00000
+    34 = 1.00000
+    37 = 1.00000
+    38 = 1.00000
+    42 = 1.00000
+    44 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    50 = 1.00000
+    51 = 1.00000
+    53 = 1.00000
+    55 = 1.00000
+    56 = 1.00000
+    61 = 1.00000
+    62 = 1.00000
+    66 = 1.00000
+    68 = 1.00000
+    72 = 1.00000
+    73 = 1.00000
+    81 = 1.00000
+    82 = 1.00000
+    83 = 1.00000
+    84 = 1.00000
+    85 = 1.00000
+    87 = 1.00000
+    89 = 1.00000
+    93 = 1.00000
+    94 = 1.00000
+    96 = 1.00000
+    97 = 1.00000
+    98 = 1.00000
+    99 = 1.00000
+    100 = 1.00000
+    105 = 1.00000
+    107 = 1.00000
+    111 = 1.00000
+    113 = 1.00000
+    120 = 1.00000
+    122 = 1.00000
+    126 = 1.00000
+    127 = 1.00000
+    135 = 1.00000
+    136 = 1.00000
+    137 = 1.00000
+    138 = 1.00000
+    139 = 1.00000
+    142 = 1.00000
+    143 = 1.00000
+    147 = 1.00000
+    148 = 1.00000
+    149 = 1.00000
+    150 = 1.00000
+    151 = 1.00000
+    153 = 1.00000
+    154 = 1.00000
+    157 = 1.00000
+    158 = 1.00000
+    166 = 1.00000
+    167 = 1.00000
+    172 = 1.00000
+    173 = 1.00000
+    180 = 1.00000
+    181 = 1.00000
+    189 = 1.00000
+    190 = 1.00000
+    195 = 1.00000
+    196 = 1.00000
+    198 = 1.00000
+    199 = 1.00000
+    216 = 1.00000
+    217 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    227 = 1.00000
+    228 = 1.00000
+    230 = 1.00000
+    232 = 1.00000
+    233 = 1.00000
+    238 = 1.00000
+    239 = 1.00000
+    243 = 1.00000
+    245 = 1.00000
+    249 = 1.00000
+    250 = 1.00000
+    251 = 1.00000
+    252 = 1.00000
+    254 = 1.00000
+    256 = 1.00000
+    257 = 1.00000
+    262 = 1.00000
+    263 = 1.00000
+    267 = 1.00000
+    269 = 1.00000
+    279 = 1.00000
+    281 = 1.00000
+    288 = 1.00000
+    290 = 1.00000
+    294 = 1.00000
+    296 = 1.00000
+    303 = 1.00000
+    305 = 1.00000
+    316 = 1.00000
+    317 = 1.00000
+    322 = 1.00000
+    323 = 1.00000
+    331 = 1.00000
+    332 = 1.00000
+    337 = 1.00000
+    338 = 1.00000
+    375 = 1.00000
+    376 = 1.00000
+    377 = 1.00000
+    378 = 1.00000
+    379 = 1.00000
+    381 = 1.00000
+    383 = 1.00000
+    387 = 1.00000
+    388 = 1.00000
+    390 = 1.00000
+    391 = 1.00000
+    392 = 1.00000
+    393 = 1.00000
+    394 = 1.00000
+    399 = 1.00000
+    401 = 1.00000
+    405 = 1.00000
+    407 = 1.00000
+    414 = 1.00000
+    416 = 1.00000
+    420 = 1.00000
+    421 = 1.00000
+    429 = 1.00000
+    430 = 1.00000
+    431 = 1.00000
+    432 = 1.00000
+    433 = 1.00000
+    434 = 1.00000
+    435 = 1.00000
+    436 = 1.00000
+    437 = 1.00000
+    439 = 1.00000
+    440 = 1.00000
+    441 = 1.00000
+    442 = 1.00000
+    443 = 1.00000
+    444 = 1.00000
+    445 = 1.00000
+    446 = 1.00000
+    447 = 1.00000
+    448 = 1.00000
+    451 = 1.00000
+    452 = 1.00000
+    453 = 1.00000
+    455 = 1.00000
+    459 = 1.00000
+    460 = 1.00000
+    461 = 1.00000
+    463 = 1.00000
+    464 = 1.00000
+    466 = 1.00000
+    467 = 1.00000
+    468 = 1.00000
+    470 = 1.00000
+    474 = 1.00000
+    475 = 1.00000
+    483 = 1.00000
+    484 = 1.00000
+    489 = 1.00000
+    490 = 1.00000
+    492 = 1.00000
+    493 = 1.00000
+    510 = 1.00000
+    511 = 1.00000
+    519 = 1.00000
+    520 = 1.00000
+    521 = 1.00000
+    523 = 1.00000
+    524 = 1.00000
+    525 = 1.00000
+    526 = 1.00000
+    527 = 1.00000
+    528 = 1.00000
+    529 = 1.00000
+    532 = 1.00000
+    533 = 1.00000
+    538 = 1.00000
+    539 = 1.00000
+    541 = 1.00000
+    542 = 1.00000
+    546 = 1.00000
+    547 = 1.00000
+    555 = 1.00000
+    557 = 1.00000
+    564 = 1.00000
+    566 = 1.00000
+    570 = 1.00000
+    572 = 1.00000
+    579 = 1.00000
+    581 = 1.00000
+    591 = 1.00000
+    592 = 1.00000
+    593 = 1.00000
+    595 = 1.00000
+    596 = 1.00000
+    598 = 1.00000
+    599 = 1.00000
+    600 = 1.00000
+    602 = 1.00000
+    606 = 1.00000
+    607 = 1.00000
+    608 = 1.00000
+    610 = 1.00000
+    611 = 1.00000
+    613 = 1.00000
+    614 = 1.00000
+    615 = 1.00000
+    617 = 1.00000
+    652 = 1.00000
+    653 = 1.00000
+    655 = 1.00000
+    656 = 1.00000
+    661 = 1.00000
+    662 = 1.00000
+    664 = 1.00000
+    665 = 1.00000
+    675 = 1.00000
+    676 = 1.00000
+    677 = 1.00000
+    678 = 1.00000
+    679 = 1.00000
+    682 = 1.00000
+    683 = 1.00000
+    687 = 1.00000
+    688 = 1.00000
+    689 = 1.00000
+    690 = 1.00000
+    691 = 1.00000
+    693 = 1.00000
+    694 = 1.00000
+    697 = 1.00000
+    698 = 1.00000
+    706 = 1.00000
+    707 = 1.00000
+    712 = 1.00000
+    713 = 1.00000
+    720 = 1.00000
+    721 = 1.00000
+    729 = 1.00000
+    730 = 1.00000
+    735 = 1.00000
+    736 = 1.00000
+    738 = 1.00000
+    739 = 1.00000
+    756 = 1.00000
+    757 = 1.00000
+    765 = 1.00000
+    766 = 1.00000
+    767 = 1.00000
+    768 = 1.00000
+    769 = 1.00000
+    770 = 1.00000
+    771 = 1.00000
+    772 = 1.00000
+    773 = 1.00000
+    774 = 1.00000
+    776 = 1.00000
+    777 = 1.00000
+    778 = 1.00000
+    779 = 1.00000
+    780 = 1.00000
+    781 = 1.00000
+    783 = 1.00000
+    784 = 1.00000
+    785 = 1.00000
+    787 = 1.00000
+    788 = 1.00000
+    792 = 1.00000
+    794 = 1.00000
+    795 = 1.00000
+    796 = 1.00000
+    797 = 1.00000
+    798 = 1.00000
+    800 = 1.00000
+    802 = 1.00000
+    803 = 1.00000
+    807 = 1.00000
+    809 = 1.00000
+    810 = 1.00000
+    811 = 1.00000
+    819 = 1.00000
+    820 = 1.00000
+    821 = 1.00000
+    822 = 1.00000
+    824 = 1.00000
+    825 = 1.00000
+    826 = 1.00000
+    828 = 1.00000
+    829 = 1.00000
+    830 = 1.00000
+    834 = 1.00000
+    836 = 1.00000
+    837 = 1.00000
+    839 = 1.00000
+    843 = 1.00000
+    845 = 1.00000
+    846 = 1.00000
+    847 = 1.00000
+    856 = 1.00000
+    857 = 1.00000
+    862 = 1.00000
+    863 = 1.00000
+    871 = 1.00000
+    872 = 1.00000
+    877 = 1.00000
+    878 = 1.00000
+    915 = 1.00000
+    916 = 1.00000
+    917 = 1.00000
+    918 = 1.00000
+    920 = 1.00000
+    922 = 1.00000
+    923 = 1.00000
+    927 = 1.00000
+    929 = 1.00000
+    930 = 1.00000
+    931 = 1.00000
+    932 = 1.00000
+    933 = 1.00000
+    935 = 1.00000
+    937 = 1.00000
+    938 = 1.00000
+    942 = 1.00000
+    944 = 1.00000
+    951 = 1.00000
+    953 = 1.00000
+    957 = 1.00000
+    959 = 1.00000
+    960 = 1.00000
+    962 = 1.00000
+    966 = 1.00000
+    968 = 1.00000
+    975 = 1.00000
+    976 = 1.00000
+    981 = 1.00000
+    982 = 1.00000
+    984 = 1.00000
+    985 = 1.00000
+    1002 = 1.00000
+    1003 = 1.00000
+    1011 = 1.00000
+    1012 = 1.00000
+    1013 = 1.00000
+    1015 = 1.00000
+    1016 = 1.00000
+    1017 = 1.00000
+    1018 = 1.00000
+    1019 = 1.00000
+    1020 = 1.00000
+    1021 = 1.00000
+    1024 = 1.00000
+    1025 = 1.00000
+    1030 = 1.00000
+    1031 = 1.00000
+    1033 = 1.00000
+    1034 = 1.00000
+    1038 = 1.00000
+    1039 = 1.00000
+    1047 = 1.00000
+    1048 = 1.00000
+    1049 = 1.00000
+    1050 = 1.00000
+    1052 = 1.00000
+    1053 = 1.00000
+    1054 = 1.00000
+    1056 = 1.00000
+    1057 = 1.00000
+    1058 = 1.00000
+    1062 = 1.00000
+    1064 = 1.00000
+    1065 = 1.00000
+    1067 = 1.00000
+    1071 = 1.00000
+    1073 = 1.00000
+    1074 = 1.00000
+    1075 = 1.00000
+    1083 = 1.00000
+    1084 = 1.00000
+    1085 = 1.00000
+    1086 = 1.00000
+    1087 = 1.00000
+    1088 = 1.00000
+    1089 = 1.00000
+    1090 = 1.00000
+    1091 = 1.00000
+    1092 = 1.00000
+    1093 = 1.00000
+    1094 = 1.00000
+    1096 = 1.00000
+    1097 = 1.00000
+    1098 = 1.00000
+    1100 = 1.00000
+    1101 = 1.00000
+    1102 = 1.00000
+    1103 = 1.00000
+    1105 = 1.00000
+    1106 = 1.00000
+    1107 = 1.00000
+    1109 = 1.00000
+    1110 = 1.00000
+    1111 = 1.00000
+    1144 = 1.00000
+    1145 = 1.00000
+    1147 = 1.00000
+    1148 = 1.00000
+    1153 = 1.00000
+    1154 = 1.00000
+    1156 = 1.00000
+    1157 = 1.00000
+    1167 = 1.00000
+    1169 = 1.00000
+    1173 = 1.00000
+    1175 = 1.00000
+    1176 = 1.00000
+    1178 = 1.00000
+    1182 = 1.00000
+    1184 = 1.00000
+    1191 = 1.00000
+    1192 = 1.00000
+    1193 = 1.00000
+    1195 = 1.00000
+    1196 = 1.00000
+    1197 = 1.00000
+    1199 = 1.00000
+    1200 = 1.00000
+    1201 = 1.00000
+    1202 = 1.00000
+    1204 = 1.00000
+    1205 = 1.00000
+    1206 = 1.00000
+    1208 = 1.00000
+    1215 = 1.00000
+    1216 = 1.00000
+    1217 = 1.00000
+    1218 = 1.00000
+    1220 = 1.00000
+    1222 = 1.00000
+    1223 = 1.00000
+    1228 = 1.00000
+    1229 = 1.00000
+    1233 = 1.00000
+    1235 = 1.00000
+    1239 = 1.00000
+    1240 = 1.00000
+    1241 = 1.00000
+    1242 = 1.00000
+    1244 = 1.00000
+    1246 = 1.00000
+    1247 = 1.00000
+    1252 = 1.00000
+    1253 = 1.00000
+    1257 = 1.00000
+    1259 = 1.00000
+    1269 = 1.00000
+    1271 = 1.00000
+    1278 = 1.00000
+    1280 = 1.00000
+    1284 = 1.00000
+    1286 = 1.00000
+    1293 = 1.00000
+    1295 = 1.00000
+    1306 = 1.00000
+    1307 = 1.00000
+    1312 = 1.00000
+    1313 = 1.00000
+    1321 = 1.00000
+    1322 = 1.00000
+    1327 = 1.00000
+    1328 = 1.00000
+    1365 = 1.00000
+    1366 = 1.00000
+    1367 = 1.00000
+    1368 = 1.00000
+    1370 = 1.00000
+    1372 = 1.00000
+    1373 = 1.00000
+    1378 = 1.00000
+    1379 = 1.00000
+    1383 = 1.00000
+    1385 = 1.00000
+    1389 = 1.00000
+    1390 = 1.00000
+    1391 = 1.00000
+    1392 = 1.00000
+    1394 = 1.00000
+    1396 = 1.00000
+    1397 = 1.00000
+    1402 = 1.00000
+    1403 = 1.00000
+    1407 = 1.00000
+    1409 = 1.00000
+    1419 = 1.00000
+    1421 = 1.00000
+    1428 = 1.00000
+    1430 = 1.00000
+    1434 = 1.00000
+    1436 = 1.00000
+    1443 = 1.00000
+    1445 = 1.00000
+    1456 = 1.00000
+    1457 = 1.00000
+    1462 = 1.00000
+    1463 = 1.00000
+    1471 = 1.00000
+    1472 = 1.00000
+    1477 = 1.00000
+    1478 = 1.00000
+    1515 = 1.00000
+    1517 = 1.00000
+    1524 = 1.00000
+    1526 = 1.00000
+    1530 = 1.00000
+    1532 = 1.00000
+    1539 = 1.00000
+    1541 = 1.00000
+    1551 = 1.00000
+    1552 = 1.00000
+    1553 = 1.00000
+    1555 = 1.00000
+    1556 = 1.00000
+    1558 = 1.00000
+    1559 = 1.00000
+    1560 = 1.00000
+    1562 = 1.00000
+    1566 = 1.00000
+    1567 = 1.00000
+    1568 = 1.00000
+    1570 = 1.00000
+    1571 = 1.00000
+    1573 = 1.00000
+    1574 = 1.00000
+    1575 = 1.00000
+    1577 = 1.00000
+    1612 = 1.00000
+    1613 = 1.00000
+    1615 = 1.00000
+    1616 = 1.00000
+    1621 = 1.00000
+    1622 = 1.00000
+    1624 = 1.00000
+    1625 = 1.00000
+    1635 = 1.00000
+    1637 = 1.00000
+    1644 = 1.00000
+    1646 = 1.00000
+    1650 = 1.00000
+    1652 = 1.00000
+    1659 = 1.00000
+    1661 = 1.00000
+    1671 = 1.00000
+    1672 = 1.00000
+    1673 = 1.00000
+    1675 = 1.00000
+    1676 = 1.00000
+    1678 = 1.00000
+    1679 = 1.00000
+    1680 = 1.00000
+    1682 = 1.00000
+    1686 = 1.00000
+    1687 = 1.00000
+    1688 = 1.00000
+    1690 = 1.00000
+    1691 = 1.00000
+    1693 = 1.00000
+    1694 = 1.00000
+    1695 = 1.00000
+    1697 = 1.00000
+    1732 = 1.00000
+    1733 = 1.00000
+    1735 = 1.00000
+    1736 = 1.00000
+    1741 = 1.00000
+    1742 = 1.00000
+    1744 = 1.00000
+    1745 = 1.00000
+    1756 = 1.00000
+    1757 = 1.00000
+    1762 = 1.00000
+    1763 = 1.00000
+    1771 = 1.00000
+    1772 = 1.00000
+    1777 = 1.00000
+    1778 = 1.00000
+    1815 = 1.00000
+    1816 = 1.00000
+    1817 = 1.00000
+    1818 = 1.00000
+    1820 = 1.00000
+    1822 = 1.00000
+    1823 = 1.00000
+    1827 = 1.00000
+    1829 = 1.00000
+    1830 = 1.00000
+    1831 = 1.00000
+    1832 = 1.00000
+    1833 = 1.00000
+    1835 = 1.00000
+    1837 = 1.00000
+    1838 = 1.00000
+    1842 = 1.00000
+    1844 = 1.00000
+    1851 = 1.00000
+    1853 = 1.00000
+    1857 = 1.00000
+    1859 = 1.00000
+    1860 = 1.00000
+    1862 = 1.00000
+    1866 = 1.00000
+    1868 = 1.00000
+    1876 = 1.00000
+    1877 = 1.00000
+    1882 = 1.00000
+    1883 = 1.00000
+    1891 = 1.00000
+    1892 = 1.00000
+    1897 = 1.00000
+    1898 = 1.00000
+    1935 = 1.00000
+    1936 = 1.00000
+    1937 = 1.00000
+    1938 = 1.00000
+    1940 = 1.00000
+    1942 = 1.00000
+    1943 = 1.00000
+    1947 = 1.00000
+    1949 = 1.00000
+    1950 = 1.00000
+    1951 = 1.00000
+    1952 = 1.00000
+    1953 = 1.00000
+    1955 = 1.00000
+    1957 = 1.00000
+    1958 = 1.00000
+    1962 = 1.00000
+    1964 = 1.00000
+    1971 = 1.00000
+    1973 = 1.00000
+    1977 = 1.00000
+    1979 = 1.00000
+    1980 = 1.00000
+    1982 = 1.00000
+    1986 = 1.00000
+    1988 = 1.00000
+    2020 = 1.00000
+    2021 = 1.00000
+    2023 = 1.00000
+    2024 = 1.00000
+    2029 = 1.00000
+    2030 = 1.00000
+    2032 = 1.00000
+    2033 = 1.00000
+    2043 = 1.00000
+    2045 = 1.00000
+    2049 = 1.00000
+    2051 = 1.00000
+    2052 = 1.00000
+    2054 = 1.00000
+    2058 = 1.00000
+    2060 = 1.00000
+    2067 = 1.00000
+    2068 = 1.00000
+    2069 = 1.00000
+    2071 = 1.00000
+    2072 = 1.00000
+    2073 = 1.00000
+    2075 = 1.00000
+    2076 = 1.00000
+    2077 = 1.00000
+    2078 = 1.00000
+    2080 = 1.00000
+    2081 = 1.00000
+    2082 = 1.00000
+    2084 = 1.00000
+    2116 = 1.00000
+    2117 = 1.00000
+    2119 = 1.00000
+    2120 = 1.00000
+    2125 = 1.00000
+    2126 = 1.00000
+    2128 = 1.00000
+    2129 = 1.00000
+    2139 = 1.00000
+    2141 = 1.00000
+    2145 = 1.00000
+    2147 = 1.00000
+    2148 = 1.00000
+    2150 = 1.00000
+    2154 = 1.00000
+    2156 = 1.00000
+    2163 = 1.00000
+    2164 = 1.00000
+    2165 = 1.00000
+    2167 = 1.00000
+    2168 = 1.00000
+    2169 = 1.00000
+    2171 = 1.00000
+    2172 = 1.00000
+    2173 = 1.00000
+    2174 = 1.00000
+    2176 = 1.00000
+    2177 = 1.00000
+    2178 = 1.00000
+    2180 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(2)^3], case=5
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    3 = 1.00000
+    4 = 1.00000
+    5 = 1.00000
+    6 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    9 = 1.00000
+    10 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    15 = 1.00000
+    17 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    24 = 1.00000
+    25 = 1.00000
+    26 = 1.00000
+    27 = 1.00000
+    28 = 1.00000
+    30 = 1.00000
+    31 = 1.00000
+    32 = 1.00000
+    33 = 1.00000
+    34 = 1.00000
+    37 = 1.00000
+    38 = 1.00000
+    42 = 1.00000
+    44 = 1.00000
+    48 = 1.00000
+    49 = 1.00000
+    50 = 1.00000
+    51 = 1.00000
+    53 = 1.00000
+    55 = 1.00000
+    56 = 1.00000
+    61 = 1.00000
+    62 = 1.00000
+    66 = 1.00000
+    68 = 1.00000
+    72 = 1.00000
+    73 = 1.00000
+    81 = 1.00000
+    82 = 1.00000
+    83 = 1.00000
+    84 = 1.00000
+    85 = 1.00000
+    87 = 1.00000
+    89 = 1.00000
+    93 = 1.00000
+    94 = 1.00000
+    96 = 1.00000
+    97 = 1.00000
+    98 = 1.00000
+    99 = 1.00000
+    100 = 1.00000
+    105 = 1.00000
+    107 = 1.00000
+    111 = 1.00000
+    113 = 1.00000
+    120 = 1.00000
+    122 = 1.00000
+    126 = 1.00000
+    127 = 1.00000
+    135 = 1.00000
+    136 = 1.00000
+    137 = 1.00000
+    138 = 1.00000
+    139 = 1.00000
+    142 = 1.00000
+    143 = 1.00000
+    147 = 1.00000
+    148 = 1.00000
+    149 = 1.00000
+    150 = 1.00000
+    151 = 1.00000
+    153 = 1.00000
+    154 = 1.00000
+    157 = 1.00000
+    158 = 1.00000
+    166 = 1.00000
+    167 = 1.00000
+    172 = 1.00000
+    173 = 1.00000
+    180 = 1.00000
+    181 = 1.00000
+    189 = 1.00000
+    190 = 1.00000
+    195 = 1.00000
+    196 = 1.00000
+    198 = 1.00000
+    199 = 1.00000
+    216 = 1.00000
+    217 = 1.00000
+    225 = 1.00000
+    226 = 1.00000
+    227 = 1.00000
+    228 = 1.00000
+    230 = 1.00000
+    232 = 1.00000
+    233 = 1.00000
+    238 = 1.00000
+    239 = 1.00000
+    243 = 1.00000
+    245 = 1.00000
+    249 = 1.00000
+    250 = 1.00000
+    251 = 1.00000
+    252 = 1.00000
+    254 = 1.00000
+    256 = 1.00000
+    257 = 1.00000
+    262 = 1.00000
+    263 = 1.00000
+    267 = 1.00000
+    269 = 1.00000
+    279 = 1.00000
+    281 = 1.00000
+    288 = 1.00000
+    290 = 1.00000
+    294 = 1.00000
+    296 = 1.00000
+    303 = 1.00000
+    305 = 1.00000
+    316 = 1.00000
+    317 = 1.00000
+    322 = 1.00000
+    323 = 1.00000
+    331 = 1.00000
+    332 = 1.00000
+    337 = 1.00000
+    338 = 1.00000
+    375 = 1.00000
+    376 = 1.00000
+    377 = 1.00000
+    378 = 1.00000
+    379 = 1.00000
+    381 = 1.00000
+    383 = 1.00000
+    387 = 1.00000
+    388 = 1.00000
+    390 = 1.00000
+    391 = 1.00000
+    392 = 1.00000
+    393 = 1.00000
+    394 = 1.00000
+    399 = 1.00000
+    401 = 1.00000
+    405 = 1.00000
+    407 = 1.00000
+    414 = 1.00000
+    416 = 1.00000
+    420 = 1.00000
+    421 = 1.00000
+    429 = 1.00000
+    430 = 1.00000
+    431 = 1.00000
+    432 = 1.00000
+    433 = 1.00000
+    434 = 1.00000
+    435 = 1.00000
+    436 = 1.00000
+    437 = 1.00000
+    439 = 1.00000
+    440 = 1.00000
+    441 = 1.00000
+    442 = 1.00000
+    443 = 1.00000
+    444 = 1.00000
+    445 = 1.00000
+    446 = 1.00000
+    447 = 1.00000
+    448 = 1.00000
+    451 = 1.00000
+    452 = 1.00000
+    453 = 1.00000
+    455 = 1.00000
+    459 = 1.00000
+    460 = 1.00000
+    461 = 1.00000
+    463 = 1.00000
+    464 = 1.00000
+    466 = 1.00000
+    467 = 1.00000
+    468 = 1.00000
+    470 = 1.00000
+    474 = 1.00000
+    475 = 1.00000
+    483 = 1.00000
+    484 = 1.00000
+    489 = 1.00000
+    490 = 1.00000
+    492 = 1.00000
+    493 = 1.00000
+    510 = 1.00000
+    511 = 1.00000
+    519 = 1.00000
+    520 = 1.00000
+    521 = 1.00000
+    523 = 1.00000
+    524 = 1.00000
+    525 = 1.00000
+    526 = 1.00000
+    527 = 1.00000
+    528 = 1.00000
+    529 = 1.00000
+    532 = 1.00000
+    533 = 1.00000
+    538 = 1.00000
+    539 = 1.00000
+    541 = 1.00000
+    542 = 1.00000
+    546 = 1.00000
+    547 = 1.00000
+    555 = 1.00000
+    557 = 1.00000
+    564 = 1.00000
+    566 = 1.00000
+    570 = 1.00000
+    572 = 1.00000
+    579 = 1.00000
+    581 = 1.00000
+    591 = 1.00000
+    592 = 1.00000
+    593 = 1.00000
+    595 = 1.00000
+    596 = 1.00000
+    598 = 1.00000
+    599 = 1.00000
+    600 = 1.00000
+    602 = 1.00000
+    606 = 1.00000
+    607 = 1.00000
+    608 = 1.00000
+    610 = 1.00000
+    611 = 1.00000
+    613 = 1.00000
+    614 = 1.00000
+    615 = 1.00000
+    617 = 1.00000
+    652 = 1.00000
+    653 = 1.00000
+    655 = 1.00000
+    656 = 1.00000
+    661 = 1.00000
+    662 = 1.00000
+    664 = 1.00000
+    665 = 1.00000
+    675 = 1.00000
+    676 = 1.00000
+    677 = 1.00000
+    678 = 1.00000
+    679 = 1.00000
+    682 = 1.00000
+    683 = 1.00000
+    687 = 1.00000
+    688 = 1.00000
+    689 = 1.00000
+    690 = 1.00000
+    691 = 1.00000
+    693 = 1.00000
+    694 = 1.00000
+    697 = 1.00000
+    698 = 1.00000
+    706 = 1.00000
+    707 = 1.00000
+    712 = 1.00000
+    713 = 1.00000
+    720 = 1.00000
+    721 = 1.00000
+    729 = 1.00000
+    730 = 1.00000
+    735 = 1.00000
+    736 = 1.00000
+    738 = 1.00000
+    739 = 1.00000
+    756 = 1.00000
+    757 = 1.00000
+    765 = 1.00000
+    766 = 1.00000
+    767 = 1.00000
+    768 = 1.00000
+    769 = 1.00000
+    770 = 1.00000
+    771 = 1.00000
+    772 = 1.00000
+    773 = 1.00000
+    774 = 1.00000
+    776 = 1.00000
+    777 = 1.00000
+    778 = 1.00000
+    779 = 1.00000
+    780 = 1.00000
+    781 = 1.00000
+    783 = 1.00000
+    784 = 1.00000
+    785 = 1.00000
+    787 = 1.00000
+    788 = 1.00000
+    792 = 1.00000
+    794 = 1.00000
+    795 = 1.00000
+    796 = 1.00000
+    797 = 1.00000
+    798 = 1.00000
+    800 = 1.00000
+    802 = 1.00000
+    803 = 1.00000
+    807 = 1.00000
+    809 = 1.00000
+    810 = 1.00000
+    811 = 1.00000
+    819 = 1.00000
+    820 = 1.00000
+    821 = 1.00000
+    822 = 1.00000
+    824 = 1.00000
+    825 = 1.00000
+    826 = 1.00000
+    828 = 1.00000
+    829 = 1.00000
+    830 = 1.00000
+    834 = 1.00000
+    836 = 1.00000
+    837 = 1.00000
+    839 = 1.00000
+    843 = 1.00000
+    845 = 1.00000
+    846 = 1.00000
+    847 = 1.00000
+    856 = 1.00000
+    857 = 1.00000
+    862 = 1.00000
+    863 = 1.00000
+    871 = 1.00000
+    872 = 1.00000
+    877 = 1.00000
+    878 = 1.00000
+    915 = 1.00000
+    916 = 1.00000
+    917 = 1.00000
+    918 = 1.00000
+    920 = 1.00000
+    922 = 1.00000
+    923 = 1.00000
+    927 = 1.00000
+    929 = 1.00000
+    930 = 1.00000
+    931 = 1.00000
+    932 = 1.00000
+    933 = 1.00000
+    935 = 1.00000
+    937 = 1.00000
+    938 = 1.00000
+    942 = 1.00000
+    944 = 1.00000
+    951 = 1.00000
+    953 = 1.00000
+    957 = 1.00000
+    959 = 1.00000
+    960 = 1.00000
+    962 = 1.00000
+    966 = 1.00000
+    968 = 1.00000
+    975 = 1.00000
+    976 = 1.00000
+    981 = 1.00000
+    982 = 1.00000
+    984 = 1.00000
+    985 = 1.00000
+    1002 = 1.00000
+    1003 = 1.00000
+    1011 = 1.00000
+    1012 = 1.00000
+    1013 = 1.00000
+    1015 = 1.00000
+    1016 = 1.00000
+    1017 = 1.00000
+    1018 = 1.00000
+    1019 = 1.00000
+    1020 = 1.00000
+    1021 = 1.00000
+    1024 = 1.00000
+    1025 = 1.00000
+    1030 = 1.00000
+    1031 = 1.00000
+    1033 = 1.00000
+    1034 = 1.00000
+    1038 = 1.00000
+    1039 = 1.00000
+    1047 = 1.00000
+    1048 = 1.00000
+    1049 = 1.00000
+    1050 = 1.00000
+    1052 = 1.00000
+    1053 = 1.00000
+    1054 = 1.00000
+    1056 = 1.00000
+    1057 = 1.00000
+    1058 = 1.00000
+    1062 = 1.00000
+    1064 = 1.00000
+    1065 = 1.00000
+    1067 = 1.00000
+    1071 = 1.00000
+    1073 = 1.00000
+    1074 = 1.00000
+    1075 = 1.00000
+    1083 = 1.00000
+    1084 = 1.00000
+    1085 = 1.00000
+    1086 = 1.00000
+    1087 = 1.00000
+    1088 = 1.00000
+    1089 = 1.00000
+    1090 = 1.00000
+    1091 = 1.00000
+    1092 = 1.00000
+    1093 = 1.00000
+    1094 = 1.00000
+    1096 = 1.00000
+    1097 = 1.00000
+    1098 = 1.00000
+    1100 = 1.00000
+    1101 = 1.00000
+    1102 = 1.00000
+    1103 = 1.00000
+    1105 = 1.00000
+    1106 = 1.00000
+    1107 = 1.00000
+    1109 = 1.00000
+    1110 = 1.00000
+    1111 = 1.00000
+    1144 = 1.00000
+    1145 = 1.00000
+    1147 = 1.00000
+    1148 = 1.00000
+    1153 = 1.00000
+    1154 = 1.00000
+    1156 = 1.00000
+    1157 = 1.00000
+    1167 = 1.00000
+    1169 = 1.00000
+    1173 = 1.00000
+    1175 = 1.00000
+    1176 = 1.00000
+    1178 = 1.00000
+    1182 = 1.00000
+    1184 = 1.00000
+    1191 = 1.00000
+    1192 = 1.00000
+    1193 = 1.00000
+    1195 = 1.00000
+    1196 = 1.00000
+    1197 = 1.00000
+    1199 = 1.00000
+    1200 = 1.00000
+    1201 = 1.00000
+    1202 = 1.00000
+    1204 = 1.00000
+    1205 = 1.00000
+    1206 = 1.00000
+    1208 = 1.00000
+    1215 = 1.00000
+    1216 = 1.00000
+    1217 = 1.00000
+    1218 = 1.00000
+    1220 = 1.00000
+    1222 = 1.00000
+    1223 = 1.00000
+    1228 = 1.00000
+    1229 = 1.00000
+    1233 = 1.00000
+    1235 = 1.00000
+    1239 = 1.00000
+    1240 = 1.00000
+    1241 = 1.00000
+    1242 = 1.00000
+    1244 = 1.00000
+    1246 = 1.00000
+    1247 = 1.00000
+    1252 = 1.00000
+    1253 = 1.00000
+    1257 = 1.00000
+    1259 = 1.00000
+    1269 = 1.00000
+    1271 = 1.00000
+    1278 = 1.00000
+    1280 = 1.00000
+    1284 = 1.00000
+    1286 = 1.00000
+    1293 = 1.00000
+    1295 = 1.00000
+    1306 = 1.00000
+    1307 = 1.00000
+    1312 = 1.00000
+    1313 = 1.00000
+    1321 = 1.00000
+    1322 = 1.00000
+    1327 = 1.00000
+    1328 = 1.00000
+    1365 = 1.00000
+    1366 = 1.00000
+    1367 = 1.00000
+    1368 = 1.00000
+    1369 = 1.00000
+    1370 = 1.00000
+    1371 = 1.00000
+    1372 = 1.00000
+    1373 = 1.00000
+    1374 = 1.00000
+    1375 = 1.00000
+    1377 = 1.00000
+    1378 = 1.00000
+    1379 = 1.00000
+    1380 = 1.00000
+    1381 = 1.00000
+    1383 = 1.00000
+    1384 = 1.00000
+    1385 = 1.00000
+    1386 = 1.00000
+    1387 = 1.00000
+    1389 = 1.00000
+    1390 = 1.00000
+    1391 = 1.00000
+    1392 = 1.00000
+    1394 = 1.00000
+    1396 = 1.00000
+    1397 = 1.00000
+    1402 = 1.00000
+    1403 = 1.00000
+    1407 = 1.00000
+    1409 = 1.00000
+    1413 = 1.00000
+    1414 = 1.00000
+    1419 = 1.00000
+    1420 = 1.00000
+    1421 = 1.00000
+    1422 = 1.00000
+    1423 = 1.00000
+    1425 = 1.00000
+    1426 = 1.00000
+    1428 = 1.00000
+    1429 = 1.00000
+    1430 = 1.00000
+    1431 = 1.00000
+    1432 = 1.00000
+    1434 = 1.00000
+    1436 = 1.00000
+    1443 = 1.00000
+    1445 = 1.00000
+    1449 = 1.00000
+    1450 = 1.00000
+    1455 = 1.00000
+    1456 = 1.00000
+    1457 = 1.00000
+    1458 = 1.00000
+    1459 = 1.00000
+    1461 = 1.00000
+    1462 = 1.00000
+    1463 = 1.00000
+    1464 = 1.00000
+    1465 = 1.00000
+    1467 = 1.00000
+    1468 = 1.00000
+    1471 = 1.00000
+    1472 = 1.00000
+    1477 = 1.00000
+    1478 = 1.00000
+    1485 = 1.00000
+    1486 = 1.00000
+    1491 = 1.00000
+    1492 = 1.00000
+    1494 = 1.00000
+    1495 = 1.00000
+    1497 = 1.00000
+    1498 = 1.00000
+    1509 = 1.00000
+    1510 = 1.00000
+    1515 = 1.00000
+    1517 = 1.00000
+    1524 = 1.00000
+    1526 = 1.00000
+    1530 = 1.00000
+    1532 = 1.00000
+    1539 = 1.00000
+    1541 = 1.00000
+    1551 = 1.00000
+    1552 = 1.00000
+    1553 = 1.00000
+    1555 = 1.00000
+    1556 = 1.00000
+    1558 = 1.00000
+    1559 = 1.00000
+    1560 = 1.00000
+    1562 = 1.00000
+    1566 = 1.00000
+    1567 = 1.00000
+    1568 = 1.00000
+    1570 = 1.00000
+    1571 = 1.00000
+    1573 = 1.00000
+    1574 = 1.00000
+    1575 = 1.00000
+    1577 = 1.00000
+    1612 = 1.00000
+    1613 = 1.00000
+    1615 = 1.00000
+    1616 = 1.00000
+    1621 = 1.00000
+    1622 = 1.00000
+    1624 = 1.00000
+    1625 = 1.00000
+    1635 = 1.00000
+    1636 = 1.00000
+    1637 = 1.00000
+    1638 = 1.00000
+    1639 = 1.00000
+    1641 = 1.00000
+    1642 = 1.00000
+    1644 = 1.00000
+    1645 = 1.00000
+    1646 = 1.00000
+    1647 = 1.00000
+    1648 = 1.00000
+    1650 = 1.00000
+    1652 = 1.00000
+    1659 = 1.00000
+    1661 = 1.00000
+    1665 = 1.00000
+    1666 = 1.00000
+    1671 = 1.00000
+    1672 = 1.00000
+    1673 = 1.00000
+    1674 = 1.00000
+    1675 = 1.00000
+    1676 = 1.00000
+    1677 = 1.00000
+    1678 = 1.00000
+    1679 = 1.00000
+    1680 = 1.00000
+    1681 = 1.00000
+    1682 = 1.00000
+    1683 = 1.00000
+    1684 = 1.00000
+    1686 = 1.00000
+    1687 = 1.00000
+    1688 = 1.00000
+    1690 = 1.00000
+    1691 = 1.00000
+    1693 = 1.00000
+    1694 = 1.00000
+    1695 = 1.00000
+    1697 = 1.00000
+    1701 = 1.00000
+    1702 = 1.00000
+    1707 = 1.00000
+    1708 = 1.00000
+    1710 = 1.00000
+    1711 = 1.00000
+    1713 = 1.00000
+    1714 = 1.00000
+    1725 = 1.00000
+    1726 = 1.00000
+    1731 = 1.00000
+    1732 = 1.00000
+    1733 = 1.00000
+    1734 = 1.00000
+    1735 = 1.00000
+    1736 = 1.00000
+    1737 = 1.00000
+    1738 = 1.00000
+    1741 = 1.00000
+    1742 = 1.00000
+    1744 = 1.00000
+    1745 = 1.00000
+    1749 = 1.00000
+    1750 = 1.00000
+    1756 = 1.00000
+    1757 = 1.00000
+    1762 = 1.00000
+    1763 = 1.00000
+    1771 = 1.00000
+    1772 = 1.00000
+    1777 = 1.00000
+    1778 = 1.00000
+    1815 = 1.00000
+    1816 = 1.00000
+    1817 = 1.00000
+    1818 = 1.00000
+    1820 = 1.00000
+    1822 = 1.00000
+    1823 = 1.00000
+    1827 = 1.00000
+    1829 = 1.00000
+    1830 = 1.00000
+    1831 = 1.00000
+    1832 = 1.00000
+    1833 = 1.00000
+    1835 = 1.00000
+    1837 = 1.00000
+    1838 = 1.00000
+    1842 = 1.00000
+    1844 = 1.00000
+    1851 = 1.00000
+    1853 = 1.00000
+    1857 = 1.00000
+    1859 = 1.00000
+    1860 = 1.00000
+    1862 = 1.00000
+    1866 = 1.00000
+    1868 = 1.00000
+    1875 = 1.00000
+    1876 = 1.00000
+    1877 = 1.00000
+    1878 = 1.00000
+    1879 = 1.00000
+    1881 = 1.00000
+    1882 = 1.00000
+    1883 = 1.00000
+    1884 = 1.00000
+    1885 = 1.00000
+    1887 = 1.00000
+    1888 = 1.00000
+    1891 = 1.00000
+    1892 = 1.00000
+    1897 = 1.00000
+    1898 = 1.00000
+    1905 = 1.00000
+    1906 = 1.00000
+    1911 = 1.00000
+    1912 = 1.00000
+    1914 = 1.00000
+    1915 = 1.00000
+    1917 = 1.00000
+    1918 = 1.00000
+    1929 = 1.00000
+    1930 = 1.00000
+    1935 = 1.00000
+    1936 = 1.00000
+    1937 = 1.00000
+    1938 = 1.00000
+    1939 = 1.00000
+    1940 = 1.00000
+    1941 = 1.00000
+    1942 = 1.00000
+    1943 = 1.00000
+    1944 = 1.00000
+    1945 = 1.00000
+    1947 = 1.00000
+    1948 = 1.00000
+    1949 = 1.00000
+    1950 = 1.00000
+    1951 = 1.00000
+    1952 = 1.00000
+    1953 = 1.00000
+    1955 = 1.00000
+    1957 = 1.00000
+    1958 = 1.00000
+    1962 = 1.00000
+    1964 = 1.00000
+    1965 = 1.00000
+    1966 = 1.00000
+    1971 = 1.00000
+    1972 = 1.00000
+    1973 = 1.00000
+    1974 = 1.00000
+    1975 = 1.00000
+    1977 = 1.00000
+    1978 = 1.00000
+    1979 = 1.00000
+    1980 = 1.00000
+    1982 = 1.00000
+    1986 = 1.00000
+    1988 = 1.00000
+    1989 = 1.00000
+    1990 = 1.00000
+    2020 = 1.00000
+    2021 = 1.00000
+    2023 = 1.00000
+    2024 = 1.00000
+    2029 = 1.00000
+    2030 = 1.00000
+    2032 = 1.00000
+    2033 = 1.00000
+    2043 = 1.00000
+    2045 = 1.00000
+    2049 = 1.00000
+    2051 = 1.00000
+    2052 = 1.00000
+    2054 = 1.00000
+    2058 = 1.00000
+    2060 = 1.00000
+    2067 = 1.00000
+    2068 = 1.00000
+    2069 = 1.00000
+    2071 = 1.00000
+    2072 = 1.00000
+    2073 = 1.00000
+    2075 = 1.00000
+    2076 = 1.00000
+    2077 = 1.00000
+    2078 = 1.00000
+    2080 = 1.00000
+    2081 = 1.00000
+    2082 = 1.00000
+    2084 = 1.00000
+    2091 = 1.00000
+    2092 = 1.00000
+    2094 = 1.00000
+    2095 = 1.00000
+    2097 = 1.00000
+    2098 = 1.00000
+    2109 = 1.00000
+    2110 = 1.00000
+    2115 = 1.00000
+    2116 = 1.00000
+    2117 = 1.00000
+    2118 = 1.00000
+    2119 = 1.00000
+    2120 = 1.00000
+    2121 = 1.00000
+    2122 = 1.00000
+    2125 = 1.00000
+    2126 = 1.00000
+    2128 = 1.00000
+    2129 = 1.00000
+    2133 = 1.00000
+    2134 = 1.00000
+    2139 = 1.00000
+    2140 = 1.00000
+    2141 = 1.00000
+    2142 = 1.00000
+    2143 = 1.00000
+    2145 = 1.00000
+    2146 = 1.00000
+    2147 = 1.00000
+    2148 = 1.00000
+    2150 = 1.00000
+    2154 = 1.00000
+    2156 = 1.00000
+    2157 = 1.00000
+    2158 = 1.00000
+    2163 = 1.00000
+    2164 = 1.00000
+    2165 = 1.00000
+    2166 = 1.00000
+    2167 = 1.00000
+    2168 = 1.00000
+    2169 = 1.00000
+    2170 = 1.00000
+    2171 = 1.00000
+    2172 = 1.00000
+    2173 = 1.00000
+    2174 = 1.00000
+    2176 = 1.00000
+    2177 = 1.00000
+    2178 = 1.00000
+    2180 = 1.00000
+    2181 = 1.00000
+    2182 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(3)^3], case=0
+    1 = 1.00000
+    2 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    26 = 1.00000
+    28 = 1.00000
+    27 = 1.00000
+    29 = 1.00000
+    50 = 1.00000
+    52 = 1.00000
+    51 = 1.00000
+    53 = 1.00000
+    74 = 1.00000
+    76 = 1.00000
+    75 = 1.00000
+    77 = 1.00000
+    86 = 1.00000
+    88 = 1.00000
+    87 = 1.00000
+    89 = 1.00000
+    100 = 1.00000
+    104 = 1.00000
+    101 = 1.00000
+    105 = 1.00000
+    102 = 1.00000
+    106 = 1.00000
+    103 = 1.00000
+    107 = 1.00000
+    337 = 1.00000
+    338 = 1.00000
+    343 = 1.00000
+    344 = 1.00000
+    350 = 1.00000
+    352 = 1.00000
+    351 = 1.00000
+    353 = 1.00000
+    368 = 1.00000
+    370 = 1.00000
+    369 = 1.00000
+    371 = 1.00000
+    386 = 1.00000
+    388 = 1.00000
+    387 = 1.00000
+    389 = 1.00000
+    400 = 1.00000
+    404 = 1.00000
+    401 = 1.00000
+    405 = 1.00000
+    402 = 1.00000
+    406 = 1.00000
+    403 = 1.00000
+    407 = 1.00000
+    589 = 1.00000
+    590 = 1.00000
+    595 = 1.00000
+    596 = 1.00000
+    602 = 1.00000
+    604 = 1.00000
+    603 = 1.00000
+    605 = 1.00000
+    626 = 1.00000
+    628 = 1.00000
+    627 = 1.00000
+    629 = 1.00000
+    638 = 1.00000
+    640 = 1.00000
+    639 = 1.00000
+    641 = 1.00000
+    652 = 1.00000
+    656 = 1.00000
+    653 = 1.00000
+    657 = 1.00000
+    654 = 1.00000
+    658 = 1.00000
+    655 = 1.00000
+    659 = 1.00000
+    841 = 1.00000
+    842 = 1.00000
+    848 = 1.00000
+    850 = 1.00000
+    849 = 1.00000
+    851 = 1.00000
+    866 = 1.00000
+    868 = 1.00000
+    867 = 1.00000
+    869 = 1.00000
+    880 = 1.00000
+    884 = 1.00000
+    881 = 1.00000
+    885 = 1.00000
+    882 = 1.00000
+    886 = 1.00000
+    883 = 1.00000
+    887 = 1.00000
+    1912 = 1.00000
+    1913 = 1.00000
+    1918 = 1.00000
+    1919 = 1.00000
+    1925 = 1.00000
+    1927 = 1.00000
+    1926 = 1.00000
+    1928 = 1.00000
+    1943 = 1.00000
+    1945 = 1.00000
+    1944 = 1.00000
+    1946 = 1.00000
+    1961 = 1.00000
+    1963 = 1.00000
+    1962 = 1.00000
+    1964 = 1.00000
+    1975 = 1.00000
+    1979 = 1.00000
+    1976 = 1.00000
+    1980 = 1.00000
+    1977 = 1.00000
+    1981 = 1.00000
+    1978 = 1.00000
+    1982 = 1.00000
+    2164 = 1.00000
+    2165 = 1.00000
+    2170 = 1.00000
+    2171 = 1.00000
+    2177 = 1.00000
+    2179 = 1.00000
+    2178 = 1.00000
+    2180 = 1.00000
+    2195 = 1.00000
+    2197 = 1.00000
+    2196 = 1.00000
+    2198 = 1.00000
+    2213 = 1.00000
+    2215 = 1.00000
+    2214 = 1.00000
+    2216 = 1.00000
+    2227 = 1.00000
+    2231 = 1.00000
+    2228 = 1.00000
+    2232 = 1.00000
+    2229 = 1.00000
+    2233 = 1.00000
+    2230 = 1.00000
+    2234 = 1.00000
+    2416 = 1.00000
+    2417 = 1.00000
+    2423 = 1.00000
+    2425 = 1.00000
+    2424 = 1.00000
+    2426 = 1.00000
+    2441 = 1.00000
+    2443 = 1.00000
+    2442 = 1.00000
+    2444 = 1.00000
+    2455 = 1.00000
+    2459 = 1.00000
+    2456 = 1.00000
+    2460 = 1.00000
+    2457 = 1.00000
+    2461 = 1.00000
+    2458 = 1.00000
+    2462 = 1.00000
+    2605 = 1.00000
+    2606 = 1.00000
+    2612 = 1.00000
+    2614 = 1.00000
+    2613 = 1.00000
+    2615 = 1.00000
+    2630 = 1.00000
+    2632 = 1.00000
+    2631 = 1.00000
+    2633 = 1.00000
+    2644 = 1.00000
+    2648 = 1.00000
+    2645 = 1.00000
+    2649 = 1.00000
+    2646 = 1.00000
+    2650 = 1.00000
+    2647 = 1.00000
+    2651 = 1.00000
+    3550 = 1.00000
+    3551 = 1.00000
+    3556 = 1.00000
+    3557 = 1.00000
+    3563 = 1.00000
+    3565 = 1.00000
+    3564 = 1.00000
+    3566 = 1.00000
+    3587 = 1.00000
+    3589 = 1.00000
+    3588 = 1.00000
+    3590 = 1.00000
+    3599 = 1.00000
+    3601 = 1.00000
+    3600 = 1.00000
+    3602 = 1.00000
+    3613 = 1.00000
+    3617 = 1.00000
+    3614 = 1.00000
+    3618 = 1.00000
+    3615 = 1.00000
+    3619 = 1.00000
+    3616 = 1.00000
+    3620 = 1.00000
+    3802 = 1.00000
+    3803 = 1.00000
+    3809 = 1.00000
+    3811 = 1.00000
+    3810 = 1.00000
+    3812 = 1.00000
+    3827 = 1.00000
+    3829 = 1.00000
+    3828 = 1.00000
+    3830 = 1.00000
+    3841 = 1.00000
+    3845 = 1.00000
+    3842 = 1.00000
+    3846 = 1.00000
+    3843 = 1.00000
+    3847 = 1.00000
+    3844 = 1.00000
+    3848 = 1.00000
+    3991 = 1.00000
+    3992 = 1.00000
+    3997 = 1.00000
+    3998 = 1.00000
+    4004 = 1.00000
+    4006 = 1.00000
+    4005 = 1.00000
+    4007 = 1.00000
+    4028 = 1.00000
+    4030 = 1.00000
+    4029 = 1.00000
+    4031 = 1.00000
+    4040 = 1.00000
+    4042 = 1.00000
+    4041 = 1.00000
+    4043 = 1.00000
+    4054 = 1.00000
+    4058 = 1.00000
+    4055 = 1.00000
+    4059 = 1.00000
+    4056 = 1.00000
+    4060 = 1.00000
+    4057 = 1.00000
+    4061 = 1.00000
+    4243 = 1.00000
+    4244 = 1.00000
+    4250 = 1.00000
+    4252 = 1.00000
+    4251 = 1.00000
+    4253 = 1.00000
+    4268 = 1.00000
+    4270 = 1.00000
+    4269 = 1.00000
+    4271 = 1.00000
+    4282 = 1.00000
+    4286 = 1.00000
+    4283 = 1.00000
+    4287 = 1.00000
+    4284 = 1.00000
+    4288 = 1.00000
+    4285 = 1.00000
+    4289 = 1.00000
+    5188 = 1.00000
+    5189 = 1.00000
+    5195 = 1.00000
+    5197 = 1.00000
+    5196 = 1.00000
+    5198 = 1.00000
+    5213 = 1.00000
+    5215 = 1.00000
+    5214 = 1.00000
+    5216 = 1.00000
+    5227 = 1.00000
+    5231 = 1.00000
+    5228 = 1.00000
+    5232 = 1.00000
+    5229 = 1.00000
+    5233 = 1.00000
+    5230 = 1.00000
+    5234 = 1.00000
+    5377 = 1.00000
+    5378 = 1.00000
+    5384 = 1.00000
+    5386 = 1.00000
+    5385 = 1.00000
+    5387 = 1.00000
+    5402 = 1.00000
+    5404 = 1.00000
+    5403 = 1.00000
+    5405 = 1.00000
+    5416 = 1.00000
+    5420 = 1.00000
+    5417 = 1.00000
+    5421 = 1.00000
+    5418 = 1.00000
+    5422 = 1.00000
+    5419 = 1.00000
+    5423 = 1.00000
+    5566 = 1.00000
+    5567 = 1.00000
+    5573 = 1.00000
+    5575 = 1.00000
+    5574 = 1.00000
+    5576 = 1.00000
+    5591 = 1.00000
+    5593 = 1.00000
+    5592 = 1.00000
+    5594 = 1.00000
+    5605 = 1.00000
+    5609 = 1.00000
+    5606 = 1.00000
+    5610 = 1.00000
+    5607 = 1.00000
+    5611 = 1.00000
+    5608 = 1.00000
+    5612 = 1.00000
+    5755 = 1.00000
+    5756 = 1.00000
+    5762 = 1.00000
+    5764 = 1.00000
+    5763 = 1.00000
+    5765 = 1.00000
+    5780 = 1.00000
+    5782 = 1.00000
+    5781 = 1.00000
+    5783 = 1.00000
+    5794 = 1.00000
+    5798 = 1.00000
+    5795 = 1.00000
+    5799 = 1.00000
+    5796 = 1.00000
+    5800 = 1.00000
+    5797 = 1.00000
+    5801 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(3)^3], case=1
+    1 = 1.00000
+    2 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    26 = 1.00000
+    28 = 1.00000
+    27 = 1.00000
+    29 = 1.00000
+    50 = 1.00000
+    52 = 1.00000
+    51 = 1.00000
+    53 = 1.00000
+    74 = 1.00000
+    76 = 1.00000
+    75 = 1.00000
+    77 = 1.00000
+    86 = 1.00000
+    88 = 1.00000
+    87 = 1.00000
+    89 = 1.00000
+    100 = 1.00000
+    104 = 1.00000
+    101 = 1.00000
+    105 = 1.00000
+    102 = 1.00000
+    106 = 1.00000
+    103 = 1.00000
+    107 = 1.00000
+    337 = 1.00000
+    338 = 1.00000
+    343 = 1.00000
+    344 = 1.00000
+    350 = 1.00000
+    352 = 1.00000
+    351 = 1.00000
+    353 = 1.00000
+    368 = 1.00000
+    370 = 1.00000
+    369 = 1.00000
+    371 = 1.00000
+    386 = 1.00000
+    388 = 1.00000
+    387 = 1.00000
+    389 = 1.00000
+    400 = 1.00000
+    404 = 1.00000
+    401 = 1.00000
+    405 = 1.00000
+    402 = 1.00000
+    406 = 1.00000
+    403 = 1.00000
+    407 = 1.00000
+    589 = 1.00000
+    590 = 1.00000
+    595 = 1.00000
+    596 = 1.00000
+    602 = 1.00000
+    604 = 1.00000
+    603 = 1.00000
+    605 = 1.00000
+    626 = 1.00000
+    628 = 1.00000
+    627 = 1.00000
+    629 = 1.00000
+    638 = 1.00000
+    640 = 1.00000
+    639 = 1.00000
+    641 = 1.00000
+    652 = 1.00000
+    656 = 1.00000
+    653 = 1.00000
+    657 = 1.00000
+    654 = 1.00000
+    658 = 1.00000
+    655 = 1.00000
+    659 = 1.00000
+    841 = 1.00000
+    842 = 1.00000
+    848 = 1.00000
+    850 = 1.00000
+    849 = 1.00000
+    851 = 1.00000
+    866 = 1.00000
+    868 = 1.00000
+    867 = 1.00000
+    869 = 1.00000
+    880 = 1.00000
+    884 = 1.00000
+    881 = 1.00000
+    885 = 1.00000
+    882 = 1.00000
+    886 = 1.00000
+    883 = 1.00000
+    887 = 1.00000
+    1174 = 1.00000
+    1175 = 1.00000
+    1177 = 1.00000
+    1178 = 1.00000
+    1180 = 1.00000
+    1181 = 1.00000
+    1183 = 1.00000
+    1184 = 1.00000
+    1187 = 1.00000
+    1189 = 1.00000
+    1188 = 1.00000
+    1190 = 1.00000
+    1205 = 1.00000
+    1207 = 1.00000
+    1206 = 1.00000
+    1208 = 1.00000
+    1223 = 1.00000
+    1225 = 1.00000
+    1224 = 1.00000
+    1226 = 1.00000
+    1229 = 1.00000
+    1231 = 1.00000
+    1230 = 1.00000
+    1232 = 1.00000
+    1237 = 1.00000
+    1241 = 1.00000
+    1238 = 1.00000
+    1242 = 1.00000
+    1239 = 1.00000
+    1243 = 1.00000
+    1240 = 1.00000
+    1244 = 1.00000
+    1426 = 1.00000
+    1427 = 1.00000
+    1429 = 1.00000
+    1430 = 1.00000
+    1433 = 1.00000
+    1435 = 1.00000
+    1434 = 1.00000
+    1436 = 1.00000
+    1445 = 1.00000
+    1447 = 1.00000
+    1446 = 1.00000
+    1448 = 1.00000
+    1457 = 1.00000
+    1459 = 1.00000
+    1458 = 1.00000
+    1460 = 1.00000
+    1465 = 1.00000
+    1469 = 1.00000
+    1466 = 1.00000
+    1470 = 1.00000
+    1467 = 1.00000
+    1471 = 1.00000
+    1468 = 1.00000
+    1472 = 1.00000
+    1642 = 1.00000
+    1643 = 1.00000
+    1645 = 1.00000
+    1646 = 1.00000
+    1649 = 1.00000
+    1651 = 1.00000
+    1650 = 1.00000
+    1652 = 1.00000
+    1667 = 1.00000
+    1669 = 1.00000
+    1668 = 1.00000
+    1670 = 1.00000
+    1673 = 1.00000
+    1675 = 1.00000
+    1674 = 1.00000
+    1676 = 1.00000
+    1681 = 1.00000
+    1685 = 1.00000
+    1682 = 1.00000
+    1686 = 1.00000
+    1683 = 1.00000
+    1687 = 1.00000
+    1684 = 1.00000
+    1688 = 1.00000
+    1831 = 1.00000
+    1832 = 1.00000
+    1835 = 1.00000
+    1837 = 1.00000
+    1836 = 1.00000
+    1838 = 1.00000
+    1847 = 1.00000
+    1849 = 1.00000
+    1848 = 1.00000
+    1850 = 1.00000
+    1855 = 1.00000
+    1859 = 1.00000
+    1856 = 1.00000
+    1860 = 1.00000
+    1857 = 1.00000
+    1861 = 1.00000
+    1858 = 1.00000
+    1862 = 1.00000
+    1912 = 1.00000
+    1913 = 1.00000
+    1918 = 1.00000
+    1919 = 1.00000
+    1925 = 1.00000
+    1927 = 1.00000
+    1926 = 1.00000
+    1928 = 1.00000
+    1943 = 1.00000
+    1945 = 1.00000
+    1944 = 1.00000
+    1946 = 1.00000
+    1961 = 1.00000
+    1963 = 1.00000
+    1962 = 1.00000
+    1964 = 1.00000
+    1975 = 1.00000
+    1979 = 1.00000
+    1976 = 1.00000
+    1980 = 1.00000
+    1977 = 1.00000
+    1981 = 1.00000
+    1978 = 1.00000
+    1982 = 1.00000
+    2164 = 1.00000
+    2165 = 1.00000
+    2170 = 1.00000
+    2171 = 1.00000
+    2177 = 1.00000
+    2179 = 1.00000
+    2178 = 1.00000
+    2180 = 1.00000
+    2195 = 1.00000
+    2197 = 1.00000
+    2196 = 1.00000
+    2198 = 1.00000
+    2213 = 1.00000
+    2215 = 1.00000
+    2214 = 1.00000
+    2216 = 1.00000
+    2227 = 1.00000
+    2231 = 1.00000
+    2228 = 1.00000
+    2232 = 1.00000
+    2229 = 1.00000
+    2233 = 1.00000
+    2230 = 1.00000
+    2234 = 1.00000
+    2416 = 1.00000
+    2417 = 1.00000
+    2423 = 1.00000
+    2425 = 1.00000
+    2424 = 1.00000
+    2426 = 1.00000
+    2441 = 1.00000
+    2443 = 1.00000
+    2442 = 1.00000
+    2444 = 1.00000
+    2455 = 1.00000
+    2459 = 1.00000
+    2456 = 1.00000
+    2460 = 1.00000
+    2457 = 1.00000
+    2461 = 1.00000
+    2458 = 1.00000
+    2462 = 1.00000
+    2605 = 1.00000
+    2606 = 1.00000
+    2612 = 1.00000
+    2614 = 1.00000
+    2613 = 1.00000
+    2615 = 1.00000
+    2630 = 1.00000
+    2632 = 1.00000
+    2631 = 1.00000
+    2633 = 1.00000
+    2644 = 1.00000
+    2648 = 1.00000
+    2645 = 1.00000
+    2649 = 1.00000
+    2646 = 1.00000
+    2650 = 1.00000
+    2647 = 1.00000
+    2651 = 1.00000
+    2902 = 1.00000
+    2903 = 1.00000
+    2905 = 1.00000
+    2906 = 1.00000
+    2909 = 1.00000
+    2911 = 1.00000
+    2910 = 1.00000
+    2912 = 1.00000
+    2921 = 1.00000
+    2923 = 1.00000
+    2922 = 1.00000
+    2924 = 1.00000
+    2933 = 1.00000
+    2935 = 1.00000
+    2934 = 1.00000
+    2936 = 1.00000
+    2941 = 1.00000
+    2945 = 1.00000
+    2942 = 1.00000
+    2946 = 1.00000
+    2943 = 1.00000
+    2947 = 1.00000
+    2944 = 1.00000
+    2948 = 1.00000
+    3118 = 1.00000
+    3119 = 1.00000
+    3121 = 1.00000
+    3122 = 1.00000
+    3125 = 1.00000
+    3127 = 1.00000
+    3126 = 1.00000
+    3128 = 1.00000
+    3137 = 1.00000
+    3139 = 1.00000
+    3138 = 1.00000
+    3140 = 1.00000
+    3149 = 1.00000
+    3151 = 1.00000
+    3150 = 1.00000
+    3152 = 1.00000
+    3157 = 1.00000
+    3161 = 1.00000
+    3158 = 1.00000
+    3162 = 1.00000
+    3159 = 1.00000
+    3163 = 1.00000
+    3160 = 1.00000
+    3164 = 1.00000
+    3307 = 1.00000
+    3308 = 1.00000
+    3311 = 1.00000
+    3313 = 1.00000
+    3312 = 1.00000
+    3314 = 1.00000
+    3323 = 1.00000
+    3325 = 1.00000
+    3324 = 1.00000
+    3326 = 1.00000
+    3331 = 1.00000
+    3335 = 1.00000
+    3332 = 1.00000
+    3336 = 1.00000
+    3333 = 1.00000
+    3337 = 1.00000
+    3334 = 1.00000
+    3338 = 1.00000
+    3469 = 1.00000
+    3470 = 1.00000
+    3473 = 1.00000
+    3475 = 1.00000
+    3474 = 1.00000
+    3476 = 1.00000
+    3485 = 1.00000
+    3487 = 1.00000
+    3486 = 1.00000
+    3488 = 1.00000
+    3493 = 1.00000
+    3497 = 1.00000
+    3494 = 1.00000
+    3498 = 1.00000
+    3495 = 1.00000
+    3499 = 1.00000
+    3496 = 1.00000
+    3500 = 1.00000
+    3550 = 1.00000
+    3551 = 1.00000
+    3556 = 1.00000
+    3557 = 1.00000
+    3563 = 1.00000
+    3565 = 1.00000
+    3564 = 1.00000
+    3566 = 1.00000
+    3587 = 1.00000
+    3589 = 1.00000
+    3588 = 1.00000
+    3590 = 1.00000
+    3599 = 1.00000
+    3601 = 1.00000
+    3600 = 1.00000
+    3602 = 1.00000
+    3613 = 1.00000
+    3617 = 1.00000
+    3614 = 1.00000
+    3618 = 1.00000
+    3615 = 1.00000
+    3619 = 1.00000
+    3616 = 1.00000
+    3620 = 1.00000
+    3802 = 1.00000
+    3803 = 1.00000
+    3809 = 1.00000
+    3811 = 1.00000
+    3810 = 1.00000
+    3812 = 1.00000
+    3827 = 1.00000
+    3829 = 1.00000
+    3828 = 1.00000
+    3830 = 1.00000
+    3841 = 1.00000
+    3845 = 1.00000
+    3842 = 1.00000
+    3846 = 1.00000
+    3843 = 1.00000
+    3847 = 1.00000
+    3844 = 1.00000
+    3848 = 1.00000
+    3991 = 1.00000
+    3992 = 1.00000
+    3997 = 1.00000
+    3998 = 1.00000
+    4004 = 1.00000
+    4006 = 1.00000
+    4005 = 1.00000
+    4007 = 1.00000
+    4028 = 1.00000
+    4030 = 1.00000
+    4029 = 1.00000
+    4031 = 1.00000
+    4040 = 1.00000
+    4042 = 1.00000
+    4041 = 1.00000
+    4043 = 1.00000
+    4054 = 1.00000
+    4058 = 1.00000
+    4055 = 1.00000
+    4059 = 1.00000
+    4056 = 1.00000
+    4060 = 1.00000
+    4057 = 1.00000
+    4061 = 1.00000
+    4243 = 1.00000
+    4244 = 1.00000
+    4250 = 1.00000
+    4252 = 1.00000
+    4251 = 1.00000
+    4253 = 1.00000
+    4268 = 1.00000
+    4270 = 1.00000
+    4269 = 1.00000
+    4271 = 1.00000
+    4282 = 1.00000
+    4286 = 1.00000
+    4283 = 1.00000
+    4287 = 1.00000
+    4284 = 1.00000
+    4288 = 1.00000
+    4285 = 1.00000
+    4289 = 1.00000
+    4540 = 1.00000
+    4541 = 1.00000
+    4543 = 1.00000
+    4544 = 1.00000
+    4547 = 1.00000
+    4549 = 1.00000
+    4548 = 1.00000
+    4550 = 1.00000
+    4565 = 1.00000
+    4567 = 1.00000
+    4566 = 1.00000
+    4568 = 1.00000
+    4571 = 1.00000
+    4573 = 1.00000
+    4572 = 1.00000
+    4574 = 1.00000
+    4579 = 1.00000
+    4583 = 1.00000
+    4580 = 1.00000
+    4584 = 1.00000
+    4581 = 1.00000
+    4585 = 1.00000
+    4582 = 1.00000
+    4586 = 1.00000
+    4729 = 1.00000
+    4730 = 1.00000
+    4733 = 1.00000
+    4735 = 1.00000
+    4734 = 1.00000
+    4736 = 1.00000
+    4745 = 1.00000
+    4747 = 1.00000
+    4746 = 1.00000
+    4748 = 1.00000
+    4753 = 1.00000
+    4757 = 1.00000
+    4754 = 1.00000
+    4758 = 1.00000
+    4755 = 1.00000
+    4759 = 1.00000
+    4756 = 1.00000
+    4760 = 1.00000
+    4918 = 1.00000
+    4919 = 1.00000
+    4921 = 1.00000
+    4922 = 1.00000
+    4925 = 1.00000
+    4927 = 1.00000
+    4926 = 1.00000
+    4928 = 1.00000
+    4943 = 1.00000
+    4945 = 1.00000
+    4944 = 1.00000
+    4946 = 1.00000
+    4949 = 1.00000
+    4951 = 1.00000
+    4950 = 1.00000
+    4952 = 1.00000
+    4957 = 1.00000
+    4961 = 1.00000
+    4958 = 1.00000
+    4962 = 1.00000
+    4959 = 1.00000
+    4963 = 1.00000
+    4960 = 1.00000
+    4964 = 1.00000
+    5107 = 1.00000
+    5108 = 1.00000
+    5111 = 1.00000
+    5113 = 1.00000
+    5112 = 1.00000
+    5114 = 1.00000
+    5123 = 1.00000
+    5125 = 1.00000
+    5124 = 1.00000
+    5126 = 1.00000
+    5131 = 1.00000
+    5135 = 1.00000
+    5132 = 1.00000
+    5136 = 1.00000
+    5133 = 1.00000
+    5137 = 1.00000
+    5134 = 1.00000
+    5138 = 1.00000
+    5188 = 1.00000
+    5189 = 1.00000
+    5195 = 1.00000
+    5197 = 1.00000
+    5196 = 1.00000
+    5198 = 1.00000
+    5213 = 1.00000
+    5215 = 1.00000
+    5214 = 1.00000
+    5216 = 1.00000
+    5227 = 1.00000
+    5231 = 1.00000
+    5228 = 1.00000
+    5232 = 1.00000
+    5229 = 1.00000
+    5233 = 1.00000
+    5230 = 1.00000
+    5234 = 1.00000
+    5377 = 1.00000
+    5378 = 1.00000
+    5384 = 1.00000
+    5386 = 1.00000
+    5385 = 1.00000
+    5387 = 1.00000
+    5402 = 1.00000
+    5404 = 1.00000
+    5403 = 1.00000
+    5405 = 1.00000
+    5416 = 1.00000
+    5420 = 1.00000
+    5417 = 1.00000
+    5421 = 1.00000
+    5418 = 1.00000
+    5422 = 1.00000
+    5419 = 1.00000
+    5423 = 1.00000
+    5566 = 1.00000
+    5567 = 1.00000
+    5573 = 1.00000
+    5575 = 1.00000
+    5574 = 1.00000
+    5576 = 1.00000
+    5591 = 1.00000
+    5593 = 1.00000
+    5592 = 1.00000
+    5594 = 1.00000
+    5605 = 1.00000
+    5609 = 1.00000
+    5606 = 1.00000
+    5610 = 1.00000
+    5607 = 1.00000
+    5611 = 1.00000
+    5608 = 1.00000
+    5612 = 1.00000
+    5755 = 1.00000
+    5756 = 1.00000
+    5762 = 1.00000
+    5764 = 1.00000
+    5763 = 1.00000
+    5765 = 1.00000
+    5780 = 1.00000
+    5782 = 1.00000
+    5781 = 1.00000
+    5783 = 1.00000
+    5794 = 1.00000
+    5798 = 1.00000
+    5795 = 1.00000
+    5799 = 1.00000
+    5796 = 1.00000
+    5800 = 1.00000
+    5797 = 1.00000
+    5801 = 1.00000
+    6025 = 1.00000
+    6026 = 1.00000
+    6029 = 1.00000
+    6031 = 1.00000
+    6030 = 1.00000
+    6032 = 1.00000
+    6041 = 1.00000
+    6043 = 1.00000
+    6042 = 1.00000
+    6044 = 1.00000
+    6049 = 1.00000
+    6053 = 1.00000
+    6050 = 1.00000
+    6054 = 1.00000
+    6051 = 1.00000
+    6055 = 1.00000
+    6052 = 1.00000
+    6056 = 1.00000
+    6187 = 1.00000
+    6188 = 1.00000
+    6191 = 1.00000
+    6193 = 1.00000
+    6192 = 1.00000
+    6194 = 1.00000
+    6203 = 1.00000
+    6205 = 1.00000
+    6204 = 1.00000
+    6206 = 1.00000
+    6211 = 1.00000
+    6215 = 1.00000
+    6212 = 1.00000
+    6216 = 1.00000
+    6213 = 1.00000
+    6217 = 1.00000
+    6214 = 1.00000
+    6218 = 1.00000
+    6349 = 1.00000
+    6350 = 1.00000
+    6353 = 1.00000
+    6355 = 1.00000
+    6354 = 1.00000
+    6356 = 1.00000
+    6365 = 1.00000
+    6367 = 1.00000
+    6366 = 1.00000
+    6368 = 1.00000
+    6373 = 1.00000
+    6377 = 1.00000
+    6374 = 1.00000
+    6378 = 1.00000
+    6375 = 1.00000
+    6379 = 1.00000
+    6376 = 1.00000
+    6380 = 1.00000
+    6511 = 1.00000
+    6512 = 1.00000
+    6515 = 1.00000
+    6517 = 1.00000
+    6516 = 1.00000
+    6518 = 1.00000
+    6527 = 1.00000
+    6529 = 1.00000
+    6528 = 1.00000
+    6530 = 1.00000
+    6535 = 1.00000
+    6539 = 1.00000
+    6536 = 1.00000
+    6540 = 1.00000
+    6537 = 1.00000
+    6541 = 1.00000
+    6538 = 1.00000
+    6542 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(3)^3], case=2
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    3 = 1.00000
+    5 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    15 = 1.00000
+    17 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    26 = 1.00000
+    28 = 1.00000
+    27 = 1.00000
+    29 = 1.00000
+    36 = 1.00000
+    40 = 1.00000
+    37 = 1.00000
+    41 = 1.00000
+    50 = 1.00000
+    52 = 1.00000
+    51 = 1.00000
+    53 = 1.00000
+    60 = 1.00000
+    64 = 1.00000
+    61 = 1.00000
+    65 = 1.00000
+    72 = 1.00000
+    74 = 1.00000
+    76 = 1.00000
+    73 = 1.00000
+    75 = 1.00000
+    77 = 1.00000
+    78 = 1.00000
+    82 = 1.00000
+    79 = 1.00000
+    83 = 1.00000
+    86 = 1.00000
+    88 = 1.00000
+    87 = 1.00000
+    89 = 1.00000
+    100 = 1.00000
+    104 = 1.00000
+    101 = 1.00000
+    105 = 1.00000
+    102 = 1.00000
+    106 = 1.00000
+    103 = 1.00000
+    107 = 1.00000
+    120 = 1.00000
+    128 = 1.00000
+    121 = 1.00000
+    129 = 1.00000
+    122 = 1.00000
+    130 = 1.00000
+    123 = 1.00000
+    131 = 1.00000
+    192 = 1.00000
+    194 = 1.00000
+    198 = 1.00000
+    200 = 1.00000
+    210 = 1.00000
+    214 = 1.00000
+    211 = 1.00000
+    215 = 1.00000
+    228 = 1.00000
+    232 = 1.00000
+    229 = 1.00000
+    233 = 1.00000
+    240 = 1.00000
+    244 = 1.00000
+    241 = 1.00000
+    245 = 1.00000
+    264 = 1.00000
+    272 = 1.00000
+    265 = 1.00000
+    273 = 1.00000
+    266 = 1.00000
+    274 = 1.00000
+    267 = 1.00000
+    275 = 1.00000
+    337 = 1.00000
+    338 = 1.00000
+    343 = 1.00000
+    344 = 1.00000
+    350 = 1.00000
+    352 = 1.00000
+    351 = 1.00000
+    353 = 1.00000
+    368 = 1.00000
+    370 = 1.00000
+    369 = 1.00000
+    371 = 1.00000
+    386 = 1.00000
+    388 = 1.00000
+    387 = 1.00000
+    389 = 1.00000
+    400 = 1.00000
+    404 = 1.00000
+    401 = 1.00000
+    405 = 1.00000
+    402 = 1.00000
+    406 = 1.00000
+    403 = 1.00000
+    407 = 1.00000
+    588 = 1.00000
+    589 = 1.00000
+    590 = 1.00000
+    591 = 1.00000
+    593 = 1.00000
+    595 = 1.00000
+    596 = 1.00000
+    602 = 1.00000
+    604 = 1.00000
+    603 = 1.00000
+    605 = 1.00000
+    612 = 1.00000
+    616 = 1.00000
+    613 = 1.00000
+    617 = 1.00000
+    624 = 1.00000
+    626 = 1.00000
+    628 = 1.00000
+    625 = 1.00000
+    627 = 1.00000
+    629 = 1.00000
+    630 = 1.00000
+    634 = 1.00000
+    631 = 1.00000
+    635 = 1.00000
+    638 = 1.00000
+    640 = 1.00000
+    639 = 1.00000
+    641 = 1.00000
+    652 = 1.00000
+    656 = 1.00000
+    653 = 1.00000
+    657 = 1.00000
+    654 = 1.00000
+    658 = 1.00000
+    655 = 1.00000
+    659 = 1.00000
+    672 = 1.00000
+    680 = 1.00000
+    673 = 1.00000
+    681 = 1.00000
+    674 = 1.00000
+    682 = 1.00000
+    675 = 1.00000
+    683 = 1.00000
+    732 = 1.00000
+    734 = 1.00000
+    744 = 1.00000
+    748 = 1.00000
+    745 = 1.00000
+    749 = 1.00000
+    756 = 1.00000
+    760 = 1.00000
+    757 = 1.00000
+    761 = 1.00000
+    780 = 1.00000
+    788 = 1.00000
+    781 = 1.00000
+    789 = 1.00000
+    782 = 1.00000
+    790 = 1.00000
+    783 = 1.00000
+    791 = 1.00000
+    841 = 1.00000
+    842 = 1.00000
+    848 = 1.00000
+    850 = 1.00000
+    849 = 1.00000
+    851 = 1.00000
+    866 = 1.00000
+    868 = 1.00000
+    867 = 1.00000
+    869 = 1.00000
+    880 = 1.00000
+    884 = 1.00000
+    881 = 1.00000
+    885 = 1.00000
+    882 = 1.00000
+    886 = 1.00000
+    883 = 1.00000
+    887 = 1.00000
+    1029 = 1.00000
+    1031 = 1.00000
+    1035 = 1.00000
+    1037 = 1.00000
+    1047 = 1.00000
+    1051 = 1.00000
+    1048 = 1.00000
+    1052 = 1.00000
+    1065 = 1.00000
+    1069 = 1.00000
+    1066 = 1.00000
+    1070 = 1.00000
+    1077 = 1.00000
+    1081 = 1.00000
+    1078 = 1.00000
+    1082 = 1.00000
+    1101 = 1.00000
+    1109 = 1.00000
+    1102 = 1.00000
+    1110 = 1.00000
+    1103 = 1.00000
+    1111 = 1.00000
+    1104 = 1.00000
+    1112 = 1.00000
+    1173 = 1.00000
+    1174 = 1.00000
+    1175 = 1.00000
+    1177 = 1.00000
+    1178 = 1.00000
+    1179 = 1.00000
+    1180 = 1.00000
+    1181 = 1.00000
+    1183 = 1.00000
+    1184 = 1.00000
+    1187 = 1.00000
+    1189 = 1.00000
+    1188 = 1.00000
+    1190 = 1.00000
+    1191 = 1.00000
+    1195 = 1.00000
+    1192 = 1.00000
+    1196 = 1.00000
+    1205 = 1.00000
+    1207 = 1.00000
+    1206 = 1.00000
+    1208 = 1.00000
+    1209 = 1.00000
+    1213 = 1.00000
+    1210 = 1.00000
+    1214 = 1.00000
+    1221 = 1.00000
+    1223 = 1.00000
+    1225 = 1.00000
+    1222 = 1.00000
+    1224 = 1.00000
+    1226 = 1.00000
+    1229 = 1.00000
+    1231 = 1.00000
+    1230 = 1.00000
+    1232 = 1.00000
+    1237 = 1.00000
+    1241 = 1.00000
+    1238 = 1.00000
+    1242 = 1.00000
+    1239 = 1.00000
+    1243 = 1.00000
+    1240 = 1.00000
+    1244 = 1.00000
+    1245 = 1.00000
+    1253 = 1.00000
+    1246 = 1.00000
+    1254 = 1.00000
+    1247 = 1.00000
+    1255 = 1.00000
+    1248 = 1.00000
+    1256 = 1.00000
+    1426 = 1.00000
+    1427 = 1.00000
+    1429 = 1.00000
+    1430 = 1.00000
+    1433 = 1.00000
+    1435 = 1.00000
+    1434 = 1.00000
+    1436 = 1.00000
+    1445 = 1.00000
+    1447 = 1.00000
+    1446 = 1.00000
+    1448 = 1.00000
+    1457 = 1.00000
+    1459 = 1.00000
+    1458 = 1.00000
+    1460 = 1.00000
+    1465 = 1.00000
+    1469 = 1.00000
+    1466 = 1.00000
+    1470 = 1.00000
+    1467 = 1.00000
+    1471 = 1.00000
+    1468 = 1.00000
+    1472 = 1.00000
+    1533 = 1.00000
+    1535 = 1.00000
+    1545 = 1.00000
+    1549 = 1.00000
+    1546 = 1.00000
+    1550 = 1.00000
+    1557 = 1.00000
+    1561 = 1.00000
+    1558 = 1.00000
+    1562 = 1.00000
+    1581 = 1.00000
+    1589 = 1.00000
+    1582 = 1.00000
+    1590 = 1.00000
+    1583 = 1.00000
+    1591 = 1.00000
+    1584 = 1.00000
+    1592 = 1.00000
+    1641 = 1.00000
+    1642 = 1.00000
+    1643 = 1.00000
+    1645 = 1.00000
+    1646 = 1.00000
+    1649 = 1.00000
+    1651 = 1.00000
+    1650 = 1.00000
+    1652 = 1.00000
+    1653 = 1.00000
+    1657 = 1.00000
+    1654 = 1.00000
+    1658 = 1.00000
+    1665 = 1.00000
+    1667 = 1.00000
+    1669 = 1.00000
+    1666 = 1.00000
+    1668 = 1.00000
+    1670 = 1.00000
+    1673 = 1.00000
+    1675 = 1.00000
+    1674 = 1.00000
+    1676 = 1.00000
+    1681 = 1.00000
+    1685 = 1.00000
+    1682 = 1.00000
+    1686 = 1.00000
+    1683 = 1.00000
+    1687 = 1.00000
+    1684 = 1.00000
+    1688 = 1.00000
+    1689 = 1.00000
+    1697 = 1.00000
+    1690 = 1.00000
+    1698 = 1.00000
+    1691 = 1.00000
+    1699 = 1.00000
+    1692 = 1.00000
+    1700 = 1.00000
+    1831 = 1.00000
+    1832 = 1.00000
+    1835 = 1.00000
+    1837 = 1.00000
+    1836 = 1.00000
+    1838 = 1.00000
+    1847 = 1.00000
+    1849 = 1.00000
+    1848 = 1.00000
+    1850 = 1.00000
+    1855 = 1.00000
+    1859 = 1.00000
+    1856 = 1.00000
+    1860 = 1.00000
+    1857 = 1.00000
+    1861 = 1.00000
+    1858 = 1.00000
+    1862 = 1.00000
+    1912 = 1.00000
+    1913 = 1.00000
+    1918 = 1.00000
+    1919 = 1.00000
+    1925 = 1.00000
+    1927 = 1.00000
+    1926 = 1.00000
+    1928 = 1.00000
+    1943 = 1.00000
+    1945 = 1.00000
+    1944 = 1.00000
+    1946 = 1.00000
+    1961 = 1.00000
+    1963 = 1.00000
+    1962 = 1.00000
+    1964 = 1.00000
+    1975 = 1.00000
+    1979 = 1.00000
+    1976 = 1.00000
+    1980 = 1.00000
+    1977 = 1.00000
+    1981 = 1.00000
+    1978 = 1.00000
+    1982 = 1.00000
+    2164 = 1.00000
+    2165 = 1.00000
+    2170 = 1.00000
+    2171 = 1.00000
+    2177 = 1.00000
+    2179 = 1.00000
+    2178 = 1.00000
+    2180 = 1.00000
+    2195 = 1.00000
+    2197 = 1.00000
+    2196 = 1.00000
+    2198 = 1.00000
+    2213 = 1.00000
+    2215 = 1.00000
+    2214 = 1.00000
+    2216 = 1.00000
+    2227 = 1.00000
+    2231 = 1.00000
+    2228 = 1.00000
+    2232 = 1.00000
+    2229 = 1.00000
+    2233 = 1.00000
+    2230 = 1.00000
+    2234 = 1.00000
+    2416 = 1.00000
+    2417 = 1.00000
+    2423 = 1.00000
+    2425 = 1.00000
+    2424 = 1.00000
+    2426 = 1.00000
+    2441 = 1.00000
+    2443 = 1.00000
+    2442 = 1.00000
+    2444 = 1.00000
+    2455 = 1.00000
+    2459 = 1.00000
+    2456 = 1.00000
+    2460 = 1.00000
+    2457 = 1.00000
+    2461 = 1.00000
+    2458 = 1.00000
+    2462 = 1.00000
+    2605 = 1.00000
+    2606 = 1.00000
+    2612 = 1.00000
+    2614 = 1.00000
+    2613 = 1.00000
+    2615 = 1.00000
+    2630 = 1.00000
+    2632 = 1.00000
+    2631 = 1.00000
+    2633 = 1.00000
+    2644 = 1.00000
+    2648 = 1.00000
+    2645 = 1.00000
+    2649 = 1.00000
+    2646 = 1.00000
+    2650 = 1.00000
+    2647 = 1.00000
+    2651 = 1.00000
+    2902 = 1.00000
+    2903 = 1.00000
+    2905 = 1.00000
+    2906 = 1.00000
+    2909 = 1.00000
+    2911 = 1.00000
+    2910 = 1.00000
+    2912 = 1.00000
+    2921 = 1.00000
+    2923 = 1.00000
+    2922 = 1.00000
+    2924 = 1.00000
+    2933 = 1.00000
+    2935 = 1.00000
+    2934 = 1.00000
+    2936 = 1.00000
+    2941 = 1.00000
+    2945 = 1.00000
+    2942 = 1.00000
+    2946 = 1.00000
+    2943 = 1.00000
+    2947 = 1.00000
+    2944 = 1.00000
+    2948 = 1.00000
+    3118 = 1.00000
+    3119 = 1.00000
+    3121 = 1.00000
+    3122 = 1.00000
+    3125 = 1.00000
+    3127 = 1.00000
+    3126 = 1.00000
+    3128 = 1.00000
+    3137 = 1.00000
+    3139 = 1.00000
+    3138 = 1.00000
+    3140 = 1.00000
+    3149 = 1.00000
+    3151 = 1.00000
+    3150 = 1.00000
+    3152 = 1.00000
+    3157 = 1.00000
+    3161 = 1.00000
+    3158 = 1.00000
+    3162 = 1.00000
+    3159 = 1.00000
+    3163 = 1.00000
+    3160 = 1.00000
+    3164 = 1.00000
+    3307 = 1.00000
+    3308 = 1.00000
+    3311 = 1.00000
+    3313 = 1.00000
+    3312 = 1.00000
+    3314 = 1.00000
+    3323 = 1.00000
+    3325 = 1.00000
+    3324 = 1.00000
+    3326 = 1.00000
+    3331 = 1.00000
+    3335 = 1.00000
+    3332 = 1.00000
+    3336 = 1.00000
+    3333 = 1.00000
+    3337 = 1.00000
+    3334 = 1.00000
+    3338 = 1.00000
+    3469 = 1.00000
+    3470 = 1.00000
+    3473 = 1.00000
+    3475 = 1.00000
+    3474 = 1.00000
+    3476 = 1.00000
+    3485 = 1.00000
+    3487 = 1.00000
+    3486 = 1.00000
+    3488 = 1.00000
+    3493 = 1.00000
+    3497 = 1.00000
+    3494 = 1.00000
+    3498 = 1.00000
+    3495 = 1.00000
+    3499 = 1.00000
+    3496 = 1.00000
+    3500 = 1.00000
+    3549 = 1.00000
+    3550 = 1.00000
+    3551 = 1.00000
+    3552 = 1.00000
+    3554 = 1.00000
+    3556 = 1.00000
+    3557 = 1.00000
+    3563 = 1.00000
+    3565 = 1.00000
+    3564 = 1.00000
+    3566 = 1.00000
+    3573 = 1.00000
+    3577 = 1.00000
+    3574 = 1.00000
+    3578 = 1.00000
+    3585 = 1.00000
+    3587 = 1.00000
+    3589 = 1.00000
+    3586 = 1.00000
+    3588 = 1.00000
+    3590 = 1.00000
+    3591 = 1.00000
+    3595 = 1.00000
+    3592 = 1.00000
+    3596 = 1.00000
+    3599 = 1.00000
+    3601 = 1.00000
+    3600 = 1.00000
+    3602 = 1.00000
+    3613 = 1.00000
+    3617 = 1.00000
+    3614 = 1.00000
+    3618 = 1.00000
+    3615 = 1.00000
+    3619 = 1.00000
+    3616 = 1.00000
+    3620 = 1.00000
+    3633 = 1.00000
+    3641 = 1.00000
+    3634 = 1.00000
+    3642 = 1.00000
+    3635 = 1.00000
+    3643 = 1.00000
+    3636 = 1.00000
+    3644 = 1.00000
+    3693 = 1.00000
+    3695 = 1.00000
+    3705 = 1.00000
+    3709 = 1.00000
+    3706 = 1.00000
+    3710 = 1.00000
+    3717 = 1.00000
+    3721 = 1.00000
+    3718 = 1.00000
+    3722 = 1.00000
+    3741 = 1.00000
+    3749 = 1.00000
+    3742 = 1.00000
+    3750 = 1.00000
+    3743 = 1.00000
+    3751 = 1.00000
+    3744 = 1.00000
+    3752 = 1.00000
+    3802 = 1.00000
+    3803 = 1.00000
+    3809 = 1.00000
+    3811 = 1.00000
+    3810 = 1.00000
+    3812 = 1.00000
+    3827 = 1.00000
+    3829 = 1.00000
+    3828 = 1.00000
+    3830 = 1.00000
+    3841 = 1.00000
+    3845 = 1.00000
+    3842 = 1.00000
+    3846 = 1.00000
+    3843 = 1.00000
+    3847 = 1.00000
+    3844 = 1.00000
+    3848 = 1.00000
+    3990 = 1.00000
+    3991 = 1.00000
+    3992 = 1.00000
+    3993 = 1.00000
+    3995 = 1.00000
+    3997 = 1.00000
+    3998 = 1.00000
+    4004 = 1.00000
+    4006 = 1.00000
+    4005 = 1.00000
+    4007 = 1.00000
+    4014 = 1.00000
+    4018 = 1.00000
+    4015 = 1.00000
+    4019 = 1.00000
+    4026 = 1.00000
+    4028 = 1.00000
+    4030 = 1.00000
+    4027 = 1.00000
+    4029 = 1.00000
+    4031 = 1.00000
+    4032 = 1.00000
+    4036 = 1.00000
+    4033 = 1.00000
+    4037 = 1.00000
+    4040 = 1.00000
+    4042 = 1.00000
+    4041 = 1.00000
+    4043 = 1.00000
+    4054 = 1.00000
+    4058 = 1.00000
+    4055 = 1.00000
+    4059 = 1.00000
+    4056 = 1.00000
+    4060 = 1.00000
+    4057 = 1.00000
+    4061 = 1.00000
+    4074 = 1.00000
+    4082 = 1.00000
+    4075 = 1.00000
+    4083 = 1.00000
+    4076 = 1.00000
+    4084 = 1.00000
+    4077 = 1.00000
+    4085 = 1.00000
+    4134 = 1.00000
+    4136 = 1.00000
+    4146 = 1.00000
+    4150 = 1.00000
+    4147 = 1.00000
+    4151 = 1.00000
+    4158 = 1.00000
+    4162 = 1.00000
+    4159 = 1.00000
+    4163 = 1.00000
+    4182 = 1.00000
+    4190 = 1.00000
+    4183 = 1.00000
+    4191 = 1.00000
+    4184 = 1.00000
+    4192 = 1.00000
+    4185 = 1.00000
+    4193 = 1.00000
+    4243 = 1.00000
+    4244 = 1.00000
+    4250 = 1.00000
+    4252 = 1.00000
+    4251 = 1.00000
+    4253 = 1.00000
+    4268 = 1.00000
+    4270 = 1.00000
+    4269 = 1.00000
+    4271 = 1.00000
+    4282 = 1.00000
+    4286 = 1.00000
+    4283 = 1.00000
+    4287 = 1.00000
+    4284 = 1.00000
+    4288 = 1.00000
+    4285 = 1.00000
+    4289 = 1.00000
+    4431 = 1.00000
+    4433 = 1.00000
+    4443 = 1.00000
+    4447 = 1.00000
+    4444 = 1.00000
+    4448 = 1.00000
+    4455 = 1.00000
+    4459 = 1.00000
+    4456 = 1.00000
+    4460 = 1.00000
+    4479 = 1.00000
+    4487 = 1.00000
+    4480 = 1.00000
+    4488 = 1.00000
+    4481 = 1.00000
+    4489 = 1.00000
+    4482 = 1.00000
+    4490 = 1.00000
+    4539 = 1.00000
+    4540 = 1.00000
+    4541 = 1.00000
+    4543 = 1.00000
+    4544 = 1.00000
+    4547 = 1.00000
+    4549 = 1.00000
+    4548 = 1.00000
+    4550 = 1.00000
+    4551 = 1.00000
+    4555 = 1.00000
+    4552 = 1.00000
+    4556 = 1.00000
+    4563 = 1.00000
+    4565 = 1.00000
+    4567 = 1.00000
+    4564 = 1.00000
+    4566 = 1.00000
+    4568 = 1.00000
+    4571 = 1.00000
+    4573 = 1.00000
+    4572 = 1.00000
+    4574 = 1.00000
+    4579 = 1.00000
+    4583 = 1.00000
+    4580 = 1.00000
+    4584 = 1.00000
+    4581 = 1.00000
+    4585 = 1.00000
+    4582 = 1.00000
+    4586 = 1.00000
+    4587 = 1.00000
+    4595 = 1.00000
+    4588 = 1.00000
+    4596 = 1.00000
+    4589 = 1.00000
+    4597 = 1.00000
+    4590 = 1.00000
+    4598 = 1.00000
+    4729 = 1.00000
+    4730 = 1.00000
+    4733 = 1.00000
+    4735 = 1.00000
+    4734 = 1.00000
+    4736 = 1.00000
+    4745 = 1.00000
+    4747 = 1.00000
+    4746 = 1.00000
+    4748 = 1.00000
+    4753 = 1.00000
+    4757 = 1.00000
+    4754 = 1.00000
+    4758 = 1.00000
+    4755 = 1.00000
+    4759 = 1.00000
+    4756 = 1.00000
+    4760 = 1.00000
+    4809 = 1.00000
+    4811 = 1.00000
+    4821 = 1.00000
+    4825 = 1.00000
+    4822 = 1.00000
+    4826 = 1.00000
+    4833 = 1.00000
+    4837 = 1.00000
+    4834 = 1.00000
+    4838 = 1.00000
+    4857 = 1.00000
+    4865 = 1.00000
+    4858 = 1.00000
+    4866 = 1.00000
+    4859 = 1.00000
+    4867 = 1.00000
+    4860 = 1.00000
+    4868 = 1.00000
+    4917 = 1.00000
+    4918 = 1.00000
+    4919 = 1.00000
+    4921 = 1.00000
+    4922 = 1.00000
+    4925 = 1.00000
+    4927 = 1.00000
+    4926 = 1.00000
+    4928 = 1.00000
+    4929 = 1.00000
+    4933 = 1.00000
+    4930 = 1.00000
+    4934 = 1.00000
+    4941 = 1.00000
+    4943 = 1.00000
+    4945 = 1.00000
+    4942 = 1.00000
+    4944 = 1.00000
+    4946 = 1.00000
+    4949 = 1.00000
+    4951 = 1.00000
+    4950 = 1.00000
+    4952 = 1.00000
+    4957 = 1.00000
+    4961 = 1.00000
+    4958 = 1.00000
+    4962 = 1.00000
+    4959 = 1.00000
+    4963 = 1.00000
+    4960 = 1.00000
+    4964 = 1.00000
+    4965 = 1.00000
+    4973 = 1.00000
+    4966 = 1.00000
+    4974 = 1.00000
+    4967 = 1.00000
+    4975 = 1.00000
+    4968 = 1.00000
+    4976 = 1.00000
+    5107 = 1.00000
+    5108 = 1.00000
+    5111 = 1.00000
+    5113 = 1.00000
+    5112 = 1.00000
+    5114 = 1.00000
+    5123 = 1.00000
+    5125 = 1.00000
+    5124 = 1.00000
+    5126 = 1.00000
+    5131 = 1.00000
+    5135 = 1.00000
+    5132 = 1.00000
+    5136 = 1.00000
+    5133 = 1.00000
+    5137 = 1.00000
+    5134 = 1.00000
+    5138 = 1.00000
+    5188 = 1.00000
+    5189 = 1.00000
+    5195 = 1.00000
+    5197 = 1.00000
+    5196 = 1.00000
+    5198 = 1.00000
+    5213 = 1.00000
+    5215 = 1.00000
+    5214 = 1.00000
+    5216 = 1.00000
+    5227 = 1.00000
+    5231 = 1.00000
+    5228 = 1.00000
+    5232 = 1.00000
+    5229 = 1.00000
+    5233 = 1.00000
+    5230 = 1.00000
+    5234 = 1.00000
+    5377 = 1.00000
+    5378 = 1.00000
+    5384 = 1.00000
+    5386 = 1.00000
+    5385 = 1.00000
+    5387 = 1.00000
+    5402 = 1.00000
+    5404 = 1.00000
+    5403 = 1.00000
+    5405 = 1.00000
+    5416 = 1.00000
+    5420 = 1.00000
+    5417 = 1.00000
+    5421 = 1.00000
+    5418 = 1.00000
+    5422 = 1.00000
+    5419 = 1.00000
+    5423 = 1.00000
+    5566 = 1.00000
+    5567 = 1.00000
+    5573 = 1.00000
+    5575 = 1.00000
+    5574 = 1.00000
+    5576 = 1.00000
+    5591 = 1.00000
+    5593 = 1.00000
+    5592 = 1.00000
+    5594 = 1.00000
+    5605 = 1.00000
+    5609 = 1.00000
+    5606 = 1.00000
+    5610 = 1.00000
+    5607 = 1.00000
+    5611 = 1.00000
+    5608 = 1.00000
+    5612 = 1.00000
+    5755 = 1.00000
+    5756 = 1.00000
+    5762 = 1.00000
+    5764 = 1.00000
+    5763 = 1.00000
+    5765 = 1.00000
+    5780 = 1.00000
+    5782 = 1.00000
+    5781 = 1.00000
+    5783 = 1.00000
+    5794 = 1.00000
+    5798 = 1.00000
+    5795 = 1.00000
+    5799 = 1.00000
+    5796 = 1.00000
+    5800 = 1.00000
+    5797 = 1.00000
+    5801 = 1.00000
+    6025 = 1.00000
+    6026 = 1.00000
+    6029 = 1.00000
+    6031 = 1.00000
+    6030 = 1.00000
+    6032 = 1.00000
+    6041 = 1.00000
+    6043 = 1.00000
+    6042 = 1.00000
+    6044 = 1.00000
+    6049 = 1.00000
+    6053 = 1.00000
+    6050 = 1.00000
+    6054 = 1.00000
+    6051 = 1.00000
+    6055 = 1.00000
+    6052 = 1.00000
+    6056 = 1.00000
+    6187 = 1.00000
+    6188 = 1.00000
+    6191 = 1.00000
+    6193 = 1.00000
+    6192 = 1.00000
+    6194 = 1.00000
+    6203 = 1.00000
+    6205 = 1.00000
+    6204 = 1.00000
+    6206 = 1.00000
+    6211 = 1.00000
+    6215 = 1.00000
+    6212 = 1.00000
+    6216 = 1.00000
+    6213 = 1.00000
+    6217 = 1.00000
+    6214 = 1.00000
+    6218 = 1.00000
+    6349 = 1.00000
+    6350 = 1.00000
+    6353 = 1.00000
+    6355 = 1.00000
+    6354 = 1.00000
+    6356 = 1.00000
+    6365 = 1.00000
+    6367 = 1.00000
+    6366 = 1.00000
+    6368 = 1.00000
+    6373 = 1.00000
+    6377 = 1.00000
+    6374 = 1.00000
+    6378 = 1.00000
+    6375 = 1.00000
+    6379 = 1.00000
+    6376 = 1.00000
+    6380 = 1.00000
+    6511 = 1.00000
+    6512 = 1.00000
+    6515 = 1.00000
+    6517 = 1.00000
+    6516 = 1.00000
+    6518 = 1.00000
+    6527 = 1.00000
+    6529 = 1.00000
+    6528 = 1.00000
+    6530 = 1.00000
+    6535 = 1.00000
+    6539 = 1.00000
+    6536 = 1.00000
+    6540 = 1.00000
+    6537 = 1.00000
+    6541 = 1.00000
+    6538 = 1.00000
+    6542 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(3)^3], case=3
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    3 = 1.00000
+    5 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    15 = 1.00000
+    17 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    26 = 1.00000
+    28 = 1.00000
+    27 = 1.00000
+    29 = 1.00000
+    36 = 1.00000
+    40 = 1.00000
+    37 = 1.00000
+    41 = 1.00000
+    50 = 1.00000
+    52 = 1.00000
+    51 = 1.00000
+    53 = 1.00000
+    60 = 1.00000
+    64 = 1.00000
+    61 = 1.00000
+    65 = 1.00000
+    72 = 1.00000
+    74 = 1.00000
+    76 = 1.00000
+    73 = 1.00000
+    75 = 1.00000
+    77 = 1.00000
+    78 = 1.00000
+    82 = 1.00000
+    79 = 1.00000
+    83 = 1.00000
+    86 = 1.00000
+    88 = 1.00000
+    87 = 1.00000
+    89 = 1.00000
+    100 = 1.00000
+    104 = 1.00000
+    101 = 1.00000
+    105 = 1.00000
+    102 = 1.00000
+    106 = 1.00000
+    103 = 1.00000
+    107 = 1.00000
+    120 = 1.00000
+    128 = 1.00000
+    121 = 1.00000
+    129 = 1.00000
+    122 = 1.00000
+    130 = 1.00000
+    123 = 1.00000
+    131 = 1.00000
+    192 = 1.00000
+    194 = 1.00000
+    198 = 1.00000
+    200 = 1.00000
+    210 = 1.00000
+    214 = 1.00000
+    211 = 1.00000
+    215 = 1.00000
+    228 = 1.00000
+    232 = 1.00000
+    229 = 1.00000
+    233 = 1.00000
+    240 = 1.00000
+    244 = 1.00000
+    241 = 1.00000
+    245 = 1.00000
+    264 = 1.00000
+    272 = 1.00000
+    265 = 1.00000
+    273 = 1.00000
+    266 = 1.00000
+    274 = 1.00000
+    267 = 1.00000
+    275 = 1.00000
+    337 = 1.00000
+    338 = 1.00000
+    343 = 1.00000
+    344 = 1.00000
+    350 = 1.00000
+    352 = 1.00000
+    351 = 1.00000
+    353 = 1.00000
+    368 = 1.00000
+    370 = 1.00000
+    369 = 1.00000
+    371 = 1.00000
+    386 = 1.00000
+    388 = 1.00000
+    387 = 1.00000
+    389 = 1.00000
+    400 = 1.00000
+    404 = 1.00000
+    401 = 1.00000
+    405 = 1.00000
+    402 = 1.00000
+    406 = 1.00000
+    403 = 1.00000
+    407 = 1.00000
+    588 = 1.00000
+    589 = 1.00000
+    590 = 1.00000
+    591 = 1.00000
+    593 = 1.00000
+    595 = 1.00000
+    596 = 1.00000
+    602 = 1.00000
+    604 = 1.00000
+    603 = 1.00000
+    605 = 1.00000
+    612 = 1.00000
+    616 = 1.00000
+    613 = 1.00000
+    617 = 1.00000
+    624 = 1.00000
+    626 = 1.00000
+    628 = 1.00000
+    625 = 1.00000
+    627 = 1.00000
+    629 = 1.00000
+    630 = 1.00000
+    634 = 1.00000
+    631 = 1.00000
+    635 = 1.00000
+    638 = 1.00000
+    640 = 1.00000
+    639 = 1.00000
+    641 = 1.00000
+    652 = 1.00000
+    656 = 1.00000
+    653 = 1.00000
+    657 = 1.00000
+    654 = 1.00000
+    658 = 1.00000
+    655 = 1.00000
+    659 = 1.00000
+    672 = 1.00000
+    680 = 1.00000
+    673 = 1.00000
+    681 = 1.00000
+    674 = 1.00000
+    682 = 1.00000
+    675 = 1.00000
+    683 = 1.00000
+    732 = 1.00000
+    734 = 1.00000
+    744 = 1.00000
+    748 = 1.00000
+    745 = 1.00000
+    749 = 1.00000
+    756 = 1.00000
+    760 = 1.00000
+    757 = 1.00000
+    761 = 1.00000
+    780 = 1.00000
+    788 = 1.00000
+    781 = 1.00000
+    789 = 1.00000
+    782 = 1.00000
+    790 = 1.00000
+    783 = 1.00000
+    791 = 1.00000
+    841 = 1.00000
+    842 = 1.00000
+    848 = 1.00000
+    850 = 1.00000
+    849 = 1.00000
+    851 = 1.00000
+    866 = 1.00000
+    868 = 1.00000
+    867 = 1.00000
+    869 = 1.00000
+    880 = 1.00000
+    884 = 1.00000
+    881 = 1.00000
+    885 = 1.00000
+    882 = 1.00000
+    886 = 1.00000
+    883 = 1.00000
+    887 = 1.00000
+    1029 = 1.00000
+    1031 = 1.00000
+    1035 = 1.00000
+    1037 = 1.00000
+    1047 = 1.00000
+    1051 = 1.00000
+    1048 = 1.00000
+    1052 = 1.00000
+    1065 = 1.00000
+    1069 = 1.00000
+    1066 = 1.00000
+    1070 = 1.00000
+    1077 = 1.00000
+    1081 = 1.00000
+    1078 = 1.00000
+    1082 = 1.00000
+    1101 = 1.00000
+    1109 = 1.00000
+    1102 = 1.00000
+    1110 = 1.00000
+    1103 = 1.00000
+    1111 = 1.00000
+    1104 = 1.00000
+    1112 = 1.00000
+    1173 = 1.00000
+    1174 = 1.00000
+    1175 = 1.00000
+    1177 = 1.00000
+    1178 = 1.00000
+    1179 = 1.00000
+    1180 = 1.00000
+    1181 = 1.00000
+    1183 = 1.00000
+    1184 = 1.00000
+    1187 = 1.00000
+    1189 = 1.00000
+    1188 = 1.00000
+    1190 = 1.00000
+    1191 = 1.00000
+    1195 = 1.00000
+    1192 = 1.00000
+    1196 = 1.00000
+    1205 = 1.00000
+    1207 = 1.00000
+    1206 = 1.00000
+    1208 = 1.00000
+    1209 = 1.00000
+    1213 = 1.00000
+    1210 = 1.00000
+    1214 = 1.00000
+    1221 = 1.00000
+    1223 = 1.00000
+    1225 = 1.00000
+    1222 = 1.00000
+    1224 = 1.00000
+    1226 = 1.00000
+    1229 = 1.00000
+    1231 = 1.00000
+    1230 = 1.00000
+    1232 = 1.00000
+    1237 = 1.00000
+    1241 = 1.00000
+    1238 = 1.00000
+    1242 = 1.00000
+    1239 = 1.00000
+    1243 = 1.00000
+    1240 = 1.00000
+    1244 = 1.00000
+    1245 = 1.00000
+    1253 = 1.00000
+    1246 = 1.00000
+    1254 = 1.00000
+    1247 = 1.00000
+    1255 = 1.00000
+    1248 = 1.00000
+    1256 = 1.00000
+    1426 = 1.00000
+    1427 = 1.00000
+    1429 = 1.00000
+    1430 = 1.00000
+    1433 = 1.00000
+    1435 = 1.00000
+    1434 = 1.00000
+    1436 = 1.00000
+    1445 = 1.00000
+    1447 = 1.00000
+    1446 = 1.00000
+    1448 = 1.00000
+    1457 = 1.00000
+    1459 = 1.00000
+    1458 = 1.00000
+    1460 = 1.00000
+    1465 = 1.00000
+    1469 = 1.00000
+    1466 = 1.00000
+    1470 = 1.00000
+    1467 = 1.00000
+    1471 = 1.00000
+    1468 = 1.00000
+    1472 = 1.00000
+    1533 = 1.00000
+    1535 = 1.00000
+    1545 = 1.00000
+    1549 = 1.00000
+    1546 = 1.00000
+    1550 = 1.00000
+    1557 = 1.00000
+    1561 = 1.00000
+    1558 = 1.00000
+    1562 = 1.00000
+    1581 = 1.00000
+    1589 = 1.00000
+    1582 = 1.00000
+    1590 = 1.00000
+    1583 = 1.00000
+    1591 = 1.00000
+    1584 = 1.00000
+    1592 = 1.00000
+    1641 = 1.00000
+    1642 = 1.00000
+    1643 = 1.00000
+    1645 = 1.00000
+    1646 = 1.00000
+    1649 = 1.00000
+    1651 = 1.00000
+    1650 = 1.00000
+    1652 = 1.00000
+    1653 = 1.00000
+    1657 = 1.00000
+    1654 = 1.00000
+    1658 = 1.00000
+    1665 = 1.00000
+    1667 = 1.00000
+    1669 = 1.00000
+    1666 = 1.00000
+    1668 = 1.00000
+    1670 = 1.00000
+    1673 = 1.00000
+    1675 = 1.00000
+    1674 = 1.00000
+    1676 = 1.00000
+    1681 = 1.00000
+    1685 = 1.00000
+    1682 = 1.00000
+    1686 = 1.00000
+    1683 = 1.00000
+    1687 = 1.00000
+    1684 = 1.00000
+    1688 = 1.00000
+    1689 = 1.00000
+    1697 = 1.00000
+    1690 = 1.00000
+    1698 = 1.00000
+    1691 = 1.00000
+    1699 = 1.00000
+    1692 = 1.00000
+    1700 = 1.00000
+    1831 = 1.00000
+    1832 = 1.00000
+    1835 = 1.00000
+    1837 = 1.00000
+    1836 = 1.00000
+    1838 = 1.00000
+    1847 = 1.00000
+    1849 = 1.00000
+    1848 = 1.00000
+    1850 = 1.00000
+    1855 = 1.00000
+    1859 = 1.00000
+    1856 = 1.00000
+    1860 = 1.00000
+    1857 = 1.00000
+    1861 = 1.00000
+    1858 = 1.00000
+    1862 = 1.00000
+    1912 = 1.00000
+    1913 = 1.00000
+    1918 = 1.00000
+    1919 = 1.00000
+    1925 = 1.00000
+    1927 = 1.00000
+    1926 = 1.00000
+    1928 = 1.00000
+    1943 = 1.00000
+    1945 = 1.00000
+    1944 = 1.00000
+    1946 = 1.00000
+    1961 = 1.00000
+    1963 = 1.00000
+    1962 = 1.00000
+    1964 = 1.00000
+    1975 = 1.00000
+    1979 = 1.00000
+    1976 = 1.00000
+    1980 = 1.00000
+    1977 = 1.00000
+    1981 = 1.00000
+    1978 = 1.00000
+    1982 = 1.00000
+    2163 = 1.00000
+    2164 = 1.00000
+    2165 = 1.00000
+    2166 = 1.00000
+    2168 = 1.00000
+    2169 = 1.00000
+    2170 = 1.00000
+    2171 = 1.00000
+    2172 = 1.00000
+    2174 = 1.00000
+    2177 = 1.00000
+    2179 = 1.00000
+    2178 = 1.00000
+    2180 = 1.00000
+    2187 = 1.00000
+    2191 = 1.00000
+    2188 = 1.00000
+    2192 = 1.00000
+    2195 = 1.00000
+    2197 = 1.00000
+    2196 = 1.00000
+    2198 = 1.00000
+    2205 = 1.00000
+    2209 = 1.00000
+    2206 = 1.00000
+    2210 = 1.00000
+    2211 = 1.00000
+    2213 = 1.00000
+    2215 = 1.00000
+    2212 = 1.00000
+    2214 = 1.00000
+    2216 = 1.00000
+    2217 = 1.00000
+    2221 = 1.00000
+    2218 = 1.00000
+    2222 = 1.00000
+    2227 = 1.00000
+    2231 = 1.00000
+    2228 = 1.00000
+    2232 = 1.00000
+    2229 = 1.00000
+    2233 = 1.00000
+    2230 = 1.00000
+    2234 = 1.00000
+    2247 = 1.00000
+    2255 = 1.00000
+    2248 = 1.00000
+    2256 = 1.00000
+    2249 = 1.00000
+    2257 = 1.00000
+    2250 = 1.00000
+    2258 = 1.00000
+    2307 = 1.00000
+    2309 = 1.00000
+    2310 = 1.00000
+    2312 = 1.00000
+    2319 = 1.00000
+    2323 = 1.00000
+    2320 = 1.00000
+    2324 = 1.00000
+    2331 = 1.00000
+    2335 = 1.00000
+    2332 = 1.00000
+    2336 = 1.00000
+    2337 = 1.00000
+    2341 = 1.00000
+    2338 = 1.00000
+    2342 = 1.00000
+    2355 = 1.00000
+    2363 = 1.00000
+    2356 = 1.00000
+    2364 = 1.00000
+    2357 = 1.00000
+    2365 = 1.00000
+    2358 = 1.00000
+    2366 = 1.00000
+    2416 = 1.00000
+    2417 = 1.00000
+    2423 = 1.00000
+    2425 = 1.00000
+    2424 = 1.00000
+    2426 = 1.00000
+    2441 = 1.00000
+    2443 = 1.00000
+    2442 = 1.00000
+    2444 = 1.00000
+    2455 = 1.00000
+    2459 = 1.00000
+    2456 = 1.00000
+    2460 = 1.00000
+    2457 = 1.00000
+    2461 = 1.00000
+    2458 = 1.00000
+    2462 = 1.00000
+    2604 = 1.00000
+    2605 = 1.00000
+    2606 = 1.00000
+    2607 = 1.00000
+    2609 = 1.00000
+    2612 = 1.00000
+    2614 = 1.00000
+    2613 = 1.00000
+    2615 = 1.00000
+    2622 = 1.00000
+    2626 = 1.00000
+    2623 = 1.00000
+    2627 = 1.00000
+    2628 = 1.00000
+    2630 = 1.00000
+    2632 = 1.00000
+    2629 = 1.00000
+    2631 = 1.00000
+    2633 = 1.00000
+    2634 = 1.00000
+    2638 = 1.00000
+    2635 = 1.00000
+    2639 = 1.00000
+    2644 = 1.00000
+    2648 = 1.00000
+    2645 = 1.00000
+    2649 = 1.00000
+    2646 = 1.00000
+    2650 = 1.00000
+    2647 = 1.00000
+    2651 = 1.00000
+    2664 = 1.00000
+    2672 = 1.00000
+    2665 = 1.00000
+    2673 = 1.00000
+    2666 = 1.00000
+    2674 = 1.00000
+    2667 = 1.00000
+    2675 = 1.00000
+    2712 = 1.00000
+    2714 = 1.00000
+    2721 = 1.00000
+    2725 = 1.00000
+    2722 = 1.00000
+    2726 = 1.00000
+    2727 = 1.00000
+    2731 = 1.00000
+    2728 = 1.00000
+    2732 = 1.00000
+    2745 = 1.00000
+    2753 = 1.00000
+    2746 = 1.00000
+    2754 = 1.00000
+    2747 = 1.00000
+    2755 = 1.00000
+    2748 = 1.00000
+    2756 = 1.00000
+    2902 = 1.00000
+    2903 = 1.00000
+    2905 = 1.00000
+    2906 = 1.00000
+    2909 = 1.00000
+    2911 = 1.00000
+    2910 = 1.00000
+    2912 = 1.00000
+    2921 = 1.00000
+    2923 = 1.00000
+    2922 = 1.00000
+    2924 = 1.00000
+    2933 = 1.00000
+    2935 = 1.00000
+    2934 = 1.00000
+    2936 = 1.00000
+    2941 = 1.00000
+    2945 = 1.00000
+    2942 = 1.00000
+    2946 = 1.00000
+    2943 = 1.00000
+    2947 = 1.00000
+    2944 = 1.00000
+    2948 = 1.00000
+    3009 = 1.00000
+    3011 = 1.00000
+    3012 = 1.00000
+    3014 = 1.00000
+    3021 = 1.00000
+    3025 = 1.00000
+    3022 = 1.00000
+    3026 = 1.00000
+    3033 = 1.00000
+    3037 = 1.00000
+    3034 = 1.00000
+    3038 = 1.00000
+    3039 = 1.00000
+    3043 = 1.00000
+    3040 = 1.00000
+    3044 = 1.00000
+    3057 = 1.00000
+    3065 = 1.00000
+    3058 = 1.00000
+    3066 = 1.00000
+    3059 = 1.00000
+    3067 = 1.00000
+    3060 = 1.00000
+    3068 = 1.00000
+    3117 = 1.00000
+    3118 = 1.00000
+    3119 = 1.00000
+    3120 = 1.00000
+    3121 = 1.00000
+    3122 = 1.00000
+    3125 = 1.00000
+    3127 = 1.00000
+    3126 = 1.00000
+    3128 = 1.00000
+    3129 = 1.00000
+    3133 = 1.00000
+    3130 = 1.00000
+    3134 = 1.00000
+    3137 = 1.00000
+    3139 = 1.00000
+    3138 = 1.00000
+    3140 = 1.00000
+    3141 = 1.00000
+    3145 = 1.00000
+    3142 = 1.00000
+    3146 = 1.00000
+    3147 = 1.00000
+    3149 = 1.00000
+    3151 = 1.00000
+    3148 = 1.00000
+    3150 = 1.00000
+    3152 = 1.00000
+    3157 = 1.00000
+    3161 = 1.00000
+    3158 = 1.00000
+    3162 = 1.00000
+    3159 = 1.00000
+    3163 = 1.00000
+    3160 = 1.00000
+    3164 = 1.00000
+    3165 = 1.00000
+    3173 = 1.00000
+    3166 = 1.00000
+    3174 = 1.00000
+    3167 = 1.00000
+    3175 = 1.00000
+    3168 = 1.00000
+    3176 = 1.00000
+    3307 = 1.00000
+    3308 = 1.00000
+    3311 = 1.00000
+    3313 = 1.00000
+    3312 = 1.00000
+    3314 = 1.00000
+    3323 = 1.00000
+    3325 = 1.00000
+    3324 = 1.00000
+    3326 = 1.00000
+    3331 = 1.00000
+    3335 = 1.00000
+    3332 = 1.00000
+    3336 = 1.00000
+    3333 = 1.00000
+    3337 = 1.00000
+    3334 = 1.00000
+    3338 = 1.00000
+    3387 = 1.00000
+    3389 = 1.00000
+    3396 = 1.00000
+    3400 = 1.00000
+    3397 = 1.00000
+    3401 = 1.00000
+    3402 = 1.00000
+    3406 = 1.00000
+    3403 = 1.00000
+    3407 = 1.00000
+    3420 = 1.00000
+    3428 = 1.00000
+    3421 = 1.00000
+    3429 = 1.00000
+    3422 = 1.00000
+    3430 = 1.00000
+    3423 = 1.00000
+    3431 = 1.00000
+    3468 = 1.00000
+    3469 = 1.00000
+    3470 = 1.00000
+    3473 = 1.00000
+    3475 = 1.00000
+    3474 = 1.00000
+    3476 = 1.00000
+    3477 = 1.00000
+    3481 = 1.00000
+    3478 = 1.00000
+    3482 = 1.00000
+    3483 = 1.00000
+    3485 = 1.00000
+    3487 = 1.00000
+    3484 = 1.00000
+    3486 = 1.00000
+    3488 = 1.00000
+    3493 = 1.00000
+    3497 = 1.00000
+    3494 = 1.00000
+    3498 = 1.00000
+    3495 = 1.00000
+    3499 = 1.00000
+    3496 = 1.00000
+    3500 = 1.00000
+    3501 = 1.00000
+    3509 = 1.00000
+    3502 = 1.00000
+    3510 = 1.00000
+    3503 = 1.00000
+    3511 = 1.00000
+    3504 = 1.00000
+    3512 = 1.00000
+    3549 = 1.00000
+    3550 = 1.00000
+    3551 = 1.00000
+    3552 = 1.00000
+    3554 = 1.00000
+    3556 = 1.00000
+    3557 = 1.00000
+    3563 = 1.00000
+    3565 = 1.00000
+    3564 = 1.00000
+    3566 = 1.00000
+    3573 = 1.00000
+    3577 = 1.00000
+    3574 = 1.00000
+    3578 = 1.00000
+    3585 = 1.00000
+    3587 = 1.00000
+    3589 = 1.00000
+    3586 = 1.00000
+    3588 = 1.00000
+    3590 = 1.00000
+    3591 = 1.00000
+    3595 = 1.00000
+    3592 = 1.00000
+    3596 = 1.00000
+    3599 = 1.00000
+    3601 = 1.00000
+    3600 = 1.00000
+    3602 = 1.00000
+    3613 = 1.00000
+    3617 = 1.00000
+    3614 = 1.00000
+    3618 = 1.00000
+    3615 = 1.00000
+    3619 = 1.00000
+    3616 = 1.00000
+    3620 = 1.00000
+    3633 = 1.00000
+    3641 = 1.00000
+    3634 = 1.00000
+    3642 = 1.00000
+    3635 = 1.00000
+    3643 = 1.00000
+    3636 = 1.00000
+    3644 = 1.00000
+    3693 = 1.00000
+    3695 = 1.00000
+    3705 = 1.00000
+    3709 = 1.00000
+    3706 = 1.00000
+    3710 = 1.00000
+    3717 = 1.00000
+    3721 = 1.00000
+    3718 = 1.00000
+    3722 = 1.00000
+    3741 = 1.00000
+    3749 = 1.00000
+    3742 = 1.00000
+    3750 = 1.00000
+    3743 = 1.00000
+    3751 = 1.00000
+    3744 = 1.00000
+    3752 = 1.00000
+    3802 = 1.00000
+    3803 = 1.00000
+    3809 = 1.00000
+    3811 = 1.00000
+    3810 = 1.00000
+    3812 = 1.00000
+    3827 = 1.00000
+    3829 = 1.00000
+    3828 = 1.00000
+    3830 = 1.00000
+    3841 = 1.00000
+    3845 = 1.00000
+    3842 = 1.00000
+    3846 = 1.00000
+    3843 = 1.00000
+    3847 = 1.00000
+    3844 = 1.00000
+    3848 = 1.00000
+    3990 = 1.00000
+    3991 = 1.00000
+    3992 = 1.00000
+    3993 = 1.00000
+    3995 = 1.00000
+    3997 = 1.00000
+    3998 = 1.00000
+    4004 = 1.00000
+    4006 = 1.00000
+    4005 = 1.00000
+    4007 = 1.00000
+    4014 = 1.00000
+    4018 = 1.00000
+    4015 = 1.00000
+    4019 = 1.00000
+    4026 = 1.00000
+    4028 = 1.00000
+    4030 = 1.00000
+    4027 = 1.00000
+    4029 = 1.00000
+    4031 = 1.00000
+    4032 = 1.00000
+    4036 = 1.00000
+    4033 = 1.00000
+    4037 = 1.00000
+    4040 = 1.00000
+    4042 = 1.00000
+    4041 = 1.00000
+    4043 = 1.00000
+    4054 = 1.00000
+    4058 = 1.00000
+    4055 = 1.00000
+    4059 = 1.00000
+    4056 = 1.00000
+    4060 = 1.00000
+    4057 = 1.00000
+    4061 = 1.00000
+    4074 = 1.00000
+    4082 = 1.00000
+    4075 = 1.00000
+    4083 = 1.00000
+    4076 = 1.00000
+    4084 = 1.00000
+    4077 = 1.00000
+    4085 = 1.00000
+    4134 = 1.00000
+    4136 = 1.00000
+    4146 = 1.00000
+    4150 = 1.00000
+    4147 = 1.00000
+    4151 = 1.00000
+    4158 = 1.00000
+    4162 = 1.00000
+    4159 = 1.00000
+    4163 = 1.00000
+    4182 = 1.00000
+    4190 = 1.00000
+    4183 = 1.00000
+    4191 = 1.00000
+    4184 = 1.00000
+    4192 = 1.00000
+    4185 = 1.00000
+    4193 = 1.00000
+    4243 = 1.00000
+    4244 = 1.00000
+    4250 = 1.00000
+    4252 = 1.00000
+    4251 = 1.00000
+    4253 = 1.00000
+    4268 = 1.00000
+    4270 = 1.00000
+    4269 = 1.00000
+    4271 = 1.00000
+    4282 = 1.00000
+    4286 = 1.00000
+    4283 = 1.00000
+    4287 = 1.00000
+    4284 = 1.00000
+    4288 = 1.00000
+    4285 = 1.00000
+    4289 = 1.00000
+    4431 = 1.00000
+    4433 = 1.00000
+    4443 = 1.00000
+    4447 = 1.00000
+    4444 = 1.00000
+    4448 = 1.00000
+    4455 = 1.00000
+    4459 = 1.00000
+    4456 = 1.00000
+    4460 = 1.00000
+    4479 = 1.00000
+    4487 = 1.00000
+    4480 = 1.00000
+    4488 = 1.00000
+    4481 = 1.00000
+    4489 = 1.00000
+    4482 = 1.00000
+    4490 = 1.00000
+    4539 = 1.00000
+    4540 = 1.00000
+    4541 = 1.00000
+    4543 = 1.00000
+    4544 = 1.00000
+    4547 = 1.00000
+    4549 = 1.00000
+    4548 = 1.00000
+    4550 = 1.00000
+    4551 = 1.00000
+    4555 = 1.00000
+    4552 = 1.00000
+    4556 = 1.00000
+    4563 = 1.00000
+    4565 = 1.00000
+    4567 = 1.00000
+    4564 = 1.00000
+    4566 = 1.00000
+    4568 = 1.00000
+    4571 = 1.00000
+    4573 = 1.00000
+    4572 = 1.00000
+    4574 = 1.00000
+    4579 = 1.00000
+    4583 = 1.00000
+    4580 = 1.00000
+    4584 = 1.00000
+    4581 = 1.00000
+    4585 = 1.00000
+    4582 = 1.00000
+    4586 = 1.00000
+    4587 = 1.00000
+    4595 = 1.00000
+    4588 = 1.00000
+    4596 = 1.00000
+    4589 = 1.00000
+    4597 = 1.00000
+    4590 = 1.00000
+    4598 = 1.00000
+    4729 = 1.00000
+    4730 = 1.00000
+    4733 = 1.00000
+    4735 = 1.00000
+    4734 = 1.00000
+    4736 = 1.00000
+    4745 = 1.00000
+    4747 = 1.00000
+    4746 = 1.00000
+    4748 = 1.00000
+    4753 = 1.00000
+    4757 = 1.00000
+    4754 = 1.00000
+    4758 = 1.00000
+    4755 = 1.00000
+    4759 = 1.00000
+    4756 = 1.00000
+    4760 = 1.00000
+    4809 = 1.00000
+    4811 = 1.00000
+    4821 = 1.00000
+    4825 = 1.00000
+    4822 = 1.00000
+    4826 = 1.00000
+    4833 = 1.00000
+    4837 = 1.00000
+    4834 = 1.00000
+    4838 = 1.00000
+    4857 = 1.00000
+    4865 = 1.00000
+    4858 = 1.00000
+    4866 = 1.00000
+    4859 = 1.00000
+    4867 = 1.00000
+    4860 = 1.00000
+    4868 = 1.00000
+    4917 = 1.00000
+    4918 = 1.00000
+    4919 = 1.00000
+    4921 = 1.00000
+    4922 = 1.00000
+    4925 = 1.00000
+    4927 = 1.00000
+    4926 = 1.00000
+    4928 = 1.00000
+    4929 = 1.00000
+    4933 = 1.00000
+    4930 = 1.00000
+    4934 = 1.00000
+    4941 = 1.00000
+    4943 = 1.00000
+    4945 = 1.00000
+    4942 = 1.00000
+    4944 = 1.00000
+    4946 = 1.00000
+    4949 = 1.00000
+    4951 = 1.00000
+    4950 = 1.00000
+    4952 = 1.00000
+    4957 = 1.00000
+    4961 = 1.00000
+    4958 = 1.00000
+    4962 = 1.00000
+    4959 = 1.00000
+    4963 = 1.00000
+    4960 = 1.00000
+    4964 = 1.00000
+    4965 = 1.00000
+    4973 = 1.00000
+    4966 = 1.00000
+    4974 = 1.00000
+    4967 = 1.00000
+    4975 = 1.00000
+    4968 = 1.00000
+    4976 = 1.00000
+    5107 = 1.00000
+    5108 = 1.00000
+    5111 = 1.00000
+    5113 = 1.00000
+    5112 = 1.00000
+    5114 = 1.00000
+    5123 = 1.00000
+    5125 = 1.00000
+    5124 = 1.00000
+    5126 = 1.00000
+    5131 = 1.00000
+    5135 = 1.00000
+    5132 = 1.00000
+    5136 = 1.00000
+    5133 = 1.00000
+    5137 = 1.00000
+    5134 = 1.00000
+    5138 = 1.00000
+    5188 = 1.00000
+    5189 = 1.00000
+    5195 = 1.00000
+    5197 = 1.00000
+    5196 = 1.00000
+    5198 = 1.00000
+    5213 = 1.00000
+    5215 = 1.00000
+    5214 = 1.00000
+    5216 = 1.00000
+    5227 = 1.00000
+    5231 = 1.00000
+    5228 = 1.00000
+    5232 = 1.00000
+    5229 = 1.00000
+    5233 = 1.00000
+    5230 = 1.00000
+    5234 = 1.00000
+    5376 = 1.00000
+    5377 = 1.00000
+    5378 = 1.00000
+    5379 = 1.00000
+    5381 = 1.00000
+    5384 = 1.00000
+    5386 = 1.00000
+    5385 = 1.00000
+    5387 = 1.00000
+    5394 = 1.00000
+    5398 = 1.00000
+    5395 = 1.00000
+    5399 = 1.00000
+    5400 = 1.00000
+    5402 = 1.00000
+    5404 = 1.00000
+    5401 = 1.00000
+    5403 = 1.00000
+    5405 = 1.00000
+    5406 = 1.00000
+    5410 = 1.00000
+    5407 = 1.00000
+    5411 = 1.00000
+    5416 = 1.00000
+    5420 = 1.00000
+    5417 = 1.00000
+    5421 = 1.00000
+    5418 = 1.00000
+    5422 = 1.00000
+    5419 = 1.00000
+    5423 = 1.00000
+    5436 = 1.00000
+    5444 = 1.00000
+    5437 = 1.00000
+    5445 = 1.00000
+    5438 = 1.00000
+    5446 = 1.00000
+    5439 = 1.00000
+    5447 = 1.00000
+    5484 = 1.00000
+    5486 = 1.00000
+    5493 = 1.00000
+    5497 = 1.00000
+    5494 = 1.00000
+    5498 = 1.00000
+    5499 = 1.00000
+    5503 = 1.00000
+    5500 = 1.00000
+    5504 = 1.00000
+    5517 = 1.00000
+    5525 = 1.00000
+    5518 = 1.00000
+    5526 = 1.00000
+    5519 = 1.00000
+    5527 = 1.00000
+    5520 = 1.00000
+    5528 = 1.00000
+    5566 = 1.00000
+    5567 = 1.00000
+    5573 = 1.00000
+    5575 = 1.00000
+    5574 = 1.00000
+    5576 = 1.00000
+    5591 = 1.00000
+    5593 = 1.00000
+    5592 = 1.00000
+    5594 = 1.00000
+    5605 = 1.00000
+    5609 = 1.00000
+    5606 = 1.00000
+    5610 = 1.00000
+    5607 = 1.00000
+    5611 = 1.00000
+    5608 = 1.00000
+    5612 = 1.00000
+    5754 = 1.00000
+    5755 = 1.00000
+    5756 = 1.00000
+    5757 = 1.00000
+    5759 = 1.00000
+    5762 = 1.00000
+    5764 = 1.00000
+    5763 = 1.00000
+    5765 = 1.00000
+    5772 = 1.00000
+    5776 = 1.00000
+    5773 = 1.00000
+    5777 = 1.00000
+    5778 = 1.00000
+    5780 = 1.00000
+    5782 = 1.00000
+    5779 = 1.00000
+    5781 = 1.00000
+    5783 = 1.00000
+    5784 = 1.00000
+    5788 = 1.00000
+    5785 = 1.00000
+    5789 = 1.00000
+    5794 = 1.00000
+    5798 = 1.00000
+    5795 = 1.00000
+    5799 = 1.00000
+    5796 = 1.00000
+    5800 = 1.00000
+    5797 = 1.00000
+    5801 = 1.00000
+    5814 = 1.00000
+    5822 = 1.00000
+    5815 = 1.00000
+    5823 = 1.00000
+    5816 = 1.00000
+    5824 = 1.00000
+    5817 = 1.00000
+    5825 = 1.00000
+    5862 = 1.00000
+    5864 = 1.00000
+    5871 = 1.00000
+    5875 = 1.00000
+    5872 = 1.00000
+    5876 = 1.00000
+    5877 = 1.00000
+    5881 = 1.00000
+    5878 = 1.00000
+    5882 = 1.00000
+    5895 = 1.00000
+    5903 = 1.00000
+    5896 = 1.00000
+    5904 = 1.00000
+    5897 = 1.00000
+    5905 = 1.00000
+    5898 = 1.00000
+    5906 = 1.00000
+    6025 = 1.00000
+    6026 = 1.00000
+    6029 = 1.00000
+    6031 = 1.00000
+    6030 = 1.00000
+    6032 = 1.00000
+    6041 = 1.00000
+    6043 = 1.00000
+    6042 = 1.00000
+    6044 = 1.00000
+    6049 = 1.00000
+    6053 = 1.00000
+    6050 = 1.00000
+    6054 = 1.00000
+    6051 = 1.00000
+    6055 = 1.00000
+    6052 = 1.00000
+    6056 = 1.00000
+    6105 = 1.00000
+    6107 = 1.00000
+    6114 = 1.00000
+    6118 = 1.00000
+    6115 = 1.00000
+    6119 = 1.00000
+    6120 = 1.00000
+    6124 = 1.00000
+    6121 = 1.00000
+    6125 = 1.00000
+    6138 = 1.00000
+    6146 = 1.00000
+    6139 = 1.00000
+    6147 = 1.00000
+    6140 = 1.00000
+    6148 = 1.00000
+    6141 = 1.00000
+    6149 = 1.00000
+    6186 = 1.00000
+    6187 = 1.00000
+    6188 = 1.00000
+    6191 = 1.00000
+    6193 = 1.00000
+    6192 = 1.00000
+    6194 = 1.00000
+    6195 = 1.00000
+    6199 = 1.00000
+    6196 = 1.00000
+    6200 = 1.00000
+    6201 = 1.00000
+    6203 = 1.00000
+    6205 = 1.00000
+    6202 = 1.00000
+    6204 = 1.00000
+    6206 = 1.00000
+    6211 = 1.00000
+    6215 = 1.00000
+    6212 = 1.00000
+    6216 = 1.00000
+    6213 = 1.00000
+    6217 = 1.00000
+    6214 = 1.00000
+    6218 = 1.00000
+    6219 = 1.00000
+    6227 = 1.00000
+    6220 = 1.00000
+    6228 = 1.00000
+    6221 = 1.00000
+    6229 = 1.00000
+    6222 = 1.00000
+    6230 = 1.00000
+    6349 = 1.00000
+    6350 = 1.00000
+    6353 = 1.00000
+    6355 = 1.00000
+    6354 = 1.00000
+    6356 = 1.00000
+    6365 = 1.00000
+    6367 = 1.00000
+    6366 = 1.00000
+    6368 = 1.00000
+    6373 = 1.00000
+    6377 = 1.00000
+    6374 = 1.00000
+    6378 = 1.00000
+    6375 = 1.00000
+    6379 = 1.00000
+    6376 = 1.00000
+    6380 = 1.00000
+    6429 = 1.00000
+    6431 = 1.00000
+    6438 = 1.00000
+    6442 = 1.00000
+    6439 = 1.00000
+    6443 = 1.00000
+    6444 = 1.00000
+    6448 = 1.00000
+    6445 = 1.00000
+    6449 = 1.00000
+    6462 = 1.00000
+    6470 = 1.00000
+    6463 = 1.00000
+    6471 = 1.00000
+    6464 = 1.00000
+    6472 = 1.00000
+    6465 = 1.00000
+    6473 = 1.00000
+    6510 = 1.00000
+    6511 = 1.00000
+    6512 = 1.00000
+    6515 = 1.00000
+    6517 = 1.00000
+    6516 = 1.00000
+    6518 = 1.00000
+    6519 = 1.00000
+    6523 = 1.00000
+    6520 = 1.00000
+    6524 = 1.00000
+    6525 = 1.00000
+    6527 = 1.00000
+    6529 = 1.00000
+    6526 = 1.00000
+    6528 = 1.00000
+    6530 = 1.00000
+    6535 = 1.00000
+    6539 = 1.00000
+    6536 = 1.00000
+    6540 = 1.00000
+    6537 = 1.00000
+    6541 = 1.00000
+    6538 = 1.00000
+    6542 = 1.00000
+    6543 = 1.00000
+    6551 = 1.00000
+    6544 = 1.00000
+    6552 = 1.00000
+    6545 = 1.00000
+    6553 = 1.00000
+    6546 = 1.00000
+    6554 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(3)^3], case=4
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    3 = 1.00000
+    4 = 1.00000
+    5 = 1.00000
+    6 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    9 = 1.00000
+    10 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    15 = 1.00000
+    17 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    24 = 1.00000
+    26 = 1.00000
+    28 = 1.00000
+    25 = 1.00000
+    27 = 1.00000
+    29 = 1.00000
+    30 = 1.00000
+    32 = 1.00000
+    31 = 1.00000
+    33 = 1.00000
+    36 = 1.00000
+    38 = 1.00000
+    40 = 1.00000
+    37 = 1.00000
+    39 = 1.00000
+    41 = 1.00000
+    42 = 1.00000
+    44 = 1.00000
+    43 = 1.00000
+    45 = 1.00000
+    50 = 1.00000
+    52 = 1.00000
+    51 = 1.00000
+    53 = 1.00000
+    60 = 1.00000
+    64 = 1.00000
+    61 = 1.00000
+    65 = 1.00000
+    72 = 1.00000
+    74 = 1.00000
+    76 = 1.00000
+    73 = 1.00000
+    75 = 1.00000
+    77 = 1.00000
+    78 = 1.00000
+    82 = 1.00000
+    79 = 1.00000
+    83 = 1.00000
+    86 = 1.00000
+    88 = 1.00000
+    87 = 1.00000
+    89 = 1.00000
+    100 = 1.00000
+    104 = 1.00000
+    101 = 1.00000
+    105 = 1.00000
+    102 = 1.00000
+    106 = 1.00000
+    103 = 1.00000
+    107 = 1.00000
+    120 = 1.00000
+    128 = 1.00000
+    121 = 1.00000
+    129 = 1.00000
+    122 = 1.00000
+    130 = 1.00000
+    123 = 1.00000
+    131 = 1.00000
+    144 = 1.00000
+    148 = 1.00000
+    145 = 1.00000
+    149 = 1.00000
+    146 = 1.00000
+    150 = 1.00000
+    147 = 1.00000
+    151 = 1.00000
+    192 = 1.00000
+    193 = 1.00000
+    194 = 1.00000
+    195 = 1.00000
+    196 = 1.00000
+    198 = 1.00000
+    200 = 1.00000
+    204 = 1.00000
+    206 = 1.00000
+    205 = 1.00000
+    207 = 1.00000
+    210 = 1.00000
+    212 = 1.00000
+    214 = 1.00000
+    211 = 1.00000
+    213 = 1.00000
+    215 = 1.00000
+    216 = 1.00000
+    218 = 1.00000
+    217 = 1.00000
+    219 = 1.00000
+    228 = 1.00000
+    232 = 1.00000
+    229 = 1.00000
+    233 = 1.00000
+    240 = 1.00000
+    244 = 1.00000
+    241 = 1.00000
+    245 = 1.00000
+    264 = 1.00000
+    272 = 1.00000
+    265 = 1.00000
+    273 = 1.00000
+    266 = 1.00000
+    274 = 1.00000
+    267 = 1.00000
+    275 = 1.00000
+    288 = 1.00000
+    292 = 1.00000
+    289 = 1.00000
+    293 = 1.00000
+    290 = 1.00000
+    294 = 1.00000
+    291 = 1.00000
+    295 = 1.00000
+    336 = 1.00000
+    337 = 1.00000
+    338 = 1.00000
+    339 = 1.00000
+    340 = 1.00000
+    343 = 1.00000
+    344 = 1.00000
+    348 = 1.00000
+    350 = 1.00000
+    352 = 1.00000
+    349 = 1.00000
+    351 = 1.00000
+    353 = 1.00000
+    354 = 1.00000
+    356 = 1.00000
+    355 = 1.00000
+    357 = 1.00000
+    360 = 1.00000
+    362 = 1.00000
+    361 = 1.00000
+    363 = 1.00000
+    368 = 1.00000
+    370 = 1.00000
+    369 = 1.00000
+    371 = 1.00000
+    386 = 1.00000
+    388 = 1.00000
+    387 = 1.00000
+    389 = 1.00000
+    400 = 1.00000
+    404 = 1.00000
+    401 = 1.00000
+    405 = 1.00000
+    402 = 1.00000
+    406 = 1.00000
+    403 = 1.00000
+    407 = 1.00000
+    432 = 1.00000
+    436 = 1.00000
+    433 = 1.00000
+    437 = 1.00000
+    434 = 1.00000
+    438 = 1.00000
+    435 = 1.00000
+    439 = 1.00000
+    480 = 1.00000
+    481 = 1.00000
+    486 = 1.00000
+    488 = 1.00000
+    487 = 1.00000
+    489 = 1.00000
+    492 = 1.00000
+    494 = 1.00000
+    493 = 1.00000
+    495 = 1.00000
+    540 = 1.00000
+    544 = 1.00000
+    541 = 1.00000
+    545 = 1.00000
+    542 = 1.00000
+    546 = 1.00000
+    543 = 1.00000
+    547 = 1.00000
+    588 = 1.00000
+    589 = 1.00000
+    590 = 1.00000
+    591 = 1.00000
+    593 = 1.00000
+    595 = 1.00000
+    596 = 1.00000
+    602 = 1.00000
+    604 = 1.00000
+    603 = 1.00000
+    605 = 1.00000
+    612 = 1.00000
+    616 = 1.00000
+    613 = 1.00000
+    617 = 1.00000
+    624 = 1.00000
+    626 = 1.00000
+    628 = 1.00000
+    625 = 1.00000
+    627 = 1.00000
+    629 = 1.00000
+    630 = 1.00000
+    634 = 1.00000
+    631 = 1.00000
+    635 = 1.00000
+    638 = 1.00000
+    640 = 1.00000
+    639 = 1.00000
+    641 = 1.00000
+    652 = 1.00000
+    656 = 1.00000
+    653 = 1.00000
+    657 = 1.00000
+    654 = 1.00000
+    658 = 1.00000
+    655 = 1.00000
+    659 = 1.00000
+    672 = 1.00000
+    680 = 1.00000
+    673 = 1.00000
+    681 = 1.00000
+    674 = 1.00000
+    682 = 1.00000
+    675 = 1.00000
+    683 = 1.00000
+    732 = 1.00000
+    734 = 1.00000
+    744 = 1.00000
+    748 = 1.00000
+    745 = 1.00000
+    749 = 1.00000
+    756 = 1.00000
+    760 = 1.00000
+    757 = 1.00000
+    761 = 1.00000
+    780 = 1.00000
+    788 = 1.00000
+    781 = 1.00000
+    789 = 1.00000
+    782 = 1.00000
+    790 = 1.00000
+    783 = 1.00000
+    791 = 1.00000
+    841 = 1.00000
+    842 = 1.00000
+    848 = 1.00000
+    850 = 1.00000
+    849 = 1.00000
+    851 = 1.00000
+    866 = 1.00000
+    868 = 1.00000
+    867 = 1.00000
+    869 = 1.00000
+    880 = 1.00000
+    884 = 1.00000
+    881 = 1.00000
+    885 = 1.00000
+    882 = 1.00000
+    886 = 1.00000
+    883 = 1.00000
+    887 = 1.00000
+    1029 = 1.00000
+    1030 = 1.00000
+    1031 = 1.00000
+    1032 = 1.00000
+    1033 = 1.00000
+    1035 = 1.00000
+    1037 = 1.00000
+    1041 = 1.00000
+    1043 = 1.00000
+    1042 = 1.00000
+    1044 = 1.00000
+    1047 = 1.00000
+    1049 = 1.00000
+    1051 = 1.00000
+    1048 = 1.00000
+    1050 = 1.00000
+    1052 = 1.00000
+    1053 = 1.00000
+    1055 = 1.00000
+    1054 = 1.00000
+    1056 = 1.00000
+    1065 = 1.00000
+    1069 = 1.00000
+    1066 = 1.00000
+    1070 = 1.00000
+    1077 = 1.00000
+    1081 = 1.00000
+    1078 = 1.00000
+    1082 = 1.00000
+    1101 = 1.00000
+    1109 = 1.00000
+    1102 = 1.00000
+    1110 = 1.00000
+    1103 = 1.00000
+    1111 = 1.00000
+    1104 = 1.00000
+    1112 = 1.00000
+    1125 = 1.00000
+    1129 = 1.00000
+    1126 = 1.00000
+    1130 = 1.00000
+    1127 = 1.00000
+    1131 = 1.00000
+    1128 = 1.00000
+    1132 = 1.00000
+    1173 = 1.00000
+    1174 = 1.00000
+    1175 = 1.00000
+    1176 = 1.00000
+    1177 = 1.00000
+    1178 = 1.00000
+    1179 = 1.00000
+    1180 = 1.00000
+    1181 = 1.00000
+    1183 = 1.00000
+    1184 = 1.00000
+    1185 = 1.00000
+    1187 = 1.00000
+    1189 = 1.00000
+    1186 = 1.00000
+    1188 = 1.00000
+    1190 = 1.00000
+    1191 = 1.00000
+    1193 = 1.00000
+    1195 = 1.00000
+    1192 = 1.00000
+    1194 = 1.00000
+    1196 = 1.00000
+    1197 = 1.00000
+    1199 = 1.00000
+    1198 = 1.00000
+    1200 = 1.00000
+    1205 = 1.00000
+    1207 = 1.00000
+    1206 = 1.00000
+    1208 = 1.00000
+    1209 = 1.00000
+    1213 = 1.00000
+    1210 = 1.00000
+    1214 = 1.00000
+    1221 = 1.00000
+    1223 = 1.00000
+    1225 = 1.00000
+    1222 = 1.00000
+    1224 = 1.00000
+    1226 = 1.00000
+    1229 = 1.00000
+    1231 = 1.00000
+    1230 = 1.00000
+    1232 = 1.00000
+    1237 = 1.00000
+    1241 = 1.00000
+    1238 = 1.00000
+    1242 = 1.00000
+    1239 = 1.00000
+    1243 = 1.00000
+    1240 = 1.00000
+    1244 = 1.00000
+    1245 = 1.00000
+    1253 = 1.00000
+    1246 = 1.00000
+    1254 = 1.00000
+    1247 = 1.00000
+    1255 = 1.00000
+    1248 = 1.00000
+    1256 = 1.00000
+    1269 = 1.00000
+    1273 = 1.00000
+    1270 = 1.00000
+    1274 = 1.00000
+    1271 = 1.00000
+    1275 = 1.00000
+    1272 = 1.00000
+    1276 = 1.00000
+    1317 = 1.00000
+    1318 = 1.00000
+    1323 = 1.00000
+    1325 = 1.00000
+    1324 = 1.00000
+    1326 = 1.00000
+    1329 = 1.00000
+    1331 = 1.00000
+    1330 = 1.00000
+    1332 = 1.00000
+    1377 = 1.00000
+    1381 = 1.00000
+    1378 = 1.00000
+    1382 = 1.00000
+    1379 = 1.00000
+    1383 = 1.00000
+    1380 = 1.00000
+    1384 = 1.00000
+    1425 = 1.00000
+    1426 = 1.00000
+    1427 = 1.00000
+    1429 = 1.00000
+    1430 = 1.00000
+    1431 = 1.00000
+    1433 = 1.00000
+    1435 = 1.00000
+    1432 = 1.00000
+    1434 = 1.00000
+    1436 = 1.00000
+    1437 = 1.00000
+    1439 = 1.00000
+    1438 = 1.00000
+    1440 = 1.00000
+    1445 = 1.00000
+    1447 = 1.00000
+    1446 = 1.00000
+    1448 = 1.00000
+    1457 = 1.00000
+    1459 = 1.00000
+    1458 = 1.00000
+    1460 = 1.00000
+    1465 = 1.00000
+    1469 = 1.00000
+    1466 = 1.00000
+    1470 = 1.00000
+    1467 = 1.00000
+    1471 = 1.00000
+    1468 = 1.00000
+    1472 = 1.00000
+    1485 = 1.00000
+    1489 = 1.00000
+    1486 = 1.00000
+    1490 = 1.00000
+    1487 = 1.00000
+    1491 = 1.00000
+    1488 = 1.00000
+    1492 = 1.00000
+    1533 = 1.00000
+    1535 = 1.00000
+    1545 = 1.00000
+    1549 = 1.00000
+    1546 = 1.00000
+    1550 = 1.00000
+    1557 = 1.00000
+    1561 = 1.00000
+    1558 = 1.00000
+    1562 = 1.00000
+    1581 = 1.00000
+    1589 = 1.00000
+    1582 = 1.00000
+    1590 = 1.00000
+    1583 = 1.00000
+    1591 = 1.00000
+    1584 = 1.00000
+    1592 = 1.00000
+    1641 = 1.00000
+    1642 = 1.00000
+    1643 = 1.00000
+    1645 = 1.00000
+    1646 = 1.00000
+    1649 = 1.00000
+    1651 = 1.00000
+    1650 = 1.00000
+    1652 = 1.00000
+    1653 = 1.00000
+    1657 = 1.00000
+    1654 = 1.00000
+    1658 = 1.00000
+    1665 = 1.00000
+    1667 = 1.00000
+    1669 = 1.00000
+    1666 = 1.00000
+    1668 = 1.00000
+    1670 = 1.00000
+    1673 = 1.00000
+    1675 = 1.00000
+    1674 = 1.00000
+    1676 = 1.00000
+    1681 = 1.00000
+    1685 = 1.00000
+    1682 = 1.00000
+    1686 = 1.00000
+    1683 = 1.00000
+    1687 = 1.00000
+    1684 = 1.00000
+    1688 = 1.00000
+    1689 = 1.00000
+    1697 = 1.00000
+    1690 = 1.00000
+    1698 = 1.00000
+    1691 = 1.00000
+    1699 = 1.00000
+    1692 = 1.00000
+    1700 = 1.00000
+    1831 = 1.00000
+    1832 = 1.00000
+    1835 = 1.00000
+    1837 = 1.00000
+    1836 = 1.00000
+    1838 = 1.00000
+    1847 = 1.00000
+    1849 = 1.00000
+    1848 = 1.00000
+    1850 = 1.00000
+    1855 = 1.00000
+    1859 = 1.00000
+    1856 = 1.00000
+    1860 = 1.00000
+    1857 = 1.00000
+    1861 = 1.00000
+    1858 = 1.00000
+    1862 = 1.00000
+    1911 = 1.00000
+    1912 = 1.00000
+    1913 = 1.00000
+    1914 = 1.00000
+    1915 = 1.00000
+    1918 = 1.00000
+    1919 = 1.00000
+    1923 = 1.00000
+    1925 = 1.00000
+    1927 = 1.00000
+    1924 = 1.00000
+    1926 = 1.00000
+    1928 = 1.00000
+    1929 = 1.00000
+    1931 = 1.00000
+    1930 = 1.00000
+    1932 = 1.00000
+    1935 = 1.00000
+    1937 = 1.00000
+    1936 = 1.00000
+    1938 = 1.00000
+    1943 = 1.00000
+    1945 = 1.00000
+    1944 = 1.00000
+    1946 = 1.00000
+    1961 = 1.00000
+    1963 = 1.00000
+    1962 = 1.00000
+    1964 = 1.00000
+    1975 = 1.00000
+    1979 = 1.00000
+    1976 = 1.00000
+    1980 = 1.00000
+    1977 = 1.00000
+    1981 = 1.00000
+    1978 = 1.00000
+    1982 = 1.00000
+    2007 = 1.00000
+    2011 = 1.00000
+    2008 = 1.00000
+    2012 = 1.00000
+    2009 = 1.00000
+    2013 = 1.00000
+    2010 = 1.00000
+    2014 = 1.00000
+    2055 = 1.00000
+    2056 = 1.00000
+    2061 = 1.00000
+    2063 = 1.00000
+    2062 = 1.00000
+    2064 = 1.00000
+    2067 = 1.00000
+    2069 = 1.00000
+    2068 = 1.00000
+    2070 = 1.00000
+    2115 = 1.00000
+    2119 = 1.00000
+    2116 = 1.00000
+    2120 = 1.00000
+    2117 = 1.00000
+    2121 = 1.00000
+    2118 = 1.00000
+    2122 = 1.00000
+    2163 = 1.00000
+    2164 = 1.00000
+    2165 = 1.00000
+    2166 = 1.00000
+    2167 = 1.00000
+    2168 = 1.00000
+    2169 = 1.00000
+    2170 = 1.00000
+    2171 = 1.00000
+    2172 = 1.00000
+    2174 = 1.00000
+    2175 = 1.00000
+    2177 = 1.00000
+    2179 = 1.00000
+    2176 = 1.00000
+    2178 = 1.00000
+    2180 = 1.00000
+    2181 = 1.00000
+    2183 = 1.00000
+    2182 = 1.00000
+    2184 = 1.00000
+    2187 = 1.00000
+    2189 = 1.00000
+    2191 = 1.00000
+    2188 = 1.00000
+    2190 = 1.00000
+    2192 = 1.00000
+    2195 = 1.00000
+    2197 = 1.00000
+    2196 = 1.00000
+    2198 = 1.00000
+    2205 = 1.00000
+    2209 = 1.00000
+    2206 = 1.00000
+    2210 = 1.00000
+    2211 = 1.00000
+    2213 = 1.00000
+    2215 = 1.00000
+    2212 = 1.00000
+    2214 = 1.00000
+    2216 = 1.00000
+    2217 = 1.00000
+    2221 = 1.00000
+    2218 = 1.00000
+    2222 = 1.00000
+    2227 = 1.00000
+    2231 = 1.00000
+    2228 = 1.00000
+    2232 = 1.00000
+    2229 = 1.00000
+    2233 = 1.00000
+    2230 = 1.00000
+    2234 = 1.00000
+    2247 = 1.00000
+    2255 = 1.00000
+    2248 = 1.00000
+    2256 = 1.00000
+    2249 = 1.00000
+    2257 = 1.00000
+    2250 = 1.00000
+    2258 = 1.00000
+    2259 = 1.00000
+    2263 = 1.00000
+    2260 = 1.00000
+    2264 = 1.00000
+    2261 = 1.00000
+    2265 = 1.00000
+    2262 = 1.00000
+    2266 = 1.00000
+    2307 = 1.00000
+    2308 = 1.00000
+    2309 = 1.00000
+    2310 = 1.00000
+    2312 = 1.00000
+    2313 = 1.00000
+    2315 = 1.00000
+    2314 = 1.00000
+    2316 = 1.00000
+    2319 = 1.00000
+    2321 = 1.00000
+    2323 = 1.00000
+    2320 = 1.00000
+    2322 = 1.00000
+    2324 = 1.00000
+    2331 = 1.00000
+    2335 = 1.00000
+    2332 = 1.00000
+    2336 = 1.00000
+    2337 = 1.00000
+    2341 = 1.00000
+    2338 = 1.00000
+    2342 = 1.00000
+    2355 = 1.00000
+    2363 = 1.00000
+    2356 = 1.00000
+    2364 = 1.00000
+    2357 = 1.00000
+    2365 = 1.00000
+    2358 = 1.00000
+    2366 = 1.00000
+    2367 = 1.00000
+    2371 = 1.00000
+    2368 = 1.00000
+    2372 = 1.00000
+    2369 = 1.00000
+    2373 = 1.00000
+    2370 = 1.00000
+    2374 = 1.00000
+    2416 = 1.00000
+    2417 = 1.00000
+    2423 = 1.00000
+    2425 = 1.00000
+    2424 = 1.00000
+    2426 = 1.00000
+    2441 = 1.00000
+    2443 = 1.00000
+    2442 = 1.00000
+    2444 = 1.00000
+    2455 = 1.00000
+    2459 = 1.00000
+    2456 = 1.00000
+    2460 = 1.00000
+    2457 = 1.00000
+    2461 = 1.00000
+    2458 = 1.00000
+    2462 = 1.00000
+    2604 = 1.00000
+    2605 = 1.00000
+    2606 = 1.00000
+    2607 = 1.00000
+    2609 = 1.00000
+    2612 = 1.00000
+    2614 = 1.00000
+    2613 = 1.00000
+    2615 = 1.00000
+    2622 = 1.00000
+    2626 = 1.00000
+    2623 = 1.00000
+    2627 = 1.00000
+    2628 = 1.00000
+    2630 = 1.00000
+    2632 = 1.00000
+    2629 = 1.00000
+    2631 = 1.00000
+    2633 = 1.00000
+    2634 = 1.00000
+    2638 = 1.00000
+    2635 = 1.00000
+    2639 = 1.00000
+    2644 = 1.00000
+    2648 = 1.00000
+    2645 = 1.00000
+    2649 = 1.00000
+    2646 = 1.00000
+    2650 = 1.00000
+    2647 = 1.00000
+    2651 = 1.00000
+    2664 = 1.00000
+    2672 = 1.00000
+    2665 = 1.00000
+    2673 = 1.00000
+    2666 = 1.00000
+    2674 = 1.00000
+    2667 = 1.00000
+    2675 = 1.00000
+    2712 = 1.00000
+    2714 = 1.00000
+    2721 = 1.00000
+    2725 = 1.00000
+    2722 = 1.00000
+    2726 = 1.00000
+    2727 = 1.00000
+    2731 = 1.00000
+    2728 = 1.00000
+    2732 = 1.00000
+    2745 = 1.00000
+    2753 = 1.00000
+    2746 = 1.00000
+    2754 = 1.00000
+    2747 = 1.00000
+    2755 = 1.00000
+    2748 = 1.00000
+    2756 = 1.00000
+    2793 = 1.00000
+    2794 = 1.00000
+    2799 = 1.00000
+    2801 = 1.00000
+    2800 = 1.00000
+    2802 = 1.00000
+    2805 = 1.00000
+    2807 = 1.00000
+    2806 = 1.00000
+    2808 = 1.00000
+    2853 = 1.00000
+    2857 = 1.00000
+    2854 = 1.00000
+    2858 = 1.00000
+    2855 = 1.00000
+    2859 = 1.00000
+    2856 = 1.00000
+    2860 = 1.00000
+    2901 = 1.00000
+    2902 = 1.00000
+    2903 = 1.00000
+    2905 = 1.00000
+    2906 = 1.00000
+    2907 = 1.00000
+    2909 = 1.00000
+    2911 = 1.00000
+    2908 = 1.00000
+    2910 = 1.00000
+    2912 = 1.00000
+    2913 = 1.00000
+    2915 = 1.00000
+    2914 = 1.00000
+    2916 = 1.00000
+    2921 = 1.00000
+    2923 = 1.00000
+    2922 = 1.00000
+    2924 = 1.00000
+    2933 = 1.00000
+    2935 = 1.00000
+    2934 = 1.00000
+    2936 = 1.00000
+    2941 = 1.00000
+    2945 = 1.00000
+    2942 = 1.00000
+    2946 = 1.00000
+    2943 = 1.00000
+    2947 = 1.00000
+    2944 = 1.00000
+    2948 = 1.00000
+    2961 = 1.00000
+    2965 = 1.00000
+    2962 = 1.00000
+    2966 = 1.00000
+    2963 = 1.00000
+    2967 = 1.00000
+    2964 = 1.00000
+    2968 = 1.00000
+    3009 = 1.00000
+    3010 = 1.00000
+    3011 = 1.00000
+    3012 = 1.00000
+    3014 = 1.00000
+    3015 = 1.00000
+    3017 = 1.00000
+    3016 = 1.00000
+    3018 = 1.00000
+    3021 = 1.00000
+    3023 = 1.00000
+    3025 = 1.00000
+    3022 = 1.00000
+    3024 = 1.00000
+    3026 = 1.00000
+    3033 = 1.00000
+    3037 = 1.00000
+    3034 = 1.00000
+    3038 = 1.00000
+    3039 = 1.00000
+    3043 = 1.00000
+    3040 = 1.00000
+    3044 = 1.00000
+    3057 = 1.00000
+    3065 = 1.00000
+    3058 = 1.00000
+    3066 = 1.00000
+    3059 = 1.00000
+    3067 = 1.00000
+    3060 = 1.00000
+    3068 = 1.00000
+    3069 = 1.00000
+    3073 = 1.00000
+    3070 = 1.00000
+    3074 = 1.00000
+    3071 = 1.00000
+    3075 = 1.00000
+    3072 = 1.00000
+    3076 = 1.00000
+    3117 = 1.00000
+    3118 = 1.00000
+    3119 = 1.00000
+    3120 = 1.00000
+    3121 = 1.00000
+    3122 = 1.00000
+    3123 = 1.00000
+    3125 = 1.00000
+    3127 = 1.00000
+    3124 = 1.00000
+    3126 = 1.00000
+    3128 = 1.00000
+    3129 = 1.00000
+    3131 = 1.00000
+    3133 = 1.00000
+    3130 = 1.00000
+    3132 = 1.00000
+    3134 = 1.00000
+    3137 = 1.00000
+    3139 = 1.00000
+    3138 = 1.00000
+    3140 = 1.00000
+    3141 = 1.00000
+    3145 = 1.00000
+    3142 = 1.00000
+    3146 = 1.00000
+    3147 = 1.00000
+    3149 = 1.00000
+    3151 = 1.00000
+    3148 = 1.00000
+    3150 = 1.00000
+    3152 = 1.00000
+    3157 = 1.00000
+    3161 = 1.00000
+    3158 = 1.00000
+    3162 = 1.00000
+    3159 = 1.00000
+    3163 = 1.00000
+    3160 = 1.00000
+    3164 = 1.00000
+    3165 = 1.00000
+    3173 = 1.00000
+    3166 = 1.00000
+    3174 = 1.00000
+    3167 = 1.00000
+    3175 = 1.00000
+    3168 = 1.00000
+    3176 = 1.00000
+    3177 = 1.00000
+    3181 = 1.00000
+    3178 = 1.00000
+    3182 = 1.00000
+    3179 = 1.00000
+    3183 = 1.00000
+    3180 = 1.00000
+    3184 = 1.00000
+    3307 = 1.00000
+    3308 = 1.00000
+    3311 = 1.00000
+    3313 = 1.00000
+    3312 = 1.00000
+    3314 = 1.00000
+    3323 = 1.00000
+    3325 = 1.00000
+    3324 = 1.00000
+    3326 = 1.00000
+    3331 = 1.00000
+    3335 = 1.00000
+    3332 = 1.00000
+    3336 = 1.00000
+    3333 = 1.00000
+    3337 = 1.00000
+    3334 = 1.00000
+    3338 = 1.00000
+    3387 = 1.00000
+    3389 = 1.00000
+    3396 = 1.00000
+    3400 = 1.00000
+    3397 = 1.00000
+    3401 = 1.00000
+    3402 = 1.00000
+    3406 = 1.00000
+    3403 = 1.00000
+    3407 = 1.00000
+    3420 = 1.00000
+    3428 = 1.00000
+    3421 = 1.00000
+    3429 = 1.00000
+    3422 = 1.00000
+    3430 = 1.00000
+    3423 = 1.00000
+    3431 = 1.00000
+    3468 = 1.00000
+    3469 = 1.00000
+    3470 = 1.00000
+    3473 = 1.00000
+    3475 = 1.00000
+    3474 = 1.00000
+    3476 = 1.00000
+    3477 = 1.00000
+    3481 = 1.00000
+    3478 = 1.00000
+    3482 = 1.00000
+    3483 = 1.00000
+    3485 = 1.00000
+    3487 = 1.00000
+    3484 = 1.00000
+    3486 = 1.00000
+    3488 = 1.00000
+    3493 = 1.00000
+    3497 = 1.00000
+    3494 = 1.00000
+    3498 = 1.00000
+    3495 = 1.00000
+    3499 = 1.00000
+    3496 = 1.00000
+    3500 = 1.00000
+    3501 = 1.00000
+    3509 = 1.00000
+    3502 = 1.00000
+    3510 = 1.00000
+    3503 = 1.00000
+    3511 = 1.00000
+    3504 = 1.00000
+    3512 = 1.00000
+    3549 = 1.00000
+    3550 = 1.00000
+    3551 = 1.00000
+    3552 = 1.00000
+    3554 = 1.00000
+    3556 = 1.00000
+    3557 = 1.00000
+    3563 = 1.00000
+    3565 = 1.00000
+    3564 = 1.00000
+    3566 = 1.00000
+    3573 = 1.00000
+    3577 = 1.00000
+    3574 = 1.00000
+    3578 = 1.00000
+    3585 = 1.00000
+    3587 = 1.00000
+    3589 = 1.00000
+    3586 = 1.00000
+    3588 = 1.00000
+    3590 = 1.00000
+    3591 = 1.00000
+    3595 = 1.00000
+    3592 = 1.00000
+    3596 = 1.00000
+    3599 = 1.00000
+    3601 = 1.00000
+    3600 = 1.00000
+    3602 = 1.00000
+    3613 = 1.00000
+    3617 = 1.00000
+    3614 = 1.00000
+    3618 = 1.00000
+    3615 = 1.00000
+    3619 = 1.00000
+    3616 = 1.00000
+    3620 = 1.00000
+    3633 = 1.00000
+    3641 = 1.00000
+    3634 = 1.00000
+    3642 = 1.00000
+    3635 = 1.00000
+    3643 = 1.00000
+    3636 = 1.00000
+    3644 = 1.00000
+    3693 = 1.00000
+    3695 = 1.00000
+    3705 = 1.00000
+    3709 = 1.00000
+    3706 = 1.00000
+    3710 = 1.00000
+    3717 = 1.00000
+    3721 = 1.00000
+    3718 = 1.00000
+    3722 = 1.00000
+    3741 = 1.00000
+    3749 = 1.00000
+    3742 = 1.00000
+    3750 = 1.00000
+    3743 = 1.00000
+    3751 = 1.00000
+    3744 = 1.00000
+    3752 = 1.00000
+    3802 = 1.00000
+    3803 = 1.00000
+    3809 = 1.00000
+    3811 = 1.00000
+    3810 = 1.00000
+    3812 = 1.00000
+    3827 = 1.00000
+    3829 = 1.00000
+    3828 = 1.00000
+    3830 = 1.00000
+    3841 = 1.00000
+    3845 = 1.00000
+    3842 = 1.00000
+    3846 = 1.00000
+    3843 = 1.00000
+    3847 = 1.00000
+    3844 = 1.00000
+    3848 = 1.00000
+    3990 = 1.00000
+    3991 = 1.00000
+    3992 = 1.00000
+    3993 = 1.00000
+    3995 = 1.00000
+    3997 = 1.00000
+    3998 = 1.00000
+    4004 = 1.00000
+    4006 = 1.00000
+    4005 = 1.00000
+    4007 = 1.00000
+    4014 = 1.00000
+    4018 = 1.00000
+    4015 = 1.00000
+    4019 = 1.00000
+    4026 = 1.00000
+    4028 = 1.00000
+    4030 = 1.00000
+    4027 = 1.00000
+    4029 = 1.00000
+    4031 = 1.00000
+    4032 = 1.00000
+    4036 = 1.00000
+    4033 = 1.00000
+    4037 = 1.00000
+    4040 = 1.00000
+    4042 = 1.00000
+    4041 = 1.00000
+    4043 = 1.00000
+    4054 = 1.00000
+    4058 = 1.00000
+    4055 = 1.00000
+    4059 = 1.00000
+    4056 = 1.00000
+    4060 = 1.00000
+    4057 = 1.00000
+    4061 = 1.00000
+    4074 = 1.00000
+    4082 = 1.00000
+    4075 = 1.00000
+    4083 = 1.00000
+    4076 = 1.00000
+    4084 = 1.00000
+    4077 = 1.00000
+    4085 = 1.00000
+    4134 = 1.00000
+    4136 = 1.00000
+    4146 = 1.00000
+    4150 = 1.00000
+    4147 = 1.00000
+    4151 = 1.00000
+    4158 = 1.00000
+    4162 = 1.00000
+    4159 = 1.00000
+    4163 = 1.00000
+    4182 = 1.00000
+    4190 = 1.00000
+    4183 = 1.00000
+    4191 = 1.00000
+    4184 = 1.00000
+    4192 = 1.00000
+    4185 = 1.00000
+    4193 = 1.00000
+    4243 = 1.00000
+    4244 = 1.00000
+    4250 = 1.00000
+    4252 = 1.00000
+    4251 = 1.00000
+    4253 = 1.00000
+    4268 = 1.00000
+    4270 = 1.00000
+    4269 = 1.00000
+    4271 = 1.00000
+    4282 = 1.00000
+    4286 = 1.00000
+    4283 = 1.00000
+    4287 = 1.00000
+    4284 = 1.00000
+    4288 = 1.00000
+    4285 = 1.00000
+    4289 = 1.00000
+    4431 = 1.00000
+    4433 = 1.00000
+    4443 = 1.00000
+    4447 = 1.00000
+    4444 = 1.00000
+    4448 = 1.00000
+    4455 = 1.00000
+    4459 = 1.00000
+    4456 = 1.00000
+    4460 = 1.00000
+    4479 = 1.00000
+    4487 = 1.00000
+    4480 = 1.00000
+    4488 = 1.00000
+    4481 = 1.00000
+    4489 = 1.00000
+    4482 = 1.00000
+    4490 = 1.00000
+    4539 = 1.00000
+    4540 = 1.00000
+    4541 = 1.00000
+    4543 = 1.00000
+    4544 = 1.00000
+    4547 = 1.00000
+    4549 = 1.00000
+    4548 = 1.00000
+    4550 = 1.00000
+    4551 = 1.00000
+    4555 = 1.00000
+    4552 = 1.00000
+    4556 = 1.00000
+    4563 = 1.00000
+    4565 = 1.00000
+    4567 = 1.00000
+    4564 = 1.00000
+    4566 = 1.00000
+    4568 = 1.00000
+    4571 = 1.00000
+    4573 = 1.00000
+    4572 = 1.00000
+    4574 = 1.00000
+    4579 = 1.00000
+    4583 = 1.00000
+    4580 = 1.00000
+    4584 = 1.00000
+    4581 = 1.00000
+    4585 = 1.00000
+    4582 = 1.00000
+    4586 = 1.00000
+    4587 = 1.00000
+    4595 = 1.00000
+    4588 = 1.00000
+    4596 = 1.00000
+    4589 = 1.00000
+    4597 = 1.00000
+    4590 = 1.00000
+    4598 = 1.00000
+    4729 = 1.00000
+    4730 = 1.00000
+    4733 = 1.00000
+    4735 = 1.00000
+    4734 = 1.00000
+    4736 = 1.00000
+    4745 = 1.00000
+    4747 = 1.00000
+    4746 = 1.00000
+    4748 = 1.00000
+    4753 = 1.00000
+    4757 = 1.00000
+    4754 = 1.00000
+    4758 = 1.00000
+    4755 = 1.00000
+    4759 = 1.00000
+    4756 = 1.00000
+    4760 = 1.00000
+    4809 = 1.00000
+    4811 = 1.00000
+    4821 = 1.00000
+    4825 = 1.00000
+    4822 = 1.00000
+    4826 = 1.00000
+    4833 = 1.00000
+    4837 = 1.00000
+    4834 = 1.00000
+    4838 = 1.00000
+    4857 = 1.00000
+    4865 = 1.00000
+    4858 = 1.00000
+    4866 = 1.00000
+    4859 = 1.00000
+    4867 = 1.00000
+    4860 = 1.00000
+    4868 = 1.00000
+    4917 = 1.00000
+    4918 = 1.00000
+    4919 = 1.00000
+    4921 = 1.00000
+    4922 = 1.00000
+    4925 = 1.00000
+    4927 = 1.00000
+    4926 = 1.00000
+    4928 = 1.00000
+    4929 = 1.00000
+    4933 = 1.00000
+    4930 = 1.00000
+    4934 = 1.00000
+    4941 = 1.00000
+    4943 = 1.00000
+    4945 = 1.00000
+    4942 = 1.00000
+    4944 = 1.00000
+    4946 = 1.00000
+    4949 = 1.00000
+    4951 = 1.00000
+    4950 = 1.00000
+    4952 = 1.00000
+    4957 = 1.00000
+    4961 = 1.00000
+    4958 = 1.00000
+    4962 = 1.00000
+    4959 = 1.00000
+    4963 = 1.00000
+    4960 = 1.00000
+    4964 = 1.00000
+    4965 = 1.00000
+    4973 = 1.00000
+    4966 = 1.00000
+    4974 = 1.00000
+    4967 = 1.00000
+    4975 = 1.00000
+    4968 = 1.00000
+    4976 = 1.00000
+    5107 = 1.00000
+    5108 = 1.00000
+    5111 = 1.00000
+    5113 = 1.00000
+    5112 = 1.00000
+    5114 = 1.00000
+    5123 = 1.00000
+    5125 = 1.00000
+    5124 = 1.00000
+    5126 = 1.00000
+    5131 = 1.00000
+    5135 = 1.00000
+    5132 = 1.00000
+    5136 = 1.00000
+    5133 = 1.00000
+    5137 = 1.00000
+    5134 = 1.00000
+    5138 = 1.00000
+    5188 = 1.00000
+    5189 = 1.00000
+    5195 = 1.00000
+    5197 = 1.00000
+    5196 = 1.00000
+    5198 = 1.00000
+    5213 = 1.00000
+    5215 = 1.00000
+    5214 = 1.00000
+    5216 = 1.00000
+    5227 = 1.00000
+    5231 = 1.00000
+    5228 = 1.00000
+    5232 = 1.00000
+    5229 = 1.00000
+    5233 = 1.00000
+    5230 = 1.00000
+    5234 = 1.00000
+    5376 = 1.00000
+    5377 = 1.00000
+    5378 = 1.00000
+    5379 = 1.00000
+    5381 = 1.00000
+    5384 = 1.00000
+    5386 = 1.00000
+    5385 = 1.00000
+    5387 = 1.00000
+    5394 = 1.00000
+    5398 = 1.00000
+    5395 = 1.00000
+    5399 = 1.00000
+    5400 = 1.00000
+    5402 = 1.00000
+    5404 = 1.00000
+    5401 = 1.00000
+    5403 = 1.00000
+    5405 = 1.00000
+    5406 = 1.00000
+    5410 = 1.00000
+    5407 = 1.00000
+    5411 = 1.00000
+    5416 = 1.00000
+    5420 = 1.00000
+    5417 = 1.00000
+    5421 = 1.00000
+    5418 = 1.00000
+    5422 = 1.00000
+    5419 = 1.00000
+    5423 = 1.00000
+    5436 = 1.00000
+    5444 = 1.00000
+    5437 = 1.00000
+    5445 = 1.00000
+    5438 = 1.00000
+    5446 = 1.00000
+    5439 = 1.00000
+    5447 = 1.00000
+    5484 = 1.00000
+    5486 = 1.00000
+    5493 = 1.00000
+    5497 = 1.00000
+    5494 = 1.00000
+    5498 = 1.00000
+    5499 = 1.00000
+    5503 = 1.00000
+    5500 = 1.00000
+    5504 = 1.00000
+    5517 = 1.00000
+    5525 = 1.00000
+    5518 = 1.00000
+    5526 = 1.00000
+    5519 = 1.00000
+    5527 = 1.00000
+    5520 = 1.00000
+    5528 = 1.00000
+    5566 = 1.00000
+    5567 = 1.00000
+    5573 = 1.00000
+    5575 = 1.00000
+    5574 = 1.00000
+    5576 = 1.00000
+    5591 = 1.00000
+    5593 = 1.00000
+    5592 = 1.00000
+    5594 = 1.00000
+    5605 = 1.00000
+    5609 = 1.00000
+    5606 = 1.00000
+    5610 = 1.00000
+    5607 = 1.00000
+    5611 = 1.00000
+    5608 = 1.00000
+    5612 = 1.00000
+    5754 = 1.00000
+    5755 = 1.00000
+    5756 = 1.00000
+    5757 = 1.00000
+    5759 = 1.00000
+    5762 = 1.00000
+    5764 = 1.00000
+    5763 = 1.00000
+    5765 = 1.00000
+    5772 = 1.00000
+    5776 = 1.00000
+    5773 = 1.00000
+    5777 = 1.00000
+    5778 = 1.00000
+    5780 = 1.00000
+    5782 = 1.00000
+    5779 = 1.00000
+    5781 = 1.00000
+    5783 = 1.00000
+    5784 = 1.00000
+    5788 = 1.00000
+    5785 = 1.00000
+    5789 = 1.00000
+    5794 = 1.00000
+    5798 = 1.00000
+    5795 = 1.00000
+    5799 = 1.00000
+    5796 = 1.00000
+    5800 = 1.00000
+    5797 = 1.00000
+    5801 = 1.00000
+    5814 = 1.00000
+    5822 = 1.00000
+    5815 = 1.00000
+    5823 = 1.00000
+    5816 = 1.00000
+    5824 = 1.00000
+    5817 = 1.00000
+    5825 = 1.00000
+    5862 = 1.00000
+    5864 = 1.00000
+    5871 = 1.00000
+    5875 = 1.00000
+    5872 = 1.00000
+    5876 = 1.00000
+    5877 = 1.00000
+    5881 = 1.00000
+    5878 = 1.00000
+    5882 = 1.00000
+    5895 = 1.00000
+    5903 = 1.00000
+    5896 = 1.00000
+    5904 = 1.00000
+    5897 = 1.00000
+    5905 = 1.00000
+    5898 = 1.00000
+    5906 = 1.00000
+    6025 = 1.00000
+    6026 = 1.00000
+    6029 = 1.00000
+    6031 = 1.00000
+    6030 = 1.00000
+    6032 = 1.00000
+    6041 = 1.00000
+    6043 = 1.00000
+    6042 = 1.00000
+    6044 = 1.00000
+    6049 = 1.00000
+    6053 = 1.00000
+    6050 = 1.00000
+    6054 = 1.00000
+    6051 = 1.00000
+    6055 = 1.00000
+    6052 = 1.00000
+    6056 = 1.00000
+    6105 = 1.00000
+    6107 = 1.00000
+    6114 = 1.00000
+    6118 = 1.00000
+    6115 = 1.00000
+    6119 = 1.00000
+    6120 = 1.00000
+    6124 = 1.00000
+    6121 = 1.00000
+    6125 = 1.00000
+    6138 = 1.00000
+    6146 = 1.00000
+    6139 = 1.00000
+    6147 = 1.00000
+    6140 = 1.00000
+    6148 = 1.00000
+    6141 = 1.00000
+    6149 = 1.00000
+    6186 = 1.00000
+    6187 = 1.00000
+    6188 = 1.00000
+    6191 = 1.00000
+    6193 = 1.00000
+    6192 = 1.00000
+    6194 = 1.00000
+    6195 = 1.00000
+    6199 = 1.00000
+    6196 = 1.00000
+    6200 = 1.00000
+    6201 = 1.00000
+    6203 = 1.00000
+    6205 = 1.00000
+    6202 = 1.00000
+    6204 = 1.00000
+    6206 = 1.00000
+    6211 = 1.00000
+    6215 = 1.00000
+    6212 = 1.00000
+    6216 = 1.00000
+    6213 = 1.00000
+    6217 = 1.00000
+    6214 = 1.00000
+    6218 = 1.00000
+    6219 = 1.00000
+    6227 = 1.00000
+    6220 = 1.00000
+    6228 = 1.00000
+    6221 = 1.00000
+    6229 = 1.00000
+    6222 = 1.00000
+    6230 = 1.00000
+    6349 = 1.00000
+    6350 = 1.00000
+    6353 = 1.00000
+    6355 = 1.00000
+    6354 = 1.00000
+    6356 = 1.00000
+    6365 = 1.00000
+    6367 = 1.00000
+    6366 = 1.00000
+    6368 = 1.00000
+    6373 = 1.00000
+    6377 = 1.00000
+    6374 = 1.00000
+    6378 = 1.00000
+    6375 = 1.00000
+    6379 = 1.00000
+    6376 = 1.00000
+    6380 = 1.00000
+    6429 = 1.00000
+    6431 = 1.00000
+    6438 = 1.00000
+    6442 = 1.00000
+    6439 = 1.00000
+    6443 = 1.00000
+    6444 = 1.00000
+    6448 = 1.00000
+    6445 = 1.00000
+    6449 = 1.00000
+    6462 = 1.00000
+    6470 = 1.00000
+    6463 = 1.00000
+    6471 = 1.00000
+    6464 = 1.00000
+    6472 = 1.00000
+    6465 = 1.00000
+    6473 = 1.00000
+    6510 = 1.00000
+    6511 = 1.00000
+    6512 = 1.00000
+    6515 = 1.00000
+    6517 = 1.00000
+    6516 = 1.00000
+    6518 = 1.00000
+    6519 = 1.00000
+    6523 = 1.00000
+    6520 = 1.00000
+    6524 = 1.00000
+    6525 = 1.00000
+    6527 = 1.00000
+    6529 = 1.00000
+    6526 = 1.00000
+    6528 = 1.00000
+    6530 = 1.00000
+    6535 = 1.00000
+    6539 = 1.00000
+    6536 = 1.00000
+    6540 = 1.00000
+    6537 = 1.00000
+    6541 = 1.00000
+    6538 = 1.00000
+    6542 = 1.00000
+    6543 = 1.00000
+    6551 = 1.00000
+    6544 = 1.00000
+    6552 = 1.00000
+    6545 = 1.00000
+    6553 = 1.00000
+    6546 = 1.00000
+    6554 = 1.00000
+DEAL::FE=FESystem<3>[FE_Q<3>(3)^3], case=5
+    0 = 1.00000
+    1 = 1.00000
+    2 = 1.00000
+    3 = 1.00000
+    4 = 1.00000
+    5 = 1.00000
+    6 = 1.00000
+    7 = 1.00000
+    8 = 1.00000
+    9 = 1.00000
+    10 = 1.00000
+    12 = 1.00000
+    13 = 1.00000
+    14 = 1.00000
+    15 = 1.00000
+    17 = 1.00000
+    19 = 1.00000
+    20 = 1.00000
+    24 = 1.00000
+    26 = 1.00000
+    28 = 1.00000
+    25 = 1.00000
+    27 = 1.00000
+    29 = 1.00000
+    30 = 1.00000
+    32 = 1.00000
+    31 = 1.00000
+    33 = 1.00000
+    36 = 1.00000
+    38 = 1.00000
+    40 = 1.00000
+    37 = 1.00000
+    39 = 1.00000
+    41 = 1.00000
+    42 = 1.00000
+    44 = 1.00000
+    43 = 1.00000
+    45 = 1.00000
+    50 = 1.00000
+    52 = 1.00000
+    51 = 1.00000
+    53 = 1.00000
+    60 = 1.00000
+    64 = 1.00000
+    61 = 1.00000
+    65 = 1.00000
+    72 = 1.00000
+    74 = 1.00000
+    76 = 1.00000
+    73 = 1.00000
+    75 = 1.00000
+    77 = 1.00000
+    78 = 1.00000
+    82 = 1.00000
+    79 = 1.00000
+    83 = 1.00000
+    86 = 1.00000
+    88 = 1.00000
+    87 = 1.00000
+    89 = 1.00000
+    100 = 1.00000
+    104 = 1.00000
+    101 = 1.00000
+    105 = 1.00000
+    102 = 1.00000
+    106 = 1.00000
+    103 = 1.00000
+    107 = 1.00000
+    120 = 1.00000
+    128 = 1.00000
+    121 = 1.00000
+    129 = 1.00000
+    122 = 1.00000
+    130 = 1.00000
+    123 = 1.00000
+    131 = 1.00000
+    144 = 1.00000
+    148 = 1.00000
+    145 = 1.00000
+    149 = 1.00000
+    146 = 1.00000
+    150 = 1.00000
+    147 = 1.00000
+    151 = 1.00000
+    192 = 1.00000
+    193 = 1.00000
+    194 = 1.00000
+    195 = 1.00000
+    196 = 1.00000
+    198 = 1.00000
+    200 = 1.00000
+    204 = 1.00000
+    206 = 1.00000
+    205 = 1.00000
+    207 = 1.00000
+    210 = 1.00000
+    212 = 1.00000
+    214 = 1.00000
+    211 = 1.00000
+    213 = 1.00000
+    215 = 1.00000
+    216 = 1.00000
+    218 = 1.00000
+    217 = 1.00000
+    219 = 1.00000
+    228 = 1.00000
+    232 = 1.00000
+    229 = 1.00000
+    233 = 1.00000
+    240 = 1.00000
+    244 = 1.00000
+    241 = 1.00000
+    245 = 1.00000
+    264 = 1.00000
+    272 = 1.00000
+    265 = 1.00000
+    273 = 1.00000
+    266 = 1.00000
+    274 = 1.00000
+    267 = 1.00000
+    275 = 1.00000
+    288 = 1.00000
+    292 = 1.00000
+    289 = 1.00000
+    293 = 1.00000
+    290 = 1.00000
+    294 = 1.00000
+    291 = 1.00000
+    295 = 1.00000
+    336 = 1.00000
+    337 = 1.00000
+    338 = 1.00000
+    339 = 1.00000
+    340 = 1.00000
+    343 = 1.00000
+    344 = 1.00000
+    348 = 1.00000
+    350 = 1.00000
+    352 = 1.00000
+    349 = 1.00000
+    351 = 1.00000
+    353 = 1.00000
+    354 = 1.00000
+    356 = 1.00000
+    355 = 1.00000
+    357 = 1.00000
+    360 = 1.00000
+    362 = 1.00000
+    361 = 1.00000
+    363 = 1.00000
+    368 = 1.00000
+    370 = 1.00000
+    369 = 1.00000
+    371 = 1.00000
+    386 = 1.00000
+    388 = 1.00000
+    387 = 1.00000
+    389 = 1.00000
+    400 = 1.00000
+    404 = 1.00000
+    401 = 1.00000
+    405 = 1.00000
+    402 = 1.00000
+    406 = 1.00000
+    403 = 1.00000
+    407 = 1.00000
+    432 = 1.00000
+    436 = 1.00000
+    433 = 1.00000
+    437 = 1.00000
+    434 = 1.00000
+    438 = 1.00000
+    435 = 1.00000
+    439 = 1.00000
+    480 = 1.00000
+    481 = 1.00000
+    486 = 1.00000
+    488 = 1.00000
+    487 = 1.00000
+    489 = 1.00000
+    492 = 1.00000
+    494 = 1.00000
+    493 = 1.00000
+    495 = 1.00000
+    540 = 1.00000
+    544 = 1.00000
+    541 = 1.00000
+    545 = 1.00000
+    542 = 1.00000
+    546 = 1.00000
+    543 = 1.00000
+    547 = 1.00000
+    588 = 1.00000
+    589 = 1.00000
+    590 = 1.00000
+    591 = 1.00000
+    593 = 1.00000
+    595 = 1.00000
+    596 = 1.00000
+    602 = 1.00000
+    604 = 1.00000
+    603 = 1.00000
+    605 = 1.00000
+    612 = 1.00000
+    616 = 1.00000
+    613 = 1.00000
+    617 = 1.00000
+    624 = 1.00000
+    626 = 1.00000
+    628 = 1.00000
+    625 = 1.00000
+    627 = 1.00000
+    629 = 1.00000
+    630 = 1.00000
+    634 = 1.00000
+    631 = 1.00000
+    635 = 1.00000
+    638 = 1.00000
+    640 = 1.00000
+    639 = 1.00000
+    641 = 1.00000
+    652 = 1.00000
+    656 = 1.00000
+    653 = 1.00000
+    657 = 1.00000
+    654 = 1.00000
+    658 = 1.00000
+    655 = 1.00000
+    659 = 1.00000
+    672 = 1.00000
+    680 = 1.00000
+    673 = 1.00000
+    681 = 1.00000
+    674 = 1.00000
+    682 = 1.00000
+    675 = 1.00000
+    683 = 1.00000
+    732 = 1.00000
+    734 = 1.00000
+    744 = 1.00000
+    748 = 1.00000
+    745 = 1.00000
+    749 = 1.00000
+    756 = 1.00000
+    760 = 1.00000
+    757 = 1.00000
+    761 = 1.00000
+    780 = 1.00000
+    788 = 1.00000
+    781 = 1.00000
+    789 = 1.00000
+    782 = 1.00000
+    790 = 1.00000
+    783 = 1.00000
+    791 = 1.00000
+    841 = 1.00000
+    842 = 1.00000
+    848 = 1.00000
+    850 = 1.00000
+    849 = 1.00000
+    851 = 1.00000
+    866 = 1.00000
+    868 = 1.00000
+    867 = 1.00000
+    869 = 1.00000
+    880 = 1.00000
+    884 = 1.00000
+    881 = 1.00000
+    885 = 1.00000
+    882 = 1.00000
+    886 = 1.00000
+    883 = 1.00000
+    887 = 1.00000
+    1029 = 1.00000
+    1030 = 1.00000
+    1031 = 1.00000
+    1032 = 1.00000
+    1033 = 1.00000
+    1035 = 1.00000
+    1037 = 1.00000
+    1041 = 1.00000
+    1043 = 1.00000
+    1042 = 1.00000
+    1044 = 1.00000
+    1047 = 1.00000
+    1049 = 1.00000
+    1051 = 1.00000
+    1048 = 1.00000
+    1050 = 1.00000
+    1052 = 1.00000
+    1053 = 1.00000
+    1055 = 1.00000
+    1054 = 1.00000
+    1056 = 1.00000
+    1065 = 1.00000
+    1069 = 1.00000
+    1066 = 1.00000
+    1070 = 1.00000
+    1077 = 1.00000
+    1081 = 1.00000
+    1078 = 1.00000
+    1082 = 1.00000
+    1101 = 1.00000
+    1109 = 1.00000
+    1102 = 1.00000
+    1110 = 1.00000
+    1103 = 1.00000
+    1111 = 1.00000
+    1104 = 1.00000
+    1112 = 1.00000
+    1125 = 1.00000
+    1129 = 1.00000
+    1126 = 1.00000
+    1130 = 1.00000
+    1127 = 1.00000
+    1131 = 1.00000
+    1128 = 1.00000
+    1132 = 1.00000
+    1173 = 1.00000
+    1174 = 1.00000
+    1175 = 1.00000
+    1176 = 1.00000
+    1177 = 1.00000
+    1178 = 1.00000
+    1179 = 1.00000
+    1180 = 1.00000
+    1181 = 1.00000
+    1183 = 1.00000
+    1184 = 1.00000
+    1185 = 1.00000
+    1187 = 1.00000
+    1189 = 1.00000
+    1186 = 1.00000
+    1188 = 1.00000
+    1190 = 1.00000
+    1191 = 1.00000
+    1193 = 1.00000
+    1195 = 1.00000
+    1192 = 1.00000
+    1194 = 1.00000
+    1196 = 1.00000
+    1197 = 1.00000
+    1199 = 1.00000
+    1198 = 1.00000
+    1200 = 1.00000
+    1205 = 1.00000
+    1207 = 1.00000
+    1206 = 1.00000
+    1208 = 1.00000
+    1209 = 1.00000
+    1213 = 1.00000
+    1210 = 1.00000
+    1214 = 1.00000
+    1221 = 1.00000
+    1223 = 1.00000
+    1225 = 1.00000
+    1222 = 1.00000
+    1224 = 1.00000
+    1226 = 1.00000
+    1229 = 1.00000
+    1231 = 1.00000
+    1230 = 1.00000
+    1232 = 1.00000
+    1237 = 1.00000
+    1241 = 1.00000
+    1238 = 1.00000
+    1242 = 1.00000
+    1239 = 1.00000
+    1243 = 1.00000
+    1240 = 1.00000
+    1244 = 1.00000
+    1245 = 1.00000
+    1253 = 1.00000
+    1246 = 1.00000
+    1254 = 1.00000
+    1247 = 1.00000
+    1255 = 1.00000
+    1248 = 1.00000
+    1256 = 1.00000
+    1269 = 1.00000
+    1273 = 1.00000
+    1270 = 1.00000
+    1274 = 1.00000
+    1271 = 1.00000
+    1275 = 1.00000
+    1272 = 1.00000
+    1276 = 1.00000
+    1317 = 1.00000
+    1318 = 1.00000
+    1323 = 1.00000
+    1325 = 1.00000
+    1324 = 1.00000
+    1326 = 1.00000
+    1329 = 1.00000
+    1331 = 1.00000
+    1330 = 1.00000
+    1332 = 1.00000
+    1377 = 1.00000
+    1381 = 1.00000
+    1378 = 1.00000
+    1382 = 1.00000
+    1379 = 1.00000
+    1383 = 1.00000
+    1380 = 1.00000
+    1384 = 1.00000
+    1425 = 1.00000
+    1426 = 1.00000
+    1427 = 1.00000
+    1429 = 1.00000
+    1430 = 1.00000
+    1431 = 1.00000
+    1433 = 1.00000
+    1435 = 1.00000
+    1432 = 1.00000
+    1434 = 1.00000
+    1436 = 1.00000
+    1437 = 1.00000
+    1439 = 1.00000
+    1438 = 1.00000
+    1440 = 1.00000
+    1445 = 1.00000
+    1447 = 1.00000
+    1446 = 1.00000
+    1448 = 1.00000
+    1457 = 1.00000
+    1459 = 1.00000
+    1458 = 1.00000
+    1460 = 1.00000
+    1465 = 1.00000
+    1469 = 1.00000
+    1466 = 1.00000
+    1470 = 1.00000
+    1467 = 1.00000
+    1471 = 1.00000
+    1468 = 1.00000
+    1472 = 1.00000
+    1485 = 1.00000
+    1489 = 1.00000
+    1486 = 1.00000
+    1490 = 1.00000
+    1487 = 1.00000
+    1491 = 1.00000
+    1488 = 1.00000
+    1492 = 1.00000
+    1533 = 1.00000
+    1535 = 1.00000
+    1545 = 1.00000
+    1549 = 1.00000
+    1546 = 1.00000
+    1550 = 1.00000
+    1557 = 1.00000
+    1561 = 1.00000
+    1558 = 1.00000
+    1562 = 1.00000
+    1581 = 1.00000
+    1589 = 1.00000
+    1582 = 1.00000
+    1590 = 1.00000
+    1583 = 1.00000
+    1591 = 1.00000
+    1584 = 1.00000
+    1592 = 1.00000
+    1641 = 1.00000
+    1642 = 1.00000
+    1643 = 1.00000
+    1645 = 1.00000
+    1646 = 1.00000
+    1649 = 1.00000
+    1651 = 1.00000
+    1650 = 1.00000
+    1652 = 1.00000
+    1653 = 1.00000
+    1657 = 1.00000
+    1654 = 1.00000
+    1658 = 1.00000
+    1665 = 1.00000
+    1667 = 1.00000
+    1669 = 1.00000
+    1666 = 1.00000
+    1668 = 1.00000
+    1670 = 1.00000
+    1673 = 1.00000
+    1675 = 1.00000
+    1674 = 1.00000
+    1676 = 1.00000
+    1681 = 1.00000
+    1685 = 1.00000
+    1682 = 1.00000
+    1686 = 1.00000
+    1683 = 1.00000
+    1687 = 1.00000
+    1684 = 1.00000
+    1688 = 1.00000
+    1689 = 1.00000
+    1697 = 1.00000
+    1690 = 1.00000
+    1698 = 1.00000
+    1691 = 1.00000
+    1699 = 1.00000
+    1692 = 1.00000
+    1700 = 1.00000
+    1831 = 1.00000
+    1832 = 1.00000
+    1835 = 1.00000
+    1837 = 1.00000
+    1836 = 1.00000
+    1838 = 1.00000
+    1847 = 1.00000
+    1849 = 1.00000
+    1848 = 1.00000
+    1850 = 1.00000
+    1855 = 1.00000
+    1859 = 1.00000
+    1856 = 1.00000
+    1860 = 1.00000
+    1857 = 1.00000
+    1861 = 1.00000
+    1858 = 1.00000
+    1862 = 1.00000
+    1911 = 1.00000
+    1912 = 1.00000
+    1913 = 1.00000
+    1914 = 1.00000
+    1915 = 1.00000
+    1918 = 1.00000
+    1919 = 1.00000
+    1923 = 1.00000
+    1925 = 1.00000
+    1927 = 1.00000
+    1924 = 1.00000
+    1926 = 1.00000
+    1928 = 1.00000
+    1929 = 1.00000
+    1931 = 1.00000
+    1930 = 1.00000
+    1932 = 1.00000
+    1935 = 1.00000
+    1937 = 1.00000
+    1936 = 1.00000
+    1938 = 1.00000
+    1943 = 1.00000
+    1945 = 1.00000
+    1944 = 1.00000
+    1946 = 1.00000
+    1961 = 1.00000
+    1963 = 1.00000
+    1962 = 1.00000
+    1964 = 1.00000
+    1975 = 1.00000
+    1979 = 1.00000
+    1976 = 1.00000
+    1980 = 1.00000
+    1977 = 1.00000
+    1981 = 1.00000
+    1978 = 1.00000
+    1982 = 1.00000
+    2007 = 1.00000
+    2011 = 1.00000
+    2008 = 1.00000
+    2012 = 1.00000
+    2009 = 1.00000
+    2013 = 1.00000
+    2010 = 1.00000
+    2014 = 1.00000
+    2055 = 1.00000
+    2056 = 1.00000
+    2061 = 1.00000
+    2063 = 1.00000
+    2062 = 1.00000
+    2064 = 1.00000
+    2067 = 1.00000
+    2069 = 1.00000
+    2068 = 1.00000
+    2070 = 1.00000
+    2115 = 1.00000
+    2119 = 1.00000
+    2116 = 1.00000
+    2120 = 1.00000
+    2117 = 1.00000
+    2121 = 1.00000
+    2118 = 1.00000
+    2122 = 1.00000
+    2163 = 1.00000
+    2164 = 1.00000
+    2165 = 1.00000
+    2166 = 1.00000
+    2167 = 1.00000
+    2168 = 1.00000
+    2169 = 1.00000
+    2170 = 1.00000
+    2171 = 1.00000
+    2172 = 1.00000
+    2174 = 1.00000
+    2175 = 1.00000
+    2177 = 1.00000
+    2179 = 1.00000
+    2176 = 1.00000
+    2178 = 1.00000
+    2180 = 1.00000
+    2181 = 1.00000
+    2183 = 1.00000
+    2182 = 1.00000
+    2184 = 1.00000
+    2187 = 1.00000
+    2189 = 1.00000
+    2191 = 1.00000
+    2188 = 1.00000
+    2190 = 1.00000
+    2192 = 1.00000
+    2195 = 1.00000
+    2197 = 1.00000
+    2196 = 1.00000
+    2198 = 1.00000
+    2205 = 1.00000
+    2209 = 1.00000
+    2206 = 1.00000
+    2210 = 1.00000
+    2211 = 1.00000
+    2213 = 1.00000
+    2215 = 1.00000
+    2212 = 1.00000
+    2214 = 1.00000
+    2216 = 1.00000
+    2217 = 1.00000
+    2221 = 1.00000
+    2218 = 1.00000
+    2222 = 1.00000
+    2227 = 1.00000
+    2231 = 1.00000
+    2228 = 1.00000
+    2232 = 1.00000
+    2229 = 1.00000
+    2233 = 1.00000
+    2230 = 1.00000
+    2234 = 1.00000
+    2247 = 1.00000
+    2255 = 1.00000
+    2248 = 1.00000
+    2256 = 1.00000
+    2249 = 1.00000
+    2257 = 1.00000
+    2250 = 1.00000
+    2258 = 1.00000
+    2259 = 1.00000
+    2263 = 1.00000
+    2260 = 1.00000
+    2264 = 1.00000
+    2261 = 1.00000
+    2265 = 1.00000
+    2262 = 1.00000
+    2266 = 1.00000
+    2307 = 1.00000
+    2308 = 1.00000
+    2309 = 1.00000
+    2310 = 1.00000
+    2312 = 1.00000
+    2313 = 1.00000
+    2315 = 1.00000
+    2314 = 1.00000
+    2316 = 1.00000
+    2319 = 1.00000
+    2321 = 1.00000
+    2323 = 1.00000
+    2320 = 1.00000
+    2322 = 1.00000
+    2324 = 1.00000
+    2331 = 1.00000
+    2335 = 1.00000
+    2332 = 1.00000
+    2336 = 1.00000
+    2337 = 1.00000
+    2341 = 1.00000
+    2338 = 1.00000
+    2342 = 1.00000
+    2355 = 1.00000
+    2363 = 1.00000
+    2356 = 1.00000
+    2364 = 1.00000
+    2357 = 1.00000
+    2365 = 1.00000
+    2358 = 1.00000
+    2366 = 1.00000
+    2367 = 1.00000
+    2371 = 1.00000
+    2368 = 1.00000
+    2372 = 1.00000
+    2369 = 1.00000
+    2373 = 1.00000
+    2370 = 1.00000
+    2374 = 1.00000
+    2416 = 1.00000
+    2417 = 1.00000
+    2423 = 1.00000
+    2425 = 1.00000
+    2424 = 1.00000
+    2426 = 1.00000
+    2441 = 1.00000
+    2443 = 1.00000
+    2442 = 1.00000
+    2444 = 1.00000
+    2455 = 1.00000
+    2459 = 1.00000
+    2456 = 1.00000
+    2460 = 1.00000
+    2457 = 1.00000
+    2461 = 1.00000
+    2458 = 1.00000
+    2462 = 1.00000
+    2604 = 1.00000
+    2605 = 1.00000
+    2606 = 1.00000
+    2607 = 1.00000
+    2609 = 1.00000
+    2612 = 1.00000
+    2614 = 1.00000
+    2613 = 1.00000
+    2615 = 1.00000
+    2622 = 1.00000
+    2626 = 1.00000
+    2623 = 1.00000
+    2627 = 1.00000
+    2628 = 1.00000
+    2630 = 1.00000
+    2632 = 1.00000
+    2629 = 1.00000
+    2631 = 1.00000
+    2633 = 1.00000
+    2634 = 1.00000
+    2638 = 1.00000
+    2635 = 1.00000
+    2639 = 1.00000
+    2644 = 1.00000
+    2648 = 1.00000
+    2645 = 1.00000
+    2649 = 1.00000
+    2646 = 1.00000
+    2650 = 1.00000
+    2647 = 1.00000
+    2651 = 1.00000
+    2664 = 1.00000
+    2672 = 1.00000
+    2665 = 1.00000
+    2673 = 1.00000
+    2666 = 1.00000
+    2674 = 1.00000
+    2667 = 1.00000
+    2675 = 1.00000
+    2712 = 1.00000
+    2714 = 1.00000
+    2721 = 1.00000
+    2725 = 1.00000
+    2722 = 1.00000
+    2726 = 1.00000
+    2727 = 1.00000
+    2731 = 1.00000
+    2728 = 1.00000
+    2732 = 1.00000
+    2745 = 1.00000
+    2753 = 1.00000
+    2746 = 1.00000
+    2754 = 1.00000
+    2747 = 1.00000
+    2755 = 1.00000
+    2748 = 1.00000
+    2756 = 1.00000
+    2793 = 1.00000
+    2794 = 1.00000
+    2799 = 1.00000
+    2801 = 1.00000
+    2800 = 1.00000
+    2802 = 1.00000
+    2805 = 1.00000
+    2807 = 1.00000
+    2806 = 1.00000
+    2808 = 1.00000
+    2853 = 1.00000
+    2857 = 1.00000
+    2854 = 1.00000
+    2858 = 1.00000
+    2855 = 1.00000
+    2859 = 1.00000
+    2856 = 1.00000
+    2860 = 1.00000
+    2901 = 1.00000
+    2902 = 1.00000
+    2903 = 1.00000
+    2905 = 1.00000
+    2906 = 1.00000
+    2907 = 1.00000
+    2909 = 1.00000
+    2911 = 1.00000
+    2908 = 1.00000
+    2910 = 1.00000
+    2912 = 1.00000
+    2913 = 1.00000
+    2915 = 1.00000
+    2914 = 1.00000
+    2916 = 1.00000
+    2921 = 1.00000
+    2923 = 1.00000
+    2922 = 1.00000
+    2924 = 1.00000
+    2933 = 1.00000
+    2935 = 1.00000
+    2934 = 1.00000
+    2936 = 1.00000
+    2941 = 1.00000
+    2945 = 1.00000
+    2942 = 1.00000
+    2946 = 1.00000
+    2943 = 1.00000
+    2947 = 1.00000
+    2944 = 1.00000
+    2948 = 1.00000
+    2961 = 1.00000
+    2965 = 1.00000
+    2962 = 1.00000
+    2966 = 1.00000
+    2963 = 1.00000
+    2967 = 1.00000
+    2964 = 1.00000
+    2968 = 1.00000
+    3009 = 1.00000
+    3010 = 1.00000
+    3011 = 1.00000
+    3012 = 1.00000
+    3014 = 1.00000
+    3015 = 1.00000
+    3017 = 1.00000
+    3016 = 1.00000
+    3018 = 1.00000
+    3021 = 1.00000
+    3023 = 1.00000
+    3025 = 1.00000
+    3022 = 1.00000
+    3024 = 1.00000
+    3026 = 1.00000
+    3033 = 1.00000
+    3037 = 1.00000
+    3034 = 1.00000
+    3038 = 1.00000
+    3039 = 1.00000
+    3043 = 1.00000
+    3040 = 1.00000
+    3044 = 1.00000
+    3057 = 1.00000
+    3065 = 1.00000
+    3058 = 1.00000
+    3066 = 1.00000
+    3059 = 1.00000
+    3067 = 1.00000
+    3060 = 1.00000
+    3068 = 1.00000
+    3069 = 1.00000
+    3073 = 1.00000
+    3070 = 1.00000
+    3074 = 1.00000
+    3071 = 1.00000
+    3075 = 1.00000
+    3072 = 1.00000
+    3076 = 1.00000
+    3117 = 1.00000
+    3118 = 1.00000
+    3119 = 1.00000
+    3120 = 1.00000
+    3121 = 1.00000
+    3122 = 1.00000
+    3123 = 1.00000
+    3125 = 1.00000
+    3127 = 1.00000
+    3124 = 1.00000
+    3126 = 1.00000
+    3128 = 1.00000
+    3129 = 1.00000
+    3131 = 1.00000
+    3133 = 1.00000
+    3130 = 1.00000
+    3132 = 1.00000
+    3134 = 1.00000
+    3137 = 1.00000
+    3139 = 1.00000
+    3138 = 1.00000
+    3140 = 1.00000
+    3141 = 1.00000
+    3145 = 1.00000
+    3142 = 1.00000
+    3146 = 1.00000
+    3147 = 1.00000
+    3149 = 1.00000
+    3151 = 1.00000
+    3148 = 1.00000
+    3150 = 1.00000
+    3152 = 1.00000
+    3157 = 1.00000
+    3161 = 1.00000
+    3158 = 1.00000
+    3162 = 1.00000
+    3159 = 1.00000
+    3163 = 1.00000
+    3160 = 1.00000
+    3164 = 1.00000
+    3165 = 1.00000
+    3173 = 1.00000
+    3166 = 1.00000
+    3174 = 1.00000
+    3167 = 1.00000
+    3175 = 1.00000
+    3168 = 1.00000
+    3176 = 1.00000
+    3177 = 1.00000
+    3181 = 1.00000
+    3178 = 1.00000
+    3182 = 1.00000
+    3179 = 1.00000
+    3183 = 1.00000
+    3180 = 1.00000
+    3184 = 1.00000
+    3307 = 1.00000
+    3308 = 1.00000
+    3311 = 1.00000
+    3313 = 1.00000
+    3312 = 1.00000
+    3314 = 1.00000
+    3323 = 1.00000
+    3325 = 1.00000
+    3324 = 1.00000
+    3326 = 1.00000
+    3331 = 1.00000
+    3335 = 1.00000
+    3332 = 1.00000
+    3336 = 1.00000
+    3333 = 1.00000
+    3337 = 1.00000
+    3334 = 1.00000
+    3338 = 1.00000
+    3387 = 1.00000
+    3389 = 1.00000
+    3396 = 1.00000
+    3400 = 1.00000
+    3397 = 1.00000
+    3401 = 1.00000
+    3402 = 1.00000
+    3406 = 1.00000
+    3403 = 1.00000
+    3407 = 1.00000
+    3420 = 1.00000
+    3428 = 1.00000
+    3421 = 1.00000
+    3429 = 1.00000
+    3422 = 1.00000
+    3430 = 1.00000
+    3423 = 1.00000
+    3431 = 1.00000
+    3468 = 1.00000
+    3469 = 1.00000
+    3470 = 1.00000
+    3473 = 1.00000
+    3475 = 1.00000
+    3474 = 1.00000
+    3476 = 1.00000
+    3477 = 1.00000
+    3481 = 1.00000
+    3478 = 1.00000
+    3482 = 1.00000
+    3483 = 1.00000
+    3485 = 1.00000
+    3487 = 1.00000
+    3484 = 1.00000
+    3486 = 1.00000
+    3488 = 1.00000
+    3493 = 1.00000
+    3497 = 1.00000
+    3494 = 1.00000
+    3498 = 1.00000
+    3495 = 1.00000
+    3499 = 1.00000
+    3496 = 1.00000
+    3500 = 1.00000
+    3501 = 1.00000
+    3509 = 1.00000
+    3502 = 1.00000
+    3510 = 1.00000
+    3503 = 1.00000
+    3511 = 1.00000
+    3504 = 1.00000
+    3512 = 1.00000
+    3549 = 1.00000
+    3550 = 1.00000
+    3551 = 1.00000
+    3552 = 1.00000
+    3554 = 1.00000
+    3556 = 1.00000
+    3557 = 1.00000
+    3563 = 1.00000
+    3565 = 1.00000
+    3564 = 1.00000
+    3566 = 1.00000
+    3573 = 1.00000
+    3577 = 1.00000
+    3574 = 1.00000
+    3578 = 1.00000
+    3585 = 1.00000
+    3587 = 1.00000
+    3589 = 1.00000
+    3586 = 1.00000
+    3588 = 1.00000
+    3590 = 1.00000
+    3591 = 1.00000
+    3595 = 1.00000
+    3592 = 1.00000
+    3596 = 1.00000
+    3599 = 1.00000
+    3601 = 1.00000
+    3600 = 1.00000
+    3602 = 1.00000
+    3613 = 1.00000
+    3617 = 1.00000
+    3614 = 1.00000
+    3618 = 1.00000
+    3615 = 1.00000
+    3619 = 1.00000
+    3616 = 1.00000
+    3620 = 1.00000
+    3633 = 1.00000
+    3641 = 1.00000
+    3634 = 1.00000
+    3642 = 1.00000
+    3635 = 1.00000
+    3643 = 1.00000
+    3636 = 1.00000
+    3644 = 1.00000
+    3693 = 1.00000
+    3695 = 1.00000
+    3705 = 1.00000
+    3709 = 1.00000
+    3706 = 1.00000
+    3710 = 1.00000
+    3717 = 1.00000
+    3721 = 1.00000
+    3718 = 1.00000
+    3722 = 1.00000
+    3741 = 1.00000
+    3749 = 1.00000
+    3742 = 1.00000
+    3750 = 1.00000
+    3743 = 1.00000
+    3751 = 1.00000
+    3744 = 1.00000
+    3752 = 1.00000
+    3802 = 1.00000
+    3803 = 1.00000
+    3809 = 1.00000
+    3811 = 1.00000
+    3810 = 1.00000
+    3812 = 1.00000
+    3827 = 1.00000
+    3829 = 1.00000
+    3828 = 1.00000
+    3830 = 1.00000
+    3841 = 1.00000
+    3845 = 1.00000
+    3842 = 1.00000
+    3846 = 1.00000
+    3843 = 1.00000
+    3847 = 1.00000
+    3844 = 1.00000
+    3848 = 1.00000
+    3990 = 1.00000
+    3991 = 1.00000
+    3992 = 1.00000
+    3993 = 1.00000
+    3994 = 1.00000
+    3995 = 1.00000
+    3996 = 1.00000
+    3997 = 1.00000
+    3998 = 1.00000
+    3999 = 1.00000
+    4000 = 1.00000
+    4002 = 1.00000
+    4004 = 1.00000
+    4006 = 1.00000
+    4003 = 1.00000
+    4005 = 1.00000
+    4007 = 1.00000
+    4008 = 1.00000
+    4010 = 1.00000
+    4009 = 1.00000
+    4011 = 1.00000
+    4014 = 1.00000
+    4016 = 1.00000
+    4018 = 1.00000
+    4015 = 1.00000
+    4017 = 1.00000
+    4019 = 1.00000
+    4020 = 1.00000
+    4022 = 1.00000
+    4021 = 1.00000
+    4023 = 1.00000
+    4026 = 1.00000
+    4028 = 1.00000
+    4030 = 1.00000
+    4027 = 1.00000
+    4029 = 1.00000
+    4031 = 1.00000
+    4032 = 1.00000
+    4036 = 1.00000
+    4033 = 1.00000
+    4037 = 1.00000
+    4040 = 1.00000
+    4042 = 1.00000
+    4041 = 1.00000
+    4043 = 1.00000
+    4054 = 1.00000
+    4058 = 1.00000
+    4055 = 1.00000
+    4059 = 1.00000
+    4056 = 1.00000
+    4060 = 1.00000
+    4057 = 1.00000
+    4061 = 1.00000
+    4074 = 1.00000
+    4082 = 1.00000
+    4075 = 1.00000
+    4083 = 1.00000
+    4076 = 1.00000
+    4084 = 1.00000
+    4077 = 1.00000
+    4085 = 1.00000
+    4098 = 1.00000
+    4102 = 1.00000
+    4099 = 1.00000
+    4103 = 1.00000
+    4100 = 1.00000
+    4104 = 1.00000
+    4101 = 1.00000
+    4105 = 1.00000
+    4134 = 1.00000
+    4135 = 1.00000
+    4136 = 1.00000
+    4137 = 1.00000
+    4138 = 1.00000
+    4140 = 1.00000
+    4142 = 1.00000
+    4141 = 1.00000
+    4143 = 1.00000
+    4146 = 1.00000
+    4148 = 1.00000
+    4150 = 1.00000
+    4147 = 1.00000
+    4149 = 1.00000
+    4151 = 1.00000
+    4152 = 1.00000
+    4154 = 1.00000
+    4153 = 1.00000
+    4155 = 1.00000
+    4158 = 1.00000
+    4162 = 1.00000
+    4159 = 1.00000
+    4163 = 1.00000
+    4182 = 1.00000
+    4190 = 1.00000
+    4183 = 1.00000
+    4191 = 1.00000
+    4184 = 1.00000
+    4192 = 1.00000
+    4185 = 1.00000
+    4193 = 1.00000
+    4206 = 1.00000
+    4210 = 1.00000
+    4207 = 1.00000
+    4211 = 1.00000
+    4208 = 1.00000
+    4212 = 1.00000
+    4209 = 1.00000
+    4213 = 1.00000
+    4242 = 1.00000
+    4243 = 1.00000
+    4244 = 1.00000
+    4245 = 1.00000
+    4246 = 1.00000
+    4248 = 1.00000
+    4250 = 1.00000
+    4252 = 1.00000
+    4249 = 1.00000
+    4251 = 1.00000
+    4253 = 1.00000
+    4254 = 1.00000
+    4256 = 1.00000
+    4255 = 1.00000
+    4257 = 1.00000
+    4260 = 1.00000
+    4262 = 1.00000
+    4261 = 1.00000
+    4263 = 1.00000
+    4268 = 1.00000
+    4270 = 1.00000
+    4269 = 1.00000
+    4271 = 1.00000
+    4282 = 1.00000
+    4286 = 1.00000
+    4283 = 1.00000
+    4287 = 1.00000
+    4284 = 1.00000
+    4288 = 1.00000
+    4285 = 1.00000
+    4289 = 1.00000
+    4314 = 1.00000
+    4318 = 1.00000
+    4315 = 1.00000
+    4319 = 1.00000
+    4316 = 1.00000
+    4320 = 1.00000
+    4317 = 1.00000
+    4321 = 1.00000
+    4350 = 1.00000
+    4351 = 1.00000
+    4353 = 1.00000
+    4355 = 1.00000
+    4354 = 1.00000
+    4356 = 1.00000
+    4359 = 1.00000
+    4361 = 1.00000
+    4360 = 1.00000
+    4362 = 1.00000
+    4395 = 1.00000
+    4399 = 1.00000
+    4396 = 1.00000
+    4400 = 1.00000
+    4397 = 1.00000
+    4401 = 1.00000
+    4398 = 1.00000
+    4402 = 1.00000
+    4431 = 1.00000
+    4433 = 1.00000
+    4443 = 1.00000
+    4447 = 1.00000
+    4444 = 1.00000
+    4448 = 1.00000
+    4455 = 1.00000
+    4459 = 1.00000
+    4456 = 1.00000
+    4460 = 1.00000
+    4479 = 1.00000
+    4487 = 1.00000
+    4480 = 1.00000
+    4488 = 1.00000
+    4481 = 1.00000
+    4489 = 1.00000
+    4482 = 1.00000
+    4490 = 1.00000
+    4539 = 1.00000
+    4540 = 1.00000
+    4541 = 1.00000
+    4543 = 1.00000
+    4544 = 1.00000
+    4547 = 1.00000
+    4549 = 1.00000
+    4548 = 1.00000
+    4550 = 1.00000
+    4551 = 1.00000
+    4555 = 1.00000
+    4552 = 1.00000
+    4556 = 1.00000
+    4563 = 1.00000
+    4565 = 1.00000
+    4567 = 1.00000
+    4564 = 1.00000
+    4566 = 1.00000
+    4568 = 1.00000
+    4571 = 1.00000
+    4573 = 1.00000
+    4572 = 1.00000
+    4574 = 1.00000
+    4579 = 1.00000
+    4583 = 1.00000
+    4580 = 1.00000
+    4584 = 1.00000
+    4581 = 1.00000
+    4585 = 1.00000
+    4582 = 1.00000
+    4586 = 1.00000
+    4587 = 1.00000
+    4595 = 1.00000
+    4588 = 1.00000
+    4596 = 1.00000
+    4589 = 1.00000
+    4597 = 1.00000
+    4590 = 1.00000
+    4598 = 1.00000
+    4729 = 1.00000
+    4730 = 1.00000
+    4733 = 1.00000
+    4735 = 1.00000
+    4734 = 1.00000
+    4736 = 1.00000
+    4745 = 1.00000
+    4747 = 1.00000
+    4746 = 1.00000
+    4748 = 1.00000
+    4753 = 1.00000
+    4757 = 1.00000
+    4754 = 1.00000
+    4758 = 1.00000
+    4755 = 1.00000
+    4759 = 1.00000
+    4756 = 1.00000
+    4760 = 1.00000
+    4809 = 1.00000
+    4810 = 1.00000
+    4811 = 1.00000
+    4812 = 1.00000
+    4813 = 1.00000
+    4815 = 1.00000
+    4817 = 1.00000
+    4816 = 1.00000
+    4818 = 1.00000
+    4821 = 1.00000
+    4823 = 1.00000
+    4825 = 1.00000
+    4822 = 1.00000
+    4824 = 1.00000
+    4826 = 1.00000
+    4827 = 1.00000
+    4829 = 1.00000
+    4828 = 1.00000
+    4830 = 1.00000
+    4833 = 1.00000
+    4837 = 1.00000
+    4834 = 1.00000
+    4838 = 1.00000
+    4857 = 1.00000
+    4865 = 1.00000
+    4858 = 1.00000
+    4866 = 1.00000
+    4859 = 1.00000
+    4867 = 1.00000
+    4860 = 1.00000
+    4868 = 1.00000
+    4881 = 1.00000
+    4885 = 1.00000
+    4882 = 1.00000
+    4886 = 1.00000
+    4883 = 1.00000
+    4887 = 1.00000
+    4884 = 1.00000
+    4888 = 1.00000
+    4917 = 1.00000
+    4918 = 1.00000
+    4919 = 1.00000
+    4920 = 1.00000
+    4921 = 1.00000
+    4922 = 1.00000
+    4923 = 1.00000
+    4925 = 1.00000
+    4927 = 1.00000
+    4924 = 1.00000
+    4926 = 1.00000
+    4928 = 1.00000
+    4929 = 1.00000
+    4931 = 1.00000
+    4933 = 1.00000
+    4930 = 1.00000
+    4932 = 1.00000
+    4934 = 1.00000
+    4935 = 1.00000
+    4937 = 1.00000
+    4936 = 1.00000
+    4938 = 1.00000
+    4941 = 1.00000
+    4943 = 1.00000
+    4945 = 1.00000
+    4942 = 1.00000
+    4944 = 1.00000
+    4946 = 1.00000
+    4949 = 1.00000
+    4951 = 1.00000
+    4950 = 1.00000
+    4952 = 1.00000
+    4957 = 1.00000
+    4961 = 1.00000
+    4958 = 1.00000
+    4962 = 1.00000
+    4959 = 1.00000
+    4963 = 1.00000
+    4960 = 1.00000
+    4964 = 1.00000
+    4965 = 1.00000
+    4973 = 1.00000
+    4966 = 1.00000
+    4974 = 1.00000
+    4967 = 1.00000
+    4975 = 1.00000
+    4968 = 1.00000
+    4976 = 1.00000
+    4989 = 1.00000
+    4993 = 1.00000
+    4990 = 1.00000
+    4994 = 1.00000
+    4991 = 1.00000
+    4995 = 1.00000
+    4992 = 1.00000
+    4996 = 1.00000
+    5025 = 1.00000
+    5026 = 1.00000
+    5028 = 1.00000
+    5030 = 1.00000
+    5029 = 1.00000
+    5031 = 1.00000
+    5034 = 1.00000
+    5036 = 1.00000
+    5035 = 1.00000
+    5037 = 1.00000
+    5070 = 1.00000
+    5074 = 1.00000
+    5071 = 1.00000
+    5075 = 1.00000
+    5072 = 1.00000
+    5076 = 1.00000
+    5073 = 1.00000
+    5077 = 1.00000
+    5106 = 1.00000
+    5107 = 1.00000
+    5108 = 1.00000
+    5109 = 1.00000
+    5111 = 1.00000
+    5113 = 1.00000
+    5110 = 1.00000
+    5112 = 1.00000
+    5114 = 1.00000
+    5115 = 1.00000
+    5117 = 1.00000
+    5116 = 1.00000
+    5118 = 1.00000
+    5123 = 1.00000
+    5125 = 1.00000
+    5124 = 1.00000
+    5126 = 1.00000
+    5131 = 1.00000
+    5135 = 1.00000
+    5132 = 1.00000
+    5136 = 1.00000
+    5133 = 1.00000
+    5137 = 1.00000
+    5134 = 1.00000
+    5138 = 1.00000
+    5151 = 1.00000
+    5155 = 1.00000
+    5152 = 1.00000
+    5156 = 1.00000
+    5153 = 1.00000
+    5157 = 1.00000
+    5154 = 1.00000
+    5158 = 1.00000
+    5188 = 1.00000
+    5189 = 1.00000
+    5195 = 1.00000
+    5197 = 1.00000
+    5196 = 1.00000
+    5198 = 1.00000
+    5213 = 1.00000
+    5215 = 1.00000
+    5214 = 1.00000
+    5216 = 1.00000
+    5227 = 1.00000
+    5231 = 1.00000
+    5228 = 1.00000
+    5232 = 1.00000
+    5229 = 1.00000
+    5233 = 1.00000
+    5230 = 1.00000
+    5234 = 1.00000
+    5376 = 1.00000
+    5377 = 1.00000
+    5378 = 1.00000
+    5379 = 1.00000
+    5381 = 1.00000
+    5384 = 1.00000
+    5386 = 1.00000
+    5385 = 1.00000
+    5387 = 1.00000
+    5394 = 1.00000
+    5398 = 1.00000
+    5395 = 1.00000
+    5399 = 1.00000
+    5400 = 1.00000
+    5402 = 1.00000
+    5404 = 1.00000
+    5401 = 1.00000
+    5403 = 1.00000
+    5405 = 1.00000
+    5406 = 1.00000
+    5410 = 1.00000
+    5407 = 1.00000
+    5411 = 1.00000
+    5416 = 1.00000
+    5420 = 1.00000
+    5417 = 1.00000
+    5421 = 1.00000
+    5418 = 1.00000
+    5422 = 1.00000
+    5419 = 1.00000
+    5423 = 1.00000
+    5436 = 1.00000
+    5444 = 1.00000
+    5437 = 1.00000
+    5445 = 1.00000
+    5438 = 1.00000
+    5446 = 1.00000
+    5439 = 1.00000
+    5447 = 1.00000
+    5484 = 1.00000
+    5486 = 1.00000
+    5493 = 1.00000
+    5497 = 1.00000
+    5494 = 1.00000
+    5498 = 1.00000
+    5499 = 1.00000
+    5503 = 1.00000
+    5500 = 1.00000
+    5504 = 1.00000
+    5517 = 1.00000
+    5525 = 1.00000
+    5518 = 1.00000
+    5526 = 1.00000
+    5519 = 1.00000
+    5527 = 1.00000
+    5520 = 1.00000
+    5528 = 1.00000
+    5565 = 1.00000
+    5566 = 1.00000
+    5567 = 1.00000
+    5568 = 1.00000
+    5569 = 1.00000
+    5571 = 1.00000
+    5573 = 1.00000
+    5575 = 1.00000
+    5572 = 1.00000
+    5574 = 1.00000
+    5576 = 1.00000
+    5577 = 1.00000
+    5579 = 1.00000
+    5578 = 1.00000
+    5580 = 1.00000
+    5583 = 1.00000
+    5585 = 1.00000
+    5584 = 1.00000
+    5586 = 1.00000
+    5591 = 1.00000
+    5593 = 1.00000
+    5592 = 1.00000
+    5594 = 1.00000
+    5605 = 1.00000
+    5609 = 1.00000
+    5606 = 1.00000
+    5610 = 1.00000
+    5607 = 1.00000
+    5611 = 1.00000
+    5608 = 1.00000
+    5612 = 1.00000
+    5637 = 1.00000
+    5641 = 1.00000
+    5638 = 1.00000
+    5642 = 1.00000
+    5639 = 1.00000
+    5643 = 1.00000
+    5640 = 1.00000
+    5644 = 1.00000
+    5673 = 1.00000
+    5674 = 1.00000
+    5676 = 1.00000
+    5678 = 1.00000
+    5677 = 1.00000
+    5679 = 1.00000
+    5682 = 1.00000
+    5684 = 1.00000
+    5683 = 1.00000
+    5685 = 1.00000
+    5718 = 1.00000
+    5722 = 1.00000
+    5719 = 1.00000
+    5723 = 1.00000
+    5720 = 1.00000
+    5724 = 1.00000
+    5721 = 1.00000
+    5725 = 1.00000
+    5754 = 1.00000
+    5755 = 1.00000
+    5756 = 1.00000
+    5757 = 1.00000
+    5758 = 1.00000
+    5759 = 1.00000
+    5760 = 1.00000
+    5762 = 1.00000
+    5764 = 1.00000
+    5761 = 1.00000
+    5763 = 1.00000
+    5765 = 1.00000
+    5766 = 1.00000
+    5768 = 1.00000
+    5767 = 1.00000
+    5769 = 1.00000
+    5772 = 1.00000
+    5774 = 1.00000
+    5776 = 1.00000
+    5773 = 1.00000
+    5775 = 1.00000
+    5777 = 1.00000
+    5778 = 1.00000
+    5780 = 1.00000
+    5782 = 1.00000
+    5779 = 1.00000
+    5781 = 1.00000
+    5783 = 1.00000
+    5784 = 1.00000
+    5788 = 1.00000
+    5785 = 1.00000
+    5789 = 1.00000
+    5794 = 1.00000
+    5798 = 1.00000
+    5795 = 1.00000
+    5799 = 1.00000
+    5796 = 1.00000
+    5800 = 1.00000
+    5797 = 1.00000
+    5801 = 1.00000
+    5814 = 1.00000
+    5822 = 1.00000
+    5815 = 1.00000
+    5823 = 1.00000
+    5816 = 1.00000
+    5824 = 1.00000
+    5817 = 1.00000
+    5825 = 1.00000
+    5826 = 1.00000
+    5830 = 1.00000
+    5827 = 1.00000
+    5831 = 1.00000
+    5828 = 1.00000
+    5832 = 1.00000
+    5829 = 1.00000
+    5833 = 1.00000
+    5862 = 1.00000
+    5863 = 1.00000
+    5864 = 1.00000
+    5865 = 1.00000
+    5867 = 1.00000
+    5866 = 1.00000
+    5868 = 1.00000
+    5871 = 1.00000
+    5873 = 1.00000
+    5875 = 1.00000
+    5872 = 1.00000
+    5874 = 1.00000
+    5876 = 1.00000
+    5877 = 1.00000
+    5881 = 1.00000
+    5878 = 1.00000
+    5882 = 1.00000
+    5895 = 1.00000
+    5903 = 1.00000
+    5896 = 1.00000
+    5904 = 1.00000
+    5897 = 1.00000
+    5905 = 1.00000
+    5898 = 1.00000
+    5906 = 1.00000
+    5907 = 1.00000
+    5911 = 1.00000
+    5908 = 1.00000
+    5912 = 1.00000
+    5909 = 1.00000
+    5913 = 1.00000
+    5910 = 1.00000
+    5914 = 1.00000
+    6025 = 1.00000
+    6026 = 1.00000
+    6029 = 1.00000
+    6031 = 1.00000
+    6030 = 1.00000
+    6032 = 1.00000
+    6041 = 1.00000
+    6043 = 1.00000
+    6042 = 1.00000
+    6044 = 1.00000
+    6049 = 1.00000
+    6053 = 1.00000
+    6050 = 1.00000
+    6054 = 1.00000
+    6051 = 1.00000
+    6055 = 1.00000
+    6052 = 1.00000
+    6056 = 1.00000
+    6105 = 1.00000
+    6107 = 1.00000
+    6114 = 1.00000
+    6118 = 1.00000
+    6115 = 1.00000
+    6119 = 1.00000
+    6120 = 1.00000
+    6124 = 1.00000
+    6121 = 1.00000
+    6125 = 1.00000
+    6138 = 1.00000
+    6146 = 1.00000
+    6139 = 1.00000
+    6147 = 1.00000
+    6140 = 1.00000
+    6148 = 1.00000
+    6141 = 1.00000
+    6149 = 1.00000
+    6186 = 1.00000
+    6187 = 1.00000
+    6188 = 1.00000
+    6191 = 1.00000
+    6193 = 1.00000
+    6192 = 1.00000
+    6194 = 1.00000
+    6195 = 1.00000
+    6199 = 1.00000
+    6196 = 1.00000
+    6200 = 1.00000
+    6201 = 1.00000
+    6203 = 1.00000
+    6205 = 1.00000
+    6202 = 1.00000
+    6204 = 1.00000
+    6206 = 1.00000
+    6211 = 1.00000
+    6215 = 1.00000
+    6212 = 1.00000
+    6216 = 1.00000
+    6213 = 1.00000
+    6217 = 1.00000
+    6214 = 1.00000
+    6218 = 1.00000
+    6219 = 1.00000
+    6227 = 1.00000
+    6220 = 1.00000
+    6228 = 1.00000
+    6221 = 1.00000
+    6229 = 1.00000
+    6222 = 1.00000
+    6230 = 1.00000
+    6267 = 1.00000
+    6268 = 1.00000
+    6270 = 1.00000
+    6272 = 1.00000
+    6271 = 1.00000
+    6273 = 1.00000
+    6276 = 1.00000
+    6278 = 1.00000
+    6277 = 1.00000
+    6279 = 1.00000
+    6312 = 1.00000
+    6316 = 1.00000
+    6313 = 1.00000
+    6317 = 1.00000
+    6314 = 1.00000
+    6318 = 1.00000
+    6315 = 1.00000
+    6319 = 1.00000
+    6348 = 1.00000
+    6349 = 1.00000
+    6350 = 1.00000
+    6351 = 1.00000
+    6353 = 1.00000
+    6355 = 1.00000
+    6352 = 1.00000
+    6354 = 1.00000
+    6356 = 1.00000
+    6357 = 1.00000
+    6359 = 1.00000
+    6358 = 1.00000
+    6360 = 1.00000
+    6365 = 1.00000
+    6367 = 1.00000
+    6366 = 1.00000
+    6368 = 1.00000
+    6373 = 1.00000
+    6377 = 1.00000
+    6374 = 1.00000
+    6378 = 1.00000
+    6375 = 1.00000
+    6379 = 1.00000
+    6376 = 1.00000
+    6380 = 1.00000
+    6393 = 1.00000
+    6397 = 1.00000
+    6394 = 1.00000
+    6398 = 1.00000
+    6395 = 1.00000
+    6399 = 1.00000
+    6396 = 1.00000
+    6400 = 1.00000
+    6429 = 1.00000
+    6430 = 1.00000
+    6431 = 1.00000
+    6432 = 1.00000
+    6434 = 1.00000
+    6433 = 1.00000
+    6435 = 1.00000
+    6438 = 1.00000
+    6440 = 1.00000
+    6442 = 1.00000
+    6439 = 1.00000
+    6441 = 1.00000
+    6443 = 1.00000
+    6444 = 1.00000
+    6448 = 1.00000
+    6445 = 1.00000
+    6449 = 1.00000
+    6462 = 1.00000
+    6470 = 1.00000
+    6463 = 1.00000
+    6471 = 1.00000
+    6464 = 1.00000
+    6472 = 1.00000
+    6465 = 1.00000
+    6473 = 1.00000
+    6474 = 1.00000
+    6478 = 1.00000
+    6475 = 1.00000
+    6479 = 1.00000
+    6476 = 1.00000
+    6480 = 1.00000
+    6477 = 1.00000
+    6481 = 1.00000
+    6510 = 1.00000
+    6511 = 1.00000
+    6512 = 1.00000
+    6513 = 1.00000
+    6515 = 1.00000
+    6517 = 1.00000
+    6514 = 1.00000
+    6516 = 1.00000
+    6518 = 1.00000
+    6519 = 1.00000
+    6521 = 1.00000
+    6523 = 1.00000
+    6520 = 1.00000
+    6522 = 1.00000
+    6524 = 1.00000
+    6525 = 1.00000
+    6527 = 1.00000
+    6529 = 1.00000
+    6526 = 1.00000
+    6528 = 1.00000
+    6530 = 1.00000
+    6535 = 1.00000
+    6539 = 1.00000
+    6536 = 1.00000
+    6540 = 1.00000
+    6537 = 1.00000
+    6541 = 1.00000
+    6538 = 1.00000
+    6542 = 1.00000
+    6543 = 1.00000
+    6551 = 1.00000
+    6544 = 1.00000
+    6552 = 1.00000
+    6545 = 1.00000
+    6553 = 1.00000
+    6546 = 1.00000
+    6554 = 1.00000
+    6555 = 1.00000
+    6559 = 1.00000
+    6556 = 1.00000
+    6560 = 1.00000
+    6557 = 1.00000
+    6561 = 1.00000
+    6558 = 1.00000
+    6562 = 1.00000

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.