]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Make GridOut::write_gnuplot available for codim=1.
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 3 Nov 2010 11:30:11 +0000 (11:30 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 3 Nov 2010 11:30:11 +0000 (11:30 +0000)
git-svn-id: https://svn.dealii.org/trunk@22595 0785d39b-7218-0410-832d-ea1e28bc413d

deal.II/doc/news/changes.h
deal.II/include/deal.II/grid/grid_out.h
deal.II/source/grid/grid_out.cc
tests/codim_one/grid_in_out_02.cc [new file with mode: 0644]
tests/codim_one/grid_in_out_02/cmp/generic [new file with mode: 0644]

index c6e2146b5811ad594f4add4da9252971c7e23cf0..c24b26546b77506a7e004403c7dc6db3a23cc0fc 100644 (file)
@@ -332,6 +332,13 @@ through DoFHandler::get_tria() and DoFHandler::get_fe(), respectively.
 <h3>deal.II</h3>
 
 <ol>
+  <li><p>New: The GridOut::write_gnuplot function now also works for meshes
+  that are embedded in a higher
+  dimensional space (i.e. if the codimension was greater than 1).
+  <br>
+  (WB, 2010/11/03)
+  </p></li>
+
   <li><p>New: The class hp::FEFaceValues and hp::FESubfaceValues were not
   previously available for meshes that were embedded in a higher
   dimensional space (i.e. if the codimension was greater than 1). This is
index 089c04f0186769a61750f4c7cde043fbc9fafb51..80579eb6255abc033d67e683a173e7ee4cc98344 100644 (file)
@@ -901,10 +901,10 @@ class GridOut
                                      * Not implemented for the
                                      * codimension one case.
                                      */
-    template <int dim>
-    void write_gnuplot (const Triangulation<dim> &tria,
+    template <int dim, int spacedim>
+    void write_gnuplot (const Triangulation<dim,spacedim> &tria,
                        std::ostream           &out,
-                       const Mapping<dim>       *mapping=0) const;
+                       const Mapping<dim,spacedim> *mapping=0) const;
 
                                     /**
                                      * Write the triangulation in the
index 474f14a26f99337c71d902da9079c88b6de08456..e843f634c6aab54b50eb5f643983a13be41b85b4 100644 (file)
@@ -999,16 +999,16 @@ void GridOut::write_ucd_lines (const Triangulation<dim, spacedim> &tria,
 
 #if deal_II_dimension==1
 
-template <int dim>
+template <int dim, int spacedim>
 void GridOut::write_gnuplot (
-  const Triangulation<dim> &tria,
+  const Triangulation<dim,spacedim> &tria,
   std::ostream             &out,
-  const Mapping<dim>       *) const
+  const Mapping<dim,spacedim>       *) const
 {
   AssertThrow (out, ExcIO());
 
-  typename Triangulation<dim>::active_cell_iterator        cell=tria.begin_active();
-  const typename Triangulation<dim>::active_cell_iterator  endc=tria.end();
+  typename Triangulation<dim,spacedim>::active_cell_iterator        cell=tria.begin_active();
+  const typename Triangulation<dim,spacedim>::active_cell_iterator  endc=tria.end();
   for (; cell!=endc; ++cell)
     {
       if (gnuplot_flags.write_cell_numbers)
@@ -1035,11 +1035,11 @@ void GridOut::write_gnuplot (
 
 #if deal_II_dimension==2
 
-template <int dim>
+template <int dim, int spacedim>
 void GridOut::write_gnuplot (
-  const Triangulation<dim> &tria,
+  const Triangulation<dim,spacedim> &tria,
   std::ostream           &out,
-  const Mapping<dim>       *mapping) const
+  const Mapping<dim,spacedim>       *mapping) const
 {
   AssertThrow (out, ExcIO());
 
@@ -1047,8 +1047,8 @@ void GridOut::write_gnuplot (
     gnuplot_flags.n_boundary_face_points;
   const unsigned int n_points=2+n_additional_points;
 
-  typename Triangulation<dim>::active_cell_iterator        cell=tria.begin_active();
-  const typename Triangulation<dim>::active_cell_iterator  endc=tria.end();
+  typename Triangulation<dim,spacedim>::active_cell_iterator        cell=tria.begin_active();
+  const typename Triangulation<dim,spacedim>::active_cell_iterator  endc=tria.end();
 
                                   // if we are to treat curved
                                   // boundaries, then generate a
@@ -1106,7 +1106,7 @@ void GridOut::write_gnuplot (
          for (unsigned int face_no=0;
               face_no<GeometryInfo<dim>::faces_per_cell; ++face_no)
            {
-             const typename Triangulation<dim>::face_iterator
+             const typename Triangulation<dim,spacedim>::face_iterator
                face = cell->face(face_no);
              if (face->at_boundary() || gnuplot_flags.curved_inner_cells)
                {
@@ -1163,10 +1163,10 @@ void GridOut::write_gnuplot (
 
 #if deal_II_dimension==3
 
-template <int dim>
-void GridOut::write_gnuplot (const Triangulation<dim> &tria,
+template <int dim, int spacedim>
+void GridOut::write_gnuplot (const Triangulation<dim,spacedim> &tria,
                             std::ostream           &out,
-                            const Mapping<dim>       *mapping) const
+                            const Mapping<dim,spacedim>       *mapping) const
 {
   AssertThrow (out, ExcIO());
 
@@ -1174,8 +1174,8 @@ void GridOut::write_gnuplot (const Triangulation<dim> &tria,
     gnuplot_flags.n_boundary_face_points;
   const unsigned int n_points=2+n_additional_points;
 
-  typename Triangulation<dim>::active_cell_iterator        cell=tria.begin_active();
-  const typename Triangulation<dim>::active_cell_iterator  endc=tria.end();
+  typename Triangulation<dim,spacedim>::active_cell_iterator        cell=tria.begin_active();
+  const typename Triangulation<dim,spacedim>::active_cell_iterator  endc=tria.end();
 
                                   // if we are to treat curved
                                   // boundaries, then generate a
@@ -1278,7 +1278,7 @@ void GridOut::write_gnuplot (const Triangulation<dim> &tria,
        {
          for (unsigned int face_no=0; face_no<GeometryInfo<dim>::faces_per_cell; ++face_no)
            {
-             const typename Triangulation<dim>::face_iterator
+             const typename Triangulation<dim,spacedim>::face_iterator
                face = cell->face(face_no);
 
              if (face->at_boundary())
@@ -1287,7 +1287,7 @@ void GridOut::write_gnuplot (const Triangulation<dim> &tria,
                  for (unsigned int i=0; i<n_points-1; ++i)
                    for (unsigned int j=0; j<n_points-1; ++j)
                      {
-                       const Point<dim> p0=mapping->transform_unit_to_real_cell(
+                       const Point<spacedim> p0=mapping->transform_unit_to_real_cell(
                          cell, q_projector->point(offset+i*n_points+j));
                        out << p0
                            << ' ' << cell->level()
@@ -1318,11 +1318,11 @@ void GridOut::write_gnuplot (const Triangulation<dim> &tria,
                {
                  for (unsigned int l=0; l<GeometryInfo<dim>::lines_per_face; ++l)
                    {
-                     const typename Triangulation<dim>::line_iterator
+                     const typename Triangulation<dim,spacedim>::line_iterator
                        line=face->line(l);
 
-                     const Point<dim> &v0=line->vertex(0),
-                                      &v1=line->vertex(1);
+                     const Point<spacedim> &v0=line->vertex(0),
+                                           &v1=line->vertex(1);
                      if (line->at_boundary() || gnuplot_flags.curved_inner_cells)
                        {
                                                           // transform_real_to_unit_cell
@@ -1333,8 +1333,8 @@ void GridOut::write_gnuplot (const Triangulation<dim> &tria,
                                                           // which is
                                                           // not yet
                                                           // implemented
-                         const Point<dim> u0=mapping->transform_real_to_unit_cell(cell, v0),
-                                          u1=mapping->transform_real_to_unit_cell(cell, v1);
+                         const Point<spacedim> u0=mapping->transform_real_to_unit_cell(cell, v0),
+                                               u1=mapping->transform_real_to_unit_cell(cell, v1);
 
                          for (unsigned int i=0; i<n_points; ++i)
                            out << (mapping->transform_unit_to_real_cell
@@ -1948,6 +1948,10 @@ template void GridOut::write_msh
 template void GridOut::write_ucd
 (const Triangulation<deal_II_dimension, deal_II_dimension+1> &,
  std::ostream &) const;
+template void GridOut::write_gnuplot
+(const Triangulation<deal_II_dimension,deal_II_dimension+1>&,
+ std::ostream&,
+ const Mapping<deal_II_dimension,deal_II_dimension+1>*) const;
 #endif
 
 DEAL_II_NAMESPACE_CLOSE
diff --git a/tests/codim_one/grid_in_out_02.cc b/tests/codim_one/grid_in_out_02.cc
new file mode 100644 (file)
index 0000000..3283abd
--- /dev/null
@@ -0,0 +1,51 @@
+
+//----------------------------  template.cc  ---------------------------
+//    $Id$
+//    Version: $Name$
+//
+//    Copyright (C) 2005, 2008, 2010 by the deal.II authors
+//
+//    This file is subject to QPL and may not be  distributed
+//    without copyright and license information. Please refer
+//    to the file deal.II/doc/license.html for the  text  and
+//    further information on this license.
+//
+//----------------------------  template.cc  ---------------------------
+
+
+// like grid_in_out but write in gnuplot format
+
+#include "../tests.h"
+#include <fstream>
+#include <base/logstream.h>
+#include <grid/tria.h>
+#include <grid/grid_in.h>
+#include <grid/grid_out.h>
+
+#include <string>
+
+std::ofstream logfile("grid_in_out_02/output");
+
+template <int dim, int spacedim>
+void test(std::string filename) {
+    Triangulation<dim, spacedim> tria;
+    GridIn<dim, spacedim> gi;
+    gi.attach_triangulation (tria);
+    std::ifstream in (filename.c_str());
+    gi.read_ucd (in);
+
+    GridOut grid_out;
+    grid_out.write_gnuplot (tria, logfile);
+}
+
+int main ()
+{
+  deallog.attach(logfile);
+  deallog.depth_console(0);
+
+  test<2,3>("grids/square.inp");
+  test<2,3>("grids/sphere_1.inp");
+
+  return 0;
+}
+
diff --git a/tests/codim_one/grid_in_out_02/cmp/generic b/tests/codim_one/grid_in_out_02/cmp/generic
new file mode 100644 (file)
index 0000000..421ee75
--- /dev/null
@@ -0,0 +1,771 @@
+
+1.00000 1.00000 0.00000 0 0
+0.00000 1.00000 0.00000 0 0
+0.00000 0.00000 0.00000 0 0
+1.00000 0.00000 0.00000 0 0
+1.00000 1.00000 0.00000 0 0
+
+
+2.00000 1.00000 0.00000 0 0
+1.00000 1.00000 0.00000 0 0
+1.00000 0.00000 0.00000 0 0
+2.00000 0.00000 0.00000 0 0
+2.00000 1.00000 0.00000 0 0
+
+
+2.00000 2.00000 0.00000 0 0
+1.00000 2.00000 0.00000 0 0
+1.00000 1.00000 0.00000 0 0
+2.00000 1.00000 0.00000 0 0
+2.00000 2.00000 0.00000 0 0
+
+
+1.00000 2.00000 0.00000 0 0
+0.00000 2.00000 0.00000 0 0
+0.00000 1.00000 0.00000 0 0
+1.00000 1.00000 0.00000 0 0
+1.00000 2.00000 0.00000 0 0
+
+
+0.00178022 0.00931797 0.999955 0 1
+0.342339 0.0465385 0.938423 0 1
+0.263823 0.408120 0.873977 0 1
+-0.0499119 0.322444 0.945272 0 1
+0.00178022 0.00931797 0.999955 0 1
+
+
+0.00178022 0.00931797 0.999955 0 1
+-0.0499119 0.322444 0.945272 0 1
+-0.349880 0.276923 0.894929 0 1
+-0.311977 0.00745462 0.950060 0 1
+0.00178022 0.00931797 0.999955 0 1
+
+
+0.00679510 -0.328843 0.944360 0 1
+0.00178022 0.00931797 0.999955 0 1
+-0.311977 0.00745462 0.950060 0 1
+-0.316292 -0.298937 0.900331 0 1
+0.00679510 -0.328843 0.944360 0 1
+
+
+0.00679510 -0.328843 0.944360 0 1
+0.354845 -0.314540 0.880426 0 1
+0.342339 0.0465385 0.938423 0 1
+0.00178022 0.00931797 0.999955 0 1
+0.00679510 -0.328843 0.944360 0 1
+
+
+0.298350 -0.356878 -0.885226 0 1
+0.00385941 -0.311698 -0.950173 0 1
+0.00349231 0.00461231 -0.999983 0 1
+0.344411 -0.0231948 -0.938532 0 1
+0.298350 -0.356878 -0.885226 0 1
+
+
+-0.289183 -0.332580 -0.897643 0 1
+-0.342360 -0.0100870 -0.939515 0 1
+0.00349231 0.00461231 -0.999983 0 1
+0.00385941 -0.311698 -0.950173 0 1
+-0.289183 -0.332580 -0.897643 0 1
+
+
+-0.366349 0.350743 -0.861840 0 1
+0.00809038 0.366486 -0.930389 0 1
+0.00349231 0.00461231 -0.999983 0 1
+-0.342360 -0.0100870 -0.939515 0 1
+-0.366349 0.350743 -0.861840 0 1
+
+
+0.363753 0.326848 -0.872270 0 1
+0.344411 -0.0231948 -0.938532 0 1
+0.00349231 0.00461231 -0.999983 0 1
+0.00809038 0.366486 -0.930389 0 1
+0.363753 0.326848 -0.872270 0 1
+
+
+-0.581804 -0.238653 0.777527 0 1
+-0.316292 -0.298937 0.900331 0 1
+-0.311977 0.00745462 0.950060 0 1
+-0.518718 -0.0208746 0.854690 0 1
+-0.581804 -0.238653 0.777527 0 1
+
+
+-0.518718 -0.0208746 0.854690 0 1
+-0.311977 0.00745462 0.950060 0 1
+-0.349880 0.276923 0.894929 0 1
+-0.618273 0.185258 0.763818 0 1
+-0.518718 -0.0208746 0.854690 0 1
+
+
+-0.655703 0.470729 0.590312 0 1
+-0.618273 0.185258 0.763818 0 1
+-0.349880 0.276923 0.894929 0 1
+-0.355505 0.548576 0.756757 0 1
+-0.655703 0.470729 0.590312 0 1
+
+
+-0.109474 0.540719 0.834050 0 1
+-0.355505 0.548576 0.756757 0 1
+-0.349880 0.276923 0.894929 0 1
+-0.0499119 0.322444 0.945272 0 1
+-0.109474 0.540719 0.834050 0 1
+
+
+-0.109474 0.540719 0.834050 0 1
+-0.0499119 0.322444 0.945272 0 1
+0.263823 0.408120 0.873977 0 1
+0.0849177 0.689837 0.718967 0 1
+-0.109474 0.540719 0.834050 0 1
+
+
+0.342339 0.0465385 0.938423 0 1
+0.653761 0.0750076 0.752975 0 1
+0.590651 0.458181 0.664230 0 1
+0.263823 0.408120 0.873977 0 1
+0.342339 0.0465385 0.938423 0 1
+
+
+0.354845 -0.314540 0.880426 0 1
+0.647206 -0.264372 0.715005 0 1
+0.653761 0.0750076 0.752975 0 1
+0.342339 0.0465385 0.938423 0 1
+0.354845 -0.314540 0.880426 0 1
+
+
+0.334293 -0.631291 0.699800 0 1
+0.644255 -0.545349 0.536218 0 1
+0.647206 -0.264372 0.715005 0 1
+0.354845 -0.314540 0.880426 0 1
+0.334293 -0.631291 0.699800 0 1
+
+
+-0.0136400 -0.623344 0.781828 0 1
+0.334293 -0.631291 0.699800 0 1
+0.354845 -0.314540 0.880426 0 1
+0.00679510 -0.328843 0.944360 0 1
+-0.0136400 -0.623344 0.781828 0 1
+
+
+-0.0136400 -0.623344 0.781828 0 1
+0.00679510 -0.328843 0.944360 0 1
+-0.316292 -0.298937 0.900331 0 1
+-0.315086 -0.567457 0.760732 0 1
+-0.0136400 -0.623344 0.781828 0 1
+
+
+-0.576157 -0.514159 0.635361 0 1
+-0.315086 -0.567457 0.760732 0 1
+-0.316292 -0.298937 0.900331 0 1
+-0.581804 -0.238653 0.777527 0 1
+-0.576157 -0.514159 0.635361 0 1
+
+
+-0.576157 -0.514159 0.635361 0 1
+-0.581804 -0.238653 0.777527 0 1
+-0.789430 -0.0638458 0.610511 0 1
+-0.815841 -0.391026 0.426030 0 1
+-0.576157 -0.514159 0.635361 0 1
+
+
+-0.683844 0.271870 -0.677085 0 1
+-0.366349 0.350743 -0.861840 0 1
+-0.342360 -0.0100870 -0.939515 0 1
+-0.630568 -0.0635365 -0.773529 0 1
+-0.683844 0.271870 -0.677085 0 1
+
+
+-0.545967 -0.351787 -0.760373 0 1
+-0.630568 -0.0635365 -0.773529 0 1
+-0.342360 -0.0100870 -0.939515 0 1
+-0.289183 -0.332580 -0.897643 0 1
+-0.545967 -0.351787 -0.760373 0 1
+
+
+-0.476920 -0.600556 -0.641779 0 1
+-0.545967 -0.351787 -0.760373 0 1
+-0.289183 -0.332580 -0.897643 0 1
+-0.216924 -0.585305 -0.781257 0 1
+-0.476920 -0.600556 -0.641779 0 1
+
+
+-0.216924 -0.585305 -0.781257 0 1
+-0.289183 -0.332580 -0.897643 0 1
+0.00385941 -0.311698 -0.950173 0 1
+0.00748938 -0.520154 -0.854040 0 1
+-0.216924 -0.585305 -0.781257 0 1
+
+
+0.182410 -0.619455 -0.763546 0 1
+0.00748938 -0.520154 -0.854040 0 1
+0.00385941 -0.311698 -0.950173 0 1
+0.298350 -0.356878 -0.885226 0 1
+0.182410 -0.619455 -0.763546 0 1
+
+
+0.182410 -0.619455 -0.763546 0 1
+0.298350 -0.356878 -0.885226 0 1
+0.587904 -0.398117 -0.704181 0 1
+0.434724 -0.699062 -0.567739 0 1
+0.182410 -0.619455 -0.763546 0 1
+
+
+0.298350 -0.356878 -0.885226 0 1
+0.344411 -0.0231948 -0.938532 0 1
+0.641342 -0.0572571 -0.765115 0 1
+0.587904 -0.398117 -0.704181 0 1
+0.298350 -0.356878 -0.885226 0 1
+
+
+0.363753 0.326848 -0.872270 0 1
+0.646115 0.257731 -0.718408 0 1
+0.641342 -0.0572571 -0.765115 0 1
+0.344411 -0.0231948 -0.938532 0 1
+0.363753 0.326848 -0.872270 0 1
+
+
+0.363753 0.326848 -0.872270 0 1
+0.382789 0.637705 -0.668435 0 1
+0.671849 0.513247 -0.534039 0 1
+0.646115 0.257731 -0.718408 0 1
+0.363753 0.326848 -0.872270 0 1
+
+
+0.363753 0.326848 -0.872270 0 1
+0.00809038 0.366486 -0.930389 0 1
+0.0230305 0.697195 -0.716511 0 1
+0.382789 0.637705 -0.668435 0 1
+0.363753 0.326848 -0.872270 0 1
+
+
+-0.366349 0.350743 -0.861840 0 1
+-0.351416 0.677986 -0.645633 0 1
+0.0230305 0.697195 -0.716511 0 1
+0.00809038 0.366486 -0.930389 0 1
+-0.366349 0.350743 -0.861840 0 1
+
+
+-0.683844 0.271870 -0.677085 0 1
+-0.669229 0.582943 -0.460771 0 1
+-0.351416 0.677986 -0.645633 0 1
+-0.366349 0.350743 -0.861840 0 1
+-0.683844 0.271870 -0.677085 0 1
+
+
+-0.893850 0.128655 -0.429512 0 1
+-0.883097 0.413202 -0.222268 0 1
+-0.669229 0.582943 -0.460771 0 1
+-0.683844 0.271870 -0.677085 0 1
+-0.893850 0.128655 -0.429512 0 1
+
+
+-0.893850 0.128655 -0.429512 0 1
+-0.683844 0.271870 -0.677085 0 1
+-0.630568 -0.0635365 -0.773529 0 1
+-0.816819 -0.157920 -0.554859 0 1
+-0.893850 0.128655 -0.429512 0 1
+
+
+-0.922392 0.225124 0.313866 0 1
+-0.789430 -0.0638458 0.610511 0 1
+-0.618273 0.185258 0.763818 0 1
+-0.655703 0.470729 0.590312 0 1
+-0.922392 0.225124 0.313866 0 1
+
+
+-0.922392 0.225124 0.313866 0 1
+-0.655703 0.470729 0.590312 0 1
+-0.550074 0.753033 0.361053 0 1
+-0.796328 0.599676 0.0790578 0 1
+-0.922392 0.225124 0.313866 0 1
+
+
+-0.655703 0.470729 0.590312 0 1
+-0.355505 0.548576 0.756757 0 1
+-0.227479 0.793528 0.564418 0 1
+-0.550074 0.753033 0.361053 0 1
+-0.655703 0.470729 0.590312 0 1
+
+
+-0.109474 0.540719 0.834050 0 1
+0.0849177 0.689837 0.718967 0 1
+-0.227479 0.793528 0.564418 0 1
+-0.355505 0.548576 0.756757 0 1
+-0.109474 0.540719 0.834050 0 1
+
+
+0.653761 0.0750076 0.752975 0 1
+0.867044 0.0465761 0.496050 0 1
+0.844766 0.377775 0.379020 0 1
+0.590651 0.458181 0.664230 0 1
+0.653761 0.0750076 0.752975 0 1
+
+
+0.647206 -0.264372 0.715005 0 1
+0.818455 -0.202855 0.537571 0 1
+0.867044 0.0465761 0.496050 0 1
+0.653761 0.0750076 0.752975 0 1
+0.647206 -0.264372 0.715005 0 1
+
+
+0.334293 -0.631291 0.699800 0 1
+0.245075 -0.866643 0.434590 0 1
+0.577369 -0.777704 0.248639 0 1
+0.644255 -0.545349 0.536218 0 1
+0.334293 -0.631291 0.699800 0 1
+
+
+-0.0136400 -0.623344 0.781828 0 1
+-0.0762364 -0.830976 0.551060 0 1
+0.245075 -0.866643 0.434590 0 1
+0.334293 -0.631291 0.699800 0 1
+-0.0136400 -0.623344 0.781828 0 1
+
+
+-0.576157 -0.514159 0.635361 0 1
+-0.815841 -0.391026 0.426030 0 1
+-0.698790 -0.680384 0.220839 0 1
+-0.482227 -0.749358 0.453784 0 1
+-0.576157 -0.514159 0.635361 0 1
+
+
+-0.968869 -0.201841 0.143363 0 1
+-0.850655 -0.523067 -0.0527958 0 1
+-0.698790 -0.680384 0.220839 0 1
+-0.815841 -0.391026 0.426030 0 1
+-0.968869 -0.201841 0.143363 0 1
+
+
+-0.968869 -0.201841 0.143363 0 1
+-0.815841 -0.391026 0.426030 0 1
+-0.789430 -0.0638458 0.610511 0 1
+-0.922392 0.225124 0.313866 0 1
+-0.968869 -0.201841 0.143363 0 1
+
+
+-0.708921 -0.356642 -0.608471 0 1
+-0.816819 -0.157920 -0.554859 0 1
+-0.630568 -0.0635365 -0.773529 0 1
+-0.545967 -0.351787 -0.760373 0 1
+-0.708921 -0.356642 -0.608471 0 1
+
+
+-0.706419 -0.531732 -0.467153 0 1
+-0.708921 -0.356642 -0.608471 0 1
+-0.545967 -0.351787 -0.760373 0 1
+-0.476920 -0.600556 -0.641779 0 1
+-0.706419 -0.531732 -0.467153 0 1
+
+
+-0.627703 -0.738044 -0.247548 0 1
+-0.706419 -0.531732 -0.467153 0 1
+-0.476920 -0.600556 -0.641779 0 1
+-0.344524 -0.828036 -0.442335 0 1
+-0.627703 -0.738044 -0.247548 0 1
+
+
+-0.344524 -0.828036 -0.442335 0 1
+-0.476920 -0.600556 -0.641779 0 1
+-0.216924 -0.585305 -0.781257 0 1
+-0.0527458 -0.777682 -0.626442 0 1
+-0.344524 -0.828036 -0.442335 0 1
+
+
+-0.0527458 -0.777682 -0.626442 0 1
+-0.216924 -0.585305 -0.781257 0 1
+0.00748938 -0.520154 -0.854040 0 1
+0.182410 -0.619455 -0.763546 0 1
+-0.0527458 -0.777682 -0.626442 0 1
+
+
+-0.0527458 -0.777682 -0.626442 0 1
+0.182410 -0.619455 -0.763546 0 1
+0.434724 -0.699062 -0.567739 0 1
+0.180294 -0.904820 -0.385740 0 1
+-0.0527458 -0.777682 -0.626442 0 1
+
+
+0.410092 -0.908811 -0.0767257 0 1
+0.180294 -0.904820 -0.385740 0 1
+0.434724 -0.699062 -0.567739 0 1
+0.671511 -0.689556 -0.271267 0 1
+0.410092 -0.908811 -0.0767257 0 1
+
+
+0.671511 -0.689556 -0.271267 0 1
+0.434724 -0.699062 -0.567739 0 1
+0.587904 -0.398117 -0.704181 0 1
+0.820909 -0.378965 -0.427193 0 1
+0.671511 -0.689556 -0.271267 0 1
+
+
+0.820909 -0.378965 -0.427193 0 1
+0.587904 -0.398117 -0.704181 0 1
+0.641342 -0.0572571 -0.765115 0 1
+0.850590 -0.0521153 -0.523241 0 1
+0.820909 -0.378965 -0.427193 0 1
+
+
+0.810912 0.188820 -0.553867 0 1
+0.850590 -0.0521153 -0.523241 0 1
+0.641342 -0.0572571 -0.765115 0 1
+0.646115 0.257731 -0.718408 0 1
+0.810912 0.188820 -0.553867 0 1
+
+
+0.810912 0.188820 -0.553867 0 1
+0.646115 0.257731 -0.718408 0 1
+0.671849 0.513247 -0.534039 0 1
+0.863023 0.343845 -0.370084 0 1
+0.810912 0.188820 -0.553867 0 1
+
+
+0.850430 0.515922 -0.102922 0 1
+0.863023 0.343845 -0.370084 0 1
+0.671849 0.513247 -0.534039 0 1
+0.655782 0.705401 -0.268995 0 1
+0.850430 0.515922 -0.102922 0 1
+
+
+0.385544 0.848621 -0.362213 0 1
+0.655782 0.705401 -0.268995 0 1
+0.671849 0.513247 -0.534039 0 1
+0.382789 0.637705 -0.668435 0 1
+0.385544 0.848621 -0.362213 0 1
+
+
+0.385544 0.848621 -0.362213 0 1
+0.382789 0.637705 -0.668435 0 1
+0.0230305 0.697195 -0.716511 0 1
+0.0439654 0.916174 -0.398361 0 1
+0.385544 0.848621 -0.362213 0 1
+
+
+-0.796328 0.599676 0.0790578 0 1
+-0.570342 0.803635 -0.169944 0 1
+-0.669229 0.582943 -0.460771 0 1
+-0.883097 0.413202 -0.222268 0 1
+-0.796328 0.599676 0.0790578 0 1
+
+
+-0.984277 -0.0519672 -0.168814 0 1
+-0.977511 0.209292 -0.0258734 0 1
+-0.883097 0.413202 -0.222268 0 1
+-0.893850 0.128655 -0.429512 0 1
+-0.984277 -0.0519672 -0.168814 0 1
+
+
+-0.627703 -0.738044 -0.247548 0 1
+-0.850655 -0.523067 -0.0527958 0 1
+-0.886983 -0.329962 -0.323088 0 1
+-0.706419 -0.531732 -0.467153 0 1
+-0.627703 -0.738044 -0.247548 0 1
+
+
+-0.627703 -0.738044 -0.247548 0 1
+-0.461518 -0.886803 0.0241058 0 1
+-0.698790 -0.680384 0.220839 0 1
+-0.850655 -0.523067 -0.0527958 0 1
+-0.627703 -0.738044 -0.247548 0 1
+
+
+-0.796328 0.599676 0.0790578 0 1
+-0.550074 0.753033 0.361053 0 1
+-0.371668 0.922819 0.101334 0 1
+-0.570342 0.803635 -0.169944 0 1
+-0.796328 0.599676 0.0790578 0 1
+
+
+0.384841 0.827678 0.408468 0 1
+0.590651 0.458181 0.664230 0 1
+0.844766 0.377775 0.379020 0 1
+0.725490 0.663670 0.182225 0 1
+0.384841 0.827678 0.408468 0 1
+
+
+0.850430 0.515922 -0.102922 0 1
+0.725490 0.663670 0.182225 0 1
+0.844766 0.377775 0.379020 0 1
+0.969530 0.235677 0.0668435 0 1
+0.850430 0.515922 -0.102922 0 1
+
+
+0.972392 -0.0935506 0.213780 0 1
+0.969530 0.235677 0.0668435 0 1
+0.844766 0.377775 0.379020 0 1
+0.867044 0.0465761 0.496050 0 1
+0.972392 -0.0935506 0.213780 0 1
+
+
+0.859439 -0.375019 0.347455 0 1
+0.972392 -0.0935506 0.213780 0 1
+0.867044 0.0465761 0.496050 0 1
+0.818455 -0.202855 0.537571 0 1
+0.859439 -0.375019 0.347455 0 1
+
+
+0.644255 -0.545349 0.536218 0 1
+0.577369 -0.777704 0.248639 0 1
+0.823247 -0.564669 0.0584194 0 1
+0.859439 -0.375019 0.347455 0 1
+0.644255 -0.545349 0.536218 0 1
+
+
+-0.249654 -0.920049 0.301963 0 1
+0.0699297 -0.989322 0.127877 0 1
+0.245075 -0.866643 0.434590 0 1
+-0.0762364 -0.830976 0.551060 0 1
+-0.249654 -0.920049 0.301963 0 1
+
+
+-0.249654 -0.920049 0.301963 0 1
+-0.482227 -0.749358 0.453784 0 1
+-0.698790 -0.680384 0.220839 0 1
+-0.461518 -0.886803 0.0241058 0 1
+-0.249654 -0.920049 0.301963 0 1
+
+
+-0.968869 -0.201841 0.143363 0 1
+-0.984277 -0.0519672 -0.168814 0 1
+-0.886983 -0.329962 -0.323088 0 1
+-0.850655 -0.523067 -0.0527958 0 1
+-0.968869 -0.201841 0.143363 0 1
+
+
+-0.249654 -0.920049 0.301963 0 1
+-0.461518 -0.886803 0.0241058 0 1
+-0.143988 -0.972315 -0.184038 0 1
+0.0699297 -0.989322 0.127877 0 1
+-0.249654 -0.920049 0.301963 0 1
+
+
+0.671511 -0.689556 -0.271267 0 1
+0.820909 -0.378965 -0.427193 0 1
+0.959996 -0.259541 -0.105098 0 1
+0.823247 -0.564669 0.0584194 0 1
+0.671511 -0.689556 -0.271267 0 1
+
+
+0.820909 -0.378965 -0.427193 0 1
+0.850590 -0.0521153 -0.523241 0 1
+0.966797 0.0718926 -0.245223 0 1
+0.959996 -0.259541 -0.105098 0 1
+0.820909 -0.378965 -0.427193 0 1
+
+
+0.850430 0.515922 -0.102922 0 1
+0.969530 0.235677 0.0668435 0 1
+0.966797 0.0718926 -0.245223 0 1
+0.863023 0.343845 -0.370084 0 1
+0.850430 0.515922 -0.102922 0 1
+
+
+0.410092 -0.908811 -0.0767257 0 1
+0.671511 -0.689556 -0.271267 0 1
+0.823247 -0.564669 0.0584194 0 1
+0.577369 -0.777704 0.248639 0 1
+0.410092 -0.908811 -0.0767257 0 1
+
+
+-0.968869 -0.201841 0.143363 0 1
+-0.922392 0.225124 0.313866 0 1
+-0.977511 0.209292 -0.0258734 0 1
+-0.984277 -0.0519672 -0.168814 0 1
+-0.968869 -0.201841 0.143363 0 1
+
+
+0.859439 -0.375019 0.347455 0 1
+0.823247 -0.564669 0.0584194 0 1
+0.959996 -0.259541 -0.105098 0 1
+0.972392 -0.0935506 0.213780 0 1
+0.859439 -0.375019 0.347455 0 1
+
+
+0.972392 -0.0935506 0.213780 0 1
+0.959996 -0.259541 -0.105098 0 1
+0.966797 0.0718926 -0.245223 0 1
+0.969530 0.235677 0.0668435 0 1
+0.972392 -0.0935506 0.213780 0 1
+
+
+0.850430 0.515922 -0.102922 0 1
+0.655782 0.705401 -0.268995 0 1
+0.605130 0.795338 -0.0354306 0 1
+0.725490 0.663670 0.182225 0 1
+0.850430 0.515922 -0.102922 0 1
+
+
+0.385544 0.848621 -0.362213 0 1
+0.368054 0.929539 -0.0222340 0 1
+0.605130 0.795338 -0.0354306 0 1
+0.655782 0.705401 -0.268995 0 1
+0.385544 0.848621 -0.362213 0 1
+
+
+0.385544 0.848621 -0.362213 0 1
+0.0439654 0.916174 -0.398361 0 1
+0.0453701 0.996779 -0.0661311 0 1
+0.368054 0.929539 -0.0222340 0 1
+0.385544 0.848621 -0.362213 0 1
+
+
+0.384841 0.827678 0.408468 0 1
+0.368054 0.929539 -0.0222340 0 1
+0.0453701 0.996779 -0.0661311 0 1
+-0.0526868 0.960179 0.274372 0 1
+0.384841 0.827678 0.408468 0 1
+
+
+0.384841 0.827678 0.408468 0 1
+0.725490 0.663670 0.182225 0 1
+0.605130 0.795338 -0.0354306 0 1
+0.368054 0.929539 -0.0222340 0 1
+0.384841 0.827678 0.408468 0 1
+
+
+0.644255 -0.545349 0.536218 0 1
+0.859439 -0.375019 0.347455 0 1
+0.818455 -0.202855 0.537571 0 1
+0.647206 -0.264372 0.715005 0 1
+0.644255 -0.545349 0.536218 0 1
+
+
+0.0699297 -0.989322 0.127877 0 1
+0.410092 -0.908811 -0.0767257 0 1
+0.577369 -0.777704 0.248639 0 1
+0.245075 -0.866643 0.434590 0 1
+0.0699297 -0.989322 0.127877 0 1
+
+
+0.0699297 -0.989322 0.127877 0 1
+-0.143988 -0.972315 -0.184038 0 1
+0.180294 -0.904820 -0.385740 0 1
+0.410092 -0.908811 -0.0767257 0 1
+0.0699297 -0.989322 0.127877 0 1
+
+
+-0.0136400 -0.623344 0.781828 0 1
+-0.315086 -0.567457 0.760732 0 1
+-0.299076 -0.738598 0.604174 0 1
+-0.0762364 -0.830976 0.551060 0 1
+-0.0136400 -0.623344 0.781828 0 1
+
+
+-0.576157 -0.514159 0.635361 0 1
+-0.482227 -0.749358 0.453784 0 1
+-0.299076 -0.738598 0.604174 0 1
+-0.315086 -0.567457 0.760732 0 1
+-0.576157 -0.514159 0.635361 0 1
+
+
+-0.344524 -0.828036 -0.442335 0 1
+-0.0527458 -0.777682 -0.626442 0 1
+0.180294 -0.904820 -0.385740 0 1
+-0.143988 -0.972315 -0.184038 0 1
+-0.344524 -0.828036 -0.442335 0 1
+
+
+-0.290124 0.889598 -0.352767 0 1
+0.0439654 0.916174 -0.398361 0 1
+0.0230305 0.697195 -0.716511 0 1
+-0.351416 0.677986 -0.645633 0 1
+-0.290124 0.889598 -0.352767 0 1
+
+
+-0.570342 0.803635 -0.169944 0 1
+-0.290124 0.889598 -0.352767 0 1
+-0.351416 0.677986 -0.645633 0 1
+-0.669229 0.582943 -0.460771 0 1
+-0.570342 0.803635 -0.169944 0 1
+
+
+-0.290124 0.889598 -0.352767 0 1
+-0.213036 0.970861 -0.109750 0 1
+0.0453701 0.996779 -0.0661311 0 1
+0.0439654 0.916174 -0.398361 0 1
+-0.290124 0.889598 -0.352767 0 1
+
+
+-0.371668 0.922819 0.101334 0 1
+-0.0526868 0.960179 0.274372 0 1
+0.0453701 0.996779 -0.0661311 0 1
+-0.213036 0.970861 -0.109750 0 1
+-0.371668 0.922819 0.101334 0 1
+
+
+-0.627703 -0.738044 -0.247548 0 1
+-0.344524 -0.828036 -0.442335 0 1
+-0.143988 -0.972315 -0.184038 0 1
+-0.461518 -0.886803 0.0241058 0 1
+-0.627703 -0.738044 -0.247548 0 1
+
+
+-0.249654 -0.920049 0.301963 0 1
+-0.0762364 -0.830976 0.551060 0 1
+-0.299076 -0.738598 0.604174 0 1
+-0.482227 -0.749358 0.453784 0 1
+-0.249654 -0.920049 0.301963 0 1
+
+
+0.810912 0.188820 -0.553867 0 1
+0.863023 0.343845 -0.370084 0 1
+0.966797 0.0718926 -0.245223 0 1
+0.850590 -0.0521153 -0.523241 0 1
+0.810912 0.188820 -0.553867 0 1
+
+
+-0.550074 0.753033 0.361053 0 1
+-0.227479 0.793528 0.564418 0 1
+-0.0526868 0.960179 0.274372 0 1
+-0.371668 0.922819 0.101334 0 1
+-0.550074 0.753033 0.361053 0 1
+
+
+-0.984277 -0.0519672 -0.168814 0 1
+-0.893850 0.128655 -0.429512 0 1
+-0.816819 -0.157920 -0.554859 0 1
+-0.886983 -0.329962 -0.323088 0 1
+-0.984277 -0.0519672 -0.168814 0 1
+
+
+-0.706419 -0.531732 -0.467153 0 1
+-0.886983 -0.329962 -0.323088 0 1
+-0.816819 -0.157920 -0.554859 0 1
+-0.708921 -0.356642 -0.608471 0 1
+-0.706419 -0.531732 -0.467153 0 1
+
+
+-0.581804 -0.238653 0.777527 0 1
+-0.518718 -0.0208746 0.854690 0 1
+-0.618273 0.185258 0.763818 0 1
+-0.789430 -0.0638458 0.610511 0 1
+-0.581804 -0.238653 0.777527 0 1
+
+
+-0.570342 0.803635 -0.169944 0 1
+-0.371668 0.922819 0.101334 0 1
+-0.213036 0.970861 -0.109750 0 1
+-0.290124 0.889598 -0.352767 0 1
+-0.570342 0.803635 -0.169944 0 1
+
+
+-0.922392 0.225124 0.313866 0 1
+-0.796328 0.599676 0.0790578 0 1
+-0.883097 0.413202 -0.222268 0 1
+-0.977511 0.209292 -0.0258734 0 1
+-0.922392 0.225124 0.313866 0 1
+
+
+0.0849177 0.689837 0.718967 0 1
+0.384841 0.827678 0.408468 0 1
+-0.0526868 0.960179 0.274372 0 1
+-0.227479 0.793528 0.564418 0 1
+0.0849177 0.689837 0.718967 0 1
+
+
+0.0849177 0.689837 0.718967 0 1
+0.263823 0.408120 0.873977 0 1
+0.590651 0.458181 0.664230 0 1
+0.384841 0.827678 0.408468 0 1
+0.0849177 0.689837 0.718967 0 1
+
+

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

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.