]> https://gitweb.dealii.org/ - dealii.git/commitdiff
add volume torus and TorusManifold
authorTimo Heister <timo.heister@gmail.com>
Sun, 20 Mar 2016 14:50:29 +0000 (15:50 +0100)
committerTimo Heister <timo.heister@gmail.com>
Sun, 20 Mar 2016 15:02:05 +0000 (16:02 +0100)
include/deal.II/grid/grid_generator.h
include/deal.II/grid/manifold_lib.h
source/grid/grid_generator.cc
source/grid/manifold_lib.cc
source/grid/manifold_lib.inst.in
tests/grid/torus_01.cc [new file with mode: 0644]
tests/grid/torus_01.output [new file with mode: 0644]

index a7395bba71f33bbe67367606982e47e71efa5702..5b90ff144c04508afdd719f8a8b03f58a1425f6d 100644 (file)
@@ -761,9 +761,18 @@ namespace GridGenerator
 
 
   /**
-   * Produce the surface meshing of the torus. The axis of the torus is the
-   * $y$-axis while the plane of the torus is the $x$-$z$ plane. The boundary
-   * of this object can be described by the TorusBoundary class.
+   * Produce the volume or surface mesh of a torus. The axis of the torus is
+   * the $y$-axis while the plane of the torus is the $x$-$z$ plane. The
+   * function is implemented
+   *
+   * If @p dim is 3, the mesh will be the volume of the torus. By default,
+   * the boundary faces will have manifold id 0 and you should attach a
+   * TorusManifold to it. The cells will have manifold id 1 and you should
+   * attach a SphericalManifold to it.
+   *
+   * If @p dim is 2, the mesh will describe the surface of the torus. All
+   * cells and faces will have manifold id 0 and you should attach a
+   * TorusManifold to it.
    *
    * @param tria The triangulation to be filled.
    *
@@ -771,10 +780,14 @@ namespace GridGenerator
    * torus containing the loop of cells. Must be greater than @p r.
    *
    * @param r The inner radius of the torus.
+   *
+   * @note Implemented for Triangulation<2,3> and Triangulation<3,3>.
    */
-  void torus (Triangulation<2,3> &tria,
-              const double        R,
-              const double        r);
+  template <int dim, int spacedim>
+  void torus (Triangulation<dim,spacedim> &tria,
+              const double R,
+              const double r);
+
 
 
   /**
index 21de7b05552a1eefca372bd3609ec65b09f8826a..6ed4cd3dc69124e9454335b7d1fc7204ddb93e7d 100644 (file)
@@ -309,6 +309,50 @@ private:
 };
 
 
+/**
+ * Manifold description for the surface of a Torus in three dimensions. The
+ * Torus is assumed to be in the x-z plane. The reference coordinate system
+ * is given by the angle $phi$ around the y axis, the angle $theta$ around
+ * the centerline of the torus, and the distance to the centerline $w$
+ * (between 0 and 1).
+ *
+ * This class was developed to be used in conjunction with
+ * GridGenerator::torus.
+ *
+ * @ingroup manifold
+ *
+ * @author Timo Heister, 2016
+ */
+template <int dim>
+class TorusManifold : public ChartManifold<dim,3,3>
+{
+public:
+  static const int chartdim = 3;
+  static const int spacedim = 3;
+
+  /**
+   * Constructor. Specify the radius of the centerline @p R and the radius
+   * of the torus itself (@p r). The variables have the same meaning as
+   * the parameters in GridGenerator::torus().
+   */
+  TorusManifold (const double R, const double r);
+
+  /**
+   * Pull back operation.
+   */
+  virtual Point<chartdim>
+  pull_back(const Point<spacedim> &p) const;
+
+  /**
+   * Push forward operation.
+   */
+  virtual Point<spacedim>
+  push_forward(const Point<chartdim> &chart_point) const;
+
+private:
+  double r, R;
+};
+
 DEAL_II_NAMESPACE_CLOSE
 
 #endif
index 6ad89aa450543e55b77199300dd398341fd297bf..1236e0d1eaecfd50c774d5d0521c1baa80cde38e 100644 (file)
@@ -582,12 +582,15 @@ namespace GridGenerator
 
 
 
+  template<>
   void
-  torus (Triangulation<2,3>  &tria,
-         const double         R,
-         const double         r)
+  torus<2,3> (Triangulation<2,3>  &tria,
+              const double R,
+              const double r)
   {
-    Assert (R>r, ExcMessage("Outer radius must be greater than inner radius."));
+    Assert (R>r, ExcMessage("Outer radius R must be greater than the inner "
+                            "radius r."));
+    Assert (r>0.0, ExcMessage("The inner radius r must be positive."));
 
     const unsigned int dim=2;
     const unsigned int spacedim=3;
@@ -715,7 +718,32 @@ namespace GridGenerator
     tria.create_triangulation_compatibility (vertices, cells, SubCellData());
   }
 
-
+  template<>
+  void
+  torus<3,3> (Triangulation<3,3>  &tria,
+              const double R,
+              const double r)
+  {
+    Assert (R>r, ExcMessage("Outer radius R must be greater than the inner "
+                            "radius r."));
+    Assert (r>0.0, ExcMessage("The inner radius r must be positive."));
+
+    // abuse the moebius function to generate a torus for us
+    GridGenerator::moebius(tria,
+                           6 /*n_cells*/,
+                           0 /*n_rotations*/,
+                           R,
+                           r);
+
+    // rotate by 90 degrees around the x axis to make the torus sit in the
+    // x-z plane instead of the x-y plane to be consistent with the other
+    // torus() function.
+    GridTools::rotate(numbers::PI/2.0, 0, tria);
+
+    // set manifolds as documented
+    tria.set_all_manifold_ids(1);
+    tria.set_all_manifold_ids_on_boundary(0);
+  }
 
   template<>
   void
index 4740f4e65c6f77ec8926e31061f8db0d3a57c07e..c3d37eb0b81c4f6c2c00e9deb56941a38737780c 100644 (file)
@@ -332,6 +332,49 @@ FunctionManifold<dim,spacedim,chartdim>::pull_back(const Point<spacedim> &space_
   return result;
 }
 
+
+
+template <int dim>
+Point<3>
+TorusManifold<dim>::pull_back(const Point<3> &p) const
+{
+  double x = p(0);
+  double z = p(1);
+  double y = p(2);
+  double phi = atan2(y, x);
+  double theta = atan2(z, std::sqrt(x*x+y*y)-R);
+  double w = std::sqrt((pow(y-sin(phi)*R, 2.0)+pow(x-cos(phi)*R, 2.0)+z*z))/r;
+  return Point<3>(phi, theta, w);
+}
+
+template <int dim>
+Point<3>
+TorusManifold<dim>::push_forward(const Point<3> &chart_point) const
+{
+  double phi = chart_point(0);
+  double theta = chart_point(1);
+  double w = chart_point(2);
+
+  return Point<3>(cos(phi)*R + r*w*cos(theta)*cos(phi),
+                  r*w*sin(theta),
+                  sin(phi)*R + r*w*cos(theta)*sin(phi)
+                 );
+}
+
+
+template <int dim>
+TorusManifold<dim>::TorusManifold (const double R, const double r)
+  : ChartManifold<dim,3,3> (Point<3>(2*numbers::PI, 2*numbers::PI, 0.0)),
+    r(r),
+    R(R)
+{
+  Assert (R>r, ExcMessage("Outer radius R must be greater than the inner "
+                          "radius r."));
+  Assert (r>0.0, ExcMessage("inner radius must be positive."));
+}
+
+
+
 // explicit instantiations
 #include "manifold_lib.inst"
 
index eaaf53d08dd82f00600a85a2f0faae02de83deae..f38840b6ced46f1cf5b0502fa183cd164b0b9b7f 100644 (file)
@@ -24,7 +24,9 @@ for (deal_II_dimension : DIMENSIONS; deal_II_space_dimension :  SPACE_DIMENSIONS
     template class FunctionManifold<deal_II_dimension, deal_II_space_dimension, 1>;                      
     template class FunctionManifold<deal_II_dimension, deal_II_space_dimension, 2>;
     template class FunctionManifold<deal_II_dimension, deal_II_space_dimension, 3>;
+#endif
+#if deal_II_dimension == deal_II_space_dimension
+  template class TorusManifold<deal_II_dimension>;
 #endif
   }
 
-
diff --git a/tests/grid/torus_01.cc b/tests/grid/torus_01.cc
new file mode 100644 (file)
index 0000000..ec5d20d
--- /dev/null
@@ -0,0 +1,67 @@
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2016 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.
+//
+// ---------------------------------------------------------------------
+
+// test GridTools::torus() and TorusManifold
+
+#include "../tests.h"
+#include <deal.II/base/logstream.h>
+#include <deal.II/grid/tria.h>
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/grid_tools.h>
+#include <deal.II/grid/grid_out.h>
+#include <deal.II/grid/manifold_lib.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+template <int dim, int spacedim>
+void test ();
+
+template <>
+void test<3,3> ()
+{
+  const int dim = 3;
+  const int spacedim = 3;
+  Triangulation<dim, spacedim> triangulation;
+
+  GridGenerator::torus(triangulation, 1.0, 0.4);
+
+  static const SphericalManifold<3> desc_sphere;
+  static const TorusManifold<3> desc_torus(1.0, 0.4);
+  triangulation.set_manifold (0, desc_torus);
+  triangulation.set_manifold (1, desc_sphere);
+
+  triangulation.refine_global(1);
+  triangulation.begin_active()->set_refine_flag();
+  triangulation.execute_coarsening_and_refinement ();
+
+  std::ofstream out ("grid-1.vtk");
+  GridOut grid_out;
+  grid_out.write_vtk (triangulation, out);
+
+
+  GridOut().write_gnuplot (triangulation, deallog.get_file_stream());
+}
+
+
+int main ()
+{
+  initlog ();
+
+  test<3,3> ();
+
+  return 0;
+}
diff --git a/tests/grid/torus_01.output b/tests/grid/torus_01.output
new file mode 100644 (file)
index 0000000..6a3aa73
--- /dev/null
@@ -0,0 +1,1321 @@
+
+0.641421 0.282843 1.11097 1 0
+0.500000 0.400000 0.866025 1 0
+0.358579 0.282843 0.621076 1 0
+0.520201 4.33154e-17 0.901014 1 0
+0.641421 0.282843 1.11097 1 0
+
+1.11097 0.282843 0.641421 1 0
+0.866025 0.400000 0.500000 1 0
+0.621076 0.282843 0.358579 1 0
+0.901694 3.47321e-17 0.520593 1 0
+1.11097 0.282843 0.641421 1 0
+
+0.641421 0.282843 1.11097 1 0
+1.11097 0.282843 0.641421 1 0
+
+0.500000 0.400000 0.866025 1 0
+0.866025 0.400000 0.500000 1 0
+
+0.358579 0.282843 0.621076 1 0
+0.621076 0.282843 0.358579 1 0
+
+0.520201 4.33154e-17 0.901014 1 0
+0.901694 3.47321e-17 0.520593 1 0
+
+1.21244 3.71201e-17 0.700000 1 0
+1.11097 0.282843 0.641421 1 0
+0.901694 3.47321e-17 0.520593 1 0
+1.11097 -0.282843 0.641421 1 0
+1.21244 3.71201e-17 0.700000 1 0
+
+1.40000 0.00000 0.00000 1 0
+1.28284 0.282843 -3.14206e-16 1 0
+1.04040 0.00000 -6.05209e-17 1 0
+1.28284 -0.282843 1.57103e-17 1 0
+1.40000 0.00000 0.00000 1 0
+
+1.21244 3.71201e-17 0.700000 1 0
+1.40000 0.00000 0.00000 1 0
+
+1.11097 0.282843 0.641421 1 0
+1.28284 0.282843 -3.14206e-16 1 0
+
+0.901694 3.47321e-17 0.520593 1 0
+1.04040 0.00000 -6.05209e-17 1 0
+
+1.11097 -0.282843 0.641421 1 0
+1.28284 -0.282843 1.57103e-17 1 0
+
+1.11097 0.282843 0.641421 1 0
+0.866025 0.400000 0.500000 1 0
+0.621076 0.282843 0.358579 1 0
+0.901694 3.47321e-17 0.520593 1 0
+1.11097 0.282843 0.641421 1 0
+
+1.28284 0.282843 -3.14206e-16 1 0
+1.00000 0.400000 -2.44929e-17 1 0
+0.717157 0.282843 -1.75653e-16 1 0
+1.04040 0.00000 -6.05209e-17 1 0
+1.28284 0.282843 -3.14206e-16 1 0
+
+1.11097 0.282843 0.641421 1 0
+1.28284 0.282843 -3.14206e-16 1 0
+
+0.866025 0.400000 0.500000 1 0
+1.00000 0.400000 -2.44929e-17 1 0
+
+0.621076 0.282843 0.358579 1 0
+0.717157 0.282843 -1.75653e-16 1 0
+
+0.901694 3.47321e-17 0.520593 1 0
+1.04040 0.00000 -6.05209e-17 1 0
+
+0.641421 -0.282843 1.11097 1 0
+0.520201 4.33154e-17 0.901014 1 0
+0.358579 -0.282843 0.621076 1 0
+0.500000 -0.400000 0.866025 1 0
+0.641421 -0.282843 1.11097 1 0
+
+1.11097 -0.282843 0.641421 1 0
+0.901694 3.47321e-17 0.520593 1 0
+0.621076 -0.282843 0.358579 1 0
+0.866025 -0.400000 0.500000 1 0
+1.11097 -0.282843 0.641421 1 0
+
+0.641421 -0.282843 1.11097 1 0
+1.11097 -0.282843 0.641421 1 0
+
+0.520201 4.33154e-17 0.901014 1 0
+0.901694 3.47321e-17 0.520593 1 0
+
+0.358579 -0.282843 0.621076 1 0
+0.621076 -0.282843 0.358579 1 0
+
+0.500000 -0.400000 0.866025 1 0
+0.866025 -0.400000 0.500000 1 0
+
+0.520201 4.33154e-17 0.901014 1 0
+0.358579 0.282843 0.621076 1 0
+0.300000 -1.71686e-17 0.519615 1 0
+0.358579 -0.282843 0.621076 1 0
+0.520201 4.33154e-17 0.901014 1 0
+
+0.901694 3.47321e-17 0.520593 1 0
+0.621076 0.282843 0.358579 1 0
+0.519615 4.89859e-17 0.300000 1 0
+0.621076 -0.282843 0.358579 1 0
+0.901694 3.47321e-17 0.520593 1 0
+
+0.520201 4.33154e-17 0.901014 1 0
+0.901694 3.47321e-17 0.520593 1 0
+
+0.358579 0.282843 0.621076 1 0
+0.621076 0.282843 0.358579 1 0
+
+0.300000 -1.71686e-17 0.519615 1 0
+0.519615 4.89859e-17 0.300000 1 0
+
+0.358579 -0.282843 0.621076 1 0
+0.621076 -0.282843 0.358579 1 0
+
+1.11097 -0.282843 0.641421 1 0
+0.901694 3.47321e-17 0.520593 1 0
+0.621076 -0.282843 0.358579 1 0
+0.866025 -0.400000 0.500000 1 0
+1.11097 -0.282843 0.641421 1 0
+
+1.28284 -0.282843 1.57103e-17 1 0
+1.04040 0.00000 -6.05209e-17 1 0
+0.717157 -0.282843 8.78264e-18 1 0
+1.00000 -0.400000 2.44929e-17 1 0
+1.28284 -0.282843 1.57103e-17 1 0
+
+1.11097 -0.282843 0.641421 1 0
+1.28284 -0.282843 1.57103e-17 1 0
+
+0.901694 3.47321e-17 0.520593 1 0
+1.04040 0.00000 -6.05209e-17 1 0
+
+0.621076 -0.282843 0.358579 1 0
+0.717157 -0.282843 8.78264e-18 1 0
+
+0.866025 -0.400000 0.500000 1 0
+1.00000 -0.400000 2.44929e-17 1 0
+
+0.901694 3.47321e-17 0.520593 1 0
+0.621076 0.282843 0.358579 1 0
+0.519615 4.89859e-17 0.300000 1 0
+0.621076 -0.282843 0.358579 1 0
+0.901694 3.47321e-17 0.520593 1 0
+
+1.04040 0.00000 -6.05209e-17 1 0
+0.717157 0.282843 -1.75653e-16 1 0
+0.600000 -4.89859e-17 2.99952e-33 1 0
+0.717157 -0.282843 8.78264e-18 1 0
+1.04040 0.00000 -6.05209e-17 1 0
+
+0.901694 3.47321e-17 0.520593 1 0
+1.04040 0.00000 -6.05209e-17 1 0
+
+0.621076 0.282843 0.358579 1 0
+0.717157 0.282843 -1.75653e-16 1 0
+
+0.519615 4.89859e-17 0.300000 1 0
+0.600000 -4.89859e-17 2.99952e-33 1 0
+
+0.621076 -0.282843 0.358579 1 0
+0.717157 -0.282843 8.78264e-18 1 0
+
+-0.700000 7.42403e-17 1.21244 1 0
+-0.641421 0.282843 1.11097 1 0
+-0.520201 2.16577e-17 0.901014 1 0
+-0.641421 -0.282843 1.11097 1 0
+-0.700000 7.42403e-17 1.21244 1 0
+
+8.57253e-17 7.42403e-17 1.40000 1 0
+7.85515e-17 0.282843 1.28284 1 0
+1.11689e-16 5.40277e-17 1.04119 1 0
+7.85515e-17 -0.282843 1.28284 1 0
+8.57253e-17 7.42403e-17 1.40000 1 0
+
+-0.700000 7.42403e-17 1.21244 1 0
+8.57253e-17 7.42403e-17 1.40000 1 0
+
+-0.641421 0.282843 1.11097 1 0
+7.85515e-17 0.282843 1.28284 1 0
+
+-0.520201 2.16577e-17 0.901014 1 0
+1.11689e-16 5.40277e-17 1.04119 1 0
+
+-0.641421 -0.282843 1.11097 1 0
+7.85515e-17 -0.282843 1.28284 1 0
+
+-0.641421 0.282843 1.11097 1 0
+-0.500000 0.400000 0.866025 1 0
+-0.358579 0.282843 0.621076 1 0
+-0.520201 2.16577e-17 0.901014 1 0
+-0.641421 0.282843 1.11097 1 0
+
+7.85515e-17 0.282843 1.28284 1 0
+6.12323e-17 0.400000 1.00000 1 0
+4.39132e-17 0.282843 0.717157 1 0
+1.11689e-16 5.40277e-17 1.04119 1 0
+7.85515e-17 0.282843 1.28284 1 0
+
+-0.641421 0.282843 1.11097 1 0
+7.85515e-17 0.282843 1.28284 1 0
+
+-0.500000 0.400000 0.866025 1 0
+6.12323e-17 0.400000 1.00000 1 0
+
+-0.358579 0.282843 0.621076 1 0
+4.39132e-17 0.282843 0.717157 1 0
+
+-0.520201 2.16577e-17 0.901014 1 0
+1.11689e-16 5.40277e-17 1.04119 1 0
+
+8.57253e-17 7.42403e-17 1.40000 1 0
+7.85515e-17 0.282843 1.28284 1 0
+1.11689e-16 5.40277e-17 1.04119 1 0
+7.85515e-17 -0.282843 1.28284 1 0
+8.57253e-17 7.42403e-17 1.40000 1 0
+
+0.700000 7.42403e-17 1.21244 1 0
+0.641421 0.282843 1.11097 1 0
+0.520201 4.33154e-17 0.901014 1 0
+0.641421 -0.282843 1.11097 1 0
+0.700000 7.42403e-17 1.21244 1 0
+
+8.57253e-17 7.42403e-17 1.40000 1 0
+0.700000 7.42403e-17 1.21244 1 0
+
+7.85515e-17 0.282843 1.28284 1 0
+0.641421 0.282843 1.11097 1 0
+
+1.11689e-16 5.40277e-17 1.04119 1 0
+0.520201 4.33154e-17 0.901014 1 0
+
+7.85515e-17 -0.282843 1.28284 1 0
+0.641421 -0.282843 1.11097 1 0
+
+7.85515e-17 0.282843 1.28284 1 0
+6.12323e-17 0.400000 1.00000 1 0
+4.39132e-17 0.282843 0.717157 1 0
+1.11689e-16 5.40277e-17 1.04119 1 0
+7.85515e-17 0.282843 1.28284 1 0
+
+0.641421 0.282843 1.11097 1 0
+0.500000 0.400000 0.866025 1 0
+0.358579 0.282843 0.621076 1 0
+0.520201 4.33154e-17 0.901014 1 0
+0.641421 0.282843 1.11097 1 0
+
+7.85515e-17 0.282843 1.28284 1 0
+0.641421 0.282843 1.11097 1 0
+
+6.12323e-17 0.400000 1.00000 1 0
+0.500000 0.400000 0.866025 1 0
+
+4.39132e-17 0.282843 0.717157 1 0
+0.358579 0.282843 0.621076 1 0
+
+1.11689e-16 5.40277e-17 1.04119 1 0
+0.520201 4.33154e-17 0.901014 1 0
+
+-0.641421 -0.282843 1.11097 1 0
+-0.520201 2.16577e-17 0.901014 1 0
+-0.358579 -0.282843 0.621076 1 0
+-0.500000 -0.400000 0.866025 1 0
+-0.641421 -0.282843 1.11097 1 0
+
+7.85515e-17 -0.282843 1.28284 1 0
+1.11689e-16 5.40277e-17 1.04119 1 0
+4.39132e-17 -0.282843 0.717157 1 0
+6.12323e-17 -0.400000 1.00000 1 0
+7.85515e-17 -0.282843 1.28284 1 0
+
+-0.641421 -0.282843 1.11097 1 0
+7.85515e-17 -0.282843 1.28284 1 0
+
+-0.520201 2.16577e-17 0.901014 1 0
+1.11689e-16 5.40277e-17 1.04119 1 0
+
+-0.358579 -0.282843 0.621076 1 0
+4.39132e-17 -0.282843 0.717157 1 0
+
+-0.500000 -0.400000 0.866025 1 0
+6.12323e-17 -0.400000 1.00000 1 0
+
+-0.520201 2.16577e-17 0.901014 1 0
+-0.358579 0.282843 0.621076 1 0
+-0.300000 -1.71686e-17 0.519615 1 0
+-0.358579 -0.282843 0.621076 1 0
+-0.520201 2.16577e-17 0.901014 1 0
+
+1.11689e-16 5.40277e-17 1.04119 1 0
+4.39132e-17 0.282843 0.717157 1 0
+3.67394e-17 4.89859e-17 0.600000 1 0
+4.39132e-17 -0.282843 0.717157 1 0
+1.11689e-16 5.40277e-17 1.04119 1 0
+
+-0.520201 2.16577e-17 0.901014 1 0
+1.11689e-16 5.40277e-17 1.04119 1 0
+
+-0.358579 0.282843 0.621076 1 0
+4.39132e-17 0.282843 0.717157 1 0
+
+-0.300000 -1.71686e-17 0.519615 1 0
+3.67394e-17 4.89859e-17 0.600000 1 0
+
+-0.358579 -0.282843 0.621076 1 0
+4.39132e-17 -0.282843 0.717157 1 0
+
+7.85515e-17 -0.282843 1.28284 1 0
+1.11689e-16 5.40277e-17 1.04119 1 0
+4.39132e-17 -0.282843 0.717157 1 0
+6.12323e-17 -0.400000 1.00000 1 0
+7.85515e-17 -0.282843 1.28284 1 0
+
+0.641421 -0.282843 1.11097 1 0
+0.520201 4.33154e-17 0.901014 1 0
+0.358579 -0.282843 0.621076 1 0
+0.500000 -0.400000 0.866025 1 0
+0.641421 -0.282843 1.11097 1 0
+
+7.85515e-17 -0.282843 1.28284 1 0
+0.641421 -0.282843 1.11097 1 0
+
+1.11689e-16 5.40277e-17 1.04119 1 0
+0.520201 4.33154e-17 0.901014 1 0
+
+4.39132e-17 -0.282843 0.717157 1 0
+0.358579 -0.282843 0.621076 1 0
+
+6.12323e-17 -0.400000 1.00000 1 0
+0.500000 -0.400000 0.866025 1 0
+
+1.11689e-16 5.40277e-17 1.04119 1 0
+4.39132e-17 0.282843 0.717157 1 0
+3.67394e-17 4.89859e-17 0.600000 1 0
+4.39132e-17 -0.282843 0.717157 1 0
+1.11689e-16 5.40277e-17 1.04119 1 0
+
+0.520201 4.33154e-17 0.901014 1 0
+0.358579 0.282843 0.621076 1 0
+0.300000 -1.71686e-17 0.519615 1 0
+0.358579 -0.282843 0.621076 1 0
+0.520201 4.33154e-17 0.901014 1 0
+
+1.11689e-16 5.40277e-17 1.04119 1 0
+0.520201 4.33154e-17 0.901014 1 0
+
+4.39132e-17 0.282843 0.717157 1 0
+0.358579 0.282843 0.621076 1 0
+
+3.67394e-17 4.89859e-17 0.600000 1 0
+0.300000 -1.71686e-17 0.519615 1 0
+
+4.39132e-17 -0.282843 0.717157 1 0
+0.358579 -0.282843 0.621076 1 0
+
+-1.40000 1.04983e-32 1.71451e-16 1 0
+-1.28284 0.282843 1.57103e-16 1 0
+-1.04040 0.00000 1.27412e-16 1 0
+-1.28284 -0.282843 1.57103e-16 1 0
+-1.40000 1.04983e-32 1.71451e-16 1 0
+
+-1.21244 3.71201e-17 0.700000 1 0
+-1.11097 0.282843 0.641421 1 0
+-0.901694 3.08730e-17 0.520593 1 0
+-1.11097 -0.282843 0.641421 1 0
+-1.21244 3.71201e-17 0.700000 1 0
+
+-1.40000 1.04983e-32 1.71451e-16 1 0
+-1.21244 3.71201e-17 0.700000 1 0
+
+-1.28284 0.282843 1.57103e-16 1 0
+-1.11097 0.282843 0.641421 1 0
+
+-1.04040 0.00000 1.27412e-16 1 0
+-0.901694 3.08730e-17 0.520593 1 0
+
+-1.28284 -0.282843 1.57103e-16 1 0
+-1.11097 -0.282843 0.641421 1 0
+
+-1.28284 0.282843 1.57103e-16 1 0
+-1.00000 0.400000 9.79717e-17 1 0
+-0.717157 0.282843 8.78264e-17 1 0
+-1.04040 0.00000 1.27412e-16 1 0
+-1.28284 0.282843 1.57103e-16 1 0
+
+-1.11097 0.282843 0.641421 1 0
+-0.866025 0.400000 0.500000 1 0
+-0.621076 0.282843 0.358579 1 0
+-0.901694 3.08730e-17 0.520593 1 0
+-1.11097 0.282843 0.641421 1 0
+
+-1.28284 0.282843 1.57103e-16 1 0
+-1.11097 0.282843 0.641421 1 0
+
+-1.00000 0.400000 9.79717e-17 1 0
+-0.866025 0.400000 0.500000 1 0
+
+-0.717157 0.282843 8.78264e-17 1 0
+-0.621076 0.282843 0.358579 1 0
+
+-1.04040 0.00000 1.27412e-16 1 0
+-0.901694 3.08730e-17 0.520593 1 0
+
+-1.21244 3.71201e-17 0.700000 1 0
+-1.11097 0.282843 0.641421 1 0
+-0.901694 3.08730e-17 0.520593 1 0
+-1.11097 -0.282843 0.641421 1 0
+-1.21244 3.71201e-17 0.700000 1 0
+
+-0.700000 7.42403e-17 1.21244 1 0
+-0.641421 0.282843 1.11097 1 0
+-0.520201 2.16577e-17 0.901014 1 0
+-0.641421 -0.282843 1.11097 1 0
+-0.700000 7.42403e-17 1.21244 1 0
+
+-1.21244 3.71201e-17 0.700000 1 0
+-0.700000 7.42403e-17 1.21244 1 0
+
+-1.11097 0.282843 0.641421 1 0
+-0.641421 0.282843 1.11097 1 0
+
+-0.901694 3.08730e-17 0.520593 1 0
+-0.520201 2.16577e-17 0.901014 1 0
+
+-1.11097 -0.282843 0.641421 1 0
+-0.641421 -0.282843 1.11097 1 0
+
+-1.11097 0.282843 0.641421 1 0
+-0.866025 0.400000 0.500000 1 0
+-0.621076 0.282843 0.358579 1 0
+-0.901694 3.08730e-17 0.520593 1 0
+-1.11097 0.282843 0.641421 1 0
+
+-0.641421 0.282843 1.11097 1 0
+-0.500000 0.400000 0.866025 1 0
+-0.358579 0.282843 0.621076 1 0
+-0.520201 2.16577e-17 0.901014 1 0
+-0.641421 0.282843 1.11097 1 0
+
+-1.11097 0.282843 0.641421 1 0
+-0.641421 0.282843 1.11097 1 0
+
+-0.866025 0.400000 0.500000 1 0
+-0.500000 0.400000 0.866025 1 0
+
+-0.621076 0.282843 0.358579 1 0
+-0.358579 0.282843 0.621076 1 0
+
+-0.901694 3.08730e-17 0.520593 1 0
+-0.520201 2.16577e-17 0.901014 1 0
+
+-1.28284 -0.282843 1.57103e-16 1 0
+-1.04040 0.00000 1.27412e-16 1 0
+-0.717157 -0.282843 8.78264e-17 1 0
+-1.00000 -0.400000 1.46958e-16 1 0
+-1.28284 -0.282843 1.57103e-16 1 0
+
+-1.11097 -0.282843 0.641421 1 0
+-0.901694 3.08730e-17 0.520593 1 0
+-0.621076 -0.282843 0.358579 1 0
+-0.866025 -0.400000 0.500000 1 0
+-1.11097 -0.282843 0.641421 1 0
+
+-1.28284 -0.282843 1.57103e-16 1 0
+-1.11097 -0.282843 0.641421 1 0
+
+-1.04040 0.00000 1.27412e-16 1 0
+-0.901694 3.08730e-17 0.520593 1 0
+
+-0.717157 -0.282843 8.78264e-17 1 0
+-0.621076 -0.282843 0.358579 1 0
+
+-1.00000 -0.400000 1.46958e-16 1 0
+-0.866025 -0.400000 0.500000 1 0
+
+-1.04040 0.00000 1.27412e-16 1 0
+-0.717157 0.282843 8.78264e-17 1 0
+-0.600000 -4.89859e-17 7.34788e-17 1 0
+-0.717157 -0.282843 8.78264e-17 1 0
+-1.04040 0.00000 1.27412e-16 1 0
+
+-0.901694 3.08730e-17 0.520593 1 0
+-0.621076 0.282843 0.358579 1 0
+-0.519615 4.89859e-17 0.300000 1 0
+-0.621076 -0.282843 0.358579 1 0
+-0.901694 3.08730e-17 0.520593 1 0
+
+-1.04040 0.00000 1.27412e-16 1 0
+-0.901694 3.08730e-17 0.520593 1 0
+
+-0.717157 0.282843 8.78264e-17 1 0
+-0.621076 0.282843 0.358579 1 0
+
+-0.600000 -4.89859e-17 7.34788e-17 1 0
+-0.519615 4.89859e-17 0.300000 1 0
+
+-0.717157 -0.282843 8.78264e-17 1 0
+-0.621076 -0.282843 0.358579 1 0
+
+-1.11097 -0.282843 0.641421 1 0
+-0.901694 3.08730e-17 0.520593 1 0
+-0.621076 -0.282843 0.358579 1 0
+-0.866025 -0.400000 0.500000 1 0
+-1.11097 -0.282843 0.641421 1 0
+
+-0.641421 -0.282843 1.11097 1 0
+-0.520201 2.16577e-17 0.901014 1 0
+-0.358579 -0.282843 0.621076 1 0
+-0.500000 -0.400000 0.866025 1 0
+-0.641421 -0.282843 1.11097 1 0
+
+-1.11097 -0.282843 0.641421 1 0
+-0.641421 -0.282843 1.11097 1 0
+
+-0.901694 3.08730e-17 0.520593 1 0
+-0.520201 2.16577e-17 0.901014 1 0
+
+-0.621076 -0.282843 0.358579 1 0
+-0.358579 -0.282843 0.621076 1 0
+
+-0.866025 -0.400000 0.500000 1 0
+-0.500000 -0.400000 0.866025 1 0
+
+-0.901694 3.08730e-17 0.520593 1 0
+-0.621076 0.282843 0.358579 1 0
+-0.519615 4.89859e-17 0.300000 1 0
+-0.621076 -0.282843 0.358579 1 0
+-0.901694 3.08730e-17 0.520593 1 0
+
+-0.520201 2.16577e-17 0.901014 1 0
+-0.358579 0.282843 0.621076 1 0
+-0.300000 -1.71686e-17 0.519615 1 0
+-0.358579 -0.282843 0.621076 1 0
+-0.520201 2.16577e-17 0.901014 1 0
+
+-0.901694 3.08730e-17 0.520593 1 0
+-0.520201 2.16577e-17 0.901014 1 0
+
+-0.621076 0.282843 0.358579 1 0
+-0.358579 0.282843 0.621076 1 0
+
+-0.519615 4.89859e-17 0.300000 1 0
+-0.300000 -1.71686e-17 0.519615 1 0
+
+-0.621076 -0.282843 0.358579 1 0
+-0.358579 -0.282843 0.621076 1 0
+
+-0.700000 -7.42403e-17 -1.21244 1 0
+-0.641421 0.282843 -1.11097 1 0
+-0.520201 -2.88769e-17 -0.901014 1 0
+-0.641421 -0.282843 -1.11097 1 0
+-0.700000 -7.42403e-17 -1.21244 1 0
+
+-1.21244 -9.79717e-17 -0.700000 1 0
+-1.11097 0.282843 -0.641421 1 0
+-0.901694 1.54365e-17 -0.520593 1 0
+-1.11097 -0.282843 -0.641421 1 0
+-1.21244 -9.79717e-17 -0.700000 1 0
+
+-0.700000 -7.42403e-17 -1.21244 1 0
+-1.21244 -9.79717e-17 -0.700000 1 0
+
+-0.641421 0.282843 -1.11097 1 0
+-1.11097 0.282843 -0.641421 1 0
+
+-0.520201 -2.88769e-17 -0.901014 1 0
+-0.901694 1.54365e-17 -0.520593 1 0
+
+-0.641421 -0.282843 -1.11097 1 0
+-1.11097 -0.282843 -0.641421 1 0
+
+-0.641421 0.282843 -1.11097 1 0
+-0.500000 0.400000 -0.866025 1 0
+-0.358579 0.282843 -0.621076 1 0
+-0.520201 -2.88769e-17 -0.901014 1 0
+-0.641421 0.282843 -1.11097 1 0
+
+-1.11097 0.282843 -0.641421 1 0
+-0.866025 0.400000 -0.500000 1 0
+-0.621076 0.282843 -0.358579 1 0
+-0.901694 1.54365e-17 -0.520593 1 0
+-1.11097 0.282843 -0.641421 1 0
+
+-0.641421 0.282843 -1.11097 1 0
+-1.11097 0.282843 -0.641421 1 0
+
+-0.500000 0.400000 -0.866025 1 0
+-0.866025 0.400000 -0.500000 1 0
+
+-0.358579 0.282843 -0.621076 1 0
+-0.621076 0.282843 -0.358579 1 0
+
+-0.520201 -2.88769e-17 -0.901014 1 0
+-0.901694 1.54365e-17 -0.520593 1 0
+
+-1.21244 -9.79717e-17 -0.700000 1 0
+-1.11097 0.282843 -0.641421 1 0
+-0.901694 1.54365e-17 -0.520593 1 0
+-1.11097 -0.282843 -0.641421 1 0
+-1.21244 -9.79717e-17 -0.700000 1 0
+
+-1.40000 1.04983e-32 1.71451e-16 1 0
+-1.28284 0.282843 1.57103e-16 1 0
+-1.04040 0.00000 1.27412e-16 1 0
+-1.28284 -0.282843 1.57103e-16 1 0
+-1.40000 1.04983e-32 1.71451e-16 1 0
+
+-1.21244 -9.79717e-17 -0.700000 1 0
+-1.40000 1.04983e-32 1.71451e-16 1 0
+
+-1.11097 0.282843 -0.641421 1 0
+-1.28284 0.282843 1.57103e-16 1 0
+
+-0.901694 1.54365e-17 -0.520593 1 0
+-1.04040 0.00000 1.27412e-16 1 0
+
+-1.11097 -0.282843 -0.641421 1 0
+-1.28284 -0.282843 1.57103e-16 1 0
+
+-1.11097 0.282843 -0.641421 1 0
+-0.866025 0.400000 -0.500000 1 0
+-0.621076 0.282843 -0.358579 1 0
+-0.901694 1.54365e-17 -0.520593 1 0
+-1.11097 0.282843 -0.641421 1 0
+
+-1.28284 0.282843 1.57103e-16 1 0
+-1.00000 0.400000 9.79717e-17 1 0
+-0.717157 0.282843 8.78264e-17 1 0
+-1.04040 0.00000 1.27412e-16 1 0
+-1.28284 0.282843 1.57103e-16 1 0
+
+-1.11097 0.282843 -0.641421 1 0
+-1.28284 0.282843 1.57103e-16 1 0
+
+-0.866025 0.400000 -0.500000 1 0
+-1.00000 0.400000 9.79717e-17 1 0
+
+-0.621076 0.282843 -0.358579 1 0
+-0.717157 0.282843 8.78264e-17 1 0
+
+-0.901694 1.54365e-17 -0.520593 1 0
+-1.04040 0.00000 1.27412e-16 1 0
+
+-0.641421 -0.282843 -1.11097 1 0
+-0.520201 -2.88769e-17 -0.901014 1 0
+-0.358579 -0.282843 -0.621076 1 0
+-0.500000 -0.400000 -0.866025 1 0
+-0.641421 -0.282843 -1.11097 1 0
+
+-1.11097 -0.282843 -0.641421 1 0
+-0.901694 1.54365e-17 -0.520593 1 0
+-0.621076 -0.282843 -0.358579 1 0
+-0.866025 -0.400000 -0.500000 1 0
+-1.11097 -0.282843 -0.641421 1 0
+
+-0.641421 -0.282843 -1.11097 1 0
+-1.11097 -0.282843 -0.641421 1 0
+
+-0.520201 -2.88769e-17 -0.901014 1 0
+-0.901694 1.54365e-17 -0.520593 1 0
+
+-0.358579 -0.282843 -0.621076 1 0
+-0.621076 -0.282843 -0.358579 1 0
+
+-0.500000 -0.400000 -0.866025 1 0
+-0.866025 -0.400000 -0.500000 1 0
+
+-0.520201 -2.88769e-17 -0.901014 1 0
+-0.358579 0.282843 -0.621076 1 0
+-0.300000 -8.08031e-17 -0.519615 1 0
+-0.358579 -0.282843 -0.621076 1 0
+-0.520201 -2.88769e-17 -0.901014 1 0
+
+-0.901694 1.54365e-17 -0.520593 1 0
+-0.621076 0.282843 -0.358579 1 0
+-0.519615 4.89859e-17 -0.300000 1 0
+-0.621076 -0.282843 -0.358579 1 0
+-0.901694 1.54365e-17 -0.520593 1 0
+
+-0.520201 -2.88769e-17 -0.901014 1 0
+-0.901694 1.54365e-17 -0.520593 1 0
+
+-0.358579 0.282843 -0.621076 1 0
+-0.621076 0.282843 -0.358579 1 0
+
+-0.300000 -8.08031e-17 -0.519615 1 0
+-0.519615 4.89859e-17 -0.300000 1 0
+
+-0.358579 -0.282843 -0.621076 1 0
+-0.621076 -0.282843 -0.358579 1 0
+
+-1.11097 -0.282843 -0.641421 1 0
+-0.901694 1.54365e-17 -0.520593 1 0
+-0.621076 -0.282843 -0.358579 1 0
+-0.866025 -0.400000 -0.500000 1 0
+-1.11097 -0.282843 -0.641421 1 0
+
+-1.28284 -0.282843 1.57103e-16 1 0
+-1.04040 0.00000 1.27412e-16 1 0
+-0.717157 -0.282843 8.78264e-17 1 0
+-1.00000 -0.400000 1.46958e-16 1 0
+-1.28284 -0.282843 1.57103e-16 1 0
+
+-1.11097 -0.282843 -0.641421 1 0
+-1.28284 -0.282843 1.57103e-16 1 0
+
+-0.901694 1.54365e-17 -0.520593 1 0
+-1.04040 0.00000 1.27412e-16 1 0
+
+-0.621076 -0.282843 -0.358579 1 0
+-0.717157 -0.282843 8.78264e-17 1 0
+
+-0.866025 -0.400000 -0.500000 1 0
+-1.00000 -0.400000 1.46958e-16 1 0
+
+-0.901694 1.54365e-17 -0.520593 1 0
+-0.621076 0.282843 -0.358579 1 0
+-0.519615 4.89859e-17 -0.300000 1 0
+-0.621076 -0.282843 -0.358579 1 0
+-0.901694 1.54365e-17 -0.520593 1 0
+
+-1.04040 0.00000 1.27412e-16 1 0
+-0.717157 0.282843 8.78264e-17 1 0
+-0.600000 -4.89859e-17 7.34788e-17 1 0
+-0.717157 -0.282843 8.78264e-17 1 0
+-1.04040 0.00000 1.27412e-16 1 0
+
+-0.901694 1.54365e-17 -0.520593 1 0
+-1.04040 0.00000 1.27412e-16 1 0
+
+-0.621076 0.282843 -0.358579 1 0
+-0.717157 0.282843 8.78264e-17 1 0
+
+-0.519615 4.89859e-17 -0.300000 1 0
+-0.600000 -4.89859e-17 7.34788e-17 1 0
+
+-0.621076 -0.282843 -0.358579 1 0
+-0.717157 -0.282843 8.78264e-17 1 0
+
+0.700000 -7.42403e-17 -1.21244 1 0
+0.641421 0.282843 -1.11097 1 0
+0.520201 -3.60962e-17 -0.901014 1 0
+0.641421 -0.282843 -1.11097 1 0
+0.700000 -7.42403e-17 -1.21244 1 0
+
+-1.50063e-15 -9.79717e-17 -1.40000 1 0
+-1.37505e-15 0.282843 -1.28284 1 0
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+-1.37505e-15 -0.282843 -1.28284 1 0
+-1.50063e-15 -9.79717e-17 -1.40000 1 0
+
+0.700000 -7.42403e-17 -1.21244 1 0
+-1.50063e-15 -9.79717e-17 -1.40000 1 0
+
+0.641421 0.282843 -1.11097 1 0
+-1.37505e-15 0.282843 -1.28284 1 0
+
+0.520201 -3.60962e-17 -0.901014 1 0
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+
+0.641421 -0.282843 -1.11097 1 0
+-1.37505e-15 -0.282843 -1.28284 1 0
+
+0.641421 0.282843 -1.11097 1 0
+0.500000 0.400000 -0.866025 1 0
+0.358579 0.282843 -0.621076 1 0
+0.520201 -3.60962e-17 -0.901014 1 0
+0.641421 0.282843 -1.11097 1 0
+
+-1.37505e-15 0.282843 -1.28284 1 0
+-1.07188e-15 0.400000 -1.00000 1 0
+-7.68703e-16 0.282843 -0.717157 1 0
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+-1.37505e-15 0.282843 -1.28284 1 0
+
+0.641421 0.282843 -1.11097 1 0
+-1.37505e-15 0.282843 -1.28284 1 0
+
+0.500000 0.400000 -0.866025 1 0
+-1.07188e-15 0.400000 -1.00000 1 0
+
+0.358579 0.282843 -0.621076 1 0
+-7.68703e-16 0.282843 -0.717157 1 0
+
+0.520201 -3.60962e-17 -0.901014 1 0
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+
+-1.50063e-15 -9.79717e-17 -1.40000 1 0
+-1.37505e-15 0.282843 -1.28284 1 0
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+-1.37505e-15 -0.282843 -1.28284 1 0
+-1.50063e-15 -9.79717e-17 -1.40000 1 0
+
+-0.700000 -7.42403e-17 -1.21244 1 0
+-0.641421 0.282843 -1.11097 1 0
+-0.520201 -2.88769e-17 -0.901014 1 0
+-0.641421 -0.282843 -1.11097 1 0
+-0.700000 -7.42403e-17 -1.21244 1 0
+
+-1.50063e-15 -9.79717e-17 -1.40000 1 0
+-0.700000 -7.42403e-17 -1.21244 1 0
+
+-1.37505e-15 0.282843 -1.28284 1 0
+-0.641421 0.282843 -1.11097 1 0
+
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+-0.520201 -2.88769e-17 -0.901014 1 0
+
+-1.37505e-15 -0.282843 -1.28284 1 0
+-0.641421 -0.282843 -1.11097 1 0
+
+-1.37505e-15 0.282843 -1.28284 1 0
+-1.07188e-15 0.400000 -1.00000 1 0
+-7.68703e-16 0.282843 -0.717157 1 0
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+-1.37505e-15 0.282843 -1.28284 1 0
+
+-0.641421 0.282843 -1.11097 1 0
+-0.500000 0.400000 -0.866025 1 0
+-0.358579 0.282843 -0.621076 1 0
+-0.520201 -2.88769e-17 -0.901014 1 0
+-0.641421 0.282843 -1.11097 1 0
+
+-1.37505e-15 0.282843 -1.28284 1 0
+-0.641421 0.282843 -1.11097 1 0
+
+-1.07188e-15 0.400000 -1.00000 1 0
+-0.500000 0.400000 -0.866025 1 0
+
+-7.68703e-16 0.282843 -0.717157 1 0
+-0.358579 0.282843 -0.621076 1 0
+
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+-0.520201 -2.88769e-17 -0.901014 1 0
+
+0.641421 -0.282843 -1.11097 1 0
+0.520201 -3.60962e-17 -0.901014 1 0
+0.358579 -0.282843 -0.621076 1 0
+0.500000 -0.400000 -0.866025 1 0
+0.641421 -0.282843 -1.11097 1 0
+
+-1.37505e-15 -0.282843 -1.28284 1 0
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+-7.68703e-16 -0.282843 -0.717157 1 0
+-1.07188e-15 -0.400000 -1.00000 1 0
+-1.37505e-15 -0.282843 -1.28284 1 0
+
+0.641421 -0.282843 -1.11097 1 0
+-1.37505e-15 -0.282843 -1.28284 1 0
+
+0.520201 -3.60962e-17 -0.901014 1 0
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+
+0.358579 -0.282843 -0.621076 1 0
+-7.68703e-16 -0.282843 -0.717157 1 0
+
+0.500000 -0.400000 -0.866025 1 0
+-1.07188e-15 -0.400000 -1.00000 1 0
+
+0.520201 -3.60962e-17 -0.901014 1 0
+0.358579 0.282843 -0.621076 1 0
+0.300000 -8.08031e-17 -0.519615 1 0
+0.358579 -0.282843 -0.621076 1 0
+0.520201 -3.60962e-17 -0.901014 1 0
+
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+-7.68703e-16 0.282843 -0.717157 1 0
+-6.43125e-16 4.89859e-17 -0.600000 1 0
+-7.68703e-16 -0.282843 -0.717157 1 0
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+
+0.520201 -3.60962e-17 -0.901014 1 0
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+
+0.358579 0.282843 -0.621076 1 0
+-7.68703e-16 0.282843 -0.717157 1 0
+
+0.300000 -8.08031e-17 -0.519615 1 0
+-6.43125e-16 4.89859e-17 -0.600000 1 0
+
+0.358579 -0.282843 -0.621076 1 0
+-7.68703e-16 -0.282843 -0.717157 1 0
+
+-1.37505e-15 -0.282843 -1.28284 1 0
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+-7.68703e-16 -0.282843 -0.717157 1 0
+-1.07188e-15 -0.400000 -1.00000 1 0
+-1.37505e-15 -0.282843 -1.28284 1 0
+
+-0.641421 -0.282843 -1.11097 1 0
+-0.520201 -2.88769e-17 -0.901014 1 0
+-0.358579 -0.282843 -0.621076 1 0
+-0.500000 -0.400000 -0.866025 1 0
+-0.641421 -0.282843 -1.11097 1 0
+
+-1.37505e-15 -0.282843 -1.28284 1 0
+-0.641421 -0.282843 -1.11097 1 0
+
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+-0.520201 -2.88769e-17 -0.901014 1 0
+
+-7.68703e-16 -0.282843 -0.717157 1 0
+-0.358579 -0.282843 -0.621076 1 0
+
+-1.07188e-15 -0.400000 -1.00000 1 0
+-0.500000 -0.400000 -0.866025 1 0
+
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+-7.68703e-16 0.282843 -0.717157 1 0
+-6.43125e-16 4.89859e-17 -0.600000 1 0
+-7.68703e-16 -0.282843 -0.717157 1 0
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+
+-0.520201 -2.88769e-17 -0.901014 1 0
+-0.358579 0.282843 -0.621076 1 0
+-0.300000 -8.08031e-17 -0.519615 1 0
+-0.358579 -0.282843 -0.621076 1 0
+-0.520201 -2.88769e-17 -0.901014 1 0
+
+-1.06315e-15 -1.15774e-17 -1.04119 1 0
+-0.520201 -2.88769e-17 -0.901014 1 0
+
+-7.68703e-16 0.282843 -0.717157 1 0
+-0.358579 0.282843 -0.621076 1 0
+
+-6.43125e-16 4.89859e-17 -0.600000 1 0
+-0.300000 -8.08031e-17 -0.519615 1 0
+
+-7.68703e-16 -0.282843 -0.717157 1 0
+-0.358579 -0.282843 -0.621076 1 0
+
+1.40000 0.00000 0.00000 1 0
+1.28284 0.282843 -3.14206e-16 1 0
+1.04040 0.00000 -6.05209e-17 1 0
+1.28284 -0.282843 1.57103e-17 1 0
+1.40000 0.00000 0.00000 1 0
+
+1.21244 -9.79717e-17 -0.700000 1 0
+1.11097 0.282843 -0.641421 1 0
+0.901694 -3.85912e-18 -0.520593 1 0
+1.11097 -0.282843 -0.641421 1 0
+1.21244 -9.79717e-17 -0.700000 1 0
+
+1.40000 0.00000 0.00000 1 0
+1.21244 -9.79717e-17 -0.700000 1 0
+
+1.28284 0.282843 -3.14206e-16 1 0
+1.11097 0.282843 -0.641421 1 0
+
+1.04040 0.00000 -6.05209e-17 1 0
+0.901694 -3.85912e-18 -0.520593 1 0
+
+1.28284 -0.282843 1.57103e-17 1 0
+1.11097 -0.282843 -0.641421 1 0
+
+1.28284 0.282843 -3.14206e-16 1 0
+1.00000 0.400000 -2.44929e-17 1 0
+0.717157 0.282843 -1.75653e-16 1 0
+1.04040 0.00000 -6.05209e-17 1 0
+1.28284 0.282843 -3.14206e-16 1 0
+
+1.11097 0.282843 -0.641421 1 0
+0.866025 0.400000 -0.500000 1 0
+0.621076 0.282843 -0.358579 1 0
+0.901694 -3.85912e-18 -0.520593 1 0
+1.11097 0.282843 -0.641421 1 0
+
+1.28284 0.282843 -3.14206e-16 1 0
+1.11097 0.282843 -0.641421 1 0
+
+1.00000 0.400000 -2.44929e-17 1 0
+0.866025 0.400000 -0.500000 1 0
+
+0.717157 0.282843 -1.75653e-16 1 0
+0.621076 0.282843 -0.358579 1 0
+
+1.04040 0.00000 -6.05209e-17 1 0
+0.901694 -3.85912e-18 -0.520593 1 0
+
+1.21244 -9.79717e-17 -0.700000 1 0
+1.11097 0.282843 -0.641421 1 0
+0.901694 -3.85912e-18 -0.520593 1 0
+1.11097 -0.282843 -0.641421 1 0
+1.21244 -9.79717e-17 -0.700000 1 0
+
+0.700000 -7.42403e-17 -1.21244 1 0
+0.641421 0.282843 -1.11097 1 0
+0.520201 -3.60962e-17 -0.901014 1 0
+0.641421 -0.282843 -1.11097 1 0
+0.700000 -7.42403e-17 -1.21244 1 0
+
+1.21244 -9.79717e-17 -0.700000 1 0
+0.700000 -7.42403e-17 -1.21244 1 0
+
+1.11097 0.282843 -0.641421 1 0
+0.641421 0.282843 -1.11097 1 0
+
+0.901694 -3.85912e-18 -0.520593 1 0
+0.520201 -3.60962e-17 -0.901014 1 0
+
+1.11097 -0.282843 -0.641421 1 0
+0.641421 -0.282843 -1.11097 1 0
+
+1.11097 0.282843 -0.641421 1 0
+0.866025 0.400000 -0.500000 1 0
+0.621076 0.282843 -0.358579 1 0
+0.901694 -3.85912e-18 -0.520593 1 0
+1.11097 0.282843 -0.641421 1 0
+
+0.641421 0.282843 -1.11097 1 0
+0.500000 0.400000 -0.866025 1 0
+0.358579 0.282843 -0.621076 1 0
+0.520201 -3.60962e-17 -0.901014 1 0
+0.641421 0.282843 -1.11097 1 0
+
+1.11097 0.282843 -0.641421 1 0
+0.641421 0.282843 -1.11097 1 0
+
+0.866025 0.400000 -0.500000 1 0
+0.500000 0.400000 -0.866025 1 0
+
+0.621076 0.282843 -0.358579 1 0
+0.358579 0.282843 -0.621076 1 0
+
+0.901694 -3.85912e-18 -0.520593 1 0
+0.520201 -3.60962e-17 -0.901014 1 0
+
+1.28284 -0.282843 1.57103e-17 1 0
+1.04040 0.00000 -6.05209e-17 1 0
+0.717157 -0.282843 8.78264e-18 1 0
+1.00000 -0.400000 2.44929e-17 1 0
+1.28284 -0.282843 1.57103e-17 1 0
+
+1.11097 -0.282843 -0.641421 1 0
+0.901694 -3.85912e-18 -0.520593 1 0
+0.621076 -0.282843 -0.358579 1 0
+0.866025 -0.400000 -0.500000 1 0
+1.11097 -0.282843 -0.641421 1 0
+
+1.28284 -0.282843 1.57103e-17 1 0
+1.11097 -0.282843 -0.641421 1 0
+
+1.04040 0.00000 -6.05209e-17 1 0
+0.901694 -3.85912e-18 -0.520593 1 0
+
+0.717157 -0.282843 8.78264e-18 1 0
+0.621076 -0.282843 -0.358579 1 0
+
+1.00000 -0.400000 2.44929e-17 1 0
+0.866025 -0.400000 -0.500000 1 0
+
+1.04040 0.00000 -6.05209e-17 1 0
+0.717157 0.282843 -1.75653e-16 1 0
+0.600000 -4.89859e-17 2.99952e-33 1 0
+0.717157 -0.282843 8.78264e-18 1 0
+1.04040 0.00000 -6.05209e-17 1 0
+
+0.901694 -3.85912e-18 -0.520593 1 0
+0.621076 0.282843 -0.358579 1 0
+0.519615 4.89859e-17 -0.300000 1 0
+0.621076 -0.282843 -0.358579 1 0
+0.901694 -3.85912e-18 -0.520593 1 0
+
+1.04040 0.00000 -6.05209e-17 1 0
+0.901694 -3.85912e-18 -0.520593 1 0
+
+0.717157 0.282843 -1.75653e-16 1 0
+0.621076 0.282843 -0.358579 1 0
+
+0.600000 -4.89859e-17 2.99952e-33 1 0
+0.519615 4.89859e-17 -0.300000 1 0
+
+0.717157 -0.282843 8.78264e-18 1 0
+0.621076 -0.282843 -0.358579 1 0
+
+1.11097 -0.282843 -0.641421 1 0
+0.901694 -3.85912e-18 -0.520593 1 0
+0.621076 -0.282843 -0.358579 1 0
+0.866025 -0.400000 -0.500000 1 0
+1.11097 -0.282843 -0.641421 1 0
+
+0.641421 -0.282843 -1.11097 1 0
+0.520201 -3.60962e-17 -0.901014 1 0
+0.358579 -0.282843 -0.621076 1 0
+0.500000 -0.400000 -0.866025 1 0
+0.641421 -0.282843 -1.11097 1 0
+
+1.11097 -0.282843 -0.641421 1 0
+0.641421 -0.282843 -1.11097 1 0
+
+0.901694 -3.85912e-18 -0.520593 1 0
+0.520201 -3.60962e-17 -0.901014 1 0
+
+0.621076 -0.282843 -0.358579 1 0
+0.358579 -0.282843 -0.621076 1 0
+
+0.866025 -0.400000 -0.500000 1 0
+0.500000 -0.400000 -0.866025 1 0
+
+0.901694 -3.85912e-18 -0.520593 1 0
+0.621076 0.282843 -0.358579 1 0
+0.519615 4.89859e-17 -0.300000 1 0
+0.621076 -0.282843 -0.358579 1 0
+0.901694 -3.85912e-18 -0.520593 1 0
+
+0.520201 -3.60962e-17 -0.901014 1 0
+0.358579 0.282843 -0.621076 1 0
+0.300000 -8.08031e-17 -0.519615 1 0
+0.358579 -0.282843 -0.621076 1 0
+0.520201 -3.60962e-17 -0.901014 1 0
+
+0.901694 -3.85912e-18 -0.520593 1 0
+0.520201 -3.60962e-17 -0.901014 1 0
+
+0.621076 0.282843 -0.358579 1 0
+0.358579 0.282843 -0.621076 1 0
+
+0.519615 4.89859e-17 -0.300000 1 0
+0.300000 -8.08031e-17 -0.519615 1 0
+
+0.621076 -0.282843 -0.358579 1 0
+0.358579 -0.282843 -0.621076 1 0
+
+0.700000 7.42403e-17 1.21244 2 0
+0.684776 0.153073 1.18607 2 0
+0.636120 3.15221e-17 1.10179 2 0
+0.684776 -0.153073 1.18607 2 0
+0.700000 7.42403e-17 1.21244 2 0
+
+0.989949 5.56802e-17 0.989949 2 0
+0.968419 0.153073 0.968419 2 0
+0.901263 1.60036e-17 0.901226 2 0
+0.968419 -0.153073 0.968419 2 0
+0.989949 5.56802e-17 0.989949 2 0
+
+0.700000 7.42403e-17 1.21244 2 0
+0.989949 5.56802e-17 0.989949 2 0
+
+0.684776 0.153073 1.18607 2 0
+0.968419 0.153073 0.968419 2 0
+
+0.636120 3.15221e-17 1.10179 2 0
+0.901263 1.60036e-17 0.901226 2 0
+
+0.684776 -0.153073 1.18607 2 0
+0.968419 -0.153073 0.968419 2 0
+
+0.684776 0.153073 1.18607 2 0
+0.641421 0.282843 1.11097 2 0
+0.584200 0.142247 1.01186 2 0
+0.636120 3.15221e-17 1.10179 2 0
+0.684776 0.153073 1.18607 2 0
+
+0.968419 0.153073 0.968419 2 0
+0.907107 0.282843 0.907107 2 0
+0.826040 0.145922 0.825966 2 0
+0.901263 1.60036e-17 0.901226 2 0
+0.968419 0.153073 0.968419 2 0
+
+0.684776 0.153073 1.18607 2 0
+0.968419 0.153073 0.968419 2 0
+
+0.641421 0.282843 1.11097 2 0
+0.907107 0.282843 0.907107 2 0
+
+0.584200 0.142247 1.01186 2 0
+0.826040 0.145922 0.825966 2 0
+
+0.636120 3.15221e-17 1.10179 2 0
+0.901263 1.60036e-17 0.901226 2 0
+
+0.989949 5.56802e-17 0.989949 2 0
+0.968419 0.153073 0.968419 2 0
+0.901263 1.60036e-17 0.901226 2 0
+0.968419 -0.153073 0.968419 2 0
+0.989949 5.56802e-17 0.989949 2 0
+
+1.21244 3.71201e-17 0.700000 2 0
+1.18607 0.153073 0.684776 2 0
+1.10196 2.80196e-17 0.636218 2 0
+1.18607 -0.153073 0.684776 2 0
+1.21244 3.71201e-17 0.700000 2 0
+
+0.989949 5.56802e-17 0.989949 2 0
+1.21244 3.71201e-17 0.700000 2 0
+
+0.968419 0.153073 0.968419 2 0
+1.18607 0.153073 0.684776 2 0
+
+0.901263 1.60036e-17 0.901226 2 0
+1.10196 2.80196e-17 0.636218 2 0
+
+0.968419 -0.153073 0.968419 2 0
+1.18607 -0.153073 0.684776 2 0
+
+0.968419 0.153073 0.968419 2 0
+0.907107 0.282843 0.907107 2 0
+0.826040 0.145922 0.825966 2 0
+0.901263 1.60036e-17 0.901226 2 0
+0.968419 0.153073 0.968419 2 0
+
+1.18607 0.153073 0.684776 2 0
+1.11097 0.282843 0.641421 2 0
+1.01221 0.142247 0.584398 2 0
+1.10196 2.80196e-17 0.636218 2 0
+1.18607 0.153073 0.684776 2 0
+
+0.968419 0.153073 0.968419 2 0
+1.18607 0.153073 0.684776 2 0
+
+0.907107 0.282843 0.907107 2 0
+1.11097 0.282843 0.641421 2 0
+
+0.826040 0.145922 0.825966 2 0
+1.01221 0.142247 0.584398 2 0
+
+0.901263 1.60036e-17 0.901226 2 0
+1.10196 2.80196e-17 0.636218 2 0
+
+0.684776 -0.153073 1.18607 2 0
+0.636120 3.15221e-17 1.10179 2 0
+0.584200 -0.142247 1.01186 2 0
+0.641421 -0.282843 1.11097 2 0
+0.684776 -0.153073 1.18607 2 0
+
+0.968419 -0.153073 0.968419 2 0
+0.901263 1.60036e-17 0.901226 2 0
+0.826040 -0.145922 0.825966 2 0
+0.907107 -0.282843 0.907107 2 0
+0.968419 -0.153073 0.968419 2 0
+
+0.684776 -0.153073 1.18607 2 0
+0.968419 -0.153073 0.968419 2 0
+
+0.636120 3.15221e-17 1.10179 2 0
+0.901263 1.60036e-17 0.901226 2 0
+
+0.584200 -0.142247 1.01186 2 0
+0.826040 -0.145922 0.825966 2 0
+
+0.641421 -0.282843 1.11097 2 0
+0.907107 -0.282843 0.907107 2 0
+
+0.636120 3.15221e-17 1.10179 2 0
+0.584200 0.142247 1.01186 2 0
+0.520201 4.33154e-17 0.901014 2 0
+0.584200 -0.142247 1.01186 2 0
+0.636120 3.15221e-17 1.10179 2 0
+
+0.901263 1.60036e-17 0.901226 2 0
+0.826040 0.145922 0.825966 2 0
+0.736027 4.04003e-17 0.735878 2 0
+0.826040 -0.145922 0.825966 2 0
+0.901263 1.60036e-17 0.901226 2 0
+
+0.636120 3.15221e-17 1.10179 2 0
+0.901263 1.60036e-17 0.901226 2 0
+
+0.584200 0.142247 1.01186 2 0
+0.826040 0.145922 0.825966 2 0
+
+0.520201 4.33154e-17 0.901014 2 0
+0.736027 4.04003e-17 0.735878 2 0
+
+0.584200 -0.142247 1.01186 2 0
+0.826040 -0.145922 0.825966 2 0
+
+0.968419 -0.153073 0.968419 2 0
+0.901263 1.60036e-17 0.901226 2 0
+0.826040 -0.145922 0.825966 2 0
+0.907107 -0.282843 0.907107 2 0
+0.968419 -0.153073 0.968419 2 0
+
+1.18607 -0.153073 0.684776 2 0
+1.10196 2.80196e-17 0.636218 2 0
+1.01221 -0.142247 0.584398 2 0
+1.11097 -0.282843 0.641421 2 0
+1.18607 -0.153073 0.684776 2 0
+
+0.968419 -0.153073 0.968419 2 0
+1.18607 -0.153073 0.684776 2 0
+
+0.901263 1.60036e-17 0.901226 2 0
+1.10196 2.80196e-17 0.636218 2 0
+
+0.826040 -0.145922 0.825966 2 0
+1.01221 -0.142247 0.584398 2 0
+
+0.907107 -0.282843 0.907107 2 0
+1.11097 -0.282843 0.641421 2 0
+
+0.901263 1.60036e-17 0.901226 2 0
+0.826040 0.145922 0.825966 2 0
+0.736027 4.04003e-17 0.735878 2 0
+0.826040 -0.145922 0.825966 2 0
+0.901263 1.60036e-17 0.901226 2 0
+
+1.10196 2.80196e-17 0.636218 2 0
+1.01221 0.142247 0.584398 2 0
+0.901694 3.47321e-17 0.520593 2 0
+1.01221 -0.142247 0.584398 2 0
+1.10196 2.80196e-17 0.636218 2 0
+
+0.901263 1.60036e-17 0.901226 2 0
+1.10196 2.80196e-17 0.636218 2 0
+
+0.826040 0.145922 0.825966 2 0
+1.01221 0.142247 0.584398 2 0
+
+0.736027 4.04003e-17 0.735878 2 0
+0.901694 3.47321e-17 0.520593 2 0
+
+0.826040 -0.145922 0.825966 2 0
+1.01221 -0.142247 0.584398 2 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.