]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Add tutorial step-03 with simplex support. 11482/head
authorElias Dejene <elias.dejene@tum.de>
Sat, 2 Jan 2021 12:23:06 +0000 (13:23 +0100)
committerPeter Munch <peterrmuench@gmail.com>
Mon, 11 Jan 2021 09:35:34 +0000 (10:35 +0100)
tests/simplex/step-03.cc [new file with mode: 0644]
tests/simplex/step-03.with_simplex_support=on.output [new file with mode: 0644]

diff --git a/tests/simplex/step-03.cc b/tests/simplex/step-03.cc
new file mode 100644 (file)
index 0000000..ae8a03e
--- /dev/null
@@ -0,0 +1,245 @@
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2020 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.md at
+// the top level directory of deal.II.
+//
+// ---------------------------------------------------------------------
+
+
+// Step-03 on a simplex mesh. Following incompatible modifications had to be
+// made:
+//  - Change the FE_Q to Simplex::FE_P.
+//  - Change QGauss to Simplex::QGauss.
+//  - Use MappingFE (Do not use default mapping).
+//  - Convert triangulation to a triangulation based on simplices.
+
+
+#include <deal.II/base/function.h>
+#include <deal.II/base/quadrature_lib.h>
+
+#include <deal.II/dofs/dof_accessor.h>
+#include <deal.II/dofs/dof_handler.h>
+#include <deal.II/dofs/dof_tools.h>
+
+#include <deal.II/fe/fe_q.h>
+#include <deal.II/fe/fe_values.h>
+#include <deal.II/fe/mapping_fe.h>
+#include <deal.II/fe/mapping_q.h>
+
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/grid_out.h>
+#include <deal.II/grid/tria.h>
+#include <deal.II/grid/tria_accessor.h>
+#include <deal.II/grid/tria_iterator.h>
+
+#include <deal.II/lac/dynamic_sparsity_pattern.h>
+#include <deal.II/lac/full_matrix.h>
+#include <deal.II/lac/precondition.h>
+#include <deal.II/lac/solver_cg.h>
+#include <deal.II/lac/sparse_matrix.h>
+#include <deal.II/lac/vector.h>
+
+#include <deal.II/numerics/data_out.h>
+#include <deal.II/numerics/matrix_tools.h>
+#include <deal.II/numerics/vector_tools.h>
+
+#include <deal.II/simplex/fe_lib.h>
+#include <deal.II/simplex/grid_generator.h>
+#include <deal.II/simplex/quadrature_lib.h>
+
+#include <fstream>
+#include <iostream>
+
+#include "../tests.h"
+
+using namespace dealii;
+
+template <int dim>
+class Step3
+{
+public:
+  Step3();
+  void
+  run();
+
+private:
+  void
+  make_grid();
+  void
+  setup_system();
+  void
+  assemble_system();
+  void
+  solve();
+  void
+  output_results() const;
+
+  Triangulation<dim, dim> triangulation;
+  unsigned int            fe_degree;
+  Simplex::FE_P<dim>      fe;
+  Simplex::QGauss<dim>    quadrature_formula;
+
+  DoFHandler<dim> dof_handler;
+  MappingFE<dim>  mapping;
+
+  SparsityPattern      sparsity_pattern;
+  SparseMatrix<double> system_matrix;
+
+  Vector<double> solution;
+  Vector<double> system_rhs;
+};
+
+template <int dim>
+Step3<dim>::Step3()
+  : fe_degree(1)
+  , fe(fe_degree)
+  , quadrature_formula(fe_degree + 1)
+  , dof_handler(triangulation)
+  , mapping(Simplex::FE_P<dim>(1))
+{}
+
+template <int dim>
+void
+Step3<dim>::make_grid()
+{
+  Triangulation<dim, dim> temp_tria;
+
+  GridGenerator::subdivided_hyper_cube(temp_tria, 2);
+  GridGenerator::convert_hypercube_to_simplex_mesh<dim, dim>(temp_tria,
+                                                             triangulation);
+  triangulation.refine_global(1);
+
+  deallog << "Number of active cells: " << triangulation.n_active_cells()
+          << std::endl;
+}
+
+template <int dim>
+void
+Step3<dim>::setup_system()
+{
+  dof_handler.distribute_dofs(fe);
+  deallog << "Number of degrees of freedom: " << dof_handler.n_dofs()
+          << std::endl;
+
+  DynamicSparsityPattern dsp(dof_handler.n_dofs());
+  DoFTools::make_sparsity_pattern(dof_handler, dsp);
+  sparsity_pattern.copy_from(dsp);
+
+  system_matrix.reinit(sparsity_pattern);
+
+  solution.reinit(dof_handler.n_dofs());
+  system_rhs.reinit(dof_handler.n_dofs());
+}
+
+template <int dim>
+void
+Step3<dim>::assemble_system()
+{
+  FEValues<dim> fe_values(mapping,
+                          fe,
+                          quadrature_formula,
+                          update_values | update_gradients | update_JxW_values);
+
+  const unsigned int dofs_per_cell = fe.n_dofs_per_cell();
+
+  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);
+
+  for (const auto &cell : dof_handler.active_cell_iterators())
+    {
+      fe_values.reinit(cell);
+
+      cell_matrix = 0;
+      cell_rhs    = 0;
+
+      for (const unsigned int q_index : fe_values.quadrature_point_indices())
+        {
+          for (const unsigned int i : fe_values.dof_indices())
+            for (const unsigned int j : fe_values.dof_indices())
+              cell_matrix(i, j) +=
+                (fe_values.shape_grad(i, q_index) * // grad phi_i(x_q)
+                 fe_values.shape_grad(j, q_index) * // grad phi_j(x_q)
+                 fe_values.JxW(q_index));           // dx
+
+          for (const unsigned int i : fe_values.dof_indices())
+            cell_rhs(i) += (fe_values.shape_value(i, q_index) * // phi_i(x_q)
+                            1. *                                // f(x_q)
+                            fe_values.JxW(q_index));            // dx
+        }
+      cell->get_dof_indices(local_dof_indices);
+
+      for (const unsigned int i : fe_values.dof_indices())
+        for (const unsigned int j : fe_values.dof_indices())
+          system_matrix.add(local_dof_indices[i],
+                            local_dof_indices[j],
+                            cell_matrix(i, j));
+
+      for (const unsigned int i : fe_values.dof_indices())
+        system_rhs(local_dof_indices[i]) += cell_rhs(i);
+    }
+
+  std::map<types::global_dof_index, double> boundary_values;
+  VectorTools::interpolate_boundary_values(
+    mapping, dof_handler, 0, Functions::ZeroFunction<dim>(), boundary_values);
+  MatrixTools::apply_boundary_values(boundary_values,
+                                     system_matrix,
+                                     solution,
+                                     system_rhs);
+}
+
+template <int dim>
+void
+Step3<dim>::solve()
+{
+  SolverControl solver_control(1000, 1e-12);
+
+  SolverCG<Vector<double>> solver(solver_control);
+  solver.solve(system_matrix, solution, system_rhs, PreconditionIdentity());
+}
+
+template <int dim>
+void
+Step3<dim>::output_results() const
+{
+  DataOut<dim> data_out;
+  data_out.attach_dof_handler(dof_handler);
+  data_out.add_data_vector(solution, "solution");
+  data_out.build_patches(mapping);
+
+  data_out.write_vtk(deallog.get_file_stream());
+}
+
+template <int dim>
+void
+Step3<dim>::run()
+{
+  make_grid();
+  setup_system();
+  assemble_system();
+  solve();
+  output_results();
+}
+
+
+int
+main()
+{
+  initlog();
+
+  deallog.depth_console(2);
+
+  Step3<2> laplace_problem;
+  laplace_problem.run();
+
+  return 0;
+}
diff --git a/tests/simplex/step-03.with_simplex_support=on.output b/tests/simplex/step-03.with_simplex_support=on.output
new file mode 100644 (file)
index 0000000..62ee19c
--- /dev/null
@@ -0,0 +1,532 @@
+
+DEAL::Number of active cells: 128
+DEAL::Number of degrees of freedom: 81
+DEAL:cg::Starting value 0.109746
+DEAL:cg::Convergence step 9 value 1.24504e-18
+# vtk DataFile Version 3.0
+#This file was generated 
+ASCII
+DATASET UNSTRUCTURED_GRID
+
+POINTS 384 double
+0.00000 0.00000 0
+0.125000 0.00000 0
+0.00000 0.125000 0
+0.125000 0.00000 0
+0.250000 0.00000 0
+0.125000 0.125000 0
+0.00000 0.125000 0
+0.125000 0.125000 0
+0.00000 0.250000 0
+0.125000 0.00000 0
+0.125000 0.125000 0
+0.00000 0.125000 0
+0.250000 0.250000 0
+0.125000 0.250000 0
+0.250000 0.125000 0
+0.125000 0.250000 0
+0.00000 0.250000 0
+0.125000 0.125000 0
+0.250000 0.125000 0
+0.125000 0.125000 0
+0.250000 0.00000 0
+0.125000 0.250000 0
+0.125000 0.125000 0
+0.250000 0.125000 0
+0.250000 0.250000 0
+0.250000 0.125000 0
+0.375000 0.250000 0
+0.250000 0.125000 0
+0.250000 0.00000 0
+0.375000 0.125000 0
+0.375000 0.250000 0
+0.375000 0.125000 0
+0.500000 0.250000 0
+0.250000 0.125000 0
+0.375000 0.125000 0
+0.375000 0.250000 0
+0.500000 0.00000 0
+0.500000 0.125000 0
+0.375000 0.00000 0
+0.500000 0.125000 0
+0.500000 0.250000 0
+0.375000 0.125000 0
+0.375000 0.00000 0
+0.375000 0.125000 0
+0.250000 0.00000 0
+0.500000 0.125000 0
+0.375000 0.125000 0
+0.375000 0.00000 0
+0.00000 0.500000 0
+0.00000 0.375000 0
+0.125000 0.500000 0
+0.00000 0.375000 0
+0.00000 0.250000 0
+0.125000 0.375000 0
+0.125000 0.500000 0
+0.125000 0.375000 0
+0.250000 0.500000 0
+0.00000 0.375000 0
+0.125000 0.375000 0
+0.125000 0.500000 0
+0.250000 0.250000 0
+0.250000 0.375000 0
+0.125000 0.250000 0
+0.250000 0.375000 0
+0.250000 0.500000 0
+0.125000 0.375000 0
+0.125000 0.250000 0
+0.125000 0.375000 0
+0.00000 0.250000 0
+0.250000 0.375000 0
+0.125000 0.375000 0
+0.125000 0.250000 0
+0.250000 0.250000 0
+0.375000 0.250000 0
+0.250000 0.375000 0
+0.375000 0.250000 0
+0.500000 0.250000 0
+0.375000 0.375000 0
+0.250000 0.375000 0
+0.375000 0.375000 0
+0.250000 0.500000 0
+0.375000 0.250000 0
+0.375000 0.375000 0
+0.250000 0.375000 0
+0.500000 0.500000 0
+0.375000 0.500000 0
+0.500000 0.375000 0
+0.375000 0.500000 0
+0.250000 0.500000 0
+0.375000 0.375000 0
+0.500000 0.375000 0
+0.375000 0.375000 0
+0.500000 0.250000 0
+0.375000 0.500000 0
+0.375000 0.375000 0
+0.500000 0.375000 0
+0.500000 0.00000 0
+0.625000 0.00000 0
+0.500000 0.125000 0
+0.625000 0.00000 0
+0.750000 0.00000 0
+0.625000 0.125000 0
+0.500000 0.125000 0
+0.625000 0.125000 0
+0.500000 0.250000 0
+0.625000 0.00000 0
+0.625000 0.125000 0
+0.500000 0.125000 0
+0.750000 0.250000 0
+0.625000 0.250000 0
+0.750000 0.125000 0
+0.625000 0.250000 0
+0.500000 0.250000 0
+0.625000 0.125000 0
+0.750000 0.125000 0
+0.625000 0.125000 0
+0.750000 0.00000 0
+0.625000 0.250000 0
+0.625000 0.125000 0
+0.750000 0.125000 0
+0.750000 0.250000 0
+0.750000 0.125000 0
+0.875000 0.250000 0
+0.750000 0.125000 0
+0.750000 0.00000 0
+0.875000 0.125000 0
+0.875000 0.250000 0
+0.875000 0.125000 0
+1.00000 0.250000 0
+0.750000 0.125000 0
+0.875000 0.125000 0
+0.875000 0.250000 0
+1.00000 0.00000 0
+1.00000 0.125000 0
+0.875000 0.00000 0
+1.00000 0.125000 0
+1.00000 0.250000 0
+0.875000 0.125000 0
+0.875000 0.00000 0
+0.875000 0.125000 0
+0.750000 0.00000 0
+1.00000 0.125000 0
+0.875000 0.125000 0
+0.875000 0.00000 0
+0.500000 0.500000 0
+0.500000 0.375000 0
+0.625000 0.500000 0
+0.500000 0.375000 0
+0.500000 0.250000 0
+0.625000 0.375000 0
+0.625000 0.500000 0
+0.625000 0.375000 0
+0.750000 0.500000 0
+0.500000 0.375000 0
+0.625000 0.375000 0
+0.625000 0.500000 0
+0.750000 0.250000 0
+0.750000 0.375000 0
+0.625000 0.250000 0
+0.750000 0.375000 0
+0.750000 0.500000 0
+0.625000 0.375000 0
+0.625000 0.250000 0
+0.625000 0.375000 0
+0.500000 0.250000 0
+0.750000 0.375000 0
+0.625000 0.375000 0
+0.625000 0.250000 0
+0.750000 0.250000 0
+0.875000 0.250000 0
+0.750000 0.375000 0
+0.875000 0.250000 0
+1.00000 0.250000 0
+0.875000 0.375000 0
+0.750000 0.375000 0
+0.875000 0.375000 0
+0.750000 0.500000 0
+0.875000 0.250000 0
+0.875000 0.375000 0
+0.750000 0.375000 0
+1.00000 0.500000 0
+0.875000 0.500000 0
+1.00000 0.375000 0
+0.875000 0.500000 0
+0.750000 0.500000 0
+0.875000 0.375000 0
+1.00000 0.375000 0
+0.875000 0.375000 0
+1.00000 0.250000 0
+0.875000 0.500000 0
+0.875000 0.375000 0
+1.00000 0.375000 0
+0.00000 0.500000 0
+0.125000 0.500000 0
+0.00000 0.625000 0
+0.125000 0.500000 0
+0.250000 0.500000 0
+0.125000 0.625000 0
+0.00000 0.625000 0
+0.125000 0.625000 0
+0.00000 0.750000 0
+0.125000 0.500000 0
+0.125000 0.625000 0
+0.00000 0.625000 0
+0.250000 0.750000 0
+0.125000 0.750000 0
+0.250000 0.625000 0
+0.125000 0.750000 0
+0.00000 0.750000 0
+0.125000 0.625000 0
+0.250000 0.625000 0
+0.125000 0.625000 0
+0.250000 0.500000 0
+0.125000 0.750000 0
+0.125000 0.625000 0
+0.250000 0.625000 0
+0.250000 0.750000 0
+0.250000 0.625000 0
+0.375000 0.750000 0
+0.250000 0.625000 0
+0.250000 0.500000 0
+0.375000 0.625000 0
+0.375000 0.750000 0
+0.375000 0.625000 0
+0.500000 0.750000 0
+0.250000 0.625000 0
+0.375000 0.625000 0
+0.375000 0.750000 0
+0.500000 0.500000 0
+0.500000 0.625000 0
+0.375000 0.500000 0
+0.500000 0.625000 0
+0.500000 0.750000 0
+0.375000 0.625000 0
+0.375000 0.500000 0
+0.375000 0.625000 0
+0.250000 0.500000 0
+0.500000 0.625000 0
+0.375000 0.625000 0
+0.375000 0.500000 0
+0.00000 1.00000 0
+0.00000 0.875000 0
+0.125000 1.00000 0
+0.00000 0.875000 0
+0.00000 0.750000 0
+0.125000 0.875000 0
+0.125000 1.00000 0
+0.125000 0.875000 0
+0.250000 1.00000 0
+0.00000 0.875000 0
+0.125000 0.875000 0
+0.125000 1.00000 0
+0.250000 0.750000 0
+0.250000 0.875000 0
+0.125000 0.750000 0
+0.250000 0.875000 0
+0.250000 1.00000 0
+0.125000 0.875000 0
+0.125000 0.750000 0
+0.125000 0.875000 0
+0.00000 0.750000 0
+0.250000 0.875000 0
+0.125000 0.875000 0
+0.125000 0.750000 0
+0.250000 0.750000 0
+0.375000 0.750000 0
+0.250000 0.875000 0
+0.375000 0.750000 0
+0.500000 0.750000 0
+0.375000 0.875000 0
+0.250000 0.875000 0
+0.375000 0.875000 0
+0.250000 1.00000 0
+0.375000 0.750000 0
+0.375000 0.875000 0
+0.250000 0.875000 0
+0.500000 1.00000 0
+0.375000 1.00000 0
+0.500000 0.875000 0
+0.375000 1.00000 0
+0.250000 1.00000 0
+0.375000 0.875000 0
+0.500000 0.875000 0
+0.375000 0.875000 0
+0.500000 0.750000 0
+0.375000 1.00000 0
+0.375000 0.875000 0
+0.500000 0.875000 0
+0.500000 0.500000 0
+0.625000 0.500000 0
+0.500000 0.625000 0
+0.625000 0.500000 0
+0.750000 0.500000 0
+0.625000 0.625000 0
+0.500000 0.625000 0
+0.625000 0.625000 0
+0.500000 0.750000 0
+0.625000 0.500000 0
+0.625000 0.625000 0
+0.500000 0.625000 0
+0.750000 0.750000 0
+0.625000 0.750000 0
+0.750000 0.625000 0
+0.625000 0.750000 0
+0.500000 0.750000 0
+0.625000 0.625000 0
+0.750000 0.625000 0
+0.625000 0.625000 0
+0.750000 0.500000 0
+0.625000 0.750000 0
+0.625000 0.625000 0
+0.750000 0.625000 0
+0.750000 0.750000 0
+0.750000 0.625000 0
+0.875000 0.750000 0
+0.750000 0.625000 0
+0.750000 0.500000 0
+0.875000 0.625000 0
+0.875000 0.750000 0
+0.875000 0.625000 0
+1.00000 0.750000 0
+0.750000 0.625000 0
+0.875000 0.625000 0
+0.875000 0.750000 0
+1.00000 0.500000 0
+1.00000 0.625000 0
+0.875000 0.500000 0
+1.00000 0.625000 0
+1.00000 0.750000 0
+0.875000 0.625000 0
+0.875000 0.500000 0
+0.875000 0.625000 0
+0.750000 0.500000 0
+1.00000 0.625000 0
+0.875000 0.625000 0
+0.875000 0.500000 0
+0.500000 1.00000 0
+0.500000 0.875000 0
+0.625000 1.00000 0
+0.500000 0.875000 0
+0.500000 0.750000 0
+0.625000 0.875000 0
+0.625000 1.00000 0
+0.625000 0.875000 0
+0.750000 1.00000 0
+0.500000 0.875000 0
+0.625000 0.875000 0
+0.625000 1.00000 0
+0.750000 0.750000 0
+0.750000 0.875000 0
+0.625000 0.750000 0
+0.750000 0.875000 0
+0.750000 1.00000 0
+0.625000 0.875000 0
+0.625000 0.750000 0
+0.625000 0.875000 0
+0.500000 0.750000 0
+0.750000 0.875000 0
+0.625000 0.875000 0
+0.625000 0.750000 0
+0.750000 0.750000 0
+0.875000 0.750000 0
+0.750000 0.875000 0
+0.875000 0.750000 0
+1.00000 0.750000 0
+0.875000 0.875000 0
+0.750000 0.875000 0
+0.875000 0.875000 0
+0.750000 1.00000 0
+0.875000 0.750000 0
+0.875000 0.875000 0
+0.750000 0.875000 0
+1.00000 1.00000 0
+0.875000 1.00000 0
+1.00000 0.875000 0
+0.875000 1.00000 0
+0.750000 1.00000 0
+0.875000 0.875000 0
+1.00000 0.875000 0
+0.875000 0.875000 0
+1.00000 0.750000 0
+0.875000 1.00000 0
+0.875000 0.875000 0
+1.00000 0.875000 0
+
+CELLS 128 512
+       3       0       1       2
+       3       3       4       5
+       3       6       7       8
+       3       9       10      11
+       3       12      13      14
+       3       15      16      17
+       3       18      19      20
+       3       21      22      23
+       3       24      25      26
+       3       27      28      29
+       3       30      31      32
+       3       33      34      35
+       3       36      37      38
+       3       39      40      41
+       3       42      43      44
+       3       45      46      47
+       3       48      49      50
+       3       51      52      53
+       3       54      55      56
+       3       57      58      59
+       3       60      61      62
+       3       63      64      65
+       3       66      67      68
+       3       69      70      71
+       3       72      73      74
+       3       75      76      77
+       3       78      79      80
+       3       81      82      83
+       3       84      85      86
+       3       87      88      89
+       3       90      91      92
+       3       93      94      95
+       3       96      97      98
+       3       99      100     101
+       3       102     103     104
+       3       105     106     107
+       3       108     109     110
+       3       111     112     113
+       3       114     115     116
+       3       117     118     119
+       3       120     121     122
+       3       123     124     125
+       3       126     127     128
+       3       129     130     131
+       3       132     133     134
+       3       135     136     137
+       3       138     139     140
+       3       141     142     143
+       3       144     145     146
+       3       147     148     149
+       3       150     151     152
+       3       153     154     155
+       3       156     157     158
+       3       159     160     161
+       3       162     163     164
+       3       165     166     167
+       3       168     169     170
+       3       171     172     173
+       3       174     175     176
+       3       177     178     179
+       3       180     181     182
+       3       183     184     185
+       3       186     187     188
+       3       189     190     191
+       3       192     193     194
+       3       195     196     197
+       3       198     199     200
+       3       201     202     203
+       3       204     205     206
+       3       207     208     209
+       3       210     211     212
+       3       213     214     215
+       3       216     217     218
+       3       219     220     221
+       3       222     223     224
+       3       225     226     227
+       3       228     229     230
+       3       231     232     233
+       3       234     235     236
+       3       237     238     239
+       3       240     241     242
+       3       243     244     245
+       3       246     247     248
+       3       249     250     251
+       3       252     253     254
+       3       255     256     257
+       3       258     259     260
+       3       261     262     263
+       3       264     265     266
+       3       267     268     269
+       3       270     271     272
+       3       273     274     275
+       3       276     277     278
+       3       279     280     281
+       3       282     283     284
+       3       285     286     287
+       3       288     289     290
+       3       291     292     293
+       3       294     295     296
+       3       297     298     299
+       3       300     301     302
+       3       303     304     305
+       3       306     307     308
+       3       309     310     311
+       3       312     313     314
+       3       315     316     317
+       3       318     319     320
+       3       321     322     323
+       3       324     325     326
+       3       327     328     329
+       3       330     331     332
+       3       333     334     335
+       3       336     337     338
+       3       339     340     341
+       3       342     343     344
+       3       345     346     347
+       3       348     349     350
+       3       351     352     353
+       3       354     355     356
+       3       357     358     359
+       3       360     361     362
+       3       363     364     365
+       3       366     367     368
+       3       369     370     371
+       3       372     373     374
+       3       375     376     377
+       3       378     379     380
+       3       381     382     383
+
+CELL_TYPES 128
+ 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5 5
+POINT_DATA 384
+SCALARS solution double 1
+LOOKUP_TABLE default
+0.00000 0.00000 0.00000 0.00000 0.00000 0.0175398 0.00000 0.0175398 0.00000 0.00000 0.0175398 0.00000 0.0430645 0.0272672 0.0272672 0.0272672 0.00000 0.0175398 0.0272672 0.0175398 0.00000 0.0272672 0.0175398 0.0272672 0.0430645 0.0272672 0.0536535 0.0272672 0.00000 0.0328393 0.0536535 0.0328393 0.0579427 0.0272672 0.0328393 0.0536535 0.00000 0.0348116 0.00000 0.0348116 0.0579427 0.0328393 0.00000 0.0328393 0.00000 0.0348116 0.0328393 0.00000 0.00000 0.00000 0.0348116 0.00000 0.00000 0.0328393 0.0348116 0.0328393 0.0579427 0.00000 0.0328393 0.0348116 0.0430645 0.0536535 0.0272672 0.0536535 0.0579427 0.0328393 0.0272672 0.0328393 0.00000 0.0536535 0.0328393 0.0272672 0.0430645 0.0536535 0.0536535 0.0536535 0.0579427 0.0651425 0.0536535 0.0651425 0.0579427 0.0536535 0.0651425 0.0536535 0.0714231 0.0688189 0.0688189 0.0688189 0.0579427 0.0651425 0.0688189 0.0651425 0.0579427 0.0688189 0.0651425 0.0688189 0.00000 0.00000 0.0348116 0.00000 0.00000 0.0328393 0.0348116 0.0328393 0.0579427 0.00000 0.0328393 0.0348116 0.0430645 0.0536535 0.0272672 0.0536535 0.0579427 0.0328393 0.0272672 0.0328393 0.00000 0.0536535 0.0328393 0.0272672 0.0430645 0.0272672 0.0272672 0.0272672 0.00000 0.0175398 0.0272672 0.0175398 0.00000 0.0272672 0.0175398 0.0272672 0.00000 0.00000 0.00000 0.00000 0.00000 0.0175398 0.00000 0.0175398 0.00000 0.00000 0.0175398 0.00000 0.0714231 0.0688189 0.0688189 0.0688189 0.0579427 0.0651425 0.0688189 0.0651425 0.0579427 0.0688189 0.0651425 0.0688189 0.0430645 0.0536535 0.0536535 0.0536535 0.0579427 0.0651425 0.0536535 0.0651425 0.0579427 0.0536535 0.0651425 0.0536535 0.0430645 0.0272672 0.0536535 0.0272672 0.00000 0.0328393 0.0536535 0.0328393 0.0579427 0.0272672 0.0328393 0.0536535 0.00000 0.0348116 0.00000 0.0348116 0.0579427 0.0328393 0.00000 0.0328393 0.00000 0.0348116 0.0328393 0.00000 0.00000 0.0348116 0.00000 0.0348116 0.0579427 0.0328393 0.00000 0.0328393 0.00000 0.0348116 0.0328393 0.00000 0.0430645 0.0272672 0.0536535 0.0272672 0.00000 0.0328393 0.0536535 0.0328393 0.0579427 0.0272672 0.0328393 0.0536535 0.0430645 0.0536535 0.0536535 0.0536535 0.0579427 0.0651425 0.0536535 0.0651425 0.0579427 0.0536535 0.0651425 0.0536535 0.0714231 0.0688189 0.0688189 0.0688189 0.0579427 0.0651425 0.0688189 0.0651425 0.0579427 0.0688189 0.0651425 0.0688189 0.00000 0.00000 0.00000 0.00000 0.00000 0.0175398 0.00000 0.0175398 0.00000 0.00000 0.0175398 0.00000 0.0430645 0.0272672 0.0272672 0.0272672 0.00000 0.0175398 0.0272672 0.0175398 0.00000 0.0272672 0.0175398 0.0272672 0.0430645 0.0536535 0.0272672 0.0536535 0.0579427 0.0328393 0.0272672 0.0328393 0.00000 0.0536535 0.0328393 0.0272672 0.00000 0.00000 0.0348116 0.00000 0.00000 0.0328393 0.0348116 0.0328393 0.0579427 0.00000 0.0328393 0.0348116 0.0714231 0.0688189 0.0688189 0.0688189 0.0579427 0.0651425 0.0688189 0.0651425 0.0579427 0.0688189 0.0651425 0.0688189 0.0430645 0.0536535 0.0536535 0.0536535 0.0579427 0.0651425 0.0536535 0.0651425 0.0579427 0.0536535 0.0651425 0.0536535 0.0430645 0.0536535 0.0272672 0.0536535 0.0579427 0.0328393 0.0272672 0.0328393 0.00000 0.0536535 0.0328393 0.0272672 0.00000 0.00000 0.0348116 0.00000 0.00000 0.0328393 0.0348116 0.0328393 0.0579427 0.00000 0.0328393 0.0348116 0.00000 0.0348116 0.00000 0.0348116 0.0579427 0.0328393 0.00000 0.0328393 0.00000 0.0348116 0.0328393 0.00000 0.0430645 0.0272672 0.0536535 0.0272672 0.00000 0.0328393 0.0536535 0.0328393 0.0579427 0.0272672 0.0328393 0.0536535 0.0430645 0.0272672 0.0272672 0.0272672 0.00000 0.0175398 0.0272672 0.0175398 0.00000 0.0272672 0.0175398 0.0272672 0.00000 0.00000 0.00000 0.00000 0.00000 0.0175398 0.00000 0.0175398 0.00000 0.00000 0.0175398 0.00000 

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

Douglas Adams


Typeset in Trocchi and Trocchi Bold Sans Serif.