]> https://gitweb.dealii.org/ - dealii-svn.git/commitdiff
new tests for MGTransferSelect
authorjanssen <janssen@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 3 Mar 2010 22:30:48 +0000 (22:30 +0000)
committerjanssen <janssen@0785d39b-7218-0410-832d-ea1e28bc413d>
Wed, 3 Mar 2010 22:30:48 +0000 (22:30 +0000)
git-svn-id: https://svn.dealii.org/trunk@20735 0785d39b-7218-0410-832d-ea1e28bc413d

tests/multigrid/transfer_system_04.cc [new file with mode: 0644]
tests/multigrid/transfer_system_04/cmp/generic [new file with mode: 0644]
tests/multigrid/transfer_system_05.cc [new file with mode: 0644]
tests/multigrid/transfer_system_05/cmp/generic [new file with mode: 0644]

diff --git a/tests/multigrid/transfer_system_04.cc b/tests/multigrid/transfer_system_04.cc
new file mode 100644 (file)
index 0000000..6f99ca3
--- /dev/null
@@ -0,0 +1,141 @@
+//----------------------------------------------------------------------------
+//    transfer.cc,v 1.13 2005/12/30 16:07:03 guido Exp
+//    Version:
+//
+//    Copyright (C) 2000 - 2007, 2009, 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.
+//
+//----------------------------------------------------------------------------
+
+// like _03, but with a TransferSelect that selects the first two vector components as the first block
+
+#include "../tests.h"
+#include <base/logstream.h>
+#include <lac/vector.h>
+#include <lac/block_vector.h>
+#include <grid/tria.h>
+#include <grid/grid_generator.h>
+#include <dofs/dof_renumbering.h>
+#include <dofs/dof_tools.h>
+#include <fe/fe_q.h>
+#include <fe/fe_system.h>
+#include <multigrid/mg_dof_handler.h>
+#include <multigrid/mg_transfer.h>
+#include <multigrid/mg_transfer_component.h>
+#include <multigrid/mg_tools.h>
+#include <multigrid/mg_level_object.h>
+
+#include <fstream>
+#include <iomanip>
+#include <iomanip>
+#include <algorithm>
+
+using namespace std;
+
+template <int dim, typename number, int spacedim>
+void
+reinit_vector (const dealii::MGDoFHandler<dim,spacedim> &mg_dof,
+              MGLevelObject<dealii::Vector<number> > &v)
+{
+  for (unsigned int level=v.get_minlevel();
+       level<=v.get_maxlevel();++level)
+    {
+      unsigned int n = mg_dof.n_dofs (level);
+      v[level].reinit(n);
+    }
+
+}
+
+
+template <typename Transfer>
+void
+make_matrix (const Transfer &transfer,
+            const unsigned int high_level,
+            FullMatrix<double> &matrix)
+{
+  Vector<double> src (matrix.n());
+  Vector<double> dst (matrix.m());
+  for (unsigned int i=0; i<src.size(); ++i)
+    {
+      src = 0;
+      src(i) = 1;
+      transfer.prolongate (high_level, dst, src);
+      for (unsigned int j=0; j<dst.size(); ++j)
+       matrix(j,i) = dst(j);
+    }
+}
+
+
+
+void print_matrix (const FullMatrix<double> &m)
+{
+  for (unsigned int i=0; i<m.m(); ++i)
+    {
+      for (unsigned int j=0; j<m.n(); ++j)
+       deallog << m(i,j) << ' ';
+      deallog << std::endl;
+    }
+}
+
+
+
+
+template <int dim>
+void check (const FiniteElement<dim>& fe)
+{
+  deallog << fe.get_name() << std::endl;
+
+  Triangulation<dim> tr;
+  GridGenerator::hyper_cube(tr);
+  tr.refine_global(2);
+
+  MGDoFHandler<dim> mg_dof_handler(tr);
+  mg_dof_handler.distribute_dofs(fe);
+
+  std::vector<unsigned int> block_component(3,0);
+  block_component[2]=1;
+
+  DoFRenumbering::component_wise (mg_dof_handler, block_component);
+  for (unsigned int level=0; level<tr.n_levels(); ++level)
+    DoFRenumbering::component_wise (mg_dof_handler, level, block_component);
+
+  MGTransferSelect<double> transfer;
+
+  transfer.build_matrices(mg_dof_handler, mg_dof_handler,
+                         0, 0,
+                         block_component, block_component);
+
+                                  // use only the first half of all
+                                  // components
+  std::vector<std::vector<unsigned int> > dofs_per_block(tr.n_levels(), std::vector<unsigned int>(2));
+  MGTools::count_dofs_per_block(mg_dof_handler, dofs_per_block, block_component);
+  FullMatrix<double> prolong_0_1 (dofs_per_block[1][0],dofs_per_block[0][0]);
+  FullMatrix<double> prolong_1_2 (dofs_per_block[2][0],dofs_per_block[1][0]);
+
+  deallog << "Level 0->1" << std::endl;
+  make_matrix (transfer, 1, prolong_0_1);
+  print_matrix (prolong_0_1);
+
+  deallog << std::endl;
+
+  deallog << "Level 1->2" << std::endl;
+  make_matrix (transfer, 2, prolong_1_2);
+  print_matrix (prolong_1_2);
+}
+
+
+int main()
+{
+  std::ofstream logfile("transfer_system_04/output");
+  deallog << std::setprecision(4);
+  deallog.attach(logfile);
+  deallog.depth_console(0);
+  deallog.threshold_double(1.e-10);
+
+//TODO: do in 1d
+  check (FESystem<2>(FE_Q<2>(1),3));
+}
diff --git a/tests/multigrid/transfer_system_04/cmp/generic b/tests/multigrid/transfer_system_04/cmp/generic
new file mode 100644 (file)
index 0000000..40097b8
--- /dev/null
@@ -0,0 +1,73 @@
+
+DEAL::FESystem<2>[FE_Q<2>(1)^2]
+DEAL::Level 0->1
+DEAL::1.000 0 0 0 0 0 0 0 
+DEAL::0.5000 0.5000 0 0 0 0 0 0 
+DEAL::0.5000 0 0.5000 0 0 0 0 0 
+DEAL::0.2500 0.2500 0.2500 0.2500 0 0 0 0 
+DEAL::0 1.000 0 0 0 0 0 0 
+DEAL::0 0.5000 0 0.5000 0 0 0 0 
+DEAL::0 0 1.000 0 0 0 0 0 
+DEAL::0 0 0.5000 0.5000 0 0 0 0 
+DEAL::0 0 0 1.000 0 0 0 0 
+DEAL::0 0 0 0 1.000 0 0 0 
+DEAL::0 0 0 0 0.5000 0.5000 0 0 
+DEAL::0 0 0 0 0.5000 0 0.5000 0 
+DEAL::0 0 0 0 0.2500 0.2500 0.2500 0.2500 
+DEAL::0 0 0 0 0 1.000 0 0 
+DEAL::0 0 0 0 0 0.5000 0 0.5000 
+DEAL::0 0 0 0 0 0 1.000 0 
+DEAL::0 0 0 0 0 0 0.5000 0.5000 
+DEAL::0 0 0 0 0 0 0 1.000 
+DEAL::
+DEAL::Level 1->2
+DEAL::1.000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0.5000 0.5000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0.5000 0 0.5000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0.2500 0.2500 0.2500 0.2500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 1.000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0.5000 0 0.5000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 1.000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0.5000 0.5000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 1.000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0.5000 0 0 0.5000 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0.2500 0 0.2500 0.2500 0.2500 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 1.000 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0.5000 0.5000 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0.5000 0 0.5000 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 1.000 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0.5000 0 0 0 0.5000 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0.2500 0.2500 0 0 0.2500 0.2500 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0.5000 0 0 0 0.5000 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 1.000 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0.5000 0.5000 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 1.000 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0.2500 0 0.2500 0 0.2500 0.2500 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0.5000 0 0 0.5000 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0.5000 0.5000 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 1.000 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 1.000 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0.5000 0.5000 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0.5000 0 0.5000 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0.2500 0.2500 0.2500 0.2500 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 1.000 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0.5000 0 0.5000 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 1.000 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0.5000 0.5000 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 1.000 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0.5000 0 0 0.5000 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0.2500 0 0.2500 0.2500 0.2500 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 1.000 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.5000 0.5000 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.5000 0 0.5000 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.000 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0.5000 0 0 0 0.5000 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0.2500 0.2500 0 0 0.2500 0.2500 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.5000 0 0 0 0.5000 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.000 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.5000 0.5000 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.000 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.2500 0 0.2500 0 0.2500 0.2500 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.5000 0 0 0.5000 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.5000 0.5000 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.000 
diff --git a/tests/multigrid/transfer_system_05.cc b/tests/multigrid/transfer_system_05.cc
new file mode 100644 (file)
index 0000000..a015248
--- /dev/null
@@ -0,0 +1,120 @@
+//----------------------------------------------------------------------------
+//    transfer.cc,v 1.13 2005/12/30 16:07:03 guido Exp
+//    Version:
+//
+//    Copyright (C) 2000 - 2007, 2009, 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.
+//
+//----------------------------------------------------------------------------
+
+// like _04, but checks the copy_to_mg and copy_from_mg of MGTransferSelect
+
+#include "../tests.h"
+#include <base/logstream.h>
+#include <lac/vector.h>
+#include <lac/block_vector.h>
+#include <grid/tria.h>
+#include <grid/grid_generator.h>
+#include <dofs/dof_renumbering.h>
+#include <dofs/dof_tools.h>
+#include <fe/fe_q.h>
+#include <fe/fe_system.h>
+#include <multigrid/mg_dof_handler.h>
+#include <multigrid/mg_transfer.h>
+#include <multigrid/mg_transfer_component.h>
+#include <multigrid/mg_tools.h>
+#include <multigrid/mg_level_object.h>
+
+#include <fstream>
+#include <iomanip>
+#include <iomanip>
+#include <algorithm>
+
+using namespace std;
+
+
+template <int dim>
+void check (const FiniteElement<dim>& fe, const unsigned int selected_block)
+{
+  deallog << fe.get_name() << std::endl;
+
+  Triangulation<dim> tr;
+  GridGenerator::hyper_cube(tr);
+  tr.refine_global(2);
+
+  MGDoFHandler<dim> mg_dof_handler(tr);
+  mg_dof_handler.distribute_dofs(fe);
+
+  std::vector<unsigned int> block_component(5,0);
+  block_component[2]=1;
+  block_component[3]=1;
+  block_component[4]=2;
+
+  DoFRenumbering::component_wise (mg_dof_handler, block_component);
+  for (unsigned int level=0; level<tr.n_levels(); ++level)
+    DoFRenumbering::component_wise (mg_dof_handler, level, block_component);
+
+
+  MGTransferSelect<double> transfer;
+
+  transfer.build_matrices(mg_dof_handler, mg_dof_handler,
+                         selected_block, selected_block,
+                         block_component, block_component);
+
+                                  // use only the first half of all
+                                  // components
+  std::vector<unsigned int> dofs_per_block(3);
+  DoFTools::count_dofs_per_block(mg_dof_handler, dofs_per_block, block_component);
+  std::vector<std::vector<unsigned int> > mg_dofs_per_block(tr.n_levels(), std::vector<unsigned int>(3));
+  MGTools::count_dofs_per_block(mg_dof_handler, mg_dofs_per_block, block_component);
+
+  deallog << "Global  dofs:";
+  for (unsigned int i=0;i<dofs_per_block.size();++i)
+    deallog << ' ' << dofs_per_block[i];
+  deallog << std::endl;
+  for (unsigned int l=0;l<mg_dofs_per_block.size();++l)
+    {
+      deallog << "Level " << l << " dofs:";
+      for (unsigned int i=0;i<mg_dofs_per_block[l].size();++i)
+       deallog << ' ' << mg_dofs_per_block[l][i];
+      deallog << std::endl;
+    }
+
+  BlockVector<double> u;
+  u.reinit (dofs_per_block);
+  for (unsigned int i=0;i<u.size();++i)
+    u(i) = i;
+  
+  MGLevelObject<Vector<double> > v(0,tr.n_levels()-1);
+  for(unsigned int l=0; l<tr.n_levels()-1; ++l)
+    v[l].reinit(mg_dofs_per_block[l][2]);
+
+
+  transfer.copy_to_mg(mg_dof_handler, v, u);
+  for(unsigned int l=0; l<tr.n_levels(); ++l)
+  {
+    deallog << "Level " << l << std::endl;
+    for (unsigned int i=0; i<v[l].size();++i)
+      deallog << ' ' << (int) v[l](i);
+    deallog << std::endl;
+  }
+}
+
+
+int main()
+{
+  std::ofstream logfile("transfer_system_05/output");
+  deallog << std::setprecision(4);
+  deallog.attach(logfile);
+  deallog.depth_console(0);
+  deallog.threshold_double(1.e-10);
+
+//TODO: do in 1d
+  check (FESystem<2>(FE_Q<2>(1),5),0);
+  check (FESystem<2>(FE_Q<2>(1),5),1);
+  check (FESystem<2>(FE_Q<2>(1),5),2);
+}
diff --git a/tests/multigrid/transfer_system_05/cmp/generic b/tests/multigrid/transfer_system_05/cmp/generic
new file mode 100644 (file)
index 0000000..40097b8
--- /dev/null
@@ -0,0 +1,73 @@
+
+DEAL::FESystem<2>[FE_Q<2>(1)^2]
+DEAL::Level 0->1
+DEAL::1.000 0 0 0 0 0 0 0 
+DEAL::0.5000 0.5000 0 0 0 0 0 0 
+DEAL::0.5000 0 0.5000 0 0 0 0 0 
+DEAL::0.2500 0.2500 0.2500 0.2500 0 0 0 0 
+DEAL::0 1.000 0 0 0 0 0 0 
+DEAL::0 0.5000 0 0.5000 0 0 0 0 
+DEAL::0 0 1.000 0 0 0 0 0 
+DEAL::0 0 0.5000 0.5000 0 0 0 0 
+DEAL::0 0 0 1.000 0 0 0 0 
+DEAL::0 0 0 0 1.000 0 0 0 
+DEAL::0 0 0 0 0.5000 0.5000 0 0 
+DEAL::0 0 0 0 0.5000 0 0.5000 0 
+DEAL::0 0 0 0 0.2500 0.2500 0.2500 0.2500 
+DEAL::0 0 0 0 0 1.000 0 0 
+DEAL::0 0 0 0 0 0.5000 0 0.5000 
+DEAL::0 0 0 0 0 0 1.000 0 
+DEAL::0 0 0 0 0 0 0.5000 0.5000 
+DEAL::0 0 0 0 0 0 0 1.000 
+DEAL::
+DEAL::Level 1->2
+DEAL::1.000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0.5000 0.5000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0.5000 0 0.5000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0.2500 0.2500 0.2500 0.2500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 1.000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0.5000 0 0.5000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 1.000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0.5000 0.5000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 1.000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0.5000 0 0 0.5000 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0.2500 0 0.2500 0.2500 0.2500 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 1.000 0 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0.5000 0.5000 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0.5000 0 0.5000 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 1.000 0 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0.5000 0 0 0 0.5000 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0.2500 0.2500 0 0 0.2500 0.2500 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0.5000 0 0 0 0.5000 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 1.000 0 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0.5000 0.5000 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 1.000 0 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0.2500 0 0.2500 0 0.2500 0.2500 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0.5000 0 0 0.5000 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0.5000 0.5000 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 1.000 0 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 1.000 0 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0.5000 0.5000 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0.5000 0 0.5000 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0.2500 0.2500 0.2500 0.2500 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 1.000 0 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0.5000 0 0.5000 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 1.000 0 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0.5000 0.5000 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 1.000 0 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0.5000 0 0 0.5000 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0.2500 0 0.2500 0.2500 0.2500 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 1.000 0 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.5000 0.5000 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.5000 0 0.5000 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.000 0 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0.5000 0 0 0 0.5000 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0.2500 0.2500 0 0 0.2500 0.2500 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.5000 0 0 0 0.5000 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.000 0 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.5000 0.5000 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.000 0 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.2500 0 0.2500 0 0.2500 0.2500 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.5000 0 0 0.5000 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.5000 0.5000 
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 1.000 

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.