]> https://gitweb.dealii.org/ - dealii.git/commitdiff
Add tests.
authorWolfgang Bangerth <bangerth@colostate.edu>
Fri, 25 Sep 2020 22:01:05 +0000 (16:01 -0600)
committerWolfgang Bangerth <bangerth@colostate.edu>
Wed, 30 Sep 2020 13:01:20 +0000 (07:01 -0600)
tests/sparsity/block_sparsity_pattern_write_gnuplot_01.cc [new file with mode: 0644]
tests/sparsity/block_sparsity_pattern_write_gnuplot_01.output [new file with mode: 0644]
tests/sparsity/block_sparsity_pattern_write_svg_01.cc [new file with mode: 0644]
tests/sparsity/block_sparsity_pattern_write_svg_01.output [new file with mode: 0644]

diff --git a/tests/sparsity/block_sparsity_pattern_write_gnuplot_01.cc b/tests/sparsity/block_sparsity_pattern_write_gnuplot_01.cc
new file mode 100644 (file)
index 0000000..25fa302
--- /dev/null
@@ -0,0 +1,83 @@
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2008 - 2018 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.
+//
+// ---------------------------------------------------------------------
+
+
+
+// check BlockSparsityPattern::print_gnuplot()
+
+#include <deal.II/dofs/dof_handler.h>
+#include <deal.II/dofs/dof_renumbering.h>
+#include <deal.II/dofs/dof_tools.h>
+
+#include <deal.II/fe/fe_q.h>
+#include <deal.II/fe/fe_system.h>
+
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/tria.h>
+
+#include <deal.II/lac/block_sparsity_pattern.h>
+
+#include "../tests.h"
+
+int
+main()
+{
+  initlog();
+
+  const int          dim = 2;
+  Triangulation<dim> tria;
+  GridGenerator::hyper_cube(tria);
+
+  const unsigned int degree = 1;
+  FESystem<dim>      fe(FE_Q<dim>(degree + 1), dim, FE_Q<dim>(degree), 1);
+  DoFHandler<dim>    dof_handler(tria);
+  dof_handler.distribute_dofs(fe);
+  DoFRenumbering::Cuthill_McKee(dof_handler);
+  DoFRenumbering::component_wise(dof_handler);
+
+  std::vector<unsigned int> block_component(dim + 1, 0);
+  block_component[dim] = 1;
+  const std::vector<types::global_dof_index> dofs_per_block =
+    DoFTools::count_dofs_per_fe_block(dof_handler, block_component);
+  const unsigned int n_u = dofs_per_block[0];
+  const unsigned int n_p = dofs_per_block[1];
+
+  BlockSparsityPattern sparsity_pattern;
+  {
+    BlockDynamicSparsityPattern dsp(2, 2);
+
+    dsp.block(0, 0).reinit(n_u, n_u);
+    dsp.block(1, 0).reinit(n_p, n_u);
+    dsp.block(0, 1).reinit(n_u, n_p);
+    dsp.block(1, 1).reinit(n_p, n_p);
+
+    dsp.collect_sizes();
+
+    Table<2, DoFTools::Coupling> coupling(dim + 1, dim + 1);
+
+    for (unsigned int c = 0; c < dim + 1; ++c)
+      for (unsigned int d = 0; d < dim + 1; ++d)
+        if (!((c == dim) && (d == dim)))
+          coupling[c][d] = DoFTools::always;
+        else
+          coupling[c][d] = DoFTools::none;
+
+    DoFTools::make_sparsity_pattern(dof_handler, coupling, dsp);
+
+    sparsity_pattern.copy_from(dsp);
+  }
+
+  sparsity_pattern.print_gnuplot(deallog.get_file_stream());
+}
diff --git a/tests/sparsity/block_sparsity_pattern_write_gnuplot_01.output b/tests/sparsity/block_sparsity_pattern_write_gnuplot_01.output
new file mode 100644 (file)
index 0000000..d8d9a97
--- /dev/null
@@ -0,0 +1,473 @@
+
+0 0
+1 0
+2 0
+3 0
+4 0
+5 0
+6 0
+7 0
+8 0
+9 0
+10 0
+11 0
+12 0
+13 0
+14 0
+15 0
+16 0
+17 0
+18 0
+19 0
+20 0
+21 0
+0 -1
+1 -1
+2 -1
+3 -1
+4 -1
+5 -1
+6 -1
+7 -1
+8 -1
+9 -1
+10 -1
+11 -1
+12 -1
+13 -1
+14 -1
+15 -1
+16 -1
+17 -1
+18 -1
+19 -1
+20 -1
+21 -1
+0 -2
+1 -2
+2 -2
+3 -2
+4 -2
+5 -2
+6 -2
+7 -2
+8 -2
+9 -2
+10 -2
+11 -2
+12 -2
+13 -2
+14 -2
+15 -2
+16 -2
+17 -2
+18 -2
+19 -2
+20 -2
+21 -2
+0 -3
+1 -3
+2 -3
+3 -3
+4 -3
+5 -3
+6 -3
+7 -3
+8 -3
+9 -3
+10 -3
+11 -3
+12 -3
+13 -3
+14 -3
+15 -3
+16 -3
+17 -3
+18 -3
+19 -3
+20 -3
+21 -3
+0 -4
+1 -4
+2 -4
+3 -4
+4 -4
+5 -4
+6 -4
+7 -4
+8 -4
+9 -4
+10 -4
+11 -4
+12 -4
+13 -4
+14 -4
+15 -4
+16 -4
+17 -4
+18 -4
+19 -4
+20 -4
+21 -4
+0 -5
+1 -5
+2 -5
+3 -5
+4 -5
+5 -5
+6 -5
+7 -5
+8 -5
+9 -5
+10 -5
+11 -5
+12 -5
+13 -5
+14 -5
+15 -5
+16 -5
+17 -5
+18 -5
+19 -5
+20 -5
+21 -5
+0 -6
+1 -6
+2 -6
+3 -6
+4 -6
+5 -6
+6 -6
+7 -6
+8 -6
+9 -6
+10 -6
+11 -6
+12 -6
+13 -6
+14 -6
+15 -6
+16 -6
+17 -6
+18 -6
+19 -6
+20 -6
+21 -6
+0 -7
+1 -7
+2 -7
+3 -7
+4 -7
+5 -7
+6 -7
+7 -7
+8 -7
+9 -7
+10 -7
+11 -7
+12 -7
+13 -7
+14 -7
+15 -7
+16 -7
+17 -7
+18 -7
+19 -7
+20 -7
+21 -7
+0 -8
+1 -8
+2 -8
+3 -8
+4 -8
+5 -8
+6 -8
+7 -8
+8 -8
+9 -8
+10 -8
+11 -8
+12 -8
+13 -8
+14 -8
+15 -8
+16 -8
+17 -8
+18 -8
+19 -8
+20 -8
+21 -8
+0 -9
+1 -9
+2 -9
+3 -9
+4 -9
+5 -9
+6 -9
+7 -9
+8 -9
+9 -9
+10 -9
+11 -9
+12 -9
+13 -9
+14 -9
+15 -9
+16 -9
+17 -9
+18 -9
+19 -9
+20 -9
+21 -9
+0 -10
+1 -10
+2 -10
+3 -10
+4 -10
+5 -10
+6 -10
+7 -10
+8 -10
+9 -10
+10 -10
+11 -10
+12 -10
+13 -10
+14 -10
+15 -10
+16 -10
+17 -10
+18 -10
+19 -10
+20 -10
+21 -10
+0 -11
+1 -11
+2 -11
+3 -11
+4 -11
+5 -11
+6 -11
+7 -11
+8 -11
+9 -11
+10 -11
+11 -11
+12 -11
+13 -11
+14 -11
+15 -11
+16 -11
+17 -11
+18 -11
+19 -11
+20 -11
+21 -11
+0 -12
+1 -12
+2 -12
+3 -12
+4 -12
+5 -12
+6 -12
+7 -12
+8 -12
+9 -12
+10 -12
+11 -12
+12 -12
+13 -12
+14 -12
+15 -12
+16 -12
+17 -12
+18 -12
+19 -12
+20 -12
+21 -12
+0 -13
+1 -13
+2 -13
+3 -13
+4 -13
+5 -13
+6 -13
+7 -13
+8 -13
+9 -13
+10 -13
+11 -13
+12 -13
+13 -13
+14 -13
+15 -13
+16 -13
+17 -13
+18 -13
+19 -13
+20 -13
+21 -13
+0 -14
+1 -14
+2 -14
+3 -14
+4 -14
+5 -14
+6 -14
+7 -14
+8 -14
+9 -14
+10 -14
+11 -14
+12 -14
+13 -14
+14 -14
+15 -14
+16 -14
+17 -14
+18 -14
+19 -14
+20 -14
+21 -14
+0 -15
+1 -15
+2 -15
+3 -15
+4 -15
+5 -15
+6 -15
+7 -15
+8 -15
+9 -15
+10 -15
+11 -15
+12 -15
+13 -15
+14 -15
+15 -15
+16 -15
+17 -15
+18 -15
+19 -15
+20 -15
+21 -15
+0 -16
+1 -16
+2 -16
+3 -16
+4 -16
+5 -16
+6 -16
+7 -16
+8 -16
+9 -16
+10 -16
+11 -16
+12 -16
+13 -16
+14 -16
+15 -16
+16 -16
+17 -16
+18 -16
+19 -16
+20 -16
+21 -16
+0 -17
+1 -17
+2 -17
+3 -17
+4 -17
+5 -17
+6 -17
+7 -17
+8 -17
+9 -17
+10 -17
+11 -17
+12 -17
+13 -17
+14 -17
+15 -17
+16 -17
+17 -17
+18 -17
+19 -17
+20 -17
+21 -17
+0 -18
+1 -18
+2 -18
+3 -18
+4 -18
+5 -18
+6 -18
+7 -18
+8 -18
+9 -18
+10 -18
+11 -18
+12 -18
+13 -18
+14 -18
+15 -18
+16 -18
+17 -18
+18 -18
+0 -19
+1 -19
+2 -19
+3 -19
+4 -19
+5 -19
+6 -19
+7 -19
+8 -19
+9 -19
+10 -19
+11 -19
+12 -19
+13 -19
+14 -19
+15 -19
+16 -19
+17 -19
+19 -19
+0 -20
+1 -20
+2 -20
+3 -20
+4 -20
+5 -20
+6 -20
+7 -20
+8 -20
+9 -20
+10 -20
+11 -20
+12 -20
+13 -20
+14 -20
+15 -20
+16 -20
+17 -20
+20 -20
+0 -21
+1 -21
+2 -21
+3 -21
+4 -21
+5 -21
+6 -21
+7 -21
+8 -21
+9 -21
+10 -21
+11 -21
+12 -21
+13 -21
+14 -21
+15 -21
+16 -21
+17 -21
+21 -21
diff --git a/tests/sparsity/block_sparsity_pattern_write_svg_01.cc b/tests/sparsity/block_sparsity_pattern_write_svg_01.cc
new file mode 100644 (file)
index 0000000..7278579
--- /dev/null
@@ -0,0 +1,83 @@
+// ---------------------------------------------------------------------
+//
+// Copyright (C) 2008 - 2018 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.
+//
+// ---------------------------------------------------------------------
+
+
+
+// check BlockSparsityPattern::write_svg
+
+#include <deal.II/dofs/dof_handler.h>
+#include <deal.II/dofs/dof_renumbering.h>
+#include <deal.II/dofs/dof_tools.h>
+
+#include <deal.II/fe/fe_q.h>
+#include <deal.II/fe/fe_system.h>
+
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/grid/tria.h>
+
+#include <deal.II/lac/block_sparsity_pattern.h>
+
+#include "../tests.h"
+
+int
+main()
+{
+  initlog();
+
+  const int          dim = 2;
+  Triangulation<dim> tria;
+  GridGenerator::hyper_cube(tria);
+
+  const unsigned int degree = 1;
+  FESystem<dim>      fe(FE_Q<dim>(degree + 1), dim, FE_Q<dim>(degree), 1);
+  DoFHandler<dim>    dof_handler(tria);
+  dof_handler.distribute_dofs(fe);
+  DoFRenumbering::Cuthill_McKee(dof_handler);
+  DoFRenumbering::component_wise(dof_handler);
+
+  std::vector<unsigned int> block_component(dim + 1, 0);
+  block_component[dim] = 1;
+  const std::vector<types::global_dof_index> dofs_per_block =
+    DoFTools::count_dofs_per_fe_block(dof_handler, block_component);
+  const unsigned int n_u = dofs_per_block[0];
+  const unsigned int n_p = dofs_per_block[1];
+
+  BlockSparsityPattern sparsity_pattern;
+  {
+    BlockDynamicSparsityPattern dsp(2, 2);
+
+    dsp.block(0, 0).reinit(n_u, n_u);
+    dsp.block(1, 0).reinit(n_p, n_u);
+    dsp.block(0, 1).reinit(n_u, n_p);
+    dsp.block(1, 1).reinit(n_p, n_p);
+
+    dsp.collect_sizes();
+
+    Table<2, DoFTools::Coupling> coupling(dim + 1, dim + 1);
+
+    for (unsigned int c = 0; c < dim + 1; ++c)
+      for (unsigned int d = 0; d < dim + 1; ++d)
+        if (!((c == dim) && (d == dim)))
+          coupling[c][d] = DoFTools::always;
+        else
+          coupling[c][d] = DoFTools::none;
+
+    DoFTools::make_sparsity_pattern(dof_handler, coupling, dsp);
+
+    sparsity_pattern.copy_from(dsp);
+  }
+
+  sparsity_pattern.print_svg(deallog.get_file_stream());
+}
diff --git a/tests/sparsity/block_sparsity_pattern_write_svg_01.output b/tests/sparsity/block_sparsity_pattern_write_svg_01.output
new file mode 100644 (file)
index 0000000..46fd84d
--- /dev/null
@@ -0,0 +1,486 @@
+
+<svg xmlns="http://www.w3.org/2000/svg" version="1.1" viewBox="0 0 24 24 ">
+<style type="text/css" >
+     <![CDATA[
+      rect.pixel {
+          fill:   #ff0000;
+      }
+    ]]>
+  </style>
+
+   <rect width="24" height="24" fill="rgb(128, 128, 128)"/>
+   <rect x="1" y="1" width="22.1000" height="22.1000" fill="rgb(255, 255, 255)"/>
+
+  <rect class="pixel" x="1" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="1" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="2" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="3" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="4" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="5" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="6" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="7" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="8" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="9" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="10" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="11" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="12" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="13" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="14" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="15" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="16" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="17" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="18" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="1" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="2" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="3" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="4" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="5" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="6" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="7" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="8" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="9" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="10" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="11" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="12" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="13" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="14" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="15" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="16" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="17" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="18" y="22" width=".9" height=".9"/>
+  <rect class="pixel" x="19" y="19" width=".9" height=".9"/>
+  <rect class="pixel" x="20" y="20" width=".9" height=".9"/>
+  <rect class="pixel" x="21" y="21" width=".9" height=".9"/>
+  <rect class="pixel" x="22" y="22" width=".9" height=".9"/>
+</svg>

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.