]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
Add another test.
authorbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 16 Nov 2010 22:27:47 +0000 (22:27 +0000)
committerbangerth <bangerth@0785d39b-7218-0410-832d-ea1e28bc413d>
Tue, 16 Nov 2010 22:27:47 +0000 (22:27 +0000)
git-svn-id: https://svn.dealii.org/trunk@22780 0785d39b-7218-0410-832d-ea1e28bc413d

tests/codim_one/extract_boundary_mesh_03.cc [new file with mode: 0644]
tests/codim_one/extract_boundary_mesh_03/cmp/generic [new file with mode: 0644]

diff --git a/tests/codim_one/extract_boundary_mesh_03.cc b/tests/codim_one/extract_boundary_mesh_03.cc
new file mode 100644 (file)
index 0000000..18f27dc
--- /dev/null
@@ -0,0 +1,130 @@
+//----------------------------  extract_boundary_mesh_03.cc  ---------------------------
+//    $Id: bem.cc 22693 2010-11-11 20:11:47Z kanschat $
+//    Version: $Name$
+//
+//    Copyright (C) 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.
+//
+//----------------------------  extract_boundary_mesh_03.cc  ---------------------------
+
+/*
+ Code for testing the function
+ GridTools::extract_boundary_mesh (...).
+ We test that the order of cells and the orientation
+ of the vertices is consistent between the two meshes.
+
+ Like _02, but set volume boundary indicator to 1 and make sure that
+ extract_boundary_mesh also copies this.
+*/
+
+#include "../tests.h"
+
+#include <grid/tria.h>
+#include <grid/grid_generator.h>
+#include <grid/tria_boundary_lib.h>
+#include <grid/grid_out.h>
+#include <grid/grid_tools.h>
+
+using namespace std;
+
+
+template <int s_dim, int spacedim>
+void test_vertices_orientation(const Triangulation<s_dim,spacedim> &boundary_mesh,
+                              map< typename Triangulation<s_dim,spacedim>::cell_iterator,
+                                   typename Triangulation<s_dim+1,spacedim>::face_iterator >
+                              &surface_to_volume_mapping)
+{
+  typename Triangulation<s_dim,spacedim>::active_cell_iterator
+    cell = boundary_mesh.begin_active(),
+    endc = boundary_mesh.end();
+  typename Triangulation<s_dim+1,spacedim>::face_iterator face;
+
+  for (; cell!=endc; ++cell){
+
+    face = surface_to_volume_mapping [cell];
+    Assert (face->at_boundary(), ExcInternalError());
+
+    deallog << "Surface cell: " << cell << " with vertices:" << std::endl;
+    for (unsigned int k=0; k<GeometryInfo<s_dim>::vertices_per_cell; ++k)
+      {
+       deallog << "  " << cell->vertex(k) << std::endl;
+       Assert (std::fabs(cell->vertex(k).distance (Point<spacedim>()) - 1) < 1e-12,
+               ExcInternalError());
+      }
+
+    deallog << "Volume face: " << face << " with vertices:" << std::endl;
+    for (unsigned int k=0; k<GeometryInfo<s_dim>::vertices_per_cell; ++k)
+      {
+       deallog << "  " << face->vertex(k) << std::endl;
+       Assert (std::fabs(face->vertex(k).distance (Point<spacedim>()) - 1) < 1e-12,
+               ExcInternalError());
+      }
+
+
+    for (unsigned int k=0; k<GeometryInfo<s_dim>::vertices_per_cell; ++k)
+      {
+       Point<spacedim> diff(face->vertex(k));
+       diff -= cell->vertex(k);
+       Assert (diff.square() == 0, ExcInternalError());
+      }
+  }
+}
+
+template <int dim, int spacedim>
+void save_mesh(const Triangulation<dim,spacedim>& tria)
+{
+  GridOut grid_out;
+  grid_out.write_gnuplot (tria, deallog.get_file_stream());
+}
+
+
+int main ()
+{
+
+  ofstream logfile("extract_boundary_mesh_03/output");
+  deallog.attach(logfile);
+  deallog.depth_console(0);
+
+
+  { // Extract the boundary of a hyper-sphere
+
+    const int dim = 3;
+    deallog << "Testing hyper_cube in dim: " << dim << "..."<< endl;
+
+    map< Triangulation<dim-1,dim>::cell_iterator,
+        Triangulation<dim,dim>::face_iterator>
+      surface_to_volume_mapping;
+    const HyperBallBoundary<dim> boundary_description;
+    Triangulation<dim> volume_mesh;
+    GridGenerator::hyper_ball(volume_mesh);
+    for (typename Triangulation<dim>::active_cell_iterator
+          cell = volume_mesh.begin_active();
+        cell != volume_mesh.end(); ++cell)
+      for (unsigned int f=0; f<GeometryInfo<dim>::faces_per_cell; ++f)
+       if (cell->at_boundary(f))
+         cell->face(f)->set_all_boundary_indicators (1);
+    volume_mesh.set_boundary (1, boundary_description);
+    volume_mesh.refine_global (1);
+
+    const HyperBallBoundary<dim-1,dim> surface_description;
+    Triangulation<dim-1,dim> boundary_mesh;
+    boundary_mesh.set_boundary (1, surface_description);
+
+    GridTools::extract_boundary_mesh (volume_mesh, boundary_mesh,
+                                     surface_to_volume_mapping);
+    deallog << volume_mesh.n_active_cells () << std::endl;
+    deallog << boundary_mesh.n_active_cells () << std::endl;
+    save_mesh(boundary_mesh);
+
+
+    test_vertices_orientation(boundary_mesh, surface_to_volume_mapping);
+    save_mesh(boundary_mesh);
+  }
+
+
+   return 0;
+ }
diff --git a/tests/codim_one/extract_boundary_mesh_03/cmp/generic b/tests/codim_one/extract_boundary_mesh_03/cmp/generic
new file mode 100644 (file)
index 0000000..70d72f9
--- /dev/null
@@ -0,0 +1,580 @@
+
+DEAL::Testing hyper_cube in dim: 3...
+DEAL::56
+DEAL::24
+-0.577350 -0.577350 -0.577350 1 1
+0.00000 -0.707107 -0.707107 1 1
+0.00000 0.00000 -1.00000 1 1
+-0.707107 0.00000 -0.707107 1 1
+-0.577350 -0.577350 -0.577350 1 1
+
+
+0.00000 -0.707107 -0.707107 1 1
+0.577350 -0.577350 -0.577350 1 1
+0.707107 0.00000 -0.707107 1 1
+0.00000 0.00000 -1.00000 1 1
+0.00000 -0.707107 -0.707107 1 1
+
+
+-0.707107 0.00000 -0.707107 1 1
+0.00000 0.00000 -1.00000 1 1
+0.00000 0.707107 -0.707107 1 1
+-0.577350 0.577350 -0.577350 1 1
+-0.707107 0.00000 -0.707107 1 1
+
+
+0.00000 0.00000 -1.00000 1 1
+0.707107 0.00000 -0.707107 1 1
+0.577350 0.577350 -0.577350 1 1
+0.00000 0.707107 -0.707107 1 1
+0.00000 0.00000 -1.00000 1 1
+
+
+0.577350 -0.577350 -0.577350 1 1
+0.707107 -0.707107 0.00000 1 1
+1.00000 0.00000 0.00000 1 1
+0.707107 0.00000 -0.707107 1 1
+0.577350 -0.577350 -0.577350 1 1
+
+
+0.707107 -0.707107 0.00000 1 1
+0.577350 -0.577350 0.577350 1 1
+0.707107 0.00000 0.707107 1 1
+1.00000 0.00000 0.00000 1 1
+0.707107 -0.707107 0.00000 1 1
+
+
+0.707107 0.00000 -0.707107 1 1
+1.00000 0.00000 0.00000 1 1
+0.707107 0.707107 0.00000 1 1
+0.577350 0.577350 -0.577350 1 1
+0.707107 0.00000 -0.707107 1 1
+
+
+1.00000 0.00000 0.00000 1 1
+0.707107 0.00000 0.707107 1 1
+0.577350 0.577350 0.577350 1 1
+0.707107 0.707107 0.00000 1 1
+1.00000 0.00000 0.00000 1 1
+
+
+-0.577350 -0.577350 0.577350 1 1
+-0.707107 0.00000 0.707107 1 1
+0.00000 0.00000 1.00000 1 1
+0.00000 -0.707107 0.707107 1 1
+-0.577350 -0.577350 0.577350 1 1
+
+
+-0.707107 0.00000 0.707107 1 1
+-0.577350 0.577350 0.577350 1 1
+0.00000 0.707107 0.707107 1 1
+0.00000 0.00000 1.00000 1 1
+-0.707107 0.00000 0.707107 1 1
+
+
+0.00000 -0.707107 0.707107 1 1
+0.00000 0.00000 1.00000 1 1
+0.707107 0.00000 0.707107 1 1
+0.577350 -0.577350 0.577350 1 1
+0.00000 -0.707107 0.707107 1 1
+
+
+0.00000 0.00000 1.00000 1 1
+0.00000 0.707107 0.707107 1 1
+0.577350 0.577350 0.577350 1 1
+0.707107 0.00000 0.707107 1 1
+0.00000 0.00000 1.00000 1 1
+
+
+-0.577350 -0.577350 -0.577350 1 1
+-0.707107 0.00000 -0.707107 1 1
+-1.00000 0.00000 0.00000 1 1
+-0.707107 -0.707107 0.00000 1 1
+-0.577350 -0.577350 -0.577350 1 1
+
+
+-0.707107 0.00000 -0.707107 1 1
+-0.577350 0.577350 -0.577350 1 1
+-0.707107 0.707107 0.00000 1 1
+-1.00000 0.00000 0.00000 1 1
+-0.707107 0.00000 -0.707107 1 1
+
+
+-0.707107 -0.707107 0.00000 1 1
+-1.00000 0.00000 0.00000 1 1
+-0.707107 0.00000 0.707107 1 1
+-0.577350 -0.577350 0.577350 1 1
+-0.707107 -0.707107 0.00000 1 1
+
+
+-1.00000 0.00000 0.00000 1 1
+-0.707107 0.707107 0.00000 1 1
+-0.577350 0.577350 0.577350 1 1
+-0.707107 0.00000 0.707107 1 1
+-1.00000 0.00000 0.00000 1 1
+
+
+-0.577350 -0.577350 -0.577350 1 1
+-0.707107 -0.707107 0.00000 1 1
+0.00000 -1.00000 0.00000 1 1
+0.00000 -0.707107 -0.707107 1 1
+-0.577350 -0.577350 -0.577350 1 1
+
+
+-0.707107 -0.707107 0.00000 1 1
+-0.577350 -0.577350 0.577350 1 1
+0.00000 -0.707107 0.707107 1 1
+0.00000 -1.00000 0.00000 1 1
+-0.707107 -0.707107 0.00000 1 1
+
+
+0.00000 -0.707107 -0.707107 1 1
+0.00000 -1.00000 0.00000 1 1
+0.707107 -0.707107 0.00000 1 1
+0.577350 -0.577350 -0.577350 1 1
+0.00000 -0.707107 -0.707107 1 1
+
+
+0.00000 -1.00000 0.00000 1 1
+0.00000 -0.707107 0.707107 1 1
+0.577350 -0.577350 0.577350 1 1
+0.707107 -0.707107 0.00000 1 1
+0.00000 -1.00000 0.00000 1 1
+
+
+-0.577350 0.577350 -0.577350 1 1
+0.00000 0.707107 -0.707107 1 1
+0.00000 1.00000 0.00000 1 1
+-0.707107 0.707107 0.00000 1 1
+-0.577350 0.577350 -0.577350 1 1
+
+
+0.00000 0.707107 -0.707107 1 1
+0.577350 0.577350 -0.577350 1 1
+0.707107 0.707107 0.00000 1 1
+0.00000 1.00000 0.00000 1 1
+0.00000 0.707107 -0.707107 1 1
+
+
+-0.707107 0.707107 0.00000 1 1
+0.00000 1.00000 0.00000 1 1
+0.00000 0.707107 0.707107 1 1
+-0.577350 0.577350 0.577350 1 1
+-0.707107 0.707107 0.00000 1 1
+
+
+0.00000 1.00000 0.00000 1 1
+0.707107 0.707107 0.00000 1 1
+0.577350 0.577350 0.577350 1 1
+0.00000 0.707107 0.707107 1 1
+0.00000 1.00000 0.00000 1 1
+
+
+DEAL::Surface cell: 1.0 with vertices:
+DEAL::  -0.577350 -0.577350 -0.577350
+DEAL::  0.00000 -0.707107 -0.707107
+DEAL::  -0.707107 0.00000 -0.707107
+DEAL::  0.00000 0.00000 -1.00000
+DEAL::Volume face: 68 with vertices:
+DEAL::  -0.577350 -0.577350 -0.577350
+DEAL::  0.00000 -0.707107 -0.707107
+DEAL::  -0.707107 0.00000 -0.707107
+DEAL::  0.00000 0.00000 -1.00000
+DEAL::Surface cell: 1.1 with vertices:
+DEAL::  0.00000 -0.707107 -0.707107
+DEAL::  0.577350 -0.577350 -0.577350
+DEAL::  0.00000 0.00000 -1.00000
+DEAL::  0.707107 0.00000 -0.707107
+DEAL::Volume face: 69 with vertices:
+DEAL::  0.00000 -0.707107 -0.707107
+DEAL::  0.577350 -0.577350 -0.577350
+DEAL::  0.00000 0.00000 -1.00000
+DEAL::  0.707107 0.00000 -0.707107
+DEAL::Surface cell: 1.2 with vertices:
+DEAL::  -0.707107 0.00000 -0.707107
+DEAL::  0.00000 0.00000 -1.00000
+DEAL::  -0.577350 0.577350 -0.577350
+DEAL::  0.00000 0.707107 -0.707107
+DEAL::Volume face: 70 with vertices:
+DEAL::  -0.707107 0.00000 -0.707107
+DEAL::  0.00000 0.00000 -1.00000
+DEAL::  -0.577350 0.577350 -0.577350
+DEAL::  0.00000 0.707107 -0.707107
+DEAL::Surface cell: 1.3 with vertices:
+DEAL::  0.00000 0.00000 -1.00000
+DEAL::  0.707107 0.00000 -0.707107
+DEAL::  0.00000 0.707107 -0.707107
+DEAL::  0.577350 0.577350 -0.577350
+DEAL::Volume face: 71 with vertices:
+DEAL::  0.00000 0.00000 -1.00000
+DEAL::  0.707107 0.00000 -0.707107
+DEAL::  0.00000 0.707107 -0.707107
+DEAL::  0.577350 0.577350 -0.577350
+DEAL::Surface cell: 1.4 with vertices:
+DEAL::  0.577350 -0.577350 -0.577350
+DEAL::  0.707107 -0.707107 0.00000
+DEAL::  0.707107 0.00000 -0.707107
+DEAL::  1.00000 0.00000 0.00000
+DEAL::Volume face: 80 with vertices:
+DEAL::  0.577350 -0.577350 -0.577350
+DEAL::  0.707107 -0.707107 0.00000
+DEAL::  0.707107 0.00000 -0.707107
+DEAL::  1.00000 0.00000 0.00000
+DEAL::Surface cell: 1.5 with vertices:
+DEAL::  0.707107 -0.707107 0.00000
+DEAL::  0.577350 -0.577350 0.577350
+DEAL::  1.00000 0.00000 0.00000
+DEAL::  0.707107 0.00000 0.707107
+DEAL::Volume face: 81 with vertices:
+DEAL::  0.707107 -0.707107 0.00000
+DEAL::  0.577350 -0.577350 0.577350
+DEAL::  1.00000 0.00000 0.00000
+DEAL::  0.707107 0.00000 0.707107
+DEAL::Surface cell: 1.6 with vertices:
+DEAL::  0.707107 0.00000 -0.707107
+DEAL::  1.00000 0.00000 0.00000
+DEAL::  0.577350 0.577350 -0.577350
+DEAL::  0.707107 0.707107 0.00000
+DEAL::Volume face: 82 with vertices:
+DEAL::  0.707107 0.00000 -0.707107
+DEAL::  1.00000 0.00000 0.00000
+DEAL::  0.577350 0.577350 -0.577350
+DEAL::  0.707107 0.707107 0.00000
+DEAL::Surface cell: 1.7 with vertices:
+DEAL::  1.00000 0.00000 0.00000
+DEAL::  0.707107 0.00000 0.707107
+DEAL::  0.707107 0.707107 0.00000
+DEAL::  0.577350 0.577350 0.577350
+DEAL::Volume face: 83 with vertices:
+DEAL::  1.00000 0.00000 0.00000
+DEAL::  0.707107 0.00000 0.707107
+DEAL::  0.707107 0.707107 0.00000
+DEAL::  0.577350 0.577350 0.577350
+DEAL::Surface cell: 1.8 with vertices:
+DEAL::  -0.577350 -0.577350 0.577350
+DEAL::  -0.707107 0.00000 0.707107
+DEAL::  0.00000 -0.707107 0.707107
+DEAL::  0.00000 0.00000 1.00000
+DEAL::Volume face: 92 with vertices:
+DEAL::  -0.577350 -0.577350 0.577350
+DEAL::  -0.707107 0.00000 0.707107
+DEAL::  0.00000 -0.707107 0.707107
+DEAL::  0.00000 0.00000 1.00000
+DEAL::Surface cell: 1.9 with vertices:
+DEAL::  -0.707107 0.00000 0.707107
+DEAL::  -0.577350 0.577350 0.577350
+DEAL::  0.00000 0.00000 1.00000
+DEAL::  0.00000 0.707107 0.707107
+DEAL::Volume face: 93 with vertices:
+DEAL::  -0.707107 0.00000 0.707107
+DEAL::  -0.577350 0.577350 0.577350
+DEAL::  0.00000 0.00000 1.00000
+DEAL::  0.00000 0.707107 0.707107
+DEAL::Surface cell: 1.10 with vertices:
+DEAL::  0.00000 -0.707107 0.707107
+DEAL::  0.00000 0.00000 1.00000
+DEAL::  0.577350 -0.577350 0.577350
+DEAL::  0.707107 0.00000 0.707107
+DEAL::Volume face: 94 with vertices:
+DEAL::  0.00000 -0.707107 0.707107
+DEAL::  0.00000 0.00000 1.00000
+DEAL::  0.577350 -0.577350 0.577350
+DEAL::  0.707107 0.00000 0.707107
+DEAL::Surface cell: 1.11 with vertices:
+DEAL::  0.00000 0.00000 1.00000
+DEAL::  0.00000 0.707107 0.707107
+DEAL::  0.707107 0.00000 0.707107
+DEAL::  0.577350 0.577350 0.577350
+DEAL::Volume face: 95 with vertices:
+DEAL::  0.00000 0.00000 1.00000
+DEAL::  0.00000 0.707107 0.707107
+DEAL::  0.707107 0.00000 0.707107
+DEAL::  0.577350 0.577350 0.577350
+DEAL::Surface cell: 1.12 with vertices:
+DEAL::  -0.577350 -0.577350 -0.577350
+DEAL::  -0.707107 0.00000 -0.707107
+DEAL::  -0.707107 -0.707107 0.00000
+DEAL::  -1.00000 0.00000 0.00000
+DEAL::Volume face: 64 with vertices:
+DEAL::  -0.577350 -0.577350 -0.577350
+DEAL::  -0.707107 0.00000 -0.707107
+DEAL::  -0.707107 -0.707107 0.00000
+DEAL::  -1.00000 0.00000 0.00000
+DEAL::Surface cell: 1.13 with vertices:
+DEAL::  -0.707107 0.00000 -0.707107
+DEAL::  -0.577350 0.577350 -0.577350
+DEAL::  -1.00000 0.00000 0.00000
+DEAL::  -0.707107 0.707107 0.00000
+DEAL::Volume face: 65 with vertices:
+DEAL::  -0.707107 0.00000 -0.707107
+DEAL::  -0.577350 0.577350 -0.577350
+DEAL::  -1.00000 0.00000 0.00000
+DEAL::  -0.707107 0.707107 0.00000
+DEAL::Surface cell: 1.14 with vertices:
+DEAL::  -0.707107 -0.707107 0.00000
+DEAL::  -1.00000 0.00000 0.00000
+DEAL::  -0.577350 -0.577350 0.577350
+DEAL::  -0.707107 0.00000 0.707107
+DEAL::Volume face: 66 with vertices:
+DEAL::  -0.707107 -0.707107 0.00000
+DEAL::  -1.00000 0.00000 0.00000
+DEAL::  -0.577350 -0.577350 0.577350
+DEAL::  -0.707107 0.00000 0.707107
+DEAL::Surface cell: 1.15 with vertices:
+DEAL::  -1.00000 0.00000 0.00000
+DEAL::  -0.707107 0.707107 0.00000
+DEAL::  -0.707107 0.00000 0.707107
+DEAL::  -0.577350 0.577350 0.577350
+DEAL::Volume face: 67 with vertices:
+DEAL::  -1.00000 0.00000 0.00000
+DEAL::  -0.707107 0.707107 0.00000
+DEAL::  -0.707107 0.00000 0.707107
+DEAL::  -0.577350 0.577350 0.577350
+DEAL::Surface cell: 1.16 with vertices:
+DEAL::  -0.577350 -0.577350 -0.577350
+DEAL::  -0.707107 -0.707107 0.00000
+DEAL::  0.00000 -0.707107 -0.707107
+DEAL::  0.00000 -1.00000 0.00000
+DEAL::Volume face: 60 with vertices:
+DEAL::  -0.577350 -0.577350 -0.577350
+DEAL::  -0.707107 -0.707107 0.00000
+DEAL::  0.00000 -0.707107 -0.707107
+DEAL::  0.00000 -1.00000 0.00000
+DEAL::Surface cell: 1.17 with vertices:
+DEAL::  -0.707107 -0.707107 0.00000
+DEAL::  -0.577350 -0.577350 0.577350
+DEAL::  0.00000 -1.00000 0.00000
+DEAL::  0.00000 -0.707107 0.707107
+DEAL::Volume face: 61 with vertices:
+DEAL::  -0.707107 -0.707107 0.00000
+DEAL::  -0.577350 -0.577350 0.577350
+DEAL::  0.00000 -1.00000 0.00000
+DEAL::  0.00000 -0.707107 0.707107
+DEAL::Surface cell: 1.18 with vertices:
+DEAL::  0.00000 -0.707107 -0.707107
+DEAL::  0.00000 -1.00000 0.00000
+DEAL::  0.577350 -0.577350 -0.577350
+DEAL::  0.707107 -0.707107 0.00000
+DEAL::Volume face: 62 with vertices:
+DEAL::  0.00000 -0.707107 -0.707107
+DEAL::  0.00000 -1.00000 0.00000
+DEAL::  0.577350 -0.577350 -0.577350
+DEAL::  0.707107 -0.707107 0.00000
+DEAL::Surface cell: 1.19 with vertices:
+DEAL::  0.00000 -1.00000 0.00000
+DEAL::  0.00000 -0.707107 0.707107
+DEAL::  0.707107 -0.707107 0.00000
+DEAL::  0.577350 -0.577350 0.577350
+DEAL::Volume face: 63 with vertices:
+DEAL::  0.00000 -1.00000 0.00000
+DEAL::  0.00000 -0.707107 0.707107
+DEAL::  0.707107 -0.707107 0.00000
+DEAL::  0.577350 -0.577350 0.577350
+DEAL::Surface cell: 1.20 with vertices:
+DEAL::  -0.577350 0.577350 -0.577350
+DEAL::  0.00000 0.707107 -0.707107
+DEAL::  -0.707107 0.707107 0.00000
+DEAL::  0.00000 1.00000 0.00000
+DEAL::Volume face: 108 with vertices:
+DEAL::  -0.577350 0.577350 -0.577350
+DEAL::  0.00000 0.707107 -0.707107
+DEAL::  -0.707107 0.707107 0.00000
+DEAL::  0.00000 1.00000 0.00000
+DEAL::Surface cell: 1.21 with vertices:
+DEAL::  0.00000 0.707107 -0.707107
+DEAL::  0.577350 0.577350 -0.577350
+DEAL::  0.00000 1.00000 0.00000
+DEAL::  0.707107 0.707107 0.00000
+DEAL::Volume face: 109 with vertices:
+DEAL::  0.00000 0.707107 -0.707107
+DEAL::  0.577350 0.577350 -0.577350
+DEAL::  0.00000 1.00000 0.00000
+DEAL::  0.707107 0.707107 0.00000
+DEAL::Surface cell: 1.22 with vertices:
+DEAL::  -0.707107 0.707107 0.00000
+DEAL::  0.00000 1.00000 0.00000
+DEAL::  -0.577350 0.577350 0.577350
+DEAL::  0.00000 0.707107 0.707107
+DEAL::Volume face: 110 with vertices:
+DEAL::  -0.707107 0.707107 0.00000
+DEAL::  0.00000 1.00000 0.00000
+DEAL::  -0.577350 0.577350 0.577350
+DEAL::  0.00000 0.707107 0.707107
+DEAL::Surface cell: 1.23 with vertices:
+DEAL::  0.00000 1.00000 0.00000
+DEAL::  0.707107 0.707107 0.00000
+DEAL::  0.00000 0.707107 0.707107
+DEAL::  0.577350 0.577350 0.577350
+DEAL::Volume face: 111 with vertices:
+DEAL::  0.00000 1.00000 0.00000
+DEAL::  0.707107 0.707107 0.00000
+DEAL::  0.00000 0.707107 0.707107
+DEAL::  0.577350 0.577350 0.577350
+-0.577350 -0.577350 -0.577350 1 1
+0.00000 -0.707107 -0.707107 1 1
+0.00000 0.00000 -1.00000 1 1
+-0.707107 0.00000 -0.707107 1 1
+-0.577350 -0.577350 -0.577350 1 1
+
+
+0.00000 -0.707107 -0.707107 1 1
+0.577350 -0.577350 -0.577350 1 1
+0.707107 0.00000 -0.707107 1 1
+0.00000 0.00000 -1.00000 1 1
+0.00000 -0.707107 -0.707107 1 1
+
+
+-0.707107 0.00000 -0.707107 1 1
+0.00000 0.00000 -1.00000 1 1
+0.00000 0.707107 -0.707107 1 1
+-0.577350 0.577350 -0.577350 1 1
+-0.707107 0.00000 -0.707107 1 1
+
+
+0.00000 0.00000 -1.00000 1 1
+0.707107 0.00000 -0.707107 1 1
+0.577350 0.577350 -0.577350 1 1
+0.00000 0.707107 -0.707107 1 1
+0.00000 0.00000 -1.00000 1 1
+
+
+0.577350 -0.577350 -0.577350 1 1
+0.707107 -0.707107 0.00000 1 1
+1.00000 0.00000 0.00000 1 1
+0.707107 0.00000 -0.707107 1 1
+0.577350 -0.577350 -0.577350 1 1
+
+
+0.707107 -0.707107 0.00000 1 1
+0.577350 -0.577350 0.577350 1 1
+0.707107 0.00000 0.707107 1 1
+1.00000 0.00000 0.00000 1 1
+0.707107 -0.707107 0.00000 1 1
+
+
+0.707107 0.00000 -0.707107 1 1
+1.00000 0.00000 0.00000 1 1
+0.707107 0.707107 0.00000 1 1
+0.577350 0.577350 -0.577350 1 1
+0.707107 0.00000 -0.707107 1 1
+
+
+1.00000 0.00000 0.00000 1 1
+0.707107 0.00000 0.707107 1 1
+0.577350 0.577350 0.577350 1 1
+0.707107 0.707107 0.00000 1 1
+1.00000 0.00000 0.00000 1 1
+
+
+-0.577350 -0.577350 0.577350 1 1
+-0.707107 0.00000 0.707107 1 1
+0.00000 0.00000 1.00000 1 1
+0.00000 -0.707107 0.707107 1 1
+-0.577350 -0.577350 0.577350 1 1
+
+
+-0.707107 0.00000 0.707107 1 1
+-0.577350 0.577350 0.577350 1 1
+0.00000 0.707107 0.707107 1 1
+0.00000 0.00000 1.00000 1 1
+-0.707107 0.00000 0.707107 1 1
+
+
+0.00000 -0.707107 0.707107 1 1
+0.00000 0.00000 1.00000 1 1
+0.707107 0.00000 0.707107 1 1
+0.577350 -0.577350 0.577350 1 1
+0.00000 -0.707107 0.707107 1 1
+
+
+0.00000 0.00000 1.00000 1 1
+0.00000 0.707107 0.707107 1 1
+0.577350 0.577350 0.577350 1 1
+0.707107 0.00000 0.707107 1 1
+0.00000 0.00000 1.00000 1 1
+
+
+-0.577350 -0.577350 -0.577350 1 1
+-0.707107 0.00000 -0.707107 1 1
+-1.00000 0.00000 0.00000 1 1
+-0.707107 -0.707107 0.00000 1 1
+-0.577350 -0.577350 -0.577350 1 1
+
+
+-0.707107 0.00000 -0.707107 1 1
+-0.577350 0.577350 -0.577350 1 1
+-0.707107 0.707107 0.00000 1 1
+-1.00000 0.00000 0.00000 1 1
+-0.707107 0.00000 -0.707107 1 1
+
+
+-0.707107 -0.707107 0.00000 1 1
+-1.00000 0.00000 0.00000 1 1
+-0.707107 0.00000 0.707107 1 1
+-0.577350 -0.577350 0.577350 1 1
+-0.707107 -0.707107 0.00000 1 1
+
+
+-1.00000 0.00000 0.00000 1 1
+-0.707107 0.707107 0.00000 1 1
+-0.577350 0.577350 0.577350 1 1
+-0.707107 0.00000 0.707107 1 1
+-1.00000 0.00000 0.00000 1 1
+
+
+-0.577350 -0.577350 -0.577350 1 1
+-0.707107 -0.707107 0.00000 1 1
+0.00000 -1.00000 0.00000 1 1
+0.00000 -0.707107 -0.707107 1 1
+-0.577350 -0.577350 -0.577350 1 1
+
+
+-0.707107 -0.707107 0.00000 1 1
+-0.577350 -0.577350 0.577350 1 1
+0.00000 -0.707107 0.707107 1 1
+0.00000 -1.00000 0.00000 1 1
+-0.707107 -0.707107 0.00000 1 1
+
+
+0.00000 -0.707107 -0.707107 1 1
+0.00000 -1.00000 0.00000 1 1
+0.707107 -0.707107 0.00000 1 1
+0.577350 -0.577350 -0.577350 1 1
+0.00000 -0.707107 -0.707107 1 1
+
+
+0.00000 -1.00000 0.00000 1 1
+0.00000 -0.707107 0.707107 1 1
+0.577350 -0.577350 0.577350 1 1
+0.707107 -0.707107 0.00000 1 1
+0.00000 -1.00000 0.00000 1 1
+
+
+-0.577350 0.577350 -0.577350 1 1
+0.00000 0.707107 -0.707107 1 1
+0.00000 1.00000 0.00000 1 1
+-0.707107 0.707107 0.00000 1 1
+-0.577350 0.577350 -0.577350 1 1
+
+
+0.00000 0.707107 -0.707107 1 1
+0.577350 0.577350 -0.577350 1 1
+0.707107 0.707107 0.00000 1 1
+0.00000 1.00000 0.00000 1 1
+0.00000 0.707107 -0.707107 1 1
+
+
+-0.707107 0.707107 0.00000 1 1
+0.00000 1.00000 0.00000 1 1
+0.00000 0.707107 0.707107 1 1
+-0.577350 0.577350 0.577350 1 1
+-0.707107 0.707107 0.00000 1 1
+
+
+0.00000 1.00000 0.00000 1 1
+0.707107 0.707107 0.00000 1 1
+0.577350 0.577350 0.577350 1 1
+0.00000 0.707107 0.707107 1 1
+0.00000 1.00000 0.00000 1 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.