From: Guido Kanschat Date: Mon, 30 Mar 2015 11:31:51 +0000 (+0200) Subject: Enable assembling multiple matrices in MeshWorker::Assembler::MatrixSimple X-Git-Tag: v8.3.0-rc1~320^2~1 X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=8254b2cae7278efd3181aea088a6cc6bc6d662e2;p=dealii.git Enable assembling multiple matrices in MeshWorker::Assembler::MatrixSimple --- diff --git a/include/deal.II/meshworker/simple.h b/include/deal.II/meshworker/simple.h index 063706284d..576fbe023b 100644 --- a/include/deal.II/meshworker/simple.h +++ b/include/deal.II/meshworker/simple.h @@ -157,6 +157,12 @@ namespace MeshWorker * Store the result matrix for later assembling. */ void initialize(MATRIX &m); + + /** + * Store several result matrices for later assembling. + */ + void initialize(std::vector &m); + /** * Initialize the constraints. After this function has been called with * a valid ConstraintMatrix, the function @@ -166,21 +172,6 @@ namespace MeshWorker */ void initialize(const ConstraintMatrix &constraints); - /** - * @deprecated This function is of no effect. Only the block info - * structure in DoFInfo is being used. - * - * Store information on the local block structure. If the assembler is - * inititialized with this function, initialize_info() will generate one - * local matrix for each block row and column, which will be numbered - * lexicographically, row by row. - * - * In spite of using local block structure, all blocks will be enteres - * into the same global matrix, disregarding any global block structure. - */ - - void initialize_local_blocks(const BlockIndices &); - /** * Initialize the local data in the DoFInfo object used later for * assembling. @@ -206,16 +197,18 @@ namespace MeshWorker const DOFINFO &info2); private: /** - * Assemble a single matrix into #matrix. + * Assemble a single matrix M into the element + * at index in the vector #matrix. */ void assemble(const FullMatrix &M, + const unsigned int index, const std::vector &i1, const std::vector &i2); /** * The global matrix being assembled. */ - SmartPointer > matrix; + std::vector > > matrix; /** * A pointer to the object containing constraints. */ @@ -261,20 +254,6 @@ namespace MeshWorker */ void initialize(const MGConstrainedDoFs &mg_constrained_dofs); - /** - * @deprecated This function is of no effect. Only the block info - * structure in DoFInfo is being used. - * - * Store information on the local block structure. If the assembler is - * inititialized with this function, initialize_info() will generate one - * local matrix for each block row and column, which will be numbered - * lexicographically, row by row. - * - * In spite of using local block structure, all blocks will be enteres - * into the same global matrix, disregarding any global block structure. - */ - void initialize_local_blocks(const BlockIndices &); - /** * Initialize the matrices #flux_up and #flux_down used for local * refinement with discontinuous Galerkin methods. @@ -587,22 +566,27 @@ namespace MeshWorker inline void MatrixSimple::initialize(MATRIX &m) { - matrix = &m; + matrix.resize(1); + matrix[0] = &m; } template inline void - MatrixSimple::initialize(const ConstraintMatrix &c) + MatrixSimple::initialize(std::vector &m) { - constraints = &c; + matrix.resize(m.size()); + for (unsigned int i=0; i inline void - MatrixSimple::initialize_local_blocks(const BlockIndices &) - {} + MatrixSimple::initialize(const ConstraintMatrix &c) + { + constraints = &c; + } template @@ -610,25 +594,28 @@ namespace MeshWorker inline void MatrixSimple::initialize_info(DOFINFO &info, bool face) const { + Assert(matrix.size() != 0, ExcNotInitialized()); + const unsigned int n = info.indices_by_block.size(); if (n == 0) - info.initialize_matrices(1, face); + info.initialize_matrices(matrix.size(), face); else { - info.initialize_matrices(n*n, face); + info.initialize_matrices(matrix.size()*n*n, face); unsigned int k=0; - for (unsigned int i=0; i inline void MatrixSimple::assemble(const FullMatrix &M, + const unsigned int index, const std::vector &i1, const std::vector &i2) { @@ -648,10 +636,10 @@ namespace MeshWorker for (unsigned int j=0; j= threshold) - matrix->add(i1[j], i2[k], M(j,k)); + matrix[index]->add(i1[j], i2[k], M(j,k)); } else - constraints->distribute_local_to_global(M, i1, i2, *matrix); + constraints->distribute_local_to_global(M, i1, i2, *matrix[index]); } @@ -661,17 +649,20 @@ namespace MeshWorker MatrixSimple::assemble(const DOFINFO &info) { Assert(!info.level_cell, ExcMessage("Cell may not access level dofs")); + const unsigned int n = info.indices_by_block.size(); - if (info.indices_by_block.size() == 0) - assemble(info.matrix(0,false).matrix, info.indices, info.indices); + if (n == 0) + for (unsigned int m=0; m - inline void - MGMatrixSimple::initialize_local_blocks(const BlockIndices &) - {} - template inline void diff --git a/tests/integrators/assembler_simple_matrix_01.cc b/tests/integrators/assembler_simple_matrix_01.cc index 7942dd2ceb..b642ff6400 100644 --- a/tests/integrators/assembler_simple_matrix_01.cc +++ b/tests/integrators/assembler_simple_matrix_01.cc @@ -73,7 +73,10 @@ int main() MeshWorker::DoFInfo<2,2,double> info1b(dof1.block_info()); MeshWorker::DoFInfo<2,2,double> info2b(dof2.block_info()); + std::vector > matrices(2); MeshWorker::Assembler::MatrixSimple > ass1; + ass1.initialize(matrices[0]); + deallog.push("Single block"); test(info1, ass1); deallog.pop(); diff --git a/tests/integrators/assembler_simple_matrix_01m.cc b/tests/integrators/assembler_simple_matrix_01m.cc new file mode 100644 index 0000000000..cf827786a4 --- /dev/null +++ b/tests/integrators/assembler_simple_matrix_01m.cc @@ -0,0 +1,88 @@ +// --------------------------------------------------------------------- +// +// Copyright (C) 2012 - 2014 by the deal.II authors +// +// This file is part of the deal.II library. +// +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + + +/** + * @file Test initialization of Assembler::MatrixSimple and + * DoFInfo with multiple matrices + */ + +#include "../tests.h" +#include +#include +#include +#include +#include +#include +#include +#include +#include + +#include +#include + +using namespace dealii; + +template +void test(DOFINFO &info, MeshWorker::Assembler::MatrixSimple &ass) +{ + ass.initialize_info(info, false); + deallog << "No faces" << std::endl; + info.print_debug(deallog); + + ass.initialize_info(info, true); + deallog << "With faces" << std::endl; + info.print_debug(deallog); +} + +int main() +{ + const std::string logname = "output"; + std::ofstream logfile(logname.c_str()); + deallog.attach(logfile); + deallog.depth_console (0); + + Triangulation<2,2> tr; + GridGenerator::hyper_cube(tr); + FE_DGP<2,2> fe1(1); + FE_DGP<2,2> fe2(2); + FE_DGP<2,2> fe3(3); + FE_DGP<2,2> fe5(5); + FESystem<2,2> fes1(fe3,1,fe5,1,fe1,1); + FESystem<2,2> fes2(fe3,1,fe5,1,fe1,1, fe2,1); + + DoFHandler<2,2> dof1(tr); + dof1.distribute_dofs(fes1); + DoFHandler<2,2> dof2(tr); + dof2.distribute_dofs(fes2); + dof1.initialize_local_block_info(); + dof2.initialize_local_block_info(); + MeshWorker::DoFInfo<2,2,double> info1(dof1); + MeshWorker::DoFInfo<2,2,double> info1b(dof1.block_info()); + MeshWorker::DoFInfo<2,2,double> info2b(dof2.block_info()); + + std::vector > matrices(2); + MeshWorker::Assembler::MatrixSimple > ass1; + ass1.initialize(matrices); + + deallog.push("Single block"); + test(info1, ass1); + deallog.pop(); + deallog.push("Multiple blocks"); + test(info1b, ass1); + deallog.pop(); + deallog.push("More blocks"); + test(info2b, ass1); +} diff --git a/tests/integrators/assembler_simple_matrix_01m.output b/tests/integrators/assembler_simple_matrix_01m.output new file mode 100644 index 0000000000..ea8d1f2da1 --- /dev/null +++ b/tests/integrators/assembler_simple_matrix_01m.output @@ -0,0 +1,129 @@ + +DEAL:Single block::No faces +DEAL:Single block::J: 0 +DEAL:Single block::R: 0 +DEAL:Single block::M: 2 face 0 +DEAL:Single block:: 0,0 0x0 +DEAL:Single block:: 0,0 0x0 +DEAL:Single block::With faces +DEAL:Single block::J: 0 +DEAL:Single block::R: 0 +DEAL:Single block::M: 2 face 2 +DEAL:Single block:: 0,0 0x0 face 0,0 0x0 +DEAL:Single block:: 0,0 0x0 face 0,0 0x0 +DEAL:Multiple blocks::No faces +DEAL:Multiple blocks::J: 0 +DEAL:Multiple blocks::R: 0 +DEAL:Multiple blocks::M: 18 face 0 +DEAL:Multiple blocks:: 0,0 0x0 +DEAL:Multiple blocks:: 0,1 0x0 +DEAL:Multiple blocks:: 0,2 0x0 +DEAL:Multiple blocks:: 1,0 0x0 +DEAL:Multiple blocks:: 1,1 0x0 +DEAL:Multiple blocks:: 1,2 0x0 +DEAL:Multiple blocks:: 2,0 0x0 +DEAL:Multiple blocks:: 2,1 0x0 +DEAL:Multiple blocks:: 2,2 0x0 +DEAL:Multiple blocks:: 0,0 0x0 +DEAL:Multiple blocks:: 0,1 0x0 +DEAL:Multiple blocks:: 0,2 0x0 +DEAL:Multiple blocks:: 1,0 0x0 +DEAL:Multiple blocks:: 1,1 0x0 +DEAL:Multiple blocks:: 1,2 0x0 +DEAL:Multiple blocks:: 2,0 0x0 +DEAL:Multiple blocks:: 2,1 0x0 +DEAL:Multiple blocks:: 2,2 0x0 +DEAL:Multiple blocks::With faces +DEAL:Multiple blocks::J: 0 +DEAL:Multiple blocks::R: 0 +DEAL:Multiple blocks::M: 18 face 18 +DEAL:Multiple blocks:: 0,0 0x0 face 0,0 0x0 +DEAL:Multiple blocks:: 0,1 0x0 face 0,1 0x0 +DEAL:Multiple blocks:: 0,2 0x0 face 0,2 0x0 +DEAL:Multiple blocks:: 1,0 0x0 face 1,0 0x0 +DEAL:Multiple blocks:: 1,1 0x0 face 1,1 0x0 +DEAL:Multiple blocks:: 1,2 0x0 face 1,2 0x0 +DEAL:Multiple blocks:: 2,0 0x0 face 2,0 0x0 +DEAL:Multiple blocks:: 2,1 0x0 face 2,1 0x0 +DEAL:Multiple blocks:: 2,2 0x0 face 2,2 0x0 +DEAL:Multiple blocks:: 0,0 0x0 face 0,0 0x0 +DEAL:Multiple blocks:: 0,1 0x0 face 0,1 0x0 +DEAL:Multiple blocks:: 0,2 0x0 face 0,2 0x0 +DEAL:Multiple blocks:: 1,0 0x0 face 1,0 0x0 +DEAL:Multiple blocks:: 1,1 0x0 face 1,1 0x0 +DEAL:Multiple blocks:: 1,2 0x0 face 1,2 0x0 +DEAL:Multiple blocks:: 2,0 0x0 face 2,0 0x0 +DEAL:Multiple blocks:: 2,1 0x0 face 2,1 0x0 +DEAL:Multiple blocks:: 2,2 0x0 face 2,2 0x0 +DEAL:More blocks::No faces +DEAL:More blocks::J: 0 +DEAL:More blocks::R: 0 +DEAL:More blocks::M: 32 face 0 +DEAL:More blocks:: 0,0 0x0 +DEAL:More blocks:: 0,1 0x0 +DEAL:More blocks:: 0,2 0x0 +DEAL:More blocks:: 0,3 0x0 +DEAL:More blocks:: 1,0 0x0 +DEAL:More blocks:: 1,1 0x0 +DEAL:More blocks:: 1,2 0x0 +DEAL:More blocks:: 1,3 0x0 +DEAL:More blocks:: 2,0 0x0 +DEAL:More blocks:: 2,1 0x0 +DEAL:More blocks:: 2,2 0x0 +DEAL:More blocks:: 2,3 0x0 +DEAL:More blocks:: 3,0 0x0 +DEAL:More blocks:: 3,1 0x0 +DEAL:More blocks:: 3,2 0x0 +DEAL:More blocks:: 3,3 0x0 +DEAL:More blocks:: 0,0 0x0 +DEAL:More blocks:: 0,1 0x0 +DEAL:More blocks:: 0,2 0x0 +DEAL:More blocks:: 0,3 0x0 +DEAL:More blocks:: 1,0 0x0 +DEAL:More blocks:: 1,1 0x0 +DEAL:More blocks:: 1,2 0x0 +DEAL:More blocks:: 1,3 0x0 +DEAL:More blocks:: 2,0 0x0 +DEAL:More blocks:: 2,1 0x0 +DEAL:More blocks:: 2,2 0x0 +DEAL:More blocks:: 2,3 0x0 +DEAL:More blocks:: 3,0 0x0 +DEAL:More blocks:: 3,1 0x0 +DEAL:More blocks:: 3,2 0x0 +DEAL:More blocks:: 3,3 0x0 +DEAL:More blocks::With faces +DEAL:More blocks::J: 0 +DEAL:More blocks::R: 0 +DEAL:More blocks::M: 32 face 32 +DEAL:More blocks:: 0,0 0x0 face 0,0 0x0 +DEAL:More blocks:: 0,1 0x0 face 0,1 0x0 +DEAL:More blocks:: 0,2 0x0 face 0,2 0x0 +DEAL:More blocks:: 0,3 0x0 face 0,3 0x0 +DEAL:More blocks:: 1,0 0x0 face 1,0 0x0 +DEAL:More blocks:: 1,1 0x0 face 1,1 0x0 +DEAL:More blocks:: 1,2 0x0 face 1,2 0x0 +DEAL:More blocks:: 1,3 0x0 face 1,3 0x0 +DEAL:More blocks:: 2,0 0x0 face 2,0 0x0 +DEAL:More blocks:: 2,1 0x0 face 2,1 0x0 +DEAL:More blocks:: 2,2 0x0 face 2,2 0x0 +DEAL:More blocks:: 2,3 0x0 face 2,3 0x0 +DEAL:More blocks:: 3,0 0x0 face 3,0 0x0 +DEAL:More blocks:: 3,1 0x0 face 3,1 0x0 +DEAL:More blocks:: 3,2 0x0 face 3,2 0x0 +DEAL:More blocks:: 3,3 0x0 face 3,3 0x0 +DEAL:More blocks:: 0,0 0x0 face 0,0 0x0 +DEAL:More blocks:: 0,1 0x0 face 0,1 0x0 +DEAL:More blocks:: 0,2 0x0 face 0,2 0x0 +DEAL:More blocks:: 0,3 0x0 face 0,3 0x0 +DEAL:More blocks:: 1,0 0x0 face 1,0 0x0 +DEAL:More blocks:: 1,1 0x0 face 1,1 0x0 +DEAL:More blocks:: 1,2 0x0 face 1,2 0x0 +DEAL:More blocks:: 1,3 0x0 face 1,3 0x0 +DEAL:More blocks:: 2,0 0x0 face 2,0 0x0 +DEAL:More blocks:: 2,1 0x0 face 2,1 0x0 +DEAL:More blocks:: 2,2 0x0 face 2,2 0x0 +DEAL:More blocks:: 2,3 0x0 face 2,3 0x0 +DEAL:More blocks:: 3,0 0x0 face 3,0 0x0 +DEAL:More blocks:: 3,1 0x0 face 3,1 0x0 +DEAL:More blocks:: 3,2 0x0 face 3,2 0x0 +DEAL:More blocks:: 3,3 0x0 face 3,3 0x0 diff --git a/tests/integrators/assembler_simple_matrix_02.cc b/tests/integrators/assembler_simple_matrix_02.cc index 2d8a0705e7..3f8e7fe023 100644 --- a/tests/integrators/assembler_simple_matrix_02.cc +++ b/tests/integrators/assembler_simple_matrix_02.cc @@ -54,8 +54,10 @@ void test(FiniteElement &fe) typename DoFHandler::active_cell_iterator cell = dof.begin_active(); typename DoFHandler::face_iterator face = cell->face(1); + std::vector > matrices(2); MeshWorker::Assembler::MatrixSimple > ass; - ass.initialize_local_blocks(dof.block_info().local()); + ass.initialize(matrices[0]); + MeshWorker::DoFInfo info(dof.block_info()); ass.initialize_info(info, false); diff --git a/tests/integrators/assembler_simple_matrix_02m.cc b/tests/integrators/assembler_simple_matrix_02m.cc new file mode 100644 index 0000000000..049c61f534 --- /dev/null +++ b/tests/integrators/assembler_simple_matrix_02m.cc @@ -0,0 +1,100 @@ +// --------------------------------------------------------------------- +// +// Copyright (C) 2012 - 2014 by the deal.II authors +// +// This file is part of the deal.II library. +// +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + + +/** + * @file Test initialization of Assembler::MatrixSimple and + * DoFInfo including assigning of local block sizes with multiple matrices + */ + +#include "../tests.h" +#include +#include +#include +#include +#include +#include +#include +#include +#include + +#include +#include +#include + +using namespace dealii; + +template +void test(FiniteElement &fe) +{ + deallog << fe.get_name() << std::endl; + + Triangulation tr; + GridGenerator::hyper_cube(tr); + tr.refine_global(1); + tr.begin_active()->neighbor(1)->set_refine_flag(); + tr.execute_coarsening_and_refinement(); + + DoFHandler dof(tr); + dof.distribute_dofs(fe); + dof.initialize_local_block_info(); + + typename DoFHandler::active_cell_iterator cell = dof.begin_active(); + typename DoFHandler::face_iterator face = cell->face(1); + + std::vector > matrices(2); + MeshWorker::Assembler::MatrixSimple > ass; + ass.initialize(matrices); + + MeshWorker::DoFInfo info(dof.block_info()); + ass.initialize_info(info, false); + + deallog.push("cell"); + info.reinit(cell); + info.print_debug(deallog); + deallog.pop(); + + deallog.push("face1"); + info.reinit(cell, face, 1); + info.print_debug(deallog); + deallog.pop(); + + deallog.push("face2"); + ass.initialize_info(info, true); + info.reinit(cell, face, 1); + info.print_debug(deallog); + deallog.pop(); +} + +int main() +{ + const std::string logname = "output"; + std::ofstream logfile(logname.c_str()); + deallog.attach(logfile); + deallog.depth_console (0); + + FE_DGP<2> p0(0); + FE_DGP<2> p1(1); + FE_DGP<2> p2(2); + FE_RaviartThomas<2> rt0(0); + + FESystem<2> sys1(p0,1, p1, 1); + FESystem<2> sys2(p2,2,p0,3,p1,1); + FESystem<2> sys3(p0, 2, rt0, 1); + + test(sys1); + test(sys2); + test(sys3); +} diff --git a/tests/integrators/assembler_simple_matrix_02m.output b/tests/integrators/assembler_simple_matrix_02m.output new file mode 100644 index 0000000000..ed9d936fbb --- /dev/null +++ b/tests/integrators/assembler_simple_matrix_02m.output @@ -0,0 +1,325 @@ + +DEAL::FESystem<2>[FE_DGP<2>(0)-FE_DGP<2>(1)] +DEAL:cell::J: 0 +DEAL:cell::R: 0 +DEAL:cell::M: 8 face 0 +DEAL:cell:: 0,0 1x1 +DEAL:cell:: 0,1 1x3 +DEAL:cell:: 1,0 3x1 +DEAL:cell:: 1,1 3x3 +DEAL:cell:: 0,0 1x1 +DEAL:cell:: 0,1 1x3 +DEAL:cell:: 1,0 3x1 +DEAL:cell:: 1,1 3x3 +DEAL:face1::J: 0 +DEAL:face1::R: 0 +DEAL:face1::M: 8 face 0 +DEAL:face1:: 0,0 1x1 +DEAL:face1:: 0,1 1x3 +DEAL:face1:: 1,0 3x1 +DEAL:face1:: 1,1 3x3 +DEAL:face1:: 0,0 1x1 +DEAL:face1:: 0,1 1x3 +DEAL:face1:: 1,0 3x1 +DEAL:face1:: 1,1 3x3 +DEAL:face2::J: 0 +DEAL:face2::R: 0 +DEAL:face2::M: 8 face 8 +DEAL:face2:: 0,0 1x1 face 0,0 1x1 +DEAL:face2:: 0,1 1x3 face 0,1 1x3 +DEAL:face2:: 1,0 3x1 face 1,0 3x1 +DEAL:face2:: 1,1 3x3 face 1,1 3x3 +DEAL:face2:: 0,0 1x1 face 0,0 1x1 +DEAL:face2:: 0,1 1x3 face 0,1 1x3 +DEAL:face2:: 1,0 3x1 face 1,0 3x1 +DEAL:face2:: 1,1 3x3 face 1,1 3x3 +DEAL::FESystem<2>[FE_DGP<2>(2)^2-FE_DGP<2>(0)^3-FE_DGP<2>(1)] +DEAL:cell::J: 0 +DEAL:cell::R: 0 +DEAL:cell::M: 72 face 0 +DEAL:cell:: 0,0 6x6 +DEAL:cell:: 0,1 6x6 +DEAL:cell:: 0,2 6x1 +DEAL:cell:: 0,3 6x1 +DEAL:cell:: 0,4 6x1 +DEAL:cell:: 0,5 6x3 +DEAL:cell:: 1,0 6x6 +DEAL:cell:: 1,1 6x6 +DEAL:cell:: 1,2 6x1 +DEAL:cell:: 1,3 6x1 +DEAL:cell:: 1,4 6x1 +DEAL:cell:: 1,5 6x3 +DEAL:cell:: 2,0 1x6 +DEAL:cell:: 2,1 1x6 +DEAL:cell:: 2,2 1x1 +DEAL:cell:: 2,3 1x1 +DEAL:cell:: 2,4 1x1 +DEAL:cell:: 2,5 1x3 +DEAL:cell:: 3,0 1x6 +DEAL:cell:: 3,1 1x6 +DEAL:cell:: 3,2 1x1 +DEAL:cell:: 3,3 1x1 +DEAL:cell:: 3,4 1x1 +DEAL:cell:: 3,5 1x3 +DEAL:cell:: 4,0 1x6 +DEAL:cell:: 4,1 1x6 +DEAL:cell:: 4,2 1x1 +DEAL:cell:: 4,3 1x1 +DEAL:cell:: 4,4 1x1 +DEAL:cell:: 4,5 1x3 +DEAL:cell:: 5,0 3x6 +DEAL:cell:: 5,1 3x6 +DEAL:cell:: 5,2 3x1 +DEAL:cell:: 5,3 3x1 +DEAL:cell:: 5,4 3x1 +DEAL:cell:: 5,5 3x3 +DEAL:cell:: 0,0 6x6 +DEAL:cell:: 0,1 6x6 +DEAL:cell:: 0,2 6x1 +DEAL:cell:: 0,3 6x1 +DEAL:cell:: 0,4 6x1 +DEAL:cell:: 0,5 6x3 +DEAL:cell:: 1,0 6x6 +DEAL:cell:: 1,1 6x6 +DEAL:cell:: 1,2 6x1 +DEAL:cell:: 1,3 6x1 +DEAL:cell:: 1,4 6x1 +DEAL:cell:: 1,5 6x3 +DEAL:cell:: 2,0 1x6 +DEAL:cell:: 2,1 1x6 +DEAL:cell:: 2,2 1x1 +DEAL:cell:: 2,3 1x1 +DEAL:cell:: 2,4 1x1 +DEAL:cell:: 2,5 1x3 +DEAL:cell:: 3,0 1x6 +DEAL:cell:: 3,1 1x6 +DEAL:cell:: 3,2 1x1 +DEAL:cell:: 3,3 1x1 +DEAL:cell:: 3,4 1x1 +DEAL:cell:: 3,5 1x3 +DEAL:cell:: 4,0 1x6 +DEAL:cell:: 4,1 1x6 +DEAL:cell:: 4,2 1x1 +DEAL:cell:: 4,3 1x1 +DEAL:cell:: 4,4 1x1 +DEAL:cell:: 4,5 1x3 +DEAL:cell:: 5,0 3x6 +DEAL:cell:: 5,1 3x6 +DEAL:cell:: 5,2 3x1 +DEAL:cell:: 5,3 3x1 +DEAL:cell:: 5,4 3x1 +DEAL:cell:: 5,5 3x3 +DEAL:face1::J: 0 +DEAL:face1::R: 0 +DEAL:face1::M: 72 face 0 +DEAL:face1:: 0,0 6x6 +DEAL:face1:: 0,1 6x6 +DEAL:face1:: 0,2 6x1 +DEAL:face1:: 0,3 6x1 +DEAL:face1:: 0,4 6x1 +DEAL:face1:: 0,5 6x3 +DEAL:face1:: 1,0 6x6 +DEAL:face1:: 1,1 6x6 +DEAL:face1:: 1,2 6x1 +DEAL:face1:: 1,3 6x1 +DEAL:face1:: 1,4 6x1 +DEAL:face1:: 1,5 6x3 +DEAL:face1:: 2,0 1x6 +DEAL:face1:: 2,1 1x6 +DEAL:face1:: 2,2 1x1 +DEAL:face1:: 2,3 1x1 +DEAL:face1:: 2,4 1x1 +DEAL:face1:: 2,5 1x3 +DEAL:face1:: 3,0 1x6 +DEAL:face1:: 3,1 1x6 +DEAL:face1:: 3,2 1x1 +DEAL:face1:: 3,3 1x1 +DEAL:face1:: 3,4 1x1 +DEAL:face1:: 3,5 1x3 +DEAL:face1:: 4,0 1x6 +DEAL:face1:: 4,1 1x6 +DEAL:face1:: 4,2 1x1 +DEAL:face1:: 4,3 1x1 +DEAL:face1:: 4,4 1x1 +DEAL:face1:: 4,5 1x3 +DEAL:face1:: 5,0 3x6 +DEAL:face1:: 5,1 3x6 +DEAL:face1:: 5,2 3x1 +DEAL:face1:: 5,3 3x1 +DEAL:face1:: 5,4 3x1 +DEAL:face1:: 5,5 3x3 +DEAL:face1:: 0,0 6x6 +DEAL:face1:: 0,1 6x6 +DEAL:face1:: 0,2 6x1 +DEAL:face1:: 0,3 6x1 +DEAL:face1:: 0,4 6x1 +DEAL:face1:: 0,5 6x3 +DEAL:face1:: 1,0 6x6 +DEAL:face1:: 1,1 6x6 +DEAL:face1:: 1,2 6x1 +DEAL:face1:: 1,3 6x1 +DEAL:face1:: 1,4 6x1 +DEAL:face1:: 1,5 6x3 +DEAL:face1:: 2,0 1x6 +DEAL:face1:: 2,1 1x6 +DEAL:face1:: 2,2 1x1 +DEAL:face1:: 2,3 1x1 +DEAL:face1:: 2,4 1x1 +DEAL:face1:: 2,5 1x3 +DEAL:face1:: 3,0 1x6 +DEAL:face1:: 3,1 1x6 +DEAL:face1:: 3,2 1x1 +DEAL:face1:: 3,3 1x1 +DEAL:face1:: 3,4 1x1 +DEAL:face1:: 3,5 1x3 +DEAL:face1:: 4,0 1x6 +DEAL:face1:: 4,1 1x6 +DEAL:face1:: 4,2 1x1 +DEAL:face1:: 4,3 1x1 +DEAL:face1:: 4,4 1x1 +DEAL:face1:: 4,5 1x3 +DEAL:face1:: 5,0 3x6 +DEAL:face1:: 5,1 3x6 +DEAL:face1:: 5,2 3x1 +DEAL:face1:: 5,3 3x1 +DEAL:face1:: 5,4 3x1 +DEAL:face1:: 5,5 3x3 +DEAL:face2::J: 0 +DEAL:face2::R: 0 +DEAL:face2::M: 72 face 72 +DEAL:face2:: 0,0 6x6 face 0,0 6x6 +DEAL:face2:: 0,1 6x6 face 0,1 6x6 +DEAL:face2:: 0,2 6x1 face 0,2 6x1 +DEAL:face2:: 0,3 6x1 face 0,3 6x1 +DEAL:face2:: 0,4 6x1 face 0,4 6x1 +DEAL:face2:: 0,5 6x3 face 0,5 6x3 +DEAL:face2:: 1,0 6x6 face 1,0 6x6 +DEAL:face2:: 1,1 6x6 face 1,1 6x6 +DEAL:face2:: 1,2 6x1 face 1,2 6x1 +DEAL:face2:: 1,3 6x1 face 1,3 6x1 +DEAL:face2:: 1,4 6x1 face 1,4 6x1 +DEAL:face2:: 1,5 6x3 face 1,5 6x3 +DEAL:face2:: 2,0 1x6 face 2,0 1x6 +DEAL:face2:: 2,1 1x6 face 2,1 1x6 +DEAL:face2:: 2,2 1x1 face 2,2 1x1 +DEAL:face2:: 2,3 1x1 face 2,3 1x1 +DEAL:face2:: 2,4 1x1 face 2,4 1x1 +DEAL:face2:: 2,5 1x3 face 2,5 1x3 +DEAL:face2:: 3,0 1x6 face 3,0 1x6 +DEAL:face2:: 3,1 1x6 face 3,1 1x6 +DEAL:face2:: 3,2 1x1 face 3,2 1x1 +DEAL:face2:: 3,3 1x1 face 3,3 1x1 +DEAL:face2:: 3,4 1x1 face 3,4 1x1 +DEAL:face2:: 3,5 1x3 face 3,5 1x3 +DEAL:face2:: 4,0 1x6 face 4,0 1x6 +DEAL:face2:: 4,1 1x6 face 4,1 1x6 +DEAL:face2:: 4,2 1x1 face 4,2 1x1 +DEAL:face2:: 4,3 1x1 face 4,3 1x1 +DEAL:face2:: 4,4 1x1 face 4,4 1x1 +DEAL:face2:: 4,5 1x3 face 4,5 1x3 +DEAL:face2:: 5,0 3x6 face 5,0 3x6 +DEAL:face2:: 5,1 3x6 face 5,1 3x6 +DEAL:face2:: 5,2 3x1 face 5,2 3x1 +DEAL:face2:: 5,3 3x1 face 5,3 3x1 +DEAL:face2:: 5,4 3x1 face 5,4 3x1 +DEAL:face2:: 5,5 3x3 face 5,5 3x3 +DEAL:face2:: 0,0 6x6 face 0,0 6x6 +DEAL:face2:: 0,1 6x6 face 0,1 6x6 +DEAL:face2:: 0,2 6x1 face 0,2 6x1 +DEAL:face2:: 0,3 6x1 face 0,3 6x1 +DEAL:face2:: 0,4 6x1 face 0,4 6x1 +DEAL:face2:: 0,5 6x3 face 0,5 6x3 +DEAL:face2:: 1,0 6x6 face 1,0 6x6 +DEAL:face2:: 1,1 6x6 face 1,1 6x6 +DEAL:face2:: 1,2 6x1 face 1,2 6x1 +DEAL:face2:: 1,3 6x1 face 1,3 6x1 +DEAL:face2:: 1,4 6x1 face 1,4 6x1 +DEAL:face2:: 1,5 6x3 face 1,5 6x3 +DEAL:face2:: 2,0 1x6 face 2,0 1x6 +DEAL:face2:: 2,1 1x6 face 2,1 1x6 +DEAL:face2:: 2,2 1x1 face 2,2 1x1 +DEAL:face2:: 2,3 1x1 face 2,3 1x1 +DEAL:face2:: 2,4 1x1 face 2,4 1x1 +DEAL:face2:: 2,5 1x3 face 2,5 1x3 +DEAL:face2:: 3,0 1x6 face 3,0 1x6 +DEAL:face2:: 3,1 1x6 face 3,1 1x6 +DEAL:face2:: 3,2 1x1 face 3,2 1x1 +DEAL:face2:: 3,3 1x1 face 3,3 1x1 +DEAL:face2:: 3,4 1x1 face 3,4 1x1 +DEAL:face2:: 3,5 1x3 face 3,5 1x3 +DEAL:face2:: 4,0 1x6 face 4,0 1x6 +DEAL:face2:: 4,1 1x6 face 4,1 1x6 +DEAL:face2:: 4,2 1x1 face 4,2 1x1 +DEAL:face2:: 4,3 1x1 face 4,3 1x1 +DEAL:face2:: 4,4 1x1 face 4,4 1x1 +DEAL:face2:: 4,5 1x3 face 4,5 1x3 +DEAL:face2:: 5,0 3x6 face 5,0 3x6 +DEAL:face2:: 5,1 3x6 face 5,1 3x6 +DEAL:face2:: 5,2 3x1 face 5,2 3x1 +DEAL:face2:: 5,3 3x1 face 5,3 3x1 +DEAL:face2:: 5,4 3x1 face 5,4 3x1 +DEAL:face2:: 5,5 3x3 face 5,5 3x3 +DEAL::FESystem<2>[FE_DGP<2>(0)^2-FE_RaviartThomas<2>(0)] +DEAL:cell::J: 0 +DEAL:cell::R: 0 +DEAL:cell::M: 18 face 0 +DEAL:cell:: 0,0 1x1 +DEAL:cell:: 0,1 1x1 +DEAL:cell:: 0,2 1x4 +DEAL:cell:: 1,0 1x1 +DEAL:cell:: 1,1 1x1 +DEAL:cell:: 1,2 1x4 +DEAL:cell:: 2,0 4x1 +DEAL:cell:: 2,1 4x1 +DEAL:cell:: 2,2 4x4 +DEAL:cell:: 0,0 1x1 +DEAL:cell:: 0,1 1x1 +DEAL:cell:: 0,2 1x4 +DEAL:cell:: 1,0 1x1 +DEAL:cell:: 1,1 1x1 +DEAL:cell:: 1,2 1x4 +DEAL:cell:: 2,0 4x1 +DEAL:cell:: 2,1 4x1 +DEAL:cell:: 2,2 4x4 +DEAL:face1::J: 0 +DEAL:face1::R: 0 +DEAL:face1::M: 18 face 0 +DEAL:face1:: 0,0 1x1 +DEAL:face1:: 0,1 1x1 +DEAL:face1:: 0,2 1x4 +DEAL:face1:: 1,0 1x1 +DEAL:face1:: 1,1 1x1 +DEAL:face1:: 1,2 1x4 +DEAL:face1:: 2,0 4x1 +DEAL:face1:: 2,1 4x1 +DEAL:face1:: 2,2 4x4 +DEAL:face1:: 0,0 1x1 +DEAL:face1:: 0,1 1x1 +DEAL:face1:: 0,2 1x4 +DEAL:face1:: 1,0 1x1 +DEAL:face1:: 1,1 1x1 +DEAL:face1:: 1,2 1x4 +DEAL:face1:: 2,0 4x1 +DEAL:face1:: 2,1 4x1 +DEAL:face1:: 2,2 4x4 +DEAL:face2::J: 0 +DEAL:face2::R: 0 +DEAL:face2::M: 18 face 18 +DEAL:face2:: 0,0 1x1 face 0,0 1x1 +DEAL:face2:: 0,1 1x1 face 0,1 1x1 +DEAL:face2:: 0,2 1x4 face 0,2 1x4 +DEAL:face2:: 1,0 1x1 face 1,0 1x1 +DEAL:face2:: 1,1 1x1 face 1,1 1x1 +DEAL:face2:: 1,2 1x4 face 1,2 1x4 +DEAL:face2:: 2,0 4x1 face 2,0 4x1 +DEAL:face2:: 2,1 4x1 face 2,1 4x1 +DEAL:face2:: 2,2 4x4 face 2,2 4x4 +DEAL:face2:: 0,0 1x1 face 0,0 1x1 +DEAL:face2:: 0,1 1x1 face 0,1 1x1 +DEAL:face2:: 0,2 1x4 face 0,2 1x4 +DEAL:face2:: 1,0 1x1 face 1,0 1x1 +DEAL:face2:: 1,1 1x1 face 1,1 1x1 +DEAL:face2:: 1,2 1x4 face 1,2 1x4 +DEAL:face2:: 2,0 4x1 face 2,0 4x1 +DEAL:face2:: 2,1 4x1 face 2,1 4x1 +DEAL:face2:: 2,2 4x4 face 2,2 4x4 diff --git a/tests/integrators/assembler_simple_matrix_03.cc b/tests/integrators/assembler_simple_matrix_03.cc index fbe0878e06..8418603477 100644 --- a/tests/integrators/assembler_simple_matrix_03.cc +++ b/tests/integrators/assembler_simple_matrix_03.cc @@ -85,7 +85,6 @@ void test(FiniteElement &fe) MeshWorker::Assembler::MatrixSimple > ass; ass.initialize(M); - ass.initialize_local_blocks(dof.block_info().local()); MeshWorker::DoFInfo info(dof.block_info()); ass.initialize_info(info, false); MeshWorker::DoFInfo infon(dof.block_info()); diff --git a/tests/integrators/assembler_simple_matrix_03m.cc b/tests/integrators/assembler_simple_matrix_03m.cc new file mode 100644 index 0000000000..1f9695e825 --- /dev/null +++ b/tests/integrators/assembler_simple_matrix_03m.cc @@ -0,0 +1,135 @@ +// --------------------------------------------------------------------- +// +// Copyright (C) 2012 - 2014 by the deal.II authors +// +// This file is part of the deal.II library. +// +// The deal.II library is free software; you can use it, redistribute +// it, and/or modify it under the terms of the GNU Lesser General +// Public License as published by the Free Software Foundation; either +// version 2.1 of the License, or (at your option) any later version. +// The full text of the license can be found in the file LICENSE at +// the top level of the deal.II distribution. +// +// --------------------------------------------------------------------- + + +/** + * @file Test whether Assembler::MatrixSimple writes the local blocks + * into the right global positions of multiple matrices + */ + +#include "../tests.h" +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include + +#include +#include +#include +#include + +using namespace dealii; + +template +void fill_matrices(MeshWorker::LocalResults &results, bool face) +{ + for (unsigned int k=0; k &M = results.matrix(k, false).matrix; + double base = 1000*(results.matrix(k).row+1) + 100*(results.matrix(k).column+1); + for (unsigned int i=0; i= results.n_matrices()/2) entry *= -1; + M(i,j) = entry; + if (face) + results.matrix(k, true).matrix(i,j) = entry; + } + } +} + + +template +void test(FiniteElement &fe) +{ + deallog << fe.get_name() << std::endl; + + Triangulation tr; + GridGenerator::hyper_cube(tr); + tr.refine_global(1); + + DoFHandler dof(tr); + dof.distribute_dofs(fe); + dof.initialize_local_block_info(); + DoFRenumbering::component_wise(dof); + + deallog << "DoFs " << dof.n_dofs() << std::endl; + + typename DoFHandler::active_cell_iterator cell = dof.begin_active(); + typename DoFHandler::face_iterator face = cell->face(1); + typename DoFHandler::active_cell_iterator neighbor = cell->neighbor(1); + + DynamicSparsityPattern csp(dof.n_dofs(),dof.n_dofs()); + DoFTools::make_flux_sparsity_pattern(dof, csp); + SparsityPattern sparsity; + sparsity.copy_from(csp); + std::vector > M(2); + M[0].reinit(sparsity); + M[1].reinit(sparsity); + + MeshWorker::Assembler::MatrixSimple > ass; + ass.initialize(M); + MeshWorker::DoFInfo info(dof.block_info()); + ass.initialize_info(info, false); + MeshWorker::DoFInfo infon(dof.block_info()); + ass.initialize_info(infon, true); + + deallog << "cell" << std::endl; + info.reinit(cell); + fill_matrices(info, false); + ass.assemble(info); + M[1].print_formatted(deallog.get_file_stream(), 0, false, 6); + M[0] = 0.; + M[1] = 0.; + + deallog << "face" << std::endl; + ass.initialize_info(info, true); + info.reinit(cell, face, 1); + infon.reinit(neighbor, neighbor->face(0), 0); + fill_matrices(info, true); + fill_matrices(infon, true); + ass.assemble(info, infon); + M[1].print_formatted(deallog.get_file_stream(), 0, false, 6); +} + +int main() +{ + initlog(); + + FE_DGP<2> p0(0); + FE_DGP<2> p1(1); + FE_RaviartThomas<2> rt0(0); + FE_Q<2> q2(2); + + FESystem<2> sys1(p0, 2, p1, 1); + FESystem<2> sys2(p0, 2, rt0, 1); + FESystem<2> sys3(rt0, 1, p0, 2); + FESystem<2> sys4(p1, 2, q2, 2); + FESystem<2> sys5(q2, 2, p1, 2); + + test(sys1); + test(sys2); + test(sys3); + test(sys4); + test(sys5); +} diff --git a/tests/integrators/assembler_simple_matrix_03m.output b/tests/integrators/assembler_simple_matrix_03m.output new file mode 100644 index 0000000000..7de0cd1c47 --- /dev/null +++ b/tests/integrators/assembler_simple_matrix_03m.output @@ -0,0 +1,437 @@ + +DEAL::FESystem<2>[FE_DGP<2>(0)^2-FE_DGP<2>(1)] +DEAL::DoFs 20 +DEAL::cell +1100. 0. 0. 1200. 0. 0. 1300. 1301. 1302. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2100. 0. 0. 2200. 0. 0. 2300. 2301. 2302. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3100. 0. 0. 3200. 0. 0. 3300. 3301. 3302. 0. 0. 0. 0. 0. 0. +3110. 0. 0. 3210. 0. 0. 3310. 3311. 3312. 0. 0. 0. 0. 0. 0. +3120. 0. 0. 3220. 0. 0. 3320. 3321. 3322. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +DEAL::face +1100. 1100. 0. 1200. 1200. 0. 1300. 1301. 1302. 1300. 1301. 1302. 0. 0. 0. +1100. 1100. 0. 1200. 1200. 0. 1300. 1301. 1302. 1300. 1301. 1302. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2100. 2100. 0. 2200. 2200. 0. 2300. 2301. 2302. 2300. 2301. 2302. 0. 0. 0. +2100. 2100. 0. 2200. 2200. 0. 2300. 2301. 2302. 2300. 2301. 2302. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3100. 3100. 0. 3200. 3200. 0. 3300. 3301. 3302. 3300. 3301. 3302. 0. 0. 0. +3110. 3110. 0. 3210. 3210. 0. 3310. 3311. 3312. 3310. 3311. 3312. 0. 0. 0. +3120. 3120. 0. 3220. 3220. 0. 3320. 3321. 3322. 3320. 3321. 3322. 0. 0. 0. +3100. 3100. 0. 3200. 3200. 0. 3300. 3301. 3302. 3300. 3301. 3302. 0. 0. 0. +3110. 3110. 0. 3210. 3210. 0. 3310. 3311. 3312. 3310. 3311. 3312. 0. 0. 0. +3120. 3120. 0. 3220. 3220. 0. 3320. 3321. 3322. 3320. 3321. 3322. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +DEAL::FESystem<2>[FE_DGP<2>(0)^2-FE_RaviartThomas<2>(0)] +DEAL::DoFs 20 +DEAL::cell +1100. 0. 0. 1200. 0. 0. 1300. 1301. 1302. 1303. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2100. 0. 0. 2200. 0. 0. 2300. 2301. 2302. 2303. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3100. 0. 0. 3200. 0. 0. 3300. 3301. 3302. 3303. 0. 0. 0. 0. 0. 0. +3110. 0. 0. 0. 3210. 0. 0. 0. 3310. 3311. 3312. 3313. 0. 0. 0. 0. 0. 0. 0. 0. +3120. 0. 0. 3220. 0. 0. 3320. 3321. 3322. 3323. 0. 0. 0. 0. 0. 0. +3130. 0. 0. 0. 3230. 0. 0. 0. 3330. 3331. 3332. 3333. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +DEAL::face +1100. 1100. 0. 1200. 1200. 0. 1300. 2601. 1302. 1303. 1301. 1302. 1303. 0. 0. 0. +1100. 1100. 0. 1200. 1200. 0. 1300. 2601. 1302. 1303. 1301. 1302. 1303. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2100. 2100. 0. 2200. 2200. 0. 2300. 4601. 2302. 2303. 2301. 2302. 2303. 0. 0. 0. +2100. 2100. 0. 2200. 2200. 0. 2300. 4601. 2302. 2303. 2301. 2302. 2303. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3100. 3100. 0. 3200. 3200. 0. 3300. 6601. 3302. 3303. 3301. 3302. 3303. 0. 0. 0. +6210. 6210. 0. 0. 6410. 6410. 0. 0. 6610. 13222. 6614. 6616. 6612. 6614. 6616. 0. 0. 0. 0. 0. +3120. 3120. 0. 3220. 3220. 0. 3320. 6641. 3322. 3323. 3321. 3322. 3323. 0. 0. 0. +3130. 3130. 0. 0. 3230. 3230. 0. 0. 3330. 6661. 3332. 3333. 3331. 3332. 3333. 0. 0. 0. 0. 0. +3110. 3110. 0. 3210. 3210. 0. 3310. 6621. 3312. 3313. 3311. 3312. 3313. 0. 0. 0. +3120. 3120. 0. 3220. 3220. 0. 3320. 6641. 3322. 3323. 3321. 3322. 3323. 0. 0. 0. +3130. 3130. 0. 0. 3230. 3230. 0. 0. 3330. 6661. 3332. 3333. 3331. 3332. 3333. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +DEAL::FESystem<2>[FE_RaviartThomas<2>(0)-FE_DGP<2>(0)^2] +DEAL::DoFs 20 +DEAL::cell +1100. 1101. 1102. 1103. 0. 0. 0. 0. 0. 0. 1200. 0. 0. 1300. 0. 0. +1110. 1111. 1112. 1113. 0. 0. 0. 0. 0. 0. 0. 0. 1210. 0. 0. 0. 1310. 0. 0. 0. +1120. 1121. 1122. 1123. 0. 0. 0. 0. 0. 0. 1220. 0. 0. 1320. 0. 0. +1130. 1131. 1132. 1133. 0. 0. 0. 0. 0. 0. 0. 0. 1230. 0. 0. 0. 1330. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2100. 2101. 2102. 2103. 0. 0. 0. 0. 0. 0. 2200. 0. 0. 2300. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3100. 3101. 3102. 3103. 0. 0. 0. 0. 0. 0. 3200. 0. 0. 3300. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +DEAL::face +1100. 2201. 1102. 1103. 1101. 1102. 1103. 0. 0. 0. 1200. 1200. 0. 1300. 1300. 0. +2210. 4422. 2214. 2216. 2212. 2214. 2216. 0. 0. 0. 0. 0. 2410. 2410. 0. 0. 2610. 2610. 0. 0. +1120. 2241. 1122. 1123. 1121. 1122. 1123. 0. 0. 0. 1220. 1220. 0. 1320. 1320. 0. +1130. 2261. 1132. 1133. 1131. 1132. 1133. 0. 0. 0. 0. 0. 1230. 1230. 0. 0. 1330. 1330. 0. 0. +1110. 2221. 1112. 1113. 1111. 1112. 1113. 0. 0. 0. 1210. 1210. 0. 1310. 1310. 0. +1120. 2241. 1122. 1123. 1121. 1122. 1123. 0. 0. 0. 1220. 1220. 0. 1320. 1320. 0. +1130. 2261. 1132. 1133. 1131. 1132. 1133. 0. 0. 0. 0. 0. 1230. 1230. 0. 0. 1330. 1330. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2100. 4201. 2102. 2103. 2101. 2102. 2103. 0. 0. 0. 2200. 2200. 0. 2300. 2300. 0. +2100. 4201. 2102. 2103. 2101. 2102. 2103. 0. 0. 0. 2200. 2200. 0. 2300. 2300. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3100. 6201. 3102. 3103. 3101. 3102. 3103. 0. 0. 0. 3200. 3200. 0. 3300. 3300. 0. +3100. 6201. 3102. 3103. 3101. 3102. 3103. 0. 0. 0. 3200. 3200. 0. 3300. 3300. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +DEAL::FESystem<2>[FE_DGP<2>(1)^2-FE_Q<2>(2)^2] +DEAL::DoFs 74 +DEAL::cell +1100. 1101. 1102. 0. 0. 0. 0. 0. 0. 1200. 1201. 1202. 0. 0. 0. 0. 0. 0. 1300. 1301. 1302. 1303. 1304. 1305. 1306. 1307. 1308. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1400. 1401. 1402. 1403. 1404. 1405. 1406. 1407. 1408. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +1110. 1111. 1112. 0. 0. 0. 0. 0. 0. 1210. 1211. 1212. 0. 0. 0. 0. 0. 0. 1310. 1311. 1312. 1313. 1314. 1315. 1316. 1317. 1318. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1410. 1411. 1412. 1413. 1414. 1415. 1416. 1417. 1418. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +1120. 1121. 1122. 0. 0. 0. 0. 0. 0. 1220. 1221. 1222. 0. 0. 0. 0. 0. 0. 1320. 1321. 1322. 1323. 1324. 1325. 1326. 1327. 1328. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1420. 1421. 1422. 1423. 1424. 1425. 1426. 1427. 1428. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2100. 2101. 2102. 0. 0. 0. 0. 0. 0. 2200. 2201. 2202. 0. 0. 0. 0. 0. 0. 2300. 2301. 2302. 2303. 2304. 2305. 2306. 2307. 2308. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2400. 2401. 2402. 2403. 2404. 2405. 2406. 2407. 2408. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2110. 2111. 2112. 0. 0. 0. 0. 0. 0. 2210. 2211. 2212. 0. 0. 0. 0. 0. 0. 2310. 2311. 2312. 2313. 2314. 2315. 2316. 2317. 2318. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2410. 2411. 2412. 2413. 2414. 2415. 2416. 2417. 2418. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2120. 2121. 2122. 0. 0. 0. 0. 0. 0. 2220. 2221. 2222. 0. 0. 0. 0. 0. 0. 2320. 2321. 2322. 2323. 2324. 2325. 2326. 2327. 2328. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2420. 2421. 2422. 2423. 2424. 2425. 2426. 2427. 2428. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3100. 3101. 3102. 0. 0. 0. 0. 0. 0. 3200. 3201. 3202. 0. 0. 0. 0. 0. 0. 3300. 3301. 3302. 3303. 3304. 3305. 3306. 3307. 3308. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3400. 3401. 3402. 3403. 3404. 3405. 3406. 3407. 3408. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3110. 3111. 3112. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3210. 3211. 3212. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3310. 3311. 3312. 3313. 3314. 3315. 3316. 3317. 3318. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3410. 3411. 3412. 3413. 3414. 3415. 3416. 3417. 3418. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3120. 3121. 3122. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3220. 3221. 3222. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3320. 3321. 3322. 3323. 3324. 3325. 3326. 3327. 3328. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3420. 3421. 3422. 3423. 3424. 3425. 3426. 3427. 3428. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3130. 3131. 3132. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3230. 3231. 3232. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3330. 3331. 3332. 3333. 3334. 3335. 3336. 3337. 3338. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3430. 3431. 3432. 3433. 3434. 3435. 3436. 3437. 3438. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3140. 3141. 3142. 0. 0. 0. 0. 0. 0. 3240. 3241. 3242. 0. 0. 0. 0. 0. 0. 3340. 3341. 3342. 3343. 3344. 3345. 3346. 3347. 3348. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3440. 3441. 3442. 3443. 3444. 3445. 3446. 3447. 3448. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3150. 3151. 3152. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3250. 3251. 3252. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3350. 3351. 3352. 3353. 3354. 3355. 3356. 3357. 3358. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3450. 3451. 3452. 3453. 3454. 3455. 3456. 3457. 3458. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3160. 3161. 3162. 0. 0. 0. 0. 0. 0. 3260. 3261. 3262. 0. 0. 0. 0. 0. 0. 3360. 3361. 3362. 3363. 3364. 3365. 3366. 3367. 3368. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3460. 3461. 3462. 3463. 3464. 3465. 3466. 3467. 3468. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3170. 3171. 3172. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3270. 3271. 3272. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3370. 3371. 3372. 3373. 3374. 3375. 3376. 3377. 3378. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3470. 3471. 3472. 3473. 3474. 3475. 3476. 3477. 3478. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3180. 3181. 3182. 0. 0. 0. 0. 0. 0. 3280. 3281. 3282. 0. 0. 0. 0. 0. 0. 3380. 3381. 3382. 3383. 3384. 3385. 3386. 3387. 3388. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3480. 3481. 3482. 3483. 3484. 3485. 3486. 3487. 3488. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4100. 4101. 4102. 0. 0. 0. 0. 0. 0. 4200. 4201. 4202. 0. 0. 0. 0. 0. 0. 4300. 4301. 4302. 4303. 4304. 4305. 4306. 4307. 4308. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4400. 4401. 4402. 4403. 4404. 4405. 4406. 4407. 4408. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4110. 4111. 4112. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4210. 4211. 4212. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4310. 4311. 4312. 4313. 4314. 4315. 4316. 4317. 4318. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4410. 4411. 4412. 4413. 4414. 4415. 4416. 4417. 4418. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4120. 4121. 4122. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4220. 4221. 4222. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4320. 4321. 4322. 4323. 4324. 4325. 4326. 4327. 4328. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4420. 4421. 4422. 4423. 4424. 4425. 4426. 4427. 4428. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4130. 4131. 4132. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4230. 4231. 4232. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4330. 4331. 4332. 4333. 4334. 4335. 4336. 4337. 4338. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4430. 4431. 4432. 4433. 4434. 4435. 4436. 4437. 4438. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4140. 4141. 4142. 0. 0. 0. 0. 0. 0. 4240. 4241. 4242. 0. 0. 0. 0. 0. 0. 4340. 4341. 4342. 4343. 4344. 4345. 4346. 4347. 4348. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4440. 4441. 4442. 4443. 4444. 4445. 4446. 4447. 4448. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4150. 4151. 4152. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4250. 4251. 4252. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4350. 4351. 4352. 4353. 4354. 4355. 4356. 4357. 4358. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4450. 4451. 4452. 4453. 4454. 4455. 4456. 4457. 4458. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4160. 4161. 4162. 0. 0. 0. 0. 0. 0. 4260. 4261. 4262. 0. 0. 0. 0. 0. 0. 4360. 4361. 4362. 4363. 4364. 4365. 4366. 4367. 4368. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4460. 4461. 4462. 4463. 4464. 4465. 4466. 4467. 4468. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4170. 4171. 4172. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4270. 4271. 4272. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4370. 4371. 4372. 4373. 4374. 4375. 4376. 4377. 4378. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4470. 4471. 4472. 4473. 4474. 4475. 4476. 4477. 4478. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4180. 4181. 4182. 0. 0. 0. 0. 0. 0. 4280. 4281. 4282. 0. 0. 0. 0. 0. 0. 4380. 4381. 4382. 4383. 4384. 4385. 4386. 4387. 4388. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4480. 4481. 4482. 4483. 4484. 4485. 4486. 4487. 4488. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +DEAL::face +1100. 1101. 1102. 1100. 1101. 1102. 0. 0. 0. 1200. 1201. 1202. 1200. 1201. 1202. 0. 0. 0. 1300. 2601. 1302. 2605. 1304. 2609. 1306. 1307. 1308. 1301. 1303. 1305. 1306. 1307. 1308. 0. 0. 0. 0. 0. 0. 1400. 2801. 1402. 2805. 1404. 2809. 1406. 1407. 1408. 1401. 1403. 1405. 1406. 1407. 1408. 0. 0. 0. 0. 0. 0. +1110. 1111. 1112. 1110. 1111. 1112. 0. 0. 0. 1210. 1211. 1212. 1210. 1211. 1212. 0. 0. 0. 1310. 2621. 1312. 2625. 1314. 2629. 1316. 1317. 1318. 1311. 1313. 1315. 1316. 1317. 1318. 0. 0. 0. 0. 0. 0. 1410. 2821. 1412. 2825. 1414. 2829. 1416. 1417. 1418. 1411. 1413. 1415. 1416. 1417. 1418. 0. 0. 0. 0. 0. 0. +1120. 1121. 1122. 1120. 1121. 1122. 0. 0. 0. 1220. 1221. 1222. 1220. 1221. 1222. 0. 0. 0. 1320. 2641. 1322. 2645. 1324. 2649. 1326. 1327. 1328. 1321. 1323. 1325. 1326. 1327. 1328. 0. 0. 0. 0. 0. 0. 1420. 2841. 1422. 2845. 1424. 2849. 1426. 1427. 1428. 1421. 1423. 1425. 1426. 1427. 1428. 0. 0. 0. 0. 0. 0. +1100. 1101. 1102. 1100. 1101. 1102. 0. 0. 0. 1200. 1201. 1202. 1200. 1201. 1202. 0. 0. 0. 1300. 2601. 1302. 2605. 1304. 2609. 1306. 1307. 1308. 1301. 1303. 1305. 1306. 1307. 1308. 0. 0. 0. 0. 0. 0. 1400. 2801. 1402. 2805. 1404. 2809. 1406. 1407. 1408. 1401. 1403. 1405. 1406. 1407. 1408. 0. 0. 0. 0. 0. 0. +1110. 1111. 1112. 1110. 1111. 1112. 0. 0. 0. 1210. 1211. 1212. 1210. 1211. 1212. 0. 0. 0. 1310. 2621. 1312. 2625. 1314. 2629. 1316. 1317. 1318. 1311. 1313. 1315. 1316. 1317. 1318. 0. 0. 0. 0. 0. 0. 1410. 2821. 1412. 2825. 1414. 2829. 1416. 1417. 1418. 1411. 1413. 1415. 1416. 1417. 1418. 0. 0. 0. 0. 0. 0. +1120. 1121. 1122. 1120. 1121. 1122. 0. 0. 0. 1220. 1221. 1222. 1220. 1221. 1222. 0. 0. 0. 1320. 2641. 1322. 2645. 1324. 2649. 1326. 1327. 1328. 1321. 1323. 1325. 1326. 1327. 1328. 0. 0. 0. 0. 0. 0. 1420. 2841. 1422. 2845. 1424. 2849. 1426. 1427. 1428. 1421. 1423. 1425. 1426. 1427. 1428. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2100. 2101. 2102. 2100. 2101. 2102. 0. 0. 0. 2200. 2201. 2202. 2200. 2201. 2202. 0. 0. 0. 2300. 4601. 2302. 4605. 2304. 4609. 2306. 2307. 2308. 2301. 2303. 2305. 2306. 2307. 2308. 0. 0. 0. 0. 0. 0. 2400. 4801. 2402. 4805. 2404. 4809. 2406. 2407. 2408. 2401. 2403. 2405. 2406. 2407. 2408. 0. 0. 0. 0. 0. 0. +2110. 2111. 2112. 2110. 2111. 2112. 0. 0. 0. 2210. 2211. 2212. 2210. 2211. 2212. 0. 0. 0. 2310. 4621. 2312. 4625. 2314. 4629. 2316. 2317. 2318. 2311. 2313. 2315. 2316. 2317. 2318. 0. 0. 0. 0. 0. 0. 2410. 4821. 2412. 4825. 2414. 4829. 2416. 2417. 2418. 2411. 2413. 2415. 2416. 2417. 2418. 0. 0. 0. 0. 0. 0. +2120. 2121. 2122. 2120. 2121. 2122. 0. 0. 0. 2220. 2221. 2222. 2220. 2221. 2222. 0. 0. 0. 2320. 4641. 2322. 4645. 2324. 4649. 2326. 2327. 2328. 2321. 2323. 2325. 2326. 2327. 2328. 0. 0. 0. 0. 0. 0. 2420. 4841. 2422. 4845. 2424. 4849. 2426. 2427. 2428. 2421. 2423. 2425. 2426. 2427. 2428. 0. 0. 0. 0. 0. 0. +2100. 2101. 2102. 2100. 2101. 2102. 0. 0. 0. 2200. 2201. 2202. 2200. 2201. 2202. 0. 0. 0. 2300. 4601. 2302. 4605. 2304. 4609. 2306. 2307. 2308. 2301. 2303. 2305. 2306. 2307. 2308. 0. 0. 0. 0. 0. 0. 2400. 4801. 2402. 4805. 2404. 4809. 2406. 2407. 2408. 2401. 2403. 2405. 2406. 2407. 2408. 0. 0. 0. 0. 0. 0. +2110. 2111. 2112. 2110. 2111. 2112. 0. 0. 0. 2210. 2211. 2212. 2210. 2211. 2212. 0. 0. 0. 2310. 4621. 2312. 4625. 2314. 4629. 2316. 2317. 2318. 2311. 2313. 2315. 2316. 2317. 2318. 0. 0. 0. 0. 0. 0. 2410. 4821. 2412. 4825. 2414. 4829. 2416. 2417. 2418. 2411. 2413. 2415. 2416. 2417. 2418. 0. 0. 0. 0. 0. 0. +2120. 2121. 2122. 2120. 2121. 2122. 0. 0. 0. 2220. 2221. 2222. 2220. 2221. 2222. 0. 0. 0. 2320. 4641. 2322. 4645. 2324. 4649. 2326. 2327. 2328. 2321. 2323. 2325. 2326. 2327. 2328. 0. 0. 0. 0. 0. 0. 2420. 4841. 2422. 4845. 2424. 4849. 2426. 2427. 2428. 2421. 2423. 2425. 2426. 2427. 2428. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3100. 3101. 3102. 3100. 3101. 3102. 0. 0. 0. 3200. 3201. 3202. 3200. 3201. 3202. 0. 0. 0. 3300. 6601. 3302. 6605. 3304. 6609. 3306. 3307. 3308. 3301. 3303. 3305. 3306. 3307. 3308. 0. 0. 0. 0. 0. 0. 3400. 6801. 3402. 6805. 3404. 6809. 3406. 3407. 3408. 3401. 3403. 3405. 3406. 3407. 3408. 0. 0. 0. 0. 0. 0. +6210. 6212. 6214. 6210. 6212. 6214. 0. 0. 0. 0. 0. 0. 6410. 6412. 6414. 6410. 6412. 6414. 0. 0. 0. 0. 0. 0. 6610. 13222. 6614. 13230. 6618. 13238. 6622. 6624. 6626. 6612. 6616. 6620. 6622. 6624. 6626. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 6810. 13622. 6814. 13630. 6818. 13638. 6822. 6824. 6826. 6812. 6816. 6820. 6822. 6824. 6826. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3120. 3121. 3122. 3120. 3121. 3122. 0. 0. 0. 0. 0. 0. 3220. 3221. 3222. 3220. 3221. 3222. 0. 0. 0. 0. 0. 0. 3320. 6641. 3322. 6645. 3324. 6649. 3326. 3327. 3328. 3321. 3323. 3325. 3326. 3327. 3328. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3420. 6841. 3422. 6845. 3424. 6849. 3426. 3427. 3428. 3421. 3423. 3425. 3426. 3427. 3428. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +6250. 6252. 6254. 6250. 6252. 6254. 0. 0. 0. 0. 0. 0. 6450. 6452. 6454. 6450. 6452. 6454. 0. 0. 0. 0. 0. 0. 6650. 13302. 6654. 13310. 6658. 13318. 6662. 6664. 6666. 6652. 6656. 6660. 6662. 6664. 6666. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 6850. 13702. 6854. 13710. 6858. 13718. 6862. 6864. 6866. 6852. 6856. 6860. 6862. 6864. 6866. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3140. 3141. 3142. 3140. 3141. 3142. 0. 0. 0. 3240. 3241. 3242. 3240. 3241. 3242. 0. 0. 0. 3340. 6681. 3342. 6685. 3344. 6689. 3346. 3347. 3348. 3341. 3343. 3345. 3346. 3347. 3348. 0. 0. 0. 0. 0. 0. 3440. 6881. 3442. 6885. 3444. 6889. 3446. 3447. 3448. 3441. 3443. 3445. 3446. 3447. 3448. 0. 0. 0. 0. 0. 0. +6290. 6292. 6294. 6290. 6292. 6294. 0. 0. 0. 0. 0. 0. 6490. 6492. 6494. 6490. 6492. 6494. 0. 0. 0. 0. 0. 0. 6690. 13382. 6694. 13390. 6698. 13398. 6702. 6704. 6706. 6692. 6696. 6700. 6702. 6704. 6706. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 6890. 13782. 6894. 13790. 6898. 13798. 6902. 6904. 6906. 6892. 6896. 6900. 6902. 6904. 6906. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3160. 3161. 3162. 3160. 3161. 3162. 0. 0. 0. 3260. 3261. 3262. 3260. 3261. 3262. 0. 0. 0. 3360. 6721. 3362. 6725. 3364. 6729. 3366. 3367. 3368. 3361. 3363. 3365. 3366. 3367. 3368. 0. 0. 0. 0. 0. 0. 3460. 6921. 3462. 6925. 3464. 6929. 3466. 3467. 3468. 3461. 3463. 3465. 3466. 3467. 3468. 0. 0. 0. 0. 0. 0. +3170. 3171. 3172. 3170. 3171. 3172. 0. 0. 0. 0. 0. 0. 3270. 3271. 3272. 3270. 3271. 3272. 0. 0. 0. 0. 0. 0. 3370. 6741. 3372. 6745. 3374. 6749. 3376. 3377. 3378. 3371. 3373. 3375. 3376. 3377. 3378. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3470. 6941. 3472. 6945. 3474. 6949. 3476. 3477. 3478. 3471. 3473. 3475. 3476. 3477. 3478. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3180. 3181. 3182. 3180. 3181. 3182. 0. 0. 0. 3280. 3281. 3282. 3280. 3281. 3282. 0. 0. 0. 3380. 6761. 3382. 6765. 3384. 6769. 3386. 3387. 3388. 3381. 3383. 3385. 3386. 3387. 3388. 0. 0. 0. 0. 0. 0. 3480. 6961. 3482. 6965. 3484. 6969. 3486. 3487. 3488. 3481. 3483. 3485. 3486. 3487. 3488. 0. 0. 0. 0. 0. 0. +3110. 3111. 3112. 3110. 3111. 3112. 0. 0. 0. 3210. 3211. 3212. 3210. 3211. 3212. 0. 0. 0. 3310. 6621. 3312. 6625. 3314. 6629. 3316. 3317. 3318. 3311. 3313. 3315. 3316. 3317. 3318. 0. 0. 0. 0. 0. 0. 3410. 6821. 3412. 6825. 3414. 6829. 3416. 3417. 3418. 3411. 3413. 3415. 3416. 3417. 3418. 0. 0. 0. 0. 0. 0. +3130. 3131. 3132. 3130. 3131. 3132. 0. 0. 0. 0. 0. 0. 3230. 3231. 3232. 3230. 3231. 3232. 0. 0. 0. 0. 0. 0. 3330. 6661. 3332. 6665. 3334. 6669. 3336. 3337. 3338. 3331. 3333. 3335. 3336. 3337. 3338. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3430. 6861. 3432. 6865. 3434. 6869. 3436. 3437. 3438. 3431. 3433. 3435. 3436. 3437. 3438. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3150. 3151. 3152. 3150. 3151. 3152. 0. 0. 0. 3250. 3251. 3252. 3250. 3251. 3252. 0. 0. 0. 3350. 6701. 3352. 6705. 3354. 6709. 3356. 3357. 3358. 3351. 3353. 3355. 3356. 3357. 3358. 0. 0. 0. 0. 0. 0. 3450. 6901. 3452. 6905. 3454. 6909. 3456. 3457. 3458. 3451. 3453. 3455. 3456. 3457. 3458. 0. 0. 0. 0. 0. 0. +3160. 3161. 3162. 3160. 3161. 3162. 0. 0. 0. 3260. 3261. 3262. 3260. 3261. 3262. 0. 0. 0. 3360. 6721. 3362. 6725. 3364. 6729. 3366. 3367. 3368. 3361. 3363. 3365. 3366. 3367. 3368. 0. 0. 0. 0. 0. 0. 3460. 6921. 3462. 6925. 3464. 6929. 3466. 3467. 3468. 3461. 3463. 3465. 3466. 3467. 3468. 0. 0. 0. 0. 0. 0. +3170. 3171. 3172. 3170. 3171. 3172. 0. 0. 0. 0. 0. 0. 3270. 3271. 3272. 3270. 3271. 3272. 0. 0. 0. 0. 0. 0. 3370. 6741. 3372. 6745. 3374. 6749. 3376. 3377. 3378. 3371. 3373. 3375. 3376. 3377. 3378. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3470. 6941. 3472. 6945. 3474. 6949. 3476. 3477. 3478. 3471. 3473. 3475. 3476. 3477. 3478. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3180. 3181. 3182. 3180. 3181. 3182. 0. 0. 0. 3280. 3281. 3282. 3280. 3281. 3282. 0. 0. 0. 3380. 6761. 3382. 6765. 3384. 6769. 3386. 3387. 3388. 3381. 3383. 3385. 3386. 3387. 3388. 0. 0. 0. 0. 0. 0. 3480. 6961. 3482. 6965. 3484. 6969. 3486. 3487. 3488. 3481. 3483. 3485. 3486. 3487. 3488. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4100. 4101. 4102. 4100. 4101. 4102. 0. 0. 0. 4200. 4201. 4202. 4200. 4201. 4202. 0. 0. 0. 4300. 8601. 4302. 8605. 4304. 8609. 4306. 4307. 4308. 4301. 4303. 4305. 4306. 4307. 4308. 0. 0. 0. 0. 0. 0. 4400. 8801. 4402. 8805. 4404. 8809. 4406. 4407. 4408. 4401. 4403. 4405. 4406. 4407. 4408. 0. 0. 0. 0. 0. 0. +8210. 8212. 8214. 8210. 8212. 8214. 0. 0. 0. 0. 0. 0. 8410. 8412. 8414. 8410. 8412. 8414. 0. 0. 0. 0. 0. 0. 8610. 17222. 8614. 17230. 8618. 17238. 8622. 8624. 8626. 8612. 8616. 8620. 8622. 8624. 8626. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 8810. 17622. 8814. 17630. 8818. 17638. 8822. 8824. 8826. 8812. 8816. 8820. 8822. 8824. 8826. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4120. 4121. 4122. 4120. 4121. 4122. 0. 0. 0. 0. 0. 0. 4220. 4221. 4222. 4220. 4221. 4222. 0. 0. 0. 0. 0. 0. 4320. 8641. 4322. 8645. 4324. 8649. 4326. 4327. 4328. 4321. 4323. 4325. 4326. 4327. 4328. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4420. 8841. 4422. 8845. 4424. 8849. 4426. 4427. 4428. 4421. 4423. 4425. 4426. 4427. 4428. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +8250. 8252. 8254. 8250. 8252. 8254. 0. 0. 0. 0. 0. 0. 8450. 8452. 8454. 8450. 8452. 8454. 0. 0. 0. 0. 0. 0. 8650. 17302. 8654. 17310. 8658. 17318. 8662. 8664. 8666. 8652. 8656. 8660. 8662. 8664. 8666. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 8850. 17702. 8854. 17710. 8858. 17718. 8862. 8864. 8866. 8852. 8856. 8860. 8862. 8864. 8866. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4140. 4141. 4142. 4140. 4141. 4142. 0. 0. 0. 4240. 4241. 4242. 4240. 4241. 4242. 0. 0. 0. 4340. 8681. 4342. 8685. 4344. 8689. 4346. 4347. 4348. 4341. 4343. 4345. 4346. 4347. 4348. 0. 0. 0. 0. 0. 0. 4440. 8881. 4442. 8885. 4444. 8889. 4446. 4447. 4448. 4441. 4443. 4445. 4446. 4447. 4448. 0. 0. 0. 0. 0. 0. +8290. 8292. 8294. 8290. 8292. 8294. 0. 0. 0. 0. 0. 0. 8490. 8492. 8494. 8490. 8492. 8494. 0. 0. 0. 0. 0. 0. 8690. 17382. 8694. 17390. 8698. 17398. 8702. 8704. 8706. 8692. 8696. 8700. 8702. 8704. 8706. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 8890. 17782. 8894. 17790. 8898. 17798. 8902. 8904. 8906. 8892. 8896. 8900. 8902. 8904. 8906. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4160. 4161. 4162. 4160. 4161. 4162. 0. 0. 0. 4260. 4261. 4262. 4260. 4261. 4262. 0. 0. 0. 4360. 8721. 4362. 8725. 4364. 8729. 4366. 4367. 4368. 4361. 4363. 4365. 4366. 4367. 4368. 0. 0. 0. 0. 0. 0. 4460. 8921. 4462. 8925. 4464. 8929. 4466. 4467. 4468. 4461. 4463. 4465. 4466. 4467. 4468. 0. 0. 0. 0. 0. 0. +4170. 4171. 4172. 4170. 4171. 4172. 0. 0. 0. 0. 0. 0. 4270. 4271. 4272. 4270. 4271. 4272. 0. 0. 0. 0. 0. 0. 4370. 8741. 4372. 8745. 4374. 8749. 4376. 4377. 4378. 4371. 4373. 4375. 4376. 4377. 4378. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4470. 8941. 4472. 8945. 4474. 8949. 4476. 4477. 4478. 4471. 4473. 4475. 4476. 4477. 4478. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4180. 4181. 4182. 4180. 4181. 4182. 0. 0. 0. 4280. 4281. 4282. 4280. 4281. 4282. 0. 0. 0. 4380. 8761. 4382. 8765. 4384. 8769. 4386. 4387. 4388. 4381. 4383. 4385. 4386. 4387. 4388. 0. 0. 0. 0. 0. 0. 4480. 8961. 4482. 8965. 4484. 8969. 4486. 4487. 4488. 4481. 4483. 4485. 4486. 4487. 4488. 0. 0. 0. 0. 0. 0. +4110. 4111. 4112. 4110. 4111. 4112. 0. 0. 0. 4210. 4211. 4212. 4210. 4211. 4212. 0. 0. 0. 4310. 8621. 4312. 8625. 4314. 8629. 4316. 4317. 4318. 4311. 4313. 4315. 4316. 4317. 4318. 0. 0. 0. 0. 0. 0. 4410. 8821. 4412. 8825. 4414. 8829. 4416. 4417. 4418. 4411. 4413. 4415. 4416. 4417. 4418. 0. 0. 0. 0. 0. 0. +4130. 4131. 4132. 4130. 4131. 4132. 0. 0. 0. 0. 0. 0. 4230. 4231. 4232. 4230. 4231. 4232. 0. 0. 0. 0. 0. 0. 4330. 8661. 4332. 8665. 4334. 8669. 4336. 4337. 4338. 4331. 4333. 4335. 4336. 4337. 4338. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4430. 8861. 4432. 8865. 4434. 8869. 4436. 4437. 4438. 4431. 4433. 4435. 4436. 4437. 4438. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4150. 4151. 4152. 4150. 4151. 4152. 0. 0. 0. 4250. 4251. 4252. 4250. 4251. 4252. 0. 0. 0. 4350. 8701. 4352. 8705. 4354. 8709. 4356. 4357. 4358. 4351. 4353. 4355. 4356. 4357. 4358. 0. 0. 0. 0. 0. 0. 4450. 8901. 4452. 8905. 4454. 8909. 4456. 4457. 4458. 4451. 4453. 4455. 4456. 4457. 4458. 0. 0. 0. 0. 0. 0. +4160. 4161. 4162. 4160. 4161. 4162. 0. 0. 0. 4260. 4261. 4262. 4260. 4261. 4262. 0. 0. 0. 4360. 8721. 4362. 8725. 4364. 8729. 4366. 4367. 4368. 4361. 4363. 4365. 4366. 4367. 4368. 0. 0. 0. 0. 0. 0. 4460. 8921. 4462. 8925. 4464. 8929. 4466. 4467. 4468. 4461. 4463. 4465. 4466. 4467. 4468. 0. 0. 0. 0. 0. 0. +4170. 4171. 4172. 4170. 4171. 4172. 0. 0. 0. 0. 0. 0. 4270. 4271. 4272. 4270. 4271. 4272. 0. 0. 0. 0. 0. 0. 4370. 8741. 4372. 8745. 4374. 8749. 4376. 4377. 4378. 4371. 4373. 4375. 4376. 4377. 4378. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4470. 8941. 4472. 8945. 4474. 8949. 4476. 4477. 4478. 4471. 4473. 4475. 4476. 4477. 4478. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4180. 4181. 4182. 4180. 4181. 4182. 0. 0. 0. 4280. 4281. 4282. 4280. 4281. 4282. 0. 0. 0. 4380. 8761. 4382. 8765. 4384. 8769. 4386. 4387. 4388. 4381. 4383. 4385. 4386. 4387. 4388. 0. 0. 0. 0. 0. 0. 4480. 8961. 4482. 8965. 4484. 8969. 4486. 4487. 4488. 4481. 4483. 4485. 4486. 4487. 4488. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +DEAL::FESystem<2>[FE_Q<2>(2)^2-FE_DGP<2>(1)^2] +DEAL::DoFs 74 +DEAL::cell +1100. 1101. 1102. 1103. 1104. 1105. 1106. 1107. 1108. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1200. 1201. 1202. 1203. 1204. 1205. 1206. 1207. 1208. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1300. 1301. 1302. 0. 0. 0. 0. 0. 0. 1400. 1401. 1402. 0. 0. 0. 0. 0. 0. +1110. 1111. 1112. 1113. 1114. 1115. 1116. 1117. 1118. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1210. 1211. 1212. 1213. 1214. 1215. 1216. 1217. 1218. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1310. 1311. 1312. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1410. 1411. 1412. 0. 0. 0. 0. 0. 0. 0. 0. 0. +1120. 1121. 1122. 1123. 1124. 1125. 1126. 1127. 1128. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1220. 1221. 1222. 1223. 1224. 1225. 1226. 1227. 1228. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1320. 1321. 1322. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1420. 1421. 1422. 0. 0. 0. 0. 0. 0. 0. 0. 0. +1130. 1131. 1132. 1133. 1134. 1135. 1136. 1137. 1138. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1230. 1231. 1232. 1233. 1234. 1235. 1236. 1237. 1238. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1330. 1331. 1332. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1430. 1431. 1432. 0. 0. 0. 0. 0. 0. 0. 0. 0. +1140. 1141. 1142. 1143. 1144. 1145. 1146. 1147. 1148. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1240. 1241. 1242. 1243. 1244. 1245. 1246. 1247. 1248. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1340. 1341. 1342. 0. 0. 0. 0. 0. 0. 1440. 1441. 1442. 0. 0. 0. 0. 0. 0. +1150. 1151. 1152. 1153. 1154. 1155. 1156. 1157. 1158. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1250. 1251. 1252. 1253. 1254. 1255. 1256. 1257. 1258. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1350. 1351. 1352. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1450. 1451. 1452. 0. 0. 0. 0. 0. 0. 0. 0. 0. +1160. 1161. 1162. 1163. 1164. 1165. 1166. 1167. 1168. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1260. 1261. 1262. 1263. 1264. 1265. 1266. 1267. 1268. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1360. 1361. 1362. 0. 0. 0. 0. 0. 0. 1460. 1461. 1462. 0. 0. 0. 0. 0. 0. +1170. 1171. 1172. 1173. 1174. 1175. 1176. 1177. 1178. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1270. 1271. 1272. 1273. 1274. 1275. 1276. 1277. 1278. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1370. 1371. 1372. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1470. 1471. 1472. 0. 0. 0. 0. 0. 0. 0. 0. 0. +1180. 1181. 1182. 1183. 1184. 1185. 1186. 1187. 1188. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1280. 1281. 1282. 1283. 1284. 1285. 1286. 1287. 1288. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1380. 1381. 1382. 0. 0. 0. 0. 0. 0. 1480. 1481. 1482. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2100. 2101. 2102. 2103. 2104. 2105. 2106. 2107. 2108. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2200. 2201. 2202. 2203. 2204. 2205. 2206. 2207. 2208. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2300. 2301. 2302. 0. 0. 0. 0. 0. 0. 2400. 2401. 2402. 0. 0. 0. 0. 0. 0. +2110. 2111. 2112. 2113. 2114. 2115. 2116. 2117. 2118. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2210. 2211. 2212. 2213. 2214. 2215. 2216. 2217. 2218. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2310. 2311. 2312. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2410. 2411. 2412. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2120. 2121. 2122. 2123. 2124. 2125. 2126. 2127. 2128. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2220. 2221. 2222. 2223. 2224. 2225. 2226. 2227. 2228. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2320. 2321. 2322. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2420. 2421. 2422. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2130. 2131. 2132. 2133. 2134. 2135. 2136. 2137. 2138. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2230. 2231. 2232. 2233. 2234. 2235. 2236. 2237. 2238. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2330. 2331. 2332. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2430. 2431. 2432. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2140. 2141. 2142. 2143. 2144. 2145. 2146. 2147. 2148. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2240. 2241. 2242. 2243. 2244. 2245. 2246. 2247. 2248. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2340. 2341. 2342. 0. 0. 0. 0. 0. 0. 2440. 2441. 2442. 0. 0. 0. 0. 0. 0. +2150. 2151. 2152. 2153. 2154. 2155. 2156. 2157. 2158. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2250. 2251. 2252. 2253. 2254. 2255. 2256. 2257. 2258. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2350. 2351. 2352. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2450. 2451. 2452. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2160. 2161. 2162. 2163. 2164. 2165. 2166. 2167. 2168. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2260. 2261. 2262. 2263. 2264. 2265. 2266. 2267. 2268. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2360. 2361. 2362. 0. 0. 0. 0. 0. 0. 2460. 2461. 2462. 0. 0. 0. 0. 0. 0. +2170. 2171. 2172. 2173. 2174. 2175. 2176. 2177. 2178. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2270. 2271. 2272. 2273. 2274. 2275. 2276. 2277. 2278. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2370. 2371. 2372. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2470. 2471. 2472. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2180. 2181. 2182. 2183. 2184. 2185. 2186. 2187. 2188. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2280. 2281. 2282. 2283. 2284. 2285. 2286. 2287. 2288. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2380. 2381. 2382. 0. 0. 0. 0. 0. 0. 2480. 2481. 2482. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3100. 3101. 3102. 3103. 3104. 3105. 3106. 3107. 3108. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3200. 3201. 3202. 3203. 3204. 3205. 3206. 3207. 3208. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3300. 3301. 3302. 0. 0. 0. 0. 0. 0. 3400. 3401. 3402. 0. 0. 0. 0. 0. 0. +3110. 3111. 3112. 3113. 3114. 3115. 3116. 3117. 3118. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3210. 3211. 3212. 3213. 3214. 3215. 3216. 3217. 3218. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3310. 3311. 3312. 0. 0. 0. 0. 0. 0. 3410. 3411. 3412. 0. 0. 0. 0. 0. 0. +3120. 3121. 3122. 3123. 3124. 3125. 3126. 3127. 3128. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3220. 3221. 3222. 3223. 3224. 3225. 3226. 3227. 3228. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 3320. 3321. 3322. 0. 0. 0. 0. 0. 0. 3420. 3421. 3422. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4100. 4101. 4102. 4103. 4104. 4105. 4106. 4107. 4108. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4200. 4201. 4202. 4203. 4204. 4205. 4206. 4207. 4208. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4300. 4301. 4302. 0. 0. 0. 0. 0. 0. 4400. 4401. 4402. 0. 0. 0. 0. 0. 0. +4110. 4111. 4112. 4113. 4114. 4115. 4116. 4117. 4118. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4210. 4211. 4212. 4213. 4214. 4215. 4216. 4217. 4218. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4310. 4311. 4312. 0. 0. 0. 0. 0. 0. 4410. 4411. 4412. 0. 0. 0. 0. 0. 0. +4120. 4121. 4122. 4123. 4124. 4125. 4126. 4127. 4128. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4220. 4221. 4222. 4223. 4224. 4225. 4226. 4227. 4228. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4320. 4321. 4322. 0. 0. 0. 0. 0. 0. 4420. 4421. 4422. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +DEAL::face +1100. 2201. 1102. 2205. 1104. 2209. 1106. 1107. 1108. 1101. 1103. 1105. 1106. 1107. 1108. 0. 0. 0. 0. 0. 0. 1200. 2401. 1202. 2405. 1204. 2409. 1206. 1207. 1208. 1201. 1203. 1205. 1206. 1207. 1208. 0. 0. 0. 0. 0. 0. 1300. 1301. 1302. 1300. 1301. 1302. 0. 0. 0. 1400. 1401. 1402. 1400. 1401. 1402. 0. 0. 0. +2210. 4422. 2214. 4430. 2218. 4438. 2222. 2224. 2226. 2212. 2216. 2220. 2222. 2224. 2226. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2410. 4822. 2414. 4830. 2418. 4838. 2422. 2424. 2426. 2412. 2416. 2420. 2422. 2424. 2426. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2610. 2612. 2614. 2610. 2612. 2614. 0. 0. 0. 0. 0. 0. 2810. 2812. 2814. 2810. 2812. 2814. 0. 0. 0. 0. 0. 0. +1120. 2241. 1122. 2245. 1124. 2249. 1126. 1127. 1128. 1121. 1123. 1125. 1126. 1127. 1128. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1220. 2441. 1222. 2445. 1224. 2449. 1226. 1227. 1228. 1221. 1223. 1225. 1226. 1227. 1228. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1320. 1321. 1322. 1320. 1321. 1322. 0. 0. 0. 0. 0. 0. 1420. 1421. 1422. 1420. 1421. 1422. 0. 0. 0. 0. 0. 0. +2250. 4502. 2254. 4510. 2258. 4518. 2262. 2264. 2266. 2252. 2256. 2260. 2262. 2264. 2266. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2450. 4902. 2454. 4910. 2458. 4918. 2462. 2464. 2466. 2452. 2456. 2460. 2462. 2464. 2466. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2650. 2652. 2654. 2650. 2652. 2654. 0. 0. 0. 0. 0. 0. 2850. 2852. 2854. 2850. 2852. 2854. 0. 0. 0. 0. 0. 0. +1140. 2281. 1142. 2285. 1144. 2289. 1146. 1147. 1148. 1141. 1143. 1145. 1146. 1147. 1148. 0. 0. 0. 0. 0. 0. 1240. 2481. 1242. 2485. 1244. 2489. 1246. 1247. 1248. 1241. 1243. 1245. 1246. 1247. 1248. 0. 0. 0. 0. 0. 0. 1340. 1341. 1342. 1340. 1341. 1342. 0. 0. 0. 1440. 1441. 1442. 1440. 1441. 1442. 0. 0. 0. +2290. 4582. 2294. 4590. 2298. 4598. 2302. 2304. 2306. 2292. 2296. 2300. 2302. 2304. 2306. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2490. 4982. 2494. 4990. 2498. 4998. 2502. 2504. 2506. 2492. 2496. 2500. 2502. 2504. 2506. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2690. 2692. 2694. 2690. 2692. 2694. 0. 0. 0. 0. 0. 0. 2890. 2892. 2894. 2890. 2892. 2894. 0. 0. 0. 0. 0. 0. +1160. 2321. 1162. 2325. 1164. 2329. 1166. 1167. 1168. 1161. 1163. 1165. 1166. 1167. 1168. 0. 0. 0. 0. 0. 0. 1260. 2521. 1262. 2525. 1264. 2529. 1266. 1267. 1268. 1261. 1263. 1265. 1266. 1267. 1268. 0. 0. 0. 0. 0. 0. 1360. 1361. 1362. 1360. 1361. 1362. 0. 0. 0. 1460. 1461. 1462. 1460. 1461. 1462. 0. 0. 0. +1170. 2341. 1172. 2345. 1174. 2349. 1176. 1177. 1178. 1171. 1173. 1175. 1176. 1177. 1178. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1270. 2541. 1272. 2545. 1274. 2549. 1276. 1277. 1278. 1271. 1273. 1275. 1276. 1277. 1278. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1370. 1371. 1372. 1370. 1371. 1372. 0. 0. 0. 0. 0. 0. 1470. 1471. 1472. 1470. 1471. 1472. 0. 0. 0. 0. 0. 0. +1180. 2361. 1182. 2365. 1184. 2369. 1186. 1187. 1188. 1181. 1183. 1185. 1186. 1187. 1188. 0. 0. 0. 0. 0. 0. 1280. 2561. 1282. 2565. 1284. 2569. 1286. 1287. 1288. 1281. 1283. 1285. 1286. 1287. 1288. 0. 0. 0. 0. 0. 0. 1380. 1381. 1382. 1380. 1381. 1382. 0. 0. 0. 1480. 1481. 1482. 1480. 1481. 1482. 0. 0. 0. +1110. 2221. 1112. 2225. 1114. 2229. 1116. 1117. 1118. 1111. 1113. 1115. 1116. 1117. 1118. 0. 0. 0. 0. 0. 0. 1210. 2421. 1212. 2425. 1214. 2429. 1216. 1217. 1218. 1211. 1213. 1215. 1216. 1217. 1218. 0. 0. 0. 0. 0. 0. 1310. 1311. 1312. 1310. 1311. 1312. 0. 0. 0. 1410. 1411. 1412. 1410. 1411. 1412. 0. 0. 0. +1130. 2261. 1132. 2265. 1134. 2269. 1136. 1137. 1138. 1131. 1133. 1135. 1136. 1137. 1138. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1230. 2461. 1232. 2465. 1234. 2469. 1236. 1237. 1238. 1231. 1233. 1235. 1236. 1237. 1238. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1330. 1331. 1332. 1330. 1331. 1332. 0. 0. 0. 0. 0. 0. 1430. 1431. 1432. 1430. 1431. 1432. 0. 0. 0. 0. 0. 0. +1150. 2301. 1152. 2305. 1154. 2309. 1156. 1157. 1158. 1151. 1153. 1155. 1156. 1157. 1158. 0. 0. 0. 0. 0. 0. 1250. 2501. 1252. 2505. 1254. 2509. 1256. 1257. 1258. 1251. 1253. 1255. 1256. 1257. 1258. 0. 0. 0. 0. 0. 0. 1350. 1351. 1352. 1350. 1351. 1352. 0. 0. 0. 1450. 1451. 1452. 1450. 1451. 1452. 0. 0. 0. +1160. 2321. 1162. 2325. 1164. 2329. 1166. 1167. 1168. 1161. 1163. 1165. 1166. 1167. 1168. 0. 0. 0. 0. 0. 0. 1260. 2521. 1262. 2525. 1264. 2529. 1266. 1267. 1268. 1261. 1263. 1265. 1266. 1267. 1268. 0. 0. 0. 0. 0. 0. 1360. 1361. 1362. 1360. 1361. 1362. 0. 0. 0. 1460. 1461. 1462. 1460. 1461. 1462. 0. 0. 0. +1170. 2341. 1172. 2345. 1174. 2349. 1176. 1177. 1178. 1171. 1173. 1175. 1176. 1177. 1178. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1270. 2541. 1272. 2545. 1274. 2549. 1276. 1277. 1278. 1271. 1273. 1275. 1276. 1277. 1278. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 1370. 1371. 1372. 1370. 1371. 1372. 0. 0. 0. 0. 0. 0. 1470. 1471. 1472. 1470. 1471. 1472. 0. 0. 0. 0. 0. 0. +1180. 2361. 1182. 2365. 1184. 2369. 1186. 1187. 1188. 1181. 1183. 1185. 1186. 1187. 1188. 0. 0. 0. 0. 0. 0. 1280. 2561. 1282. 2565. 1284. 2569. 1286. 1287. 1288. 1281. 1283. 1285. 1286. 1287. 1288. 0. 0. 0. 0. 0. 0. 1380. 1381. 1382. 1380. 1381. 1382. 0. 0. 0. 1480. 1481. 1482. 1480. 1481. 1482. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +2100. 4201. 2102. 4205. 2104. 4209. 2106. 2107. 2108. 2101. 2103. 2105. 2106. 2107. 2108. 0. 0. 0. 0. 0. 0. 2200. 4401. 2202. 4405. 2204. 4409. 2206. 2207. 2208. 2201. 2203. 2205. 2206. 2207. 2208. 0. 0. 0. 0. 0. 0. 2300. 2301. 2302. 2300. 2301. 2302. 0. 0. 0. 2400. 2401. 2402. 2400. 2401. 2402. 0. 0. 0. +4210. 8422. 4214. 8430. 4218. 8438. 4222. 4224. 4226. 4212. 4216. 4220. 4222. 4224. 4226. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4410. 8822. 4414. 8830. 4418. 8838. 4422. 4424. 4426. 4412. 4416. 4420. 4422. 4424. 4426. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4610. 4612. 4614. 4610. 4612. 4614. 0. 0. 0. 0. 0. 0. 4810. 4812. 4814. 4810. 4812. 4814. 0. 0. 0. 0. 0. 0. +2120. 4241. 2122. 4245. 2124. 4249. 2126. 2127. 2128. 2121. 2123. 2125. 2126. 2127. 2128. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2220. 4441. 2222. 4445. 2224. 4449. 2226. 2227. 2228. 2221. 2223. 2225. 2226. 2227. 2228. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2320. 2321. 2322. 2320. 2321. 2322. 0. 0. 0. 0. 0. 0. 2420. 2421. 2422. 2420. 2421. 2422. 0. 0. 0. 0. 0. 0. +4250. 8502. 4254. 8510. 4258. 8518. 4262. 4264. 4266. 4252. 4256. 4260. 4262. 4264. 4266. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4450. 8902. 4454. 8910. 4458. 8918. 4462. 4464. 4466. 4452. 4456. 4460. 4462. 4464. 4466. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4650. 4652. 4654. 4650. 4652. 4654. 0. 0. 0. 0. 0. 0. 4850. 4852. 4854. 4850. 4852. 4854. 0. 0. 0. 0. 0. 0. +2140. 4281. 2142. 4285. 2144. 4289. 2146. 2147. 2148. 2141. 2143. 2145. 2146. 2147. 2148. 0. 0. 0. 0. 0. 0. 2240. 4481. 2242. 4485. 2244. 4489. 2246. 2247. 2248. 2241. 2243. 2245. 2246. 2247. 2248. 0. 0. 0. 0. 0. 0. 2340. 2341. 2342. 2340. 2341. 2342. 0. 0. 0. 2440. 2441. 2442. 2440. 2441. 2442. 0. 0. 0. +4290. 8582. 4294. 8590. 4298. 8598. 4302. 4304. 4306. 4292. 4296. 4300. 4302. 4304. 4306. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4490. 8982. 4494. 8990. 4498. 8998. 4502. 4504. 4506. 4492. 4496. 4500. 4502. 4504. 4506. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 4690. 4692. 4694. 4690. 4692. 4694. 0. 0. 0. 0. 0. 0. 4890. 4892. 4894. 4890. 4892. 4894. 0. 0. 0. 0. 0. 0. +2160. 4321. 2162. 4325. 2164. 4329. 2166. 2167. 2168. 2161. 2163. 2165. 2166. 2167. 2168. 0. 0. 0. 0. 0. 0. 2260. 4521. 2262. 4525. 2264. 4529. 2266. 2267. 2268. 2261. 2263. 2265. 2266. 2267. 2268. 0. 0. 0. 0. 0. 0. 2360. 2361. 2362. 2360. 2361. 2362. 0. 0. 0. 2460. 2461. 2462. 2460. 2461. 2462. 0. 0. 0. +2170. 4341. 2172. 4345. 2174. 4349. 2176. 2177. 2178. 2171. 2173. 2175. 2176. 2177. 2178. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2270. 4541. 2272. 4545. 2274. 4549. 2276. 2277. 2278. 2271. 2273. 2275. 2276. 2277. 2278. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2370. 2371. 2372. 2370. 2371. 2372. 0. 0. 0. 0. 0. 0. 2470. 2471. 2472. 2470. 2471. 2472. 0. 0. 0. 0. 0. 0. +2180. 4361. 2182. 4365. 2184. 4369. 2186. 2187. 2188. 2181. 2183. 2185. 2186. 2187. 2188. 0. 0. 0. 0. 0. 0. 2280. 4561. 2282. 4565. 2284. 4569. 2286. 2287. 2288. 2281. 2283. 2285. 2286. 2287. 2288. 0. 0. 0. 0. 0. 0. 2380. 2381. 2382. 2380. 2381. 2382. 0. 0. 0. 2480. 2481. 2482. 2480. 2481. 2482. 0. 0. 0. +2110. 4221. 2112. 4225. 2114. 4229. 2116. 2117. 2118. 2111. 2113. 2115. 2116. 2117. 2118. 0. 0. 0. 0. 0. 0. 2210. 4421. 2212. 4425. 2214. 4429. 2216. 2217. 2218. 2211. 2213. 2215. 2216. 2217. 2218. 0. 0. 0. 0. 0. 0. 2310. 2311. 2312. 2310. 2311. 2312. 0. 0. 0. 2410. 2411. 2412. 2410. 2411. 2412. 0. 0. 0. +2130. 4261. 2132. 4265. 2134. 4269. 2136. 2137. 2138. 2131. 2133. 2135. 2136. 2137. 2138. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2230. 4461. 2232. 4465. 2234. 4469. 2236. 2237. 2238. 2231. 2233. 2235. 2236. 2237. 2238. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2330. 2331. 2332. 2330. 2331. 2332. 0. 0. 0. 0. 0. 0. 2430. 2431. 2432. 2430. 2431. 2432. 0. 0. 0. 0. 0. 0. +2150. 4301. 2152. 4305. 2154. 4309. 2156. 2157. 2158. 2151. 2153. 2155. 2156. 2157. 2158. 0. 0. 0. 0. 0. 0. 2250. 4501. 2252. 4505. 2254. 4509. 2256. 2257. 2258. 2251. 2253. 2255. 2256. 2257. 2258. 0. 0. 0. 0. 0. 0. 2350. 2351. 2352. 2350. 2351. 2352. 0. 0. 0. 2450. 2451. 2452. 2450. 2451. 2452. 0. 0. 0. +2160. 4321. 2162. 4325. 2164. 4329. 2166. 2167. 2168. 2161. 2163. 2165. 2166. 2167. 2168. 0. 0. 0. 0. 0. 0. 2260. 4521. 2262. 4525. 2264. 4529. 2266. 2267. 2268. 2261. 2263. 2265. 2266. 2267. 2268. 0. 0. 0. 0. 0. 0. 2360. 2361. 2362. 2360. 2361. 2362. 0. 0. 0. 2460. 2461. 2462. 2460. 2461. 2462. 0. 0. 0. +2170. 4341. 2172. 4345. 2174. 4349. 2176. 2177. 2178. 2171. 2173. 2175. 2176. 2177. 2178. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2270. 4541. 2272. 4545. 2274. 4549. 2276. 2277. 2278. 2271. 2273. 2275. 2276. 2277. 2278. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 2370. 2371. 2372. 2370. 2371. 2372. 0. 0. 0. 0. 0. 0. 2470. 2471. 2472. 2470. 2471. 2472. 0. 0. 0. 0. 0. 0. +2180. 4361. 2182. 4365. 2184. 4369. 2186. 2187. 2188. 2181. 2183. 2185. 2186. 2187. 2188. 0. 0. 0. 0. 0. 0. 2280. 4561. 2282. 4565. 2284. 4569. 2286. 2287. 2288. 2281. 2283. 2285. 2286. 2287. 2288. 0. 0. 0. 0. 0. 0. 2380. 2381. 2382. 2380. 2381. 2382. 0. 0. 0. 2480. 2481. 2482. 2480. 2481. 2482. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +3100. 6201. 3102. 6205. 3104. 6209. 3106. 3107. 3108. 3101. 3103. 3105. 3106. 3107. 3108. 0. 0. 0. 0. 0. 0. 3200. 6401. 3202. 6405. 3204. 6409. 3206. 3207. 3208. 3201. 3203. 3205. 3206. 3207. 3208. 0. 0. 0. 0. 0. 0. 3300. 3301. 3302. 3300. 3301. 3302. 0. 0. 0. 3400. 3401. 3402. 3400. 3401. 3402. 0. 0. 0. +3110. 6221. 3112. 6225. 3114. 6229. 3116. 3117. 3118. 3111. 3113. 3115. 3116. 3117. 3118. 0. 0. 0. 0. 0. 0. 3210. 6421. 3212. 6425. 3214. 6429. 3216. 3217. 3218. 3211. 3213. 3215. 3216. 3217. 3218. 0. 0. 0. 0. 0. 0. 3310. 3311. 3312. 3310. 3311. 3312. 0. 0. 0. 3410. 3411. 3412. 3410. 3411. 3412. 0. 0. 0. +3120. 6241. 3122. 6245. 3124. 6249. 3126. 3127. 3128. 3121. 3123. 3125. 3126. 3127. 3128. 0. 0. 0. 0. 0. 0. 3220. 6441. 3222. 6445. 3224. 6449. 3226. 3227. 3228. 3221. 3223. 3225. 3226. 3227. 3228. 0. 0. 0. 0. 0. 0. 3320. 3321. 3322. 3320. 3321. 3322. 0. 0. 0. 3420. 3421. 3422. 3420. 3421. 3422. 0. 0. 0. +3100. 6201. 3102. 6205. 3104. 6209. 3106. 3107. 3108. 3101. 3103. 3105. 3106. 3107. 3108. 0. 0. 0. 0. 0. 0. 3200. 6401. 3202. 6405. 3204. 6409. 3206. 3207. 3208. 3201. 3203. 3205. 3206. 3207. 3208. 0. 0. 0. 0. 0. 0. 3300. 3301. 3302. 3300. 3301. 3302. 0. 0. 0. 3400. 3401. 3402. 3400. 3401. 3402. 0. 0. 0. +3110. 6221. 3112. 6225. 3114. 6229. 3116. 3117. 3118. 3111. 3113. 3115. 3116. 3117. 3118. 0. 0. 0. 0. 0. 0. 3210. 6421. 3212. 6425. 3214. 6429. 3216. 3217. 3218. 3211. 3213. 3215. 3216. 3217. 3218. 0. 0. 0. 0. 0. 0. 3310. 3311. 3312. 3310. 3311. 3312. 0. 0. 0. 3410. 3411. 3412. 3410. 3411. 3412. 0. 0. 0. +3120. 6241. 3122. 6245. 3124. 6249. 3126. 3127. 3128. 3121. 3123. 3125. 3126. 3127. 3128. 0. 0. 0. 0. 0. 0. 3220. 6441. 3222. 6445. 3224. 6449. 3226. 3227. 3228. 3221. 3223. 3225. 3226. 3227. 3228. 0. 0. 0. 0. 0. 0. 3320. 3321. 3322. 3320. 3321. 3322. 0. 0. 0. 3420. 3421. 3422. 3420. 3421. 3422. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +4100. 8201. 4102. 8205. 4104. 8209. 4106. 4107. 4108. 4101. 4103. 4105. 4106. 4107. 4108. 0. 0. 0. 0. 0. 0. 4200. 8401. 4202. 8405. 4204. 8409. 4206. 4207. 4208. 4201. 4203. 4205. 4206. 4207. 4208. 0. 0. 0. 0. 0. 0. 4300. 4301. 4302. 4300. 4301. 4302. 0. 0. 0. 4400. 4401. 4402. 4400. 4401. 4402. 0. 0. 0. +4110. 8221. 4112. 8225. 4114. 8229. 4116. 4117. 4118. 4111. 4113. 4115. 4116. 4117. 4118. 0. 0. 0. 0. 0. 0. 4210. 8421. 4212. 8425. 4214. 8429. 4216. 4217. 4218. 4211. 4213. 4215. 4216. 4217. 4218. 0. 0. 0. 0. 0. 0. 4310. 4311. 4312. 4310. 4311. 4312. 0. 0. 0. 4410. 4411. 4412. 4410. 4411. 4412. 0. 0. 0. +4120. 8241. 4122. 8245. 4124. 8249. 4126. 4127. 4128. 4121. 4123. 4125. 4126. 4127. 4128. 0. 0. 0. 0. 0. 0. 4220. 8441. 4222. 8445. 4224. 8449. 4226. 4227. 4228. 4221. 4223. 4225. 4226. 4227. 4228. 0. 0. 0. 0. 0. 0. 4320. 4321. 4322. 4320. 4321. 4322. 0. 0. 0. 4420. 4421. 4422. 4420. 4421. 4422. 0. 0. 0. +4100. 8201. 4102. 8205. 4104. 8209. 4106. 4107. 4108. 4101. 4103. 4105. 4106. 4107. 4108. 0. 0. 0. 0. 0. 0. 4200. 8401. 4202. 8405. 4204. 8409. 4206. 4207. 4208. 4201. 4203. 4205. 4206. 4207. 4208. 0. 0. 0. 0. 0. 0. 4300. 4301. 4302. 4300. 4301. 4302. 0. 0. 0. 4400. 4401. 4402. 4400. 4401. 4402. 0. 0. 0. +4110. 8221. 4112. 8225. 4114. 8229. 4116. 4117. 4118. 4111. 4113. 4115. 4116. 4117. 4118. 0. 0. 0. 0. 0. 0. 4210. 8421. 4212. 8425. 4214. 8429. 4216. 4217. 4218. 4211. 4213. 4215. 4216. 4217. 4218. 0. 0. 0. 0. 0. 0. 4310. 4311. 4312. 4310. 4311. 4312. 0. 0. 0. 4410. 4411. 4412. 4410. 4411. 4412. 0. 0. 0. +4120. 8241. 4122. 8245. 4124. 8249. 4126. 4127. 4128. 4121. 4123. 4125. 4126. 4127. 4128. 0. 0. 0. 0. 0. 0. 4220. 8441. 4222. 8445. 4224. 8449. 4226. 4227. 4228. 4221. 4223. 4225. 4226. 4227. 4228. 0. 0. 0. 0. 0. 0. 4320. 4321. 4322. 4320. 4321. 4322. 0. 0. 0. 4420. 4421. 4422. 4420. 4421. 4422. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. +0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. + 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. 0. diff --git a/tests/integrators/assembler_simple_matrix_03tri.cc b/tests/integrators/assembler_simple_matrix_03tri.cc index aa5861d52b..69cf1ebdc4 100644 --- a/tests/integrators/assembler_simple_matrix_03tri.cc +++ b/tests/integrators/assembler_simple_matrix_03tri.cc @@ -85,7 +85,6 @@ void test(FiniteElement &fe) MeshWorker::Assembler::MatrixSimple ass; ass.initialize(M); - ass.initialize_local_blocks(dof.block_info().local()); MeshWorker::DoFInfo info(dof.block_info()); ass.initialize_info(info, false); MeshWorker::DoFInfo infon(dof.block_info()); diff --git a/tests/integrators/assembler_simple_matrix_04.cc b/tests/integrators/assembler_simple_matrix_04.cc index e39727c1d5..024f346824 100644 --- a/tests/integrators/assembler_simple_matrix_04.cc +++ b/tests/integrators/assembler_simple_matrix_04.cc @@ -85,7 +85,6 @@ void test(FiniteElement &fe) MeshWorker::Assembler::MatrixSimple > ass; ass.initialize(M); - ass.initialize_local_blocks(dof.block_info().local()); MeshWorker::DoFInfo info(dof.block_info()); ass.initialize_info(info, false); MeshWorker::DoFInfo infon(dof.block_info()); diff --git a/tests/integrators/assembler_simple_mgmatrix_02.cc b/tests/integrators/assembler_simple_mgmatrix_02.cc index f158627214..739b9238e6 100644 --- a/tests/integrators/assembler_simple_mgmatrix_02.cc +++ b/tests/integrators/assembler_simple_mgmatrix_02.cc @@ -55,7 +55,6 @@ void test(FiniteElement &fe) typename DoFHandler::face_iterator face = cell->face(1); MeshWorker::Assembler::MGMatrixSimple > ass; - ass.initialize_local_blocks(dof.block_info().local()); MeshWorker::DoFInfo info(dof.block_info()); ass.initialize_info(info, false); diff --git a/tests/integrators/assembler_simple_mgmatrix_03.cc b/tests/integrators/assembler_simple_mgmatrix_03.cc index 1b2e1e7098..aa865921b3 100644 --- a/tests/integrators/assembler_simple_mgmatrix_03.cc +++ b/tests/integrators/assembler_simple_mgmatrix_03.cc @@ -92,7 +92,6 @@ void test(FiniteElement &fe) MeshWorker::Assembler::MGMatrixSimple > ass; ass.initialize(matrix); - ass.initialize_local_blocks(dof.block_info().local()); MeshWorker::DoFInfo info(dof.block_info()); ass.initialize_info(info, false); MeshWorker::DoFInfo infon(dof.block_info());