]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Derive CylindricalManifold from ChartManifold
authorDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Sun, 4 Jun 2017 23:37:38 +0000 (01:37 +0200)
committerDaniel Arndt <daniel.arndt@iwr.uni-heidelberg.de>
Mon, 5 Jun 2017 23:28:16 +0000 (01:28 +0200)
doc/news/changes/minor/20170605DanielArndt [new file with mode: 0644]
include/deal.II/grid/manifold_lib.h
source/grid/manifold_lib.cc
source/grid/manifold_lib.inst.in
tests/manifold/transfinite_manifold_02.output
tests/manifold/transfinite_manifold_03.output
tests/mappings/data_out_curved_geometry_3d.output
tests/mappings/mapping_q_mixed_manifolds_01.output
tests/mappings/mapping_q_mixed_manifolds_02.output

diff --git a/doc/news/changes/minor/20170605DanielArndt b/doc/news/changes/minor/20170605DanielArndt
new file mode 100644 (file)
index 0000000..9ad8703
--- /dev/null
@@ -0,0 +1,4 @@
+Improved: CylindricalManifold is now really using cylindrical coordinates
+instead of taking an average in space coordinates.
+<br>
+(Daniel Arndt, 2017/06/05)
index b92941bf5caf8cbe0c624c9c8016daebabfc602a..53d59fed5d87f6477a88aa8f29019635d949dc0e 100644 (file)
@@ -251,15 +251,15 @@ public:
  * its axis and a point located on the axis.
  *
  * This class was developed to be used in conjunction with the @p cylinder or
- * @p cylinder_shell functions of GridGenerator. This function will throw an
- * exception whenever spacedim is not equal to three.
+ * @p cylinder_shell functions of GridGenerator. This function will throw a
+ * compile time exception whenever spacedim is not equal to three.
  *
  * @ingroup manifold
  *
- * @author Luca Heltai, 2014
+ * @author Luca Heltai, Daniel Arndt, 2014, 2017
  */
 template <int dim, int spacedim = dim>
-class CylindricalManifold : public Manifold<dim,spacedim>
+class CylindricalManifold : public ChartManifold<dim,spacedim,3>
 {
 public:
   /**
@@ -282,30 +282,51 @@ public:
                        const Point<spacedim> &point_on_axis,
                        const double tolerance = 1e-10);
 
+  /**
+   * Compute the cartesian coordinates for a point given in cylindrical
+   * coordinates.
+   */
+  virtual Point<3>
+  pull_back(const Point<spacedim> &space_point) const override;
+
+  /**
+   * Compute the cylindrical coordinates \f$(r, \phi, \lambda)\f$ for the given
+   * point where \f$r\f$ denotes the distance from the axis,
+   * \f$\phi\f$ the angle between the given point and the computed normal
+   * direction and \f$\lambda\f$ the axial position.
+   */
+  virtual Point<spacedim>
+  push_forward(const Point<3> &chart_point) const override;
+
   /**
    * Compute new points on the CylindricalManifold. See the documentation of
    * the base class for a detailed description of what this function does.
    */
   virtual Point<spacedim>
   get_new_point(const std::vector<Point<spacedim> > &surrounding_points,
-                const std::vector<double>           &weights) const;
+                const std::vector<double>           &weights) const override;
+
+private:
+  /**
+   * Compute a vector that is orthogonal to the given one.
+   * Used for initializing the member variable normal_direction.
+   */
+  Point<spacedim> compute_normal(const Tensor<1,spacedim> &vector) const;
 
-protected:
   /**
-   * The direction vector of the axis.
+   * A vector orthogonal to direcetion.
    */
-  const Point<spacedim> direction;
+  const Tensor<1,spacedim> normal_direction;
 
   /**
-   * An arbitrary point on the axis.
+   * The direction vector of the axis.
    */
-  const Point<spacedim> point_on_axis;
+  const Tensor<1,spacedim> direction;
 
-private:
   /**
-   * Helper FlatManifold to compute tentative midpoints.
+   * An arbitrary point on the axis.
    */
-  FlatManifold<dim,spacedim> flat_manifold;
+  const Point<spacedim> point_on_axis;
 
   /**
    * Relative tolerance to measure zero distances.
index 1de6dbb3335d5417d7d919357129274d1e730aa5..f4d6e35663b623d692036e3b10893cc6bb60764a 100644 (file)
@@ -301,29 +301,67 @@ get_new_point (const std::vector<Point<spacedim> > &vertices,
 // ============================================================
 
 template <int dim, int spacedim>
-CylindricalManifold<dim,spacedim>::CylindricalManifold(const unsigned int axis,
-                                                       const double tolerance) :
-  direction (Point<spacedim>::unit_vector(axis)),
-  point_on_axis (Point<spacedim>()),
-  tolerance(tolerance)
+CylindricalManifold<dim, spacedim>::CylindricalManifold(const unsigned int axis,
+                                                        const double tolerance) :
+  ChartManifold<dim,spacedim,3>(Tensor<1,3>({0,2.*numbers::PI,0})),
+              normal_direction(compute_normal(Point<3>::unit_vector(axis))),
+              direction (Point<3>::unit_vector(axis)),
+              point_on_axis (Point<3>()),
+              tolerance(tolerance)
 {
-  Assert(spacedim > 1, ExcImpossibleInDim(1));
+  static_assert(spacedim==3,
+                "CylindricalManifold can only be used for spacedim==3!");
 }
 
 
+
 template <int dim, int spacedim>
-CylindricalManifold<dim,spacedim>::CylindricalManifold(const Point<spacedim> &direction,
-                                                       const Point<spacedim> &point_on_axis,
-                                                       const double tolerance) :
-  direction (direction),
-  point_on_axis (point_on_axis),
-  tolerance(tolerance)
+CylindricalManifold<dim, spacedim>::CylindricalManifold(const Point<spacedim> &direction_,
+                                                        const Point<spacedim> &point_on_axis_,
+                                                        const double tolerance) :
+  ChartManifold<dim,3,3>(Tensor<1,3>({0,2.*numbers::PI,0})),
+              normal_direction(compute_normal(direction_)),
+              direction (direction_/direction_.norm()),
+              point_on_axis (point_on_axis_),
+              tolerance(tolerance)
 {
-  Assert(spacedim > 2, ExcImpossibleInDim(spacedim));
+  static_assert(spacedim==3,
+                "CylindricalManifold can only be used for spacedim==3!");
 }
 
 
 
+template <int dim, int spacedim>
+Point<spacedim>
+CylindricalManifold<dim, spacedim>::compute_normal(const Tensor<1,spacedim> &vector) const
+{
+  AssertThrow(vector.norm() != 0.,
+              ExcMessage("The direction parameter must not be zero!"));
+  Point<3> normal;
+  if (std::abs(vector[0]) >= std::abs(vector[1])
+      && std::abs(vector[0]) >= std::abs(vector[2]))
+    {
+      normal[1]=-1.;
+      normal[2]=-1.;
+      normal[0]=(vector[1]+vector[2])/vector[0];
+    }
+  else if (std::abs(vector[1]) >= std::abs(vector[0])
+           && std::abs(vector[1]) >= std::abs(vector[2]))
+    {
+      normal[0]=-1.;
+      normal[2]=-1.;
+      normal[1]=(vector[0]+vector[2])/vector[1];
+    }
+  else
+    {
+      normal[0]=-1.;
+      normal[1]=-1.;
+      normal[2]=(vector[0]+vector[1])/vector[2];
+    }
+  return normal;
+}
+
+
 
 template <int dim, int spacedim>
 Point<spacedim>
@@ -331,38 +369,78 @@ CylindricalManifold<dim,spacedim>::
 get_new_point (const std::vector<Point<spacedim> > &surrounding_points,
                const std::vector<double>           &weights) const
 {
-  // compute a proposed new point
-  const Point<spacedim> middle = flat_manifold.get_new_point(surrounding_points,
-                                                             weights);
-
-  double radius = 0;
-  Tensor<1,spacedim> on_plane;
-
+  // First check if the the average in space lies on the axis.
+  Point<spacedim> middle;
+  double average_length = 0.;
   for (unsigned int i=0; i<surrounding_points.size(); ++i)
     {
-      on_plane = surrounding_points[i]-point_on_axis;
-      on_plane = on_plane - (on_plane*direction) * direction;
-      radius += weights[i]*on_plane.norm();
+      middle += surrounding_points[i]*weights[i];
+      average_length += surrounding_points[i].square()*weights[i];
     }
+  middle -= point_on_axis;
+  const double lambda = middle*direction;
+
+  if ((middle-direction*lambda).square() < tolerance*average_length)
+    return Point<spacedim>()+direction*lambda;
+  else // If not, using the ChartManifold should yield valid results.
+    return ChartManifold<dim, spacedim, 3>::get_new_point(surrounding_points,
+                                                          weights);
+}
 
-  // we then have to project this point out to the given radius from
-  // the axis. to this end, we have to take into account the offset
-  // point_on_axis and the direction of the axis
-  const Tensor<1,spacedim> vector_from_axis = (middle-point_on_axis) -
-                                              ((middle-point_on_axis) * direction) * direction;
 
-  // scale it to the desired length and put everything back together,
-  // unless we have a point on the axis
-  if (vector_from_axis.norm() <= tolerance * middle.norm())
-    return middle;
 
-  else
-    return Point<spacedim>((vector_from_axis / vector_from_axis.norm() * radius +
-                            ((middle-point_on_axis) * direction) * direction +
-                            point_on_axis));
+template <int dim, int spacedim>
+Point<3>
+CylindricalManifold<dim, spacedim>::pull_back(const Point<spacedim> &space_point) const
+{
+  // First find the projection of the given point to the axis.
+  const Tensor<1,3> normalized_point = space_point-point_on_axis;
+  const double lambda = normalized_point*direction;
+  const Point<3> projection = point_on_axis + direction*lambda;
+  const Tensor<1,3> p_diff = space_point - projection;
+
+  // Then compute the angle between the projection direction and
+  // another vector orthogonal to the direction vector.
+  const double dot = normal_direction*p_diff;
+  const double det = direction*cross_product_3d(normal_direction, p_diff);
+  const double phi = std::atan2(det, dot);
+
+  // Return distance from the axis, angle and signed distance on the axis.
+  return Point<3> (p_diff.norm(), phi, lambda);
+}
+
+
+
+template <int dim, int spacedim>
+Point<spacedim>
+CylindricalManifold<dim, spacedim>::push_forward(const Point<3> &chart_point) const
+{
+  // Rotate the orthogonal direction by the given angle.
+  // Formula from Section 5.2 in
+  // http://inside.mines.edu/fs_home/gmurray/ArbitraryAxisRotation/
+  // simplified assuming normal_direction and direction are orthogonal.
+  const double sine = std::sin(chart_point(1));
+  const double cosine = std::cos(chart_point(1));
+  const double x = normal_direction[0]*cosine
+                   -sine*(direction[2]*normal_direction[1]
+                          -direction[1]*normal_direction[2]);
+  const double y = normal_direction[1]*cosine
+                   -sine*(direction[0]*normal_direction[2]
+                          -direction[2]*normal_direction[0]);
+  const double z = normal_direction[2]*cosine
+                   -sine*(direction[1]*normal_direction[0]
+                          -direction[0]*normal_direction[1]);
+
+  // Rescale according to the given distance from the axis.
+  Point<3> intermediate (x,y,z);
+  intermediate *= chart_point(0)/std::sqrt(intermediate.square());
+
+  // Finally, put everything together.
+  return intermediate+point_on_axis+direction*chart_point(2);
 }
 
 
+
 // ============================================================
 // FunctionManifold
 // ============================================================
index 911f3bf7d97052f32128ca967927ae4af54e3413..b3387bf72023c68f64b379c5fdd82d8111b0dec6 100644 (file)
 //
 // ---------------------------------------------------------------------
 
+for (deal_II_dimension : DIMENSIONS)
+{
+    template class CylindricalManifold<deal_II_dimension, 3>;
+}
 
 for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS)
 {
 #if deal_II_dimension <= deal_II_space_dimension
     template class PolarManifold<deal_II_dimension, deal_II_space_dimension>;
     template class SphericalManifold<deal_II_dimension, deal_II_space_dimension>;
-    template class CylindricalManifold<deal_II_dimension, deal_II_space_dimension>;
 #if deal_II_dimension > 1
     template class TransfiniteInterpolationManifold<deal_II_dimension, deal_II_space_dimension>;
 #endif
index 75b400ae87cf858d1330de2eb524504fe93fdea3..edd55864f187d322dc37586dbd6d4519a16f5895 100644 (file)
@@ -171,9 +171,9 @@ DEAL::6.93889e-18 -0.394338 -0.394338
 DEAL::6.93889e-18 0.394338 -0.394338
 DEAL::0.00000 0.00000 -1.00000
 DEAL::0.00000 0.00000 -0.211325
-DEAL::Center with manifold: -1.11022e-16 -1.11022e-16 -0.571260
-DEAL::Distance between cell manifold and face manifold: 1.11022e-16 -1.11022e-16 -1.11022e-16
-DEAL::Distance between cell manifold and face manifold: -1.38778e-17 -1.11022e-16 -1.11022e-16
+DEAL::Center with manifold: -5.89806e-17 2.08167e-17 -0.571260
+DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
+DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Lines on cell with center: 0.394338 0.00000 2.08167e-17
 DEAL::0.394338 -0.394338 -0.394338
 DEAL::0.394338 0.394338 -0.394338
@@ -196,7 +196,7 @@ DEAL::0.394338 0.00000 -0.394338
 DEAL::0.394338 0.00000 0.394338
 DEAL::Center with manifold: 0.571260 2.08167e-17 -5.55112e-17
 DEAL::Distance between cell manifold and face manifold: 1.11022e-16 -1.11022e-16 5.55112e-17
-DEAL::Distance between cell manifold and face manifold: 1.11022e-16 -1.11022e-16 -1.38778e-17
+DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 -1.38778e-16
 DEAL::Lines on cell with center: 0.00000 2.08167e-17 0.394338
 DEAL::-0.394338 -0.394338 0.394338
 DEAL::0.394338 -0.394338 0.394338
@@ -218,8 +218,8 @@ DEAL::0.00000 0.00000 0.211325
 DEAL::0.00000 -0.394338 0.394338
 DEAL::0.00000 0.394338 0.394338
 DEAL::Center with manifold: 2.08167e-17 -5.55112e-17 0.571260
-DEAL::Distance between cell manifold and face manifold: -1.11022e-16 5.55112e-17 1.11022e-16
-DEAL::Distance between cell manifold and face manifold: -1.11022e-16 -1.94289e-16 1.11022e-16
+DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
+DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Lines on cell with center: -0.394338 3.46945e-18 1.73472e-17
 DEAL::-0.707107 0.00000 -0.707107
 DEAL::-0.211325 0.00000 -0.211325
@@ -240,9 +240,9 @@ DEAL::-0.394338 -0.394338 0.00000
 DEAL::-0.394338 0.394338 0.00000
 DEAL::-0.394338 0.00000 -0.394338
 DEAL::-0.394338 6.93889e-18 0.394338
-DEAL::Center with manifold: -0.571260 -3.81639e-17 -1.73472e-17
-DEAL::Distance between cell manifold and face manifold: -1.11022e-16 1.11022e-16 -1.11022e-16
-DEAL::Distance between cell manifold and face manifold: -1.11022e-16 -1.38778e-17 -1.11022e-16
+DEAL::Center with manifold: -0.571260 -2.77556e-17 -6.93889e-18
+DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
+DEAL::Distance between cell manifold and face manifold: 0.00000 -1.38778e-16 0.00000
 DEAL::Lines on cell with center: 0.00000 -0.394338 2.08167e-17
 DEAL::-0.394338 -0.394338 -0.394338
 DEAL::0.394338 -0.394338 -0.394338
@@ -264,8 +264,8 @@ DEAL::0.00000 -0.211325 0.00000
 DEAL::6.93889e-18 -0.394338 -0.394338
 DEAL::0.00000 -0.394338 0.394338
 DEAL::Center with manifold: 2.08167e-17 -0.571260 -5.55112e-17
-DEAL::Distance between cell manifold and face manifold: 1.11022e-16 -2.22045e-16 -5.55112e-17
-DEAL::Distance between cell manifold and face manifold: -2.22045e-16 -2.22045e-16 -9.71445e-17
+DEAL::Distance between cell manifold and face manifold: -1.11022e-16 1.11022e-16 0.00000
+DEAL::Distance between cell manifold and face manifold: -2.22045e-16 -2.22045e-16 0.00000
 DEAL::Lines on cell with center: 3.46945e-18 0.394338 1.73472e-17
 DEAL::0.00000 0.707107 -0.707107
 DEAL::0.00000 0.211325 -0.211325
@@ -286,7 +286,7 @@ DEAL::-0.394338 0.394338 0.00000
 DEAL::0.394338 0.394338 6.93889e-18
 DEAL::6.93889e-18 0.394338 -0.394338
 DEAL::0.00000 0.394338 0.394338
-DEAL::Center with manifold: -3.81639e-17 0.571260 -1.73472e-17
+DEAL::Center with manifold: -2.77556e-17 0.571260 -6.93889e-18
 DEAL::Distance between cell manifold and face manifold: 1.11022e-16 1.11022e-16 -1.11022e-16
 DEAL::Distance between cell manifold and face manifold: -1.38778e-17 1.11022e-16 -1.11022e-16
 DEAL::
@@ -294,8 +294,8 @@ DEAL::Testing with CylindricalManifold in 3d
 DEAL::Lines on cell with center: -0.500000 0.00000 -0.500000
 DEAL::-0.500000 0.707107 -0.707107
 DEAL::-0.500000 -0.707107 -0.707107
-DEAL::-1.00000 0.00000 -1.00000
-DEAL::0.00000 0.00000 -1.00000
+DEAL::-1.00000 -7.85046e-17 -1.00000
+DEAL::3.47661e-310 -7.85046e-17 -1.00000
 DEAL::-0.500000 0.292893 -0.292893
 DEAL::-0.500000 -0.292893 -0.292893
 DEAL::-1.00000 0.00000 -0.292893
@@ -307,14 +307,14 @@ DEAL::0.00000 -0.500000 -0.500000
 DEAL::Faces on cell with center: -0.500000 0.00000 -0.500000
 DEAL::-0.500000 0.500000 -0.500000
 DEAL::-0.500000 -0.500000 -0.500000
-DEAL::-1.00000 0.00000 -0.646447
+DEAL::-1.00000 -4.16334e-17 -0.646447
 DEAL::0.00000 0.00000 -0.500000
-DEAL::-0.500000 0.00000 -1.00000
+DEAL::-0.500000 -7.85046e-17 -1.00000
 DEAL::-0.500000 0.00000 -0.292893
-DEAL::Center with manifold: -0.500000 0.00000 -0.634243
-DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
+DEAL::Center with manifold: -0.500000 -3.46945e-17 -0.634243
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
+DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 -2.22045e-16
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Lines on cell with center: -0.500000 0.500000 -6.93889e-18
 DEAL::-0.500000 0.707107 -0.707107
@@ -325,18 +325,18 @@ DEAL::-0.500000 0.707107 0.707107
 DEAL::-0.500000 0.292893 0.292893
 DEAL::-1.00000 0.500000 0.500000
 DEAL::0.00000 0.500000 0.500000
-DEAL::-1.00000 1.00000 0.00000
+DEAL::-1.00000 1.00000 -7.85046e-17
 DEAL::-1.00000 0.292893 0.00000
-DEAL::0.00000 1.00000 0.00000
+DEAL::-3.47661e-310 1.00000 -7.85046e-17
 DEAL::0.00000 0.292893 0.00000
 DEAL::Faces on cell with center: -0.500000 0.500000 -6.93889e-18
-DEAL::-0.500000 1.00000 0.00000
+DEAL::-0.500000 1.00000 -7.85046e-17
 DEAL::-0.500000 0.292893 0.00000
-DEAL::-1.00000 0.646447 0.00000
+DEAL::-1.00000 0.646447 -4.16334e-17
 DEAL::0.00000 0.500000 0.00000
 DEAL::-0.500000 0.500000 -0.500000
 DEAL::-0.500000 0.500000 0.500000
-DEAL::Center with manifold: -0.500000 0.634243 1.66533e-16
+DEAL::Center with manifold: -0.500000 0.634243 -4.16334e-17
 DEAL::Distance between cell manifold and face manifold: -2.77556e-17 0.00000 0.00000
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
@@ -367,8 +367,8 @@ DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Lines on cell with center: -0.500000 -0.500000 0.00000
 DEAL::-0.500000 -0.707107 -0.707107
 DEAL::-0.500000 -0.707107 0.707107
-DEAL::-1.00000 -1.00000 0.00000
-DEAL::0.00000 -1.00000 0.00000
+DEAL::-1.00000 -1.00000 2.35514e-16
+DEAL::3.47661e-310 -1.00000 2.35514e-16
 DEAL::-0.500000 -0.292893 -0.292893
 DEAL::-0.500000 -0.292893 0.292893
 DEAL::-1.00000 -0.292893 0.00000
@@ -380,11 +380,11 @@ DEAL::0.00000 -0.500000 0.500000
 DEAL::Faces on cell with center: -0.500000 -0.500000 0.00000
 DEAL::-0.500000 -0.500000 -0.500000
 DEAL::-0.500000 -0.500000 0.500000
-DEAL::-1.00000 -0.646447 0.00000
+DEAL::-1.00000 -0.646447 1.11022e-16
 DEAL::0.00000 -0.500000 0.00000
-DEAL::-0.500000 -1.00000 0.00000
+DEAL::-0.500000 -1.00000 2.35514e-16
 DEAL::-0.500000 -0.292893 0.00000
-DEAL::Center with manifold: -0.500000 -0.634243 0.00000
+DEAL::Center with manifold: -0.500000 -0.634243 1.11022e-16
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
@@ -398,18 +398,18 @@ DEAL::-0.500000 -0.707107 0.707107
 DEAL::-0.500000 -0.292893 0.292893
 DEAL::-1.00000 -0.500000 0.500000
 DEAL::0.00000 -0.500000 0.500000
-DEAL::-1.00000 0.00000 1.00000
+DEAL::-1.00000 1.57009e-16 1.00000
 DEAL::-1.00000 0.00000 0.292893
-DEAL::0.00000 0.00000 1.00000
+DEAL::-3.47661e-310 1.57009e-16 1.00000
 DEAL::0.00000 0.00000 0.292893
 DEAL::Faces on cell with center: -0.500000 6.93889e-18 0.500000
-DEAL::-0.500000 0.00000 1.00000
+DEAL::-0.500000 1.57009e-16 1.00000
 DEAL::-0.500000 0.00000 0.292893
-DEAL::-1.00000 0.00000 0.646447
+DEAL::-1.00000 8.32667e-17 0.646447
 DEAL::0.00000 0.00000 0.500000
 DEAL::-0.500000 0.500000 0.500000
 DEAL::-0.500000 -0.500000 0.500000
-DEAL::Center with manifold: -0.500000 -1.66533e-16 0.634243
+DEAL::Center with manifold: -0.500000 9.71445e-17 0.634243
 DEAL::Distance between cell manifold and face manifold: -2.77556e-17 0.00000 0.00000
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
@@ -417,8 +417,8 @@ DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Lines on cell with center: 0.500000 0.00000 -0.500000
 DEAL::0.500000 0.707107 -0.707107
 DEAL::0.500000 -0.707107 -0.707107
-DEAL::0.00000 0.00000 -1.00000
-DEAL::1.00000 0.00000 -1.00000
+DEAL::3.47661e-310 -7.85046e-17 -1.00000
+DEAL::1.00000 -7.85046e-17 -1.00000
 DEAL::0.500000 0.292893 -0.292893
 DEAL::0.500000 -0.292893 -0.292893
 DEAL::0.00000 0.00000 -0.292893
@@ -432,12 +432,12 @@ DEAL::0.500000 0.500000 -0.500000
 DEAL::0.500000 -0.500000 -0.500000
 DEAL::0.00000 0.00000 -0.500000
 DEAL::1.00000 0.00000 -0.500000
-DEAL::0.500000 0.00000 -1.00000
+DEAL::0.500000 -7.85046e-17 -1.00000
 DEAL::0.500000 0.00000 -0.292893
-DEAL::Center with manifold: 0.500000 0.00000 -0.622039
+DEAL::Center with manifold: 0.500000 -3.46945e-17 -0.622039
 DEAL::Distance between cell manifold and face manifold: 0.00000 5.55112e-17 -5.55112e-17
-DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
-DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
+DEAL::Distance between cell manifold and face manifold: 0.00000 1.11022e-16 0.00000
+DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 -2.22045e-16
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Lines on cell with center: 0.500000 0.500000 -6.93889e-18
 DEAL::0.500000 0.707107 -0.707107
@@ -448,22 +448,22 @@ DEAL::0.500000 0.707107 0.707107
 DEAL::0.500000 0.292893 0.292893
 DEAL::0.00000 0.500000 0.500000
 DEAL::1.00000 0.500000 0.500000
-DEAL::0.00000 1.00000 0.00000
+DEAL::-3.47661e-310 1.00000 -7.85046e-17
 DEAL::0.00000 0.292893 0.00000
-DEAL::1.00000 1.00000 0.00000
+DEAL::1.00000 1.00000 -7.85046e-17
 DEAL::1.00000 0.292893 0.00000
 DEAL::Faces on cell with center: 0.500000 0.500000 -6.93889e-18
-DEAL::0.500000 1.00000 0.00000
+DEAL::0.500000 1.00000 -7.85046e-17
 DEAL::0.500000 0.292893 0.00000
 DEAL::0.00000 0.500000 0.00000
 DEAL::1.00000 0.500000 0.00000
 DEAL::0.500000 0.500000 -0.500000
 DEAL::0.500000 0.500000 0.500000
-DEAL::Center with manifold: 0.500000 0.622039 1.52656e-16
+DEAL::Center with manifold: 0.500000 0.622039 -2.77556e-17
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
-DEAL::Distance between cell manifold and face manifold: 0.00000 -0.0737620 -0.0590096
-DEAL::Distance between cell manifold and face manifold: 0.00000 -0.287930 0.0287930
+DEAL::Distance between cell manifold and face manifold: 0.00000 -0.101910 -0.0220998
+DEAL::Distance between cell manifold and face manifold: 0.00000 -0.289811 0.00774842
 DEAL::Lines on cell with center: 0.500000 0.00000 1.38778e-17
 DEAL::0.500000 0.292893 -0.292893
 DEAL::0.500000 -0.292893 -0.292893
@@ -490,8 +490,8 @@ DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Lines on cell with center: 0.500000 -0.500000 0.00000
 DEAL::0.500000 -0.707107 -0.707107
 DEAL::0.500000 -0.707107 0.707107
-DEAL::0.00000 -1.00000 0.00000
-DEAL::1.00000 -1.00000 0.00000
+DEAL::3.47661e-310 -1.00000 2.35514e-16
+DEAL::1.00000 -1.00000 2.35514e-16
 DEAL::0.500000 -0.292893 -0.292893
 DEAL::0.500000 -0.292893 0.292893
 DEAL::0.00000 -0.292893 0.00000
@@ -505,11 +505,11 @@ DEAL::0.500000 -0.500000 -0.500000
 DEAL::0.500000 -0.500000 0.500000
 DEAL::0.00000 -0.500000 0.00000
 DEAL::1.00000 -0.500000 0.00000
-DEAL::0.500000 -1.00000 0.00000
+DEAL::0.500000 -1.00000 2.35514e-16
 DEAL::0.500000 -0.292893 0.00000
-DEAL::Center with manifold: 0.500000 -0.622039 0.00000
+DEAL::Center with manifold: 0.500000 -0.622039 9.71445e-17
 DEAL::Distance between cell manifold and face manifold: 0.00000 -5.55112e-17 -5.55112e-17
-DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
+DEAL::Distance between cell manifold and face manifold: 0.00000 -1.11022e-16 -1.11022e-16
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Lines on cell with center: 0.500000 6.93889e-18 0.500000
@@ -521,20 +521,20 @@ DEAL::0.500000 -0.707107 0.707107
 DEAL::0.500000 -0.292893 0.292893
 DEAL::0.00000 -0.500000 0.500000
 DEAL::1.00000 -0.500000 0.500000
-DEAL::0.00000 0.00000 1.00000
+DEAL::-3.47661e-310 1.57009e-16 1.00000
 DEAL::0.00000 0.00000 0.292893
-DEAL::1.00000 0.00000 1.00000
+DEAL::1.00000 1.57009e-16 1.00000
 DEAL::1.00000 0.00000 0.292893
 DEAL::Faces on cell with center: 0.500000 6.93889e-18 0.500000
-DEAL::0.500000 0.00000 1.00000
+DEAL::0.500000 1.57009e-16 1.00000
 DEAL::0.500000 0.00000 0.292893
 DEAL::0.00000 0.00000 0.500000
 DEAL::1.00000 0.00000 0.500000
 DEAL::0.500000 0.500000 0.500000
 DEAL::0.500000 -0.500000 0.500000
-DEAL::Center with manifold: 0.500000 -1.52656e-16 0.622039
+DEAL::Center with manifold: 0.500000 6.93889e-17 0.622039
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
 DEAL::Distance between cell manifold and face manifold: 0.00000 0.00000 0.00000
-DEAL::Distance between cell manifold and face manifold: 0.00000 0.0590096 -0.0737620
-DEAL::Distance between cell manifold and face manifold: 0.00000 -0.0287930 -0.287930
+DEAL::Distance between cell manifold and face manifold: 0.00000 0.0220998 -0.101910
+DEAL::Distance between cell manifold and face manifold: 0.00000 -0.00774842 -0.289811
 DEAL::
index 276ab46d87f8d4afdf7a8e9cda84dcdf77c9ba4e..78c821c765cb770e71240f4265d6e61c12bdb663 100644 (file)
@@ -19,7 +19,7 @@ DEAL::56   cells, degree=4: 4.18868242879
 DEAL::
 DEAL::Testing with CylindricalManifold in 3d
 DEAL::80   cells, degree=1: 5.65685424949 
-DEAL::80   cells, degree=2: 6.25775643968 
-DEAL::80   cells, degree=3: 6.28283082764 
-DEAL::80   cells, degree=4: 6.28312774156 
+DEAL::80   cells, degree=2: 6.27829514062 
+DEAL::80   cells, degree=3: 6.28316607872 
+DEAL::80   cells, degree=4: 6.28318526295 
 DEAL::
index 8c96cee32c5095bd6add795b5c19bc7991e4bda7..b1103e0bc83df3411bf4d2fca9faa56c0b6c9bac 100644 (file)
@@ -373,31 +373,31 @@ DATASET UNSTRUCTURED_GRID
 
 POINTS 270 double
 -1.00000 0.707107 -0.707107
--1.00000 0.00000 -1.00000
+-1.00000 -7.85046e-17 -1.00000
 -1.00000 -0.707107 -0.707107
 -0.500000 0.707107 -0.707107
--0.500000 0.00000 -1.00000
+-0.500000 -7.85046e-17 -1.00000
 -0.500000 -0.707107 -0.707107
 0.00000 0.707107 -0.707107
-0.00000 0.00000 -1.00000
+0.00000 -7.85046e-17 -1.00000
 0.00000 -0.707107 -0.707107
 -1.00000 0.500000 -0.500000
--1.00000 0.00000 -0.707107
+-1.00000 -5.55112e-17 -0.707107
 -1.00000 -0.500000 -0.500000
 -0.500000 0.500000 -0.500000
--0.500000 0.00000 -0.707107
+-0.500000 -5.55112e-17 -0.707107
 -0.500000 -0.500000 -0.500000
 0.00000 0.500000 -0.500000
-0.00000 0.00000 -0.707107
+0.00000 -5.55112e-17 -0.707107
 0.00000 -0.500000 -0.500000
 -1.00000 0.292893 -0.292893
--1.00000 0.00000 -0.414214
+-1.00000 -3.25177e-17 -0.414214
 -1.00000 -0.292893 -0.292893
 -0.500000 0.292893 -0.292893
--0.500000 0.00000 -0.414214
+-0.500000 -3.25177e-17 -0.414214
 -0.500000 -0.292893 -0.292893
 0.00000 0.292893 -0.292893
-0.00000 0.00000 -0.414214
+0.00000 -3.25177e-17 -0.414214
 0.00000 -0.292893 -0.292893
 -1.00000 0.707107 -0.707107
 -1.00000 0.500000 -0.500000
@@ -408,15 +408,15 @@ POINTS 270 double
 0.00000 0.707107 -0.707107
 0.00000 0.500000 -0.500000
 0.00000 0.292893 -0.292893
--1.00000 1.00000 0.00000
--1.00000 0.707107 -1.96262e-17
--1.00000 0.414214 0.00000
--0.500000 1.00000 0.00000
--0.500000 0.707107 -9.81308e-18
--0.500000 0.414214 0.00000
-0.00000 1.00000 0.00000
-0.00000 0.707107 -1.96262e-17
-0.00000 0.414214 0.00000
+-1.00000 1.00000 -7.85046e-17
+-1.00000 0.707107 -5.55112e-17
+-1.00000 0.414214 -3.25177e-17
+-0.500000 1.00000 -7.85046e-17
+-0.500000 0.707107 -5.55112e-17
+-0.500000 0.414214 -3.25177e-17
+0.00000 1.00000 -7.85046e-17
+0.00000 0.707107 -5.55112e-17
+0.00000 0.414214 -3.25177e-17
 -1.00000 0.707107 0.707107
 -1.00000 0.500000 0.500000
 -1.00000 0.292893 0.292893
@@ -427,58 +427,58 @@ POINTS 270 double
 0.00000 0.500000 0.500000
 0.00000 0.292893 0.292893
 -1.00000 0.292893 -0.292893
--1.00000 0.00000 -0.414214
+-1.00000 -3.25177e-17 -0.414214
 -1.00000 -0.292893 -0.292893
 -0.500000 0.292893 -0.292893
--0.500000 0.00000 -0.414214
+-0.500000 -3.25177e-17 -0.414214
 -0.500000 -0.292893 -0.292893
 0.00000 0.292893 -0.292893
-0.00000 0.00000 -0.414214
+0.00000 -3.25177e-17 -0.414214
 0.00000 -0.292893 -0.292893
--1.00000 0.414214 0.00000
--1.00000 0.00000 0.00000
--1.00000 -0.414214 0.00000
--0.500000 0.414214 0.00000
--0.500000 0.00000 0.00000
--0.500000 -0.414214 0.00000
-0.00000 0.414214 0.00000
-0.00000 0.00000 0.00000
-0.00000 -0.414214 0.00000
+-1.00000 0.414214 -3.25177e-17
+-1.00000 0.00000 1.21941e-17
+-1.00000 -0.414214 9.75530e-17
+-0.500000 0.414214 -3.25177e-17
+-0.500000 1.65876e-17 6.93889e-18
+-0.500000 -0.414214 9.75530e-17
+0.00000 0.414214 -3.25177e-17
+0.00000 0.00000 1.21941e-17
+0.00000 -0.414214 9.75530e-17
 -1.00000 0.292893 0.292893
--1.00000 0.00000 0.414214
+-1.00000 6.50354e-17 0.414214
 -1.00000 -0.292893 0.292893
 -0.500000 0.292893 0.292893
--0.500000 0.00000 0.414214
+-0.500000 6.50354e-17 0.414214
 -0.500000 -0.292893 0.292893
 0.00000 0.292893 0.292893
-0.00000 0.00000 0.414214
+0.00000 6.50354e-17 0.414214
 0.00000 -0.292893 0.292893
 -1.00000 -0.707107 -0.707107
--1.00000 -1.00000 0.00000
+-1.00000 -1.00000 2.35514e-16
 -1.00000 -0.707107 0.707107
 -0.500000 -0.707107 -0.707107
--0.500000 -1.00000 0.00000
+-0.500000 -1.00000 2.35514e-16
 -0.500000 -0.707107 0.707107
 0.00000 -0.707107 -0.707107
-0.00000 -1.00000 0.00000
+0.00000 -1.00000 2.35514e-16
 0.00000 -0.707107 0.707107
 -1.00000 -0.500000 -0.500000
--1.00000 -0.707107 0.00000
+-1.00000 -0.707107 1.66533e-16
 -1.00000 -0.500000 0.500000
 -0.500000 -0.500000 -0.500000
--0.500000 -0.707107 0.00000
+-0.500000 -0.707107 1.66533e-16
 -0.500000 -0.500000 0.500000
 0.00000 -0.500000 -0.500000
-0.00000 -0.707107 0.00000
+0.00000 -0.707107 1.66533e-16
 0.00000 -0.500000 0.500000
 -1.00000 -0.292893 -0.292893
--1.00000 -0.414214 0.00000
+-1.00000 -0.414214 9.75530e-17
 -1.00000 -0.292893 0.292893
 -0.500000 -0.292893 -0.292893
--0.500000 -0.414214 0.00000
+-0.500000 -0.414214 9.75530e-17
 -0.500000 -0.292893 0.292893
 0.00000 -0.292893 -0.292893
-0.00000 -0.414214 0.00000
+0.00000 -0.414214 9.75530e-17
 0.00000 -0.292893 0.292893
 -1.00000 0.707107 0.707107
 -1.00000 0.500000 0.500000
@@ -489,15 +489,15 @@ POINTS 270 double
 0.00000 0.707107 0.707107
 0.00000 0.500000 0.500000
 0.00000 0.292893 0.292893
--1.00000 0.00000 1.00000
--1.00000 1.96262e-17 0.707107
--1.00000 0.00000 0.414214
--0.500000 0.00000 1.00000
--0.500000 9.81308e-18 0.707107
--0.500000 0.00000 0.414214
-0.00000 0.00000 1.00000
-0.00000 1.96262e-17 0.707107
-0.00000 0.00000 0.414214
+-1.00000 1.57009e-16 1.00000
+-1.00000 1.11022e-16 0.707107
+-1.00000 6.50354e-17 0.414214
+-0.500000 1.57009e-16 1.00000
+-0.500000 1.11022e-16 0.707107
+-0.500000 6.50354e-17 0.414214
+0.00000 1.57009e-16 1.00000
+0.00000 1.11022e-16 0.707107
+0.00000 6.50354e-17 0.414214
 -1.00000 -0.707107 0.707107
 -1.00000 -0.500000 0.500000
 -1.00000 -0.292893 0.292893
@@ -508,31 +508,31 @@ POINTS 270 double
 0.00000 -0.500000 0.500000
 0.00000 -0.292893 0.292893
 0.00000 0.707107 -0.707107
-0.00000 0.00000 -1.00000
+0.00000 -7.85046e-17 -1.00000
 0.00000 -0.707107 -0.707107
 0.500000 0.707107 -0.707107
-0.500000 0.00000 -1.00000
+0.500000 -7.85046e-17 -1.00000
 0.500000 -0.707107 -0.707107
 1.00000 0.707107 -0.707107
-1.00000 0.00000 -1.00000
+1.00000 -7.85046e-17 -1.00000
 1.00000 -0.707107 -0.707107
 0.00000 0.500000 -0.500000
-0.00000 0.00000 -0.707107
+0.00000 -5.55112e-17 -0.707107
 0.00000 -0.500000 -0.500000
 0.500000 0.500000 -0.500000
-0.500000 0.00000 -0.707107
+0.500000 -5.55112e-17 -0.707107
 0.500000 -0.500000 -0.500000
 1.00000 0.500000 -0.500000
-1.00000 0.00000 -0.707107
+1.00000 -5.55112e-17 -0.707107
 1.00000 -0.500000 -0.500000
 0.00000 0.292893 -0.292893
-0.00000 0.00000 -0.414214
+0.00000 -3.25177e-17 -0.414214
 0.00000 -0.292893 -0.292893
 0.500000 0.292893 -0.292893
-0.500000 0.00000 -0.414214
+0.500000 -3.25177e-17 -0.414214
 0.500000 -0.292893 -0.292893
 1.00000 0.292893 -0.292893
-1.00000 0.00000 -0.414214
+1.00000 -3.25177e-17 -0.414214
 1.00000 -0.292893 -0.292893
 0.00000 0.707107 -0.707107
 0.00000 0.500000 -0.500000
@@ -543,15 +543,15 @@ POINTS 270 double
 1.00000 0.707107 -0.707107
 1.00000 0.500000 -0.500000
 1.00000 0.292893 -0.292893
-0.00000 1.00000 0.00000
-0.00000 0.707107 -1.96262e-17
-0.00000 0.414214 0.00000
-0.500000 1.00000 0.00000
-0.500000 0.707107 -9.81308e-18
-0.500000 0.414214 0.00000
-1.00000 1.00000 0.00000
-1.00000 0.707107 -1.96262e-17
-1.00000 0.414214 0.00000
+0.00000 1.00000 -7.85046e-17
+0.00000 0.707107 -5.55112e-17
+0.00000 0.414214 -3.25177e-17
+0.500000 1.00000 -7.85046e-17
+0.500000 0.707107 -5.55112e-17
+0.500000 0.414214 -3.25177e-17
+1.00000 1.00000 -7.85046e-17
+1.00000 0.707107 -5.55112e-17
+1.00000 0.414214 -3.25177e-17
 0.00000 0.707107 0.707107
 0.00000 0.500000 0.500000
 0.00000 0.292893 0.292893
@@ -562,58 +562,58 @@ POINTS 270 double
 1.00000 0.500000 0.500000
 1.00000 0.292893 0.292893
 0.00000 0.292893 -0.292893
-0.00000 0.00000 -0.414214
+0.00000 -3.25177e-17 -0.414214
 0.00000 -0.292893 -0.292893
 0.500000 0.292893 -0.292893
-0.500000 0.00000 -0.414214
+0.500000 -3.25177e-17 -0.414214
 0.500000 -0.292893 -0.292893
 1.00000 0.292893 -0.292893
-1.00000 0.00000 -0.414214
+1.00000 -3.25177e-17 -0.414214
 1.00000 -0.292893 -0.292893
-0.00000 0.414214 0.00000
-0.00000 0.00000 0.00000
-0.00000 -0.414214 0.00000
-0.500000 0.414214 0.00000
-0.500000 0.00000 0.00000
-0.500000 -0.414214 0.00000
-1.00000 0.414214 0.00000
-1.00000 0.00000 0.00000
-1.00000 -0.414214 0.00000
+0.00000 0.414214 -3.25177e-17
+0.00000 0.00000 1.21941e-17
+0.00000 -0.414214 9.75530e-17
+0.500000 0.414214 -3.25177e-17
+0.500000 1.65876e-17 6.93889e-18
+0.500000 -0.414214 9.75530e-17
+1.00000 0.414214 -3.25177e-17
+1.00000 0.00000 1.21941e-17
+1.00000 -0.414214 9.75530e-17
 0.00000 0.292893 0.292893
-0.00000 0.00000 0.414214
+0.00000 6.50354e-17 0.414214
 0.00000 -0.292893 0.292893
 0.500000 0.292893 0.292893
-0.500000 0.00000 0.414214
+0.500000 6.50354e-17 0.414214
 0.500000 -0.292893 0.292893
 1.00000 0.292893 0.292893
-1.00000 0.00000 0.414214
+1.00000 6.50354e-17 0.414214
 1.00000 -0.292893 0.292893
 0.00000 -0.707107 -0.707107
-0.00000 -1.00000 0.00000
+0.00000 -1.00000 2.35514e-16
 0.00000 -0.707107 0.707107
 0.500000 -0.707107 -0.707107
-0.500000 -1.00000 0.00000
+0.500000 -1.00000 2.35514e-16
 0.500000 -0.707107 0.707107
 1.00000 -0.707107 -0.707107
-1.00000 -1.00000 0.00000
+1.00000 -1.00000 2.35514e-16
 1.00000 -0.707107 0.707107
 0.00000 -0.500000 -0.500000
-0.00000 -0.707107 0.00000
+0.00000 -0.707107 1.66533e-16
 0.00000 -0.500000 0.500000
 0.500000 -0.500000 -0.500000
-0.500000 -0.707107 0.00000
+0.500000 -0.707107 1.66533e-16
 0.500000 -0.500000 0.500000
 1.00000 -0.500000 -0.500000
-1.00000 -0.707107 0.00000
+1.00000 -0.707107 1.66533e-16
 1.00000 -0.500000 0.500000
 0.00000 -0.292893 -0.292893
-0.00000 -0.414214 0.00000
+0.00000 -0.414214 9.75530e-17
 0.00000 -0.292893 0.292893
 0.500000 -0.292893 -0.292893
-0.500000 -0.414214 0.00000
+0.500000 -0.414214 9.75530e-17
 0.500000 -0.292893 0.292893
 1.00000 -0.292893 -0.292893
-1.00000 -0.414214 0.00000
+1.00000 -0.414214 9.75530e-17
 1.00000 -0.292893 0.292893
 0.00000 0.707107 0.707107
 0.00000 0.500000 0.500000
@@ -624,15 +624,15 @@ POINTS 270 double
 1.00000 0.707107 0.707107
 1.00000 0.500000 0.500000
 1.00000 0.292893 0.292893
-0.00000 0.00000 1.00000
-0.00000 1.96262e-17 0.707107
-0.00000 0.00000 0.414214
-0.500000 0.00000 1.00000
-0.500000 9.81308e-18 0.707107
-0.500000 0.00000 0.414214
-1.00000 0.00000 1.00000
-1.00000 1.96262e-17 0.707107
-1.00000 0.00000 0.414214
+0.00000 1.57009e-16 1.00000
+0.00000 1.11022e-16 0.707107
+0.00000 6.50354e-17 0.414214
+0.500000 1.57009e-16 1.00000
+0.500000 1.11022e-16 0.707107
+0.500000 6.50354e-17 0.414214
+1.00000 1.57009e-16 1.00000
+1.00000 1.11022e-16 0.707107
+1.00000 6.50354e-17 0.414214
 0.00000 -0.707107 0.707107
 0.00000 -0.500000 0.500000
 0.00000 -0.292893 0.292893
@@ -739,31 +739,31 @@ DATASET UNSTRUCTURED_GRID
 
 POINTS 270 double
 -1.00000 0.707107 -0.707107
--1.00000 0.00000 -0.964312
+-1.00000 2.77556e-17 -0.996906
 -1.00000 -0.707107 -0.707107
 -0.500000 0.707107 -0.707107
--0.500000 0.00000 -0.964312
+-0.500000 -2.22045e-16 -0.996906
 -0.500000 -0.707107 -0.707107
 0.00000 0.707107 -0.707107
-0.00000 0.00000 -0.964312
+0.00000 2.77556e-17 -0.996906
 0.00000 -0.707107 -0.707107
 -1.00000 0.500000 -0.500000
--1.00000 1.38778e-17 -0.681872
+-1.00000 -1.24900e-16 -0.704919
 -1.00000 -0.500000 -0.500000
 -0.500000 0.500000 -0.500000
--0.500000 2.77556e-17 -0.681872
+-0.500000 1.11022e-16 -0.704919
 -0.500000 -0.500000 -0.500000
 0.00000 0.500000 -0.500000
-0.00000 1.38778e-17 -0.681872
+0.00000 -1.24900e-16 -0.704919
 0.00000 -0.500000 -0.500000
 -1.00000 0.292893 -0.292893
--1.00000 0.00000 -0.399431
+-1.00000 1.38778e-17 -0.412932
 -1.00000 -0.292893 -0.292893
 -0.500000 0.292893 -0.292893
--0.500000 0.00000 -0.399431
+-0.500000 -1.04083e-16 -0.412932
 -0.500000 -0.292893 -0.292893
 0.00000 0.292893 -0.292893
-0.00000 0.00000 -0.399431
+0.00000 1.38778e-17 -0.412932
 0.00000 -0.292893 -0.292893
 -1.00000 0.707107 -0.707107
 -1.00000 0.500000 -0.500000
@@ -774,15 +774,15 @@ POINTS 270 double
 0.00000 0.707107 -0.707107
 0.00000 0.500000 -0.500000
 0.00000 0.292893 -0.292893
--1.00000 0.964312 0.00000
--1.00000 0.681872 -2.77556e-17
--1.00000 0.399431 0.00000
--0.500000 0.964312 0.00000
--0.500000 0.681872 -1.04083e-16
--0.500000 0.399431 0.00000
-0.00000 0.964312 0.00000
-0.00000 0.681872 -2.77556e-17
-0.00000 0.399431 0.00000
+-1.00000 0.996906 -1.11022e-16
+-1.00000 0.704919 -3.19189e-16
+-1.00000 0.412932 -2.77556e-17
+-0.500000 0.996906 -3.33067e-16
+-0.500000 0.704919 1.04083e-16
+-0.500000 0.412932 -1.52656e-16
+0.00000 0.996906 -1.11022e-16
+0.00000 0.704919 -3.19189e-16
+0.00000 0.412932 -2.77556e-17
 -1.00000 0.707107 0.707107
 -1.00000 0.500000 0.500000
 -1.00000 0.292893 0.292893
@@ -793,58 +793,58 @@ POINTS 270 double
 0.00000 0.500000 0.500000
 0.00000 0.292893 0.292893
 -1.00000 0.292893 -0.292893
--1.00000 0.00000 -0.399431
+-1.00000 1.38778e-17 -0.412932
 -1.00000 -0.292893 -0.292893
 -0.500000 0.292893 -0.292893
--0.500000 -2.08167e-17 -0.406969
+-0.500000 7.63278e-17 -0.412932
 -0.500000 -0.292893 -0.292893
 0.00000 0.292893 -0.292893
-0.00000 0.00000 -0.399431
+0.00000 1.38778e-17 -0.412932
 0.00000 -0.292893 -0.292893
--1.00000 0.399431 0.00000
--1.00000 0.00000 1.38778e-17
--1.00000 -0.399431 0.00000
--0.500000 0.406969 2.77556e-17
--0.500000 -1.38778e-17 2.77556e-17
--0.500000 -0.406969 2.77556e-17
-0.00000 0.399431 0.00000
-0.00000 0.00000 1.38778e-17
-0.00000 -0.399431 0.00000
+-1.00000 0.412932 -2.77556e-17
+-1.00000 1.38778e-17 2.77556e-17
+-1.00000 -0.412932 1.38778e-16
+-0.500000 0.412932 2.56739e-16
+-0.500000 -6.93889e-18 6.93889e-17
+-0.500000 -0.412932 3.88578e-16
+0.00000 0.412932 -2.77556e-17
+0.00000 1.38778e-17 2.77556e-17
+0.00000 -0.412932 1.38778e-16
 -1.00000 0.292893 0.292893
--1.00000 0.00000 0.399431
+-1.00000 8.32667e-17 0.412932
 -1.00000 -0.292893 0.292893
 -0.500000 0.292893 0.292893
--0.500000 -2.08167e-17 0.406969
+-0.500000 2.91434e-16 0.412932
 -0.500000 -0.292893 0.292893
 0.00000 0.292893 0.292893
-0.00000 0.00000 0.399431
+0.00000 8.32667e-17 0.412932
 0.00000 -0.292893 0.292893
 -1.00000 -0.707107 -0.707107
--1.00000 -0.964312 0.00000
+-1.00000 -0.996906 3.05311e-16
 -1.00000 -0.707107 0.707107
 -0.500000 -0.707107 -0.707107
--0.500000 -0.964312 0.00000
+-0.500000 -0.996906 2.77556e-16
 -0.500000 -0.707107 0.707107
 0.00000 -0.707107 -0.707107
-0.00000 -0.964312 0.00000
+0.00000 -0.996906 3.05311e-16
 0.00000 -0.707107 0.707107
 -1.00000 -0.500000 -0.500000
--1.00000 -0.681872 -1.38778e-17
+-1.00000 -0.704919 1.66533e-16
 -1.00000 -0.500000 0.500000
 -0.500000 -0.500000 -0.500000
--0.500000 -0.681872 -2.77556e-17
+-0.500000 -0.704919 1.80411e-16
 -0.500000 -0.500000 0.500000
 0.00000 -0.500000 -0.500000
-0.00000 -0.681872 -1.38778e-17
+0.00000 -0.704919 1.66533e-16
 0.00000 -0.500000 0.500000
 -1.00000 -0.292893 -0.292893
--1.00000 -0.399431 0.00000
+-1.00000 -0.412932 1.38778e-16
 -1.00000 -0.292893 0.292893
 -0.500000 -0.292893 -0.292893
--0.500000 -0.399431 0.00000
+-0.500000 -0.412932 1.11022e-16
 -0.500000 -0.292893 0.292893
 0.00000 -0.292893 -0.292893
-0.00000 -0.399431 0.00000
+0.00000 -0.412932 1.38778e-16
 0.00000 -0.292893 0.292893
 -1.00000 0.707107 0.707107
 -1.00000 0.500000 0.500000
@@ -855,15 +855,15 @@ POINTS 270 double
 0.00000 0.707107 0.707107
 0.00000 0.500000 0.500000
 0.00000 0.292893 0.292893
--1.00000 0.00000 0.964312
--1.00000 2.77556e-17 0.681872
--1.00000 0.00000 0.399431
--0.500000 0.00000 0.964312
--0.500000 1.04083e-16 0.681872
--0.500000 0.00000 0.399431
-0.00000 0.00000 0.964312
-0.00000 2.77556e-17 0.681872
-0.00000 0.00000 0.399431
+-1.00000 2.22045e-16 0.996906
+-1.00000 -5.82867e-16 0.704919
+-1.00000 8.32667e-17 0.412932
+-0.500000 -8.88178e-16 0.996906
+-0.500000 2.56739e-16 0.704919
+-0.500000 -3.46945e-16 0.412932
+0.00000 2.22045e-16 0.996906
+0.00000 -5.82867e-16 0.704919
+0.00000 8.32667e-17 0.412932
 -1.00000 -0.707107 0.707107
 -1.00000 -0.500000 0.500000
 -1.00000 -0.292893 0.292893
@@ -874,31 +874,31 @@ POINTS 270 double
 0.00000 -0.500000 0.500000
 0.00000 -0.292893 0.292893
 0.00000 0.707107 -0.707107
-0.00000 0.00000 -0.964312
+0.00000 2.77556e-17 -0.996906
 0.00000 -0.707107 -0.707107
 0.500000 0.707107 -0.707107
-0.500000 0.00000 -0.964312
+0.500000 -2.22045e-16 -0.996906
 0.500000 -0.707107 -0.707107
 1.00000 0.707107 -0.707107
-1.00000 0.00000 -0.964312
+1.00000 2.77556e-17 -0.996906
 1.00000 -0.707107 -0.707107
 0.00000 0.500000 -0.500000
-0.00000 1.38778e-17 -0.681872
+0.00000 -1.24900e-16 -0.704919
 0.00000 -0.500000 -0.500000
 0.500000 0.500000 -0.500000
-0.500000 2.77556e-17 -0.681872
+0.500000 1.11022e-16 -0.704919
 0.500000 -0.500000 -0.500000
 1.00000 0.500000 -0.500000
-1.00000 1.38778e-17 -0.681872
+1.00000 -1.24900e-16 -0.704919
 1.00000 -0.500000 -0.500000
 0.00000 0.292893 -0.292893
-0.00000 0.00000 -0.399431
+0.00000 1.38778e-17 -0.412932
 0.00000 -0.292893 -0.292893
 0.500000 0.292893 -0.292893
-0.500000 0.00000 -0.399431
+0.500000 -1.04083e-16 -0.412932
 0.500000 -0.292893 -0.292893
 1.00000 0.292893 -0.292893
-1.00000 0.00000 -0.399431
+1.00000 1.38778e-17 -0.412932
 1.00000 -0.292893 -0.292893
 0.00000 0.707107 -0.707107
 0.00000 0.500000 -0.500000
@@ -909,15 +909,15 @@ POINTS 270 double
 1.00000 0.707107 -0.707107
 1.00000 0.500000 -0.500000
 1.00000 0.292893 -0.292893
-0.00000 0.964312 0.00000
-0.00000 0.681872 -2.77556e-17
-0.00000 0.399431 0.00000
-0.500000 0.964312 0.00000
-0.500000 0.681872 -1.04083e-16
-0.500000 0.399431 0.00000
-1.00000 0.964312 0.00000
-1.00000 0.681872 -2.77556e-17
-1.00000 0.399431 0.00000
+0.00000 0.996906 -1.11022e-16
+0.00000 0.704919 -3.19189e-16
+0.00000 0.412932 -2.77556e-17
+0.500000 0.996906 -3.33067e-16
+0.500000 0.704919 1.04083e-16
+0.500000 0.412932 -1.52656e-16
+1.00000 0.996906 -1.11022e-16
+1.00000 0.704919 -3.19189e-16
+1.00000 0.412932 -2.77556e-17
 0.00000 0.707107 0.707107
 0.00000 0.500000 0.500000
 0.00000 0.292893 0.292893
@@ -928,58 +928,58 @@ POINTS 270 double
 1.00000 0.500000 0.500000
 1.00000 0.292893 0.292893
 0.00000 0.292893 -0.292893
-0.00000 0.00000 -0.399431
+0.00000 1.38778e-17 -0.412932
 0.00000 -0.292893 -0.292893
 0.500000 0.292893 -0.292893
-0.500000 -2.08167e-17 -0.406969
+0.500000 7.63278e-17 -0.412932
 0.500000 -0.292893 -0.292893
 1.00000 0.292893 -0.292893
-1.00000 0.00000 -0.399431
+1.00000 1.38778e-17 -0.412932
 1.00000 -0.292893 -0.292893
-0.00000 0.399431 0.00000
-0.00000 0.00000 1.38778e-17
-0.00000 -0.399431 0.00000
-0.500000 0.406969 2.77556e-17
-0.500000 -1.38778e-17 2.77556e-17
-0.500000 -0.406969 2.77556e-17
-1.00000 0.399431 0.00000
-1.00000 0.00000 1.38778e-17
-1.00000 -0.399431 0.00000
+0.00000 0.412932 -2.77556e-17
+0.00000 1.38778e-17 2.77556e-17
+0.00000 -0.412932 1.38778e-16
+0.500000 0.412932 2.56739e-16
+0.500000 -6.93889e-18 6.93889e-17
+0.500000 -0.412932 3.88578e-16
+1.00000 0.412932 -2.77556e-17
+1.00000 1.38778e-17 2.77556e-17
+1.00000 -0.412932 1.38778e-16
 0.00000 0.292893 0.292893
-0.00000 0.00000 0.399431
+0.00000 8.32667e-17 0.412932
 0.00000 -0.292893 0.292893
 0.500000 0.292893 0.292893
-0.500000 -2.08167e-17 0.406969
+0.500000 2.91434e-16 0.412932
 0.500000 -0.292893 0.292893
 1.00000 0.292893 0.292893
-1.00000 0.00000 0.399431
+1.00000 8.32667e-17 0.412932
 1.00000 -0.292893 0.292893
 0.00000 -0.707107 -0.707107
-0.00000 -0.964312 0.00000
+0.00000 -0.996906 3.05311e-16
 0.00000 -0.707107 0.707107
 0.500000 -0.707107 -0.707107
-0.500000 -0.964312 0.00000
+0.500000 -0.996906 2.77556e-16
 0.500000 -0.707107 0.707107
 1.00000 -0.707107 -0.707107
-1.00000 -0.964312 0.00000
+1.00000 -0.996906 3.05311e-16
 1.00000 -0.707107 0.707107
 0.00000 -0.500000 -0.500000
-0.00000 -0.681872 -1.38778e-17
+0.00000 -0.704919 1.66533e-16
 0.00000 -0.500000 0.500000
 0.500000 -0.500000 -0.500000
-0.500000 -0.681872 -2.77556e-17
+0.500000 -0.704919 1.80411e-16
 0.500000 -0.500000 0.500000
 1.00000 -0.500000 -0.500000
-1.00000 -0.681872 -1.38778e-17
+1.00000 -0.704919 1.66533e-16
 1.00000 -0.500000 0.500000
 0.00000 -0.292893 -0.292893
-0.00000 -0.399431 0.00000
+0.00000 -0.412932 1.38778e-16
 0.00000 -0.292893 0.292893
 0.500000 -0.292893 -0.292893
-0.500000 -0.399431 0.00000
+0.500000 -0.412932 1.11022e-16
 0.500000 -0.292893 0.292893
 1.00000 -0.292893 -0.292893
-1.00000 -0.399431 0.00000
+1.00000 -0.412932 1.38778e-16
 1.00000 -0.292893 0.292893
 0.00000 0.707107 0.707107
 0.00000 0.500000 0.500000
@@ -990,15 +990,15 @@ POINTS 270 double
 1.00000 0.707107 0.707107
 1.00000 0.500000 0.500000
 1.00000 0.292893 0.292893
-0.00000 0.00000 0.964312
-0.00000 2.77556e-17 0.681872
-0.00000 0.00000 0.399431
-0.500000 0.00000 0.964312
-0.500000 1.04083e-16 0.681872
-0.500000 0.00000 0.399431
-1.00000 0.00000 0.964312
-1.00000 2.77556e-17 0.681872
-1.00000 0.00000 0.399431
+0.00000 2.22045e-16 0.996906
+0.00000 -5.82867e-16 0.704919
+0.00000 8.32667e-17 0.412932
+0.500000 -8.88178e-16 0.996906
+0.500000 2.56739e-16 0.704919
+0.500000 -3.46945e-16 0.412932
+1.00000 2.22045e-16 0.996906
+1.00000 -5.82867e-16 0.704919
+1.00000 8.32667e-17 0.412932
 0.00000 -0.707107 0.707107
 0.00000 -0.500000 0.500000
 0.00000 -0.292893 0.292893
@@ -1105,31 +1105,31 @@ DATASET UNSTRUCTURED_GRID
 
 POINTS 270 double
 -1.00000 0.707107 -0.707107
--1.00000 0.00000 -1.00000
+-1.00000 -7.85046e-17 -1.00000
 -1.00000 -0.707107 -0.707107
 -0.500000 0.707107 -0.707107
--0.500000 0.00000 -1.00000
+-0.500000 -7.85046e-17 -1.00000
 -0.500000 -0.707107 -0.707107
 0.00000 0.707107 -0.707107
-0.00000 0.00000 -1.00000
+0.00000 -7.85046e-17 -1.00000
 0.00000 -0.707107 -0.707107
 -1.00000 0.500000 -0.500000
--1.00000 0.00000 -0.707107
+-1.00000 -5.55112e-17 -0.707107
 -1.00000 -0.500000 -0.500000
 -0.500000 0.500000 -0.500000
--0.500000 0.00000 -0.707107
+-0.500000 -5.55112e-17 -0.707107
 -0.500000 -0.500000 -0.500000
 0.00000 0.500000 -0.500000
-0.00000 0.00000 -0.707107
+0.00000 -5.55112e-17 -0.707107
 0.00000 -0.500000 -0.500000
 -1.00000 0.292893 -0.292893
--1.00000 0.00000 -0.414214
+-1.00000 -3.25177e-17 -0.414214
 -1.00000 -0.292893 -0.292893
 -0.500000 0.292893 -0.292893
--0.500000 0.00000 -0.414214
+-0.500000 -3.25177e-17 -0.414214
 -0.500000 -0.292893 -0.292893
 0.00000 0.292893 -0.292893
-0.00000 0.00000 -0.414214
+0.00000 -3.25177e-17 -0.414214
 0.00000 -0.292893 -0.292893
 -1.00000 0.707107 -0.707107
 -1.00000 0.500000 -0.500000
@@ -1140,15 +1140,15 @@ POINTS 270 double
 0.00000 0.707107 -0.707107
 0.00000 0.500000 -0.500000
 0.00000 0.292893 -0.292893
--1.00000 1.00000 0.00000
--1.00000 0.707107 -1.96262e-17
--1.00000 0.414214 0.00000
--0.500000 1.00000 0.00000
--0.500000 0.707107 -9.81308e-18
--0.500000 0.414214 0.00000
-0.00000 1.00000 0.00000
-0.00000 0.707107 -1.96262e-17
-0.00000 0.414214 0.00000
+-1.00000 1.00000 -7.85046e-17
+-1.00000 0.707107 -5.55112e-17
+-1.00000 0.414214 -3.25177e-17
+-0.500000 1.00000 -7.85046e-17
+-0.500000 0.707107 -5.55112e-17
+-0.500000 0.414214 -3.25177e-17
+0.00000 1.00000 -7.85046e-17
+0.00000 0.707107 -5.55112e-17
+0.00000 0.414214 -3.25177e-17
 -1.00000 0.707107 0.707107
 -1.00000 0.500000 0.500000
 -1.00000 0.292893 0.292893
@@ -1159,58 +1159,58 @@ POINTS 270 double
 0.00000 0.500000 0.500000
 0.00000 0.292893 0.292893
 -1.00000 0.292893 -0.292893
--1.00000 0.00000 -0.414214
+-1.00000 -3.25177e-17 -0.414214
 -1.00000 -0.292893 -0.292893
 -0.500000 0.292893 -0.292893
--0.500000 -1.10088e-16 -0.414214
+-0.500000 -2.27624e-16 -0.414214
 -0.500000 -0.292893 -0.292893
 0.00000 0.292893 -0.292893
-0.00000 0.00000 -0.414214
+0.00000 -3.25177e-17 -0.414214
 0.00000 -0.292893 -0.292893
--1.00000 0.414214 0.00000
--1.00000 -9.71445e-17 9.19403e-17
--1.00000 -0.414214 0.00000
--0.500000 0.414214 9.95024e-17
--0.500000 -1.18829e-16 9.45424e-17
--0.500000 -0.414214 9.95024e-17
-0.00000 0.414214 0.00000
-0.00000 -9.71445e-17 9.19403e-17
-0.00000 -0.414214 0.00000
+-1.00000 0.414214 -3.25177e-17
+-1.00000 -7.63278e-17 9.19403e-17
+-1.00000 -0.414214 9.75530e-17
+-0.500000 0.414214 -2.27624e-16
+-0.500000 -7.43763e-17 1.06252e-16
+-0.500000 -0.414214 9.75530e-17
+0.00000 0.414214 -3.25177e-17
+0.00000 -7.63278e-17 9.19403e-17
+0.00000 -0.414214 9.75530e-17
 -1.00000 0.292893 0.292893
--1.00000 0.00000 0.414214
+-1.00000 6.50354e-17 0.414214
 -1.00000 -0.292893 0.292893
 -0.500000 0.292893 0.292893
--0.500000 -1.10088e-16 0.414214
+-0.500000 -9.75530e-17 0.414214
 -0.500000 -0.292893 0.292893
 0.00000 0.292893 0.292893
-0.00000 0.00000 0.414214
+0.00000 6.50354e-17 0.414214
 0.00000 -0.292893 0.292893
 -1.00000 -0.707107 -0.707107
--1.00000 -1.00000 0.00000
+-1.00000 -1.00000 2.35514e-16
 -1.00000 -0.707107 0.707107
 -0.500000 -0.707107 -0.707107
--0.500000 -1.00000 0.00000
+-0.500000 -1.00000 2.35514e-16
 -0.500000 -0.707107 0.707107
 0.00000 -0.707107 -0.707107
-0.00000 -1.00000 0.00000
+0.00000 -1.00000 2.35514e-16
 0.00000 -0.707107 0.707107
 -1.00000 -0.500000 -0.500000
--1.00000 -0.707107 0.00000
+-1.00000 -0.707107 1.66533e-16
 -1.00000 -0.500000 0.500000
 -0.500000 -0.500000 -0.500000
--0.500000 -0.707107 0.00000
+-0.500000 -0.707107 1.66533e-16
 -0.500000 -0.500000 0.500000
 0.00000 -0.500000 -0.500000
-0.00000 -0.707107 0.00000
+0.00000 -0.707107 1.66533e-16
 0.00000 -0.500000 0.500000
 -1.00000 -0.292893 -0.292893
--1.00000 -0.414214 0.00000
+-1.00000 -0.414214 9.75530e-17
 -1.00000 -0.292893 0.292893
 -0.500000 -0.292893 -0.292893
--0.500000 -0.414214 0.00000
+-0.500000 -0.414214 9.75530e-17
 -0.500000 -0.292893 0.292893
 0.00000 -0.292893 -0.292893
-0.00000 -0.414214 0.00000
+0.00000 -0.414214 9.75530e-17
 0.00000 -0.292893 0.292893
 -1.00000 0.707107 0.707107
 -1.00000 0.500000 0.500000
@@ -1221,15 +1221,15 @@ POINTS 270 double
 0.00000 0.707107 0.707107
 0.00000 0.500000 0.500000
 0.00000 0.292893 0.292893
--1.00000 0.00000 1.00000
--1.00000 1.96262e-17 0.707107
--1.00000 0.00000 0.414214
--0.500000 0.00000 1.00000
--0.500000 9.81308e-18 0.707107
--0.500000 0.00000 0.414214
-0.00000 0.00000 1.00000
-0.00000 1.96262e-17 0.707107
-0.00000 0.00000 0.414214
+-1.00000 1.57009e-16 1.00000
+-1.00000 1.11022e-16 0.707107
+-1.00000 6.50354e-17 0.414214
+-0.500000 1.57009e-16 1.00000
+-0.500000 1.11022e-16 0.707107
+-0.500000 6.50354e-17 0.414214
+0.00000 1.57009e-16 1.00000
+0.00000 1.11022e-16 0.707107
+0.00000 6.50354e-17 0.414214
 -1.00000 -0.707107 0.707107
 -1.00000 -0.500000 0.500000
 -1.00000 -0.292893 0.292893
@@ -1240,31 +1240,31 @@ POINTS 270 double
 0.00000 -0.500000 0.500000
 0.00000 -0.292893 0.292893
 0.00000 0.707107 -0.707107
-0.00000 0.00000 -1.00000
+0.00000 -7.85046e-17 -1.00000
 0.00000 -0.707107 -0.707107
 0.500000 0.707107 -0.707107
-0.500000 0.00000 -1.00000
+0.500000 -7.85046e-17 -1.00000
 0.500000 -0.707107 -0.707107
 1.00000 0.707107 -0.707107
-1.00000 0.00000 -1.00000
+1.00000 -7.85046e-17 -1.00000
 1.00000 -0.707107 -0.707107
 0.00000 0.500000 -0.500000
-0.00000 0.00000 -0.707107
+0.00000 -5.55112e-17 -0.707107
 0.00000 -0.500000 -0.500000
 0.500000 0.500000 -0.500000
-0.500000 0.00000 -0.707107
+0.500000 -5.55112e-17 -0.707107
 0.500000 -0.500000 -0.500000
 1.00000 0.500000 -0.500000
-1.00000 0.00000 -0.707107
+1.00000 -5.55112e-17 -0.707107
 1.00000 -0.500000 -0.500000
 0.00000 0.292893 -0.292893
-0.00000 0.00000 -0.414214
+0.00000 -3.25177e-17 -0.414214
 0.00000 -0.292893 -0.292893
 0.500000 0.292893 -0.292893
-0.500000 0.00000 -0.414214
+0.500000 -3.25177e-17 -0.414214
 0.500000 -0.292893 -0.292893
 1.00000 0.292893 -0.292893
-1.00000 0.00000 -0.414214
+1.00000 -3.25177e-17 -0.414214
 1.00000 -0.292893 -0.292893
 0.00000 0.707107 -0.707107
 0.00000 0.500000 -0.500000
@@ -1275,15 +1275,15 @@ POINTS 270 double
 1.00000 0.707107 -0.707107
 1.00000 0.500000 -0.500000
 1.00000 0.292893 -0.292893
-0.00000 1.00000 0.00000
-0.00000 0.707107 -1.96262e-17
-0.00000 0.414214 0.00000
-0.500000 1.00000 0.00000
-0.500000 0.707107 -9.81308e-18
-0.500000 0.414214 0.00000
-1.00000 1.00000 0.00000
-1.00000 0.707107 -1.96262e-17
-1.00000 0.414214 0.00000
+0.00000 1.00000 -7.85046e-17
+0.00000 0.707107 -5.55112e-17
+0.00000 0.414214 -3.25177e-17
+0.500000 1.00000 -7.85046e-17
+0.500000 0.707107 -5.55112e-17
+0.500000 0.414214 -3.25177e-17
+1.00000 1.00000 -7.85046e-17
+1.00000 0.707107 -5.55112e-17
+1.00000 0.414214 -3.25177e-17
 0.00000 0.707107 0.707107
 0.00000 0.500000 0.500000
 0.00000 0.292893 0.292893
@@ -1294,58 +1294,58 @@ POINTS 270 double
 1.00000 0.500000 0.500000
 1.00000 0.292893 0.292893
 0.00000 0.292893 -0.292893
-0.00000 0.00000 -0.414214
+0.00000 -3.25177e-17 -0.414214
 0.00000 -0.292893 -0.292893
 0.500000 0.292893 -0.292893
-0.500000 -1.10088e-16 -0.414214
+0.500000 -2.27624e-16 -0.414214
 0.500000 -0.292893 -0.292893
 1.00000 0.292893 -0.292893
-1.00000 0.00000 -0.414214
+1.00000 -3.25177e-17 -0.414214
 1.00000 -0.292893 -0.292893
-0.00000 0.414214 0.00000
-0.00000 -9.71445e-17 9.19403e-17
-0.00000 -0.414214 0.00000
-0.500000 0.414214 9.95024e-17
-0.500000 -1.18829e-16 9.45424e-17
-0.500000 -0.414214 9.95024e-17
-1.00000 0.414214 0.00000
-1.00000 -9.71445e-17 9.19403e-17
-1.00000 -0.414214 0.00000
+0.00000 0.414214 -3.25177e-17
+0.00000 -7.63278e-17 9.19403e-17
+0.00000 -0.414214 9.75530e-17
+0.500000 0.414214 -2.27624e-16
+0.500000 -7.43763e-17 1.06252e-16
+0.500000 -0.414214 9.75530e-17
+1.00000 0.414214 -3.25177e-17
+1.00000 -7.63278e-17 9.19403e-17
+1.00000 -0.414214 9.75530e-17
 0.00000 0.292893 0.292893
-0.00000 0.00000 0.414214
+0.00000 6.50354e-17 0.414214
 0.00000 -0.292893 0.292893
 0.500000 0.292893 0.292893
-0.500000 -1.10088e-16 0.414214
+0.500000 -9.75530e-17 0.414214
 0.500000 -0.292893 0.292893
 1.00000 0.292893 0.292893
-1.00000 0.00000 0.414214
+1.00000 6.50354e-17 0.414214
 1.00000 -0.292893 0.292893
 0.00000 -0.707107 -0.707107
-0.00000 -1.00000 0.00000
+0.00000 -1.00000 2.35514e-16
 0.00000 -0.707107 0.707107
 0.500000 -0.707107 -0.707107
-0.500000 -1.00000 0.00000
+0.500000 -1.00000 2.35514e-16
 0.500000 -0.707107 0.707107
 1.00000 -0.707107 -0.707107
-1.00000 -1.00000 0.00000
+1.00000 -1.00000 2.35514e-16
 1.00000 -0.707107 0.707107
 0.00000 -0.500000 -0.500000
-0.00000 -0.707107 0.00000
+0.00000 -0.707107 1.66533e-16
 0.00000 -0.500000 0.500000
 0.500000 -0.500000 -0.500000
-0.500000 -0.707107 0.00000
+0.500000 -0.707107 1.66533e-16
 0.500000 -0.500000 0.500000
 1.00000 -0.500000 -0.500000
-1.00000 -0.707107 0.00000
+1.00000 -0.707107 1.66533e-16
 1.00000 -0.500000 0.500000
 0.00000 -0.292893 -0.292893
-0.00000 -0.414214 0.00000
+0.00000 -0.414214 9.75530e-17
 0.00000 -0.292893 0.292893
 0.500000 -0.292893 -0.292893
-0.500000 -0.414214 0.00000
+0.500000 -0.414214 9.75530e-17
 0.500000 -0.292893 0.292893
 1.00000 -0.292893 -0.292893
-1.00000 -0.414214 0.00000
+1.00000 -0.414214 9.75530e-17
 1.00000 -0.292893 0.292893
 0.00000 0.707107 0.707107
 0.00000 0.500000 0.500000
@@ -1356,15 +1356,15 @@ POINTS 270 double
 1.00000 0.707107 0.707107
 1.00000 0.500000 0.500000
 1.00000 0.292893 0.292893
-0.00000 0.00000 1.00000
-0.00000 1.96262e-17 0.707107
-0.00000 0.00000 0.414214
-0.500000 0.00000 1.00000
-0.500000 9.81308e-18 0.707107
-0.500000 0.00000 0.414214
-1.00000 0.00000 1.00000
-1.00000 1.96262e-17 0.707107
-1.00000 0.00000 0.414214
+0.00000 1.57009e-16 1.00000
+0.00000 1.11022e-16 0.707107
+0.00000 6.50354e-17 0.414214
+0.500000 1.57009e-16 1.00000
+0.500000 1.11022e-16 0.707107
+0.500000 6.50354e-17 0.414214
+1.00000 1.57009e-16 1.00000
+1.00000 1.11022e-16 0.707107
+1.00000 6.50354e-17 0.414214
 0.00000 -0.707107 0.707107
 0.00000 -0.500000 0.500000
 0.00000 -0.292893 0.292893
index 655493e2c7e6656b526079efd07547d5df978007..333f1fd26bc3ea53c98236cbb0979c827637154d 100644 (file)
@@ -1,3 +1,3 @@
 
 DEAL::Volume 2D mapping degree 6: 0.857305 error: 5.06446e-06
-DEAL::Volume 3D mapping degree 6: 0.857302 error: 1.46779e-06
+DEAL::Volume 3D mapping degree 6: 0.857301 error: 2.02087e-11
index 63115b7652b63326ead6e1e47e588562cf0ec2f9..1c3fb6ae73acbfe23dd06243a0334996000b1151 100644 (file)
@@ -7,7 +7,7 @@ DEAL::Volume 2D mapping degree 5: 0.156146 error: 8.80543e-09
 DEAL::Volume 2D mapping degree 6: 0.156146 error: 8.99035e-11
 DEAL::Volume 3D mapping degree 1: 0.0643409 error: 0.00501399
 DEAL::Volume 3D mapping degree 2: 0.0640224 error: 3.91474e-05
-DEAL::Volume 3D mapping degree 3: 0.0640197 error: -3.27847e-06
-DEAL::Volume 3D mapping degree 4: 0.0640199 error: -1.41198e-08
-DEAL::Volume 3D mapping degree 5: 0.0640199 error: 5.05984e-10
-DEAL::Volume 3D mapping degree 6: 0.0640199 error: 8.74883e-11
+DEAL::Volume 3D mapping degree 3: 0.0640199 error: 1.53930e-07
+DEAL::Volume 3D mapping degree 4: 0.0640199 error: 3.54084e-10
+DEAL::Volume 3D mapping degree 5: 0.0640199 error: 5.30661e-13
+DEAL::Volume 3D mapping degree 6: 0.0640199 error: 0

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.