]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Add a test. 4991/head
authorWolfgang Bangerth <bangerth@colostate.edu>
Wed, 30 Aug 2017 17:15:03 +0000 (11:15 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Thu, 31 Aug 2017 00:45:54 +0000 (18:45 -0600)
tests/numerics/data_out_postprocessor_vector_03.cc [new file with mode: 0644]
tests/numerics/data_out_postprocessor_vector_03.output [new file with mode: 0644]

diff --git a/tests/numerics/data_out_postprocessor_vector_03.cc b/tests/numerics/data_out_postprocessor_vector_03.cc
new file mode 100644 (file)
index 0000000..aff1949
--- /dev/null
@@ -0,0 +1,349 @@
+/* ---------------------------------------------------------------------
+ *
+ * Copyright (C) 2000 - 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.
+ *
+ * ---------------------------------------------------------------------
+ */
+
+
+// a slightly modified version of step-6 that tests the postprocessor
+// discussed in the documentation of DataPostprocessorVector
+
+
+#include "../tests.h"
+#include <deal.II/base/quadrature_lib.h>
+#include <deal.II/base/function.h>
+#include <deal.II/base/logstream.h>
+#include <deal.II/lac/vector.h>
+#include <deal.II/lac/full_matrix.h>
+#include <deal.II/lac/sparse_matrix.h>
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
+#include <deal.II/lac/solver_cg.h>
+#include <deal.II/lac/precondition.h>
+#include <deal.II/grid/tria.h>
+#include <deal.II/dofs/dof_handler.h>
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/tria_accessor.h>
+#include <deal.II/grid/tria_iterator.h>
+#include <deal.II/grid/manifold_lib.h>
+#include <deal.II/dofs/dof_accessor.h>
+#include <deal.II/dofs/dof_tools.h>
+#include <deal.II/fe/fe_values.h>
+#include <deal.II/numerics/vector_tools.h>
+#include <deal.II/numerics/matrix_tools.h>
+#include <deal.II/numerics/data_out.h>
+
+#include <fstream>
+#include <iostream>
+
+#include <deal.II/fe/fe_q.h>
+#include <deal.II/grid/grid_out.h>
+
+
+#include <deal.II/lac/constraint_matrix.h>
+
+#include <deal.II/grid/grid_refinement.h>
+
+#include <deal.II/numerics/error_estimator.h>
+
+using namespace dealii;
+
+
+
+template <int dim>
+class Step6
+{
+public:
+  Step6 ();
+  ~Step6 ();
+
+  void run ();
+
+private:
+  void setup_system ();
+  void assemble_system ();
+  void solve ();
+  void refine_grid ();
+  void output_results (const unsigned int cycle) const;
+
+  Triangulation<dim>   triangulation;
+
+  DoFHandler<dim>      dof_handler;
+  FE_Q<dim>            fe;
+
+  ConstraintMatrix     constraints;
+
+  SparsityPattern      sparsity_pattern;
+  SparseMatrix<double> system_matrix;
+
+  Vector<double>       solution;
+  Vector<double>       system_rhs;
+};
+
+
+
+template <int dim>
+double coefficient (const Point<dim> &p)
+{
+  if (p.square() < 0.5*0.5)
+    return 20;
+  else
+    return 1;
+}
+
+
+
+
+
+template <int dim>
+Step6<dim>::Step6 ()
+  :
+  dof_handler (triangulation),
+  fe (2)
+{}
+
+
+
+template <int dim>
+Step6<dim>::~Step6 ()
+{
+  dof_handler.clear ();
+}
+
+
+
+template <int dim>
+void Step6<dim>::setup_system ()
+{
+  dof_handler.distribute_dofs (fe);
+
+  solution.reinit (dof_handler.n_dofs());
+  system_rhs.reinit (dof_handler.n_dofs());
+
+
+  constraints.clear ();
+  DoFTools::make_hanging_node_constraints (dof_handler,
+                                           constraints);
+
+
+  VectorTools::interpolate_boundary_values (dof_handler,
+                                            0,
+                                            ZeroFunction<dim>(),
+                                            constraints);
+
+
+  constraints.close ();
+
+  DynamicSparsityPattern dsp(dof_handler.n_dofs());
+  DoFTools::make_sparsity_pattern(dof_handler,
+                                  dsp,
+                                  constraints,
+                                  /*keep_constrained_dofs = */ false);
+
+  sparsity_pattern.copy_from(dsp);
+
+  system_matrix.reinit (sparsity_pattern);
+}
+
+
+
+template <int dim>
+void Step6<dim>::assemble_system ()
+{
+  const QGauss<dim>  quadrature_formula(3);
+
+  FEValues<dim> fe_values (fe, quadrature_formula,
+                           update_values    |  update_gradients |
+                           update_quadrature_points  |  update_JxW_values);
+
+  const unsigned int   dofs_per_cell = fe.dofs_per_cell;
+  const unsigned int   n_q_points    = quadrature_formula.size();
+
+  FullMatrix<double>   cell_matrix (dofs_per_cell, dofs_per_cell);
+  Vector<double>       cell_rhs (dofs_per_cell);
+
+  std::vector<types::global_dof_index> local_dof_indices (dofs_per_cell);
+
+  typename DoFHandler<dim>::active_cell_iterator
+  cell = dof_handler.begin_active(),
+  endc = dof_handler.end();
+  for (; cell!=endc; ++cell)
+    {
+      cell_matrix = 0;
+      cell_rhs = 0;
+
+      fe_values.reinit (cell);
+
+      for (unsigned int q_index=0; q_index<n_q_points; ++q_index)
+        {
+          const double current_coefficient = coefficient<dim>
+                                             (fe_values.quadrature_point (q_index));
+          for (unsigned int i=0; i<dofs_per_cell; ++i)
+            {
+              for (unsigned int j=0; j<dofs_per_cell; ++j)
+                cell_matrix(i,j) += (current_coefficient *
+                                     fe_values.shape_grad(i,q_index) *
+                                     fe_values.shape_grad(j,q_index) *
+                                     fe_values.JxW(q_index));
+
+              cell_rhs(i) += (fe_values.shape_value(i,q_index) *
+                              1.0 *
+                              fe_values.JxW(q_index));
+            }
+        }
+
+      cell->get_dof_indices (local_dof_indices);
+      constraints.distribute_local_to_global (cell_matrix,
+                                              cell_rhs,
+                                              local_dof_indices,
+                                              system_matrix,
+                                              system_rhs);
+    }
+}
+
+
+
+
+template <int dim>
+void Step6<dim>::solve ()
+{
+  SolverControl      solver_control (1000, 1e-12);
+  SolverCG<>         solver (solver_control);
+
+  PreconditionSSOR<> preconditioner;
+  preconditioner.initialize(system_matrix, 1.2);
+
+  solver.solve (system_matrix, solution, system_rhs,
+                preconditioner);
+
+  constraints.distribute (solution);
+}
+
+
+
+template <int dim>
+void Step6<dim>::refine_grid ()
+{
+  Vector<float> estimated_error_per_cell (triangulation.n_active_cells());
+
+  KellyErrorEstimator<dim>::estimate (dof_handler,
+                                      QGauss<dim-1>(3),
+                                      typename FunctionMap<dim>::type(),
+                                      solution,
+                                      estimated_error_per_cell);
+
+  GridRefinement::refine_and_coarsen_fixed_number (triangulation,
+                                                   estimated_error_per_cell,
+                                                   0.3, 0.03);
+
+  triangulation.execute_coarsening_and_refinement ();
+}
+
+
+template <int dim>
+class HeatFluxPostprocessor : public DataPostprocessorVector<dim>
+{
+public:
+  HeatFluxPostprocessor ()
+    :
+    // like above, but now also make sure that DataOut provides
+    // us with coordinates of the evaluation points:
+    DataPostprocessorVector<dim> ("heatflux",
+                                  update_gradients | update_quadrature_points)
+  {}
+
+  virtual
+  void
+  evaluate_scalar_field (const DataPostprocessorInputs::Scalar<dim> &input_data,
+                         std::vector<Vector<double> >               &computed_quantities) const
+  {
+    AssertDimension (input_data.solution_gradients.size(),
+                     computed_quantities.size());
+
+    for (unsigned int p=0; p<input_data.solution_gradients.size(); ++p)
+      {
+        AssertDimension (computed_quantities[p].size(), dim);
+        for (unsigned int d=0; d<dim; ++d)
+          // like above, but also multiply the gradients with
+          // the coefficient evaluated at the current point:
+          computed_quantities[p][d]
+            = coefficient (input_data.evaluation_points[p]) *
+              input_data.solution_gradients[p][d];
+      }
+  }
+};
+
+
+
+template <int dim>
+void Step6<dim>::output_results (const unsigned int cycle) const
+{
+}
+
+
+
+template <int dim>
+void Step6<dim>::run ()
+{
+  for (unsigned int cycle=0; cycle<4; ++cycle)
+    {
+      deallog << "Cycle " << cycle << ':' << std::endl;
+
+      if (cycle == 0)
+        {
+          GridGenerator::hyper_ball (triangulation);
+
+          static const SphericalManifold<dim> boundary;
+          triangulation.set_all_manifold_ids_on_boundary(0);
+          triangulation.set_manifold (0, boundary);
+
+          triangulation.refine_global (1);
+        }
+      else
+        refine_grid ();
+
+
+      deallog << "   Number of active cells:       "
+              << triangulation.n_active_cells()
+              << std::endl;
+
+      setup_system ();
+
+      deallog << "   Number of degrees of freedom: "
+              << dof_handler.n_dofs()
+              << std::endl;
+
+      assemble_system ();
+      solve ();
+    }
+
+  HeatFluxPostprocessor<dim> heatflux_postprocessor;
+
+  DataOut<dim> data_out;
+
+  data_out.attach_dof_handler (dof_handler);
+  data_out.add_data_vector (solution, "solution");
+  data_out.add_data_vector (solution, heatflux_postprocessor);
+  data_out.build_patches ();
+
+  data_out.write_gnuplot (deallog.get_file_stream());
+}
+
+
+
+int main ()
+{
+  initlog ();
+
+  Step6<2> laplace_problem_2d;
+  laplace_problem_2d.run ();
+}
diff --git a/tests/numerics/data_out_postprocessor_vector_03.output b/tests/numerics/data_out_postprocessor_vector_03.output
new file mode 100644 (file)
index 0000000..09e73b8
--- /dev/null
@@ -0,0 +1,1428 @@
+
+DEAL::Cycle 0:
+DEAL::   Number of active cells:       20
+DEAL::   Number of degrees of freedom: 89
+DEAL:cg::Starting value 0.351647
+DEAL:cg::Convergence step 22 value 3.77522e-13
+DEAL::Cycle 1:
+DEAL::   Number of active cells:       44
+DEAL::   Number of degrees of freedom: 209
+DEAL:cg::Starting value 0.271387
+DEAL:cg::Convergence step 30 value 5.55301e-13
+DEAL::Cycle 2:
+DEAL::   Number of active cells:       92
+DEAL::   Number of degrees of freedom: 449
+DEAL:cg::Starting value 0.203851
+DEAL:cg::Convergence step 51 value 3.79839e-13
+DEAL::Cycle 3:
+DEAL::   Number of active cells:       200
+DEAL::   Number of degrees of freedom: 921
+DEAL:cg::Starting value 0.151971
+DEAL:cg::Convergence step 71 value 7.39437e-13
+# This file was generated by the deal.II library.
+
+
+#
+# For a description of the GNUPLOT format see the GNUPLOT manual.
+#
+# <x> <y> <solution> <heatflux> <heatflux> 
+-0.707107 -0.707107 0.00000 0.230380 0.344788 
+-0.382683 -0.923880 0.00000 0.250300 0.374600 
+
+-0.603553 -0.603553 0.0628253 0.309697 0.328525 
+-0.316342 -0.748551 0.0807873 0.175941 0.385671 
+
+
+-0.603553 -0.603553 0.0628253 0.298951 0.307239 
+-0.316342 -0.748551 0.0807873 0.167122 0.368202 
+
+-0.500000 -0.500000 0.121074 0.259530 0.259277 
+-0.250000 -0.573223 0.147874 0.115760 0.290032 
+
+
+0.382683 -0.923880 0.00000 -0.250300 0.374600 
+0.707107 -0.707107 0.00000 -0.230380 0.344788 
+
+0.316342 -0.748551 0.0807873 -0.175941 0.385671 
+0.603553 -0.603553 0.0628253 -0.309697 0.328525 
+
+
+0.316342 -0.748551 0.0807873 -0.167122 0.368202 
+0.603553 -0.603553 0.0628253 -0.298951 0.307239 
+
+0.250000 -0.573223 0.147874 -0.115760 0.290032 
+0.500000 -0.500000 0.121074 -0.259530 0.259277 
+
+
+-0.707107 -0.707107 0.00000 0.344788 0.230380 
+-0.603553 -0.603553 0.0628253 0.328525 0.309697 
+
+-0.923880 -0.382683 0.00000 0.374600 0.250300 
+-0.748551 -0.316342 0.0807873 0.385671 0.175941 
+
+
+-0.603553 -0.603553 0.0628253 0.307239 0.298951 
+-0.500000 -0.500000 0.121074 0.259277 0.259530 
+
+-0.748551 -0.316342 0.0807873 0.368202 0.167122 
+-0.573223 -0.250000 0.147874 0.290032 0.115760 
+
+
+-0.923880 0.382683 0.00000 0.374600 -0.250300 
+-0.748551 0.316342 0.0807873 0.385671 -0.175941 
+
+-0.707107 0.707107 0.00000 0.344788 -0.230380 
+-0.603553 0.603553 0.0628253 0.328525 -0.309697 
+
+
+-0.748551 0.316342 0.0807873 0.368202 -0.167122 
+-0.573223 0.250000 0.147874 0.290032 -0.115760 
+
+-0.603553 0.603553 0.0628253 0.307239 -0.298951 
+-0.500000 0.500000 0.121074 0.259277 -0.259530 
+
+
+0.707107 -0.707107 0.00000 -0.344788 0.230380 
+0.923880 -0.382683 0.00000 -0.374600 0.250300 
+
+0.603553 -0.603553 0.0628253 -0.328525 0.309697 
+0.748551 -0.316342 0.0807873 -0.385671 0.175941 
+
+
+0.603553 -0.603553 0.0628253 -0.307239 0.298951 
+0.748551 -0.316342 0.0807873 -0.368202 0.167122 
+
+0.500000 -0.500000 0.121074 -0.259277 0.259530 
+0.573223 -0.250000 0.147874 -0.290032 0.115760 
+
+
+0.923880 0.382683 0.00000 -0.374600 -0.250300 
+0.707107 0.707107 0.00000 -0.344788 -0.230380 
+
+0.748551 0.316342 0.0807873 -0.385671 -0.175941 
+0.603553 0.603553 0.0628253 -0.328525 -0.309697 
+
+
+0.748551 0.316342 0.0807873 -0.368202 -0.167122 
+0.603553 0.603553 0.0628253 -0.307239 -0.298951 
+
+0.573223 0.250000 0.147874 -0.290032 -0.115760 
+0.500000 0.500000 0.121074 -0.259277 -0.259530 
+
+
+-0.707107 0.707107 0.00000 0.230380 -0.344788 
+-0.603553 0.603553 0.0628253 0.309697 -0.328525 
+
+-0.382683 0.923880 0.00000 0.250300 -0.374600 
+-0.316342 0.748551 0.0807873 0.175941 -0.385671 
+
+
+-0.603553 0.603553 0.0628253 0.298951 -0.307239 
+-0.500000 0.500000 0.121074 0.259530 -0.259277 
+
+-0.316342 0.748551 0.0807873 0.167122 -0.368202 
+-0.250000 0.573223 0.147874 0.115760 -0.290032 
+
+
+0.382683 0.923880 0.00000 -0.250300 -0.374600 
+0.316342 0.748551 0.0807873 -0.175941 -0.385671 
+
+0.707107 0.707107 0.00000 -0.230380 -0.344788 
+0.603553 0.603553 0.0628253 -0.309697 -0.328525 
+
+
+0.316342 0.748551 0.0807873 -0.167122 -0.368202 
+0.250000 0.573223 0.147874 -0.115760 -0.290032 
+
+0.603553 0.603553 0.0628253 -0.298951 -0.307239 
+0.500000 0.500000 0.121074 -0.259530 -0.259277 
+
+
+-0.198223 -0.433058 0.182000 0.138362 0.197735 
+0.00000 -0.469670 0.182165 -0.0254081 0.233991 
+
+-0.146447 -0.292893 0.183490 0.0837403 0.145367 
+0.00000 -0.292893 0.183789 -0.00208730 0.133504 
+
+
+0.00000 -0.469670 0.182165 0.0254081 0.233991 
+0.198223 -0.433058 0.182000 -0.138362 0.197735 
+
+0.00000 -0.292893 0.183789 0.00208730 0.133504 
+0.146447 -0.292893 0.183490 -0.0837403 0.145367 
+
+
+-0.433058 -0.198223 0.182000 0.197735 0.138362 
+-0.292893 -0.146447 0.183490 0.145367 0.0837403 
+
+-0.469670 0.00000 0.182165 0.233991 -0.0254081 
+-0.292893 0.00000 0.183789 0.133504 -0.00208730 
+
+
+-0.469670 0.00000 0.182165 0.233991 0.0254081 
+-0.292893 0.00000 0.183789 0.133504 0.00208730 
+
+-0.433058 0.198223 0.182000 0.197735 -0.138362 
+-0.292893 0.146447 0.183490 0.145367 -0.0837403 
+
+
+0.433058 -0.198223 0.182000 -0.197735 0.138362 
+0.469670 0.00000 0.182165 -0.233991 -0.0254081 
+
+0.292893 -0.146447 0.183490 -0.145367 0.0837403 
+0.292893 0.00000 0.183789 -0.133504 -0.00208730 
+
+
+0.469670 0.00000 0.182165 -0.233991 0.0254081 
+0.433058 0.198223 0.182000 -0.197735 -0.138362 
+
+0.292893 0.00000 0.183789 -0.133504 0.00208730 
+0.292893 0.146447 0.183490 -0.145367 -0.0837403 
+
+
+-0.198223 0.433058 0.182000 0.138362 -0.197735 
+-0.146447 0.292893 0.183490 0.0837403 -0.145367 
+
+0.00000 0.469670 0.182165 -0.0254081 -0.233991 
+0.00000 0.292893 0.183789 -0.00208730 -0.133504 
+
+
+0.00000 0.469670 0.182165 0.0254081 -0.233991 
+0.00000 0.292893 0.183789 0.00208730 -0.133504 
+
+0.198223 0.433058 0.182000 -0.138362 -0.197735 
+0.146447 0.292893 0.183490 -0.0837403 -0.145367 
+
+
+-0.292893 -0.292893 0.182593 0.160265 0.160265 
+-0.146447 -0.292893 0.183490 0.0846397 0.144937 
+
+-0.292893 -0.146447 0.183490 0.144937 0.0846397 
+-0.146447 -0.146447 0.184298 0.0756805 0.0756805 
+
+
+-0.146447 -0.292893 0.183490 0.0837403 0.144937 
+0.00000 -0.292893 0.183789 -0.00208730 0.141841 
+
+-0.146447 -0.146447 0.184298 0.0752678 0.0756805 
+0.00000 -0.146447 0.184573 4.06684e-05 0.0724325 
+
+
+-0.292893 -0.146447 0.183490 0.144937 0.0837403 
+-0.146447 -0.146447 0.184298 0.0756805 0.0752678 
+
+-0.292893 0.00000 0.183789 0.141841 -0.00208730 
+-0.146447 0.00000 0.184573 0.0724325 4.06684e-05 
+
+
+-0.146447 -0.146447 0.184298 0.0752678 0.0752678 
+0.00000 -0.146447 0.184573 4.06684e-05 0.0727171 
+
+-0.146447 0.00000 0.184573 0.0727171 4.06684e-05 
+0.00000 0.00000 0.184840 0.000121528 0.000121528 
+
+
+0.00000 -0.292893 0.183789 0.00208730 0.141841 
+0.146447 -0.292893 0.183490 -0.0837403 0.144937 
+
+0.00000 -0.146447 0.184573 -4.06684e-05 0.0724325 
+0.146447 -0.146447 0.184298 -0.0752678 0.0756805 
+
+
+0.146447 -0.292893 0.183490 -0.0846397 0.144937 
+0.292893 -0.292893 0.182593 -0.160265 0.160265 
+
+0.146447 -0.146447 0.184298 -0.0756805 0.0756805 
+0.292893 -0.146447 0.183490 -0.144937 0.0846397 
+
+
+0.00000 -0.146447 0.184573 -4.06684e-05 0.0727171 
+0.146447 -0.146447 0.184298 -0.0752678 0.0752678 
+
+0.00000 0.00000 0.184840 -0.000121528 0.000121528 
+0.146447 0.00000 0.184573 -0.0727171 4.06684e-05 
+
+
+0.146447 -0.146447 0.184298 -0.0756805 0.0752678 
+0.292893 -0.146447 0.183490 -0.144937 0.0837403 
+
+0.146447 0.00000 0.184573 -0.0724325 4.06684e-05 
+0.292893 0.00000 0.183789 -0.141841 -0.00208730 
+
+
+-0.292893 0.00000 0.183789 0.141841 0.00208730 
+-0.146447 0.00000 0.184573 0.0724325 -4.06684e-05 
+
+-0.292893 0.146447 0.183490 0.144937 -0.0837403 
+-0.146447 0.146447 0.184298 0.0756805 -0.0752678 
+
+
+-0.146447 0.00000 0.184573 0.0727171 -4.06684e-05 
+0.00000 0.00000 0.184840 0.000121528 -0.000121528 
+
+-0.146447 0.146447 0.184298 0.0752678 -0.0752678 
+0.00000 0.146447 0.184573 4.06684e-05 -0.0727171 
+
+
+-0.292893 0.146447 0.183490 0.144937 -0.0846397 
+-0.146447 0.146447 0.184298 0.0756805 -0.0756805 
+
+-0.292893 0.292893 0.182593 0.160265 -0.160265 
+-0.146447 0.292893 0.183490 0.0846397 -0.144937 
+
+
+-0.146447 0.146447 0.184298 0.0752678 -0.0756805 
+0.00000 0.146447 0.184573 4.06684e-05 -0.0724325 
+
+-0.146447 0.292893 0.183490 0.0837403 -0.144937 
+0.00000 0.292893 0.183789 -0.00208730 -0.141841 
+
+
+0.00000 0.00000 0.184840 -0.000121528 -0.000121528 
+0.146447 0.00000 0.184573 -0.0727171 -4.06684e-05 
+
+0.00000 0.146447 0.184573 -4.06684e-05 -0.0727171 
+0.146447 0.146447 0.184298 -0.0752678 -0.0752678 
+
+
+0.146447 0.00000 0.184573 -0.0724325 -4.06684e-05 
+0.292893 0.00000 0.183789 -0.141841 0.00208730 
+
+0.146447 0.146447 0.184298 -0.0756805 -0.0752678 
+0.292893 0.146447 0.183490 -0.144937 -0.0837403 
+
+
+0.00000 0.146447 0.184573 -4.06684e-05 -0.0724325 
+0.146447 0.146447 0.184298 -0.0752678 -0.0756805 
+
+0.00000 0.292893 0.183789 0.00208730 -0.141841 
+0.146447 0.292893 0.183490 -0.0837403 -0.144937 
+
+
+0.146447 0.146447 0.184298 -0.0756805 -0.0756805 
+0.292893 0.146447 0.183490 -0.144937 -0.0846397 
+
+0.146447 0.292893 0.183490 -0.0846397 -0.144937 
+0.292893 0.292893 0.182593 -0.160265 -0.160265 
+
+
+-0.316342 -0.748551 0.0807873 0.161288 0.370409 
+-0.158171 -0.785887 0.0858254 0.0803874 0.383550 
+
+-0.283171 -0.660887 0.116470 0.141157 0.329225 
+-0.141585 -0.697861 0.118961 0.0690865 0.341136 
+
+
+-0.158171 -0.785887 0.0858254 0.0785652 0.383893 
+0.00000 -0.823223 0.0773822 0.000206243 0.402098 
+
+-0.141585 -0.697861 0.118961 0.0694878 0.341060 
+0.00000 -0.734835 0.110971 0.000181550 0.357922 
+
+
+-0.283171 -0.660887 0.116470 0.141157 0.329225 
+-0.141585 -0.697861 0.118961 0.0690693 0.341070 
+
+-0.250000 -0.573223 0.147874 0.115576 0.290102 
+-0.125000 -0.609835 0.148002 0.0578028 0.294863 
+
+
+-0.141585 -0.697861 0.118961 0.0694707 0.340995 
+0.00000 -0.734835 0.110971 0.000164196 0.357856 
+
+-0.125000 -0.609835 0.148002 0.0588028 0.294675 
+0.00000 -0.646447 0.140583 0.000230514 0.312186 
+
+
+0.00000 -0.823223 0.0773822 -0.000206243 0.402098 
+0.158171 -0.785887 0.0858254 -0.0785652 0.383893 
+
+0.00000 -0.734835 0.110971 -0.000181550 0.357922 
+0.141585 -0.697861 0.118961 -0.0694878 0.341060 
+
+
+0.158171 -0.785887 0.0858254 -0.0803874 0.383550 
+0.316342 -0.748551 0.0807873 -0.161288 0.370409 
+
+0.141585 -0.697861 0.118961 -0.0690865 0.341136 
+0.283171 -0.660887 0.116470 -0.141157 0.329225 
+
+
+0.00000 -0.734835 0.110971 -0.000164196 0.357856 
+0.141585 -0.697861 0.118961 -0.0694707 0.340995 
+
+0.00000 -0.646447 0.140583 -0.000230514 0.312186 
+0.125000 -0.609835 0.148002 -0.0588028 0.294675 
+
+
+0.141585 -0.697861 0.118961 -0.0690693 0.341070 
+0.283171 -0.660887 0.116470 -0.141157 0.329225 
+
+0.125000 -0.609835 0.148002 -0.0578028 0.294863 
+0.250000 -0.573223 0.147874 -0.115576 0.290102 
+
+
+-0.748551 -0.316342 0.0807873 0.370409 0.161288 
+-0.660887 -0.283171 0.116470 0.329225 0.141157 
+
+-0.785887 -0.158171 0.0858254 0.383550 0.0803874 
+-0.697861 -0.141585 0.118961 0.341136 0.0690865 
+
+
+-0.660887 -0.283171 0.116470 0.329225 0.141157 
+-0.573223 -0.250000 0.147874 0.290102 0.115576 
+
+-0.697861 -0.141585 0.118961 0.341070 0.0690693 
+-0.609835 -0.125000 0.148002 0.294863 0.0578028 
+
+
+-0.785887 -0.158171 0.0858254 0.383893 0.0785652 
+-0.697861 -0.141585 0.118961 0.341060 0.0694878 
+
+-0.823223 0.00000 0.0773822 0.402098 0.000206243 
+-0.734835 0.00000 0.110971 0.357922 0.000181550 
+
+
+-0.697861 -0.141585 0.118961 0.340995 0.0694707 
+-0.609835 -0.125000 0.148002 0.294675 0.0588028 
+
+-0.734835 0.00000 0.110971 0.357856 0.000164196 
+-0.646447 0.00000 0.140583 0.312186 0.000230514 
+
+
+-0.823223 0.00000 0.0773822 0.402098 -0.000206243 
+-0.734835 0.00000 0.110971 0.357922 -0.000181550 
+
+-0.785887 0.158171 0.0858254 0.383893 -0.0785652 
+-0.697861 0.141585 0.118961 0.341060 -0.0694878 
+
+
+-0.734835 0.00000 0.110971 0.357856 -0.000164196 
+-0.646447 0.00000 0.140583 0.312186 -0.000230514 
+
+-0.697861 0.141585 0.118961 0.340995 -0.0694707 
+-0.609835 0.125000 0.148002 0.294675 -0.0588028 
+
+
+-0.785887 0.158171 0.0858254 0.383550 -0.0803874 
+-0.697861 0.141585 0.118961 0.341136 -0.0690865 
+
+-0.748551 0.316342 0.0807873 0.370409 -0.161288 
+-0.660887 0.283171 0.116470 0.329225 -0.141157 
+
+
+-0.697861 0.141585 0.118961 0.341070 -0.0690693 
+-0.609835 0.125000 0.148002 0.294863 -0.0578028 
+
+-0.660887 0.283171 0.116470 0.329225 -0.141157 
+-0.573223 0.250000 0.147874 0.290102 -0.115576 
+
+
+0.748551 -0.316342 0.0807873 -0.370409 0.161288 
+0.785887 -0.158171 0.0858254 -0.383550 0.0803874 
+
+0.660887 -0.283171 0.116470 -0.329225 0.141157 
+0.697861 -0.141585 0.118961 -0.341136 0.0690865 
+
+
+0.785887 -0.158171 0.0858254 -0.383893 0.0785652 
+0.823223 0.00000 0.0773822 -0.402098 0.000206243 
+
+0.697861 -0.141585 0.118961 -0.341060 0.0694878 
+0.734835 0.00000 0.110971 -0.357922 0.000181550 
+
+
+0.660887 -0.283171 0.116470 -0.329225 0.141157 
+0.697861 -0.141585 0.118961 -0.341070 0.0690693 
+
+0.573223 -0.250000 0.147874 -0.290102 0.115576 
+0.609835 -0.125000 0.148002 -0.294863 0.0578028 
+
+
+0.697861 -0.141585 0.118961 -0.340995 0.0694707 
+0.734835 0.00000 0.110971 -0.357856 0.000164196 
+
+0.609835 -0.125000 0.148002 -0.294675 0.0588028 
+0.646447 0.00000 0.140583 -0.312186 0.000230514 
+
+
+0.823223 0.00000 0.0773822 -0.402098 -0.000206243 
+0.785887 0.158171 0.0858254 -0.383893 -0.0785652 
+
+0.734835 0.00000 0.110971 -0.357922 -0.000181550 
+0.697861 0.141585 0.118961 -0.341060 -0.0694878 
+
+
+0.785887 0.158171 0.0858254 -0.383550 -0.0803874 
+0.748551 0.316342 0.0807873 -0.370409 -0.161288 
+
+0.697861 0.141585 0.118961 -0.341136 -0.0690865 
+0.660887 0.283171 0.116470 -0.329225 -0.141157 
+
+
+0.734835 0.00000 0.110971 -0.357856 -0.000164196 
+0.697861 0.141585 0.118961 -0.340995 -0.0694707 
+
+0.646447 0.00000 0.140583 -0.312186 -0.000230514 
+0.609835 0.125000 0.148002 -0.294675 -0.0588028 
+
+
+0.697861 0.141585 0.118961 -0.341070 -0.0690693 
+0.660887 0.283171 0.116470 -0.329225 -0.141157 
+
+0.609835 0.125000 0.148002 -0.294863 -0.0578028 
+0.573223 0.250000 0.147874 -0.290102 -0.115576 
+
+
+-0.316342 0.748551 0.0807873 0.161288 -0.370409 
+-0.283171 0.660887 0.116470 0.141157 -0.329225 
+
+-0.158171 0.785887 0.0858254 0.0803874 -0.383550 
+-0.141585 0.697861 0.118961 0.0690865 -0.341136 
+
+
+-0.283171 0.660887 0.116470 0.141157 -0.329225 
+-0.250000 0.573223 0.147874 0.115576 -0.290102 
+
+-0.141585 0.697861 0.118961 0.0690693 -0.341070 
+-0.125000 0.609835 0.148002 0.0578028 -0.294863 
+
+
+-0.158171 0.785887 0.0858254 0.0785652 -0.383893 
+-0.141585 0.697861 0.118961 0.0694878 -0.341060 
+
+0.00000 0.823223 0.0773822 0.000206243 -0.402098 
+0.00000 0.734835 0.110971 0.000181550 -0.357922 
+
+
+-0.141585 0.697861 0.118961 0.0694707 -0.340995 
+-0.125000 0.609835 0.148002 0.0588028 -0.294675 
+
+0.00000 0.734835 0.110971 0.000164196 -0.357856 
+0.00000 0.646447 0.140583 0.000230514 -0.312186 
+
+
+0.00000 0.823223 0.0773822 -0.000206243 -0.402098 
+0.00000 0.734835 0.110971 -0.000181550 -0.357922 
+
+0.158171 0.785887 0.0858254 -0.0785652 -0.383893 
+0.141585 0.697861 0.118961 -0.0694878 -0.341060 
+
+
+0.00000 0.734835 0.110971 -0.000164196 -0.357856 
+0.00000 0.646447 0.140583 -0.000230514 -0.312186 
+
+0.141585 0.697861 0.118961 -0.0694707 -0.340995 
+0.125000 0.609835 0.148002 -0.0588028 -0.294675 
+
+
+0.158171 0.785887 0.0858254 -0.0803874 -0.383550 
+0.141585 0.697861 0.118961 -0.0690865 -0.341136 
+
+0.316342 0.748551 0.0807873 -0.161288 -0.370409 
+0.283171 0.660887 0.116470 -0.141157 -0.329225 
+
+
+0.141585 0.697861 0.118961 -0.0690693 -0.341070 
+0.125000 0.609835 0.148002 -0.0578028 -0.294863 
+
+0.283171 0.660887 0.116470 -0.141157 -0.329225 
+0.250000 0.573223 0.147874 -0.115576 -0.290102 
+
+
+-0.382683 -0.923880 0.00000 0.127705 0.420988 
+-0.195090 -0.980785 0.00000 0.131125 0.432261 
+
+-0.349513 -0.836215 0.0407676 0.180986 0.392295 
+-0.176631 -0.883336 0.0445538 0.0897473 0.440301 
+
+
+-0.195090 -0.980785 0.00000 0.0441959 0.448728 
+0.00000 -1.00000 0.00000 0.0440006 0.446746 
+
+-0.176631 -0.883336 0.0445538 0.0874744 0.440732 
+0.00000 -0.911612 0.0399268 0.00379613 0.456696 
+
+
+-0.349513 -0.836215 0.0407676 0.180986 0.392295 
+-0.176631 -0.883336 0.0445538 0.0868388 0.429630 
+
+-0.316342 -0.748551 0.0807873 0.165797 0.389510 
+-0.158171 -0.785887 0.0858254 0.0808807 0.385640 
+
+
+-0.176631 -0.883336 0.0445538 0.0857308 0.429840 
+0.00000 -0.911612 0.0399268 0.00182585 0.444388 
+
+-0.158171 -0.785887 0.0858254 0.0790590 0.385985 
+0.00000 -0.823223 0.0773822 0.000450003 0.403131 
+
+
+0.00000 -1.00000 0.00000 -0.0440006 0.446746 
+0.195090 -0.980785 0.00000 -0.0441959 0.448728 
+
+0.00000 -0.911612 0.0399268 -0.00379613 0.456696 
+0.176631 -0.883336 0.0445538 -0.0874744 0.440732 
+
+
+0.195090 -0.980785 0.00000 -0.131125 0.432261 
+0.382683 -0.923880 0.00000 -0.127705 0.420988 
+
+0.176631 -0.883336 0.0445538 -0.0897473 0.440301 
+0.349513 -0.836215 0.0407676 -0.180986 0.392295 
+
+
+0.00000 -0.911612 0.0399268 -0.00182585 0.444388 
+0.176631 -0.883336 0.0445538 -0.0857308 0.429840 
+
+0.00000 -0.823223 0.0773822 -0.000450003 0.403131 
+0.158171 -0.785887 0.0858254 -0.0790590 0.385985 
+
+
+0.176631 -0.883336 0.0445538 -0.0868388 0.429630 
+0.349513 -0.836215 0.0407676 -0.180986 0.392295 
+
+0.158171 -0.785887 0.0858254 -0.0808807 0.385640 
+0.316342 -0.748551 0.0807873 -0.165797 0.389510 
+
+
+-0.923880 -0.382683 0.00000 0.420988 0.127705 
+-0.836215 -0.349513 0.0407676 0.392295 0.180986 
+
+-0.980785 -0.195090 0.00000 0.432261 0.131125 
+-0.883336 -0.176631 0.0445538 0.440301 0.0897473 
+
+
+-0.836215 -0.349513 0.0407676 0.392295 0.180986 
+-0.748551 -0.316342 0.0807873 0.389510 0.165797 
+
+-0.883336 -0.176631 0.0445538 0.429630 0.0868388 
+-0.785887 -0.158171 0.0858254 0.385640 0.0808807 
+
+
+-0.980785 -0.195090 0.00000 0.448728 0.0441959 
+-0.883336 -0.176631 0.0445538 0.440732 0.0874744 
+
+-1.00000 0.00000 0.00000 0.446746 0.0440006 
+-0.911612 0.00000 0.0399268 0.456696 0.00379613 
+
+
+-0.883336 -0.176631 0.0445538 0.429840 0.0857308 
+-0.785887 -0.158171 0.0858254 0.385985 0.0790590 
+
+-0.911612 0.00000 0.0399268 0.444388 0.00182585 
+-0.823223 0.00000 0.0773822 0.403131 0.000450003 
+
+
+-1.00000 0.00000 0.00000 0.446746 -0.0440006 
+-0.911612 0.00000 0.0399268 0.456696 -0.00379613 
+
+-0.980785 0.195090 0.00000 0.448728 -0.0441959 
+-0.883336 0.176631 0.0445538 0.440732 -0.0874744 
+
+
+-0.911612 0.00000 0.0399268 0.444388 -0.00182585 
+-0.823223 0.00000 0.0773822 0.403131 -0.000450003 
+
+-0.883336 0.176631 0.0445538 0.429840 -0.0857308 
+-0.785887 0.158171 0.0858254 0.385985 -0.0790590 
+
+
+-0.980785 0.195090 0.00000 0.432261 -0.131125 
+-0.883336 0.176631 0.0445538 0.440301 -0.0897473 
+
+-0.923880 0.382683 0.00000 0.420988 -0.127705 
+-0.836215 0.349513 0.0407676 0.392295 -0.180986 
+
+
+-0.883336 0.176631 0.0445538 0.429630 -0.0868388 
+-0.785887 0.158171 0.0858254 0.385640 -0.0808807 
+
+-0.836215 0.349513 0.0407676 0.392295 -0.180986 
+-0.748551 0.316342 0.0807873 0.389510 -0.165797 
+
+
+0.923880 -0.382683 0.00000 -0.420988 0.127705 
+0.980785 -0.195090 0.00000 -0.432261 0.131125 
+
+0.836215 -0.349513 0.0407676 -0.392295 0.180986 
+0.883336 -0.176631 0.0445538 -0.440301 0.0897473 
+
+
+0.980785 -0.195090 0.00000 -0.448728 0.0441959 
+1.00000 0.00000 0.00000 -0.446746 0.0440006 
+
+0.883336 -0.176631 0.0445538 -0.440732 0.0874744 
+0.911612 0.00000 0.0399268 -0.456696 0.00379613 
+
+
+0.836215 -0.349513 0.0407676 -0.392295 0.180986 
+0.883336 -0.176631 0.0445538 -0.429630 0.0868388 
+
+0.748551 -0.316342 0.0807873 -0.389510 0.165797 
+0.785887 -0.158171 0.0858254 -0.385640 0.0808807 
+
+
+0.883336 -0.176631 0.0445538 -0.429840 0.0857308 
+0.911612 0.00000 0.0399268 -0.444388 0.00182585 
+
+0.785887 -0.158171 0.0858254 -0.385985 0.0790590 
+0.823223 0.00000 0.0773822 -0.403131 0.000450003 
+
+
+1.00000 0.00000 0.00000 -0.446746 -0.0440006 
+0.980785 0.195090 0.00000 -0.448728 -0.0441959 
+
+0.911612 0.00000 0.0399268 -0.456696 -0.00379613 
+0.883336 0.176631 0.0445538 -0.440732 -0.0874744 
+
+
+0.980785 0.195090 0.00000 -0.432261 -0.131125 
+0.923880 0.382683 0.00000 -0.420988 -0.127705 
+
+0.883336 0.176631 0.0445538 -0.440301 -0.0897473 
+0.836215 0.349513 0.0407676 -0.392295 -0.180986 
+
+
+0.911612 0.00000 0.0399268 -0.444388 -0.00182585 
+0.883336 0.176631 0.0445538 -0.429840 -0.0857308 
+
+0.823223 0.00000 0.0773822 -0.403131 -0.000450003 
+0.785887 0.158171 0.0858254 -0.385985 -0.0790590 
+
+
+0.883336 0.176631 0.0445538 -0.429630 -0.0868388 
+0.836215 0.349513 0.0407676 -0.392295 -0.180986 
+
+0.785887 0.158171 0.0858254 -0.385640 -0.0808807 
+0.748551 0.316342 0.0807873 -0.389510 -0.165797 
+
+
+-0.382683 0.923880 0.00000 0.127705 -0.420988 
+-0.349513 0.836215 0.0407676 0.180986 -0.392295 
+
+-0.195090 0.980785 0.00000 0.131125 -0.432261 
+-0.176631 0.883336 0.0445538 0.0897473 -0.440301 
+
+
+-0.349513 0.836215 0.0407676 0.180986 -0.392295 
+-0.316342 0.748551 0.0807873 0.165797 -0.389510 
+
+-0.176631 0.883336 0.0445538 0.0868388 -0.429630 
+-0.158171 0.785887 0.0858254 0.0808807 -0.385640 
+
+
+-0.195090 0.980785 0.00000 0.0441959 -0.448728 
+-0.176631 0.883336 0.0445538 0.0874744 -0.440732 
+
+0.00000 1.00000 0.00000 0.0440006 -0.446746 
+0.00000 0.911612 0.0399268 0.00379613 -0.456696 
+
+
+-0.176631 0.883336 0.0445538 0.0857308 -0.429840 
+-0.158171 0.785887 0.0858254 0.0790590 -0.385985 
+
+0.00000 0.911612 0.0399268 0.00182585 -0.444388 
+0.00000 0.823223 0.0773822 0.000450003 -0.403131 
+
+
+0.00000 1.00000 0.00000 -0.0440006 -0.446746 
+0.00000 0.911612 0.0399268 -0.00379613 -0.456696 
+
+0.195090 0.980785 0.00000 -0.0441959 -0.448728 
+0.176631 0.883336 0.0445538 -0.0874744 -0.440732 
+
+
+0.00000 0.911612 0.0399268 -0.00182585 -0.444388 
+0.00000 0.823223 0.0773822 -0.000450003 -0.403131 
+
+0.176631 0.883336 0.0445538 -0.0857308 -0.429840 
+0.158171 0.785887 0.0858254 -0.0790590 -0.385985 
+
+
+0.195090 0.980785 0.00000 -0.131125 -0.432261 
+0.176631 0.883336 0.0445538 -0.0897473 -0.440301 
+
+0.382683 0.923880 0.00000 -0.127705 -0.420988 
+0.349513 0.836215 0.0407676 -0.180986 -0.392295 
+
+
+0.176631 0.883336 0.0445538 -0.0868388 -0.429630 
+0.158171 0.785887 0.0858254 -0.0808807 -0.385640 
+
+0.349513 0.836215 0.0407676 -0.180986 -0.392295 
+0.316342 0.748551 0.0807873 -0.165797 -0.389510 
+
+
+-0.500000 -0.500000 0.121074 0.258947 0.257283 
+-0.375000 -0.536612 0.139248 0.189363 0.280518 
+
+-0.448223 -0.448223 0.146641 0.238084 0.233277 
+-0.336167 -0.475682 0.162551 0.166216 0.257774 
+
+
+-0.375000 -0.536612 0.139248 0.189363 0.280518 
+-0.250000 -0.573223 0.147874 0.115229 0.288220 
+
+-0.336167 -0.475682 0.162551 0.163787 0.259322 
+-0.224112 -0.503141 0.169702 0.0907658 0.258617 
+
+
+-0.448223 -0.448223 0.146641 0.238845 0.236382 
+-0.336167 -0.475682 0.162551 0.172379 0.282926 
+
+-0.396447 -0.396447 0.169668 0.268014 0.146240 
+-0.297335 -0.414752 0.181595 0.0381037 0.208044 
+
+
+-0.336167 -0.475682 0.162551 0.169951 0.284474 
+-0.224112 -0.503141 0.169702 0.108788 0.332163 
+
+-0.297335 -0.414752 0.181595 0.0374570 0.208456 
+-0.198223 -0.433058 0.182000 0.0983969 -0.464420 
+
+
+-0.250000 -0.573223 0.147874 0.115045 0.288288 
+-0.125000 -0.609835 0.148002 0.0580885 0.295839 
+
+-0.224112 -0.503141 0.169702 0.0823903 0.261711 
+-0.112056 -0.530600 0.170119 0.0491786 0.244888 
+
+
+-0.125000 -0.609835 0.148002 0.0590956 0.295674 
+0.00000 -0.646447 0.140583 0.000477679 0.313030 
+
+-0.112056 -0.530600 0.170119 0.0568755 0.243630 
+0.00000 -0.558058 0.166041 -0.00551155 0.263018 
+
+
+-0.224112 -0.503141 0.169702 0.100412 0.335257 
+-0.112056 -0.530600 0.170119 0.0683767 0.323232 
+
+-0.198223 -0.433058 0.182000 0.0213216 -0.435948 
+-0.0991117 -0.451364 0.182294 -0.0810377 -0.528671 
+
+
+-0.112056 -0.530600 0.170119 0.0760735 0.321975 
+0.00000 -0.558058 0.166041 0.0263887 0.393199 
+
+-0.0991117 -0.451364 0.182294 -0.0810377 -0.528671 
+0.00000 -0.469670 0.182165 -0.173361 -0.567056 
+
+
+-0.396447 -0.396447 0.169668 0.284290 0.234365 
+-0.297335 -0.414752 0.181595 0.00162004 0.0105130 
+
+-0.344670 -0.344670 0.181844 -0.0675999 -0.899403 
+-0.258502 -0.353823 0.182346 0.218099 0.122600 
+
+
+-0.297335 -0.414752 0.181595 0.000973260 0.0109252 
+-0.198223 -0.433058 0.182000 0.215438 0.169264 
+
+-0.258502 -0.353823 0.182346 0.145468 0.168890 
+-0.172335 -0.362976 0.182808 0.105741 0.173513 
+
+
+-0.344670 -0.344670 0.181844 0.0447653 0.158427 
+-0.258502 -0.353823 0.182346 0.219131 0.132316 
+
+-0.292893 -0.292893 0.182593 0.160265 0.215532 
+-0.219670 -0.292893 0.183111 0.122452 0.152223 
+
+
+-0.258502 -0.353823 0.182346 0.146500 0.178607 
+-0.172335 -0.362976 0.182808 0.105741 0.173513 
+
+-0.219670 -0.292893 0.183111 0.122452 0.152223 
+-0.146447 -0.292893 0.183490 0.0846397 0.145035 
+
+
+0.00000 -0.646447 0.140583 -0.000477679 0.313030 
+0.125000 -0.609835 0.148002 -0.0590956 0.295674 
+
+0.00000 -0.558058 0.166041 0.00551155 0.263018 
+0.112056 -0.530600 0.170119 -0.0568755 0.243630 
+
+
+0.125000 -0.609835 0.148002 -0.0580885 0.295839 
+0.250000 -0.573223 0.147874 -0.115045 0.288288 
+
+0.112056 -0.530600 0.170119 -0.0491786 0.244888 
+0.224112 -0.503141 0.169702 -0.0823903 0.261711 
+
+
+0.00000 -0.558058 0.166041 -0.0263887 0.393199 
+0.112056 -0.530600 0.170119 -0.0760735 0.321975 
+
+0.00000 -0.469670 0.182165 0.173361 -0.567056 
+0.0991117 -0.451364 0.182294 0.0810377 -0.528671 
+
+
+0.112056 -0.530600 0.170119 -0.0683767 0.323232 
+0.224112 -0.503141 0.169702 -0.100412 0.335257 
+
+0.0991117 -0.451364 0.182294 0.0810377 -0.528671 
+0.198223 -0.433058 0.182000 -0.0213216 -0.435948 
+
+
+0.250000 -0.573223 0.147874 -0.115229 0.288220 
+0.375000 -0.536612 0.139248 -0.189363 0.280518 
+
+0.224112 -0.503141 0.169702 -0.0907658 0.258617 
+0.336167 -0.475682 0.162551 -0.163787 0.259322 
+
+
+0.375000 -0.536612 0.139248 -0.189363 0.280518 
+0.500000 -0.500000 0.121074 -0.258947 0.257283 
+
+0.336167 -0.475682 0.162551 -0.166216 0.257774 
+0.448223 -0.448223 0.146641 -0.238084 0.233277 
+
+
+0.224112 -0.503141 0.169702 -0.108788 0.332163 
+0.336167 -0.475682 0.162551 -0.169951 0.284474 
+
+0.198223 -0.433058 0.182000 -0.0983969 -0.464420 
+0.297335 -0.414752 0.181595 -0.0374570 0.208456 
+
+
+0.336167 -0.475682 0.162551 -0.172379 0.282926 
+0.448223 -0.448223 0.146641 -0.238845 0.236382 
+
+0.297335 -0.414752 0.181595 -0.0381037 0.208044 
+0.396447 -0.396447 0.169668 -0.268014 0.146240 
+
+
+0.198223 -0.433058 0.182000 -0.215438 0.169264 
+0.297335 -0.414752 0.181595 -0.000973260 0.0109252 
+
+0.172335 -0.362976 0.182808 -0.105741 0.173513 
+0.258502 -0.353823 0.182346 -0.145468 0.168890 
+
+
+0.297335 -0.414752 0.181595 -0.00162004 0.0105130 
+0.396447 -0.396447 0.169668 -0.284290 0.234365 
+
+0.258502 -0.353823 0.182346 -0.218099 0.122600 
+0.344670 -0.344670 0.181844 0.0675999 -0.899403 
+
+
+0.172335 -0.362976 0.182808 -0.105741 0.173513 
+0.258502 -0.353823 0.182346 -0.146500 0.178607 
+
+0.146447 -0.292893 0.183490 -0.0846397 0.145035 
+0.219670 -0.292893 0.183111 -0.122452 0.152223 
+
+
+0.258502 -0.353823 0.182346 -0.219131 0.132316 
+0.344670 -0.344670 0.181844 -0.0447653 0.158427 
+
+0.219670 -0.292893 0.183111 -0.122452 0.152223 
+0.292893 -0.292893 0.182593 -0.160265 0.215532 
+
+
+-0.500000 -0.500000 0.121074 0.257283 0.258947 
+-0.448223 -0.448223 0.146641 0.233277 0.238084 
+
+-0.536612 -0.375000 0.139248 0.280518 0.189363 
+-0.475682 -0.336167 0.162551 0.257774 0.166216 
+
+
+-0.448223 -0.448223 0.146641 0.236382 0.238845 
+-0.396447 -0.396447 0.169668 0.146240 0.268014 
+
+-0.475682 -0.336167 0.162551 0.282926 0.172379 
+-0.414752 -0.297335 0.181595 0.208044 0.0381037 
+
+
+-0.536612 -0.375000 0.139248 0.280518 0.189363 
+-0.475682 -0.336167 0.162551 0.259322 0.163787 
+
+-0.573223 -0.250000 0.147874 0.288220 0.115229 
+-0.503141 -0.224112 0.169702 0.258617 0.0907658 
+
+
+-0.475682 -0.336167 0.162551 0.284474 0.169951 
+-0.414752 -0.297335 0.181595 0.208456 0.0374570 
+
+-0.503141 -0.224112 0.169702 0.332163 0.108788 
+-0.433058 -0.198223 0.182000 -0.464420 0.0983969 
+
+
+-0.396447 -0.396447 0.169668 0.234365 0.284290 
+-0.344670 -0.344670 0.181844 -0.899403 -0.0675999 
+
+-0.414752 -0.297335 0.181595 0.0105130 0.00162004 
+-0.353823 -0.258502 0.182346 0.122600 0.218099 
+
+
+-0.344670 -0.344670 0.181844 0.158427 0.0447653 
+-0.292893 -0.292893 0.182593 0.215532 0.160265 
+
+-0.353823 -0.258502 0.182346 0.132316 0.219131 
+-0.292893 -0.219670 0.183111 0.152223 0.122452 
+
+
+-0.414752 -0.297335 0.181595 0.0109252 0.000973260 
+-0.353823 -0.258502 0.182346 0.168890 0.145468 
+
+-0.433058 -0.198223 0.182000 0.169264 0.215438 
+-0.362976 -0.172335 0.182808 0.173513 0.105741 
+
+
+-0.353823 -0.258502 0.182346 0.178607 0.146500 
+-0.292893 -0.219670 0.183111 0.152223 0.122452 
+
+-0.362976 -0.172335 0.182808 0.173513 0.105741 
+-0.292893 -0.146447 0.183490 0.145035 0.0846397 
+
+
+-0.573223 -0.250000 0.147874 0.288288 0.115045 
+-0.503141 -0.224112 0.169702 0.261711 0.0823903 
+
+-0.609835 -0.125000 0.148002 0.295839 0.0580885 
+-0.530600 -0.112056 0.170119 0.244888 0.0491786 
+
+
+-0.503141 -0.224112 0.169702 0.335257 0.100412 
+-0.433058 -0.198223 0.182000 -0.435948 0.0213216 
+
+-0.530600 -0.112056 0.170119 0.323232 0.0683767 
+-0.451364 -0.0991117 0.182294 -0.528671 -0.0810377 
+
+
+-0.609835 -0.125000 0.148002 0.295674 0.0590956 
+-0.530600 -0.112056 0.170119 0.243630 0.0568755 
+
+-0.646447 0.00000 0.140583 0.313030 0.000477679 
+-0.558058 0.00000 0.166041 0.263018 -0.00551155 
+
+
+-0.530600 -0.112056 0.170119 0.321975 0.0760735 
+-0.451364 -0.0991117 0.182294 -0.528671 -0.0810377 
+
+-0.558058 0.00000 0.166041 0.393199 0.0263887 
+-0.469670 0.00000 0.182165 -0.567056 -0.173361 
+
+
+-0.646447 0.00000 0.140583 0.313030 -0.000477679 
+-0.558058 0.00000 0.166041 0.263018 0.00551155 
+
+-0.609835 0.125000 0.148002 0.295674 -0.0590956 
+-0.530600 0.112056 0.170119 0.243630 -0.0568755 
+
+
+-0.558058 0.00000 0.166041 0.393199 -0.0263887 
+-0.469670 0.00000 0.182165 -0.567056 0.173361 
+
+-0.530600 0.112056 0.170119 0.321975 -0.0760735 
+-0.451364 0.0991117 0.182294 -0.528671 0.0810377 
+
+
+-0.609835 0.125000 0.148002 0.295839 -0.0580885 
+-0.530600 0.112056 0.170119 0.244888 -0.0491786 
+
+-0.573223 0.250000 0.147874 0.288288 -0.115045 
+-0.503141 0.224112 0.169702 0.261711 -0.0823903 
+
+
+-0.530600 0.112056 0.170119 0.323232 -0.0683767 
+-0.451364 0.0991117 0.182294 -0.528671 0.0810377 
+
+-0.503141 0.224112 0.169702 0.335257 -0.100412 
+-0.433058 0.198223 0.182000 -0.435948 -0.0213216 
+
+
+-0.573223 0.250000 0.147874 0.288220 -0.115229 
+-0.503141 0.224112 0.169702 0.258617 -0.0907658 
+
+-0.536612 0.375000 0.139248 0.280518 -0.189363 
+-0.475682 0.336167 0.162551 0.259322 -0.163787 
+
+
+-0.503141 0.224112 0.169702 0.332163 -0.108788 
+-0.433058 0.198223 0.182000 -0.464420 -0.0983969 
+
+-0.475682 0.336167 0.162551 0.284474 -0.169951 
+-0.414752 0.297335 0.181595 0.208456 -0.0374570 
+
+
+-0.536612 0.375000 0.139248 0.280518 -0.189363 
+-0.475682 0.336167 0.162551 0.257774 -0.166216 
+
+-0.500000 0.500000 0.121074 0.257283 -0.258947 
+-0.448223 0.448223 0.146641 0.233277 -0.238084 
+
+
+-0.475682 0.336167 0.162551 0.282926 -0.172379 
+-0.414752 0.297335 0.181595 0.208044 -0.0381037 
+
+-0.448223 0.448223 0.146641 0.236382 -0.238845 
+-0.396447 0.396447 0.169668 0.146240 -0.268014 
+
+
+-0.433058 0.198223 0.182000 0.169264 -0.215438 
+-0.362976 0.172335 0.182808 0.173513 -0.105741 
+
+-0.414752 0.297335 0.181595 0.0109252 -0.000973260 
+-0.353823 0.258502 0.182346 0.168890 -0.145468 
+
+
+-0.362976 0.172335 0.182808 0.173513 -0.105741 
+-0.292893 0.146447 0.183490 0.145035 -0.0846397 
+
+-0.353823 0.258502 0.182346 0.178607 -0.146500 
+-0.292893 0.219670 0.183111 0.152223 -0.122452 
+
+
+-0.414752 0.297335 0.181595 0.0105130 -0.00162004 
+-0.353823 0.258502 0.182346 0.122600 -0.218099 
+
+-0.396447 0.396447 0.169668 0.234365 -0.284290 
+-0.344670 0.344670 0.181844 -0.899403 0.0675999 
+
+
+-0.353823 0.258502 0.182346 0.132316 -0.219131 
+-0.292893 0.219670 0.183111 0.152223 -0.122452 
+
+-0.344670 0.344670 0.181844 0.158427 -0.0447653 
+-0.292893 0.292893 0.182593 0.215532 -0.160265 
+
+
+0.500000 -0.500000 0.121074 -0.257283 0.258947 
+0.536612 -0.375000 0.139248 -0.280518 0.189363 
+
+0.448223 -0.448223 0.146641 -0.233277 0.238084 
+0.475682 -0.336167 0.162551 -0.257774 0.166216 
+
+
+0.536612 -0.375000 0.139248 -0.280518 0.189363 
+0.573223 -0.250000 0.147874 -0.288220 0.115229 
+
+0.475682 -0.336167 0.162551 -0.259322 0.163787 
+0.503141 -0.224112 0.169702 -0.258617 0.0907658 
+
+
+0.448223 -0.448223 0.146641 -0.236382 0.238845 
+0.475682 -0.336167 0.162551 -0.282926 0.172379 
+
+0.396447 -0.396447 0.169668 -0.146240 0.268014 
+0.414752 -0.297335 0.181595 -0.208044 0.0381037 
+
+
+0.475682 -0.336167 0.162551 -0.284474 0.169951 
+0.503141 -0.224112 0.169702 -0.332163 0.108788 
+
+0.414752 -0.297335 0.181595 -0.208456 0.0374570 
+0.433058 -0.198223 0.182000 0.464420 0.0983969 
+
+
+0.573223 -0.250000 0.147874 -0.288288 0.115045 
+0.609835 -0.125000 0.148002 -0.295839 0.0580885 
+
+0.503141 -0.224112 0.169702 -0.261711 0.0823903 
+0.530600 -0.112056 0.170119 -0.244888 0.0491786 
+
+
+0.609835 -0.125000 0.148002 -0.295674 0.0590956 
+0.646447 0.00000 0.140583 -0.313030 0.000477679 
+
+0.530600 -0.112056 0.170119 -0.243630 0.0568755 
+0.558058 0.00000 0.166041 -0.263018 -0.00551155 
+
+
+0.503141 -0.224112 0.169702 -0.335257 0.100412 
+0.530600 -0.112056 0.170119 -0.323232 0.0683767 
+
+0.433058 -0.198223 0.182000 0.435948 0.0213216 
+0.451364 -0.0991117 0.182294 0.528671 -0.0810377 
+
+
+0.530600 -0.112056 0.170119 -0.321975 0.0760735 
+0.558058 0.00000 0.166041 -0.393199 0.0263887 
+
+0.451364 -0.0991117 0.182294 0.528671 -0.0810377 
+0.469670 0.00000 0.182165 0.567056 -0.173361 
+
+
+0.396447 -0.396447 0.169668 -0.234365 0.284290 
+0.414752 -0.297335 0.181595 -0.0105130 0.00162004 
+
+0.344670 -0.344670 0.181844 0.899403 -0.0675999 
+0.353823 -0.258502 0.182346 -0.122600 0.218099 
+
+
+0.414752 -0.297335 0.181595 -0.0109252 0.000973260 
+0.433058 -0.198223 0.182000 -0.169264 0.215438 
+
+0.353823 -0.258502 0.182346 -0.168890 0.145468 
+0.362976 -0.172335 0.182808 -0.173513 0.105741 
+
+
+0.344670 -0.344670 0.181844 -0.158427 0.0447653 
+0.353823 -0.258502 0.182346 -0.132316 0.219131 
+
+0.292893 -0.292893 0.182593 -0.215532 0.160265 
+0.292893 -0.219670 0.183111 -0.152223 0.122452 
+
+
+0.353823 -0.258502 0.182346 -0.178607 0.146500 
+0.362976 -0.172335 0.182808 -0.173513 0.105741 
+
+0.292893 -0.219670 0.183111 -0.152223 0.122452 
+0.292893 -0.146447 0.183490 -0.145035 0.0846397 
+
+
+0.646447 0.00000 0.140583 -0.313030 -0.000477679 
+0.609835 0.125000 0.148002 -0.295674 -0.0590956 
+
+0.558058 0.00000 0.166041 -0.263018 0.00551155 
+0.530600 0.112056 0.170119 -0.243630 -0.0568755 
+
+
+0.609835 0.125000 0.148002 -0.295839 -0.0580885 
+0.573223 0.250000 0.147874 -0.288288 -0.115045 
+
+0.530600 0.112056 0.170119 -0.244888 -0.0491786 
+0.503141 0.224112 0.169702 -0.261711 -0.0823903 
+
+
+0.558058 0.00000 0.166041 -0.393199 -0.0263887 
+0.530600 0.112056 0.170119 -0.321975 -0.0760735 
+
+0.469670 0.00000 0.182165 0.567056 0.173361 
+0.451364 0.0991117 0.182294 0.528671 0.0810377 
+
+
+0.530600 0.112056 0.170119 -0.323232 -0.0683767 
+0.503141 0.224112 0.169702 -0.335257 -0.100412 
+
+0.451364 0.0991117 0.182294 0.528671 0.0810377 
+0.433058 0.198223 0.182000 0.435948 -0.0213216 
+
+
+0.573223 0.250000 0.147874 -0.288220 -0.115229 
+0.536612 0.375000 0.139248 -0.280518 -0.189363 
+
+0.503141 0.224112 0.169702 -0.258617 -0.0907658 
+0.475682 0.336167 0.162551 -0.259322 -0.163787 
+
+
+0.536612 0.375000 0.139248 -0.280518 -0.189363 
+0.500000 0.500000 0.121074 -0.257283 -0.258947 
+
+0.475682 0.336167 0.162551 -0.257774 -0.166216 
+0.448223 0.448223 0.146641 -0.233277 -0.238084 
+
+
+0.503141 0.224112 0.169702 -0.332163 -0.108788 
+0.475682 0.336167 0.162551 -0.284474 -0.169951 
+
+0.433058 0.198223 0.182000 0.464420 -0.0983969 
+0.414752 0.297335 0.181595 -0.208456 -0.0374570 
+
+
+0.475682 0.336167 0.162551 -0.282926 -0.172379 
+0.448223 0.448223 0.146641 -0.236382 -0.238845 
+
+0.414752 0.297335 0.181595 -0.208044 -0.0381037 
+0.396447 0.396447 0.169668 -0.146240 -0.268014 
+
+
+0.433058 0.198223 0.182000 -0.169264 -0.215438 
+0.414752 0.297335 0.181595 -0.0109252 -0.000973260 
+
+0.362976 0.172335 0.182808 -0.173513 -0.105741 
+0.353823 0.258502 0.182346 -0.168890 -0.145468 
+
+
+0.414752 0.297335 0.181595 -0.0105130 -0.00162004 
+0.396447 0.396447 0.169668 -0.234365 -0.284290 
+
+0.353823 0.258502 0.182346 -0.122600 -0.218099 
+0.344670 0.344670 0.181844 0.899403 0.0675999 
+
+
+0.362976 0.172335 0.182808 -0.173513 -0.105741 
+0.353823 0.258502 0.182346 -0.178607 -0.146500 
+
+0.292893 0.146447 0.183490 -0.145035 -0.0846397 
+0.292893 0.219670 0.183111 -0.152223 -0.122452 
+
+
+0.353823 0.258502 0.182346 -0.132316 -0.219131 
+0.344670 0.344670 0.181844 -0.158427 -0.0447653 
+
+0.292893 0.219670 0.183111 -0.152223 -0.122452 
+0.292893 0.292893 0.182593 -0.215532 -0.160265 
+
+
+-0.500000 0.500000 0.121074 0.258947 -0.257283 
+-0.448223 0.448223 0.146641 0.238084 -0.233277 
+
+-0.375000 0.536612 0.139248 0.189363 -0.280518 
+-0.336167 0.475682 0.162551 0.166216 -0.257774 
+
+
+-0.448223 0.448223 0.146641 0.238845 -0.236382 
+-0.396447 0.396447 0.169668 0.268014 -0.146240 
+
+-0.336167 0.475682 0.162551 0.172379 -0.282926 
+-0.297335 0.414752 0.181595 0.0381037 -0.208044 
+
+
+-0.375000 0.536612 0.139248 0.189363 -0.280518 
+-0.336167 0.475682 0.162551 0.163787 -0.259322 
+
+-0.250000 0.573223 0.147874 0.115229 -0.288220 
+-0.224112 0.503141 0.169702 0.0907658 -0.258617 
+
+
+-0.336167 0.475682 0.162551 0.169951 -0.284474 
+-0.297335 0.414752 0.181595 0.0374570 -0.208456 
+
+-0.224112 0.503141 0.169702 0.108788 -0.332163 
+-0.198223 0.433058 0.182000 0.0983969 0.464420 
+
+
+-0.396447 0.396447 0.169668 0.284290 -0.234365 
+-0.344670 0.344670 0.181844 -0.0675999 0.899403 
+
+-0.297335 0.414752 0.181595 0.00162004 -0.0105130 
+-0.258502 0.353823 0.182346 0.218099 -0.122600 
+
+
+-0.344670 0.344670 0.181844 0.0447653 -0.158427 
+-0.292893 0.292893 0.182593 0.160265 -0.215532 
+
+-0.258502 0.353823 0.182346 0.219131 -0.132316 
+-0.219670 0.292893 0.183111 0.122452 -0.152223 
+
+
+-0.297335 0.414752 0.181595 0.000973260 -0.0109252 
+-0.258502 0.353823 0.182346 0.145468 -0.168890 
+
+-0.198223 0.433058 0.182000 0.215438 -0.169264 
+-0.172335 0.362976 0.182808 0.105741 -0.173513 
+
+
+-0.258502 0.353823 0.182346 0.146500 -0.178607 
+-0.219670 0.292893 0.183111 0.122452 -0.152223 
+
+-0.172335 0.362976 0.182808 0.105741 -0.173513 
+-0.146447 0.292893 0.183490 0.0846397 -0.145035 
+
+
+-0.250000 0.573223 0.147874 0.115045 -0.288288 
+-0.224112 0.503141 0.169702 0.0823903 -0.261711 
+
+-0.125000 0.609835 0.148002 0.0580885 -0.295839 
+-0.112056 0.530600 0.170119 0.0491786 -0.244888 
+
+
+-0.224112 0.503141 0.169702 0.100412 -0.335257 
+-0.198223 0.433058 0.182000 0.0213216 0.435948 
+
+-0.112056 0.530600 0.170119 0.0683767 -0.323232 
+-0.0991117 0.451364 0.182294 -0.0810377 0.528671 
+
+
+-0.125000 0.609835 0.148002 0.0590956 -0.295674 
+-0.112056 0.530600 0.170119 0.0568755 -0.243630 
+
+0.00000 0.646447 0.140583 0.000477679 -0.313030 
+0.00000 0.558058 0.166041 -0.00551155 -0.263018 
+
+
+-0.112056 0.530600 0.170119 0.0760735 -0.321975 
+-0.0991117 0.451364 0.182294 -0.0810377 0.528671 
+
+0.00000 0.558058 0.166041 0.0263887 -0.393199 
+0.00000 0.469670 0.182165 -0.173361 0.567056 
+
+
+0.00000 0.646447 0.140583 -0.000477679 -0.313030 
+0.00000 0.558058 0.166041 0.00551155 -0.263018 
+
+0.125000 0.609835 0.148002 -0.0590956 -0.295674 
+0.112056 0.530600 0.170119 -0.0568755 -0.243630 
+
+
+0.00000 0.558058 0.166041 -0.0263887 -0.393199 
+0.00000 0.469670 0.182165 0.173361 0.567056 
+
+0.112056 0.530600 0.170119 -0.0760735 -0.321975 
+0.0991117 0.451364 0.182294 0.0810377 0.528671 
+
+
+0.125000 0.609835 0.148002 -0.0580885 -0.295839 
+0.112056 0.530600 0.170119 -0.0491786 -0.244888 
+
+0.250000 0.573223 0.147874 -0.115045 -0.288288 
+0.224112 0.503141 0.169702 -0.0823903 -0.261711 
+
+
+0.112056 0.530600 0.170119 -0.0683767 -0.323232 
+0.0991117 0.451364 0.182294 0.0810377 0.528671 
+
+0.224112 0.503141 0.169702 -0.100412 -0.335257 
+0.198223 0.433058 0.182000 -0.0213216 0.435948 
+
+
+0.250000 0.573223 0.147874 -0.115229 -0.288220 
+0.224112 0.503141 0.169702 -0.0907658 -0.258617 
+
+0.375000 0.536612 0.139248 -0.189363 -0.280518 
+0.336167 0.475682 0.162551 -0.163787 -0.259322 
+
+
+0.224112 0.503141 0.169702 -0.108788 -0.332163 
+0.198223 0.433058 0.182000 -0.0983969 0.464420 
+
+0.336167 0.475682 0.162551 -0.169951 -0.284474 
+0.297335 0.414752 0.181595 -0.0374570 -0.208456 
+
+
+0.375000 0.536612 0.139248 -0.189363 -0.280518 
+0.336167 0.475682 0.162551 -0.166216 -0.257774 
+
+0.500000 0.500000 0.121074 -0.258947 -0.257283 
+0.448223 0.448223 0.146641 -0.238084 -0.233277 
+
+
+0.336167 0.475682 0.162551 -0.172379 -0.282926 
+0.297335 0.414752 0.181595 -0.0381037 -0.208044 
+
+0.448223 0.448223 0.146641 -0.238845 -0.236382 
+0.396447 0.396447 0.169668 -0.268014 -0.146240 
+
+
+0.198223 0.433058 0.182000 -0.215438 -0.169264 
+0.172335 0.362976 0.182808 -0.105741 -0.173513 
+
+0.297335 0.414752 0.181595 -0.000973260 -0.0109252 
+0.258502 0.353823 0.182346 -0.145468 -0.168890 
+
+
+0.172335 0.362976 0.182808 -0.105741 -0.173513 
+0.146447 0.292893 0.183490 -0.0846397 -0.145035 
+
+0.258502 0.353823 0.182346 -0.146500 -0.178607 
+0.219670 0.292893 0.183111 -0.122452 -0.152223 
+
+
+0.297335 0.414752 0.181595 -0.00162004 -0.0105130 
+0.258502 0.353823 0.182346 -0.218099 -0.122600 
+
+0.396447 0.396447 0.169668 -0.284290 -0.234365 
+0.344670 0.344670 0.181844 0.0675999 0.899403 
+
+
+0.258502 0.353823 0.182346 -0.219131 -0.132316 
+0.219670 0.292893 0.183111 -0.122452 -0.152223 
+
+0.344670 0.344670 0.181844 -0.0447653 -0.158427 
+0.292893 0.292893 0.182593 -0.160265 -0.215532 
+
+

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.