* More information on this topic can be found in the documentation of
* FESystem, the @ref vector_valued module and the tutorial programs
* referenced therein.
+ *
+ * <i>Selecting blocks:</i>
+ * Many functions allow you to restrict their operation to certain
+ * vector components or blocks. For example, this is the case for
+ * the functions that interpolate boundary values: one may want
+ * to only interpolate the boundary values for the velocity block of
+ * a finite element field but not the pressure block. The way to do
+ * this is by passing a BlockMask argument to such functions, see the
+ * @ref GlossBlockMask "block mask entry of this glossary".
* </dd>
*
*
+ * <dt class="glossary">@anchor GlossBlockMask <b>Block mask</b></dt>
+ *
+ * <dd>
+ * In much the same way as one can think of elements as being composed
+ * of physical vector components (see @ref GlossComponent) or logical
+ * blocks (see @ref GlossBlock), there is frequently a need to select
+ * a set of such blocks for operations that are not intended to be run
+ * on <i>all</i> blocks of a finite element space. Selecting which blocks
+ * to work on happens using the BlockMask class.
+ *
+ * Block masks work in much the same way as component masks, including the
+ * fact that the BlockMask class has similar semantics to the ComponentMask
+ * class. See @ref GlossComponentMask "the glossary entry on component masks"
+ * for more information.
+ *
+ * @note While components and blocks provide two alternate but equally valid
+ * viewpoints on finite elements with multiple vector components, the fact
+ * is that throughout the library there are far more places where you can
+ * pass a ComponentMask argument rather than a BlockMask argument. Fortunately,
+ * one can be converted into the other, using the syntax
+ * <code>fe.component_mask(block_mask)</code> where <code>block_mask</code>
+ * is a variable of type BlockMask. In other words, if you have a block
+ * mask but need to call a function that only accepts a component mask, this
+ * syntax can be used to obtain the necessary component mask.
+ *
+ * <b>Creation of block masks:</b>
+ * Block masks are typically created by asking the finite element
+ * to generate a block mask from certain selected vector components using
+ * code such as this where we create a mask that only denotes the
+ * velocity components of a Stokes element (see @ref vector_valued):
+ * @code
+ * FESystem<dim> stokes_fe (FESystem<dim>(FE_Q<dim>(2), dim), 1, // Q2 element for the velocities
+ * FE_Q<dim>(1), 1); // Q1 element for the pressure
+ * FEValuesExtractors::Scalar pressure(dim);
+ * BlockMask pressure_mask = stokes_fe.block_mask (pressure);
+ * @endcode
+ * The result is a block mask that, in 1d as well as 2d and 3d, would have values
+ * <code>[false, true]</code>. Similarly, using
+ * @code
+ * FEValuesExtractors::Vector velocities(0);
+ * BlockMask velocity_mask = stokes_fe.block_mask (velocities);
+ * @endcode
+ * would result in a mask <code>[true, false]</code> in any dimension.
+ *
+ * Note, however, that if we had defined the finite element in the following
+ * way:
+ * @code
+ * FESystem<dim> stokes_fe (FE_Q<dim>(2), dim, // Q2 element for the velocities
+ * FE_Q<dim>(1), 1); // Q1 element for the pressure
+ * @endcode
+ * then the code
+ * @code
+ * FEValuesExtractors::Scalar pressure(dim);
+ * BlockMask pressure_mask = stokes_fe.block_mask (pressure);
+ * @endcode
+ * would yield a block mask that in 2d has elements
+ * <code>[false, false, true]</code> because the element has
+ * <code>dim+1</code> components and equally many blocks. See the
+ * discussion on what a block represents exactly in the
+ * @ref GlossBlock "block entry of this glossary".
+ * </dd>
+ *
* <dt class="glossary">@anchor GlossBoundaryForm <b>%Boundary form</b></dt>
*
* <dd>For a dim-dimensional triangulation in dim-dimensional space,
* equation considered in step-22 has four elements: $u=(v_x,v_y,v_z,p)^T$. We
* call the elements of the vector-valued solution <i>components</i> in
* deal.II. To be well-posed, for the solution to have $n$ components, there
- * need to be $n$ partial differential equations to describe them.
+ * need to be $n$ partial differential equations to describe them. This
+ * concept is discussed in great detail in the @ref vector_valued module.
*
* In finite element programs, one frequently wants to address individual
* elements (components) of this vector-valued solution, or sets of
* terms of blocks is most frequently the better strategy.
*
* For a given finite element, the number of components can be queried using
- * the FiniteElementData::n_components() function. Individual components of a
+ * the FiniteElementData::n_components() function, and you can find out
+ * which vector components are nonzero for a given finite element shape
+ * function using FiniteElement::get_nonzero_components(). The values and
+ * gradients of individual components of a
* shape function (if the element is primitive) can be queried using the
* FiniteElement::shape_value_component() and
* FiniteElement::shape_grad_component() functions on the reference cell. The
* FEValues::shape_value_component() and FEValues::shape_grad_component()
* functions do the same on a real cell. See also the documentation of the
- * FiniteElement and FEValues classes.</dd>
+ * FiniteElement and FEValues classes.
+ *
+ * <i>Selecting components:</i>
+ * Many functions allow you to restrict their operation to certain
+ * vector components or blocks. For example, this is the case for
+ * the functions that interpolate boundary values: one may want
+ * to only interpolate the boundary values for the velocity components of
+ * a finite element field but not the pressure component. The way to do
+ * this is by passing a ComponentMask argument to such functions, see the
+ * @ref GlossComponentMask "component mask entry of this glossary".
+ * </dd>
*
*
* <dt class="glossary">@anchor GlossComponentMask <b>Component mask</b></dt>
* wish to only interpolate boundary values for the velocity components
* but not the pressure. In deal.II, this is typically done by passing functions
* a <i>component mask</i>. Component masks are always specified as a
- * <code>std::vector@<bool@></code>, i.e., an array with as many entries as the
- * finite element has components (e.g., in the Stokes case, there are
+ * ComponentMask object which one can think of as an array with
+ * as many entries as the finite element has components (e.g., in the Stokes case, there are
* <code>dim+1</code> components) and where each entry is either true or false.
* In the example where we would like to interpolate boundary values only for
* the velocity components of the Stokes system, this component mask would then
* functions with these names but only some of them have a component mask
* argument.
*
- * Many of the functions that take a component mask accept a vector of length
- * zero to indicate <i>all components</i>, i.e., as if the vector had the
+ * <b>Semantics of component masks:</b>
+ * Many of the functions that take a component mask object that has been default
+ * constructed to indicate <i>all components</i>, i.e., as if the vector had the
* correct length and was filled with only <code>true</code> values. The reason
- * is that the empty vector can be constructed in place using the code snippet
- * <code>std::vector@<bool@>()</code> and can thus be used as a default
+ * is that default initialized objects can be constructed in place using the code snippet
+ * <code>ComponentMask()</code> and can thus be used as a default
* argument in function signatures.
+ *
+ * In other words, ComponentMask objects can be in one of two states: They can have
+ * been initialized by a vector of booleans with a nonzero length; in that case,
+ * they represent a mask of a particular length where some elements may be true
+ * and others may be false. Or, the ComponentMask may have been default initialized
+ * (using the default constructor) in which case it represents an array of indefinite
+ * length (i.e., a length appropriate to the circumstances) in which <i>every entry</i>
+ * is true.
+ *
+ * <b>Creation of component masks:</b>
+ * Component masks are typically created by asking the finite element
+ * to generate a component mask from certain selected components using
+ * code such as this where we create a mask that only denotes the
+ * velocity components of a Stokes element (see @ref vector_valued):
+ * @code
+ * FESystem<dim> stokes_fe (FE_Q<dim>(2), dim, // Q2 element for the velocities
+ * FE_Q<dim>(1), 1); // Q1 element for the pressure
+ * FEValuesExtractors::Scalar pressure(dim);
+ * ComponentMask pressure_mask = stokes_fe.component_mask (pressure);
+ * @endcode
+ * The result is a component mask that, in 2d, would have values
+ * <code>[false, false, true]</code>. Similarly, using
+ * @code
+ * FEValuesExtractors::Vector velocities(0);
+ * ComponentMask velocity_mask = stokes_fe.component_mask (velocities);
+ * @endcode
+ * would result in a mask <code>[true, true, false]</code> in 2d. Of
+ * course, in 3d, the result would be <code>[true, true, true, false]</code>.
+ *
+ * @note Just as one can think of composed elements as being made up of
+ * @ref GlossComponent "components" or @ref GlossBlock "blocks", there are
+ * component masks (represented by the ComponentMask class) and
+ * @ref GlossBlockMask "block masks" (represented by the BlockMask class).
+ * The FiniteElement class has functions that convert between the two kinds of
+ * objects.
+ *
+ * @note Not all component masks actually make sense. For example, if you have
+ * a FE_RaviartThomas object in 2d, then it doesn't make any sense to have a
+ * component mask of the form <code>[true, false]</code> because you try to
+ * select individual vector components of a finite element where each shape
+ * function has both $x$ and $y$ velocities. In essence, while you can of
+ * course create such a component mask, there is nothing you can do with it.
* </dd>
*
*
</p>
<ol>
+<li>New: In the past, deal.II used a std::vector of bools in many places
+to denote component masks (see @ref GlossComponentMask) as well as for
+block masks (see @ref GlossBlockMask). This was neither
+descriptive (the data type does not indicate what it is supposed to
+represent, nor whether the proper size for such an argument would be equal
+to the number of degrees of freedom per cell, the number of vector components
+of the finite element, or the number of degrees of freedom in total).
+<br>
+There are now new class types ComponentMask and BlockMask that are used in these places.
+They are used both descriptively (as a return type of the function
+FiniteElement::get_nonzero_components indicating the vector components within
+which a given shape function is nonzero) as well as prescriptively (as
+input arguments to functions such as those listed in the glossary entry
+linked to above).
+<br>
+While the descriptive places are not backward compatible (they return a
+ComponentMask which is not convertible to the std::vector of bools returned
+before), most of the prescriptive places are in fact backward compatible
+(because the std::vector of bool that was passed previously can
+implicitly be converted to an object of type ComponentMask. The sole
+exception is the function DoFTools::extract_dofs (and its multigrid
+equivalent DoFTools::extract_level_dofs) that previously
+could interpret its argument as either a component or
+a block mask, depending on a boolean flag. This function now exists
+in two different versions, one that takes a ComponentMask and
+one that takes a BlockMask. Call sites need to be adjusted.
+<br>
+(Wolfgang Bangerth, 2012/09/22)
+
<li> Changed: the optional argument offset got removed from
DoFHandler and MGDoFHandler::distribute_dofs() because it was
never working correctly and it is not used.
<br>
(Timo Heister, 2012/09/03)
-
</ol>
/**
* The names of registered events
*/
+//TODO: This static field must be guarded by a mutex to be thread-safe!
static std::vector<std::string> names;
};
#include <deal.II/dofs/function_map.h>
#include <deal.II/dofs/dof_handler.h>
#include <deal.II/fe/fe.h>
+#include <deal.II/fe/component_mask.h>
#include <deal.II/hp/mapping_collection.h>
#include <vector>
* components of the finite element space
* shall be constrained with periodic
* boundary conditions. If it is left as
- * specified by the default value (i.e. an
- * empty array), all components are
- * constrainted. If it is different from
+ * specified by the default value all components are
+ * constrained. If it is different from
* the default value, it is assumed that
* the number of entries equals the number
* of components in the boundary functions
make_periodicity_constraints (const FaceIterator &face_1,
const typename identity<FaceIterator>::type &face_2,
dealii::ConstraintMatrix &constraint_matrix,
- const std::vector<bool> &component_mask = std::vector<bool>());
+ const ComponentMask &component_mask = ComponentMask());
/**
* components of the finite element space
* shall be constrained with periodic
* boundary conditions. If it is left as
- * specified by the default value (i.e. an
- * empty array), all components are
- * constrainted. If it is different from
+ * specified by the default value all components are
+ * constrained. If it is different from
* the default value, it is assumed that
* the number of entries equals the number
* of components in the boundary functions
const types::boundary_id boundary_component,
const int direction,
dealii::ConstraintMatrix &constraint_matrix,
- const std::vector<bool> &component_mask = std::vector<bool>());
+ const ComponentMask &component_mask = ComponentMask());
/**
dealii::Tensor<1,DH::space_dimension>
&offset,
dealii::ConstraintMatrix &constraint_matrix,
- const std::vector<bool> &component_mask = std::vector<bool>());
+ const ComponentMask &component_mask = ComponentMask());
//@}
* Extract the indices of the
* degrees of freedom belonging
* to certain vector components
- * or blocks (if the last
- * argument is <tt>true</tt>) of
+ * of
* a vector-valued finite
- * element. The bit vector @p
- * select defines, which
+ * element. The @p component_mask
+ * defines which
* components or blocks of an
* FESystem are to be extracted
* from the DoFHandler @p
- * dof. The entries in @p
+ * dof. The entries in the output array @p
* selected_dofs corresponding to
* degrees of freedom belonging
* to these components are then
* flagged @p true, while all
* others are set to @p false.
*
- * The size of @p select must
- * equal the number of components
- * or blocks in the FiniteElement
- * used by @p dof, depending on
- * the argument
- * <tt>blocks</tt>. The size of
+ * The size of @p component_mask must
+ * be compatible with the number of components
+ * in the FiniteElement
+ * used by @p dof. The size of
* @p selected_dofs must equal
* DoFHandler::n_dofs(). Previous
* contents of this array are
* overwritten.
*
* If the finite element under
- * consideration is not primitive, that is
+ * consideration is not primitive, i.e.,
* some or all of its shape functions are
* non-zero in more than one vector
* component (which holds, for example, for
* equivalent to selecting <em>all</em>
* vector components corresponding to this
* non-primitive base element.
+ *
+ * @note If the @p blocks argument is
+ * true,
*/
template <int dim, int spacedim>
void
extract_dofs (const DoFHandler<dim,spacedim> &dof_handler,
- const std::vector<bool> &select,
- std::vector<bool> &selected_dofs,
- const bool blocks = false);
+ const ComponentMask &component_mask,
+ std::vector<bool> &selected_dofs);
- /**
- * The same function as above,
- * but for a hp::DoFHandler.
- */
+ /**
+ * The same function as above,
+ * but for a hp::DoFHandler.
+ */
template <int dim, int spacedim>
void
extract_dofs (const hp::DoFHandler<dim,spacedim> &dof_handler,
- const std::vector<bool> &select,
- std::vector<bool> &selected_dofs,
- const bool blocks = false);
+ const ComponentMask &component_mask,
+ std::vector<bool> &selected_dofs);
- /**
- * Do the same thing as
- * extract_dofs() for one level
- * of a multi-grid DoF numbering.
- */
+ /**
+ * This function is the equivalent to the DoFTools::extract_dofs() functions above
+ * except that the selection of which degrees of freedom to extract is not done
+ * based on components (see @ref GlossComponent) but instead based on whether they
+ * are part of a particular block (see @ref GlossBlock). Consequently, the second
+ * argument is not a ComponentMask but a BlockMask object.
+ *
+ * @param dof_handler The DoFHandler object from which to extract degrees of freedom
+ * @param block_mask The block mask that describes which blocks to consider (see
+ * @ref GlossBlockMask)
+ * @param selected_dofs A vector of length DoFHandler::n_dofs() in which those
+ * entries are true that correspond to the selected blocks.
+ */
+ template <int dim, int spacedim>
+ void
+ extract_dofs (const DoFHandler<dim,spacedim> &dof_handler,
+ const BlockMask &block_mask,
+ std::vector<bool> &selected_dofs);
+
+ /**
+ * The same function as above,
+ * but for a hp::DoFHandler.
+ */
+ template <int dim, int spacedim>
+ void
+ extract_dofs (const hp::DoFHandler<dim,spacedim> &dof_handler,
+ const BlockMask &block_mask,
+ std::vector<bool> &selected_dofs);
+
+ /**
+ * Do the same thing as the corresponding
+ * extract_dofs() functino for one level
+ * of a multi-grid DoF numbering.
+ */
+ template <int dim, int spacedim>
+ void
+ extract_level_dofs (const unsigned int level,
+ const MGDoFHandler<dim,spacedim> &dof,
+ const ComponentMask &component_mask,
+ std::vector<bool> &selected_dofs);
+
+ /**
+ * Do the same thing as the corresponding
+ * extract_dofs() functino for one level
+ * of a multi-grid DoF numbering.
+ */
template <int dim, int spacedim>
void
extract_level_dofs (const unsigned int level,
const MGDoFHandler<dim,spacedim> &dof,
- const std::vector<bool> &select,
- std::vector<bool> &selected_dofs,
- const bool blocks = false);
+ const BlockMask &component_mask,
+ std::vector<bool> &selected_dofs);
/**
* Extract all degrees of freedom
template <class DH>
void
extract_boundary_dofs (const DH &dof_handler,
- const std::vector<bool> &component_mask,
+ const ComponentMask &component_mask,
std::vector<bool> &selected_dofs,
const std::set<types::boundary_id> &boundary_indicators = std::set<types::boundary_id>());
template <class DH>
void
extract_boundary_dofs (const DH &dof_handler,
- const std::vector<bool> &component_mask,
- IndexSet &selected_dofs,
+ const ComponentMask &component_mask,
+ IndexSet &selected_dofs,
const std::set<types::boundary_id> &boundary_indicators = std::set<types::boundary_id>());
/**
*/
template <class DH>
void
- extract_dofs_with_support_on_boundary (const DH &dof_handler,
- const std::vector<bool> &component_mask,
- std::vector<bool> &selected_dofs,
+ extract_dofs_with_support_on_boundary (const DH &dof_handler,
+ const ComponentMask &component_mask,
+ std::vector<bool> &selected_dofs,
const std::set<types::boundary_id> &boundary_indicators = std::set<types::boundary_id>());
/**
/**
* Create a sparsity pattern which
* in each row lists the degrees of
- * freedom associated to the
+ * freedom associated with the
* corresponding cell.
*
* Ordering follows the ordering of
template <class DH>
void
extract_constant_modes (const DH &dof_handler,
- const std::vector<bool> &component_mask,
+ const ComponentMask &component_mask,
std::vector<std::vector<bool> > &constant_modes);
/**
template <int dim, int spacedim, template <int, int> class DH>
void
make_zero_boundary_constraints (const DH<dim,spacedim> &dof,
- ConstraintMatrix &zero_boundary_constraints,
- const std::vector<bool> &component_mask_=std::vector<bool>());
+ ConstraintMatrix &zero_boundary_constraints,
+ const ComponentMask &component_mask = ComponentMask());
/**
* Map a coupling table from the
--- /dev/null
+//---------------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2009, 2010, 2011, 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//---------------------------------------------------------------------------
+#ifndef __deal2__fe_block_mask_h
+#define __deal2__fe_block_mask_h
+
+#include <deal.II/base/config.h>
+#include <deal.II/base/exceptions.h>
+#include <deal.II/base/memory_consumption.h>
+
+#include <vector>
+#ifdef HAVE_STD_IOSFWD_HEADER
+# include <iosfwd>
+#else
+# include <iostream>
+#endif
+
+DEAL_II_NAMESPACE_OPEN
+
+
+
+/**
+ * This class represents a mask that can be used to select individual
+ * vector blocks of a finite element (see also
+ * @ref GlossBlockMask "this glossary entry"). It will typically have as many
+ * elements as the finite element has blocks, and one can
+ * use <code>operator[]</code> to query whether a particular block
+ * has been selected.
+ *
+ * The semantics of this class are the same as the related ComponentMask
+ * class, i.e., a default constructed mask represents all possible
+ * blocks. See there for more information about these semantics.
+ *
+ * Objects of this kind are used in many places where one wants to restrict
+ * operations to a certain subset of blocks, e.g. in DoFTools::extract_dofs.
+ * These objects can
+ * either be created by hand, or, simpler, by asking the finite element
+ * to generate a block mask from certain selected blocks using
+ * code such as this where we create a mask that only denotes the
+ * velocity block of a Stokes element (see @ref vector_valued):
+ * @code
+ * FESystem<dim> stokes_fe (FESystem<dim>(FE_Q<dim>(2), dim), 1, // Q2 element for the velocities
+ * FE_Q<dim>(1), 1); // Q1 element for the pressure
+ * FEValuesExtractors::Scalar pressure(dim);
+ * BlockMask pressure_mask = stokes_fe.block_mask (pressure);
+ * @endcode
+ * Note that by wrapping the velocity elements into a single FESystem
+ * object we make sure that the overall element has only 2 blocks.
+ * The result is a block mask that, in both 2d and 3d, would have values
+ * <code>[false, true]</code>. (Compare this to the corresponding
+ * component mask discussed in the ComponentMask documentation.)
+ * Similarly, using
+ * @code
+ * FEValuesExtractors::Vector velocities(0);
+ * BlockMask velocity_mask = stokes_fe.block_mask (velocities);
+ * @endcode
+ * would result in a mask <code>[true, false]</code> in both 2d and 3d.
+ *
+ * @ingroup fe
+ * @author Wolfgang Bangerth
+ * @date 2012
+ * @ingroup vector_valued
+ */
+class BlockMask
+{
+ public:
+ /**
+ * Initialize a block mask. The default is that a block
+ * mask represents a set of blocks that are <i>all</i>
+ * selected, i.e., calling this constructor results in
+ * a block mask that always returns <code>true</code>
+ * whenever asked whether a block is selected.
+ */
+ BlockMask ();
+
+ /**
+ * Initialize an object of this type with a set of selected
+ * blocks specified by the argument.
+ *
+ * @param block_mask A vector of <code>true/false</code>
+ * entries that determine which blocks of a finite element
+ * are selected. If the length of the given vector is zero,
+ * then this interpreted as the case where <i>every</i> block
+ * is selected.
+ */
+ BlockMask (const std::vector<bool> &block_mask);
+
+ /**
+ * Initialize the block mask with a number of elements that
+ * are either all true or false.
+ *
+ * @param n_blocks The number of elements of this mask
+ * @param initializer The value each of these elements is supposed to have:
+ * either true or false.
+ */
+ BlockMask (const unsigned int n_blocks,
+ const bool initializer);
+
+ /**
+ * If this block mask has been initialized with a mask of
+ * size greater than zero, then return the size of the mask
+ * represented by this object. On the other hand, if this
+ * mask has been initialized as an empty object that represents
+ * a mask that is true for every element (i.e., if this object
+ * would return true when calling represents_the_all_selected_mask())
+ * then return zero since no definite size is known.
+ */
+ unsigned int size () const;
+
+ /**
+ * Return whether a particular block is selected by this
+ * mask. If this mask represents the case of an object that
+ * selects <i>all blocks</i> (e.g. if it is created
+ * using the default constructor or is converted from an
+ * empty vector of type bool) then this function returns
+ * true regardless of the given argument.
+ *
+ * @param block_index The index for which the function
+ * should return whether the block is selected. If this
+ * object represents a mask in which all blocks are always
+ * selected then any index is allowed here. Otherwise, the
+ * given index needs to be between zero and the number of
+ * blocks that this mask represents.
+ */
+ bool operator[] (const unsigned int block_index) const;
+
+ /**
+ * Return whether this block mask represents a mask with
+ * exactly <code>n</code> blocks. This is true if either
+ * it was initilized with a vector with exactly <code>n</code>
+ * entries of type <code>bool</code> (in this case, @p n must
+ * equal the result of size()) or if it was initialized
+ * with an empty vector (or using the default constructor) in
+ * which case it can represent a mask with an arbitrary number
+ * of blocks and will always say that a block is
+ * selected.
+ */
+ bool
+ represents_n_blocks (const unsigned int n) const;
+
+ /**
+ * Return the number of blocks that are selected by this mask.
+ *
+ * Since empty block masks represent a block mask that
+ * would return <code>true</code> for every block, this
+ * function may not know the true size of the block
+ * mask and it therefore requires an argument that denotes the
+ * overall number of blocks.
+ *
+ * If the object has been initialized with a non-empty mask (i.e.,
+ * if the size() function returns something greater than zero,
+ * or equivalently if represents_the_all_selected_mask() returns
+ * false) then the argument can be omitted and the result of size()
+ * is taken.
+ */
+ unsigned int
+ n_selected_blocks (const unsigned int overall_number_of_blocks = numbers::invalid_unsigned_int) const;
+
+ /**
+ * Return the index of the first selected block. The argument
+ * is there for the same reason it exists with the
+ * n_selected_blocks() function.
+ *
+ * The function throws an exception if no block is selected at all.
+ */
+ unsigned int
+ first_selected_block (const unsigned int overall_number_of_blocks = numbers::invalid_unsigned_int) const;
+
+ /**
+ * Return true if this mask represents a default
+ * constructed mask that corresponds to one in which
+ * all blocks are selected. If true, then the size()
+ * function will return zero.
+ */
+ bool
+ represents_the_all_selected_mask () const;
+
+ /**
+ * Return a block mask that contains the union of the
+ * blocks selected by the current object and the one
+ * passed as an argument.
+ */
+ BlockMask operator | (const BlockMask &mask) const;
+
+ /**
+ * Return a block mask that has only those elements set that
+ * are set both in the current object as well as the one
+ * passed as an argument.
+ */
+ BlockMask operator & (const BlockMask &mask) const;
+
+ /**
+ * Return whether this object and the argument are identical.
+ */
+ bool operator== (const BlockMask &mask) const;
+
+ /**
+ * Determine an estimate for the
+ * memory consumption (in bytes)
+ * of this object.
+ */
+ std::size_t
+ memory_consumption () const;
+
+ private:
+ /**
+ * The actual block mask.
+ */
+ std::vector<bool> block_mask;
+
+ // make the output operator a friend so it can access
+ // the block_mask array
+ friend
+ std::ostream & operator << (std::ostream &out,
+ const BlockMask &mask);
+};
+
+
+/**
+ * Write a block mask to an output stream. If the block
+ * mask represents one where all blocks are selected without
+ * specifying a particular size of the mask, then it
+ * writes the string <code>[all blocks selected]</code> to the
+ * stream. Otherwise, it prints the block mask in a form like
+ * <code>[true,true,true,false]</code>.
+ *
+ * @param out The stream to write to.
+ * @param mask The mask to write.
+ * @return A reference to the first argument.
+ */
+std::ostream & operator << (std::ostream &out,
+ const BlockMask &mask);
+
+
+// -------------------- inline functions ---------------------
+
+inline
+BlockMask::BlockMask()
+{}
+
+
+inline
+BlockMask::BlockMask(const std::vector<bool> &block_mask)
+:
+block_mask (block_mask)
+{}
+
+
+inline
+BlockMask::BlockMask(const unsigned int n_blocks,
+ const bool initializer)
+:
+block_mask (n_blocks, initializer)
+{}
+
+
+inline
+unsigned int
+BlockMask::size () const
+{
+ return block_mask.size();
+}
+
+
+inline
+bool
+BlockMask::operator [](const unsigned int block_index) const
+{
+ // if the mask represents the all-block mask
+ // then always return true
+ if (block_mask.size() == 0)
+ return true;
+ else
+ {
+ // otherwise check the validity of the index and
+ // return whatever is appropriate
+ Assert (block_index < block_mask.size(),
+ ExcIndexRange (block_index, 0, block_mask.size()));
+ return block_mask[block_index];
+ }
+}
+
+
+inline
+bool
+BlockMask::represents_n_blocks(const unsigned int n) const
+{
+ return ((block_mask.size() == 0)
+ ||
+ (block_mask.size() == n));
+}
+
+
+inline
+unsigned int
+BlockMask::n_selected_blocks(const unsigned int n) const
+{
+ if ((n != numbers::invalid_unsigned_int) && (size() > 0))
+ AssertDimension (n, size());
+
+ const unsigned int real_n = (n != numbers::invalid_unsigned_int
+ ?
+ n
+ :
+ size());
+ if (block_mask.size() == 0)
+ return real_n;
+ else
+ {
+ AssertDimension (real_n, block_mask.size());
+ unsigned int c = 0;
+ for (unsigned int i=0; i<block_mask.size(); ++i)
+ if (block_mask[i] == true)
+ ++c;
+ return c;
+ }
+}
+
+
+inline
+unsigned int
+BlockMask::first_selected_block(const unsigned int n) const
+{
+ if ((n != numbers::invalid_unsigned_int) && (size() > 0))
+ AssertDimension (n, size());
+
+ if (block_mask.size() == 0)
+ return 0;
+ else
+ {
+ for (unsigned int c=0; c<block_mask.size(); ++c)
+ if (block_mask[c] == true)
+ return c;
+
+ Assert (false, ExcMessage ("No block is selected at all!"));
+ return numbers::invalid_unsigned_int;
+ }
+}
+
+
+
+inline
+bool
+BlockMask::represents_the_all_selected_mask () const
+{
+ return (block_mask.size() == 0);
+}
+
+
+
+inline
+BlockMask
+BlockMask::operator | (const BlockMask &mask) const
+{
+ // if one of the two masks denotes the all-block mask,
+ // then return the other one
+ if (block_mask.size() == 0)
+ return mask;
+ else if (mask.block_mask.size() == 0)
+ return *this;
+ else
+ {
+ // if both masks have individual entries set, form
+ // the combination of the two
+ AssertDimension(block_mask.size(), mask.block_mask.size());
+ std::vector<bool> new_mask (block_mask.size());
+ for (unsigned int i=0; i<block_mask.size(); ++i)
+ new_mask[i] = (block_mask[i] || mask.block_mask[i]);
+
+ return new_mask;
+ }
+}
+
+
+inline
+BlockMask
+BlockMask::operator & (const BlockMask &mask) const
+{
+ // if one of the two masks denotes the all-block mask,
+ // then return the other one
+ if (block_mask.size() == 0)
+ return mask;
+ else if (mask.block_mask.size() == 0)
+ return *this;
+ else
+ {
+ // if both masks have individual entries set, form
+ // the combination of the two
+ AssertDimension(block_mask.size(), mask.block_mask.size());
+ std::vector<bool> new_mask (block_mask.size());
+ for (unsigned int i=0; i<block_mask.size(); ++i)
+ new_mask[i] = (block_mask[i] && mask.block_mask[i]);
+
+ return new_mask;
+ }
+}
+
+
+inline
+bool
+BlockMask::operator== (const BlockMask &mask) const
+{
+ return block_mask == mask.block_mask;
+}
+
+
+DEAL_II_NAMESPACE_CLOSE
+
+#endif
--- /dev/null
+//---------------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 2009, 2010, 2011, 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//---------------------------------------------------------------------------
+#ifndef __deal2__fe_component_mask_h
+#define __deal2__fe_component_mask_h
+
+#include <deal.II/base/config.h>
+#include <deal.II/base/exceptions.h>
+#include <deal.II/base/memory_consumption.h>
+
+#include <vector>
+#ifdef HAVE_STD_IOSFWD_HEADER
+# include <iosfwd>
+#else
+# include <iostream>
+#endif
+
+DEAL_II_NAMESPACE_OPEN
+
+
+
+/**
+ * This class represents a mask that can be used to select individual
+ * vector components of a finite element (see also
+ * @ref GlossComponentMask "this glossary entry"). It will typically have as many
+ * elements as the finite element has vector components, and one can
+ * use <code>operator[]</code> to query whether a particular component
+ * has been selected.
+ *
+ * Objects of this kind are used in many places where one wants to restrict
+ * operations to a certain subset of components, e.g. in DoFTools::make_zero_boundary_values
+ * or VectorTools::interpolate_boundary_values. These objects can
+ * either be created by hand, or, simpler, by asking the finite element
+ * to generate a component mask from certain selected components using
+ * code such as this where we create a mask that only denotes the
+ * velocity components of a Stokes element (see @ref vector_valued):
+ * @code
+ * FESystem<dim> stokes_fe (FE_Q<dim>(2), dim, // Q2 element for the velocities
+ * FE_Q<dim>(1), 1); // Q1 element for the pressure
+ * FEValuesExtractors::Scalar pressure(dim);
+ * ComponentMask pressure_mask = stokes_fe.component_mask (pressure);
+ * @endcode
+ * The result is a component mask that, in 2d, would have values
+ * <code>[false, false, true]</code>. Similarly, using
+ * @code
+ * FEValuesExtractors::Vector velocities(0);
+ * ComponentMask velocity_mask = stokes_fe.component_mask (velocities);
+ * @endcode
+ * would result in a mask <code>[true, true, false]</code> in 2d. Of
+ * course, in 3d, the result would be <code>[true, true, true, false]</code>.
+ *
+ * @ingroup fe
+ * @author Wolfgang Bangerth
+ * @date 2012
+ * @ingroup vector_valued
+ */
+class ComponentMask
+{
+ public:
+ /**
+ * Initialize a component mask. The default is that a component
+ * mask represents a set of components that are <i>all</i>
+ * selected, i.e., calling this constructor results in
+ * a component mask that always returns <code>true</code>
+ * whenever asked whether a component is selected.
+ */
+ ComponentMask ();
+
+ /**
+ * Initialize an object of this type with a set of selected
+ * components specified by the argument.
+ *
+ * @param component_mask A vector of <code>true/false</code>
+ * entries that determine which components of a finite element
+ * are selected. If the length of the given vector is zero,
+ * then this interpreted as the case where <i>every</i> component
+ * is selected.
+ */
+ ComponentMask (const std::vector<bool> &component_mask);
+
+ /**
+ * Initialize the component mask with a number of elements that
+ * are either all true or false.
+ *
+ * @param n_components The number of elements of this mask
+ * @param initializer The value each of these elements is supposed to have:
+ * either true or false.
+ */
+ ComponentMask (const unsigned int n_components,
+ const bool initializer);
+
+ /**
+ * If this component mask has been initialized with a mask of
+ * size greater than zero, then return the size of the mask
+ * represented by this object. On the other hand, if this
+ * mask has been initialized as an empty object that represents
+ * a mask that is true for every element (i.e., if this object
+ * would return true when calling represents_the_all_selected_mask())
+ * then return zero since no definite size is known.
+ */
+ unsigned int size () const;
+
+ /**
+ * Return whether a particular component is selected by this
+ * mask. If this mask represents the case of an object that
+ * selects <i>all components</i> (e.g. if it is created
+ * using the default constructor or is converted from an
+ * empty vector of type bool) then this function returns
+ * true regardless of the given argument.
+ *
+ * @param component_index The index for which the function
+ * should return whether the component is selected. If this
+ * object represents a mask in which all components are always
+ * selected then any index is allowed here. Otherwise, the
+ * given index needs to be between zero and the number of
+ * components that this mask represents.
+ */
+ bool operator[] (const unsigned int component_index) const;
+
+ /**
+ * Return whether this component mask represents a mask with
+ * exactly <code>n</code> components. This is true if either
+ * it was initilized with a vector with exactly <code>n</code>
+ * entries of type <code>bool</code> (in this case, @p n must
+ * equal the result of size()) or if it was initialized
+ * with an empty vector (or using the default constructor) in
+ * which case it can represent a mask with an arbitrary number
+ * of components and will always say that a component is
+ * selected.
+ */
+ bool
+ represents_n_components (const unsigned int n) const;
+
+ /**
+ * Return the number of components that are selected by this mask.
+ *
+ * Since empty component masks represent a component mask that
+ * would return <code>true</code> for every component, this
+ * function may not know the true size of the component
+ * mask and it therefore requires an argument that denotes the
+ * overall number of components.
+ *
+ * If the object has been initialized with a non-empty mask (i.e.,
+ * if the size() function returns something greater than zero,
+ * or equivalently if represents_the_all_selected_mask() returns
+ * false) then the argument can be omitted and the result of size()
+ * is taken.
+ */
+ unsigned int
+ n_selected_components (const unsigned int overall_number_of_components = numbers::invalid_unsigned_int) const;
+
+ /**
+ * Return the index of the first selected component. The argument
+ * is there for the same reason it exists with the
+ * n_selected_components() function.
+ *
+ * The function throws an exception if no component is selected at all.
+ */
+ unsigned int
+ first_selected_component (const unsigned int overall_number_of_components = numbers::invalid_unsigned_int) const;
+
+ /**
+ * Return true if this mask represents a default
+ * constructed mask that corresponds to one in which
+ * all components are selected. If true, then the size()
+ * function will return zero.
+ */
+ bool
+ represents_the_all_selected_mask () const;
+
+ /**
+ * Return a component mask that contains the union of the
+ * components selected by the current object and the one
+ * passed as an argument.
+ */
+ ComponentMask operator | (const ComponentMask &mask) const;
+
+ /**
+ * Return a component mask that has only those elements set that
+ * are set both in the current object as well as the one
+ * passed as an argument.
+ */
+ ComponentMask operator & (const ComponentMask &mask) const;
+
+ /**
+ * Return whether this object and the argument are identical.
+ */
+ bool operator== (const ComponentMask &mask) const;
+
+ /**
+ * Determine an estimate for the
+ * memory consumption (in bytes)
+ * of this object.
+ */
+ std::size_t
+ memory_consumption () const;
+
+ private:
+ /**
+ * The actual component mask.
+ */
+ std::vector<bool> component_mask;
+
+ // make the output operator a friend so it can access
+ // the component_mask array
+ friend
+ std::ostream & operator << (std::ostream &out,
+ const ComponentMask &mask);
+};
+
+
+/**
+ * Write a component mask to an output stream. If the component
+ * mask represents one where all components are selected without
+ * specifying a particular size of the mask, then it
+ * writes the string <code>[all components selected]</code> to the
+ * stream. Otherwise, it prints the component mask in a form like
+ * <code>[true,true,true,false]</code>.
+ *
+ * @param out The stream to write to.
+ * @param mask The mask to write.
+ * @return A reference to the first argument.
+ */
+std::ostream & operator << (std::ostream &out,
+ const ComponentMask &mask);
+
+
+// -------------------- inline functions ---------------------
+
+inline
+ComponentMask::ComponentMask()
+{}
+
+
+inline
+ComponentMask::ComponentMask(const std::vector<bool> &component_mask)
+:
+component_mask (component_mask)
+{}
+
+
+inline
+ComponentMask::ComponentMask(const unsigned int n_components,
+ const bool initializer)
+:
+component_mask (n_components, initializer)
+{}
+
+
+inline
+unsigned int
+ComponentMask::size () const
+{
+ return component_mask.size();
+}
+
+
+inline
+bool
+ComponentMask::operator [](const unsigned int component_index) const
+{
+ // if the mask represents the all-component mask
+ // then always return true
+ if (component_mask.size() == 0)
+ return true;
+ else
+ {
+ // otherwise check the validity of the index and
+ // return whatever is appropriate
+ Assert (component_index < component_mask.size(),
+ ExcIndexRange (component_index, 0, component_mask.size()));
+ return component_mask[component_index];
+ }
+}
+
+
+inline
+bool
+ComponentMask::represents_n_components(const unsigned int n) const
+{
+ return ((component_mask.size() == 0)
+ ||
+ (component_mask.size() == n));
+}
+
+
+inline
+unsigned int
+ComponentMask::n_selected_components(const unsigned int n) const
+{
+ if ((n != numbers::invalid_unsigned_int) && (size() > 0))
+ AssertDimension (n, size());
+
+ const unsigned int real_n = (n != numbers::invalid_unsigned_int
+ ?
+ n
+ :
+ size());
+ if (component_mask.size() == 0)
+ return real_n;
+ else
+ {
+ AssertDimension (real_n, component_mask.size());
+ unsigned int c = 0;
+ for (unsigned int i=0; i<component_mask.size(); ++i)
+ if (component_mask[i] == true)
+ ++c;
+ return c;
+ }
+}
+
+
+inline
+unsigned int
+ComponentMask::first_selected_component(const unsigned int n) const
+{
+ if ((n != numbers::invalid_unsigned_int) && (size() > 0))
+ AssertDimension (n, size());
+
+ if (component_mask.size() == 0)
+ return 0;
+ else
+ {
+ for (unsigned int c=0; c<component_mask.size(); ++c)
+ if (component_mask[c] == true)
+ return c;
+
+ Assert (false, ExcMessage ("No component is selected at all!"));
+ return numbers::invalid_unsigned_int;
+ }
+}
+
+
+
+inline
+bool
+ComponentMask::represents_the_all_selected_mask () const
+{
+ return (component_mask.size() == 0);
+}
+
+
+
+inline
+ComponentMask
+ComponentMask::operator | (const ComponentMask &mask) const
+{
+ // if one of the two masks denotes the all-component mask,
+ // then return the other one
+ if (component_mask.size() == 0)
+ return mask;
+ else if (mask.component_mask.size() == 0)
+ return *this;
+ else
+ {
+ // if both masks have individual entries set, form
+ // the combination of the two
+ AssertDimension(component_mask.size(), mask.component_mask.size());
+ std::vector<bool> new_mask (component_mask.size());
+ for (unsigned int i=0; i<component_mask.size(); ++i)
+ new_mask[i] = (component_mask[i] || mask.component_mask[i]);
+
+ return new_mask;
+ }
+}
+
+
+inline
+ComponentMask
+ComponentMask::operator & (const ComponentMask &mask) const
+{
+ // if one of the two masks denotes the all-component mask,
+ // then return the other one
+ if (component_mask.size() == 0)
+ return mask;
+ else if (mask.component_mask.size() == 0)
+ return *this;
+ else
+ {
+ // if both masks have individual entries set, form
+ // the combination of the two
+ AssertDimension(component_mask.size(), mask.component_mask.size());
+ std::vector<bool> new_mask (component_mask.size());
+ for (unsigned int i=0; i<component_mask.size(); ++i)
+ new_mask[i] = (component_mask[i] && mask.component_mask[i]);
+
+ return new_mask;
+ }
+}
+
+
+inline
+bool
+ComponentMask::operator== (const ComponentMask &mask) const
+{
+ return component_mask == mask.component_mask;
+}
+
+
+DEAL_II_NAMESPACE_CLOSE
+
+#endif
#include <deal.II/base/config.h>
#include <deal.II/base/geometry_info.h>
#include <deal.II/fe/fe_base.h>
+#include <deal.II/fe/fe_values_extractors.h>
+#include <deal.II/fe/component_mask.h>
+#include <deal.II/fe/block_mask.h>
DEAL_II_NAMESPACE_OPEN
*/
FiniteElement (const FiniteElementData<dim> &fe_data,
const std::vector<bool> &restriction_is_additive_flags,
- const std::vector<std::vector<bool> > &nonzero_components);
+ const std::vector<ComponentMask> &nonzero_components);
/**
* Virtual destructor. Makes sure
* called non-primitive (see
* @ref GlossPrimitive).
*/
- const std::vector<bool> &
+ const ComponentMask &
get_nonzero_components (const unsigned int i) const;
/**
unsigned int
component_to_block_index (const unsigned int component) const;
+ //@}
+
+ /**
+ * @name Component and block matrices
+ * @{
+ */
+
+ /**
+ * Return a component mask with as many elements as this
+ * object has vector components and of which exactly the
+ * one component is true that corresponds to the given
+ * argument. See @ref GlossComponentMask "the glossary"
+ * for more information.
+ *
+ * @param scalar An object that represents a single scalar
+ * vector component of this finite element.
+ * @return A component mask that is false in all components
+ * except for the one that corresponds to the argument.
+ */
+ ComponentMask
+ component_mask (const FEValuesExtractors::Scalar &scalar) const;
+
+ /**
+ * Return a component mask with as many elements as this
+ * object has vector components and of which exactly the
+ * <code>dim</code> components are true that correspond to the given
+ * argument. See @ref GlossComponentMask "the glossary"
+ * for more information.
+ *
+ * @param vector An object that represents dim
+ * vector components of this finite element.
+ * @return A component mask that is false in all components
+ * except for the ones that corresponds to the argument.
+ */
+ ComponentMask
+ component_mask (const FEValuesExtractors::Vector &vector) const;
+
+ /**
+ * Return a component mask with as many elements as this
+ * object has vector components and of which exactly the
+ * <code>dim*(dim+1)/2</code> components are true that
+ * correspond to the given argument. See @ref GlossComponentMask "the glossary"
+ * for more information.
+ *
+ * @param sym_tensor An object that represents dim*(dim+1)/2
+ * components of this finite element that are jointly to be
+ * interpreted as forming a symmetric tensor.
+ * @return A component mask that is false in all components
+ * except for the ones that corresponds to the argument.
+ */
+ ComponentMask
+ component_mask (const FEValuesExtractors::SymmetricTensor<2> &sym_tensor) const;
+
+ /**
+ * Given a block mask (see @ref GlossBlockMask "this glossary entry"),
+ * produce a component mask (see @ref GlossComponentMask "this glossary entry")
+ * that represents the components that correspond to the blocks selected in
+ * the input argument. This is essentially a conversion operator from
+ * BlockMask to ComponentMask.
+ *
+ * @param block_mask The mask that selects individual blocks of the finite
+ * element
+ * @return A mask that selects those components corresponding to the selected
+ * blocks of the input argument.
+ */
+ ComponentMask
+ component_mask (const BlockMask &block_mask) const;
+
+ /**
+ * Return a block mask with as many elements as this
+ * object has blocks and of which exactly the
+ * one component is true that corresponds to the given
+ * argument. See @ref GlossBlockMask "the glossary"
+ * for more information.
+ *
+ * @note This function will only succeed if the scalar referenced
+ * by the argument encompasses a complete block. In other words,
+ * if, for example, you pass an extractor for the single
+ * $x$ velocity and this object represents an FE_RaviartThomas
+ * object, then the single scalar object you selected is part
+ * of a larger block and consequently there is no block mask that
+ * would represent it. The function will then produce an exception.
+ *
+ * @param scalar An object that represents a single scalar
+ * vector component of this finite element.
+ * @return A component mask that is false in all components
+ * except for the one that corresponds to the argument.
+ */
+ BlockMask
+ block_mask (const FEValuesExtractors::Scalar &scalar) const;
+
+ /**
+ * Return a component mask with as many elements as this
+ * object has vector components and of which exactly the
+ * <code>dim</code> components are true that correspond to the given
+ * argument. See @ref GlossBlockMask "the glossary"
+ * for more information.
+ *
+ * @note The same caveat applies as to the version of the function above:
+ * The extractor object passed as argument must be so that it corresponds
+ * to full blocks and does not split blocks of this element.
+ *
+ * @param vector An object that represents dim
+ * vector components of this finite element.
+ * @return A component mask that is false in all components
+ * except for the ones that corresponds to the argument.
+ */
+ BlockMask
+ block_mask (const FEValuesExtractors::Vector &vector) const;
+
+ /**
+ * Return a component mask with as many elements as this
+ * object has vector components and of which exactly the
+ * <code>dim*(dim+1)/2</code> components are true that
+ * correspond to the given argument. See @ref GlossBlockMask "the glossary"
+ * for more information.
+ *
+ * @note The same caveat applies as to the version of the function above:
+ * The extractor object passed as argument must be so that it corresponds
+ * to full blocks and does not split blocks of this element.
+ *
+ * @param sym_tensor An object that represents dim*(dim+1)/2
+ * components of this finite element that are jointly to be
+ * interpreted as forming a symmetric tensor.
+ * @return A component mask that is false in all components
+ * except for the ones that corresponds to the argument.
+ */
+ BlockMask
+ block_mask (const FEValuesExtractors::SymmetricTensor<2> &sym_tensor) const;
+
+ /**
+ * Given a component mask (see @ref GlossComponentMask "this glossary entry"),
+ * produce a block mask (see @ref GlossBlockMask "this glossary entry")
+ * that represents the blocks that correspond to the components selected in
+ * the input argument. This is essentially a conversion operator from
+ * ComponentMask to BlockMask.
+ *
+ * @note This function will only succeed if the components referenced
+ * by the argument encompasses complete blocks. In other words,
+ * if, for example, you pass an component mask for the single
+ * $x$ velocity and this object represents an FE_RaviartThomas
+ * object, then the single component you selected is part
+ * of a larger block and consequently there is no block mask that
+ * would represent it. The function will then produce an exception.
+ *
+ * @param component_mask The mask that selects individual components of the finite
+ * element
+ * @return A mask that selects those blocks corresponding to the selected
+ * blocks of the input argument.
+ */
+ BlockMask
+ block_mask (const ComponentMask &component_mask) const;
+
//@}
/**
*/
static
std::vector<unsigned int>
- compute_n_nonzero_components (const std::vector<std::vector<bool> > &nonzero_components);
+ compute_n_nonzero_components (const std::vector<ComponentMask> &nonzero_components);
/**
* Determine the values a finite
* is only one non-zero
* component.
*/
- const std::vector<std::vector<bool> > nonzero_components;
+ const std::vector<ComponentMask> nonzero_components;
/**
* This array holds how many
template <int dim, int spacedim>
inline
-const std::vector<bool> &
+const ComponentMask &
FiniteElement<dim,spacedim>::get_nonzero_components (const unsigned int i) const
{
Assert (i < this->dofs_per_cell, ExcIndexRange (i, 0, this->dofs_per_cell));
FiniteElementData<dim>(
get_dpo_vector(deg), dim, deg+1, FiniteElementData<dim>::L2, 1),
std::vector<bool>(POLY::compute_n_pols(deg), true),
- std::vector<std::vector<bool> >(POLY::compute_n_pols(deg),
- std::vector<bool>(dim,true)))
+ std::vector<ComponentMask>(POLY::compute_n_pols(deg),
+ ComponentMask(dim,true)))
{
this->mapping_type = map;
const unsigned int polynomial_degree = this->tensor_degree();
FE_Poly (const POLY& poly_space,
const FiniteElementData<dim> &fe_data,
const std::vector<bool> &restriction_is_additive_flags,
- const std::vector<std::vector<bool> > &nonzero_components);
+ const std::vector<ComponentMask> &nonzero_components);
/**
* Return the polynomial degree
FE_Poly<POLY,dim,spacedim>::FE_Poly (const POLY& poly_space,
const FiniteElementData<dim> &fe_data,
const std::vector<bool> &restriction_is_additive_flags,
- const std::vector<std::vector<bool> > &nonzero_components):
+ const std::vector<ComponentMask> &nonzero_components):
FiniteElement<dim,spacedim> (fe_data,
restriction_is_additive_flags,
nonzero_components),
const std::vector<bool> &restriction_is_additive_flags):
FiniteElement<dim,spacedim> (fe_data,
restriction_is_additive_flags,
- std::vector<std::vector<bool> > (1, std::vector<bool>(1,true))),
+ std::vector<ComponentMask> (1, ComponentMask(1,true))),
poly_space(poly_space)
{
AssertDimension(dim, POLY::dimension+1);
FE_PolyTensor (const unsigned int degree,
const FiniteElementData<dim> &fe_data,
const std::vector<bool> &restriction_is_additive_flags,
- const std::vector<std::vector<bool> > &nonzero_components);
+ const std::vector<ComponentMask> &nonzero_components);
/**
* Since these elements are
* components of a composed
* finite element.
*/
- static std::vector<std::vector<bool> >
+ static std::vector<ComponentMask>
compute_nonzero_components (const FiniteElement<dim,spacedim> &fe1,
const unsigned int N1);
* components of a composed
* finite element.
*/
- static std::vector<std::vector<bool> >
+ static std::vector<ComponentMask>
compute_nonzero_components (const FiniteElement<dim,spacedim> &fe1,
const unsigned int N1,
const FiniteElement<dim,spacedim> &fe2,
* components of a composed
* finite element.
*/
- static std::vector<std::vector<bool> >
+ static std::vector<ComponentMask>
compute_nonzero_components (const FiniteElement<dim,spacedim> &fe1,
const unsigned int N1,
const FiniteElement<dim,spacedim> &fe2,
* components of a composed
* finite element.
*/
- static std::vector<std::vector<bool> >
+ static std::vector<ComponentMask>
compute_nonzero_components (const FiniteElement<dim,spacedim> &fe1,
const unsigned int N1,
const FiniteElement<dim,spacedim> &fe2,
/**
* With 5 elements.
*/
- static std::vector<std::vector<bool> >
+ static std::vector<ComponentMask>
compute_nonzero_components (const FiniteElement<dim,spacedim> &fe1,
const unsigned int N1,
const FiniteElement<dim,spacedim> &fe2,
* function is called from all
* the above functions.
*/
- static std::vector<std::vector<bool> >
+ static std::vector<ComponentMask>
compute_nonzero_components (const std::vector<const FiniteElement<dim,spacedim>*> &fes,
const std::vector<unsigned int> &multiplicities);
#include <deal.II/hp/dof_handler.h>
#include <deal.II/fe/fe.h>
#include <deal.II/fe/fe_update_flags.h>
+#include <deal.II/fe/fe_values_extractors.h>
#include <deal.II/fe/mapping.h>
#include <deal.II/multigrid/mg_dof_handler.h>
#include <deal.II/multigrid/mg_dof_accessor.h>
}
-/**
- * A namespace in which we declare "extractors", i.e. classes that when used
- * as subscripts in operator[] expressions on FEValues, FEFaceValues, and
- * FESubfaceValues objects extract certain components of a vector-valued
- * element. The result of applying an extractor to these objects is an object
- * with corresponding type from the namespace FEValuesViews. There are
- * extractors for single scalar components, vector components consisting of
- * <code>dim</code> elements, and second order symmetric tensors consisting of
- * <code>(dim*dim + dim)/2</code> components
- *
- * See the description of the @ref vector_valued module for examples how to
- * use the features of this namespace.
- *
- * @ingroup feaccess vector_valued
- */
-namespace FEValuesExtractors
-{
- /**
- * Extractor for a single scalar component
- * of a vector-valued element. The result
- * of applying an object of this type to an
- * FEValues, FEFaceValues or
- * FESubfaceValues object is of type
- * FEValuesViews::Scalar. The concept of
- * extractors is defined in the
- * documentation of the namespace
- * FEValuesExtractors and in the @ref
- * vector_valued module.
- *
- * @ingroup feaccess vector_valued
- */
- struct Scalar
- {
- /**
- * The selected scalar component of the
- * vector.
- */
- unsigned int component;
-
- /**
- * Constructor. Take the selected
- * vector component as argument.
- */
- Scalar (const unsigned int component);
- };
-
-
- /**
- * Extractor for a vector of
- * <code>spacedim</code> components of a
- * vector-valued element. The value of
- * <code>spacedim</code> is defined by the
- * FEValues object the extractor is applied
- * to. The result of applying an object of
- * this type to an FEValues, FEFaceValues
- * or FESubfaceValues object is of type
- * FEValuesViews::Vector.
- *
- * The concept of
- * extractors is defined in the
- * documentation of the namespace
- * FEValuesExtractors and in the @ref
- * vector_valued module.
- *
- * Note that in the current context, a
- * vector is meant in the sense physics
- * uses it: it has <code>spacedim</code>
- * components that behave in specific ways
- * under coordinate system
- * transformations. Examples include
- * velocity or displacement fields. This is
- * opposed to how mathematics uses the word
- * "vector" (and how we use this word in
- * other contexts in the library, for
- * example in the Vector class), where it
- * really stands for a collection of
- * numbers. An example of this latter use
- * of the word could be the set of
- * concentrations of chemical species in a
- * flame; however, these are really just a
- * collection of scalar variables, since
- * they do not change if the coordinate
- * system is rotated, unlike the components
- * of a velocity vector, and consequently,
- * this class should not be used for this
- * context.
- *
- * @ingroup feaccess vector_valued
- */
- struct Vector
- {
- /**
- * The first component of the vector
- * view.
- */
- unsigned int first_vector_component;
-
- /**
- * Constructor. Take the first
- * component of the selected vector
- * inside the FEValues object as
- * argument.
- */
- Vector (const unsigned int first_vector_component);
- };
-
-
- /**
- * Extractor for a symmetric tensor of a
- * rank specified by the template
- * argument. For a second order symmetric
- * tensor, this represents a collection of
- * <code>(dim*dim + dim)/2</code>
- * components of a vector-valued
- * element. The value of <code>dim</code>
- * is defined by the FEValues object the
- * extractor is applied to. The result of
- * applying an object of this type to an
- * FEValues, FEFaceValues or
- * FESubfaceValues object is of type
- * FEValuesViews::SymmetricTensor.
- *
- * The concept of
- * extractors is defined in the
- * documentation of the namespace
- * FEValuesExtractors and in the @ref
- * vector_valued module.
- *
- * @ingroup feaccess vector_valued
- *
- * @author Andrew McBride, 2009
- */
- template <int rank>
- struct SymmetricTensor
- {
- /**
- * The first component of the tensor
- * view.
- */
- unsigned int first_tensor_component;
-
- /**
- * Constructor. Take the first
- * component of the selected tensor
- * inside the FEValues object as
- * argument.
- */
- SymmetricTensor (const unsigned int first_tensor_component);
- };
-}
-
-
/**
std::vector<Tensor<1,spacedim> > boundary_forms;
/**
- * Indicate the first row which a
- * given shape function occupies
- * in the #shape_values,
- * #shape_gradients and
- * #shape_hessians
- * arrays. If all shape functions
- * are primitive, then this is
- * the identity mapping. If, on
- * the other hand some shape
- * functions have more than one
- * non-zero vector components,
- * then they may occupy more than
- * one row, and this array
- * indicates which is the first
- * one.
- *
- * The questions which particular
- * vector component occupies
- * which row for a given shape
- * function is answered as
- * follows: we allocate one row
- * for each non-zero component as
- * indicated by the
- * FiniteElement::get_nonzero_components()
- * function, and the rows are in
- * ascending order exactly those
- * non-zero components.
+ * When asked for the value (or
+ * gradient, or Hessian) of shape
+ * function i's c-th vector
+ * component, we need to look it
+ * up in the #shape_values,
+ * #shape_gradients and
+ * #shape_hessians arrays. The
+ * question is where in this
+ * array does the data for shape
+ * function i, component c
+ * reside. This is what this
+ * table answers.
+ *
+ * The format of the table is as
+ * follows:
+ * - It has dofs_per_cell times
+ * n_components entries.
+ * - The entry that corresponds to
+ * shape function i, component c
+ * is <code>i * n_components + c</code>.
+ * - The value stored at this
+ * position indicates the row
+ * in #shape_values and the
+ * other tables where the
+ * corresponding datum is stored
+ * for all the quadrature points.
+ *
+ * In the general, vector-valued
+ * context, the number of
+ * components is larger than one,
+ * but for a given shape
+ * function, not all vector
+ * components may be nonzero
+ * (e.g., if a shape function is
+ * primitive, then exactly one
+ * vector component is non-zero,
+ * while the others are all
+ * zero). For such zero
+ * components, #shape_values and
+ * friends do not have a
+ * row. Consequently, for vector
+ * components for which shape
+ * function i is zero, the entry
+ * in the current table is
+ * numbers::invalid_unsigned_int.
+ *
+ * On the other hand, the table
+ * is guaranteed to have at least
+ * one valid index for each shape
+ * function. In particular, for a
+ * primitive finite element, each
+ * shape function has exactly one
+ * nonzero component and so for
+ * each i, there is exactly one
+ * valid index within the range
+ * <code>[i*n_components,
+ * (i+1)*n_components)</code>.
*/
std::vector<unsigned int> shape_function_to_row_table;
return fe_values_views_cache.symmetric_second_order_tensors[tensor.first_tensor_component];
}
+
+
template <int dim, int spacedim>
inline
const double &
if (fe->is_primitive())
return this->shape_values(i,j);
else
- // otherwise, use the mapping
- // between shape function numbers
- // and rows. note that by the
- // assertions above, we know that
- // this particular shape function
- // is primitive, so there is no
- // question to which vector
- // component the call of this
- // function refers
- return this->shape_values(this->shape_function_to_row_table[i], j);
+ {
+ // otherwise, use the mapping
+ // between shape function
+ // numbers and rows. note that
+ // by the assertions above, we
+ // know that this particular
+ // shape function is primitive,
+ // so we can call
+ // system_to_component_index
+ const unsigned int
+ row = this->shape_function_to_row_table[i * fe->n_components() + fe->system_to_component_index(i).first];
+ return this->shape_values(row, j);
+ }
}
Assert (component < fe->n_components(),
ExcIndexRange(component, 0, fe->n_components()));
- // if this particular shape
- // function is primitive, then we
- // can take a short-cut by checking
- // whether the requested component
- // is the only non-zero one (note
- // that calling
- // system_to_component_table only
- // works if the shape function is
- // primitive):
- if (fe->is_primitive(i))
- {
- if (component == fe->system_to_component_index(i).first)
- return this->shape_values(this->shape_function_to_row_table[i],j);
- else
- return 0;
- }
- else
- {
- // no, this shape function is
- // not primitive. then we have
- // to loop over its components
- // to find the corresponding
- // row in the arrays of this
- // object. before that check
- // whether the shape function
- // is non-zero at all within
- // this component:
- if (fe->get_nonzero_components(i)[component] == false)
- return 0;
-
- // count how many non-zero
- // component the shape function
- // has before the one we are
- // looking for, and add this to
- // the offset of the first
- // non-zero component of this
- // shape function in the arrays
- // we index presently:
- const unsigned int
- row = (this->shape_function_to_row_table[i]
- +
- std::count (fe->get_nonzero_components(i).begin(),
- fe->get_nonzero_components(i).begin()+component,
- true));
- return this->shape_values(row, j);
- }
+ // check whether the shape function
+ // is non-zero at all within
+ // this component:
+ if (fe->get_nonzero_components(i)[component] == false)
+ return 0;
+
+ // look up the right row in the
+ // table and take the data from
+ // there
+ const unsigned int
+ row = this->shape_function_to_row_table[i * fe->n_components() + component];
+ return this->shape_values(row, j);
}
if (fe->is_primitive())
return this->shape_gradients[i][j];
else
- // otherwise, use the mapping
- // between shape function numbers
- // and rows. note that by the
- // assertions above, we know that
- // this particular shape function
- // is primitive, so there is no
- // question to which vector
- // component the call of this
- // function refers
- return this->shape_gradients[this->shape_function_to_row_table[i]][j];
+ {
+ // otherwise, use the mapping
+ // between shape function
+ // numbers and rows. note that
+ // by the assertions above, we
+ // know that this particular
+ // shape function is primitive,
+ // so we can call
+ // system_to_component_index
+ const unsigned int
+ row = this->shape_function_to_row_table[i * fe->n_components() + fe->system_to_component_index(i).first];
+ return this->shape_gradients[row][j];
+ }
}
Assert (component < fe->n_components(),
ExcIndexRange(component, 0, fe->n_components()));
- // if this particular shape
- // function is primitive, then we
- // can take a short-cut by checking
- // whether the requested component
- // is the only non-zero one (note
- // that calling
- // system_to_component_table only
- // works if the shape function is
- // primitive):
- if (fe->is_primitive(i))
- {
- if (component == fe->system_to_component_index(i).first)
- return this->shape_gradients[this->shape_function_to_row_table[i]][j];
- else
- return Tensor<1,spacedim>();
- }
- else
- {
- // no, this shape function is
- // not primitive. then we have
- // to loop over its components
- // to find the corresponding
- // row in the arrays of this
- // object. before that check
- // whether the shape function
- // is non-zero at all within
- // this component:
- if (fe->get_nonzero_components(i)[component] == false)
- return Tensor<1,spacedim>();
-
- // count how many non-zero
- // component the shape function
- // has before the one we are
- // looking for, and add this to
- // the offset of the first
- // non-zero component of this
- // shape function in the arrays
- // we index presently:
- const unsigned int
- row = (this->shape_function_to_row_table[i]
- +
- std::count (fe->get_nonzero_components(i).begin(),
- fe->get_nonzero_components(i).begin()+component,
- true));
- return this->shape_gradients[row][j];
- }
+ // check whether the shape function
+ // is non-zero at all within
+ // this component:
+ if (fe->get_nonzero_components(i)[component] == false)
+ return Tensor<1,spacedim>();
+
+ // look up the right row in the
+ // table and take the data from
+ // there
+ const unsigned int
+ row = this->shape_function_to_row_table[i * fe->n_components() + component];
+ return this->shape_gradients[row][j];
}
if (fe->is_primitive())
return this->shape_hessians[i][j];
else
- // otherwise, use the mapping
- // between shape function numbers
- // and rows. note that by the
- // assertions above, we know that
- // this particular shape function
- // is primitive, so there is no
- // question to which vector
- // component the call of this
- // function refers
- return this->shape_hessians[this->shape_function_to_row_table[i]][j];
+ {
+ // otherwise, use the mapping
+ // between shape function
+ // numbers and rows. note that
+ // by the assertions above, we
+ // know that this particular
+ // shape function is primitive,
+ // so we can call
+ // system_to_component_index
+ const unsigned int
+ row = this->shape_function_to_row_table[i * fe->n_components() + fe->system_to_component_index(i).first];
+ return this->shape_hessians[row][j];
+ }
}
Assert (component < fe->n_components(),
ExcIndexRange(component, 0, fe->n_components()));
- // if this particular shape
- // function is primitive, then we
- // can take a short-cut by checking
- // whether the requested component
- // is the only non-zero one (note
- // that calling
- // system_to_component_table only
- // works if the shape function is
- // primitive):
- if (fe->is_primitive(i))
- {
- if (component == fe->system_to_component_index(i).first)
- return this->shape_hessians[this->shape_function_to_row_table[i]][j];
- else
- return Tensor<2,spacedim>();
- }
- else
- {
- // no, this shape function is
- // not primitive. then we have
- // to loop over its components
- // to find the corresponding
- // row in the arrays of this
- // object. before that check
- // whether the shape function
- // is non-zero at all within
- // this component:
- if (fe->get_nonzero_components(i)[component] == false)
- return Tensor<2,spacedim>();
-
- // count how many non-zero
- // component the shape function
- // has before the one we are
- // looking for, and add this to
- // the offset of the first
- // non-zero component of this
- // shape function in the arrays
- // we index presently:
- const unsigned int
- row = (this->shape_function_to_row_table[i]
- +
- std::count (fe->get_nonzero_components(i).begin(),
- fe->get_nonzero_components(i).begin()+component,
- true));
- return this->shape_hessians[row][j];
- }
+ // check whether the shape function
+ // is non-zero at all within
+ // this component:
+ if (fe->get_nonzero_components(i)[component] == false)
+ return Tensor<2,spacedim>();
+
+ // look up the right row in the
+ // table and take the data from
+ // there
+ const unsigned int
+ row = this->shape_function_to_row_table[i * fe->n_components() + component];
+ return this->shape_hessians[row][j];
}
--- /dev/null
+//---------------------------------------------------------------------------
+// $Id$
+//
+// Copyright (C) 1998, 1999, 2000, 2001, 2002, 2003, 2004, 2005, 2006, 2007, 2008, 2009, 2010, 2011, 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//---------------------------------------------------------------------------
+#ifndef __deal2__fe_values_extractors_h
+#define __deal2__fe_values_extractors_h
+
+
+#include <deal.II/base/config.h>
+
+DEAL_II_NAMESPACE_OPEN
+
+
+/**
+ * A namespace in which we declare "extractors", i.e. classes that when used
+ * as subscripts in operator[] expressions on FEValues, FEFaceValues, and
+ * FESubfaceValues objects extract certain components of a vector-valued
+ * element. The result of applying an extractor to these objects is an object
+ * with corresponding type from the namespace FEValuesViews. There are
+ * extractors for single scalar components, vector components consisting of
+ * <code>dim</code> elements, and second order symmetric tensors consisting of
+ * <code>(dim*dim + dim)/2</code> components
+ *
+ * See the description of the @ref vector_valued module for examples how to
+ * use the features of this namespace.
+ *
+ * @ingroup feaccess vector_valued
+ */
+namespace FEValuesExtractors
+{
+ /**
+ * Extractor for a single scalar component
+ * of a vector-valued element. The result
+ * of applying an object of this type to an
+ * FEValues, FEFaceValues or
+ * FESubfaceValues object is of type
+ * FEValuesViews::Scalar. The concept of
+ * extractors is defined in the
+ * documentation of the namespace
+ * FEValuesExtractors and in the @ref
+ * vector_valued module.
+ *
+ * @ingroup feaccess vector_valued
+ */
+ struct Scalar
+ {
+ /**
+ * The selected scalar component of the
+ * vector.
+ */
+ unsigned int component;
+
+ /**
+ * Constructor. Take the selected
+ * vector component as argument.
+ */
+ Scalar (const unsigned int component);
+ };
+
+
+ /**
+ * Extractor for a vector of
+ * <code>spacedim</code> components of a
+ * vector-valued element. The value of
+ * <code>spacedim</code> is defined by the
+ * FEValues object the extractor is applied
+ * to. The result of applying an object of
+ * this type to an FEValues, FEFaceValues
+ * or FESubfaceValues object is of type
+ * FEValuesViews::Vector.
+ *
+ * The concept of
+ * extractors is defined in the
+ * documentation of the namespace
+ * FEValuesExtractors and in the @ref
+ * vector_valued module.
+ *
+ * Note that in the current context, a
+ * vector is meant in the sense physics
+ * uses it: it has <code>spacedim</code>
+ * components that behave in specific ways
+ * under coordinate system
+ * transformations. Examples include
+ * velocity or displacement fields. This is
+ * opposed to how mathematics uses the word
+ * "vector" (and how we use this word in
+ * other contexts in the library, for
+ * example in the Vector class), where it
+ * really stands for a collection of
+ * numbers. An example of this latter use
+ * of the word could be the set of
+ * concentrations of chemical species in a
+ * flame; however, these are really just a
+ * collection of scalar variables, since
+ * they do not change if the coordinate
+ * system is rotated, unlike the components
+ * of a velocity vector, and consequently,
+ * this class should not be used for this
+ * context.
+ *
+ * @ingroup feaccess vector_valued
+ */
+ struct Vector
+ {
+ /**
+ * The first component of the vector
+ * view.
+ */
+ unsigned int first_vector_component;
+
+ /**
+ * Constructor. Take the first
+ * component of the selected vector
+ * inside the FEValues object as
+ * argument.
+ */
+ Vector (const unsigned int first_vector_component);
+ };
+
+
+ /**
+ * Extractor for a symmetric tensor of a
+ * rank specified by the template
+ * argument. For a second order symmetric
+ * tensor, this represents a collection of
+ * <code>(dim*dim + dim)/2</code>
+ * components of a vector-valued
+ * element. The value of <code>dim</code>
+ * is defined by the FEValues object the
+ * extractor is applied to. The result of
+ * applying an object of this type to an
+ * FEValues, FEFaceValues or
+ * FESubfaceValues object is of type
+ * FEValuesViews::SymmetricTensor.
+ *
+ * The concept of
+ * extractors is defined in the
+ * documentation of the namespace
+ * FEValuesExtractors and in the @ref
+ * vector_valued module.
+ *
+ * @ingroup feaccess vector_valued
+ *
+ * @author Andrew McBride, 2009
+ */
+ template <int rank>
+ struct SymmetricTensor
+ {
+ /**
+ * The first component of the tensor
+ * view.
+ */
+ unsigned int first_tensor_component;
+
+ /**
+ * Constructor. Take the first
+ * component of the selected tensor
+ * inside the FEValues object as
+ * argument.
+ */
+ SymmetricTensor (const unsigned int first_tensor_component);
+ };
+}
+
+
+DEAL_II_NAMESPACE_CLOSE
+
+#endif
* not. It is used by the
* refinement listeners as a
* persistent buffer during the
- * refinement.
+ * refinement, i.e. from between
+ * when pre_refinement_action is
+ * called and when post_refinement_action
+ * runs.
*/
std::vector<std::vector<bool> *> has_children;
#include <deal.II/base/config.h>
#include <deal.II/base/std_cxx1x/shared_ptr.h>
#include <deal.II/fe/fe.h>
+#include <deal.II/fe/fe_values_extractors.h>
+#include <deal.II/fe/component_mask.h>
DEAL_II_NAMESPACE_OPEN
*/
bool hp_constraints_are_implemented () const;
+ /**
+ * Return a component mask with as many elements as this
+ * object has vector components and of which exactly the
+ * one component is true that corresponds to the given
+ * argument.
+ *
+ * @note This function is the equivalent of
+ * FiniteElement::component_mask() with the same arguments.
+ * It verifies that it gets the same result from every one
+ * of the elements that are stored in this FECollection. If
+ * this is not the case, it throws an exception.
+ *
+ * @param scalar An object that represents a single scalar
+ * vector component of this finite element.
+ * @return A component mask that is false in all components
+ * except for the one that corresponds to the argument.
+ */
+ ComponentMask
+ component_mask (const FEValuesExtractors::Scalar &scalar) const;
+
+ /**
+ * Return a component mask with as many elements as this
+ * object has vector components and of which exactly the
+ * <code>dim</code> components are true that correspond to the given
+ * argument.
+ *
+ * @note This function is the equivalent of
+ * FiniteElement::component_mask() with the same arguments.
+ * It verifies that it gets the same result from every one
+ * of the elements that are stored in this FECollection. If
+ * this is not the case, it throws an exception.
+ *
+ * @param vector An object that represents dim
+ * vector components of this finite element.
+ * @return A component mask that is false in all components
+ * except for the ones that corresponds to the argument.
+ */
+ ComponentMask
+ component_mask (const FEValuesExtractors::Vector &vector) const;
+
+ /**
+ * Return a component mask with as many elements as this
+ * object has vector components and of which exactly the
+ * <code>dim*(dim+1)/2</code> components are true that
+ * correspond to the given argument.
+ *
+ * @note This function is the equivalent of
+ * FiniteElement::component_mask() with the same arguments.
+ * It verifies that it gets the same result from every one
+ * of the elements that are stored in this FECollection. If
+ * this is not the case, it throws an exception.
+ *
+ * @param sym_tensor An object that represents dim*(dim+1)/2
+ * components of this finite element that are jointly to be
+ * interpreted as forming a symmetric tensor.
+ * @return A component mask that is false in all components
+ * except for the ones that corresponds to the argument.
+ */
+ ComponentMask
+ component_mask (const FEValuesExtractors::SymmetricTensor<2> &sym_tensor) const;
+
+ /**
+ * Given a block mask (see @ref GlossBlockMask "this glossary entry"),
+ * produce a component mask (see @ref GlossComponentMask "this glossary entry")
+ * that represents the components that correspond to the blocks selected in
+ * the input argument. This is essentially a conversion operator from
+ * BlockMask to ComponentMask.
+ *
+ * @note This function is the equivalent of
+ * FiniteElement::component_mask() with the same arguments.
+ * It verifies that it gets the same result from every one
+ * of the elements that are stored in this FECollection. If
+ * this is not the case, it throws an exception.
+ *
+ * @param block_mask The mask that selects individual blocks of the finite
+ * element
+ * @return A mask that selects those components corresponding to the selected
+ * blocks of the input argument.
+ */
+ ComponentMask
+ component_mask (const BlockMask &block_mask) const;
+
+ /**
+ * Return a block mask with as many elements as this
+ * object has blocks and of which exactly the
+ * one component is true that corresponds to the given
+ * argument. See @ref GlossBlockMask "the glossary"
+ * for more information.
+ *
+ * @note This function will only succeed if the scalar referenced
+ * by the argument encompasses a complete block. In other words,
+ * if, for example, you pass an extractor for the single
+ * $x$ velocity and this object represents an FE_RaviartThomas
+ * object, then the single scalar object you selected is part
+ * of a larger block and consequently there is no block mask that
+ * would represent it. The function will then produce an exception.
+ *
+ * @note This function is the equivalent of
+ * FiniteElement::component_mask() with the same arguments.
+ * It verifies that it gets the same result from every one
+ * of the elements that are stored in this FECollection. If
+ * this is not the case, it throws an exception.
+ *
+ * @param scalar An object that represents a single scalar
+ * vector component of this finite element.
+ * @return A component mask that is false in all components
+ * except for the one that corresponds to the argument.
+ */
+ BlockMask
+ block_mask (const FEValuesExtractors::Scalar &scalar) const;
+
+ /**
+ * Return a component mask with as many elements as this
+ * object has vector components and of which exactly the
+ * <code>dim</code> components are true that correspond to the given
+ * argument. See @ref GlossBlockMask "the glossary"
+ * for more information.
+ *
+ * @note This function is the equivalent of
+ * FiniteElement::component_mask() with the same arguments.
+ * It verifies that it gets the same result from every one
+ * of the elements that are stored in this FECollection. If
+ * this is not the case, it throws an exception.
+ *
+ * @note The same caveat applies as to the version of the function above:
+ * The extractor object passed as argument must be so that it corresponds
+ * to full blocks and does not split blocks of this element.
+ *
+ * @param vector An object that represents dim
+ * vector components of this finite element.
+ * @return A component mask that is false in all components
+ * except for the ones that corresponds to the argument.
+ */
+ BlockMask
+ block_mask (const FEValuesExtractors::Vector &vector) const;
+
+ /**
+ * Return a component mask with as many elements as this
+ * object has vector components and of which exactly the
+ * <code>dim*(dim+1)/2</code> components are true that
+ * correspond to the given argument. See @ref GlossBlockMask "the glossary"
+ * for more information.
+ *
+ * @note The same caveat applies as to the version of the function above:
+ * The extractor object passed as argument must be so that it corresponds
+ * to full blocks and does not split blocks of this element.
+ *
+ * @note This function is the equivalent of
+ * FiniteElement::component_mask() with the same arguments.
+ * It verifies that it gets the same result from every one
+ * of the elements that are stored in this FECollection. If
+ * this is not the case, it throws an exception.
+ *
+ * @param sym_tensor An object that represents dim*(dim+1)/2
+ * components of this finite element that are jointly to be
+ * interpreted as forming a symmetric tensor.
+ * @return A component mask that is false in all components
+ * except for the ones that corresponds to the argument.
+ */
+ BlockMask
+ block_mask (const FEValuesExtractors::SymmetricTensor<2> &sym_tensor) const;
+
+ /**
+ * Given a component mask (see @ref GlossComponentMask "this glossary entry"),
+ * produce a block mask (see @ref GlossBlockMask "this glossary entry")
+ * that represents the blocks that correspond to the components selected in
+ * the input argument. This is essentially a conversion operator from
+ * ComponentMask to BlockMask.
+ *
+ * @note This function will only succeed if the components referenced
+ * by the argument encompasses complete blocks. In other words,
+ * if, for example, you pass an component mask for the single
+ * $x$ velocity and this object represents an FE_RaviartThomas
+ * object, then the single component you selected is part
+ * of a larger block and consequently there is no block mask that
+ * would represent it. The function will then produce an exception.
+ *
+ * @note This function is the equivalent of
+ * FiniteElement::component_mask() with the same arguments.
+ * It verifies that it gets the same result from every one
+ * of the elements that are stored in this FECollection. If
+ * this is not the case, it throws an exception.
+ *
+ * @param component_mask The mask that selects individual components of the finite
+ * element
+ * @return A mask that selects those blocks corresponding to the selected
+ * blocks of the input argument.
+ */
+ BlockMask
+ block_mask (const ComponentMask &component_mask) const;
+
/**
* Exception
// similar as before, now with shortcut for
- // deal.II sparse matrices. this lets use
+ // deal.II sparse matrices. this lets us
// avoid using extra arrays, and does all the
// operations just in place, i.e., in the
// respective matrix row
template <int dim, int spacedim>
void initialize(const MGDoFHandler<dim,spacedim>& dof,
const typename FunctionMap<dim>::type& function_map,
- const std::vector<bool>& component_mask = std::vector<bool>());
+ const ComponentMask &component_mask = ComponentMask());
/**
* Reset the data structures.
MGConstrainedDoFs::initialize(
const MGDoFHandler<dim,spacedim>& dof,
const typename FunctionMap<dim>::type& function_map,
- const std::vector<bool>& component_mask)
+ const ComponentMask &component_mask)
{
const unsigned int nlevels = dof.get_tria().n_levels();
boundary_indices.resize(nlevels);
make_boundary_list (const MGDoFHandler<dim,spacedim> &mg_dof,
const typename FunctionMap<dim>::type &function_map,
std::vector<std::set<unsigned int> > &boundary_indices,
- const std::vector<bool> &component_mask = std::vector<bool>());
+ const ComponentMask &component_mask = ComponentMask());
/**
* The same function as above, but return
make_boundary_list (const MGDoFHandler<dim,spacedim> &mg_dof,
const typename FunctionMap<dim>::type &function_map,
std::vector<IndexSet> &boundary_indices,
- const std::vector<bool> &component_mask = std::vector<bool>());
+ const ComponentMask &component_mask = ComponentMask());
/**
* Maybe no longer needed.
apply_boundary_values (const std::set<unsigned int> &boundary_dofs,
SparseMatrix<number>& matrix,
const bool preserve_symmetry,
- const bool ignore_zeros = false);
+ const bool ignore_zeros = false);
template <typename number>
void
* on the blocks having a
* <tt>true</tt> entry here.
*/
+//TODO: rename this to block_mask, in the same way as has already been done in MGTransferComponent, and give it type BlockMask
std::vector<bool> selected;
/**
* entries may be illegal
* unsigned integers.
*/
+//TODO: rename this to mg_block_mask, in the same way as has already been done in MGTransferComponent, and give it type BlockMask
std::vector<unsigned int> mg_block;
/**
* this refers to the
* <b>renumbered</b> components.
*/
- std::vector<bool> selected;
+ ComponentMask component_mask;
/**
* Flag of selected components.
* this refers to the
* <b>renumbered</b> components.
*/
- std::vector<bool> mg_selected;
+ ComponentMask mg_component_mask;
/**
* Target component of the
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = numbers::invalid_unsigned_int,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim>* coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
- const std::vector<bool> &component_mask = std::vector<bool>(),
+ const ComponentMask &component_mask = ComponentMask(),
const Function<spacedim> *coefficients = 0,
const unsigned int n_threads = multithread_info.n_default_threads,
const types::subdomain_id subdomain_id = types::invalid_subdomain_id,
#ifndef __dealii__point_value_history_h
#define __dealii__point_value_history_h
-#include <deal.II/dofs/dof_handler.h>
#include <deal.II/base/point.h>
-#include <deal.II/lac/vector.h>
-
-#include <deal.II/dofs/dof_accessor.h>
+#include <deal.II/base/smartpointer.h>
+#include <deal.II/base/utilities.h>
#include <deal.II/base/exceptions.h>
#include <deal.II/base/quadrature_lib.h>
+#include <deal.II/lac/vector.h>
+#include <deal.II/grid/grid_tools.h>
+#include <deal.II/dofs/dof_accessor.h>
+#include <deal.II/dofs/dof_handler.h>
#include <deal.II/fe/fe_q.h>
#include <deal.II/fe/mapping.h>
#include <deal.II/fe/mapping_q1.h>
#include <deal.II/fe/fe_values.h>
-#include <deal.II/base/smartpointer.h>
-#include <deal.II/base/utilities.h>
-#include <numerics/data_postprocessor.h>
-#include <grid/grid_tools.h>
+#include <deal.II/fe/component_mask.h>
+#include <deal.II/numerics/data_postprocessor.h>
#include <vector>
#include <iostream>
* </ol>
*
* When recording a new mnemonic name, the user must supply a
- * std::vector@<bool@> component_mask (see @ref GlossComponentMask "this glossary entry")
+ * component_mask (see @ref GlossComponentMask "this glossary entry")
* to indicate the @ref GlossComponent "(vector) components"
* to be extracted from the given input. If the user simply wants to extract
* all the components, the mask need not be explicitly supplied to the @p
* be called in any order.
*/
void add_field_name(const std::string &vector_name,
- const std::vector <bool> &component_mask = std::vector <bool>());
+ const ComponentMask &component_mask = ComponentMask());
/**
* Put another mnemonic string (and hence
* Saves a component mask
* for each mnemonic.
*/
- std::map <std::string, std::vector<bool> > component_mask;
+ std::map <std::string, ComponentMask> component_mask;
/**
const DH &dof,
const typename FunctionMap<DH::space_dimension>::type &function_map,
std::map<unsigned int,double> &boundary_values,
- const std::vector<bool> &component_mask = std::vector<bool>());
+ const ComponentMask &component_mask = ComponentMask());
/**
* @deprecated This function exists mainly
const types::boundary_id boundary_component,
const Function<DH::space_dimension> &boundary_function,
std::map<unsigned int,double> &boundary_values,
- const std::vector<bool> &component_mask = std::vector<bool>());
+ const ComponentMask &component_mask = ComponentMask());
/**
* Calls the other
const types::boundary_id boundary_component,
const Function<DH::space_dimension> &boundary_function,
std::map<unsigned int,double> &boundary_values,
- const std::vector<bool> &component_mask = std::vector<bool>());
+ const ComponentMask &component_mask = ComponentMask());
/**
interpolate_boundary_values (const DH &dof,
const typename FunctionMap<DH::space_dimension>::type &function_map,
std::map<unsigned int,double> &boundary_values,
- const std::vector<bool> &component_mask = std::vector<bool>());
+ const ComponentMask &component_mask = ComponentMask());
/**
const DH &dof,
const typename FunctionMap<DH::space_dimension>::type &function_map,
ConstraintMatrix &constraints,
- const std::vector<bool> &component_mask = std::vector<bool>());
+ const ComponentMask &component_mask = ComponentMask());
/**
* @deprecated This function exists
const types::boundary_id boundary_component,
const Function<DH::space_dimension> &boundary_function,
ConstraintMatrix &constraints,
- const std::vector<bool> &component_mask = std::vector<bool>());
+ const ComponentMask &component_mask = ComponentMask());
/**
* Calls the other
const types::boundary_id boundary_component,
const Function<DH::space_dimension> &boundary_function,
ConstraintMatrix &constraints,
- const std::vector<bool> &component_mask = std::vector<bool>());
+ const ComponentMask &component_mask = ComponentMask());
/**
interpolate_boundary_values (const DH &dof,
const typename FunctionMap<DH::space_dimension>::type &function_map,
ConstraintMatrix &constraints,
- const std::vector<bool> &component_mask = std::vector<bool>());
+ const ComponentMask &component_mask = ComponentMask());
/**
= function_values_scalar[fe_index][dof_to_rep_index_table[fe_index][i]];
}
}
- vec.compress(::dealii::VectorOperation::insert);
+ vec.compress(::dealii::VectorOperation::insert);
}
const DH &dof,
const typename FunctionMap<DH::space_dimension>::type &function_map,
std::map<unsigned int,double> &boundary_values,
- const std::vector<bool> &component_mask_,
+ const ComponentMask &component_mask,
const dealii::internal::int2type<1>)
{
const unsigned int dim = DH::dimension;
const unsigned int spacedim=DH::space_dimension;
- Assert ((component_mask_.size() == 0) ||
- (component_mask_.size() == dof.get_fe().n_components()),
+ Assert (component_mask.represents_n_components(dof.get_fe().n_components()),
ExcMessage ("The number of components in the mask has to be either "
"zero or equal to the number of components in the finite "
"element."));
ExcDimensionMismatch(fe.n_components(),
boundary_function.n_components));
- // set the component mask to either
- // the original value or a vector
- // of trues
- const std::vector<bool> component_mask ((component_mask_.size() == 0) ?
- std::vector<bool> (fe.n_components(), true) :
- component_mask_);
- Assert (std::count(component_mask.begin(), component_mask.end(), true) > 0,
+ Assert (component_mask.n_selected_components(fe.n_components()) > 0,
ExcNoComponentSelected());
// now set the value of
const DH &dof,
const typename FunctionMap<DH::space_dimension>::type &function_map,
std::map<unsigned int,double> &boundary_values,
- const std::vector<bool> &component_mask_,
+ const ComponentMask &component_mask,
const dealii::internal::int2type<DH::dimension>)
{
const unsigned int dim = DH::dimension;
const unsigned int spacedim=DH::space_dimension;
- Assert ((component_mask_.size() == 0) ||
- (component_mask_.size() == dof.get_fe().n_components()),
+ Assert (component_mask.represents_n_components(dof.get_fe().n_components()),
ExcMessage ("The number of components in the mask has to be either "
"zero or equal to the number of components in the finite "
"element."));
Assert (n_components == i->second->n_components,
ExcDimensionMismatch(n_components, i->second->n_components));
- // set the component mask to either
- // the original value or a vector
- // of trues
- const std::vector<bool> component_mask ((component_mask_.size() == 0) ?
- std::vector<bool> (n_components, true) :
- component_mask_);
- Assert (std::count(component_mask.begin(), component_mask.end(), true) > 0,
- ExcNoComponentSelected());
-
// field to store the indices
std::vector<unsigned int> face_dofs;
face_dofs.reserve (DoFTools::max_dofs_per_face(dof));
// are in fact primitive
for (unsigned int i=0; i<cell->get_fe().dofs_per_cell; ++i)
{
- const std::vector<bool> &nonzero_component_array
+ const ComponentMask &nonzero_component_array
= cell->get_fe().get_nonzero_components (i);
for (unsigned int c=0; c<n_components; ++c)
if ((nonzero_component_array[c] == true)
// component
// which we
// will use
- component = (std::find (fe.get_nonzero_components(cell_i).begin(),
- fe.get_nonzero_components(cell_i).end(),
- true)
- -
- fe.get_nonzero_components(cell_i).begin());
+ component = fe.get_nonzero_components(cell_i).first_selected_component();
}
if (component_mask[component] == true)
const DH &dof,
const typename FunctionMap<DH::space_dimension>::type &function_map,
std::map<unsigned int,double> &boundary_values,
- const std::vector<bool> &component_mask_)
+ const ComponentMask &component_mask_)
{
internal::
interpolate_boundary_values (mapping, dof, function_map, boundary_values,
const types::boundary_id boundary_component,
const Function<DH::space_dimension> &boundary_function,
std::map<unsigned int,double> &boundary_values,
- const std::vector<bool> &component_mask)
+ const ComponentMask &component_mask)
{
typename FunctionMap<DH::space_dimension>::type function_map;
function_map[boundary_component] = &boundary_function;
const types::boundary_id boundary_component,
const Function<DH::space_dimension> &boundary_function,
std::map<unsigned int,double> &boundary_values,
- const std::vector<bool> &component_mask)
+ const ComponentMask &component_mask)
{
Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
interpolate_boundary_values(StaticMappingQ1<DH::dimension,DH::space_dimension>::mapping,
interpolate_boundary_values (const DH &dof,
const typename FunctionMap<DH::space_dimension>::type &function_map,
std::map<unsigned int,double> &boundary_values,
- const std::vector<bool> &component_mask)
+ const ComponentMask &component_mask)
{
Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
interpolate_boundary_values(StaticMappingQ1<DH::dimension,DH::space_dimension>::mapping,
const DH &dof,
const typename FunctionMap<DH::space_dimension>::type &function_map,
ConstraintMatrix &constraints,
- const std::vector<bool> &component_mask_)
+ const ComponentMask &component_mask_)
{
std::map<unsigned int,double> boundary_values;
interpolate_boundary_values (mapping, dof, function_map,
const types::boundary_id boundary_component,
const Function<DH::space_dimension> &boundary_function,
ConstraintMatrix &constraints,
- const std::vector<bool> &component_mask)
+ const ComponentMask &component_mask)
{
typename FunctionMap<DH::space_dimension>::type function_map;
function_map[boundary_component] = &boundary_function;
const types::boundary_id boundary_component,
const Function<DH::space_dimension> &boundary_function,
ConstraintMatrix &constraints,
- const std::vector<bool> &component_mask)
+ const ComponentMask &component_mask)
{
Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
interpolate_boundary_values(StaticMappingQ1<DH::dimension,DH::space_dimension>::mapping,
(const DH &dof,
const typename FunctionMap<DH::space_dimension>::type &function_map,
ConstraintMatrix &constraints,
- const std::vector<bool> &component_mask)
+ const ComponentMask &component_mask)
{
Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping"));
interpolate_boundary_values(StaticMappingQ1<DH::dimension,DH::space_dimension>::mapping,
// projection in 1d is equivalent
// to interpolation
interpolate_boundary_values (mapping, dof, boundary_functions,
- boundary_values, std::vector<bool>());
+ boundary_values, ComponentMask());
}
// projection in 1d is equivalent
// to interpolation
interpolate_boundary_values (mapping, dof, boundary_functions,
- boundary_values, std::vector<bool>());
+ boundary_values, ComponentMask());
}
const std::vector<Point<dim> >&
reference_quadrature_points = fe_values.get_quadrature ().get_points ();
std::pair<unsigned int, unsigned int> base_indices (0, 0);
-
+
if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) != 0)
{
unsigned int fe_index = 0;
unsigned int fe_index_old = 0;
unsigned int i = 0;
-
+
for (; i < fe.n_base_elements (); ++i)
{
fe_index_old = fe_index;
fe_index += fe.element_multiplicity (i) * fe.base_element (i).n_components ();
-
+
if (fe_index >= first_vector_component)
break;
}
-
+
base_indices.first = i;
base_indices.second = (first_vector_component - fe_index_old) / fe.base_element (i).n_components ();
}
* jacobians[q_point][1][edge_coordinate_direction[face][line]]
+ jacobians[q_point][2][edge_coordinate_direction[face][line]]
* jacobians[q_point][2][edge_coordinate_direction[face][line]]));
-
+
if (q_point == 0)
dofs_processed[i] = true;
}
quadrature_points = fe_values.get_quadrature_points ();
const unsigned int degree = fe.degree - 1;
std::pair<unsigned int, unsigned int> base_indices (0, 0);
-
+
if (dynamic_cast<const FESystem<dim>*> (&cell->get_fe ()) != 0)
{
unsigned int fe_index = 0;
unsigned int fe_index_old = 0;
unsigned int i = 0;
-
+
for (; i < fe.n_base_elements (); ++i)
{
fe_index_old = fe_index;
fe_index += fe.element_multiplicity (i) * fe.base_element (i).n_components ();
-
+
if (fe_index >= first_vector_component)
break;
}
-
+
base_indices.first = i;
base_indices.second = (first_vector_component - fe_index_old) / fe.base_element (i).n_components ();
}
* jacobians[q_point][0][face_coordinate_direction[face]]
+ jacobians[q_point][1][face_coordinate_direction[face]]
* jacobians[q_point][1][face_coordinate_direction[face]]);
-
+
if (q_point == 0)
dofs_processed[i] = true;
}
for (unsigned int d = 0; d < dim; ++d)
tmp[d] = values[q_point] (first_vector_component + d);
-
+
for (unsigned int i = 0; i < fe.dofs_per_face; ++i)
if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
&& (fe.system_to_base_index (fe.face_to_cell_index (i, face)).first == base_indices)
// the face.
for (unsigned int d = 0; d < dim; ++d)
assembling_vector (dim * q_point + d) = JxW * tmp[d];
-
+
unsigned int index = 0;
-
+
for (unsigned int i = 0; i < fe.dofs_per_face; ++i)
if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
&& (fe.system_to_base_index (fe.face_to_cell_index (i, face)).first == base_indices)
for (unsigned int d = 0; d < dim; ++d)
assembling_matrix (index, dim * q_point + d) = shape_value[d];
-
+
++index;
}
}
// values.
{
unsigned int index = 0;
-
+
for (unsigned int i = 0; i < fe.dofs_per_face; ++i)
if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
&& (fe.system_to_base_index (fe.face_to_cell_index (i, face)).first == base_indices)
assembling_vector (dim * q_point + d) = JxW * tmp[d];
unsigned int index = 0;
-
+
for (unsigned int i = 0; i < fe.dofs_per_face; ++i)
if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
&& (fe.system_to_base_index (fe.face_to_cell_index (i, face)).first == base_indices)
for (unsigned int d = 0; d < dim; ++d)
assembling_matrix (index, dim * q_point + d) = shape_value[d];
-
+
++index;
}
}
cell_matrix_inv.vmult (solution, cell_rhs);
unsigned int index = 0;
-
+
for (unsigned int i = 0; i < fe.dofs_per_face; ++i)
if (((dynamic_cast<const FESystem<dim>*> (&fe) != 0)
&& (fe.system_to_base_index (fe.face_to_cell_index (i, face)).first == base_indices)
cell->face (face)->get_dof_indices (face_dof_indices,
cell->active_fe_index ());
-
+
const double tol = 0.5 * superdegree * 1e-13 / cell->face (face)->diameter ();
for (unsigned int dof = 0; dof < dofs_per_face; ++dof)
}
const unsigned int dofs_per_face = cell->get_fe ().dofs_per_face;
-
+
dofs_processed.resize (dofs_per_face);
dof_values.resize (dofs_per_face);
const unsigned int superdegree = cell->get_fe ().degree;
const unsigned int degree = superdegree - 1;
const unsigned int dofs_per_face = cell->get_fe ().dofs_per_face;
-
+
dofs_processed.resize (dofs_per_face);
dof_values.resize (dofs_per_face);
face_dof_indices.resize (dofs_per_face);
cell->face (face)->get_dof_indices (face_dof_indices,
cell->active_fe_index ());
-
+
const double tol = 0.5 * superdegree * 1e-13 / cell->face (face)->diameter ();
for (unsigned int dof = 0; dof < dofs_per_face; ++dof)
= component_order[fe.system_to_component_index(i).first];
else
{
- const unsigned int comp = (std::find(fe.get_nonzero_components(i).begin(),
- fe.get_nonzero_components(i).end(),
- true) -
- fe.get_nonzero_components(i).begin());
+ const unsigned int comp
+ = fe.get_nonzero_components(i).first_selected_component();
// then associate this degree
// of freedom with this
else
{
const unsigned int first_nonzero_comp_i
- = (std::find (fe_collection[f].get_nonzero_components(i).begin(),
- fe_collection[f].get_nonzero_components(i).end(),
- true)
- -
- fe_collection[f].get_nonzero_components(i).begin());
+ = fe_collection[f].get_nonzero_components(i).first_selected_component();
const unsigned int first_nonzero_comp_j
- = (std::find (fe_collection[f].get_nonzero_components(j).begin(),
- fe_collection[f].get_nonzero_components(j).end(),
- true)
- -
- fe_collection[f].get_nonzero_components(j).begin());
+ = fe_collection[f].get_nonzero_components(j).first_selected_component();
Assert (first_nonzero_comp_i < fe_collection[f].n_components(),
ExcInternalError());
Assert (first_nonzero_comp_j < fe_collection[f].n_components(),
= (fe.is_primitive(i) ?
fe.system_to_component_index(i).first
:
- (std::find (fe.get_nonzero_components(i).begin(),
- fe.get_nonzero_components(i).end(),
- true)
- -
- fe.get_nonzero_components(i).begin())
+ fe.get_nonzero_components(i).first_selected_component()
);
Assert (ii < fe.n_components(), ExcInternalError());
= (fe.is_primitive(j) ?
fe.system_to_component_index(j).first
:
- (std::find (fe.get_nonzero_components(j).begin(),
- fe.get_nonzero_components(j).end(),
- true)
- -
- fe.get_nonzero_components(j).begin())
+ fe.get_nonzero_components(j).first_selected_component()
);
Assert (jj < fe.n_components(), ExcInternalError());
make_periodicity_constraints (const FaceIterator &face_1,
const typename identity<FaceIterator>::type &face_2,
dealii::ConstraintMatrix &constraint_matrix,
- const std::vector<bool> &component_mask)
+ const ComponentMask &component_mask)
{
static const int dim = FaceIterator::AccessorType::dimension;
const dealii::FiniteElement<dim> &fe = face_1->get_fe(face_1_index);
- Assert (component_mask.size() == 0 ||
- component_mask.size() == fe.n_components(),
+ Assert (component_mask.represents_n_components(fe.n_components()),
ExcMessage ("The number of components in the mask has to be either "
"zero or equal to the number of components in the finite "
"element."));
// .. and constrain them (respecting
// component_mask):
for (unsigned int i = 0; i < dofs_per_face; ++i) {
- if (component_mask.size() == 0 ||
- component_mask[fe.face_system_to_component_index(i).first]) {
- if(!constraint_matrix.is_constrained(dofs_1[i])) {
- constraint_matrix.add_line(dofs_1[i]);
- constraint_matrix.add_entry(dofs_1[i], dofs_2[i], 1.0);
+ if ((component_mask.n_selected_components(fe.n_components()) == fe.n_components())
+ ||
+ (component_mask[fe.face_system_to_component_index(i).first] == true))
+ {
+ if(!constraint_matrix.is_constrained(dofs_1[i]))
+ {
+ constraint_matrix.add_line(dofs_1[i]);
+ constraint_matrix.add_entry(dofs_1[i], dofs_2[i], 1.0);
+ }
}
- }
}
}
const types::boundary_id boundary_component,
const int direction,
dealii::ConstraintMatrix &constraint_matrix,
- const std::vector<bool> &component_mask)
+ const ComponentMask &component_mask)
{
Tensor<1,DH::space_dimension> dummy;
make_periodicity_constraints (dof_handler,
dealii::Tensor<1,DH::space_dimension>
&offset,
dealii::ConstraintMatrix &constraint_matrix,
- const std::vector<bool> &component_mask)
+ const ComponentMask &component_mask)
{
static const int space_dim = DH::space_dimension;
Assert (0<=direction && direction<space_dim,
// make_periodicity_constraints function
// to every matching pair:
for (typename std::map<CellIterator, CellIterator>::iterator it = matched_cells.begin();
- it != matched_cells.end(); ++it)
+ it != matched_cells.end(); ++it)
{
- typedef typename DH::face_iterator FaceIterator;
- FaceIterator face_1 = it->first->face(2*direction);
- FaceIterator face_2 = it->second->face(2*direction+1);
+ typedef typename DH::face_iterator FaceIterator;
+ FaceIterator face_1 = it->first->face(2*direction);
+ FaceIterator face_2 = it->second->face(2*direction+1);
- Assert(face_1->at_boundary() && face_2->at_boundary(),
- ExcInternalError());
+ Assert(face_1->at_boundary() && face_2->at_boundary(),
+ ExcInternalError());
- Assert (face_1->boundary_indicator() == boundary_component &&
- face_2->boundary_indicator() == boundary_component,
- ExcInternalError());
+ Assert (face_1->boundary_indicator() == boundary_component &&
+ face_2->boundary_indicator() == boundary_component,
+ ExcInternalError());
- make_periodicity_constraints(face_1,
- face_2,
- constraint_matrix,
- component_mask);
+ make_periodicity_constraints(face_1,
+ face_2,
+ constraint_matrix,
+ component_mask);
}
}
namespace internal
{
- // this internal function assigns to each dof
- // the respective component of the vector
- // system. if use_blocks is set, then the
- // assignment is done by blocks, not by
- // components, as specified by
- // component_select. The additional argument
- // component_select is only used for
- // non-primitive FEs, where we need it since
- // more components couple, and no unique
- // component can be assigned. Then, we sort
- // them to the first selected component of the
- // vector system.
- //
- // the output array dofs_by_component
- // lists for each dof the corresponding
- // vector component. if the DoFHandler is
- // based on a parallel distributed
- // triangulation then the output array is
- // index by
- // dof.locally_owned_dofs().index_within_set(indices[i])
+ // return an array that for each dof on the reference cell
+ // lists the corresponding vector component.
+ //
+ // if an element is non-primitive then we assign to each degree of freedom
+ // the following component:
+ // - if the nonzero components that belong to a shape function are not
+ // selected in the component_mask, then the shape function is assigned
+ // to the first nonzero vector component that corresponds to this
+ // shape function
+ // - otherwise, the shape function is assigned the first component selected
+ // in the component_mask that corresponds to this shape function
+ template <int dim, int spacedim>
+ std::vector<unsigned char>
+ get_local_component_association (const FiniteElement<dim,spacedim> &fe,
+ const ComponentMask &component_mask)
+ {
+ std::vector<unsigned char> local_component_association (fe.dofs_per_cell,
+ (unsigned char)(-1));
+
+ // compute the component each local dof belongs to.
+ // if the shape function is primitive, then this
+ // is simple and we can just associate it with
+ // what system_to_component_index gives us
+ for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
+ if (fe.is_primitive(i))
+ local_component_association[i] =
+ fe.system_to_component_index(i).first;
+ else
+ // if the shape function is not primitive, then either use the
+ // component of the first nonzero component corresponding
+ // to this shape function (if the component is not specified
+ // in the component_mask), or the first component of this block
+ // that is listed in the component_mask (if the block this
+ // component corresponds to is indeed specified in the component
+ // mask)
+ {
+ const unsigned int first_comp =
+ fe.get_nonzero_components(i).first_selected_component();
+
+ if ((fe.get_nonzero_components(i)
+ &
+ component_mask).n_selected_components(fe.n_components()) == 0)
+ local_component_association[i] = first_comp;
+ else
+ // pick the component selected. we know from the previous 'if'
+ // that within the components that are nonzero for this
+ // shape function there must be at least one for which the
+ // mask is true, so we will for sure run into the break()
+ // at one point
+ for (unsigned int c=first_comp; c<fe.n_components(); ++c)
+ if (component_mask[c] == true)
+ {
+ local_component_association[i] = c;
+ break;
+ }
+ }
+
+ Assert (std::find (local_component_association.begin(),
+ local_component_association.end(),
+ (unsigned char)(-1))
+ ==
+ local_component_association.end(),
+ ExcInternalError());
+
+ return local_component_association;
+ }
+
+
+ // this internal function assigns to each dof
+ // the respective component of the vector
+ // system.
+ //
+ // the output array dofs_by_component
+ // lists for each dof the corresponding
+ // vector component. if the DoFHandler is
+ // based on a parallel distributed
+ // triangulation then the output array is
+ // index by
+ // dof.locally_owned_dofs().index_within_set(indices[i])
+ //
+ // if an element is non-primitive then we assign to each degree of freedom
+ // the following component:
+ // - if the nonzero components that belong to a shape function are not
+ // selected in the component_mask, then the shape function is assigned
+ // to the first nonzero vector component that corresponds to this
+ // shape function
+ // - otherwise, the shape function is assigned the first component selected
+ // in the component_mask that corresponds to this shape function
template <class DH>
- inline
void
- extract_dofs_by_component (const DH &dof,
- const std::vector<bool> &component_select,
- const bool sort_by_blocks,
- std::vector<unsigned char> &dofs_by_component)
+ get_component_association (const DH &dof,
+ const ComponentMask &component_mask,
+ std::vector<unsigned char> &dofs_by_component)
{
const dealii::hp::FECollection<DH::dimension,DH::space_dimension>
- fe_collection (dof.get_fe());
+ fe_collection (dof.get_fe());
Assert (fe_collection.n_components() < 256, ExcNotImplemented());
Assert (dofs_by_component.size() == dof.n_locally_owned_dofs(),
- ExcDimensionMismatch(dofs_by_component.size(),
- dof.n_locally_owned_dofs()));
-
- // next set up a table for the degrees
- // of freedom on each of the cells
- // (regardless of the fact whether it
- // is listed in the component_select
- // argument or not)
- //
- // for each element 'f' of the
- // FECollection,
- // local_component_association[f][d]
- // then returns the vector component
- // that degree of freedom 'd' belongs
- // to (or, in the case of
- // sort_by_blocks, the block that it
- // corresponds to)
- std::vector<std::vector<unsigned char> > local_component_association
- (fe_collection.size());
+ ExcDimensionMismatch(dofs_by_component.size(),
+ dof.n_locally_owned_dofs()));
+
+ // next set up a table for the degrees
+ // of freedom on each of the cells
+ // (regardless of the fact whether it
+ // is listed in the component_select
+ // argument or not)
+ //
+ // for each element 'f' of the
+ // FECollection,
+ // local_component_association[f][d]
+ // then returns the vector component
+ // that degree of freedom 'd' belongs
+ // to
+ std::vector<std::vector<unsigned char> >
+ local_component_association (fe_collection.size());
for (unsigned int f=0; f<fe_collection.size(); ++f)
{
const FiniteElement<DH::dimension,DH::space_dimension> &fe =
- fe_collection[f];
- local_component_association[f].resize(fe.dofs_per_cell);
- if (sort_by_blocks == true)
- // compute the block each
- // local dof belongs to
- {
- for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
- local_component_association[f][i]
- = fe.system_to_block_index(i).first;
- }
- else
- // compute the component each
- // local dof belongs to
- for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
- if (fe.is_primitive(i))
- local_component_association[f][i] =
- fe.system_to_component_index(i).first;
- else
- // if this shape function is
- // not primitive, then we have
- // to work harder. we have to
- // find out whether _any_ of
- // the vector components of
- // this element is selected or
- // not
- //
- // to do so, get the a list of
- // nonzero elements and see which are
- // actually active
- {
- const unsigned int first_comp =
- (std::find(fe.get_nonzero_components(i).begin(),
- fe.get_nonzero_components(i).end(),
- true) -
- fe.get_nonzero_components(i).begin());
- const unsigned int end_comp =
- (std::find(fe.get_nonzero_components(i).begin()+first_comp,
- fe.get_nonzero_components(i).end(),
- false)-
- fe.get_nonzero_components(i).begin());
-
- // now check whether any of
- // the components in between
- // is set
- if (component_select.size() == 0 ||
- (component_select[first_comp] == true ||
- std::count(component_select.begin()+first_comp,
- component_select.begin()+end_comp, true) == 0))
- local_component_association[f][i] = first_comp;
- else
- for (unsigned int c=first_comp; c<end_comp; ++c)
- if (component_select[c] == true)
- {
- local_component_association[f][i] = c;
- break;
- }
- }
+ fe_collection[f];
+ local_component_association[f]
+ = get_local_component_association (fe, component_mask);
}
- // then loop over all cells and do
- // the work
+ // then loop over all cells and do
+ // the work
std::vector<unsigned int> indices;
for (typename DH::active_cell_iterator c=dof.begin_active();
- c!=dof.end(); ++ c)
+ c!=dof.end(); ++ c)
if (c->is_locally_owned())
{
const unsigned int fe_index = c->active_fe_index();
for (unsigned int i=0; i<dofs_per_cell; ++i)
if (dof.locally_owned_dofs().is_element(indices[i]))
dofs_by_component[dof.locally_owned_dofs().index_within_set(indices[i])]
- = local_component_association[fe_index][i];
+ = local_component_association[fe_index][i];
+ }
+ }
+
+
+ // this is the function corresponding to the one above but working
+ // on blocks instead of components.
+ //
+ // the output array dofs_by_block
+ // lists for each dof the corresponding
+ // vector block. if the DoFHandler is
+ // based on a parallel distributed
+ // triangulation then the output array is
+ // index by
+ // dof.locally_owned_dofs().index_within_set(indices[i])
+ template <class DH>
+ inline
+ void
+ get_block_association (const DH &dof,
+ std::vector<unsigned char> &dofs_by_block)
+ {
+ const dealii::hp::FECollection<DH::dimension,DH::space_dimension>
+ fe_collection (dof.get_fe());
+ Assert (fe_collection.n_components() < 256, ExcNotImplemented());
+ Assert (dofs_by_block.size() == dof.n_locally_owned_dofs(),
+ ExcDimensionMismatch(dofs_by_block.size(),
+ dof.n_locally_owned_dofs()));
+
+ // next set up a table for the degrees
+ // of freedom on each of the cells
+ // (regardless of the fact whether it
+ // is listed in the component_select
+ // argument or not)
+ //
+ // for each element 'f' of the
+ // FECollection,
+ // local_block_association[f][d]
+ // then returns the vector block
+ // that degree of freedom 'd' belongs
+ // to
+ std::vector<std::vector<unsigned char> > local_block_association
+ (fe_collection.size());
+ for (unsigned int f=0; f<fe_collection.size(); ++f)
+ {
+ const FiniteElement<DH::dimension,DH::space_dimension> &fe =
+ fe_collection[f];
+ local_block_association[f].resize(fe.dofs_per_cell,
+ (unsigned char)(-1));
+ for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
+ local_block_association[f][i] = fe.system_to_block_index(i).first;
+
+ Assert (std::find (local_block_association[f].begin(),
+ local_block_association[f].end(),
+ (unsigned char)(-1))
+ ==
+ local_block_association[f].end(),
+ ExcInternalError());
+ }
+
+ // then loop over all cells and do
+ // the work
+ std::vector<unsigned int> indices;
+ for (typename DH::active_cell_iterator c=dof.begin_active();
+ c!=dof.end(); ++ c)
+ if (c->is_locally_owned())
+ {
+ const unsigned int fe_index = c->active_fe_index();
+ const unsigned int dofs_per_cell = c->get_fe().dofs_per_cell;
+ indices.resize(dofs_per_cell);
+ c->get_dof_indices(indices);
+ for (unsigned int i=0; i<dofs_per_cell; ++i)
+ if (dof.locally_owned_dofs().is_element(indices[i]))
+ dofs_by_block[dof.locally_owned_dofs().index_within_set(indices[i])]
+ = local_block_association[fe_index][i];
}
}
}
else
{
std::vector<unsigned char> component_dofs (dof_handler.n_locally_owned_dofs());
- std::vector<bool> component_mask (dof_handler.get_fe().n_components(),
- false);
- component_mask[component] = true;
- internal::extract_dofs_by_component (dof_handler, component_mask,
- false, component_dofs);
+ internal::get_component_association (dof_handler,
+ dof_handler.get_fe().component_mask
+ (FEValuesExtractors::Scalar(component)),
+ component_dofs);
for (unsigned int i=0; i<dof_data.size(); ++i)
if (component_dofs[i] == static_cast<unsigned char>(component))
template <int dim, int spacedim>
void
- extract_dofs (
- const DoFHandler<dim,spacedim> &dof,
- const std::vector<bool> &component_select,
- std::vector<bool> &selected_dofs,
- const bool count_by_blocks)
+ extract_dofs (const DoFHandler<dim,spacedim> &dof,
+ const ComponentMask &component_mask,
+ std::vector<bool> &selected_dofs)
{
const FiniteElement<dim,spacedim> &fe = dof.get_fe();
- if (count_by_blocks == true)
- {
- Assert(component_select.size() == fe.n_blocks(),
- ExcDimensionMismatch(component_select.size(), fe.n_blocks()));
- }
- else
- {
- Assert(component_select.size() == n_components(dof),
- ExcDimensionMismatch(component_select.size(), n_components(dof)));
- }
-
+ Assert(component_mask.represents_n_components(fe.n_components()),
+ ExcMessage ("The given component mask is not sized correctly to represent the "
+ "components of the given finite element."));
Assert(selected_dofs.size() == dof.n_locally_owned_dofs(),
ExcDimensionMismatch(selected_dofs.size(), dof.n_locally_owned_dofs()));
// is selected, and all components
// are selected; both rather
// stupid, but easy to catch
- if (std::count (component_select.begin(), component_select.end(), true)
- == 0)
+ if (component_mask.n_selected_components(n_components(dof)) == 0)
{
std::fill_n (selected_dofs.begin(), dof.n_locally_owned_dofs(), false);
return;
}
- else if (std::count (component_select.begin(), component_select.end(), true)
- == static_cast<signed int>(component_select.size()))
+ else if (component_mask.n_selected_components(n_components(dof)) == n_components(dof))
{
std::fill_n (selected_dofs.begin(), dof.n_locally_owned_dofs(), true);
return;
// preset all values by false
std::fill_n (selected_dofs.begin(), dof.n_locally_owned_dofs(), false);
- // if we count by blocks, we need to extract
- // the association of blocks with local dofs,
- // and then go through all the cells and set
- // the properties according to this
- // info. Otherwise, we let the function
- // extract_dofs_by_component function do the
- // job.
+ // get the component association of each DoF
+ // and then select the ones that match the
+ // given set of blocks
std::vector<unsigned char> dofs_by_component (dof.n_locally_owned_dofs());
- internal::extract_dofs_by_component (dof, component_select, count_by_blocks,
+ internal::get_component_association (dof, component_mask,
dofs_by_component);
for (unsigned int i=0; i<dof.n_locally_owned_dofs(); ++i)
- if (component_select[dofs_by_component[i]] == true)
+ if (component_mask[dofs_by_component[i]] == true)
selected_dofs[i] = true;
}
+//TODO: Unify the following two functions with the non-hp case
template <int dim, int spacedim>
void
- extract_dofs (
- const hp::DoFHandler<dim,spacedim> &dof,
- const std::vector<bool> &component_select,
- std::vector<bool> &selected_dofs,
- const bool count_by_blocks)
+ extract_dofs (const hp::DoFHandler<dim,spacedim> &dof,
+ const ComponentMask &component_mask,
+ std::vector<bool> &selected_dofs)
{
const FiniteElement<dim,spacedim> &fe = dof.begin_active()->get_fe();
- if (count_by_blocks == true)
- {
- Assert(component_select.size() == fe.n_blocks(),
- ExcDimensionMismatch(component_select.size(), fe.n_blocks()));
- }
- else
- {
- Assert(component_select.size() == n_components(dof),
- ExcDimensionMismatch(component_select.size(), n_components(dof)));
- }
-
+ Assert(component_mask.represents_n_components(fe.n_components()),
+ ExcMessage ("The given component mask is not sized correctly to represent the "
+ "components of the given finite element."));
Assert(selected_dofs.size() == dof.n_dofs(),
ExcDimensionMismatch(selected_dofs.size(), dof.n_dofs()));
// is selected, and all components
// are selected; both rather
// stupid, but easy to catch
- if (std::count (component_select.begin(), component_select.end(), true)
- == 0)
+ if (component_mask.n_selected_components(n_components(dof)) == 0)
{
std::fill_n (selected_dofs.begin(), dof.n_dofs(), false);
return;
- };
- if (std::count (component_select.begin(), component_select.end(), true)
- == static_cast<signed int>(component_select.size()))
+ }
+ else if (component_mask.n_selected_components(n_components(dof)) == n_components(dof))
{
std::fill_n (selected_dofs.begin(), dof.n_dofs(), true);
return;
- };
+ }
// preset all values by false
std::fill_n (selected_dofs.begin(), dof.n_dofs(), false);
- // if we count by blocks, we need to extract
- // the association of blocks with local dofs,
- // and then go through all the cells and set
- // the properties according to this
- // info. Otherwise, we let the function
- // extract_dofs_by_component function do the
- // job.
+ // get the component association of each DoF
+ // and then select the ones that match the
+ // given set of components
std::vector<unsigned char> dofs_by_component (dof.n_dofs());
- internal::extract_dofs_by_component (dof, component_select, count_by_blocks,
+ internal::get_component_association (dof, component_mask,
dofs_by_component);
for (unsigned int i=0; i<dof.n_dofs(); ++i)
- if (component_select[dofs_by_component[i]] == true)
+ if (component_mask[dofs_by_component[i]] == true)
selected_dofs[i] = true;
}
+ template <int dim, int spacedim>
+ void
+ extract_dofs (const DoFHandler<dim,spacedim> &dof,
+ const BlockMask &block_mask,
+ std::vector<bool> &selected_dofs)
+ {
+ // simply forward to the function that works based on a component mask
+ extract_dofs (dof, dof.get_fe().component_mask (block_mask),
+ selected_dofs);
+ }
+
+
+
+ template <int dim, int spacedim>
+ void
+ extract_dofs (const hp::DoFHandler<dim,spacedim> &dof,
+ const BlockMask &block_mask,
+ std::vector<bool> &selected_dofs)
+ {
+ // simply forward to the function that works based on a component mask
+ extract_dofs (dof, dof.get_fe().component_mask (block_mask),
+ selected_dofs);
+ }
+
+
+
template<int dim, int spacedim>
void
- extract_level_dofs(
- const unsigned int level,
- const MGDoFHandler<dim,spacedim> &dof,
- const std::vector<bool> &component_select,
- std::vector<bool> &selected_dofs,
- const bool count_by_blocks)
+ extract_level_dofs(const unsigned int level,
+ const MGDoFHandler<dim,spacedim> &dof,
+ const ComponentMask &component_mask,
+ std::vector<bool> &selected_dofs)
{
const FiniteElement<dim,spacedim>& fe = dof.get_fe();
- if (count_by_blocks == true)
- {
- Assert(component_select.size() == fe.n_blocks(),
- ExcDimensionMismatch(component_select.size(), fe.n_blocks()));
- }
- else
- {
- Assert(component_select.size() == fe.n_components(),
- ExcDimensionMismatch(component_select.size(), fe.n_components()));
- }
-
+ Assert(component_mask.represents_n_components(n_components(dof)),
+ ExcMessage ("The given component mask is not sized correctly to represent the "
+ "components of the given finite element."));
Assert(selected_dofs.size() == dof.n_dofs(level),
ExcDimensionMismatch(selected_dofs.size(), dof.n_dofs(level)));
// is selected, and all components
// are selected, both rather
// stupid, but easy to catch
- if (std::count (component_select.begin(), component_select.end(), true)
- == 0)
+ if (component_mask.n_selected_components(n_components(dof)) == 0)
{
std::fill_n (selected_dofs.begin(), dof.n_dofs(level), false);
return;
- };
- if (std::count (component_select.begin(), component_select.end(), true)
- == static_cast<signed int>(component_select.size()))
+ }
+ else if (component_mask.n_selected_components(n_components(dof)) == n_components(dof))
{
std::fill_n (selected_dofs.begin(), dof.n_dofs(level), true);
return;
- };
+ }
// preset all values by false
std::fill_n (selected_dofs.begin(), dof.n_dofs(level), false);
// degrees of freedom on each of
// the cells whether it is
// something interesting or not
- std::vector<bool> local_selected_dofs (fe.dofs_per_cell, false);
+ std::vector<unsigned char> local_component_asssociation
+ = internal::get_local_component_association (fe, component_mask);
+ std::vector<bool> local_selected_dofs (fe.dofs_per_cell);
for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
- if (count_by_blocks == true)
- local_selected_dofs[i]
- = component_select[fe.system_to_block_index(i).first];
- else
- if (fe.is_primitive(i))
- local_selected_dofs[i]
- = component_select[fe.system_to_component_index(i).first];
- else
- // if this shape function is
- // not primitive, then we have
- // to work harder. we have to
- // find out whether _any_ of
- // the vector components of
- // this element is selected or
- // not
- //
- // to do so, get the first and
- // last vector components of
- // the base element to which
- // the local dof with index i
- // belongs
- {
- unsigned int first_comp = 0;
- const unsigned int this_base = fe.system_to_base_index(i).first.first;
- const unsigned int this_multiplicity
- = fe.system_to_base_index(i).first.second;
-
- for (unsigned int b=0; b<this_base; ++b)
- first_comp += fe.base_element(b).n_components() *
- fe.element_multiplicity(b);
- for (unsigned int m=0; m<this_multiplicity; ++m)
- first_comp += fe.base_element(this_base).n_components();
- const unsigned int end_comp = first_comp +
- fe.base_element(this_base).n_components();
-
- Assert (first_comp < fe.n_components(), ExcInternalError());
- Assert (end_comp <= fe.n_components(), ExcInternalError());
-
- // now check whether any of
- // the components in between
- // is set
- for (unsigned int c=first_comp; c<end_comp; ++c)
- if (component_select[c] == true)
- {
- local_selected_dofs[i] = true;
- break;
- }
- }
+ local_selected_dofs[i] = component_mask[local_component_asssociation[i]];
// then loop over all cells and do
// work
+ template<int dim, int spacedim>
+ void
+ extract_level_dofs(const unsigned int level,
+ const MGDoFHandler<dim,spacedim> &dof,
+ const BlockMask &block_mask,
+ std::vector<bool> &selected_dofs)
+ {
+ // simply defer to the other extract_level_dofs() function
+ extract_level_dofs (level, dof, dof.get_fe().component_mask(block_mask),
+ selected_dofs);
+ }
+
+
+
template <class DH>
void
extract_boundary_dofs (const DH &dof_handler,
- const std::vector<bool> &component_select,
+ const ComponentMask &component_mask,
std::vector<bool> &selected_dofs,
const std::set<types::boundary_id> &boundary_indicators)
{
"See the documentation for more information."));
IndexSet indices;
- extract_boundary_dofs (dof_handler, component_select,
+ extract_boundary_dofs (dof_handler, component_mask,
indices, boundary_indicators);
// clear and reset array by default values
template <class DH>
void
extract_boundary_dofs (const DH &dof_handler,
- const std::vector<bool> &component_select,
+ const ComponentMask &component_mask,
IndexSet &selected_dofs,
const std::set<types::boundary_id> &boundary_indicators)
{
- AssertDimension (component_select.size(), n_components(dof_handler));
+ Assert (component_mask.represents_n_components(n_components(dof_handler)),
+ ExcMessage ("Component mask has invalid size."));
Assert (boundary_indicators.find (numbers::internal_face_boundary_id) == boundary_indicators.end(),
ExcInvalidBoundaryIndicator());
const unsigned int dim=DH::dimension;
// check whether a certain vector
// component is selected, or all
const bool check_vector_component
- = (component_select != std::vector<bool>(component_select.size(),
- true));
+ = ((component_mask.represents_the_all_selected_mask() == false)
+ ||
+ (component_mask.n_selected_components(n_components(dof_handler)) !=
+ n_components(dof_handler)));
std::vector<unsigned int> face_dof_indices;
face_dof_indices.reserve (max_dofs_per_face(dof_handler));
numbers::invalid_unsigned_int)));
if (fe.is_primitive (cell_index))
{
- if (component_select[fe.face_system_to_component_index(i).first]
+ if (component_mask[fe.face_system_to_component_index(i).first]
== true)
selected_dofs.add_index (face_dof_indices[i]);
}
else // not primitive
{
const unsigned int first_nonzero_comp
- = (std::find (fe.get_nonzero_components(cell_index).begin(),
- fe.get_nonzero_components(cell_index).end(),
- true)
- -
- fe.get_nonzero_components(cell_index).begin());
+ = fe.get_nonzero_components(cell_index).first_selected_component();
Assert (first_nonzero_comp < fe.n_components(),
ExcInternalError());
- if (component_select[first_nonzero_comp] == true)
+ if (component_mask[first_nonzero_comp] == true)
selected_dofs.add_index (face_dof_indices[i]);
}
}
template <class DH>
void
extract_dofs_with_support_on_boundary (const DH &dof_handler,
- const std::vector<bool> &component_select,
+ const ComponentMask &component_mask,
std::vector<bool> &selected_dofs,
const std::set<types::boundary_id> &boundary_indicators)
{
- AssertDimension (component_select.size(), n_components(dof_handler));
+ Assert (component_mask.represents_n_components (n_components(dof_handler)),
+ ExcMessage ("This component mask has the wrong size."));
Assert (boundary_indicators.find (numbers::internal_face_boundary_id) == boundary_indicators.end(),
ExcInvalidBoundaryIndicator());
// check whether a certain vector
// component is selected, or all
const bool check_vector_component
- = (component_select != std::vector<bool>(component_select.size(),
- true));
+ = (component_mask.represents_the_all_selected_mask() == false);
// clear and reset array by default
// values
{
if (fe.is_primitive (i))
selected_dofs[cell_dof_indices[i]]
- = (component_select[fe.system_to_component_index(i).first]
+ = (component_mask[fe.system_to_component_index(i).first]
== true);
else // not primitive
{
const unsigned int first_nonzero_comp
- = (std::find (fe.get_nonzero_components(i).begin(),
- fe.get_nonzero_components(i).end(),
- true)
- -
- fe.get_nonzero_components(i).begin());
+ = fe.get_nonzero_components(i).first_selected_component();
Assert (first_nonzero_comp < fe.n_components(),
ExcInternalError());
selected_dofs[cell_dof_indices[i]]
- = (component_select[first_nonzero_comp]
+ = (component_mask[first_nonzero_comp]
== true);
}
}
template <class DH>
void
extract_constant_modes (const DH &dof_handler,
- const std::vector<bool> &component_select,
+ const ComponentMask &component_mask,
std::vector<std::vector<bool> > &constant_modes)
{
const unsigned int n_components = dof_handler.get_fe().n_components();
- Assert (n_components == component_select.size(),
+ Assert (n_components == component_mask.size(),
ExcDimensionMismatch(n_components,
- component_select.size()));
+ component_mask.size()));
std::vector<unsigned int> localized_component (n_components,
numbers::invalid_unsigned_int);
unsigned int n_components_selected = 0;
for (unsigned int i=0; i<n_components; ++i)
- if (component_select[i] == true)
+ if (component_mask[i] == true)
localized_component[i] = n_components_selected++;
std::vector<unsigned char> dofs_by_component (dof_handler.n_locally_owned_dofs());
- internal::extract_dofs_by_component (dof_handler, component_select, false,
+ internal::get_component_association (dof_handler, component_mask,
dofs_by_component);
unsigned int n_selected_dofs = 0;
for (unsigned int i=0; i<n_components; ++i)
- if (component_select[i] == true)
+ if (component_mask[i] == true)
n_selected_dofs += std::count (dofs_by_component.begin(),
dofs_by_component.end(), i);
false));
std::vector<unsigned int> component_list (n_components, 0);
for (unsigned int d=0; d<n_components; ++d)
- component_list[d] = component_select[d];
+ component_list[d] = component_mask[d];
unsigned int counter = 0;
for (unsigned int i=0; i<dof_handler.n_locally_owned_dofs(); ++i)
- if (component_select[dofs_by_component[i]])
+ if (component_mask[dofs_by_component[i]])
{
constant_modes[localized_component[dofs_by_component[i]]][counter] = true;
++counter;
get_subdomain_association (dof_handler, subdomain_association);
std::vector<unsigned char> component_association (dof_handler.n_dofs());
- internal::extract_dofs_by_component (dof_handler, std::vector<bool>(), false,
+ internal::get_component_association (dof_handler, std::vector<bool>(),
component_association);
for (unsigned int c=0; c<dof_handler.get_fe().n_components(); ++c)
// of dofs in each component
// separately. do so in parallel
std::vector<unsigned char> dofs_by_component (dof_handler.n_locally_owned_dofs());
- internal::extract_dofs_by_component (dof_handler, std::vector<bool>(), false,
+ internal::get_component_association (dof_handler, ComponentMask(),
dofs_by_component);
// next count what we got
// of dofs in each block
// separately.
std::vector<unsigned char> dofs_by_block (dof_handler.n_locally_owned_dofs());
- internal::extract_dofs_by_component (dof_handler, std::vector<bool>(),
- true, dofs_by_block);
+ internal::get_block_association (dof_handler, dofs_by_block);
// next count what we got
for (unsigned int block=0; block<fe.n_blocks(); ++block)
std::vector<bool> mask (coarse_grid.get_fe().n_components(),
false);
mask[coarse_component] = true;
- extract_dofs (coarse_grid, mask, coarse_dof_is_parameter);
- };
+ extract_dofs (coarse_grid, ComponentMask(mask), coarse_dof_is_parameter);
+ }
// now we know that the weights in
// each row constitute a
void
make_zero_boundary_constraints (const DH<dim, spacedim> &dof,
ConstraintMatrix &zero_boundary_constraints,
- const std::vector<bool> &component_mask_)
+ const ComponentMask &component_mask)
{
- Assert ((component_mask_.size() == 0) ||
- (component_mask_.size() == dof.get_fe().n_components()),
+ Assert (component_mask.represents_n_components(dof.get_fe().n_components()),
ExcMessage ("The number of components in the mask has to be either "
"zero or equal to the number of components in the finite "
"element."));
const unsigned int n_components = DoFTools::n_components (dof);
- // set the component mask to either
- // the original value or a vector
- // of trues
- const std::vector<bool> component_mask ((component_mask_.size() == 0) ?
- std::vector<bool> (n_components, true) :
- component_mask_);
- Assert (std::count(component_mask.begin(), component_mask.end(), true) > 0,
+ Assert (component_mask.n_selected_components(n_components) > 0,
VectorTools::ExcNoComponentSelected());
// a field to store the indices
endc = dof.end();
for (; cell!=endc; ++cell)
if (!cell->is_artificial())
- for (unsigned int face_no = 0; face_no < GeometryInfo<dim>::faces_per_cell;
- ++face_no)
- {
- const FiniteElement<dim,spacedim> &fe = cell->get_fe();
+ for (unsigned int face_no = 0; face_no < GeometryInfo<dim>::faces_per_cell;
+ ++face_no)
+ {
+ const FiniteElement<dim,spacedim> &fe = cell->get_fe();
- typename DH<dim,spacedim>::face_iterator face = cell->face(face_no);
+ typename DH<dim,spacedim>::face_iterator face = cell->face(face_no);
// if face is on the boundary
- if (face->at_boundary ())
- {
- // get indices and physical
- // location on this face
- face_dofs.resize (fe.dofs_per_face);
- face->get_dof_indices (face_dofs, cell->active_fe_index());
-
- // enter those dofs into the list
- // that match the component
- // signature.
- for (unsigned int i=0; i<face_dofs.size(); ++i)
- {
- // Find out if a dof
- // has a contribution
- // in this component,
- // and if so, add it
- // to the list
- const std::vector<bool> &nonzero_component_array
- = cell->get_fe().get_nonzero_components (i);
- bool nonzero = false;
- for (unsigned int c=0; c<n_components; ++c)
- if (nonzero_component_array[c] && component_mask[c])
- {
- nonzero = true;
- break;
- }
-
- if (nonzero)
- zero_boundary_constraints.add_line (face_dofs[i]);
- }
- }
- }
+ if (face->at_boundary ())
+ {
+ // get indices and physical
+ // location on this face
+ face_dofs.resize (fe.dofs_per_face);
+ face->get_dof_indices (face_dofs, cell->active_fe_index());
+
+ // enter those dofs into the list
+ // that match the component
+ // signature.
+ for (unsigned int i=0; i<face_dofs.size(); ++i)
+ {
+ // Find out if a dof
+ // has a contribution
+ // in this component,
+ // and if so, add it
+ // to the list
+ const ComponentMask &nonzero_component_array
+ = cell->get_fe().get_nonzero_components (i);
+ bool nonzero = false;
+ for (unsigned int c=0; c<n_components; ++c)
+ if (nonzero_component_array[c] && component_mask[c])
+ {
+ nonzero = true;
+ break;
+ }
+
+ if (nonzero)
+ zero_boundary_constraints.add_line (face_dofs[i]);
+ }
+ }
+ }
}
template <class DH, class Sparsity>
DoFTools::make_periodicity_constraints (const DH::face_iterator &,
const DH::face_iterator &,
dealii::ConstraintMatrix &,
- const std::vector<bool> &);
+ const ComponentMask &);
template
void
const types::boundary_id,
const int,
dealii::ConstraintMatrix &,
- const std::vector<bool> &);
+ const ComponentMask &);
template
void
const int,
dealii::Tensor<1,DH::space_dimension> &,
dealii::ConstraintMatrix &,
- const std::vector<bool> &);
+ const ComponentMask &);
#endif
}
template void DoFTools::extract_dofs<deal_II_dimension>
(const DoFHandler<deal_II_dimension>&,
- const std::vector<bool>&, std::vector<bool>&, bool);
+ const ComponentMask &,
+ std::vector<bool>&);
+
+template void DoFTools::extract_dofs<deal_II_dimension>
+(const DoFHandler<deal_II_dimension>&,
+ const BlockMask &,
+ std::vector<bool>&);
+
+template void DoFTools::extract_dofs<deal_II_dimension>
+(const hp::DoFHandler<deal_II_dimension>&,
+ const ComponentMask &,
+ std::vector<bool>&);
template void DoFTools::extract_dofs<deal_II_dimension>
(const hp::DoFHandler<deal_II_dimension>&,
- const std::vector<bool>&, std::vector<bool>&, bool);
+ const BlockMask &,
+ std::vector<bool>&);
+
+template void DoFTools::extract_level_dofs<deal_II_dimension>
+(const unsigned int level,
+ const MGDoFHandler<deal_II_dimension>&,
+ const ComponentMask &,
+ std::vector<bool>&);
template void DoFTools::extract_level_dofs<deal_II_dimension>
-(const unsigned int level, const MGDoFHandler<deal_II_dimension>&,
- const std::vector<bool>&, std::vector<bool>&, bool);
+(const unsigned int level,
+ const MGDoFHandler<deal_II_dimension>&,
+ const BlockMask &,
+ std::vector<bool>&);
template
void
DoFTools::extract_boundary_dofs<DoFHandler<deal_II_dimension> >
(const DoFHandler<deal_II_dimension> &,
- const std::vector<bool> &,
+ const ComponentMask &,
std::vector<bool> &,
const std::set<types::boundary_id> &);
template
void
DoFTools::extract_boundary_dofs<hp::DoFHandler<deal_II_dimension> >
(const hp::DoFHandler<deal_II_dimension> &,
- const std::vector<bool> &,
+ const ComponentMask &,
std::vector<bool> &,
const std::set<types::boundary_id> &);
void
DoFTools::extract_dofs_with_support_on_boundary<DoFHandler<deal_II_dimension> >
(const DoFHandler<deal_II_dimension> &,
- const std::vector<bool> &,
+ const ComponentMask &,
std::vector<bool> &,
const std::set<types::boundary_id> &);
template
void
DoFTools::extract_dofs_with_support_on_boundary<hp::DoFHandler<deal_II_dimension> >
(const hp::DoFHandler<deal_II_dimension> &,
- const std::vector<bool> &,
+ const ComponentMask &,
std::vector<bool> &,
const std::set<types::boundary_id> &);
void
DoFTools::extract_constant_modes<DoFHandler<deal_II_dimension> >
(const DoFHandler<deal_II_dimension> &dof_handler,
- const std::vector<bool> &selected_components,
+ const ComponentMask &selected_components,
std::vector<std::vector<bool> > &constant_modes);
template
void
DoFTools::extract_constant_modes<hp::DoFHandler<deal_II_dimension> >
(const hp::DoFHandler<deal_II_dimension> &dof_handler,
- const std::vector<bool> &selected_components,
+ const ComponentMask &selected_components,
std::vector<std::vector<bool> > &constant_modes);
template
void
DoFTools::extract_boundary_dofs<DoFHandler<deal_II_dimension,deal_II_dimension+1> >
(const DoFHandler<deal_II_dimension,deal_II_dimension+1> &,
- const std::vector<bool> &,
+ const ComponentMask &,
std::vector<bool> &,
const std::set<types::boundary_id> &);
template
void
DoFTools::extract_boundary_dofs<DoFHandler<1,3> >
(const DoFHandler<1,3> &,
- const std::vector<bool> &,
+ const ComponentMask &,
std::vector<bool> &,
const std::set<types::boundary_id> &);
template
void
DoFTools::extract_level_dofs<deal_II_dimension, deal_II_dimension+1>
-(const unsigned int level, const MGDoFHandler<deal_II_dimension, deal_II_dimension+1>&,
- const std::vector<bool>&, std::vector<bool>&, bool);
+(const unsigned int level,
+ const MGDoFHandler<deal_II_dimension, deal_II_dimension+1>&,
+ const ComponentMask&,
+ std::vector<bool>&);
+
+template
+void
+DoFTools::extract_level_dofs<deal_II_dimension, deal_II_dimension+1>
+(const unsigned int level,
+ const MGDoFHandler<deal_II_dimension, deal_II_dimension+1>&,
+ const BlockMask&,
+ std::vector<bool>&);
#endif
template
void
DoFTools::extract_level_dofs<1,3>
-(const unsigned int level, const MGDoFHandler<1,3>&,
- const std::vector<bool>&, std::vector<bool>&, bool);
+(const unsigned int level,
+ const MGDoFHandler<1,3>&,
+ const ComponentMask &,
+ std::vector<bool>&);
+
+template
+void
+DoFTools::extract_level_dofs<1,3>
+(const unsigned int level,
+ const MGDoFHandler<1,3>&,
+ const BlockMask &,
+ std::vector<bool>&);
#endif
DoFTools::make_zero_boundary_constraints
(const DoFHandler<deal_II_dimension> &,
ConstraintMatrix &,
- const std::vector<bool> &);
+ const ComponentMask &);
template
void
DoFTools::make_zero_boundary_constraints
(const hp::DoFHandler<deal_II_dimension> &,
ConstraintMatrix &,
- const std::vector<bool> &);
+ const ComponentMask &);
#if deal_II_dimension < 3
--- /dev/null
+//---------------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//---------------------------------------------------------------------------
+
+#include <deal.II/fe/block_mask.h>
+
+#include <iostream>
+
+
+DEAL_II_NAMESPACE_OPEN
+
+std::ostream & operator << (std::ostream &out,
+ const BlockMask &mask)
+{
+ if (mask.block_mask.size() == 0)
+ out << "[all blocks selected]";
+ else
+ {
+ out << '[';
+ for (unsigned int i=0; i<mask.block_mask.size(); ++i)
+ {
+ out << (mask.block_mask[i] ? "true" : "false");
+ if (i != mask.block_mask.size()-1)
+ out << ',';
+ }
+ out << ']';
+ }
+
+ return out;
+}
+
+
+
+std::size_t
+BlockMask::memory_consumption () const
+{
+ return sizeof(*this) + MemoryConsumption::memory_consumption (block_mask);
+}
+
+
+DEAL_II_NAMESPACE_CLOSE
--- /dev/null
+//---------------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//---------------------------------------------------------------------------
+
+#include <deal.II/fe/component_mask.h>
+
+#include <iostream>
+
+
+DEAL_II_NAMESPACE_OPEN
+
+std::ostream & operator << (std::ostream &out,
+ const ComponentMask &mask)
+{
+ if (mask.component_mask.size() == 0)
+ out << "[all components selected]";
+ else
+ {
+ out << '[';
+ for (unsigned int i=0; i<mask.component_mask.size(); ++i)
+ {
+ out << (mask.component_mask[i] ? "true" : "false");
+ if (i != mask.component_mask.size()-1)
+ out << ',';
+ }
+ out << ']';
+ }
+
+ return out;
+}
+
+
+
+std::size_t
+ComponentMask::memory_consumption () const
+{
+ return sizeof(*this) + MemoryConsumption::memory_consumption (component_mask);
+}
+
+
+DEAL_II_NAMESPACE_CLOSE
FiniteElement<dim,spacedim>::FiniteElement (
const FiniteElementData<dim> &fe_data,
const std::vector<bool> &r_i_a_f,
- const std::vector<std::vector<bool> > &nonzero_c)
+ const std::vector<ComponentMask> &nonzero_c)
:
FiniteElementData<dim> (fe_data),
adjust_quad_dof_index_for_face_orientation_table (dim == 3 ?
if (nonzero_components.size() == 1 && ndofs > 1)
{
- std::vector<std::vector<bool> >& aux
- = const_cast<std::vector<std::vector<bool> >&> (nonzero_components);
+ std::vector<ComponentMask>& aux
+ = const_cast<std::vector<ComponentMask>&> (nonzero_components);
aux.resize(ndofs, nonzero_components[0]);
}
{
Assert (nonzero_components[i].size() == this->n_components(),
ExcInternalError());
- Assert (std::count (nonzero_components[i].begin(),
- nonzero_components[i].end(),
- true)
+ Assert (nonzero_components[i].n_selected_components ()
>= 1,
ExcInternalError());
Assert (n_nonzero_components_table[i] >= 1,
}
+template <int dim, int spacedim>
+ComponentMask
+FiniteElement<dim,spacedim>::
+component_mask (const FEValuesExtractors::Scalar &scalar) const
+{
+ AssertIndexRange(scalar.component, this->n_components());
+
+//TODO: it would be nice to verify that it is indeed possible
+// to select this scalar component, i.e., that it is not part
+// of a non-primitive element. unfortunately, there is no simple
+// way to write such a condition...
+
+ std::vector<bool> mask (this->n_components(), false);
+ mask[scalar.component] = true;
+ return mask;
+}
+
+
+template <int dim, int spacedim>
+ComponentMask
+FiniteElement<dim,spacedim>::
+component_mask (const FEValuesExtractors::Vector &vector) const
+{
+ AssertIndexRange(vector.first_vector_component+dim-1, this->n_components());
+
+ //TODO: it would be nice to verify that it is indeed possible
+ // to select these vector components, i.e., that they don't span
+ // beyond the beginning or end of anon-primitive element.
+ // unfortunately, there is no simple way to write such a condition...
+
+ std::vector<bool> mask (this->n_components(), false);
+ for (unsigned int c=vector.first_vector_component; c<vector.first_vector_component+dim; ++c)
+ mask[c] = true;
+ return mask;
+}
+
+
+template <int dim, int spacedim>
+ComponentMask
+FiniteElement<dim,spacedim>::
+component_mask (const FEValuesExtractors::SymmetricTensor<2> &sym_tensor) const
+{
+ AssertIndexRange((sym_tensor.first_tensor_component +
+ SymmetricTensor<2,dim>::n_independent_components-1),
+ this->n_components());
+
+ //TODO: it would be nice to verify that it is indeed possible
+ // to select these vector components, i.e., that they don't span
+ // beyond the beginning or end of anon-primitive element.
+ // unfortunately, there is no simple way to write such a condition...
+
+ std::vector<bool> mask (this->n_components(), false);
+ for (unsigned int c=sym_tensor.first_tensor_component;
+ c<sym_tensor.first_tensor_component+SymmetricTensor<2,dim>::n_independent_components; ++c)
+ mask[c] = true;
+ return mask;
+}
+
+
+
+template <int dim, int spacedim>
+ComponentMask
+FiniteElement<dim,spacedim>::
+component_mask (const BlockMask &block_mask) const
+{
+ // if we get a block mask that represents all blocks, then
+ // do the same for the returned component mask
+ if (block_mask.represents_the_all_selected_mask())
+ return ComponentMask();
+
+ AssertDimension(block_mask.size(), this->n_blocks());
+
+ std::vector<bool> component_mask (this->n_components(), false);
+ for (unsigned int c=0; c<this->n_components(); ++c)
+ if (block_mask[component_to_block_index(c)] == true)
+ component_mask[c] = true;
+
+ return component_mask;
+}
+
+
+
+template <int dim, int spacedim>
+BlockMask
+FiniteElement<dim,spacedim>::
+block_mask (const FEValuesExtractors::Scalar &scalar) const
+{
+ // simply create the corresponding component mask (a simpler
+ // process) and then convert it to a block mask
+ return block_mask(component_mask(scalar));
+}
+
+
+template <int dim, int spacedim>
+BlockMask
+FiniteElement<dim,spacedim>::
+block_mask (const FEValuesExtractors::Vector &vector) const
+{
+ // simply create the corresponding component mask (a simpler
+ // process) and then convert it to a block mask
+ return block_mask(component_mask(vector));
+}
+
+
+template <int dim, int spacedim>
+BlockMask
+FiniteElement<dim,spacedim>::
+block_mask (const FEValuesExtractors::SymmetricTensor<2> &sym_tensor) const
+{
+ // simply create the corresponding component mask (a simpler
+ // process) and then convert it to a block mask
+ return block_mask(component_mask(sym_tensor));
+}
+
+
+
+template <int dim, int spacedim>
+BlockMask
+FiniteElement<dim,spacedim>::
+block_mask (const ComponentMask &component_mask) const
+{
+ // if we get a component mask that represents all component, then
+ // do the same for the returned block mask
+ if (component_mask.represents_the_all_selected_mask())
+ return BlockMask();
+
+ AssertDimension(component_mask.size(), this->n_components());
+
+ // walk over all of the components
+ // of this finite element and see
+ // if we need to set the
+ // corresponding block. inside the
+ // block, walk over all the
+ // components that correspond to
+ // this block and make sure the
+ // component mask is set for all of
+ // them
+ std::vector<bool> block_mask (this->n_blocks(), false);
+ for (unsigned int c=0; c<this->n_components();)
+ {
+ const unsigned int block = component_to_block_index(c);
+ if (component_mask[c] == true)
+ block_mask[block] = true;
+
+ // now check all of the other
+ // components that correspond
+ // to this block
+ ++c;
+ while ((c<this->n_components())
+ &&
+ (component_to_block_index(c) == block))
+ {
+ Assert (component_mask[c] == block_mask[block],
+ ExcMessage ("The component mask argument given to this function "
+ "is not a mask where the individual components belonging "
+ "to one block of the finite element are either all "
+ "selected or not selected. You can't call this function "
+ "with a component mask that splits blocks."));
+ ++c;
+ }
+ }
+
+
+ return block_mask;
+}
+
+
+
template <int dim, int spacedim>
unsigned int
FiniteElement<dim,spacedim>::adjust_quad_dof_index_for_face_orientation (const unsigned int index,
template <int dim, int spacedim>
std::vector<unsigned int>
FiniteElement<dim,spacedim>::compute_n_nonzero_components (
- const std::vector<std::vector<bool> > &nonzero_components)
+ const std::vector<ComponentMask> &nonzero_components)
{
std::vector<unsigned int> retval (nonzero_components.size());
for (unsigned int i=0; i<nonzero_components.size(); ++i)
- retval[i] = std::count (nonzero_components[i].begin(),
- nonzero_components[i].end(),
- true);
+ retval[i] = nonzero_components[i].n_selected_components();
return retval;
}
FiniteElementData<dim>(get_dpo_vector(deg),
dim, deg+1, FiniteElementData<dim>::Hdiv, 1),
std::vector<bool>(PolynomialsABF<dim>::compute_n_pols(deg), true),
- std::vector<std::vector<bool> >(PolynomialsABF<dim>::compute_n_pols(deg),
- std::vector<bool>(dim,true))),
+ std::vector<ComponentMask>(PolynomialsABF<dim>::compute_n_pols(deg),
+ std::vector<bool>(dim,true))),
rt_order(deg)
{
Assert (dim >= 2, ExcImpossibleInDim(dim));
FiniteElementData<dim>(get_dpo_vector(deg),
dim, deg+1, FiniteElementData<dim>::Hdiv, 1),
get_ria_vector (deg),
- std::vector<std::vector<bool> >(PolynomialsBDM<dim>::compute_n_pols(deg),
- std::vector<bool>(dim,true)))
+ std::vector<ComponentMask>(PolynomialsBDM<dim>::compute_n_pols(deg),
+ std::vector<bool>(dim,true)))
{
Assert (dim >= 2, ExcImpossibleInDim(dim));
Assert (dim<3, ExcNotImplemented());
PolynomialSpace<dim>(Polynomials::Legendre::generate_complete_basis(degree)),
FiniteElementData<dim>(get_dpo_vector(degree), 1, degree, FiniteElementData<dim>::L2),
std::vector<bool>(FiniteElementData<dim>(get_dpo_vector(degree), 1, degree).dofs_per_cell,true),
- std::vector<std::vector<bool> >(FiniteElementData<dim>(
+ std::vector<ComponentMask>(FiniteElementData<dim>(
get_dpo_vector(degree), 1, degree).dofs_per_cell, std::vector<bool>(1,true)))
{
// Reinit the vectors of
PolynomialsP<dim>(degree),
FiniteElementData<dim>(get_dpo_vector(degree), 1, degree, FiniteElementData<dim>::L2),
std::vector<bool>(FiniteElementData<dim>(get_dpo_vector(degree), 1, degree).dofs_per_cell,true),
- std::vector<std::vector<bool> >(FiniteElementData<dim>(
+ std::vector<ComponentMask>(FiniteElementData<dim>(
get_dpo_vector(degree), 1, degree).dofs_per_cell, std::vector<bool>(1,true)))
{
Assert(this->poly_space.n()==this->dofs_per_cell, ExcInternalError());
FiniteElementData<dim>::L2),
std::vector<bool>(
FiniteElementData<dim>(get_dpo_vector(degree), 1, degree).dofs_per_cell,true),
- std::vector<std::vector<bool> >(
+ std::vector<ComponentMask>(
FiniteElementData<dim>(get_dpo_vector(degree),1, degree).dofs_per_cell,
std::vector<bool>(1,true))),
degree(degree),
TensorProductPolynomials<dim>(Polynomials::LagrangeEquidistant::generate_complete_basis(degree)),
FiniteElementData<dim>(get_dpo_vector(degree), 1, degree, FiniteElementData<dim>::L2),
std::vector<bool>(FiniteElementData<dim>(get_dpo_vector(degree),1, degree).dofs_per_cell, true),
- std::vector<std::vector<bool> >(FiniteElementData<dim>(
+ std::vector<ComponentMask>(FiniteElementData<dim>(
get_dpo_vector(degree),1, degree).dofs_per_cell, std::vector<bool>(1,true)))
{
// Reinit the vectors of
TensorProductPolynomials<dim>(Polynomials::generate_complete_Lagrange_basis(points.get_points())),
FiniteElementData<dim>(get_dpo_vector(points.size()-1), 1, points.size()-1, FiniteElementData<dim>::L2),
std::vector<bool>(FiniteElementData<dim>(get_dpo_vector(points.size()-1),1, points.size()-1).dofs_per_cell, true),
- std::vector<std::vector<bool> >(FiniteElementData<dim>(
+ std::vector<ComponentMask>(FiniteElementData<dim>(
get_dpo_vector(points.size()-1),1, points.size()-1).dofs_per_cell, std::vector<bool>(1,true)))
{
// Reinit the vectors of
FiniteElementData<dim> (get_dpo_vector (p), dim, p + 1,
FiniteElementData<dim>::Hcurl, 1),
std::vector<bool> (PolynomialsNedelec<dim>::compute_n_pols (p), true),
- std::vector<std::vector<bool> >
+ std::vector<ComponentMask>
(PolynomialsNedelec<dim>::compute_n_pols (p),
std::vector<bool> (dim, true)))
{
n_components, 0,
FiniteElementData<dim>::unknown),
std::vector<bool>(),
- std::vector<std::vector<bool> >() )
+ std::vector<ComponentMask>() )
{
// in most other elements we have to set up all sorts of stuff
// here. there isn't much that we have to do here; in particular,
FE_PolyTensor<POLY,dim,spacedim>::FE_PolyTensor (const unsigned int degree,
const FiniteElementData<dim> &fe_data,
const std::vector<bool> &restriction_is_additive_flags,
- const std::vector<std::vector<bool> > &nonzero_components)
+ const std::vector<ComponentMask> &nonzero_components)
:
FiniteElement<dim,spacedim> (fe_data,
restriction_is_additive_flags,
for (unsigned int i=0; i<this->dofs_per_cell; ++i)
{
- const unsigned int first = data.shape_function_to_row_table[i];
+ const unsigned int first = data.shape_function_to_row_table[i * this->n_components() +
+ this->get_nonzero_components(i).first_selected_component()];
if (flags & update_values && cell_similarity != CellSimilarity::translation)
switch (mapping_type)
for (unsigned int i=0; i<this->dofs_per_cell; ++i)
{
- const unsigned int first = data.shape_function_to_row_table[i];
+ const unsigned int first = data.shape_function_to_row_table[i * this->n_components() +
+ this->get_nonzero_components(i).first_selected_component()];
if (flags & update_values)
{
for (unsigned int i=0; i<this->dofs_per_cell; ++i)
{
- const unsigned int first = data.shape_function_to_row_table[i];
+ const unsigned int first = data.shape_function_to_row_table[i * this->n_components() +
+ this->get_nonzero_components(i).first_selected_component()];
if (flags & update_values)
{
1, degree,
FiniteElementData<dim>::H1),
std::vector<bool> (1, false),
- std::vector<std::vector<bool> >(1, std::vector<bool>(1,true))),
+ std::vector<ComponentMask>(1, std::vector<bool>(1,true))),
face_index_map(FE_Q_Helper::invert_numbering(face_lexicographic_to_hierarchic_numbering (degree)))
{
Assert (degree > 0,
1, points.size()-1,
FiniteElementData<dim>::H1),
std::vector<bool> (1, false),
- std::vector<std::vector<bool> >(1, std::vector<bool>(1,true))),
+ std::vector<ComponentMask>(1, std::vector<bool>(1,true))),
face_index_map(FE_Q_Helper::invert_numbering(face_lexicographic_to_hierarchic_numbering (points.size()-1)))
{
const int degree = points.size()-1;
FiniteElementData<dim>::H1),
std::vector<bool> (FiniteElementData<dim>(
get_dpo_vector(degree),1, degree).dofs_per_cell, false),
- std::vector<std::vector<bool> >(FiniteElementData<dim>(
+ std::vector<ComponentMask>(FiniteElementData<dim>(
get_dpo_vector(degree),1, degree).dofs_per_cell, std::vector<bool>(1,true))),
face_renumber(face_fe_q_hierarchical_to_hierarchic_numbering (degree))
{
FiniteElementData<dim>(get_dpo_vector(deg),
dim, deg+1, FiniteElementData<dim>::Hdiv, 1),
std::vector<bool>(PolynomialsRaviartThomas<dim>::compute_n_pols(deg), true),
- std::vector<std::vector<bool> >(PolynomialsRaviartThomas<dim>::compute_n_pols(deg),
- std::vector<bool>(dim,true)))
+ std::vector<ComponentMask>(PolynomialsRaviartThomas<dim>::compute_n_pols(deg),
+ std::vector<bool>(dim,true)))
{
Assert (dim >= 2, ExcImpossibleInDim(dim));
const unsigned int n_dofs = this->dofs_per_cell;
FiniteElementData<dim>(get_dpo_vector(deg),
dim, deg+1, FiniteElementData<dim>::Hdiv, 1),
get_ria_vector (deg),
- std::vector<std::vector<bool> >(PolynomialsRaviartThomas<dim>::compute_n_pols(deg),
- std::vector<bool>(dim,true)))
+ std::vector<ComponentMask>(PolynomialsRaviartThomas<dim>::compute_n_pols(deg),
+ std::vector<bool>(dim,true)))
{
Assert (dim >= 2, ExcImpossibleInDim(dim));
const unsigned int n_dofs = this->dofs_per_cell;
template <int dim, int spacedim>
-std::vector<std::vector<bool> >
+std::vector<ComponentMask>
FESystem<dim,spacedim>::compute_nonzero_components (const FiniteElement<dim,spacedim> &fe1,
const unsigned int N1)
{
template <int dim, int spacedim>
-std::vector<std::vector<bool> >
+std::vector<ComponentMask>
FESystem<dim,spacedim>::compute_nonzero_components (const FiniteElement<dim,spacedim> &fe1,
const unsigned int N1,
const FiniteElement<dim,spacedim> &fe2,
template <int dim, int spacedim>
-std::vector<std::vector<bool> >
+std::vector<ComponentMask>
FESystem<dim,spacedim>::compute_nonzero_components (const FiniteElement<dim,spacedim> &fe1,
const unsigned int N1,
const FiniteElement<dim,spacedim> &fe2,
template <int dim, int spacedim>
-std::vector<std::vector<bool> >
+std::vector<ComponentMask>
FESystem<dim,spacedim>::compute_nonzero_components (const FiniteElement<dim,spacedim> &fe1,
const unsigned int N1,
const FiniteElement<dim,spacedim> &fe2,
template <int dim, int spacedim>
-std::vector<std::vector<bool> >
+std::vector<ComponentMask>
FESystem<dim,spacedim>::compute_nonzero_components (const FiniteElement<dim,spacedim> &fe1,
const unsigned int N1,
const FiniteElement<dim,spacedim> &fe2,
template <int dim, int spacedim>
-std::vector<std::vector<bool> >
+std::vector<ComponentMask>
FESystem<dim,spacedim>::
compute_nonzero_components (const std::vector<const FiniteElement<dim,spacedim>*> &fes,
const std::vector<unsigned int> &multiplicities)
Assert (total_index == n_shape_functions, ExcInternalError());
- return retval;
+ // now copy the vector<vector<bool> > into a vector<ComponentMask>.
+ // this appears complicated but we do it this way since it's just
+ // awkward to generate ComponentMasks directly and so we need the
+ // recourse of the inner vector<bool> anyway.
+ std::vector<ComponentMask> xretval (retval.size());
+ for (unsigned int i=0; i<retval.size(); ++i)
+ xretval[i] = ComponentMask(retval[i]);
+ return xretval;
}
std::vector<unsigned int>
make_shape_function_to_row_table (const FiniteElement<dim,spacedim> &fe)
{
- std::vector<unsigned int> shape_function_to_row_table (fe.dofs_per_cell);
+ std::vector<unsigned int> shape_function_to_row_table (fe.dofs_per_cell * fe.n_components(),
+ numbers::invalid_unsigned_int);
unsigned int row = 0;
for (unsigned int i=0; i<fe.dofs_per_cell; ++i)
{
- shape_function_to_row_table[i] = row;
+ // loop over all components that are nonzero for this particular
+ // shape function. if a component is zero then we leave the
+ // value in the table unchanged (at the invalid value)
+ // otherwise it is mapped to the next free entry
+ unsigned int nth_nonzero_component = 0;
+ for (unsigned int c=0; c<fe.n_components(); ++c)
+ if (fe.get_nonzero_components(i)[c] == true)
+ {
+ shape_function_to_row_table[i*fe.n_components()+c] = row + nth_nonzero_component;
+ ++nth_nonzero_component;
+ }
row += fe.n_nonzero_components (i);
}
Assert (component < fe_values.fe->n_components(),
ExcIndexRange(component, 0, fe_values.fe->n_components()));
+//TODO: we'd like to use the fields with the same name as these
+// variables from FEValuesData, but they aren't initialized yet
+// at the time we get here, so re-create it all
const std::vector<unsigned int> shape_function_to_row_table
- = make_shape_function_to_row_table (*fe_values.fe);
+ = make_shape_function_to_row_table (*fe_values.fe);
for (unsigned int i=0; i<fe_values.fe->dofs_per_cell; ++i)
{
== true);
if (shape_function_data[i].is_nonzero_shape_function_component == true)
- {
- if (is_primitive == true)
- shape_function_data[i].row_index = shape_function_to_row_table[i];
- else
- shape_function_data[i].row_index
- = (shape_function_to_row_table[i]
- +
- std::count (fe_values.fe->get_nonzero_components(i).begin(),
- fe_values.fe->get_nonzero_components(i).begin()+
- component,
- true));
- }
+ shape_function_data[i].row_index
+ = shape_function_to_row_table[i*fe_values.fe->n_components()+component];
else
shape_function_data[i].row_index = numbers::invalid_unsigned_int;
}
ExcIndexRange(first_vector_component+spacedim-1, 0,
fe_values.fe->n_components()));
+//TODO: we'd like to use the fields with the same name as these
+// variables from FEValuesData, but they aren't initialized yet
+// at the time we get here, so re-create it all
const std::vector<unsigned int> shape_function_to_row_table
- = make_shape_function_to_row_table (*fe_values.fe);
+ = make_shape_function_to_row_table (*fe_values.fe);
for (unsigned int d=0; d<spacedim; ++d)
{
if (shape_function_data[i].is_nonzero_shape_function_component[d]
== true)
- {
- if (is_primitive == true)
- shape_function_data[i].row_index[d]
- = shape_function_to_row_table[i];
- else
- shape_function_data[i].row_index[d]
- = (shape_function_to_row_table[i]
- +
- std::count (fe_values.fe->get_nonzero_components(i).begin(),
- fe_values.fe->get_nonzero_components(i).begin()+
- component,
- true));
- }
+ shape_function_data[i].row_index[d]
+ = shape_function_to_row_table[i*fe_values.fe->n_components()+component];
else
shape_function_data[i].row_index[d]
= numbers::invalid_unsigned_int;
dealii::SymmetricTensor<2,dim>::n_independent_components - 1,
0,
fe_values.fe->n_components()));
-
+//TODO: we'd like to use the fields with the same name as these
+// variables from FEValuesData, but they aren't initialized yet
+// at the time we get here, so re-create it all
const std::vector<unsigned int> shape_function_to_row_table
- = make_shape_function_to_row_table(*fe_values.fe);
+ = make_shape_function_to_row_table (*fe_values.fe);
for (unsigned int d = 0; d < dealii::SymmetricTensor<2,dim>::n_independent_components; ++d)
{
if (shape_function_data[i].is_nonzero_shape_function_component[d]
== true)
- {
- if (is_primitive == true)
- shape_function_data[i].row_index[d]
- = shape_function_to_row_table[i];
- else
- shape_function_data[i].row_index[d]
- = (shape_function_to_row_table[i]
- +
- std::count(fe_values.fe->get_nonzero_components(i).begin(),
- fe_values.fe->get_nonzero_components(i).begin() +
- component,
- true));
- }
+ shape_function_data[i].row_index[d]
+ = shape_function_to_row_table[i*fe_values.fe->n_components()+component];
else
shape_function_data[i].row_index[d]
= numbers::invalid_unsigned_int;
// initialize the table mapping
// from shape function number to
- // the rows in the tables denoting
- // its first non-zero
- // component
+ // the rows in the tables storing
+ // the data by shape function and
+ // nonzero component
this->shape_function_to_row_table
= make_shape_function_to_row_table (fe);
if (fe->is_primitive(shape_func))
{
- // compared to the scalar
- // functions, finding the correct
- // index in the shape_value table
- // is more involved, since we have
- // to find the row in shape_values
- // that corresponds to the present
- // shape_func. this is done
- // manually in the same way as in
- // shape_value_component() (that
- // function can't be used because
- // it doesn't return us a pointer
- // to the data).
+ const unsigned int comp = fe->system_to_component_index(shape_func).first;
const unsigned int
- row = fe->is_primitive() ?
- shape_func : this->shape_function_to_row_table[shape_func];
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + comp];
const double *shape_value_ptr = &this->shape_values(row, 0);
- const unsigned int comp = fe->system_to_component_index(shape_func).first;
for (unsigned int point=0; point<n_quadrature_points; ++point)
values[point](comp) += value * *shape_value_ptr++;
}
continue;
const unsigned int
- row = (this->shape_function_to_row_table[shape_func]
- +
- std::count (fe->get_nonzero_components(shape_func).begin(),
- fe->get_nonzero_components(shape_func).begin()+c,
- true));
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + c];
const double *shape_value_ptr = &this->shape_values(row, 0);
if (fe->is_primitive(shape_func))
{
- const unsigned int
- row = fe->is_primitive() ?
- shape_func : this->shape_function_to_row_table[shape_func];
-
- const double *shape_value_ptr = &this->shape_values(row, 0);
const unsigned int comp = fe->system_to_component_index(shape_func).first
+ mc * n_components;
+ const unsigned int
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + comp];
+
+ const double *shape_value_ptr = &this->shape_values(row, 0);
for (unsigned int point=0; point<n_quadrature_points; ++point)
values[point](comp) += value * *shape_value_ptr++;
}
continue;
const unsigned int
- row = (this->shape_function_to_row_table[shape_func]
- +
- std::count (fe->get_nonzero_components(shape_func).begin(),
- fe->get_nonzero_components(shape_func).begin()+c,
- true));
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + c];
const double *shape_value_ptr = &this->shape_values(row, 0);
const unsigned int comp = c + mc * n_components;
if (fe->is_primitive(shape_func))
{
- const unsigned int
- row = fe->is_primitive() ?
- shape_func : this->shape_function_to_row_table[shape_func];
-
- const double *shape_value_ptr = &this->shape_values(row, 0);
const unsigned int comp = fe->system_to_component_index(shape_func).first
+ mc * n_components;
+ const unsigned int
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + comp];
+
+ const double *shape_value_ptr = &this->shape_values(row, 0);
if (quadrature_points_fastest)
for (unsigned int point=0; point<n_quadrature_points; ++point)
continue;
const unsigned int
- row = (this->shape_function_to_row_table[shape_func]
- +
- std::count (fe->get_nonzero_components(shape_func).begin(),
- fe->get_nonzero_components(shape_func).begin()+c,
- true));
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + c];
const double *shape_value_ptr = &this->shape_values(row, 0);
const unsigned int comp = c + mc * n_components;
if (fe->is_primitive(shape_func))
{
- const unsigned int
- row = fe->is_primitive() ?
- shape_func : this->shape_function_to_row_table[shape_func];
+ const unsigned int comp = fe->system_to_component_index(shape_func).first;
+ const unsigned int
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + comp];
+
const Tensor<1,spacedim> *shape_gradient_ptr
= &this->shape_gradients[row][0];
- const unsigned int comp = fe->system_to_component_index(shape_func).first;
for (unsigned int point=0; point<n_quadrature_points; ++point)
gradients[point][comp] += value * *shape_gradient_ptr++;
}
continue;
const unsigned int
- row = (this->shape_function_to_row_table[shape_func]
- +
- std::count (fe->get_nonzero_components(shape_func).begin(),
- fe->get_nonzero_components(shape_func).begin()+c,
- true));
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + c];
const Tensor<1,spacedim> *shape_gradient_ptr
= &this->shape_gradients[row][0];
if (fe->is_primitive(shape_func))
{
- const unsigned int
- row = fe->is_primitive() ?
- shape_func : this->shape_function_to_row_table[shape_func];
- const Tensor<1,spacedim> *shape_gradient_ptr
- = &this->shape_gradients[row][0];
const unsigned int comp = fe->system_to_component_index(shape_func).first
+ mc * n_components;
+ const unsigned int
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + comp];
+
+ const Tensor<1,spacedim> *shape_gradient_ptr
+ = &this->shape_gradients[row][0];
if (quadrature_points_fastest)
for (unsigned int point=0; point<n_quadrature_points; ++point)
continue;
const unsigned int
- row = (this->shape_function_to_row_table[shape_func]
- +
- std::count (fe->get_nonzero_components(shape_func).begin(),
- fe->get_nonzero_components(shape_func).begin()+c,
- true));
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + c];
const Tensor<1,spacedim> *shape_gradient_ptr
= &this->shape_gradients[row][0];
if (fe->is_primitive(shape_func))
{
- const unsigned int
- row = fe->is_primitive() ?
- shape_func : this->shape_function_to_row_table[shape_func];
+ const unsigned int comp = fe->system_to_component_index(shape_func).first;
+ const unsigned int
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + comp];
const Tensor<2,spacedim> *shape_hessian_ptr
= &this->shape_hessians[row][0];
- const unsigned int comp = fe->system_to_component_index(shape_func).first;
if (quadrature_points_fastest)
for (unsigned int point=0; point<n_quadrature_points; ++point)
continue;
const unsigned int
- row = (this->shape_function_to_row_table[shape_func]
- +
- std::count (fe->get_nonzero_components(shape_func).begin(),
- fe->get_nonzero_components(shape_func).begin()+c,
- true));
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + c];
const Tensor<2,spacedim> *shape_hessian_ptr
= &this->shape_hessians[row][0];
if (fe->is_primitive(shape_func))
{
- const unsigned int
- row = fe->is_primitive() ?
- shape_func : this->shape_function_to_row_table[shape_func];
+ const unsigned int comp = fe->system_to_component_index(shape_func).first
+ + mc * n_components;
+ const unsigned int
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + comp];
const Tensor<2,spacedim> *shape_hessian_ptr
= &this->shape_hessians[row][0];
- const unsigned int comp = fe->system_to_component_index(shape_func).first
- + mc * n_components;
if (quadrature_points_fastest)
for (unsigned int point=0; point<n_quadrature_points; ++point)
continue;
const unsigned int
- row = (this->shape_function_to_row_table[shape_func]
- +
- std::count (fe->get_nonzero_components(shape_func).begin(),
- fe->get_nonzero_components(shape_func).begin()+c,
- true));
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + c];
const Tensor<2,spacedim> *shape_hessian_ptr
= &this->shape_hessians[row][0];
if (fe->is_primitive(shape_func))
{
- const unsigned int
- row = fe->is_primitive() ?
- shape_func : this->shape_function_to_row_table[shape_func];
+ const unsigned int comp = fe->system_to_component_index(shape_func).first;
+ const unsigned int
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + comp];
const Tensor<2,spacedim> *shape_hessian_ptr
= &this->shape_hessians[row][0];
- const unsigned int comp = fe->system_to_component_index(shape_func).first;
for (unsigned int point=0; point<n_quadrature_points; ++point)
laplacians[point](comp) += value * trace(*shape_hessian_ptr++);
}
continue;
const unsigned int
- row = (this->shape_function_to_row_table[shape_func]
- +
- std::count (fe->get_nonzero_components(shape_func).begin(),
- fe->get_nonzero_components(shape_func).begin()+c,
- true));
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + c];
const Tensor<2,spacedim> *shape_hessian_ptr
= &this->shape_hessians[row][0];
if (fe->is_primitive(shape_func))
{
- const unsigned int
- row = fe->is_primitive() ?
- shape_func : this->shape_function_to_row_table[shape_func];
+ const unsigned int comp = fe->system_to_component_index(shape_func).first
+ + mc * n_components;
+ const unsigned int
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + comp];
const Tensor<2,spacedim> *shape_hessian_ptr
= &this->shape_hessians[row][0];
- const unsigned int comp = fe->system_to_component_index(shape_func).first
- + mc * n_components;
for (unsigned int point=0; point<n_quadrature_points; ++point)
laplacians[point](comp) += value * trace(*shape_hessian_ptr++);
}
continue;
const unsigned int
- row = (this->shape_function_to_row_table[shape_func]
- +
- std::count (fe->get_nonzero_components(shape_func).begin(),
- fe->get_nonzero_components(shape_func).begin()+c,
- true));
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + c];
const Tensor<2,spacedim> *shape_hessian_ptr
= &this->shape_hessians[row][0];
if (fe->is_primitive(shape_func))
{
- const unsigned int
- row = fe->is_primitive() ?
- shape_func : this->shape_function_to_row_table[shape_func];
+ const unsigned int comp = fe->system_to_component_index(shape_func).first
+ + mc * n_components;
+ const unsigned int
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + comp];
const Tensor<2,spacedim> *shape_hessian_ptr
= &this->shape_hessians[row][0];
- const unsigned int comp = fe->system_to_component_index(shape_func).first
- + mc * n_components;
+
if (quadrature_points_fastest)
for (unsigned int point=0; point<n_quadrature_points; ++point)
laplacians[comp][point] += value * trace(*shape_hessian_ptr++);
continue;
const unsigned int
- row = (this->shape_function_to_row_table[shape_func]
- +
- std::count (fe->get_nonzero_components(shape_func).begin(),
- fe->get_nonzero_components(shape_func).begin()+c,
- true));
+ row = this->shape_function_to_row_table[shape_func * fe->n_components() + c];
const Tensor<2,spacedim> *shape_hessian_ptr
= &this->shape_hessians[row][0];
+ template <int dim, int spacedim>
+ ComponentMask
+ FECollection<dim,spacedim>::
+ component_mask (const FEValuesExtractors::Scalar &scalar) const
+ {
+ Assert (size() > 0,
+ ExcMessage ("This collection contains no finite element."));
+
+ // get the mask from the first element of the collection
+ const ComponentMask mask = (*this)[0].component_mask(scalar);
+
+ // but then also verify that the other elements of the collection
+ // would return the same mask
+ for (unsigned int c=1; c<size(); ++c)
+ Assert (mask == (*this)[c].component_mask(scalar),
+ ExcInternalError());
+
+ return mask;
+ }
+
+
+ template <int dim, int spacedim>
+ ComponentMask
+ FECollection<dim,spacedim>::
+ component_mask (const FEValuesExtractors::Vector &vector) const
+ {
+ Assert (size() > 0,
+ ExcMessage ("This collection contains no finite element."));
+
+ // get the mask from the first element of the collection
+ const ComponentMask mask = (*this)[0].component_mask(vector);
+
+ // but then also verify that the other elements of the collection
+ // would return the same mask
+ for (unsigned int c=1; c<size(); ++c)
+ Assert (mask == (*this)[c].component_mask(vector),
+ ExcInternalError());
+
+ return mask;
+ }
+
+
+ template <int dim, int spacedim>
+ ComponentMask
+ FECollection<dim,spacedim>::
+ component_mask (const FEValuesExtractors::SymmetricTensor<2> &sym_tensor) const
+ {
+ Assert (size() > 0,
+ ExcMessage ("This collection contains no finite element."));
+
+ // get the mask from the first element of the collection
+ const ComponentMask mask = (*this)[0].component_mask(sym_tensor);
+
+ // but then also verify that the other elements of the collection
+ // would return the same mask
+ for (unsigned int c=1; c<size(); ++c)
+ Assert (mask == (*this)[c].component_mask(sym_tensor),
+ ExcInternalError());
+
+ return mask;
+ }
+
+
+ template <int dim, int spacedim>
+ ComponentMask
+ FECollection<dim,spacedim>::
+ component_mask (const BlockMask &block_mask) const
+ {
+ Assert (size() > 0,
+ ExcMessage ("This collection contains no finite element."));
+
+ // get the mask from the first element of the collection
+ const ComponentMask mask = (*this)[0].component_mask(block_mask);
+
+ // but then also verify that the other elements of the collection
+ // would return the same mask
+ for (unsigned int c=1; c<size(); ++c)
+ Assert (mask == (*this)[c].component_mask(block_mask),
+ ExcMessage ("Not all elements of this collection agree on what "
+ "the appropriate mask should be."));
+
+ return mask;
+ }
+
+
+ template <int dim, int spacedim>
+ BlockMask
+ FECollection<dim,spacedim>::
+ block_mask (const FEValuesExtractors::Scalar &scalar) const
+ {
+ Assert (size() > 0,
+ ExcMessage ("This collection contains no finite element."));
+
+ // get the mask from the first element of the collection
+ const BlockMask mask = (*this)[0].block_mask(scalar);
+
+ // but then also verify that the other elements of the collection
+ // would return the same mask
+ for (unsigned int c=1; c<size(); ++c)
+ Assert (mask == (*this)[c].block_mask(scalar),
+ ExcMessage ("Not all elements of this collection agree on what "
+ "the appropriate mask should be."));
+
+ return mask;
+ }
+
+
+ template <int dim, int spacedim>
+ BlockMask
+ FECollection<dim,spacedim>::
+ block_mask (const FEValuesExtractors::Vector &vector) const
+ {
+ Assert (size() > 0,
+ ExcMessage ("This collection contains no finite element."));
+
+ // get the mask from the first element of the collection
+ const BlockMask mask = (*this)[0].block_mask(vector);
+
+ // but then also verify that the other elements of the collection
+ // would return the same mask
+ for (unsigned int c=1; c<size(); ++c)
+ Assert (mask == (*this)[c].block_mask(vector),
+ ExcMessage ("Not all elements of this collection agree on what "
+ "the appropriate mask should be."));
+
+ return mask;
+ }
+
+
+ template <int dim, int spacedim>
+ BlockMask
+ FECollection<dim,spacedim>::
+ block_mask (const FEValuesExtractors::SymmetricTensor<2> &sym_tensor) const
+ {
+ Assert (size() > 0,
+ ExcMessage ("This collection contains no finite element."));
+
+ // get the mask from the first element of the collection
+ const BlockMask mask = (*this)[0].block_mask(sym_tensor);
+
+ // but then also verify that the other elements of the collection
+ // would return the same mask
+ for (unsigned int c=1; c<size(); ++c)
+ Assert (mask == (*this)[c].block_mask(sym_tensor),
+ ExcMessage ("Not all elements of this collection agree on what "
+ "the appropriate mask should be."));
+
+ return mask;
+ }
+
+
+
+ template <int dim, int spacedim>
+ BlockMask
+ FECollection<dim,spacedim>::
+ block_mask (const ComponentMask &component_mask) const
+ {
+ Assert (size() > 0,
+ ExcMessage ("This collection contains no finite element."));
+
+ // get the mask from the first element of the collection
+ const BlockMask mask = (*this)[0].block_mask(component_mask);
+
+ // but then also verify that the other elements of the collection
+ // would return the same mask
+ for (unsigned int c=1; c<size(); ++c)
+ Assert (mask == (*this)[c].block_mask(component_mask),
+ ExcMessage ("Not all elements of this collection agree on what "
+ "the appropriate mask should be."));
+
+ return mask;
+ }
+
+
+
template <int dim, int spacedim>
unsigned int
FECollection<dim,spacedim>::n_blocks () const
#include <deal.II/base/mg_level_object.h>
#include <deal.II/dofs/dof_tools.h>
#include <deal.II/fe/fe.h>
+#include <deal.II/fe/component_mask.h>
#include <vector>
#include <algorithm>
dofs_in_component (n_components,
std::vector<bool>(dof_handler.n_dofs(l),
false));
- std::vector<std::vector<bool> >
- component_select (n_components,
- std::vector<bool>(n_components, false));
+ std::vector<ComponentMask> component_select (n_components);
Threads::TaskGroup<> tasks;
for (unsigned int i=0; i<n_components; ++i)
{
void (*fun_ptr) (const unsigned int level,
const MGDoFHandler<dim,spacedim> &,
- const std::vector<bool> &,
- std::vector<bool> &,
- bool)
+ const ComponentMask &,
+ std::vector<bool> &)
= &DoFTools::template extract_level_dofs<dim>;
- component_select[i][i] = true;
+
+ std::vector<bool> tmp(n_components, false);
+ tmp[i] = true;
+ component_select[i] = ComponentMask(tmp);
+
tasks += Threads::new_task (fun_ptr,
l, dof_handler,
component_select[i],
- dofs_in_component[i], false);
+ dofs_in_component[i]);
}
tasks.join_all();
template <int dim, int spacedim>
void
-
count_dofs_per_component (const MGDoFHandler<dim,spacedim> &dof_handler,
std::vector<std::vector<unsigned int> > &result,
std::vector<unsigned int> target_component)
{
std::vector<std::vector<bool> >
dofs_in_block (n_blocks, std::vector<bool>(dof_handler.n_dofs(l), false));
- std::vector<std::vector<bool> >
- block_select (n_blocks, std::vector<bool>(n_blocks, false));
+ std::vector<BlockMask> block_select (n_blocks);
Threads::TaskGroup<> tasks;
for (unsigned int i=0; i<n_blocks; ++i)
{
void (*fun_ptr) (const unsigned int level,
const MGDoFHandler<dim,spacedim>&,
- const std::vector<bool>&,
- std::vector<bool>&,
- bool)
+ const BlockMask &,
+ std::vector<bool>&)
= &DoFTools::template extract_level_dofs<dim>;
- block_select[i][i] = true;
+
+ std::vector<bool> tmp(n_blocks, false);
+ tmp[i] = true;
+ block_select[i] = tmp;
+
tasks += Threads::new_task (fun_ptr,
l, dof_handler, block_select[i],
- dofs_in_block[i], true);
- };
+ dofs_in_block[i]);
+ }
tasks.join_all ();
// next count what we got
const MGDoFHandler<1,1>&,
const FunctionMap<1>::type&,
std::vector<std::set<unsigned int> >&,
- const std::vector<bool>&)
+ const ComponentMask &)
{
Assert(false, ExcNotImplemented());
}
const MGDoFHandler<1,2>&,
const FunctionMap<1>::type&,
std::vector<std::set<unsigned int> >&,
- const std::vector<bool>&)
+ const ComponentMask &)
{
Assert(false, ExcNotImplemented());
}
const MGDoFHandler<dim,spacedim>& dof,
const typename FunctionMap<dim>::type& function_map,
std::vector<std::set<unsigned int> >& boundary_indices,
- const std::vector<bool>& component_mask)
+ const ComponentMask & component_mask)
{
// if for whatever reason we were
// passed an empty map, return
std::vector<unsigned int> local_dofs;
local_dofs.reserve (DoFTools::max_dofs_per_face(dof));
- std::fill (local_dofs.begin (), local_dofs.end (),
+ std::fill (local_dofs.begin (),
+ local_dofs.end (),
DoFHandler<dim,spacedim>::invalid_dof_index);
// First, deal with the simpler
// case when we have to identify
// all boundary dofs
- if (component_mask.size() == 0)
+ if (component_mask.n_selected_components(n_components) == n_components)
{
typename MGDoFHandler<dim,spacedim>::cell_iterator
cell = dof.begin(),
}
else
{
- Assert (std::count(component_mask.begin(), component_mask.end(), true) > 0,
+ Assert (component_mask.n_selected_components(n_components) > 0,
ExcMessage("It's probably worthwhile to select at least one component."));
typename MGDoFHandler<dim,spacedim>::cell_iterator
// are in fact primitive
for (unsigned int i=0; i<cell->get_fe().dofs_per_cell; ++i)
{
- const std::vector<bool> &nonzero_component_array
+ const ComponentMask &nonzero_component_array
= cell->get_fe().get_nonzero_components (i);
for (unsigned int c=0; c<n_components; ++c)
if ((nonzero_component_array[c] == true)
// components. if shape function is non-primitive, then we will ignore
// the result in the following anyway, otherwise there's only one
// non-zero component which we will use
- component = (std::find (fe.get_nonzero_components(cell_i).begin(),
- fe.get_nonzero_components(cell_i).end(),
- true)
- -
- fe.get_nonzero_components(cell_i).begin());
+ component = fe.get_nonzero_components(cell_i).first_selected_component();
}
if (component_mask[component] == true)
make_boundary_list(const MGDoFHandler<dim,spacedim>& dof,
const typename FunctionMap<dim>::type& function_map,
std::vector<IndexSet>& boundary_indices,
- const std::vector<bool>& component_mask)
+ const ComponentMask & component_mask)
{
Assert (boundary_indices.size() == dof.get_tria().n_levels(),
ExcDimensionMismatch (boundary_indices.size(),
const MGDoFHandler<deal_II_dimension>&,
const FunctionMap<deal_II_dimension>::type&,
std::vector<std::set<unsigned int> >&,
- const std::vector<bool>&);
+ const ComponentMask &);
#endif
- template void make_boundary_list(
+ template void make_boundary_list(
const MGDoFHandler<deal_II_dimension>&,
const FunctionMap<deal_II_dimension>::type&,
std::vector<IndexSet>&,
- const std::vector<bool>&);
+ const ComponentMask &);
- template
+ template
void
extract_inner_interface_dofs (const MGDoFHandler<deal_II_dimension> &mg_dof_handler,
std::vector<std::vector<bool> > &interface_dofs,
std::vector<std::vector<bool> > &boundary_interface_dofs);
- template
+ template
void
extract_inner_interface_dofs (const MGDoFHandler<deal_II_dimension> &mg_dof_handler,
std::vector<std::vector<bool> > &interface_dofs);
namespace
{
- /**
- * Adjust block-vectors on all
- * levels to correct size. Count
- * the numbers of degrees of
- * freedom on each level
- * component-wise. Then, assign
- * each block of @p vector the
- * corresponding size.
- *
- * The boolean field @p selected
- * allows restricting this
- * operation to certain
- * components. In this case, @p
- * vector will only have as many
- * blocks as there are true
- * values in @p selected (no
- * blocks of length zero are
- * padded in). If this argument
- * is omitted, all blocks will be
- * considered.
- *
- * Degrees of freedom must be
- * sorted by component in order
- * to obtain reasonable results
- * from this function.
- *
- * The argument
- * @p target_component allows to
- * re-sort and group components
- * as in
- * DoFRenumbering::component_wise.
- *
- *
- */
- template <int dim, typename number, int spacedim>
- void
- reinit_vector_by_components (
- const dealii::MGDoFHandler<dim,spacedim> &mg_dof,
- MGLevelObject<BlockVector<number> > &v,
- const std::vector<bool> &sel,
- const std::vector<unsigned int> &target_comp,
- std::vector<std::vector<unsigned int> >& ndofs)
- {
- std::vector<bool> selected=sel;
- std::vector<unsigned int> target_component=target_comp;
- const unsigned int ncomp = mg_dof.get_fe().n_components();
-
- // If the selected and
- // target_component have size 0,
- // they must be replaced by default
- // values.
- //
- // Since we already made copies
- // directly after this function was
- // called, we use the arguments
- // directly.
- if (target_component.size() == 0)
- {
- target_component.resize(ncomp);
- for (unsigned int i=0;i<ncomp;++i)
- target_component[i] = i;
- }
-
- // If selected is an empty vector,
- // all components are selected.
- if (selected.size() == 0)
- {
- selected.resize(target_component.size());
- std::fill_n (selected.begin(), ncomp, false);
- for (unsigned int i=0;i<target_component.size();++i)
- selected[target_component[i]] = true;
- }
-
- Assert (selected.size() == target_component.size(),
- ExcDimensionMismatch(selected.size(), target_component.size()));
-
- // Compute the number of blocks needed
- const unsigned int n_selected
- = std::accumulate(selected.begin(),
- selected.end(),
- 0U);
-
- if (ndofs.size() == 0)
- {
- std::vector<std::vector<unsigned int> >
- new_dofs(mg_dof.get_tria().n_levels(),
- std::vector<unsigned int>(target_component.size()));
- std::swap(ndofs, new_dofs);
- MGTools::count_dofs_per_block (mg_dof, ndofs, target_component);
- }
-
- for (unsigned int level=v.get_minlevel();
- level<=v.get_maxlevel();++level)
- {
- v[level].reinit(n_selected, 0);
- unsigned int k=0;
- for (unsigned int i=0;i<selected.size() && (k<v[level].n_blocks());++i)
- {
- if (selected[i])
- {
- v[level].block(k++).reinit(ndofs[level][i]);
- }
- v[level].collect_sizes();
- }
- }
- }
-
-
/**
* Adjust vectors on all levels
* to correct size. Count the
reinit_vector_by_components (
const dealii::MGDoFHandler<dim,spacedim> &mg_dof,
MGLevelObject<dealii::Vector<number> > &v,
- const std::vector<bool> &selected,
+ const ComponentMask &component_mask,
const std::vector<unsigned int> &target_component,
std::vector<std::vector<unsigned int> >& ndofs)
{
- Assert (selected.size() == target_component.size(),
- ExcDimensionMismatch(selected.size(), target_component.size()));
-
- // Compute the number of blocks needed
-#ifdef DEBUG
-// const unsigned int n_selected
-// = std::accumulate(selected.begin(),
-// selected.end(),
-// 0U);
-// Assert(n_selected == 1, ExcDimensionMismatch(n_selected, 1));
-#endif
+ Assert (component_mask.represents_n_components(target_component.size()),
+ ExcMessage ("The component mask does not have the correct size."));
unsigned int selected_block = 0;
for (unsigned int i=0; i<target_component.size(); ++i)
- if(selected[i])
+ if(component_mask[i])
selected_block = target_component[i];
if (ndofs.size() == 0)
Assert(sizes.size()==mg_dof_handler.get_tria().n_levels(),
ExcMatricesNotBuilt());
- reinit_vector_by_components(mg_dof_handler, dst, mg_selected,
+ reinit_vector_by_components(mg_dof_handler, dst,
+ mg_component_mask,
mg_target_component, sizes);
// traverse the grid top-down
const unsigned int dofs_per_cell = fe.dofs_per_cell;
const unsigned int n_levels = mg_dof.get_tria().n_levels();
- Assert (mg_selected.size() == fe.n_components(),
- ExcDimensionMismatch(mg_selected.size(), fe.n_components()));
+ Assert (mg_component_mask.represents_n_components(fe.n_components()),
+ ExcMessage ("Component mask has wrong size."));
// Compute the lengths of all blocks
sizes.resize(n_levels);
= fe.system_to_component_index(i).first;
const unsigned int jcomp
= fe.system_to_component_index(j).first;
- if ((icomp==jcomp) && mg_selected[icomp])
+ if ((icomp==jcomp) && mg_component_mask[icomp])
prolongation_sparsities[level]->add(dof_indices_child[i],
dof_indices_parent[j]);
};
{
const unsigned int icomp = fe.system_to_component_index(i).first;
const unsigned int jcomp = fe.system_to_component_index(j).first;
- if ((icomp==jcomp) && mg_selected[icomp])
+ if ((icomp==jcomp) && mg_component_mask[icomp])
prolongation_matrices[level]->set(dof_indices_child[i],
dof_indices_parent[j],
prolongation(i,j));
selected_component = select;
mg_selected_component = mg_select;
- selected.resize(ncomp, false);
- for(unsigned int c=0; c<ncomp; ++c)
- if(t_component[c] == selected_component)
- selected[c] = true;
-
- mg_selected.resize(ncomp, false);
- for(unsigned int c=0; c<ncomp; ++c)
- if(mg_t_component[c] == mg_selected_component)
- mg_selected[c] = true;
+
+ {
+ std::vector<bool> tmp(ncomp, false);
+ for(unsigned int c=0; c<ncomp; ++c)
+ if(t_component[c] == selected_component)
+ tmp[c] = true;
+ component_mask = ComponentMask(tmp);
+ }
+
+ {
+ std::vector<bool> tmp(ncomp, false);
+ for(unsigned int c=0; c<ncomp; ++c)
+ if(mg_t_component[c] == mg_selected_component)
+ tmp[c] = true;
+ mg_component_mask = ComponentMask(tmp);
+ }
+
// If components are renumbered,
// find the first original
// component corresponding to the
{
const unsigned int component
= fe.system_to_component_index(i).first;
- if (selected[component] &&
+ if (component_mask[component] &&
!interface_dofs[level][level_dof_indices[i]])
{
const unsigned int level_start
MGTransferComponentBase::memory_consumption () const
{
std::size_t result = sizeof(*this);
- result += MemoryConsumption::memory_consumption(selected)
- - sizeof(selected);
+ result += MemoryConsumption::memory_consumption(component_mask)
+ - sizeof(ComponentMask);
result += MemoryConsumption::memory_consumption(target_component)
- sizeof(mg_target_component);
result += MemoryConsumption::memory_consumption(sizes)
* function.
*/
const typename FunctionMap<spacedim>::type *neumann_bc;
- const std::vector<bool> component_mask;
+ const ComponentMask component_mask;
const Function<spacedim> *coefficients;
/**
const types::subdomain_id subdomain_id,
const types::material_id material_id,
const typename FunctionMap<spacedim>::type *neumann_bc,
- const std::vector<bool> component_mask,
+ const ComponentMask component_mask,
const Function<spacedim> *coefficients);
/**
const types::subdomain_id subdomain_id,
const types::material_id material_id,
const typename FunctionMap<spacedim>::type *neumann_bc,
- const std::vector<bool> component_mask,
+ const ComponentMask component_mask,
const Function<spacedim> *coefficients)
:
finite_element (fe),
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector*> &solutions,
std::vector<Vector<float>*> &errors,
- const std::vector<bool> &component_mask,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector*> &solutions,
std::vector<Vector<float>*> &errors,
- const std::vector<bool> &component_mask,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id subdomain_id,
const typename FunctionMap<spacedim>::type &/*neumann_bc*/,
const std::vector<const InputVector *> &/*solutions*/,
std::vector<Vector<float>*> &/*errors*/,
- const std::vector<bool> &/*component_mask_*/,
+ const ComponentMask &/*component_mask_*/,
const Function<spacedim> */*coefficient*/,
const unsigned int,
const types::subdomain_id /*subdomain_id*/,
const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
- const std::vector<bool> &component_mask_,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficient,
const unsigned int,
const types::subdomain_id subdomain_id_,
i!=neumann_bc.end(); ++i)
Assert (i->second->n_components == n_components, ExcInvalidBoundaryFunction());
- Assert ((component_mask_.size() == 0) ||
- (component_mask_.size() == n_components), ExcInvalidComponentMask());
- Assert ((component_mask_.size() == 0) ||
- (std::count(component_mask_.begin(), component_mask_.end(),
- true) > 0),
+ Assert (component_mask.represents_n_components(n_components),
+ ExcInvalidComponentMask());
+ Assert (component_mask.n_selected_components(n_components) > 0,
ExcInvalidComponentMask());
Assert ((coefficient == 0) ||
Assert (solutions[n]->size() == dof_handler.n_dofs(),
ExcInvalidSolutionVector());
- // if no mask given: treat all components
- std::vector<bool> component_mask ((component_mask_.size() == 0) ?
- std::vector<bool>(n_components, true) :
- component_mask_);
- Assert (component_mask.size() == n_components, ExcInvalidComponentMask());
- Assert (std::count(component_mask.begin(), component_mask.end(), true) > 0,
- ExcInvalidComponentMask());
-
Assert ((coefficient == 0) ||
(coefficient->n_components == n_components) ||
(coefficient->n_components == 1),
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const InputVector &solution,
Vector<float> &error,
- const std::vector<bool> &component_mask,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
- const std::vector<bool> &component_mask_,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients,
const unsigned int ,
const types::subdomain_id subdomain_id_,
Assert (i->second->n_components == n_components,
ExcInvalidBoundaryFunction());
- Assert ((component_mask_.size() == 0) ||
- (component_mask_.size() == n_components), ExcInvalidComponentMask());
- Assert ((component_mask_.size() == 0) ||
- (std::count(component_mask_.begin(), component_mask_.end(),
- true) > 0),
+ Assert (component_mask.represents_n_components(n_components),
+ ExcInvalidComponentMask());
+ Assert (component_mask.n_selected_components(n_components) > 0,
ExcInvalidComponentMask());
Assert ((coefficients == 0) ||
Assert (solutions[n]->size() == dof_handler.n_dofs(),
ExcInvalidSolutionVector());
- // if no mask given: treat all components
- std::vector<bool> component_mask ((component_mask_.size() == 0) ?
- std::vector<bool>(n_components, true) :
- component_mask_);
- Assert (component_mask.size() == n_components, ExcInvalidComponentMask());
- Assert (std::count(component_mask.begin(), component_mask.end(), true) > 0,
- ExcInvalidComponentMask());
-
const unsigned int n_solution_vectors = solutions.size();
// Map of integrals indexed by
const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
- const std::vector<bool> &component_mask,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
- const std::vector<bool> &component_mask,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id subdomain_id,
const typename FunctionMap<spacedim>::type &neumann_bc,
const std::vector<const InputVector *> &solutions,
std::vector<Vector<float>*> &errors,
- const std::vector<bool> &component_mask,
+ const ComponentMask &component_mask,
const Function<spacedim> *coefficients,
const unsigned int n_threads,
const types::subdomain_id subdomain_id,
const FunctionMap<deal_II_dimension>::type &, \
const InputVector &, \
Vector<float> &, \
- const std::vector<bool> &, \
+ const ComponentMask &, \
const Function<deal_II_dimension> *, \
const unsigned int , \
const unsigned int , \
const FunctionMap<deal_II_dimension>::type &, \
const InputVector &, \
Vector<float> &, \
- const std::vector<bool> &, \
+ const ComponentMask &, \
const Function<deal_II_dimension> *, \
const unsigned int , \
const unsigned int , \
const FunctionMap<deal_II_dimension>::type &, \
const std::vector<const InputVector *> &, \
std::vector<Vector<float>*> &, \
- const std::vector<bool> &, \
+ const ComponentMask &, \
const Function<deal_II_dimension> *, \
const unsigned int , \
const unsigned int , \
const FunctionMap<deal_II_dimension>::type &, \
const std::vector<const InputVector *> &, \
std::vector<Vector<float>*> &, \
- const std::vector<bool> &, \
+ const ComponentMask &, \
const Function<deal_II_dimension> *, \
const unsigned int , \
const unsigned int , \
const FunctionMap<deal_II_dimension+1>::type &, \
const InputVector &, \
Vector<float> &, \
- const std::vector<bool> &, \
+ const ComponentMask &, \
const Function<deal_II_dimension+1> *, \
const unsigned int , \
const unsigned int , \
const FunctionMap<deal_II_dimension+1>::type &, \
const InputVector &, \
Vector<float> &, \
- const std::vector<bool> &, \
+ const ComponentMask &, \
const Function<deal_II_dimension+1> *, \
const unsigned int , \
const unsigned int , \
const FunctionMap<deal_II_dimension+1>::type &, \
const std::vector<const InputVector *> &, \
std::vector<Vector<float>*> &, \
- const std::vector<bool> &, \
+ const ComponentMask &, \
const Function<deal_II_dimension+1> *, \
const unsigned int , \
const unsigned int , \
const FunctionMap<deal_II_dimension+1>::type &, \
const std::vector<const InputVector *> &, \
std::vector<Vector<float>*> &, \
- const std::vector<bool> &, \
+ const ComponentMask &, \
const Function<deal_II_dimension+1> *, \
const unsigned int , \
const unsigned int , \
// support points
// GridTools::find_active_cell_around_point
// is an alternative. That method is not
- // used here mostly because of the history
- // of the class. The algorithm used in
+ // used here mostly because of the history
+ // of the class. The algorithm used in
// add_points below may be slightly more
// efficient than find_active_cell_around_point
// because it operates on a set of points.
-
+
for (; cell != endc; cell++)
{
fe_values.reinit (cell);
{
// add an extra row to each vector
// entry
- std::vector <bool> current_mask = (component_mask.find (data_store_begin->first))->second;
- unsigned int n_stored = std::count(current_mask.begin(), current_mask.end(), true);
+ const ComponentMask ¤t_mask = (component_mask.find (data_store_begin->first))->second;
+ unsigned int n_stored = current_mask.n_selected_components();
for (unsigned int component = 0; component < n_stored; component++)
{
data_store_begin->second.push_back (std::vector<double> (0));
// points
// GridTools::find_active_cell_around_point
// is an alternative. That method is not
- // used here mostly because of the history
- // of the class. The algorithm used here
+ // used here mostly because of the history
+ // of the class. The algorithm used here
// may be slightly more
// efficient than find_active_cell_around_point
// because it operates on a set of points.
{
// add an extra row to each vector
// entry
- std::vector <bool> current_mask = (component_mask.find (data_store_begin->first))->second;
- unsigned int n_stored = std::count(current_mask.begin(), current_mask.end(), true);
+ const ComponentMask current_mask = (component_mask.find (data_store_begin->first))->second;
+ unsigned int n_stored = current_mask.n_selected_components();
for (unsigned int component = 0; component < n_stored; component++)
{
data_store_begin->second.push_back (std::vector<double> (0));
template <int dim>
void PointValueHistory<dim>
-::add_field_name (const std::string &vector_name, const std::vector <bool> &mask)
+::add_field_name (const std::string &vector_name,
+ const ComponentMask &mask)
{
// can't be closed to add additional points
// or vectors
AssertThrow (have_dof_handler, ExcDoFHandlerRequired ());
AssertThrow (!triangulation_changed, ExcDoFHandlerChanged ());
-
- // Make a component_mask, if not supplied
- std::vector <bool> temp_mask = mask;
- if (temp_mask.size() == 0)
- {
- temp_mask = std::vector<bool> (dof_handler->get_fe().n_components(), true);
- }
- component_mask.insert (std::pair <std::string, std::vector<bool> > (vector_name, temp_mask));
+ // insert a component mask that is always of the right size
+ if (mask.represents_the_all_selected_mask() == false)
+ component_mask.insert (std::make_pair (vector_name, mask));
+ else
+ component_mask.insert (std::make_pair (vector_name,
+ ComponentMask(std::vector<bool>(dof_handler->get_fe().n_components(), true))));
// insert an empty vector of strings
// to ensure each field has an entry
// in the map
- std::pair <std::string, std::vector <std::string> > empty_names (vector_name, std::vector <std::string> ());
+ std::pair <std::string, std::vector <std::string> >
+ empty_names (vector_name, std::vector <std::string> ());
component_names_map.insert (empty_names);
// make and add a new vector
// point_geometry_data.size() long
std::pair<std::string, std::vector <std::vector <double> > > pair_data;
pair_data.first = vector_name;
- unsigned int n_stored = std::count(temp_mask.begin(), temp_mask.end(), true);
+ const unsigned int n_stored = (mask.represents_the_all_selected_mask() == false
+ ?
+ mask.n_selected_components()
+ :
+ dof_handler->get_fe().n_components());
+
int n_datastreams = point_geometry_data.size () * n_stored; // each point has n_stored sub parts
std::vector < std::vector <double> > vector_size (n_datastreams,
std::vector <double> (0));
typename std::map <std::string, std::vector <std::string> >::iterator names = component_names_map.find(vector_name);
Assert (names != component_names_map.end(), ExcMessage("vector_name not in class"));
- typename std::map <std::string, std::vector <bool> >::iterator mask = component_mask.find(vector_name);
+ typename std::map <std::string, ComponentMask>::iterator mask = component_mask.find(vector_name);
Assert (mask != component_mask.end(), ExcMessage("vector_name not in class"));
- unsigned int n_stored = std::count(mask->second.begin(), mask->second.end(), true);
+ unsigned int n_stored = mask->second.n_selected_components();
Assert (component_names.size() == n_stored, ExcDimensionMismatch (component_names.size(), n_stored));
names->second = component_names;
typename std::map <std::string, std::vector <std::vector <double> > >::iterator data_store_field = data_store.find(vector_name);
Assert (data_store_field != data_store.end(), ExcMessage("vector_name not in class"));
// Repeat for component_mask
- typename std::map <std::string, std::vector <bool> >::iterator mask = component_mask.find(vector_name);
+ typename std::map <std::string, ComponentMask>::iterator mask = component_mask.find(vector_name);
Assert (mask != component_mask.end(), ExcMessage("vector_name not in class"));
- Assert (mask->second.size () == dof_handler->get_fe ().n_components (), ExcDimensionMismatch (mask->second.size (), dof_handler->get_fe ().n_components ()));
- unsigned int n_stored = std::count(mask->second.begin(), mask->second.end(), true);
+ unsigned int n_stored = mask->second.n_selected_components(dof_handler->get_fe ().n_components ());
typename std::vector <internal::PointValueHistory::PointGeometryData <dim> >::iterator point = point_geometry_data.begin ();
for (unsigned int data_store_index = 0; point != point_geometry_data.end (); point++, data_store_index++)
// in the component_mask, and
// access the data associated with
// those components
-
- for (unsigned int store_index = 0, comp = 0; comp < mask->second.size(); comp++)
+
+ for (unsigned int store_index = 0, comp = 0; comp < dof_handler->get_fe ().n_components (); comp++)
{
if (mask->second[comp])
{
typename std::map <std::string, std::vector <std::vector <double> > >::iterator data_store_field = data_store.find(*name);
Assert (data_store_field != data_store.end(), ExcMessage("vector_name not in class"));
// Repeat for component_mask
- typename std::map <std::string, std::vector <bool> >::iterator mask = component_mask.find(*name);
+ typename std::map <std::string, ComponentMask>::iterator mask = component_mask.find(*name);
Assert (mask != component_mask.end(), ExcMessage("vector_name not in class"));
- Assert (mask->second.size () == n_output_variables, ExcDimensionMismatch (mask->second.size (),n_output_variables));
- unsigned int n_stored = std::count(mask->second.begin(), mask->second.end(), true);
-
+ unsigned int n_stored = mask->second.n_selected_components(n_output_variables);
+
// Push back computed quantities according
// to the component_mask.
- for (unsigned int store_index = 0, comp = 0; comp < mask->second.size(); comp++)
+ for (unsigned int store_index = 0, comp = 0; comp < n_output_variables; comp++)
{
if (mask->second[comp])
{
typename std::map <std::string, std::vector <std::vector <double> > >::iterator data_store_field = data_store.find(vector_name);
Assert (data_store_field != data_store.end(), ExcMessage("vector_name not in class"));
// Repeat for component_mask
- typename std::map <std::string, std::vector <bool> >::iterator mask = component_mask.find(vector_name);
+ typename std::map <std::string, ComponentMask>::iterator mask = component_mask.find(vector_name);
Assert (mask != component_mask.end(), ExcMessage("vector_name not in class"));
- Assert (mask->second.size () == dof_handler->get_fe ().n_components (), ExcDimensionMismatch (mask->second.size (), dof_handler->get_fe ().n_components ()));
- unsigned int n_stored = std::count(mask->second.begin(), mask->second.end(), true);
+ unsigned int n_stored = mask->second.n_selected_components(dof_handler->get_fe ().n_components ());
typename std::vector <internal::PointValueHistory::PointGeometryData <dim> >::iterator point = point_geometry_data.begin ();
Vector <double> value (dof_handler->get_fe().n_components());
for (; data_store_begin != data_store.end (); data_store_begin++)
{
- typename std::map <std::string, std::vector <bool> >::iterator mask = component_mask.find(data_store_begin->first);
- unsigned int n_stored = std::count(mask->second.begin(), mask->second.end(), true);
+ typename std::map <std::string, ComponentMask>::iterator mask = component_mask.find(data_store_begin->first);
+ unsigned int n_stored = mask->second.n_selected_components();
std::vector <std::string> names = (component_names_map.find (data_store_begin->first))->second;
if (names.size() > 0)
}
}
else
- {
+ {
for (unsigned int component = 0; component < n_stored; component++)
{
to_gnuplot << "<" << data_store_begin->first << "_" << component << "> ";
for (; data_store_begin != data_store.end (); data_store_begin++)
{
- typename std::map <std::string, std::vector <bool> >::iterator mask = component_mask.find(data_store_begin->first);
- unsigned int n_stored = std::count(mask->second.begin(), mask->second.end(), true);
+ typename std::map <std::string, ComponentMask>::iterator mask = component_mask.find(data_store_begin->first);
+ unsigned int n_stored = mask->second.n_selected_components();
for (unsigned int component = 0; component < n_stored; component++)
{
{
// Find field mnemonic
std::string vector_name = data_store_begin->first;
- typename std::map <std::string, std::vector <bool> >::iterator mask = component_mask.find(vector_name);
+ typename std::map <std::string, ComponentMask>::iterator mask = component_mask.find(vector_name);
Assert (mask != component_mask.end(), ExcMessage("vector_name not in class"));
typename std::map <std::string, std::vector <std::string> >::iterator component_names = component_names_map.find(vector_name);
Assert (component_names != component_names_map.end(), ExcMessage("vector_name not in class"));
if (data_store_begin->second.size () != 0)
{
out << data_store_begin->first << ": " << data_store_begin->second.size () << " (";
- out << mask->second.size() << ", " << std::count (mask->second.begin(), mask->second.end(), true) << ") : ";
+ out << mask->second.size() << ", " << mask->second.n_selected_components() << ") : ";
out << (data_store_begin->second)[0].size () << "\n";
}
else
{
out << data_store_begin->first << ": " << data_store_begin->second.size () << " (";
- out << mask->second.size() << ", " << std::count (mask->second.begin(), mask->second.end(), true) << ") : ";
+ out << mask->second.size() << ", " << mask->second.n_selected_components() << ") : ";
out << "No points added" << "\n";
}
// add names, if available
template <int dim>
bool PointValueHistory<dim>
-::deep_check (bool strict)
+::deep_check (const bool strict)
{
- // test ways that it can fail, if control
- // reaches last statement return true
+ // test ways that it can fail, if control
+ // reaches last statement return true
if (strict)
{
if (n_indep != 0)
}
}
std::map <std::string, std::vector <std::vector <double> > >::iterator
- data_store_begin = data_store.begin ();
+ data_store_begin = data_store.begin ();
if (have_dof_handler)
{
for (; data_store_begin != data_store.end (); data_store_begin++)
{
+ Assert (data_store_begin->second.size() > 0,
+ ExcInternalError());
if ((data_store_begin->second)[0].size () != dataset_key.size ())
return false;
- // this loop only tests one
- // member for each name,
- // i.e. checks the user it will
- // not catch internal errors
- // which do not update all
- // fields for a name.
+ // this loop only tests one
+ // member for each name,
+ // i.e. checks the user it will
+ // not catch internal errors
+ // which do not update all
+ // fields for a name.
}
}
return true;
if (have_dof_handler)
{
std::map <std::string, std::vector <std::vector <double> > >::iterator
- data_store_begin = data_store.begin ();
+ data_store_begin = data_store.begin ();
for (; data_store_begin != data_store.end (); data_store_begin++)
{
+ Assert (data_store_begin->second.size() > 0,
+ ExcInternalError());
+
if (std::abs ((int) (data_store_begin->second)[0].size () - (int) dataset_key.size ()) >= 2)
return false;
- // this loop only tests one member
- // for each name, i.e. checks the
- // user it will not catch internal
- // errors which do not update all
- // fields for a name.
+ // this loop only tests one member
+ // for each name, i.e. checks the
+ // user it will not catch internal
+ // errors which do not update all
+ // fields for a name.
}
}
return true;
const DH<deal_II_dimension,deal_II_space_dimension> &,
const FunctionMap<deal_II_space_dimension>::type &,
std::map<unsigned int,double> &,
- const std::vector<bool> &);
+ const ComponentMask &);
template
void interpolate_boundary_values
const types::boundary_id,
const Function<deal_II_space_dimension> &,
std::map<unsigned int,double> &,
- const std::vector<bool> &);
+ const ComponentMask &);
template
void interpolate_boundary_values (
const types::boundary_id,
const Function<deal_II_space_dimension> &,
std::map<unsigned int,double> &,
- const std::vector<bool> &);
+ const ComponentMask &);
template
void interpolate_boundary_values
(const DH<deal_II_dimension,deal_II_space_dimension> &,
const FunctionMap<deal_II_space_dimension>::type &,
std::map<unsigned int,double> &,
- const std::vector<bool> &);
+ const ComponentMask &);
template
void interpolate_boundary_values (
const DH<deal_II_dimension,deal_II_space_dimension> &,
const FunctionMap<deal_II_space_dimension>::type &,
ConstraintMatrix &,
- const std::vector<bool> &);
+ const ComponentMask &);
template
void interpolate_boundary_values
const types::boundary_id,
const Function<deal_II_space_dimension> &,
ConstraintMatrix &,
- const std::vector<bool> &);
+ const ComponentMask &);
template
void interpolate_boundary_values (
const types::boundary_id,
const Function<deal_II_space_dimension> &,
ConstraintMatrix &,
- const std::vector<bool> &);
+ const ComponentMask &);
template
void interpolate_boundary_values (
const DH<deal_II_dimension,deal_II_space_dimension> &,
const FunctionMap<deal_II_space_dimension>::type &,
ConstraintMatrix &,
- const std::vector<bool> &);
+ const ComponentMask &);
\}
#endif
# in the report with it. for a branch, prefix everything
# with x-branch-name/ so that tests run from the branch will show up
# in different folders on the webpage.
-WORKDIR = $(notdir $(shell pwd))
+WORKDIR = x-branch-component-mask/$(notdir $(shell pwd))
//---------------------------- anna_3.cc ---------------------------
// $Id$
-// Version: $Name$
+// Version: $Name$
//
-// Copyright (C) 2002, 2003, 2004, 2005, 2010 by the deal.II authors and Anna Schneebeli
+// Copyright (C) 2002, 2003, 2004, 2005, 2010, 2012 by the deal.II authors and Anna Schneebeli
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <deal.II/grid/tria_iterator.h>
#include <deal.II/dofs/dof_accessor.h>
#include <deal.II/dofs/dof_tools.h>
-#include <deal.II/fe/fe_system.h>
+#include <deal.II/fe/fe_system.h>
#include <deal.II/fe/fe_q.h>
#include <deal.II/fe/fe_nedelec.h>
#include <deal.II/fe/fe_base.h>
template <int dim>
-class SystemTest
+class SystemTest
{
public:
SystemTest ();
- void run ();
-
+ void run ();
+
private:
void make_grid_and_dofs ();
void check ();
-
+
Triangulation<dim> triangulation;
FESystem<dim> fe;
DoFHandler<dim> dof_handler;
-
+
};
template <int dim>
template <int dim>
void SystemTest<dim>::make_grid_and_dofs ()
-{
+{
GridGenerator::hyper_cube (triangulation, -1, 1);
triangulation.refine_global (0);
deallog << "Number of active cells: " << triangulation.n_active_cells()
<< std::endl;
deallog << "Total number of cells: " << triangulation.n_cells()
<< std::endl;
-
+
dof_handler.distribute_dofs (fe);
deallog << "Number of degrees of freedom: " << dof_handler.n_dofs()
<< std::endl;
-
+
}
template <int dim>
-void SystemTest<dim>::check ()
+void SystemTest<dim>::check ()
{
for (unsigned int c=0; c<fe.n_components(); ++c)
{
std::vector<bool> x(fe.n_components(), false);
x[c] = true;
std::vector<bool> sel(dof_handler.n_dofs());
- DoFTools::extract_dofs (dof_handler, x, sel);
+ DoFTools::extract_dofs (dof_handler, ComponentMask(x), sel);
for (unsigned int i=0; i<sel.size(); ++i)
if (sel[i])
template <int dim>
-void SystemTest<dim>::run ()
+void SystemTest<dim>::run ()
{
deallog << "************* " << dim << "D *************" << std::endl;
make_grid_and_dofs ();
check ();
}
-
-int main ()
+
+int main ()
{
std::ofstream logfile("anna_3/output");
deallog.attach(logfile);
deallog.threshold_double(1.e-10);
SystemTest<2>().run();
- SystemTest<3>().run();
+ SystemTest<3>().run();
return 0;
}
//---------------------------- dof_tools_12.cc ---------------------------
// $Id$
-// Version: $Name$
+// Version: $Name$
//
-// Copyright (C) 2003, 2004 by the deal.II authors
+// Copyright (C) 2003, 2004, 2012 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
// only select first component
mask[0] = true;
- DoFTools::extract_dofs (dof_handler, mask, selected_dofs);
+ DoFTools::extract_dofs (dof_handler, ComponentMask(mask), selected_dofs);
output_bool_vector (selected_dofs);
// also select last component
mask.back() = true;
- DoFTools::extract_dofs (dof_handler, mask, selected_dofs);
+ DoFTools::extract_dofs (dof_handler, ComponentMask(mask), selected_dofs);
output_bool_vector (selected_dofs);
}
//---------------------------- dof_tools_13a.cc ---------------------------
// $Id$
-// Version: $Name$
+// Version: $Name$
//
-// Copyright (C) 2003, 2004, 2007 by the deal.II authors
+// Copyright (C) 2003, 2004, 2007, 2012 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
// the element is not primitive
if (dof_handler.get_fe().is_primitive() == false)
return;
-
+
Vector<double> cell_data (dof_handler.get_tria().n_active_cells());
for (unsigned int i=0; i<cell_data.size(); ++i)
cell_data(i) = i;
std::vector<bool> component_mask (dof_handler.get_fe().n_components(),
false);
component_mask[0] = true;
- DoFTools::extract_dofs (dof_handler, component_mask, component_dofs);
+ DoFTools::extract_dofs (dof_handler, ComponentMask(component_mask), component_dofs);
for (unsigned int i=0; i<dof_data.size(); ++i)
if (component_dofs[i] == true)
else
dof_data(i) = 0;
}
-
+
DoFTools::distribute_cell_to_dof_vector (dof_handler,
cell_data,
dof_data);
// output every third element
for (unsigned int i=0; i<dof_data.size(); i+=3)
deallog << dof_data(i) << " ";
- deallog << std::endl;
+ deallog << std::endl;
// check that no other values were
// set
if (component_dofs[i] == false)
Assert (dof_data(i) == 0,
ExcInternalError());
-
+
// distribute to last component. by
// default we distribute to
// component zero
-
+
// preset the vector again to make
// sure that the function zeroes out
- // previous content.
+ // previous content.
{
std::vector<bool> component_mask (dof_handler.get_fe().n_components(),
false);
component_mask.back() = true;
- DoFTools::extract_dofs (dof_handler, component_mask, component_dofs);
+ DoFTools::extract_dofs (dof_handler, ComponentMask(component_mask), component_dofs);
for (unsigned int i=0; i<dof_data.size(); ++i)
if (component_dofs[i] == true)
dof_data(i) = i+1;
dof_handler.get_fe().n_components()-1);
for (unsigned int i=0; i<dof_data.size(); i+=3)
deallog << dof_data(i) << " ";
- deallog << std::endl;
+ deallog << std::endl;
// check that no other values were
// set
component_mask[c] = (int_mask & (1<<c));
std::vector<bool> dofs (dof.n_dofs());
- DoFTools::extract_dofs (dof, component_mask, dofs);
+ DoFTools::extract_dofs (dof, ComponentMask(component_mask), dofs);
for (unsigned int d=0; d<dof.n_dofs(); ++d)
deallog << dofs[d];
component_mask[c] = (int_mask & (1<<c));
std::vector<bool> dofs (dof.n_dofs());
- DoFTools::extract_dofs (dof, component_mask, dofs);
+ DoFTools::extract_dofs (dof, ComponentMask(component_mask), dofs);
for (unsigned int d=0; d<dof.n_dofs(); ++d)
deallog << dofs[d];
deallog << "level=" << level << std::endl;
std::vector<bool> dofs (dof.n_dofs(level));
- DoFTools::extract_level_dofs (level, dof, component_mask, dofs);
+ DoFTools::extract_level_dofs (level, dof, ComponentMask(component_mask), dofs);
for (unsigned int d=0; d<dofs.size(); ++d)
deallog << dofs[d];
--- /dev/null
+//---------------------------- extract_dofs_by_component_01x.cc ---------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2010, 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//---------------------------- extract_dofs_by_component_01x.cc ---------------------------
+
+
+// test internal::extract_dofs_by_component for some corner cases that
+// I was unsure about when refactoring some code in there
+//
+// this particular test checks the call path to
+// internal::extract_dofs_by_component from DoFTools::extract_dofs via
+// the component_select flag
+//
+// this is a redux of the _01 test that broke on a branch at the
+// beginning
+
+
+#include "../tests.h"
+#include <deal.II/base/logstream.h>
+#include <deal.II/grid/tria.h>
+#include <deal.II/grid/tria_iterator.h>
+#include <deal.II/grid/tria_accessor.h>
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/dofs/dof_handler.h>
+#include <deal.II/fe/fe_dgq.h>
+#include <deal.II/fe/fe_raviart_thomas.h>
+#include <deal.II/fe/fe_nedelec.h>
+#include <deal.II/fe/fe_system.h>
+#include <deal.II/dofs/dof_tools.h>
+
+#include <fstream>
+
+
+
+
+template <int dim>
+void
+check ()
+{
+ Triangulation<dim> tr;
+ GridGenerator::hyper_cube(tr, -1,1);
+ tr.refine_global (1);
+
+ // use a simpler finite element
+ // than in the _01x test
+ FESystem<dim> element (FE_DGQ<dim>(0), 1,
+ FE_Nedelec<dim>(0), 1);
+ DoFHandler<dim> dof(tr);
+ dof.distribute_dofs(element);
+
+ // use a mask that only has the
+ // first component set
+ std::vector<bool> component_mask (element.n_components(), false);
+ component_mask[0] = true;
+
+ std::vector<bool> dofs (dof.n_dofs());
+ DoFTools::extract_dofs (dof, ComponentMask(component_mask), dofs);
+
+ for (unsigned int d=0; d<dof.n_dofs(); ++d)
+ deallog << dofs[d];
+ deallog << std::endl;
+}
+
+
+int main ()
+{
+ std::ofstream logfile ("extract_dofs_by_component_01x/output");
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+
+ deallog.push ("2d");
+ check<2> ();
+ deallog.pop ();
+}
--- /dev/null
+
+DEAL:2d::0000100010001001
--- /dev/null
+//---------------------------- extract_dofs_by_component_01y.cc ---------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2000, 2001, 2003, 2004, 2007, 2010, 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//---------------------------- extract_dofs_by_component_01y.cc ---------------------------
+
+
+// test internal::extract_dofs_by_component for some corner cases that
+// I was unsure about when refactoring some code in there
+//
+// this particular test checks the call path to
+// internal::extract_dofs_by_component from DoFTools::extract_dofs via
+// the component_select flag
+//
+// this is a variant of the _01x test that shows that we were doing something
+// wrong all along even on mainline but that nobody apparently ever realized
+// this. the bug is that internal::extract_dofs_by_component got things wrong
+// when a non-primitive element was part of an FESystem but it was
+// accidentally correct whenever there was only one such element; this test
+// verifies the same with two non-primitive elements in one FESystem
+
+
+#include "../tests.h"
+#include <deal.II/base/logstream.h>
+#include <deal.II/grid/tria.h>
+#include <deal.II/grid/tria_iterator.h>
+#include <deal.II/grid/tria_accessor.h>
+#include <deal.II/grid/grid_generator.h>
+#include <deal.II/dofs/dof_handler.h>
+#include <deal.II/fe/fe_dgq.h>
+#include <deal.II/fe/fe_raviart_thomas.h>
+#include <deal.II/fe/fe_nedelec.h>
+#include <deal.II/fe/fe_system.h>
+#include <deal.II/dofs/dof_tools.h>
+
+#include <fstream>
+
+
+
+
+template <int dim>
+void
+check ()
+{
+ Triangulation<dim> tr;
+ GridGenerator::hyper_cube(tr, -1,1);
+
+ FESystem<dim> element (FE_Nedelec<dim>(0), 2);
+ DoFHandler<dim> dof(tr);
+ dof.distribute_dofs(element);
+
+ // use a mask that only has the one
+ // component set and cycle over
+ // which one that is
+ for (unsigned int comp=0; comp<element.n_components(); ++comp)
+ {
+ std::vector<bool> component_mask (element.n_components(), false);
+ component_mask[comp] = true;
+
+ std::vector<bool> dofs (dof.n_dofs());
+ DoFTools::extract_dofs (dof, ComponentMask(component_mask), dofs);
+
+ for (unsigned int d=0; d<dof.n_dofs(); ++d)
+ deallog << dofs[d];
+ deallog << std::endl;
+ }
+}
+
+
+int main ()
+{
+ std::ofstream logfile ("extract_dofs_by_component_01y/output");
+ deallog << std::setprecision (2);
+ deallog << std::fixed;
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+
+ deallog.push ("2d");
+ check<2> ();
+ deallog.pop ();
+}
--- /dev/null
+
+DEAL:2d::10101010
+DEAL:2d::10101010
+DEAL:2d::01010101
+DEAL:2d::01010101
component_mask[c] = (int_mask & (1<<c));
std::vector<bool> dofs (dof.n_dofs());
- DoFTools::extract_dofs (dof, component_mask, dofs, true);
+ DoFTools::extract_dofs (dof, BlockMask(component_mask), dofs);
for (unsigned int d=0; d<dof.n_dofs(); ++d)
deallog << dofs[d];
component_mask[c] = (int_mask & (1<<c));
std::vector<bool> dofs (dof.n_dofs());
- DoFTools::extract_dofs (dof, component_mask, dofs, true);
+ DoFTools::extract_dofs (dof, BlockMask(component_mask), dofs);
for (unsigned int d=0; d<dof.n_dofs(); ++d)
deallog << dofs[d];
//
// this particular test checks the call path to
// internal::extract_dofs_by_component from DoFTools::extract_dofs via
-// the block_select flag
+// the BlockMask argument
#include "../tests.h"
deallog << "level=" << level << std::endl;
std::vector<bool> dofs (dof.n_dofs(level));
- DoFTools::extract_level_dofs (level, dof, component_mask, dofs, true);
+ DoFTools::extract_level_dofs (level, dof, BlockMask(component_mask), dofs);
for (unsigned int d=0; d<dofs.size(); ++d)
deallog << dofs[d];
DEAL:cg::Convergence step 13 value 0
DEAL::Memory consumption -- Triangulation: 2622
DEAL::Memory consumption -- DoFHandler: 952
-DEAL::Memory consumption -- FE: 1680
+DEAL::Memory consumption -- FE: 1800
DEAL::Memory consumption -- Constraints: 78
DEAL::Memory consumption -- Sparsity: 456
DEAL::Memory consumption -- Matrix: 632
DEAL:cg::Convergence step 16 value 0
DEAL::Memory consumption -- Triangulation: 3414
DEAL::Memory consumption -- DoFHandler: 1140
-DEAL::Memory consumption -- FE: 1680
+DEAL::Memory consumption -- FE: 1800
DEAL::Memory consumption -- Constraints: 78
DEAL::Memory consumption -- Sparsity: 576
DEAL::Memory consumption -- Matrix: 824
DEAL:cg::Convergence step 21 value 0
DEAL::Memory consumption -- Triangulation: 4166
DEAL::Memory consumption -- DoFHandler: 1332
-DEAL::Memory consumption -- FE: 1680
+DEAL::Memory consumption -- FE: 1800
DEAL::Memory consumption -- Constraints: 78
DEAL::Memory consumption -- Sparsity: 736
DEAL::Memory consumption -- Matrix: 1080
DEAL:cg::Convergence step 27 value 0
DEAL::Memory consumption -- Triangulation: 5118
DEAL::Memory consumption -- DoFHandler: 1560
-DEAL::Memory consumption -- FE: 1680
+DEAL::Memory consumption -- FE: 1800
DEAL::Memory consumption -- Constraints: 78
DEAL::Memory consumption -- Sparsity: 936
DEAL::Memory consumption -- Matrix: 1400
DEAL:cg::Convergence step 22 value 0
DEAL::Memory consumption -- Triangulation: 4739
DEAL::Memory consumption -- DoFHandler: 1912
-DEAL::Memory consumption -- FE: 13948
+DEAL::Memory consumption -- FE: 14308
DEAL::Memory consumption -- Constraints: 78
DEAL::Memory consumption -- Sparsity: 5736
DEAL::Memory consumption -- Matrix: 10616
DEAL:cg::Convergence step 30 value 0
DEAL::Memory consumption -- Triangulation: 9747
DEAL::Memory consumption -- DoFHandler: 3704
-DEAL::Memory consumption -- FE: 13948
+DEAL::Memory consumption -- FE: 14308
DEAL::Memory consumption -- Constraints: 3102
DEAL::Memory consumption -- Sparsity: 13992
DEAL::Memory consumption -- Matrix: 26168
DEAL:cg::Convergence step 51 value 0
DEAL::Memory consumption -- Triangulation: 19011
DEAL::Memory consumption -- DoFHandler: 7160
-DEAL::Memory consumption -- FE: 13948
+DEAL::Memory consumption -- FE: 14308
DEAL::Memory consumption -- Constraints: 10734
DEAL::Memory consumption -- Sparsity: 31240
DEAL::Memory consumption -- Matrix: 58744
DEAL:cg::Convergence step 71 value 0
DEAL::Memory consumption -- Triangulation: 38163
DEAL::Memory consumption -- DoFHandler: 14648
-DEAL::Memory consumption -- FE: 13948
+DEAL::Memory consumption -- FE: 14308
DEAL::Memory consumption -- Constraints: 19966
DEAL::Memory consumption -- Sparsity: 64168
DEAL::Memory consumption -- Matrix: 120824
DEAL:cg::Convergence step 29 value 0
DEAL::Memory consumption -- Triangulation: 22643
DEAL::Memory consumption -- DoFHandler: 9736
-DEAL::Memory consumption -- FE: 314524
+DEAL::Memory consumption -- FE: 315604
DEAL::Memory consumption -- Constraints: 78
DEAL::Memory consumption -- Sparsity: 120280
DEAL::Memory consumption -- Matrix: 236280
DEAL:cg::Convergence step 31 value 0
DEAL::Memory consumption -- Triangulation: 88881
DEAL::Memory consumption -- DoFHandler: 37972
-DEAL::Memory consumption -- FE: 314524
+DEAL::Memory consumption -- FE: 315604
DEAL::Memory consumption -- Constraints: 55262
DEAL::Memory consumption -- Sparsity: 567152
DEAL::Memory consumption -- Matrix: 1116424
DEAL:cg::Convergence step 55 value 0
DEAL::Memory consumption -- Triangulation: 355923
DEAL::Memory consumption -- DoFHandler: 151256
-DEAL::Memory consumption -- FE: 314524
+DEAL::Memory consumption -- FE: 315604
DEAL::Memory consumption -- Constraints: 367086
DEAL::Memory consumption -- Sparsity: 2517208
DEAL::Memory consumption -- Matrix: 4959288
DEAL:cg::Convergence step 82 value 0
DEAL::Memory consumption -- Triangulation: 1252759
DEAL::Memory consumption -- DoFHandler: 541984
-DEAL::Memory consumption -- FE: 314524
+DEAL::Memory consumption -- FE: 315604
DEAL::Memory consumption -- Constraints: 1307806
DEAL::Memory consumption -- Sparsity: 8321768
DEAL::Memory consumption -- Matrix: 16383928
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the BlockMask class
+//
+// here: test that creating a mask that's empty is always true
+
+
+#include "../tests.h"
+#include <deal.II/fe/block_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ BlockMask m;
+ Assert (m[0] == true, ExcInternalError());
+ Assert (m[42] == true, ExcInternalError());
+ Assert (m[1000000000] == true, ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("block_mask_01/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the BlockMask class
+//
+// here: test that creating a mask from a vector<bool> works
+
+
+#include "../tests.h"
+#include <deal.II/fe/block_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ std::vector<bool> v(12);
+ for (unsigned int i=0; i<v.size(); ++i)
+ v[i] = (i%3 == 0);
+
+ BlockMask m(v);
+
+ // verify equality
+ for (unsigned int i=0; i<v.size(); ++i)
+ Assert (m[i] == v[i], ExcInternalError());
+
+ // this needs to throw an exception
+ m[v.size()];
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ deal_II_exceptions::disable_abort_on_exception();
+ std::ofstream logfile ("block_mask_02/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::ExcIndexRange (block_index, 0, block_mask.size())
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the BlockMask class
+//
+// here: test that creating a mask with constant elements using the direct
+// constructor
+
+
+#include "../tests.h"
+#include <deal.II/fe/block_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ std::vector<bool> v(12, false);
+ BlockMask m(12, false);
+
+ // verify equality
+ for (unsigned int i=0; i<v.size(); ++i)
+ Assert (m[i] == v[i], ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("block_mask_03/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the BlockMask class
+//
+// here: test BlockMask::size()
+
+
+#include "../tests.h"
+#include <deal.II/fe/block_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ Assert (BlockMask(12, false).size() == 12, ExcInternalError());
+ Assert (BlockMask().size() == 0, ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("block_mask_04/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the BlockMask class
+//
+// here: BlockMask::represents_n_blocks
+
+
+#include "../tests.h"
+#include <deal.II/fe/block_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ // test for an initialized mask
+ Assert (BlockMask(12,false).represents_n_blocks(12) == true,
+ ExcInternalError());
+ Assert (BlockMask(12,false).represents_n_blocks(13) == false,
+ ExcInternalError());
+ // test for an empty mask
+ Assert (BlockMask().represents_n_blocks(12) == true,
+ ExcInternalError());
+ Assert (BlockMask().represents_n_blocks(13) == true,
+ ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("block_mask_05/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the BlockMask class
+//
+// here: BlockMask::n_selected_blocks
+
+
+#include "../tests.h"
+#include <deal.II/fe/block_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ // test for an initialized mask
+ Assert (BlockMask(12,true).n_selected_blocks() == 12,
+ ExcInternalError());
+ Assert (BlockMask(12,true).n_selected_blocks(12) == 12,
+ ExcInternalError());
+ // test for an empty mask
+ Assert (BlockMask().n_selected_blocks(12) == 12,
+ ExcInternalError());
+ Assert (BlockMask().n_selected_blocks(13) == 13,
+ ExcInternalError());
+
+
+ deallog << "OK" << std::endl;
+
+ // this now must throw an exception,
+ // though:
+ Assert (BlockMask(12,true).n_selected_blocks(13) == 12,
+ ExcInternalError());
+}
+
+
+int main()
+{
+ deal_II_exceptions::disable_abort_on_exception();
+
+ std::ofstream logfile ("block_mask_06/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
+DEAL::ExcDimensionMismatch((n),(size()))
+DEAL::ExcDimensionMismatch((real_n),(block_mask.size()))
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the BlockMask class
+//
+// here: BlockMask::first_selected_block
+
+
+#include "../tests.h"
+#include <deal.II/fe/block_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ std::vector<bool> v(12,false);
+ v[3] = true;
+
+ BlockMask m(v);
+
+ // test for an initialized mask
+ Assert (m.first_selected_block() == 3,
+ ExcInternalError());
+ Assert (BlockMask(12,true).first_selected_block() == 0,
+ ExcInternalError());
+ // test for an empty mask
+ Assert (BlockMask().first_selected_block(12) == 0,
+ ExcInternalError());
+
+ deallog << "OK" << std::endl;
+
+ // the following should yield an exception:
+ Assert (BlockMask(12,true).first_selected_block(13) == 0,
+ ExcInternalError());
+ // as should this:
+ Assert (BlockMask(12,false).first_selected_block() == 0,
+ ExcInternalError());
+}
+
+
+int main()
+{
+ deal_II_exceptions::disable_abort_on_exception();
+
+ std::ofstream logfile ("block_mask_07/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
+DEAL::ExcDimensionMismatch((n),(size()))
+DEAL::ExcMessage ("No block is selected at all!")
+DEAL::ExcInternalError()
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the BlockMask class
+//
+// here: BlockMask::represents_the_all_selected_mask
+
+
+#include "../tests.h"
+#include <deal.II/fe/block_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ // test for an initialized mask
+ Assert (BlockMask(12,false).represents_the_all_selected_mask() == false,
+ ExcInternalError());
+ // note the semantics of the following as
+ // described in the documentation
+ Assert (BlockMask(12,true).represents_the_all_selected_mask() == false,
+ ExcInternalError());
+ // test for an empty mask
+ Assert (BlockMask().represents_the_all_selected_mask() == true,
+ ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("block_mask_08/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the BlockMask class
+//
+// here: BlockMask::operator|
+
+
+#include "../tests.h"
+#include <deal.II/fe/block_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ std::vector<bool> v1(12);
+ for (unsigned int i=0; i<v1.size(); ++i)
+ v1[i] = (i%3 == 0);
+ std::vector<bool> v2(12);
+ for (unsigned int i=0; i<v2.size(); ++i)
+ v2[2] = (i%4 == 0);
+
+ BlockMask m1(v1);
+ BlockMask m2(v2);
+ BlockMask m = m1 | m2;
+
+ // verify equality
+ for (unsigned int i=0; i<v1.size(); ++i)
+ Assert (m[i] == (v1[i] || v2[i]), ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("block_mask_09/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the BlockMask class
+//
+// here: BlockMask::operator&
+
+
+#include "../tests.h"
+#include <deal.II/fe/block_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ std::vector<bool> v1(12);
+ for (unsigned int i=0; i<v1.size(); ++i)
+ v1[i] = (i%3 == 0);
+ std::vector<bool> v2(12);
+ for (unsigned int i=0; i<v2.size(); ++i)
+ v2[2] = (i%4 == 0);
+
+ BlockMask m1(v1);
+ BlockMask m2(v2);
+ BlockMask m = m1 & m2;
+
+ // verify equality
+ for (unsigned int i=0; i<v1.size(); ++i)
+ Assert (m[i] == (v1[i] && v2[i]), ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("block_mask_10/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the BlockMask class
+//
+// here: BlockMask::operator==
+
+
+#include "../tests.h"
+#include <deal.II/fe/block_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ std::vector<bool> v1(12);
+ for (unsigned int i=0; i<v1.size(); ++i)
+ v1[i] = (i%3 == 0);
+ std::vector<bool> v2(12);
+ for (unsigned int i=0; i<v2.size(); ++i)
+ v2[i] = (i%4 == 0);
+
+ std::vector<bool> v(12);
+ for (unsigned int i=0; i<v.size(); ++i)
+ v[i] = (v1[i] || v2[i]);
+
+ BlockMask m1(v1);
+ BlockMask m2(v2);
+ BlockMask m = m1 | m2;
+
+ // verify equality
+ Assert (m == BlockMask(v),
+ ExcInternalError());
+ Assert (!(m == m1),
+ ExcInternalError());
+ Assert (!(m == BlockMask(v1)),
+ ExcInternalError());
+ Assert (!(m == BlockMask(v2)),
+ ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("block_mask_11/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the ComponentMask class
+//
+// here: test that creating a mask that's empty is always true
+
+
+#include "../tests.h"
+#include <deal.II/fe/component_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ ComponentMask m;
+ Assert (m[0] == true, ExcInternalError());
+ Assert (m[42] == true, ExcInternalError());
+ Assert (m[1000000000] == true, ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("component_mask_01/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the ComponentMask class
+//
+// here: test that creating a mask from a vector<bool> works
+
+
+#include "../tests.h"
+#include <deal.II/fe/component_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ std::vector<bool> v(12);
+ for (unsigned int i=0; i<v.size(); ++i)
+ v[i] = (i%3 == 0);
+
+ ComponentMask m(v);
+
+ // verify equality
+ for (unsigned int i=0; i<v.size(); ++i)
+ Assert (m[i] == v[i], ExcInternalError());
+
+ // this needs to throw an exception
+ m[v.size()];
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ deal_II_exceptions::disable_abort_on_exception();
+ std::ofstream logfile ("component_mask_02/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::ExcIndexRange (component_index, 0, component_mask.size())
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the ComponentMask class
+//
+// here: test that creating a mask with constant elements using the direct
+// constructor
+
+
+#include "../tests.h"
+#include <deal.II/fe/component_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ std::vector<bool> v(12, false);
+ ComponentMask m(12, false);
+
+ // verify equality
+ for (unsigned int i=0; i<v.size(); ++i)
+ Assert (m[i] == v[i], ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("component_mask_03/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the ComponentMask class
+//
+// here: test ComponentMask::size()
+
+
+#include "../tests.h"
+#include <deal.II/fe/component_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ Assert (ComponentMask(12, false).size() == 12, ExcInternalError());
+ Assert (ComponentMask().size() == 0, ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("component_mask_04/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the ComponentMask class
+//
+// here: ComponentMask::represents_n_components
+
+
+#include "../tests.h"
+#include <deal.II/fe/component_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ // test for an initialized mask
+ Assert (ComponentMask(12,false).represents_n_components(12) == true,
+ ExcInternalError());
+ Assert (ComponentMask(12,false).represents_n_components(13) == false,
+ ExcInternalError());
+ // test for an empty mask
+ Assert (ComponentMask().represents_n_components(12) == true,
+ ExcInternalError());
+ Assert (ComponentMask().represents_n_components(13) == true,
+ ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("component_mask_05/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the ComponentMask class
+//
+// here: ComponentMask::n_selected_components
+
+
+#include "../tests.h"
+#include <deal.II/fe/component_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ // test for an initialized mask
+ Assert (ComponentMask(12,true).n_selected_components() == 12,
+ ExcInternalError());
+ Assert (ComponentMask(12,true).n_selected_components(12) == 12,
+ ExcInternalError());
+ // test for an empty mask
+ Assert (ComponentMask().n_selected_components(12) == 12,
+ ExcInternalError());
+ Assert (ComponentMask().n_selected_components(13) == 13,
+ ExcInternalError());
+
+
+ deallog << "OK" << std::endl;
+
+ // this now must throw an exception,
+ // though:
+ Assert (ComponentMask(12,true).n_selected_components(13) == 12,
+ ExcInternalError());
+}
+
+
+int main()
+{
+ deal_II_exceptions::disable_abort_on_exception();
+
+ std::ofstream logfile ("component_mask_06/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
+DEAL::ExcDimensionMismatch((n),(size()))
+DEAL::ExcDimensionMismatch((real_n),(component_mask.size()))
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the ComponentMask class
+//
+// here: ComponentMask::first_selected_component
+
+
+#include "../tests.h"
+#include <deal.II/fe/component_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ std::vector<bool> v(12,false);
+ v[3] = true;
+
+ ComponentMask m(v);
+
+ // test for an initialized mask
+ Assert (m.first_selected_component() == 3,
+ ExcInternalError());
+ Assert (ComponentMask(12,true).first_selected_component() == 0,
+ ExcInternalError());
+ // test for an empty mask
+ Assert (ComponentMask().first_selected_component(12) == 0,
+ ExcInternalError());
+
+ deallog << "OK" << std::endl;
+
+ // the following should yield an exception:
+ Assert (ComponentMask(12,true).first_selected_component(13) == 0,
+ ExcInternalError());
+ // as should this:
+ Assert (ComponentMask(12,false).first_selected_component() == 0,
+ ExcInternalError());
+}
+
+
+int main()
+{
+ deal_II_exceptions::disable_abort_on_exception();
+
+ std::ofstream logfile ("component_mask_07/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
+DEAL::ExcDimensionMismatch((n),(size()))
+DEAL::ExcMessage ("No component is selected at all!")
+DEAL::ExcInternalError()
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the ComponentMask class
+//
+// here: ComponentMask::represents_the_all_selected_mask
+
+
+#include "../tests.h"
+#include <deal.II/fe/component_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ // test for an initialized mask
+ Assert (ComponentMask(12,false).represents_the_all_selected_mask() == false,
+ ExcInternalError());
+ // note the semantics of the following as
+ // described in the documentation
+ Assert (ComponentMask(12,true).represents_the_all_selected_mask() == false,
+ ExcInternalError());
+ // test for an empty mask
+ Assert (ComponentMask().represents_the_all_selected_mask() == true,
+ ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("component_mask_08/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the ComponentMask class
+//
+// here: ComponentMask::operator|
+
+
+#include "../tests.h"
+#include <deal.II/fe/component_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ std::vector<bool> v1(12);
+ for (unsigned int i=0; i<v1.size(); ++i)
+ v1[i] = (i%3 == 0);
+ std::vector<bool> v2(12);
+ for (unsigned int i=0; i<v2.size(); ++i)
+ v2[2] = (i%4 == 0);
+
+ ComponentMask m1(v1);
+ ComponentMask m2(v2);
+ ComponentMask m = m1 | m2;
+
+ // verify equality
+ for (unsigned int i=0; i<v1.size(); ++i)
+ Assert (m[i] == (v1[i] || v2[i]), ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("component_mask_09/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the ComponentMask class
+//
+// here: ComponentMask::operator&
+
+
+#include "../tests.h"
+#include <deal.II/fe/component_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ std::vector<bool> v1(12);
+ for (unsigned int i=0; i<v1.size(); ++i)
+ v1[i] = (i%3 == 0);
+ std::vector<bool> v2(12);
+ for (unsigned int i=0; i<v2.size(); ++i)
+ v2[2] = (i%4 == 0);
+
+ ComponentMask m1(v1);
+ ComponentMask m2(v2);
+ ComponentMask m = m1 & m2;
+
+ // verify equality
+ for (unsigned int i=0; i<v1.size(); ++i)
+ Assert (m[i] == (v1[i] && v2[i]), ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("component_mask_10/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the ComponentMask class
+//
+// here: ComponentMask::operator==
+
+
+#include "../tests.h"
+#include <deal.II/fe/component_mask.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ std::vector<bool> v1(12);
+ for (unsigned int i=0; i<v1.size(); ++i)
+ v1[i] = (i%3 == 0);
+ std::vector<bool> v2(12);
+ for (unsigned int i=0; i<v2.size(); ++i)
+ v2[i] = (i%4 == 0);
+
+ std::vector<bool> v(12);
+ for (unsigned int i=0; i<v.size(); ++i)
+ v[i] = (v1[i] || v2[i]);
+
+ ComponentMask m1(v1);
+ ComponentMask m2(v2);
+ ComponentMask m = m1 | m2;
+
+ // verify equality
+ Assert (m == ComponentMask(v),
+ ExcInternalError());
+ Assert (!(m == m1),
+ ExcInternalError());
+ Assert (!(m == ComponentMask(v1)),
+ ExcInternalError());
+ Assert (!(m == ComponentMask(v2)),
+ ExcInternalError());
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("component_mask_11/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the ComponentMask class
+//
+// here: test conversion from component mask to block mask and back
+
+
+#include "../tests.h"
+#include <deal.II/fe/component_mask.h>
+#include <deal.II/fe/fe_system.h>
+#include <deal.II/fe/fe_q.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ // the following element has as
+ // many components as blocks so
+ // that any component mask we come
+ // up with should also produce a
+ // valid block mask (in fact, it
+ // should be exactly the same mask)
+ FESystem<2> fe (FE_Q<2>(1), 5);
+
+ // try all possible component
+ // masks, which we encode as bit
+ // strings
+ for (unsigned int int_mask=0; int_mask<(1U<<fe.n_components()); ++int_mask)
+ {
+ std::vector<bool> component_mask (fe.n_components());
+ for (unsigned int c=0; c<fe.n_components(); ++c)
+ component_mask[c] = (int_mask & (1<<c));
+
+ // make sure that the round-trip works
+ Assert (ComponentMask(component_mask) == fe.component_mask(fe.block_mask(ComponentMask(component_mask))),
+ ExcInternalError());
+
+ // then compare elementwise with
+ // the block mask (where there is
+ // no direct comparison operator,
+ // but they should be the same
+ // because each component of the
+ // element corresponds to a
+ // block)
+ for (unsigned int c=0; c<fe.n_components(); ++c)
+ Assert (component_mask[c] == fe.block_mask(component_mask)[c],
+ ExcInternalError());
+ }
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("component_mask_12/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the ComponentMask class
+//
+// here: test conversion from component mask to block mask and back. start with
+// blocks where the _12 test starts with components, and use an element that
+// does have fewer blocks than components
+
+
+#include "../tests.h"
+#include <deal.II/fe/component_mask.h>
+#include <deal.II/fe/fe_system.h>
+#include <deal.II/fe/fe_raviart_thomas.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ // the following element has more
+ // components than blocks
+ FESystem<2> fe (FE_RaviartThomas<2>(1), 3);
+
+ // try all possible block
+ // masks, which we encode as bit
+ // strings
+ for (unsigned int int_mask=0; int_mask<(1U<<fe.n_blocks()); ++int_mask)
+ {
+ std::vector<bool> block_mask (fe.n_blocks());
+ for (unsigned int c=0; c<fe.n_blocks(); ++c)
+ block_mask[c] = (int_mask & (1<<c));
+
+ // make sure that the round-trip works
+ Assert (BlockMask(block_mask) == fe.block_mask(fe.component_mask(BlockMask(block_mask))),
+ ExcInternalError());
+ }
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ std::ofstream logfile ("component_mask_13/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::OK
--- /dev/null
+//----------------------------------------------------------------------
+// $Id$
+// Version: $Name$
+//
+// Copyright (C) 2012 by the deal.II authors
+//
+// This file is subject to QPL and may not be distributed
+// without copyright and license information. Please refer
+// to the file deal.II/doc/license.html for the text and
+// further information on this license.
+//
+//----------------------------------------------------------------------
+
+
+// tests for the ComponentMask class
+//
+// here: test conversion from component mask to block mask does indeed
+// not work if we try to split a block
+
+
+#include "../tests.h"
+#include <deal.II/fe/component_mask.h>
+#include <deal.II/fe/fe_system.h>
+#include <deal.II/fe/fe_raviart_thomas.h>
+
+#include <fstream>
+#include <iomanip>
+
+
+
+
+void test ()
+{
+ // the following element has more
+ // components than blocks
+ FESystem<2> fe (FE_RaviartThomas<2>(1), 2);
+
+ // try all possible component
+ // masks, which we encode as bit
+ // strings
+ for (unsigned int int_mask=0; int_mask<(1U<<fe.n_components()); ++int_mask)
+ {
+ std::vector<bool> component_mask (fe.n_components());
+ for (unsigned int c=0; c<fe.n_components(); ++c)
+ component_mask[c] = (int_mask & (1<<c));
+
+ // now try to convert to a block
+ // mask. this should not always
+ // work
+ deallog << fe.block_mask (component_mask) << std::endl;
+ }
+
+ deallog << "OK" << std::endl;
+}
+
+
+int main()
+{
+ deal_II_exceptions::disable_abort_on_exception();
+
+ std::ofstream logfile ("component_mask_14/output");
+ deallog << std::setprecision (4);
+
+ deallog.attach(logfile);
+ deallog.depth_console (0);
+ deallog.threshold_double(1.e-7);
+
+ test();
+}
--- /dev/null
+
+DEAL::[false,false]
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::[true,false]
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::[false,false]
+DEAL::[true,false]
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::[false,true]
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::[true,true]
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::[false,true]
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::[true,true]
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::[false,false]
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::[true,false]
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::[false,false]
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::[true,false]
+DEAL::[false,true]
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::[true,true]
+DEAL::ExcMessage ("The component mask argument given to this function " "is not a mask where the individual components belonging " "to one block of the finite element are either all " "selected or not selected. You can't call this function " "with a component mask that splits blocks.")
+DEAL::[false,true]
+DEAL::[true,true]
+DEAL::OK
DEAL::-0.00681584 0.0298193 0.0758263 0.0150517 -0.0343364 0.150222 0.381993 0.0758263 -0.0135031 0.0590760 0.150222 0.0298193 0.00308642 -0.0135031 -0.0343364 -0.00681584
DEAL::0.00425990 -0.0144837 0.00851980 0.0105078 0.0214603 -0.0729649 0.0429205 0.0529353 0.00843943 -0.0286941 0.0168789 0.0208173 -0.00192901 0.00655864 -0.00385802 -0.00475823
DEAL::-0.0153356 0.0230035 0.0230035 -0.00766782 -0.0772569 0.115885 0.115885 -0.0386285 -0.0303819 0.0455729 0.0455729 -0.0151910 0.00694444 -0.0104167 -0.0104167 0.00347222
-DEAL::-0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585938 0.472656 0.644531 -0.515625 -0.0429687
+DEAL::-0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585937 0.472656 0.644531 -0.515625 -0.0429687
DEAL::0.00347222 -0.0151910 -0.0386285 -0.00766782 0.0416667 -0.182292 -0.463542 -0.0920139 -0.0520833 0.227865 0.579427 0.115017 -0.0381944 0.167101 0.424913 0.0843461
DEAL::-0.00217014 0.00737847 -0.00434028 -0.00535301 -0.0260417 0.0885417 -0.0520833 -0.0642361 0.0325521 -0.110677 0.0651042 0.0802951 0.0238715 -0.0811632 0.0477431 0.0588831
DEAL::0.00781250 -0.0117187 -0.0117188 0.00390625 0.0937500 -0.140625 -0.140625 0.0468750 -0.117188 0.175781 0.175781 -0.0585938 -0.0859375 0.128906 0.128906 -0.0429688
DEAL::-0.0120850 0.0161133 0.0120850 0.0483398 -0.0644531 -0.0483398 0.0281982 -0.0375977 -0.0281982 -0.0131836 0.0175781 0.0131836 0.0527344 -0.0703125 -0.0527344 0.0307617 -0.0410156 -0.0307617 0.00329590 -0.00439453 -0.00329590 -0.0131836 0.0175781 0.0131836 -0.00769043 0.0102539 0.00769043
DEAL::0.0886230 0.0966797 -0.0241699 -0.118164 -0.128906 0.0322266 -0.0886230 -0.0966797 0.0241699 0.0966797 0.105469 -0.0263672 -0.128906 -0.140625 0.0351563 -0.0966797 -0.105469 0.0263672 -0.0241699 -0.0263672 0.00659180 0.0322266 0.0351563 -0.00878906 0.0241699 0.0263672 -0.00659180
DEAL::-0.0120850 0.0483398 0.0281982 0.0161133 -0.0644531 -0.0375977 0.0120850 -0.0483398 -0.0281982 -0.0131836 0.0527344 0.0307617 0.0175781 -0.0703125 -0.0410156 0.0131836 -0.0527344 -0.0307617 0.00329590 -0.0131836 -0.00769043 -0.00439453 0.0175781 0.0102539 -0.00329590 0.0131836 0.00769043
-DEAL::0.0241699 -0.0322266 -0.0241699 -0.0322266 0.0429687 0.0322266 -0.0241699 0.0322266 0.0241699 0.0263672 -0.0351562 -0.0263672 -0.0351563 0.0468750 0.0351563 -0.0263672 0.0351563 0.0263672 -0.00659180 0.00878906 0.00659180 0.00878906 -0.0117187 -0.00878906 0.00659180 -0.00878906 -0.00659180
+DEAL::0.0241699 -0.0322266 -0.0241699 -0.0322266 0.0429687 0.0322266 -0.0241699 0.0322266 0.0241699 0.0263672 -0.0351563 -0.0263672 -0.0351563 0.0468750 0.0351563 -0.0263672 0.0351563 0.0263672 -0.00659180 0.00878906 0.00659180 0.00878906 -0.0117187 -0.00878906 0.00659180 -0.00878906 -0.00659180
DEAL::-0.0443115 -0.0483398 0.0120850 -0.0483398 -0.0527344 0.0131836 0.0120850 0.0131836 -0.00329590 0.177246 0.193359 -0.0483398 0.193359 0.210938 -0.0527344 -0.0483398 -0.0527344 0.0131836 0.103394 0.112793 -0.0281982 0.112793 0.123047 -0.0307617 -0.0281982 -0.0307617 0.00769043
DEAL::0.00604248 -0.0241699 -0.0140991 0.00659180 -0.0263672 -0.0153809 -0.00164795 0.00659180 0.00384521 -0.0241699 0.0966797 0.0563965 -0.0263672 0.105469 0.0615234 0.00659180 -0.0263672 -0.0153809 -0.0140991 0.0563965 0.0328979 -0.0153809 0.0615234 0.0358887 0.00384521 -0.0153809 -0.00897217
DEAL::-0.0120850 0.0161133 0.0120850 -0.0131836 0.0175781 0.0131836 0.00329590 -0.00439453 -0.00329590 0.0483398 -0.0644531 -0.0483398 0.0527344 -0.0703125 -0.0527344 -0.0131836 0.0175781 0.0131836 0.0281982 -0.0375977 -0.0281982 0.0307617 -0.0410156 -0.0307617 -0.00769043 0.0102539 0.00769043
DEAL::-0.0120850 -0.0131836 0.00329590 0.0161133 0.0175781 -0.00439453 0.0120850 0.0131836 -0.00329590 0.0483398 0.0527344 -0.0131836 -0.0644531 -0.0703125 0.0175781 -0.0483398 -0.0527344 0.0131836 0.0281982 0.0307617 -0.00769043 -0.0375977 -0.0410156 0.0102539 -0.0281982 -0.0307617 0.00769043
DEAL::0.00164795 -0.00659180 -0.00384521 -0.00219727 0.00878906 0.00512695 -0.00164795 0.00659180 0.00384521 -0.00659180 0.0263672 0.0153809 0.00878906 -0.0351562 -0.0205078 0.00659180 -0.0263672 -0.0153809 -0.00384521 0.0153809 0.00897217 0.00512695 -0.0205078 -0.0119629 0.00384521 -0.0153809 -0.00897217
DEAL::-0.00329590 0.00439453 0.00329590 0.00439453 -0.00585937 -0.00439453 0.00329590 -0.00439453 -0.00329590 0.0131836 -0.0175781 -0.0131836 -0.0175781 0.0234375 0.0175781 -0.0131836 0.0175781 0.0131836 0.00769043 -0.0102539 -0.00769043 -0.0102539 0.0136719 0.0102539 -0.00769043 0.0102539 0.00769043
-DEAL::0.0886230 0.0966797 -0.0241699 0.0966797 0.105469 -0.0263672 -0.0241699 -0.0263672 0.00659180 -0.118164 -0.128906 0.0322266 -0.128906 -0.140625 0.0351562 0.0322266 0.0351563 -0.00878906 -0.0886230 -0.0966797 0.0241699 -0.0966797 -0.105469 0.0263672 0.0241699 0.0263672 -0.00659180
+DEAL::0.0886230 0.0966797 -0.0241699 0.0966797 0.105469 -0.0263672 -0.0241699 -0.0263672 0.00659180 -0.118164 -0.128906 0.0322266 -0.128906 -0.140625 0.0351563 0.0322266 0.0351563 -0.00878906 -0.0886230 -0.0966797 0.0241699 -0.0966797 -0.105469 0.0263672 0.0241699 0.0263672 -0.00659180
DEAL::-0.0120850 0.0483398 0.0281982 -0.0131836 0.0527344 0.0307617 0.00329590 -0.0131836 -0.00769043 0.0161133 -0.0644531 -0.0375977 0.0175781 -0.0703125 -0.0410156 -0.00439453 0.0175781 0.0102539 0.0120850 -0.0483398 -0.0281982 0.0131836 -0.0527344 -0.0307617 -0.00329590 0.0131836 0.00769043
-DEAL::0.0241699 -0.0322266 -0.0241699 0.0263672 -0.0351563 -0.0263672 -0.00659180 0.00878906 0.00659180 -0.0322266 0.0429687 0.0322266 -0.0351563 0.0468750 0.0351562 0.00878906 -0.0117187 -0.00878906 -0.0241699 0.0322266 0.0241699 -0.0263672 0.0351562 0.0263672 0.00659180 -0.00878906 -0.00659180
+DEAL::0.0241699 -0.0322266 -0.0241699 0.0263672 -0.0351563 -0.0263672 -0.00659180 0.00878906 0.00659180 -0.0322266 0.0429687 0.0322266 -0.0351563 0.0468750 0.0351563 0.00878906 -0.0117187 -0.00878906 -0.0241699 0.0322266 0.0241699 -0.0263672 0.0351562 0.0263672 0.00659180 -0.00878906 -0.00659180
DEAL::-0.0120850 -0.0131836 0.00329590 0.0483398 0.0527344 -0.0131836 0.0281982 0.0307617 -0.00769043 0.0161133 0.0175781 -0.00439453 -0.0644531 -0.0703125 0.0175781 -0.0375977 -0.0410156 0.0102539 0.0120850 0.0131836 -0.00329590 -0.0483398 -0.0527344 0.0131836 -0.0281982 -0.0307617 0.00769043
DEAL::0.00164795 -0.00659180 -0.00384521 -0.00659180 0.0263672 0.0153809 -0.00384521 0.0153809 0.00897217 -0.00219727 0.00878906 0.00512695 0.00878906 -0.0351562 -0.0205078 0.00512695 -0.0205078 -0.0119629 -0.00164795 0.00659180 0.00384521 0.00659180 -0.0263672 -0.0153809 0.00384521 -0.0153809 -0.00897217
DEAL::-0.00329590 0.00439453 0.00329590 0.0131836 -0.0175781 -0.0131836 0.00769043 -0.0102539 -0.00769043 0.00439453 -0.00585937 -0.00439453 -0.0175781 0.0234375 0.0175781 -0.0102539 0.0136719 0.0102539 0.00329590 -0.00439453 -0.00329590 -0.0131836 0.0175781 0.0131836 -0.00769043 0.0102539 0.00769043
DEAL::0.0120850 0.0161133 -0.0120850 0.0131836 0.0175781 -0.0131836 -0.00329590 -0.00439453 0.00329590 -0.0483398 -0.0644531 0.0483398 -0.0527344 -0.0703125 0.0527344 0.0131836 0.0175781 -0.0131836 -0.0281982 -0.0375977 0.0281982 -0.0307617 -0.0410156 0.0307617 0.00769043 0.0102539 -0.00769043
DEAL::-0.0140991 -0.0241699 0.00604248 -0.0153809 -0.0263672 0.00659180 0.00384521 0.00659180 -0.00164795 0.0563965 0.0966797 -0.0241699 0.0615234 0.105469 -0.0263672 -0.0153809 -0.0263672 0.00659180 0.0328979 0.0563965 -0.0140991 0.0358887 0.0615234 -0.0153809 -0.00897217 -0.0153809 0.00384521
DEAL::0.0120850 -0.0483398 -0.0443115 0.0131836 -0.0527344 -0.0483398 -0.00329590 0.0131836 0.0120850 -0.0483398 0.193359 0.177246 -0.0527344 0.210938 0.193359 0.0131836 -0.0527344 -0.0483398 -0.0281982 0.112793 0.103394 -0.0307617 0.123047 0.112793 0.00769043 -0.0307617 -0.0281982
-DEAL::-0.00164795 -0.00219727 0.00164795 0.00659180 0.00878906 -0.00659180 0.00384521 0.00512695 -0.00384521 0.00659180 0.00878906 -0.00659180 -0.0263672 -0.0351563 0.0263672 -0.0153809 -0.0205078 0.0153809 0.00384521 0.00512695 -0.00384521 -0.0153809 -0.0205078 0.0153809 -0.00897217 -0.0119629 0.00897217
+DEAL::-0.00164795 -0.00219727 0.00164795 0.00659180 0.00878906 -0.00659180 0.00384521 0.00512695 -0.00384521 0.00659180 0.00878906 -0.00659180 -0.0263672 -0.0351562 0.0263672 -0.0153809 -0.0205078 0.0153809 0.00384521 0.00512695 -0.00384521 -0.0153809 -0.0205078 0.0153809 -0.00897217 -0.0119629 0.00897217
DEAL::0.00192261 0.00329590 -0.000823975 -0.00769043 -0.0131836 0.00329590 -0.00448608 -0.00769043 0.00192261 -0.00769043 -0.0131836 0.00329590 0.0307617 0.0527344 -0.0131836 0.0179443 0.0307617 -0.00769043 -0.00448608 -0.00769043 0.00192261 0.0179443 0.0307617 -0.00769043 0.0104675 0.0179443 -0.00448608
DEAL::-0.00164795 0.00659180 0.00604248 0.00659180 -0.0263672 -0.0241699 0.00384521 -0.0153809 -0.0140991 0.00659180 -0.0263672 -0.0241699 -0.0263672 0.105469 0.0966797 -0.0153809 0.0615234 0.0563965 0.00384521 -0.0153809 -0.0140991 -0.0153809 0.0615234 0.0563965 -0.00897217 0.0358887 0.0328979
DEAL::0.00329590 0.00439453 -0.00329590 -0.00439453 -0.00585937 0.00439453 -0.00329590 -0.00439453 0.00329590 -0.0131836 -0.0175781 0.0131836 0.0175781 0.0234375 -0.0175781 0.0131836 0.0175781 -0.0131836 -0.00769043 -0.0102539 0.00769043 0.0102539 0.0136719 -0.0102539 0.00769043 0.0102539 -0.00769043
DEAL::-0.00384521 -0.00659180 0.00164795 0.00512695 0.00878906 -0.00219727 0.00384521 0.00659180 -0.00164795 0.0153809 0.0263672 -0.00659180 -0.0205078 -0.0351562 0.00878906 -0.0153809 -0.0263672 0.00659180 0.00897217 0.0153809 -0.00384521 -0.0119629 -0.0205078 0.00512695 -0.00897217 -0.0153809 0.00384521
DEAL::0.00329590 -0.0131836 -0.0120850 -0.00439453 0.0175781 0.0161133 -0.00329590 0.0131836 0.0120850 -0.0131836 0.0527344 0.0483398 0.0175781 -0.0703125 -0.0644531 0.0131836 -0.0527344 -0.0483398 -0.00769043 0.0307617 0.0281982 0.0102539 -0.0410156 -0.0375977 0.00769043 -0.0307617 -0.0281982
-DEAL::-0.0241699 -0.0322266 0.0241699 -0.0263672 -0.0351563 0.0263672 0.00659180 0.00878906 -0.00659180 0.0322266 0.0429687 -0.0322266 0.0351562 0.0468750 -0.0351563 -0.00878906 -0.0117187 0.00878906 0.0241699 0.0322266 -0.0241699 0.0263672 0.0351562 -0.0263672 -0.00659180 -0.00878906 0.00659180
+DEAL::-0.0241699 -0.0322266 0.0241699 -0.0263672 -0.0351563 0.0263672 0.00659180 0.00878906 -0.00659180 0.0322266 0.0429687 -0.0322266 0.0351563 0.0468750 -0.0351563 -0.00878906 -0.0117187 0.00878906 0.0241699 0.0322266 -0.0241699 0.0263672 0.0351563 -0.0263672 -0.00659180 -0.00878906 0.00659180
DEAL::0.0281982 0.0483398 -0.0120850 0.0307617 0.0527344 -0.0131836 -0.00769043 -0.0131836 0.00329590 -0.0375977 -0.0644531 0.0161133 -0.0410156 -0.0703125 0.0175781 0.0102539 0.0175781 -0.00439453 -0.0281982 -0.0483398 0.0120850 -0.0307617 -0.0527344 0.0131836 0.00769043 0.0131836 -0.00329590
DEAL::-0.0241699 0.0966797 0.0886230 -0.0263672 0.105469 0.0966797 0.00659180 -0.0263672 -0.0241699 0.0322266 -0.128906 -0.118164 0.0351562 -0.140625 -0.128906 -0.00878906 0.0351563 0.0322266 0.0241699 -0.0966797 -0.0886230 0.0263672 -0.105469 -0.0966797 -0.00659180 0.0263672 0.0241699
DEAL::0.00329590 0.00439453 -0.00329590 -0.0131836 -0.0175781 0.0131836 -0.00769043 -0.0102539 0.00769043 -0.00439453 -0.00585937 0.00439453 0.0175781 0.0234375 -0.0175781 0.0102539 0.0136719 -0.0102539 -0.00329590 -0.00439453 0.00329590 0.0131836 0.0175781 -0.0131836 0.00769043 0.0102539 -0.00769043
DEAL::0.0120850 -0.0483398 -0.0281982 -0.0483398 0.193359 0.112793 -0.0443115 0.177246 0.103394 0.0131836 -0.0527344 -0.0307617 -0.0527344 0.210937 0.123047 -0.0483398 0.193359 0.112793 -0.00329590 0.0131836 0.00769043 0.0131836 -0.0527344 -0.0307617 0.0120850 -0.0483398 -0.0281982
DEAL::-0.0241699 0.0322266 0.0241699 0.0966797 -0.128906 -0.0966797 0.0886230 -0.118164 -0.0886230 -0.0263672 0.0351563 0.0263672 0.105469 -0.140625 -0.105469 0.0966797 -0.128906 -0.0966797 0.00659180 -0.00878906 -0.00659180 -0.0263672 0.0351563 0.0263672 -0.0241699 0.0322266 0.0241699
DEAL::0.0120850 0.0131836 -0.00329590 0.0161133 0.0175781 -0.00439453 -0.0120850 -0.0131836 0.00329590 -0.0483398 -0.0527344 0.0131836 -0.0644531 -0.0703125 0.0175781 0.0483398 0.0527344 -0.0131836 -0.0281982 -0.0307617 0.00769043 -0.0375977 -0.0410156 0.0102539 0.0281982 0.0307617 -0.00769043
-DEAL::-0.00164795 0.00659180 0.00384521 -0.00219727 0.00878906 0.00512695 0.00164795 -0.00659180 -0.00384521 0.00659180 -0.0263672 -0.0153809 0.00878906 -0.0351562 -0.0205078 -0.00659180 0.0263672 0.0153809 0.00384521 -0.0153809 -0.00897217 0.00512695 -0.0205078 -0.0119629 -0.00384521 0.0153809 0.00897217
+DEAL::-0.00164795 0.00659180 0.00384521 -0.00219727 0.00878906 0.00512695 0.00164795 -0.00659180 -0.00384521 0.00659180 -0.0263672 -0.0153809 0.00878906 -0.0351563 -0.0205078 -0.00659180 0.0263672 0.0153809 0.00384521 -0.0153809 -0.00897217 0.00512695 -0.0205078 -0.0119629 -0.00384521 0.0153809 0.00897217
DEAL::0.00329590 -0.00439453 -0.00329590 0.00439453 -0.00585937 -0.00439453 -0.00329590 0.00439453 0.00329590 -0.0131836 0.0175781 0.0131836 -0.0175781 0.0234375 0.0175781 0.0131836 -0.0175781 -0.0131836 -0.00769043 0.0102539 0.00769043 -0.0102539 0.0136719 0.0102539 0.00769043 -0.0102539 -0.00769043
DEAL::-0.0140991 -0.0153809 0.00384521 -0.0241699 -0.0263672 0.00659180 0.00604248 0.00659180 -0.00164795 0.0563965 0.0615234 -0.0153809 0.0966797 0.105469 -0.0263672 -0.0241699 -0.0263672 0.00659180 0.0328979 0.0358887 -0.00897217 0.0563965 0.0615234 -0.0153809 -0.0140991 -0.0153809 0.00384521
DEAL::0.00192261 -0.00769043 -0.00448608 0.00329590 -0.0131836 -0.00769043 -0.000823975 0.00329590 0.00192261 -0.00769043 0.0307617 0.0179443 -0.0131836 0.0527344 0.0307617 0.00329590 -0.0131836 -0.00769043 -0.00448608 0.0179443 0.0104675 -0.00769043 0.0307617 0.0179443 0.00192261 -0.00769043 -0.00448608
DEAL::0.00329590 -0.0131836 -0.00769043 -0.0131836 0.0527344 0.0307617 -0.0120850 0.0483398 0.0281982 -0.00439453 0.0175781 0.0102539 0.0175781 -0.0703125 -0.0410156 0.0161133 -0.0644531 -0.0375977 -0.00329590 0.0131836 0.00769043 0.0131836 -0.0527344 -0.0307617 0.0120850 -0.0483398 -0.0281982
DEAL::-0.00659180 0.00878906 0.00659180 0.0263672 -0.0351562 -0.0263672 0.0241699 -0.0322266 -0.0241699 0.00878906 -0.0117187 -0.00878906 -0.0351563 0.0468750 0.0351563 -0.0322266 0.0429687 0.0322266 0.00659180 -0.00878906 -0.00659180 -0.0263672 0.0351563 0.0263672 -0.0241699 0.0322266 0.0241699
DEAL::DGQ2<3> restriction 3
-DEAL::0.0241699 0.0322266 -0.0241699 0.0322266 0.0429688 -0.0322266 -0.0241699 -0.0322266 0.0241699 0.0263672 0.0351563 -0.0263672 0.0351563 0.0468750 -0.0351563 -0.0263672 -0.0351562 0.0263672 -0.00659180 -0.00878906 0.00659180 -0.00878906 -0.0117188 0.00878906 0.00659180 0.00878906 -0.00659180
+DEAL::0.0241699 0.0322266 -0.0241699 0.0322266 0.0429688 -0.0322266 -0.0241699 -0.0322266 0.0241699 0.0263672 0.0351562 -0.0263672 0.0351563 0.0468750 -0.0351563 -0.0263672 -0.0351562 0.0263672 -0.00659180 -0.00878906 0.00659180 -0.00878906 -0.0117188 0.00878906 0.00659180 0.00878906 -0.00659180
DEAL::-0.0281982 -0.0483398 0.0120850 -0.0375977 -0.0644531 0.0161133 0.0281982 0.0483398 -0.0120850 -0.0307617 -0.0527344 0.0131836 -0.0410156 -0.0703125 0.0175781 0.0307617 0.0527344 -0.0131836 0.00769043 0.0131836 -0.00329590 0.0102539 0.0175781 -0.00439453 -0.00769043 -0.0131836 0.00329590
DEAL::0.0241699 -0.0966797 -0.0886230 0.0322266 -0.128906 -0.118164 -0.0241699 0.0966797 0.0886230 0.0263672 -0.105469 -0.0966797 0.0351563 -0.140625 -0.128906 -0.0263672 0.105469 0.0966797 -0.00659180 0.0263672 0.0241699 -0.00878906 0.0351563 0.0322266 0.00659180 -0.0263672 -0.0241699
DEAL::-0.0281982 -0.0375977 0.0281982 -0.0483398 -0.0644531 0.0483398 0.0120850 0.0161133 -0.0120850 -0.0307617 -0.0410156 0.0307617 -0.0527344 -0.0703125 0.0527344 0.0131836 0.0175781 -0.0131836 0.00769043 0.0102539 -0.00769043 0.0131836 0.0175781 -0.0131836 -0.00329590 -0.00439453 0.00329590
DEAL::-0.00329590 0.0131836 0.0120850 0.0131836 -0.0527344 -0.0483398 0.0120850 -0.0483398 -0.0443115 0.0131836 -0.0527344 -0.0483398 -0.0527344 0.210937 0.193359 -0.0483398 0.193359 0.177246 0.00769043 -0.0307617 -0.0281982 -0.0307617 0.123047 0.112793 -0.0281982 0.112793 0.103394
DEAL::0.00659180 0.00878906 -0.00659180 0.00878906 0.0117188 -0.00878906 -0.00659180 -0.00878906 0.00659180 -0.00878906 -0.0117187 0.00878906 -0.0117187 -0.0156250 0.0117187 0.00878906 0.0117187 -0.00878906 -0.00659180 -0.00878906 0.00659180 -0.00878906 -0.0117188 0.00878906 0.00659180 0.00878906 -0.00659180
DEAL::-0.00769043 -0.0131836 0.00329590 -0.0102539 -0.0175781 0.00439453 0.00769043 0.0131836 -0.00329590 0.0102539 0.0175781 -0.00439453 0.0136719 0.0234375 -0.00585937 -0.0102539 -0.0175781 0.00439453 0.00769043 0.0131836 -0.00329590 0.0102539 0.0175781 -0.00439453 -0.00769043 -0.0131836 0.00329590
-DEAL::0.00659180 -0.0263672 -0.0241699 0.00878906 -0.0351562 -0.0322266 -0.00659180 0.0263672 0.0241699 -0.00878906 0.0351563 0.0322266 -0.0117187 0.0468750 0.0429687 0.00878906 -0.0351563 -0.0322266 -0.00659180 0.0263672 0.0241699 -0.00878906 0.0351562 0.0322266 0.00659180 -0.0263672 -0.0241699
+DEAL::0.00659180 -0.0263672 -0.0241699 0.00878906 -0.0351562 -0.0322266 -0.00659180 0.0263672 0.0241699 -0.00878906 0.0351563 0.0322266 -0.0117187 0.0468750 0.0429687 0.00878906 -0.0351563 -0.0322266 -0.00659180 0.0263672 0.0241699 -0.00878906 0.0351563 0.0322266 0.00659180 -0.0263672 -0.0241699
DEAL::-0.00769043 -0.0102539 0.00769043 -0.0131836 -0.0175781 0.0131836 0.00329590 0.00439453 -0.00329590 0.0102539 0.0136719 -0.0102539 0.0175781 0.0234375 -0.0175781 -0.00439453 -0.00585937 0.00439453 0.00769043 0.0102539 -0.00769043 0.0131836 0.0175781 -0.0131836 -0.00329590 -0.00439453 0.00329590
DEAL::0.00897217 0.0153809 -0.00384521 0.0153809 0.0263672 -0.00659180 -0.00384521 -0.00659180 0.00164795 -0.0119629 -0.0205078 0.00512695 -0.0205078 -0.0351563 0.00878906 0.00512695 0.00878906 -0.00219727 -0.00897217 -0.0153809 0.00384521 -0.0153809 -0.0263672 0.00659180 0.00384521 0.00659180 -0.00164795
DEAL::-0.00769043 0.0307617 0.0281982 -0.0131836 0.0527344 0.0483398 0.00329590 -0.0131836 -0.0120850 0.0102539 -0.0410156 -0.0375977 0.0175781 -0.0703125 -0.0644531 -0.00439453 0.0175781 0.0161133 0.00769043 -0.0307617 -0.0281982 0.0131836 -0.0527344 -0.0483398 -0.00329590 0.0131836 0.0120850
-DEAL::0.00659180 0.00878906 -0.00659180 -0.0263672 -0.0351562 0.0263672 -0.0241699 -0.0322266 0.0241699 -0.00878906 -0.0117187 0.00878906 0.0351563 0.0468750 -0.0351563 0.0322266 0.0429687 -0.0322266 -0.00659180 -0.00878906 0.00659180 0.0263672 0.0351562 -0.0263672 0.0241699 0.0322266 -0.0241699
+DEAL::0.00659180 0.00878906 -0.00659180 -0.0263672 -0.0351562 0.0263672 -0.0241699 -0.0322266 0.0241699 -0.00878906 -0.0117187 0.00878906 0.0351563 0.0468750 -0.0351563 0.0322266 0.0429688 -0.0322266 -0.00659180 -0.00878906 0.00659180 0.0263672 0.0351562 -0.0263672 0.0241699 0.0322266 -0.0241699
DEAL::-0.00769043 -0.0131836 0.00329590 0.0307617 0.0527344 -0.0131836 0.0281982 0.0483398 -0.0120850 0.0102539 0.0175781 -0.00439453 -0.0410156 -0.0703125 0.0175781 -0.0375977 -0.0644531 0.0161133 0.00769043 0.0131836 -0.00329590 -0.0307617 -0.0527344 0.0131836 -0.0281982 -0.0483398 0.0120850
DEAL::0.00659180 -0.0263672 -0.0241699 -0.0263672 0.105469 0.0966797 -0.0241699 0.0966797 0.0886230 -0.00878906 0.0351563 0.0322266 0.0351563 -0.140625 -0.128906 0.0322266 -0.128906 -0.118164 -0.00659180 0.0263672 0.0241699 0.0263672 -0.105469 -0.0966797 0.0241699 -0.0966797 -0.0886230
DEAL::DGQ2<3> restriction 4
DEAL::-0.0886230 -0.0966797 0.0241699 -0.0966797 -0.105469 0.0263672 0.0241699 0.0263672 -0.00659180 -0.118164 -0.128906 0.0322266 -0.128906 -0.140625 0.0351563 0.0322266 0.0351563 -0.00878906 0.0886230 0.0966797 -0.0241699 0.0966797 0.105469 -0.0263672 -0.0241699 -0.0263672 0.00659180
DEAL::0.0120850 -0.0483398 -0.0281982 0.0131836 -0.0527344 -0.0307617 -0.00329590 0.0131836 0.00769043 0.0161133 -0.0644531 -0.0375977 0.0175781 -0.0703125 -0.0410156 -0.00439453 0.0175781 0.0102539 -0.0120850 0.0483398 0.0281982 -0.0131836 0.0527344 0.0307617 0.00329590 -0.0131836 -0.00769043
-DEAL::-0.0241699 0.0322266 0.0241699 -0.0263672 0.0351563 0.0263672 0.00659180 -0.00878906 -0.00659180 -0.0322266 0.0429688 0.0322266 -0.0351563 0.0468750 0.0351563 0.00878906 -0.0117187 -0.00878906 0.0241699 -0.0322266 -0.0241699 0.0263672 -0.0351563 -0.0263672 -0.00659180 0.00878906 0.00659180
+DEAL::-0.0241699 0.0322266 0.0241699 -0.0263672 0.0351563 0.0263672 0.00659180 -0.00878906 -0.00659180 -0.0322266 0.0429688 0.0322266 -0.0351563 0.0468750 0.0351563 0.00878906 -0.0117188 -0.00878906 0.0241699 -0.0322266 -0.0241699 0.0263672 -0.0351563 -0.0263672 -0.00659180 0.00878906 0.00659180
DEAL::0.0120850 0.0131836 -0.00329590 -0.0483398 -0.0527344 0.0131836 -0.0281982 -0.0307617 0.00769043 0.0161133 0.0175781 -0.00439453 -0.0644531 -0.0703125 0.0175781 -0.0375977 -0.0410156 0.0102539 -0.0120850 -0.0131836 0.00329590 0.0483398 0.0527344 -0.0131836 0.0281982 0.0307617 -0.00769043
DEAL::-0.00164795 0.00659180 0.00384521 0.00659180 -0.0263672 -0.0153809 0.00384521 -0.0153809 -0.00897217 -0.00219727 0.00878906 0.00512695 0.00878906 -0.0351562 -0.0205078 0.00512695 -0.0205078 -0.0119629 0.00164795 -0.00659180 -0.00384521 -0.00659180 0.0263672 0.0153809 -0.00384521 0.0153809 0.00897217
DEAL::0.00329590 -0.00439453 -0.00329590 -0.0131836 0.0175781 0.0131836 -0.00769043 0.0102539 0.00769043 0.00439453 -0.00585937 -0.00439453 -0.0175781 0.0234375 0.0175781 -0.0102539 0.0136719 0.0102539 -0.00329590 0.00439453 0.00329590 0.0131836 -0.0175781 -0.0131836 0.00769043 -0.0102539 -0.00769043
DEAL::-0.00384521 0.0153809 0.00897217 0.00512695 -0.0205078 -0.0119629 0.00384521 -0.0153809 -0.00897217 -0.00659180 0.0263672 0.0153809 0.00878906 -0.0351562 -0.0205078 0.00659180 -0.0263672 -0.0153809 0.00164795 -0.00659180 -0.00384521 -0.00219727 0.00878906 0.00512695 -0.00164795 0.00659180 0.00384521
DEAL::0.00769043 -0.0102539 -0.00769043 -0.0102539 0.0136719 0.0102539 -0.00769043 0.0102539 0.00769043 0.0131836 -0.0175781 -0.0131836 -0.0175781 0.0234375 0.0175781 -0.0131836 0.0175781 0.0131836 -0.00329590 0.00439453 0.00329590 0.00439453 -0.00585937 -0.00439453 0.00329590 -0.00439453 -0.00329590
DEAL::-0.0886230 -0.0966797 0.0241699 -0.0966797 -0.105469 0.0263672 0.0241699 0.0263672 -0.00659180 0.354492 0.386719 -0.0966797 0.386719 0.421875 -0.105469 -0.0966797 -0.105469 0.0263672 0.324951 0.354492 -0.0886230 0.354492 0.386719 -0.0966797 -0.0886230 -0.0966797 0.0241699
-DEAL::0.0120850 -0.0483398 -0.0281982 0.0131836 -0.0527344 -0.0307617 -0.00329590 0.0131836 0.00769043 -0.0483398 0.193359 0.112793 -0.0527344 0.210937 0.123047 0.0131836 -0.0527344 -0.0307617 -0.0443115 0.177246 0.103394 -0.0483398 0.193359 0.112793 0.0120850 -0.0483398 -0.0281982
+DEAL::0.0120850 -0.0483398 -0.0281982 0.0131836 -0.0527344 -0.0307617 -0.00329590 0.0131836 0.00769043 -0.0483398 0.193359 0.112793 -0.0527344 0.210938 0.123047 0.0131836 -0.0527344 -0.0307617 -0.0443115 0.177246 0.103394 -0.0483398 0.193359 0.112793 0.0120850 -0.0483398 -0.0281982
DEAL::-0.0241699 0.0322266 0.0241699 -0.0263672 0.0351562 0.0263672 0.00659180 -0.00878906 -0.00659180 0.0966797 -0.128906 -0.0966797 0.105469 -0.140625 -0.105469 -0.0263672 0.0351563 0.0263672 0.0886230 -0.118164 -0.0886230 0.0966797 -0.128906 -0.0966797 -0.0241699 0.0322266 0.0241699
-DEAL::0.0120850 0.0131836 -0.00329590 -0.0483398 -0.0527344 0.0131836 -0.0281982 -0.0307617 0.00769043 -0.0483398 -0.0527344 0.0131836 0.193359 0.210938 -0.0527344 0.112793 0.123047 -0.0307617 -0.0443115 -0.0483398 0.0120850 0.177246 0.193359 -0.0483398 0.103394 0.112793 -0.0281982
+DEAL::0.0120850 0.0131836 -0.00329590 -0.0483398 -0.0527344 0.0131836 -0.0281982 -0.0307617 0.00769043 -0.0483398 -0.0527344 0.0131836 0.193359 0.210937 -0.0527344 0.112793 0.123047 -0.0307617 -0.0443115 -0.0483398 0.0120850 0.177246 0.193359 -0.0483398 0.103394 0.112793 -0.0281982
DEAL::-0.00164795 0.00659180 0.00384521 0.00659180 -0.0263672 -0.0153809 0.00384521 -0.0153809 -0.00897217 0.00659180 -0.0263672 -0.0153809 -0.0263672 0.105469 0.0615234 -0.0153809 0.0615234 0.0358887 0.00604248 -0.0241699 -0.0140991 -0.0241699 0.0966797 0.0563965 -0.0140991 0.0563965 0.0328979
DEAL::0.00329590 -0.00439453 -0.00329590 -0.0131836 0.0175781 0.0131836 -0.00769043 0.0102539 0.00769043 -0.0131836 0.0175781 0.0131836 0.0527344 -0.0703125 -0.0527344 0.0307617 -0.0410156 -0.0307617 -0.0120850 0.0161133 0.0120850 0.0483398 -0.0644531 -0.0483398 0.0281982 -0.0375977 -0.0281982
DEAL::-0.0241699 -0.0263672 0.00659180 0.0322266 0.0351562 -0.00878906 0.0241699 0.0263672 -0.00659180 0.0966797 0.105469 -0.0263672 -0.128906 -0.140625 0.0351563 -0.0966797 -0.105469 0.0263672 0.0886230 0.0966797 -0.0241699 -0.118164 -0.128906 0.0322266 -0.0886230 -0.0966797 0.0241699
DEAL::-0.0281982 -0.0483398 0.0120850 -0.0307617 -0.0527344 0.0131836 0.00769043 0.0131836 -0.00329590 -0.0375977 -0.0644531 0.0161133 -0.0410156 -0.0703125 0.0175781 0.0102539 0.0175781 -0.00439453 0.0281982 0.0483398 -0.0120850 0.0307617 0.0527344 -0.0131836 -0.00769043 -0.0131836 0.00329590
DEAL::0.0241699 -0.0966797 -0.0886230 0.0263672 -0.105469 -0.0966797 -0.00659180 0.0263672 0.0241699 0.0322266 -0.128906 -0.118164 0.0351563 -0.140625 -0.128906 -0.00878906 0.0351563 0.0322266 -0.0241699 0.0966797 0.0886230 -0.0263672 0.105469 0.0966797 0.00659180 -0.0263672 -0.0241699
DEAL::-0.00329590 -0.00439453 0.00329590 0.0131836 0.0175781 -0.0131836 0.00769043 0.0102539 -0.00769043 -0.00439453 -0.00585937 0.00439453 0.0175781 0.0234375 -0.0175781 0.0102539 0.0136719 -0.0102539 0.00329590 0.00439453 -0.00329590 -0.0131836 -0.0175781 0.0131836 -0.00769043 -0.0102539 0.00769043
-DEAL::0.00384521 0.00659180 -0.00164795 -0.0153809 -0.0263672 0.00659180 -0.00897217 -0.0153809 0.00384521 0.00512695 0.00878906 -0.00219727 -0.0205078 -0.0351563 0.00878906 -0.0119629 -0.0205078 0.00512695 -0.00384521 -0.00659180 0.00164795 0.0153809 0.0263672 -0.00659180 0.00897217 0.0153809 -0.00384521
+DEAL::0.00384521 0.00659180 -0.00164795 -0.0153809 -0.0263672 0.00659180 -0.00897217 -0.0153809 0.00384521 0.00512695 0.00878906 -0.00219727 -0.0205078 -0.0351562 0.00878906 -0.0119629 -0.0205078 0.00512695 -0.00384521 -0.00659180 0.00164795 0.0153809 0.0263672 -0.00659180 0.00897217 0.0153809 -0.00384521
DEAL::-0.00329590 0.0131836 0.0120850 0.0131836 -0.0527344 -0.0483398 0.00769043 -0.0307617 -0.0281982 -0.00439453 0.0175781 0.0161133 0.0175781 -0.0703125 -0.0644531 0.0102539 -0.0410156 -0.0375977 0.00329590 -0.0131836 -0.0120850 -0.0131836 0.0527344 0.0483398 -0.00769043 0.0307617 0.0281982
DEAL::0.00659180 0.00878906 -0.00659180 -0.00878906 -0.0117187 0.00878906 -0.00659180 -0.00878906 0.00659180 0.00878906 0.0117188 -0.00878906 -0.0117187 -0.0156250 0.0117188 -0.00878906 -0.0117188 0.00878906 -0.00659180 -0.00878906 0.00659180 0.00878906 0.0117187 -0.00878906 0.00659180 0.00878906 -0.00659180
DEAL::-0.00769043 -0.0131836 0.00329590 0.0102539 0.0175781 -0.00439453 0.00769043 0.0131836 -0.00329590 -0.0102539 -0.0175781 0.00439453 0.0136719 0.0234375 -0.00585937 0.0102539 0.0175781 -0.00439453 0.00769043 0.0131836 -0.00329590 -0.0102539 -0.0175781 0.00439453 -0.00769043 -0.0131836 0.00329590
-DEAL::0.00659180 -0.0263672 -0.0241699 -0.00878906 0.0351562 0.0322266 -0.00659180 0.0263672 0.0241699 0.00878906 -0.0351562 -0.0322266 -0.0117187 0.0468750 0.0429687 -0.00878906 0.0351562 0.0322266 -0.00659180 0.0263672 0.0241699 0.00878906 -0.0351563 -0.0322266 0.00659180 -0.0263672 -0.0241699
+DEAL::0.00659180 -0.0263672 -0.0241699 -0.00878906 0.0351563 0.0322266 -0.00659180 0.0263672 0.0241699 0.00878906 -0.0351562 -0.0322266 -0.0117187 0.0468750 0.0429687 -0.00878906 0.0351562 0.0322266 -0.00659180 0.0263672 0.0241699 0.00878906 -0.0351563 -0.0322266 0.00659180 -0.0263672 -0.0241699
DEAL::-0.0281982 -0.0375977 0.0281982 -0.0307617 -0.0410156 0.0307617 0.00769043 0.0102539 -0.00769043 -0.0483398 -0.0644531 0.0483398 -0.0527344 -0.0703125 0.0527344 0.0131836 0.0175781 -0.0131836 0.0120850 0.0161133 -0.0120850 0.0131836 0.0175781 -0.0131836 -0.00329590 -0.00439453 0.00329590
DEAL::0.0328979 0.0563965 -0.0140991 0.0358887 0.0615234 -0.0153809 -0.00897217 -0.0153809 0.00384521 0.0563965 0.0966797 -0.0241699 0.0615234 0.105469 -0.0263672 -0.0153809 -0.0263672 0.00659180 -0.0140991 -0.0241699 0.00604248 -0.0153809 -0.0263672 0.00659180 0.00384521 0.00659180 -0.00164795
DEAL::-0.0281982 0.112793 0.103394 -0.0307617 0.123047 0.112793 0.00769043 -0.0307617 -0.0281982 -0.0483398 0.193359 0.177246 -0.0527344 0.210938 0.193359 0.0131836 -0.0527344 -0.0483398 0.0120850 -0.0483398 -0.0443115 0.0131836 -0.0527344 -0.0483398 -0.00329590 0.0131836 0.0120850
DEAL::0.00659180 -0.0263672 -0.0241699 -0.00878906 0.0351562 0.0322266 -0.00659180 0.0263672 0.0241699 -0.0263672 0.105469 0.0966797 0.0351563 -0.140625 -0.128906 0.0263672 -0.105469 -0.0966797 -0.0241699 0.0966797 0.0886230 0.0322266 -0.128906 -0.118164 0.0241699 -0.0966797 -0.0886230
DEAL::DGQ2<3> restriction 6
DEAL::0.0241699 0.0263672 -0.00659180 0.0322266 0.0351563 -0.00878906 -0.0241699 -0.0263672 0.00659180 0.0322266 0.0351563 -0.00878906 0.0429688 0.0468750 -0.0117188 -0.0322266 -0.0351563 0.00878906 -0.0241699 -0.0263672 0.00659180 -0.0322266 -0.0351563 0.00878906 0.0241699 0.0263672 -0.00659180
-DEAL::-0.00329590 0.0131836 0.00769043 -0.00439453 0.0175781 0.0102539 0.00329590 -0.0131836 -0.00769043 -0.00439453 0.0175781 0.0102539 -0.00585938 0.0234375 0.0136719 0.00439453 -0.0175781 -0.0102539 0.00329590 -0.0131836 -0.00769043 0.00439453 -0.0175781 -0.0102539 -0.00329590 0.0131836 0.00769043
-DEAL::0.00659180 -0.00878906 -0.00659180 0.00878906 -0.0117187 -0.00878906 -0.00659180 0.00878906 0.00659180 0.00878906 -0.0117187 -0.00878906 0.0117188 -0.0156250 -0.0117188 -0.00878906 0.0117187 0.00878906 -0.00659180 0.00878906 0.00659180 -0.00878906 0.0117188 0.00878906 0.00659180 -0.00878906 -0.00659180
+DEAL::-0.00329590 0.0131836 0.00769043 -0.00439453 0.0175781 0.0102539 0.00329590 -0.0131836 -0.00769043 -0.00439453 0.0175781 0.0102539 -0.00585937 0.0234375 0.0136719 0.00439453 -0.0175781 -0.0102539 0.00329590 -0.0131836 -0.00769043 0.00439453 -0.0175781 -0.0102539 -0.00329590 0.0131836 0.00769043
+DEAL::0.00659180 -0.00878906 -0.00659180 0.00878906 -0.0117188 -0.00878906 -0.00659180 0.00878906 0.00659180 0.00878906 -0.0117188 -0.00878906 0.0117188 -0.0156250 -0.0117188 -0.00878906 0.0117187 0.00878906 -0.00659180 0.00878906 0.00659180 -0.00878906 0.0117187 0.00878906 0.00659180 -0.00878906 -0.00659180
DEAL::-0.0281982 -0.0307617 0.00769043 -0.0483398 -0.0527344 0.0131836 0.0120850 0.0131836 -0.00329590 -0.0375977 -0.0410156 0.0102539 -0.0644531 -0.0703125 0.0175781 0.0161133 0.0175781 -0.00439453 0.0281982 0.0307617 -0.00769043 0.0483398 0.0527344 -0.0131836 -0.0120850 -0.0131836 0.00329590
DEAL::0.00384521 -0.0153809 -0.00897217 0.00659180 -0.0263672 -0.0153809 -0.00164795 0.00659180 0.00384521 0.00512695 -0.0205078 -0.0119629 0.00878906 -0.0351562 -0.0205078 -0.00219727 0.00878906 0.00512695 -0.00384521 0.0153809 0.00897217 -0.00659180 0.0263672 0.0153809 0.00164795 -0.00659180 -0.00384521
DEAL::-0.00769043 0.0102539 0.00769043 -0.0131836 0.0175781 0.0131836 0.00329590 -0.00439453 -0.00329590 -0.0102539 0.0136719 0.0102539 -0.0175781 0.0234375 0.0175781 0.00439453 -0.00585937 -0.00439453 0.00769043 -0.0102539 -0.00769043 0.0131836 -0.0175781 -0.0131836 -0.00329590 0.00439453 0.00329590
DEAL::0.0241699 0.0263672 -0.00659180 -0.0966797 -0.105469 0.0263672 -0.0886230 -0.0966797 0.0241699 0.0322266 0.0351563 -0.00878906 -0.128906 -0.140625 0.0351562 -0.118164 -0.128906 0.0322266 -0.0241699 -0.0263672 0.00659180 0.0966797 0.105469 -0.0263672 0.0886230 0.0966797 -0.0241699
DEAL::-0.00329590 0.0131836 0.00769043 0.0131836 -0.0527344 -0.0307617 0.0120850 -0.0483398 -0.0281982 -0.00439453 0.0175781 0.0102539 0.0175781 -0.0703125 -0.0410156 0.0161133 -0.0644531 -0.0375977 0.00329590 -0.0131836 -0.00769043 -0.0131836 0.0527344 0.0307617 -0.0120850 0.0483398 0.0281982
-DEAL::0.00659180 -0.00878906 -0.00659180 -0.0263672 0.0351563 0.0263672 -0.0241699 0.0322266 0.0241699 0.00878906 -0.0117188 -0.00878906 -0.0351562 0.0468750 0.0351563 -0.0322266 0.0429687 0.0322266 -0.00659180 0.00878906 0.00659180 0.0263672 -0.0351562 -0.0263672 0.0241699 -0.0322266 -0.0241699
+DEAL::0.00659180 -0.00878906 -0.00659180 -0.0263672 0.0351563 0.0263672 -0.0241699 0.0322266 0.0241699 0.00878906 -0.0117188 -0.00878906 -0.0351562 0.0468750 0.0351562 -0.0322266 0.0429687 0.0322266 -0.00659180 0.00878906 0.00659180 0.0263672 -0.0351562 -0.0263672 0.0241699 -0.0322266 -0.0241699
DEAL::-0.0281982 -0.0307617 0.00769043 -0.0375977 -0.0410156 0.0102539 0.0281982 0.0307617 -0.00769043 -0.0483398 -0.0527344 0.0131836 -0.0644531 -0.0703125 0.0175781 0.0483398 0.0527344 -0.0131836 0.0120850 0.0131836 -0.00329590 0.0161133 0.0175781 -0.00439453 -0.0120850 -0.0131836 0.00329590
DEAL::0.00384521 -0.0153809 -0.00897217 0.00512695 -0.0205078 -0.0119629 -0.00384521 0.0153809 0.00897217 0.00659180 -0.0263672 -0.0153809 0.00878906 -0.0351562 -0.0205078 -0.00659180 0.0263672 0.0153809 -0.00164795 0.00659180 0.00384521 -0.00219727 0.00878906 0.00512695 0.00164795 -0.00659180 -0.00384521
DEAL::-0.00769043 0.0102539 0.00769043 -0.0102539 0.0136719 0.0102539 0.00769043 -0.0102539 -0.00769043 -0.0131836 0.0175781 0.0131836 -0.0175781 0.0234375 0.0175781 0.0131836 -0.0175781 -0.0131836 0.00329590 -0.00439453 -0.00329590 0.00439453 -0.00585937 -0.00439453 -0.00329590 0.00439453 0.00329590
DEAL::-0.0281982 -0.0307617 0.00769043 0.112793 0.123047 -0.0307617 0.103394 0.112793 -0.0281982 -0.0483398 -0.0527344 0.0131836 0.193359 0.210938 -0.0527344 0.177246 0.193359 -0.0483398 0.0120850 0.0131836 -0.00329590 -0.0483398 -0.0527344 0.0131836 -0.0443115 -0.0483398 0.0120850
DEAL::0.00384521 -0.0153809 -0.00897217 -0.0153809 0.0615234 0.0358887 -0.0140991 0.0563965 0.0328979 0.00659180 -0.0263672 -0.0153809 -0.0263672 0.105469 0.0615234 -0.0241699 0.0966797 0.0563965 -0.00164795 0.00659180 0.00384521 0.00659180 -0.0263672 -0.0153809 0.00604248 -0.0241699 -0.0140991
DEAL::-0.00769043 0.0102539 0.00769043 0.0307617 -0.0410156 -0.0307617 0.0281982 -0.0375977 -0.0281982 -0.0131836 0.0175781 0.0131836 0.0527344 -0.0703125 -0.0527344 0.0483398 -0.0644531 -0.0483398 0.00329590 -0.00439453 -0.00329590 -0.0131836 0.0175781 0.0131836 -0.0120850 0.0161133 0.0120850
-DEAL::0.0241699 0.0263672 -0.00659180 0.0322266 0.0351563 -0.00878906 -0.0241699 -0.0263672 0.00659180 -0.0966797 -0.105469 0.0263672 -0.128906 -0.140625 0.0351562 0.0966797 0.105469 -0.0263672 -0.0886230 -0.0966797 0.0241699 -0.118164 -0.128906 0.0322266 0.0886230 0.0966797 -0.0241699
+DEAL::0.0241699 0.0263672 -0.00659180 0.0322266 0.0351563 -0.00878906 -0.0241699 -0.0263672 0.00659180 -0.0966797 -0.105469 0.0263672 -0.128906 -0.140625 0.0351563 0.0966797 0.105469 -0.0263672 -0.0886230 -0.0966797 0.0241699 -0.118164 -0.128906 0.0322266 0.0886230 0.0966797 -0.0241699
DEAL::-0.00329590 0.0131836 0.00769043 -0.00439453 0.0175781 0.0102539 0.00329590 -0.0131836 -0.00769043 0.0131836 -0.0527344 -0.0307617 0.0175781 -0.0703125 -0.0410156 -0.0131836 0.0527344 0.0307617 0.0120850 -0.0483398 -0.0281982 0.0161133 -0.0644531 -0.0375977 -0.0120850 0.0483398 0.0281982
-DEAL::0.00659180 -0.00878906 -0.00659180 0.00878906 -0.0117187 -0.00878906 -0.00659180 0.00878906 0.00659180 -0.0263672 0.0351563 0.0263672 -0.0351562 0.0468750 0.0351562 0.0263672 -0.0351562 -0.0263672 -0.0241699 0.0322266 0.0241699 -0.0322266 0.0429687 0.0322266 0.0241699 -0.0322266 -0.0241699
+DEAL::0.00659180 -0.00878906 -0.00659180 0.00878906 -0.0117187 -0.00878906 -0.00659180 0.00878906 0.00659180 -0.0263672 0.0351562 0.0263672 -0.0351562 0.0468750 0.0351562 0.0263672 -0.0351562 -0.0263672 -0.0241699 0.0322266 0.0241699 -0.0322266 0.0429687 0.0322266 0.0241699 -0.0322266 -0.0241699
DEAL::-0.0281982 -0.0307617 0.00769043 -0.0483398 -0.0527344 0.0131836 0.0120850 0.0131836 -0.00329590 0.112793 0.123047 -0.0307617 0.193359 0.210937 -0.0527344 -0.0483398 -0.0527344 0.0131836 0.103394 0.112793 -0.0281982 0.177246 0.193359 -0.0483398 -0.0443115 -0.0483398 0.0120850
DEAL::0.00384521 -0.0153809 -0.00897217 0.00659180 -0.0263672 -0.0153809 -0.00164795 0.00659180 0.00384521 -0.0153809 0.0615234 0.0358887 -0.0263672 0.105469 0.0615234 0.00659180 -0.0263672 -0.0153809 -0.0140991 0.0563965 0.0328979 -0.0241699 0.0966797 0.0563965 0.00604248 -0.0241699 -0.0140991
DEAL::-0.00769043 0.0102539 0.00769043 -0.0131836 0.0175781 0.0131836 0.00329590 -0.00439453 -0.00329590 0.0307617 -0.0410156 -0.0307617 0.0527344 -0.0703125 -0.0527344 -0.0131836 0.0175781 0.0131836 0.0281982 -0.0375977 -0.0281982 0.0483398 -0.0644531 -0.0483398 -0.0120850 0.0161133 0.0120850
DEAL::0.00769043 0.0102539 -0.00769043 -0.0307617 -0.0410156 0.0307617 -0.0281982 -0.0375977 0.0281982 0.0131836 0.0175781 -0.0131836 -0.0527344 -0.0703125 0.0527344 -0.0483398 -0.0644531 0.0483398 -0.00329590 -0.00439453 0.00329590 0.0131836 0.0175781 -0.0131836 0.0120850 0.0161133 -0.0120850
DEAL::-0.00897217 -0.0153809 0.00384521 0.0358887 0.0615234 -0.0153809 0.0328979 0.0563965 -0.0140991 -0.0153809 -0.0263672 0.00659180 0.0615234 0.105469 -0.0263672 0.0563965 0.0966797 -0.0241699 0.00384521 0.00659180 -0.00164795 -0.0153809 -0.0263672 0.00659180 -0.0140991 -0.0241699 0.00604248
DEAL::0.00769043 -0.0307617 -0.0281982 -0.0307617 0.123047 0.112793 -0.0281982 0.112793 0.103394 0.0131836 -0.0527344 -0.0483398 -0.0527344 0.210937 0.193359 -0.0483398 0.193359 0.177246 -0.00329590 0.0131836 0.0120850 0.0131836 -0.0527344 -0.0483398 0.0120850 -0.0483398 -0.0443115
-DEAL::-0.00659180 -0.00878906 0.00659180 -0.00878906 -0.0117188 0.00878906 0.00659180 0.00878906 -0.00659180 0.0263672 0.0351563 -0.0263672 0.0351562 0.0468750 -0.0351562 -0.0263672 -0.0351562 0.0263672 0.0241699 0.0322266 -0.0241699 0.0322266 0.0429688 -0.0322266 -0.0241699 -0.0322266 0.0241699
+DEAL::-0.00659180 -0.00878906 0.00659180 -0.00878906 -0.0117188 0.00878906 0.00659180 0.00878906 -0.00659180 0.0263672 0.0351563 -0.0263672 0.0351563 0.0468750 -0.0351562 -0.0263672 -0.0351562 0.0263672 0.0241699 0.0322266 -0.0241699 0.0322266 0.0429688 -0.0322266 -0.0241699 -0.0322266 0.0241699
DEAL::0.00769043 0.0131836 -0.00329590 0.0102539 0.0175781 -0.00439453 -0.00769043 -0.0131836 0.00329590 -0.0307617 -0.0527344 0.0131836 -0.0410156 -0.0703125 0.0175781 0.0307617 0.0527344 -0.0131836 -0.0281982 -0.0483398 0.0120850 -0.0375977 -0.0644531 0.0161133 0.0281982 0.0483398 -0.0120850
DEAL::-0.00659180 0.0263672 0.0241699 -0.00878906 0.0351562 0.0322266 0.00659180 -0.0263672 -0.0241699 0.0263672 -0.105469 -0.0966797 0.0351562 -0.140625 -0.128906 -0.0263672 0.105469 0.0966797 0.0241699 -0.0966797 -0.0886230 0.0322266 -0.128906 -0.118164 -0.0241699 0.0966797 0.0886230
DEAL::0.00769043 0.0102539 -0.00769043 0.0131836 0.0175781 -0.0131836 -0.00329590 -0.00439453 0.00329590 -0.0307617 -0.0410156 0.0307617 -0.0527344 -0.0703125 0.0527344 0.0131836 0.0175781 -0.0131836 -0.0281982 -0.0375977 0.0281982 -0.0483398 -0.0644531 0.0483398 0.0120850 0.0161133 -0.0120850
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ 0 ~ ~ 0
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 0 ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ -0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0
DEAL::0 0 0 0 0 ~ 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0 ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 ~ 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 0 ~ ~ -0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ -0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.0937500 ~ ~ -0.0541266 ~ ~ -0.0541266 ~ ~ 0.0312500 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.0937500 ~ ~ -0.0541266 ~ ~ -0.0541266 ~ ~ 0.0312500 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ 0.0937500 ~ ~ -0.0541266 ~ ~ -0.0541266 ~ ~ 0.0312500
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 ~ ~ 0.0937500 ~ ~ -0.0541266 ~ ~ -0.0541266 ~ ~ 0.0312500
DEAL::RaviartThomas1<3> restriction 1
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ 0.250000 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ 0.250000 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ -0.216506 0.125000 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ -0.216506 ~ 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ 0.187500 -0.108253 -0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.216506 0.125000 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.216506 0 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.187500 -0.108253 0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ 0 ~ ~ 0
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 0 ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 ~ 0 0 0 ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0
DEAL::0 0 0 0 0 ~ 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0 ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 ~ 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 0 ~ ~ -0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ -0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.0937500 ~ ~ -0.0541266 ~ ~ -0.0541266 ~ ~ 0.0312500 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0937500 ~ ~ -0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 ~ ~ ~ -0.0937500 ~ ~ -0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ -0.0937500 ~ ~ -0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500
DEAL::RaviartThomas1<3> restriction 2
-DEAL::0.250000 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::0.250000 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::0.216506 0.125000 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::-0.216506 0 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::-0.187500 -0.108253 0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ 0 ~ ~ 0
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 0 ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ -0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0
DEAL::0 0 0 0 0 ~ 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0 ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 ~ 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 ~ 0 ~ ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 ~ 0 0 ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0
DEAL::0 0 ~ 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0937500 ~ ~ -0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.0937500 ~ ~ -0.0541266 ~ ~ -0.0541266 ~ ~ 0.0312500 ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ -0.0937500 ~ ~ 0.0541266 ~ ~ -0.0541266 ~ ~ 0.0312500
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ 0.250000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ 0.250000 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ 0.216506 0.125000 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ -0.216506 ~ 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ -0.187500 -0.108253 0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.216506 0.125000 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.216506 0 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.187500 0.108253 -0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.216506 0.125000 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.216506 0 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.187500 0.108253 0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ 0 ~ ~ 0
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 0 ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 ~ 0 0 0 ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0
DEAL::0 0 0 0 0 ~ 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0 ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 ~ 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 ~ 0 ~ ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 ~ 0 0 ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0
DEAL::0 0 ~ 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0937500 ~ ~ -0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0937500 ~ ~ -0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ ~ 0 0 0 0 ~ ~ ~ 0.0937500 ~ ~ 0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 ~ ~ ~ 0.0937500 ~ ~ 0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500
DEAL::RaviartThomas1<3> restriction 4
DEAL::0.250000 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::-0.216506 0.125000 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0.216506 0.125000 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ -0.216506 0 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ -0.187500 -0.108253 0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.187500 -0.108253 -0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ 0 ~ ~ 0
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 0 ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ -0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0
-DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0 ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 0 ~ ~ -0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0
+DEAL::0 0 0 0 ~ 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0 ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ -0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0
DEAL::0 0 ~ 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0937500 ~ ~ 0.0541266 ~ ~ -0.0541266 ~ ~ 0.0312500 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0937500 ~ ~ 0.0541266 ~ ~ -0.0541266 ~ ~ 0.0312500 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ 0.0937500 ~ ~ -0.0541266 ~ ~ -0.0541266 ~ ~ 0.0312500
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 ~ ~ 0.0937500 ~ ~ -0.0541266 ~ ~ -0.0541266 ~ ~ 0.0312500
DEAL::RaviartThomas1<3> restriction 5
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ -0.216506 0.125000 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ 0.216506 0 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ -0.187500 0.108253 -0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0.216506 0.125000 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0.216506 0 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0.187500 0.108253 0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.216506 0.125000 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.216506 0 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.187500 -0.108253 0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ 0 ~ ~ 0
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 0 ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0
-DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0 ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 0 ~ ~ -0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 ~ 0 0 0 ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0
+DEAL::0 0 0 0 ~ 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0 ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ -0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0
DEAL::0 0 ~ 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0937500 ~ ~ 0.0541266 ~ ~ -0.0541266 ~ ~ 0.0312500 ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.0937500 ~ ~ 0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 ~ ~ ~ -0.0937500 ~ ~ -0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 ~ 0 0 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.0937500 ~ ~ 0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500 ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ -0.0937500 ~ ~ -0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500
DEAL::RaviartThomas1<3> restriction 6
-DEAL::0.250000 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::0.250000 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::0.216506 0.125000 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::0.216506 0 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::0.187500 0.108253 0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.216506 0.125000 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.216506 0 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.187500 -0.108253 0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.187500 0.108253 -0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ 0 ~ ~ 0
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 0 ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ -0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0
-DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0 ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 ~ 0 ~ ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0
-DEAL::0 0 ~ 0 0 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.0937500 ~ ~ 0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500 ~ ~
+DEAL::0 0 0 0 ~ 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0 ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 ~ 0 0 ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0
+DEAL::0 0 ~ 0 ~ 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.0937500 ~ ~ 0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0937500 ~ ~ 0.0541266 ~ ~ -0.0541266 ~ ~ 0.0312500 ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ -0.0937500 ~ ~ 0.0541266 ~ ~ -0.0541266 ~ ~ 0.0312500
DEAL::RaviartThomas1<3> restriction 7
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ 0.250000 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ 0.250000 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ 0.216506 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ 0.216506 0 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ 0.187500 0.108253 0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.216506 0.125000 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.216506 0 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.187500 0.108253 0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.250000 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.216506 0.125000 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.216506 0 0.125000 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.187500 0.108253 0.108253 0.0625000 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 ~ ~ ~ 0.125000 ~ ~ ~ ~ ~ 0 ~ ~ 0
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 0 ~ ~ 0.125000 ~ ~ 0 ~ ~ 0 ~ ~ 0
DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0
-DEAL::0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0 ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 ~ 0 ~ ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0
-DEAL::0 0 ~ 0 0 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.0937500 ~ ~ 0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500 ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.0937500 ~ ~ 0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500 ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ ~ 0 0 0 0 ~ ~ ~ 0.0937500 ~ ~ 0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0 ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 ~ 0 0 0 ~ ~ 0.108253 ~ ~ 0.0625000 ~ ~ 0 ~ ~ 0
+DEAL::0 0 0 0 ~ 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0 ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 0 0 0 0 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.108253 ~ ~ 0 ~ ~ 0.0625000 ~ ~ 0 ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 0 0 ~ 0 0 ~ ~ 0.108253 ~ ~ ~ ~ ~ 0.0625000 ~ ~ 0
+DEAL::0 0 ~ 0 ~ 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.0937500 ~ ~ 0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500 ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0 0 ~ 0 0 0 ~ 0 ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.0937500 ~ ~ 0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500 ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0 ~ 0 0 0 0 ~ ~ ~ 0.0937500 ~ ~ 0.0541266 ~ ~ 0.0541266 ~ ~ 0.0312500
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00681584 0.0298193 0.0758263 0.0150517 -0.0343364 0.150222 0.381993 0.0758263 -0.0135031 0.0590760 0.150222 0.0298193 0.00308642 -0.0135031 -0.0343364 -0.00681584
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00425990 -0.0144837 0.00851980 0.0105078 0.0214603 -0.0729649 0.0429205 0.0529353 0.00843943 -0.0286941 0.0168789 0.0208173 -0.00192901 0.00655864 -0.00385802 -0.00475823
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0153356 0.0230035 0.0230035 -0.00766782 -0.0772569 0.115885 0.115885 -0.0386285 -0.0303819 0.0455729 0.0455729 -0.0151910 0.00694444 -0.0104167 -0.0104167 0.00347222
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585938 0.472656 0.644531 -0.515625 -0.0429687
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585937 0.472656 0.644531 -0.515625 -0.0429687
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00347222 -0.0151910 -0.0386285 -0.00766782 0.0416667 -0.182292 -0.463542 -0.0920139 -0.0520833 0.227865 0.579427 0.115017 -0.0381944 0.167101 0.424913 0.0843461
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00217014 0.00737847 -0.00434028 -0.00535301 -0.0260417 0.0885417 -0.0520833 -0.0642361 0.0325521 -0.110677 0.0651042 0.0802951 0.0238715 -0.0811632 0.0477431 0.0588831
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00781250 -0.0117187 -0.0117188 0.00390625 0.0937500 -0.140625 -0.140625 0.0468750 -0.117188 0.175781 0.175781 -0.0585938 -0.0859375 0.128906 0.128906 -0.0429688
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00681584 0.0298193 0.0758263 0.0150517 -0.0343364 0.150222 0.381993 0.0758263 -0.0135031 0.0590760 0.150222 0.0298193 0.00308642 -0.0135031 -0.0343364 -0.00681584 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00425990 -0.0144837 0.00851980 0.0105078 0.0214603 -0.0729649 0.0429205 0.0529353 0.00843943 -0.0286941 0.0168789 0.0208173 -0.00192901 0.00655864 -0.00385802 -0.00475823 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0153356 0.0230035 0.0230035 -0.00766782 -0.0772569 0.115885 0.115885 -0.0386285 -0.0303819 0.0455729 0.0455729 -0.0151910 0.00694444 -0.0104167 -0.0104167 0.00347222 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585938 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585937 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00347222 -0.0151910 -0.0386285 -0.00766782 0.0416667 -0.182292 -0.463542 -0.0920139 -0.0520833 0.227865 0.579427 0.115017 -0.0381944 0.167101 0.424913 0.0843461 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00217014 0.00737847 -0.00434028 -0.00535301 -0.0260417 0.0885417 -0.0520833 -0.0642361 0.0325521 -0.110677 0.0651042 0.0802951 0.0238715 -0.0811632 0.0477431 0.0588831 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00781250 -0.0117187 -0.0117188 0.00390625 0.0937500 -0.140625 -0.140625 0.0468750 -0.117188 0.175781 0.175781 -0.0585938 -0.0859375 0.128906 0.128906 -0.0429688 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00681584 0.0298193 0.0758263 0.0150517 -0.0343364 0.150222 0.381993 0.0758263 -0.0135031 0.0590760 0.150222 0.0298193 0.00308642 -0.0135031 -0.0343364 -0.00681584 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00425990 -0.0144837 0.00851980 0.0105078 0.0214603 -0.0729649 0.0429205 0.0529353 0.00843943 -0.0286941 0.0168789 0.0208173 -0.00192901 0.00655864 -0.00385802 -0.00475823 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0153356 0.0230035 0.0230035 -0.00766782 -0.0772569 0.115885 0.115885 -0.0386285 -0.0303819 0.0455729 0.0455729 -0.0151910 0.00694444 -0.0104167 -0.0104167 0.00347222 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585938 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585937 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00347222 -0.0151910 -0.0386285 -0.00766782 0.0416667 -0.182292 -0.463542 -0.0920139 -0.0520833 0.227865 0.579427 0.115017 -0.0381944 0.167101 0.424913 0.0843461 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00217014 0.00737847 -0.00434028 -0.00535301 -0.0260417 0.0885417 -0.0520833 -0.0642361 0.0325521 -0.110677 0.0651042 0.0802951 0.0238715 -0.0811632 0.0477431 0.0588831 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00781250 -0.0117187 -0.0117188 0.00390625 0.0937500 -0.140625 -0.140625 0.0468750 -0.117188 0.175781 0.175781 -0.0585938 -0.0859375 0.128906 0.128906 -0.0429688 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00681584 0.0298193 0.0758263 0.0150517 -0.0343364 0.150222 0.381993 0.0758263 -0.0135031 0.0590760 0.150222 0.0298193 0.00308642 -0.0135031 -0.0343364 -0.00681584 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00425990 -0.0144837 0.00851980 0.0105078 0.0214603 -0.0729649 0.0429205 0.0529353 0.00843943 -0.0286941 0.0168789 0.0208173 -0.00192901 0.00655864 -0.00385802 -0.00475823 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0153356 0.0230035 0.0230035 -0.00766782 -0.0772569 0.115885 0.115885 -0.0386285 -0.0303819 0.0455729 0.0455729 -0.0151910 0.00694444 -0.0104167 -0.0104167 0.00347222 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585938 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585937 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00347222 -0.0151910 -0.0386285 -0.00766782 0.0416667 -0.182292 -0.463542 -0.0920139 -0.0520833 0.227865 0.579427 0.115017 -0.0381944 0.167101 0.424913 0.0843461 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00217014 0.00737847 -0.00434028 -0.00535301 -0.0260417 0.0885417 -0.0520833 -0.0642361 0.0325521 -0.110677 0.0651042 0.0802951 0.0238715 -0.0811632 0.0477431 0.0588831 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00781250 -0.0117187 -0.0117188 0.00390625 0.0937500 -0.140625 -0.140625 0.0468750 -0.117188 0.175781 0.175781 -0.0585938 -0.0859375 0.128906 0.128906 -0.0429688 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00681584 0.0298193 0.0758263 0.0150517 -0.0343364 0.150222 0.381993 0.0758263 -0.0135031 0.0590760 0.150222 0.0298193 0.00308642 -0.0135031 -0.0343364 -0.00681584 ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00425990 -0.0144837 0.00851980 0.0105078 0.0214603 -0.0729649 0.0429205 0.0529353 0.00843943 -0.0286941 0.0168789 0.0208173 -0.00192901 0.00655864 -0.00385802 -0.00475823 ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0153356 0.0230035 0.0230035 -0.00766782 -0.0772569 0.115885 0.115885 -0.0386285 -0.0303819 0.0455729 0.0455729 -0.0151910 0.00694444 -0.0104167 -0.0104167 0.00347222 ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585938 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585937 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00347222 -0.0151910 -0.0386285 -0.00766782 0.0416667 -0.182292 -0.463542 -0.0920139 -0.0520833 0.227865 0.579427 0.115017 -0.0381944 0.167101 0.424913 0.0843461 ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00217014 0.00737847 -0.00434028 -0.00535301 -0.0260417 0.0885417 -0.0520833 -0.0642361 0.0325521 -0.110677 0.0651042 0.0802951 0.0238715 -0.0811632 0.0477431 0.0588831 ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00781250 -0.0117187 -0.0117188 0.00390625 0.0937500 -0.140625 -0.140625 0.0468750 -0.117188 0.175781 0.175781 -0.0585938 -0.0859375 0.128906 0.128906 -0.0429688 ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ -0.00681584 0.0298193 0.0758263 0.0150517 -0.0343364 0.150222 0.381993 0.0758263 -0.0135031 0.0590760 0.150222 0.0298193 0.00308642 -0.0135031 -0.0343364 -0.00681584
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0.00425990 -0.0144837 0.00851980 0.0105078 0.0214603 -0.0729649 0.0429205 0.0529353 0.00843943 -0.0286941 0.0168789 0.0208173 -0.00192901 0.00655864 -0.00385802 -0.00475823
DEAL::~ ~ ~ ~ ~ ~ ~ ~ -0.0153356 0.0230035 0.0230035 -0.00766782 -0.0772569 0.115885 0.115885 -0.0386285 -0.0303819 0.0455729 0.0455729 -0.0151910 0.00694444 -0.0104167 -0.0104167 0.00347222
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585938 0.472656 0.644531 -0.515625 -0.0429687
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585937 0.472656 0.644531 -0.515625 -0.0429687
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0.00347222 -0.0151910 -0.0386285 -0.00766782 0.0416667 -0.182292 -0.463542 -0.0920139 -0.0520833 0.227865 0.579427 0.115017 -0.0381944 0.167101 0.424913 0.0843461
DEAL::~ ~ ~ ~ ~ ~ ~ ~ -0.00217014 0.00737847 -0.00434028 -0.00535301 -0.0260417 0.0885417 -0.0520833 -0.0642361 0.0325521 -0.110677 0.0651042 0.0802951 0.0238715 -0.0811632 0.0477431 0.0588831
DEAL::~ ~ ~ ~ ~ ~ ~ ~ 0.00781250 -0.0117187 -0.0117188 0.00390625 0.0937500 -0.140625 -0.140625 0.0468750 -0.117188 0.175781 0.175781 -0.0585938 -0.0859375 0.128906 0.128906 -0.0429688
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00681584 0.0298193 0.0758263 0.0150517 -0.0343364 0.150222 0.381993 0.0758263 -0.0135031 0.0590760 0.150222 0.0298193 0.00308642 -0.0135031 -0.0343364 -0.00681584 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00425990 -0.0144837 0.00851980 0.0105078 0.0214603 -0.0729649 0.0429205 0.0529353 0.00843943 -0.0286941 0.0168789 0.0208173 -0.00192901 0.00655864 -0.00385802 -0.00475823 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0153356 0.0230035 0.0230035 -0.00766782 -0.0772569 0.115885 0.115885 -0.0386285 -0.0303819 0.0455729 0.0455729 -0.0151910 0.00694444 -0.0104167 -0.0104167 0.00347222 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585938 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585937 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00347222 -0.0151910 -0.0386285 -0.00766782 0.0416667 -0.182292 -0.463542 -0.0920139 -0.0520833 0.227865 0.579427 0.115017 -0.0381944 0.167101 0.424913 0.0843461 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00217014 0.00737847 -0.00434028 -0.00535301 -0.0260417 0.0885417 -0.0520833 -0.0642361 0.0325521 -0.110677 0.0651042 0.0802951 0.0238715 -0.0811632 0.0477431 0.0588831 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00781250 -0.0117187 -0.0117188 0.00390625 0.0937500 -0.140625 -0.140625 0.0468750 -0.117188 0.175781 0.175781 -0.0585938 -0.0859375 0.128906 0.128906 -0.0429688 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00681584 0.0298193 0.0758263 0.0150517 -0.0343364 0.150222 0.381993 0.0758263 -0.0135031 0.0590760 0.150222 0.0298193 0.00308642 -0.0135031 -0.0343364 -0.00681584 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00425990 -0.0144837 0.00851980 0.0105078 0.0214603 -0.0729649 0.0429205 0.0529353 0.00843943 -0.0286941 0.0168789 0.0208173 -0.00192901 0.00655864 -0.00385802 -0.00475823 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0153356 0.0230035 0.0230035 -0.00766782 -0.0772569 0.115885 0.115885 -0.0386285 -0.0303819 0.0455729 0.0455729 -0.0151910 0.00694444 -0.0104167 -0.0104167 0.00347222 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585938 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585937 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00347222 -0.0151910 -0.0386285 -0.00766782 0.0416667 -0.182292 -0.463542 -0.0920139 -0.0520833 0.227865 0.579427 0.115017 -0.0381944 0.167101 0.424913 0.0843461 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00217014 0.00737847 -0.00434028 -0.00535301 -0.0260417 0.0885417 -0.0520833 -0.0642361 0.0325521 -0.110677 0.0651042 0.0802951 0.0238715 -0.0811632 0.0477431 0.0588831 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00781250 -0.0117187 -0.0117188 0.00390625 0.0937500 -0.140625 -0.140625 0.0468750 -0.117188 0.175781 0.175781 -0.0585938 -0.0859375 0.128906 0.128906 -0.0429688 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00681584 0.0298193 0.0758263 0.0150517 -0.0343364 0.150222 0.381993 0.0758263 -0.0135031 0.0590760 0.150222 0.0298193 0.00308642 -0.0135031 -0.0343364 -0.00681584 ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00425990 -0.0144837 0.00851980 0.0105078 0.0214603 -0.0729649 0.0429205 0.0529353 0.00843943 -0.0286941 0.0168789 0.0208173 -0.00192901 0.00655864 -0.00385802 -0.00475823 ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0153356 0.0230035 0.0230035 -0.00766782 -0.0772569 0.115885 0.115885 -0.0386285 -0.0303819 0.0455729 0.0455729 -0.0151910 0.00694444 -0.0104167 -0.0104167 0.00347222 ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585938 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585937 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00347222 -0.0151910 -0.0386285 -0.00766782 0.0416667 -0.182292 -0.463542 -0.0920139 -0.0520833 0.227865 0.579427 0.115017 -0.0381944 0.167101 0.424913 0.0843461 ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00217014 0.00737847 -0.00434028 -0.00535301 -0.0260417 0.0885417 -0.0520833 -0.0642361 0.0325521 -0.110677 0.0651042 0.0802951 0.0238715 -0.0811632 0.0477431 0.0588831 ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00781250 -0.0117187 -0.0117188 0.00390625 0.0937500 -0.140625 -0.140625 0.0468750 -0.117188 0.175781 0.175781 -0.0585938 -0.0859375 0.128906 0.128906 -0.0429688 ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00681584 0.0298193 0.0758263 0.0150517 -0.0343364 0.150222 0.381993 0.0758263 -0.0135031 0.0590760 0.150222 0.0298193 0.00308642 -0.0135031 -0.0343364 -0.00681584 ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00425990 -0.0144837 0.00851980 0.0105078 0.0214603 -0.0729649 0.0429205 0.0529353 0.00843943 -0.0286941 0.0168789 0.0208173 -0.00192901 0.00655864 -0.00385802 -0.00475823 ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0153356 0.0230035 0.0230035 -0.00766782 -0.0772569 0.115885 0.115885 -0.0386285 -0.0303819 0.0455729 0.0455729 -0.0151910 0.00694444 -0.0104167 -0.0104167 0.00347222 ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585938 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585937 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00347222 -0.0151910 -0.0386285 -0.00766782 0.0416667 -0.182292 -0.463542 -0.0920139 -0.0520833 0.227865 0.579427 0.115017 -0.0381944 0.167101 0.424913 0.0843461 ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00217014 0.00737847 -0.00434028 -0.00535301 -0.0260417 0.0885417 -0.0520833 -0.0642361 0.0325521 -0.110677 0.0651042 0.0802951 0.0238715 -0.0811632 0.0477431 0.0588831 ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00781250 -0.0117187 -0.0117188 0.00390625 0.0937500 -0.140625 -0.140625 0.0468750 -0.117188 0.175781 0.175781 -0.0585938 -0.0859375 0.128906 0.128906 -0.0429688 ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00681584 0.0298193 0.0758263 0.0150517 -0.0343364 0.150222 0.381993 0.0758263 -0.0135031 0.0590760 0.150222 0.0298193 0.00308642 -0.0135031 -0.0343364 -0.00681584 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00425990 -0.0144837 0.00851980 0.0105078 0.0214603 -0.0729649 0.0429205 0.0529353 0.00843943 -0.0286941 0.0168789 0.0208173 -0.00192901 0.00655864 -0.00385802 -0.00475823 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0153356 0.0230035 0.0230035 -0.00766782 -0.0772569 0.115885 0.115885 -0.0386285 -0.0303819 0.0455729 0.0455729 -0.0151910 0.00694444 -0.0104167 -0.0104167 0.00347222 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585938 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585937 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00347222 -0.0151910 -0.0386285 -0.00766782 0.0416667 -0.182292 -0.463542 -0.0920139 -0.0520833 0.227865 0.579427 0.115017 -0.0381944 0.167101 0.424913 0.0843461 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00217014 0.00737847 -0.00434028 -0.00535301 -0.0260417 0.0885417 -0.0520833 -0.0642361 0.0325521 -0.110677 0.0651042 0.0802951 0.0238715 -0.0811632 0.0477431 0.0588831 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00781250 -0.0117187 -0.0117188 0.00390625 0.0937500 -0.140625 -0.140625 0.0468750 -0.117188 0.175781 0.175781 -0.0585938 -0.0859375 0.128906 0.128906 -0.0429688 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00681584 0.0298193 0.0758263 0.0150517 -0.0343364 0.150222 0.381993 0.0758263 -0.0135031 0.0590760 0.150222 0.0298193 0.00308642 -0.0135031 -0.0343364 -0.00681584 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00425990 -0.0144837 0.00851980 0.0105078 0.0214603 -0.0729649 0.0429205 0.0529353 0.00843943 -0.0286941 0.0168789 0.0208173 -0.00192901 0.00655864 -0.00385802 -0.00475823 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0153356 0.0230035 0.0230035 -0.00766782 -0.0772569 0.115885 0.115885 -0.0386285 -0.0303819 0.0455729 0.0455729 -0.0151910 0.00694444 -0.0104167 -0.0104167 0.00347222 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585938 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585937 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00347222 -0.0151910 -0.0386285 -0.00766782 0.0416667 -0.182292 -0.463542 -0.0920139 -0.0520833 0.227865 0.579427 0.115017 -0.0381944 0.167101 0.424913 0.0843461 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00217014 0.00737847 -0.00434028 -0.00535301 -0.0260417 0.0885417 -0.0520833 -0.0642361 0.0325521 -0.110677 0.0651042 0.0802951 0.0238715 -0.0811632 0.0477431 0.0588831 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00781250 -0.0117187 -0.0117188 0.00390625 0.0937500 -0.140625 -0.140625 0.0468750 -0.117188 0.175781 0.175781 -0.0585938 -0.0859375 0.128906 0.128906 -0.0429688 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00681584 0.0298193 0.0758263 0.0150517 -0.0343364 0.150222 0.381993 0.0758263 -0.0135031 0.0590760 0.150222 0.0298193 0.00308642 -0.0135031 -0.0343364 -0.00681584 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00425990 -0.0144837 0.00851980 0.0105078 0.0214603 -0.0729649 0.0429205 0.0529353 0.00843943 -0.0286941 0.0168789 0.0208173 -0.00192901 0.00655864 -0.00385802 -0.00475823 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0153356 0.0230035 0.0230035 -0.00766782 -0.0772569 0.115885 0.115885 -0.0386285 -0.0303819 0.0455729 0.0455729 -0.0151910 0.00694444 -0.0104167 -0.0104167 0.00347222 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
-DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585938 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
+DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.0429687 -0.0585937 0.0468750 0.00390625 -0.515625 -0.703125 0.562500 0.0468750 0.644531 0.878906 -0.703125 -0.0585937 0.472656 0.644531 -0.515625 -0.0429687 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00347222 -0.0151910 -0.0386285 -0.00766782 0.0416667 -0.182292 -0.463542 -0.0920139 -0.0520833 0.227865 0.579427 0.115017 -0.0381944 0.167101 0.424913 0.0843461 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ -0.00217014 0.00737847 -0.00434028 -0.00535301 -0.0260417 0.0885417 -0.0520833 -0.0642361 0.0325521 -0.110677 0.0651042 0.0802951 0.0238715 -0.0811632 0.0477431 0.0588831 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
DEAL::~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ 0.00781250 -0.0117187 -0.0117188 0.00390625 0.0937500 -0.140625 -0.140625 0.0468750 -0.117188 0.175781 0.175781 -0.0585938 -0.0859375 0.128906 0.128906 -0.0429688 ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~ ~
// $Id$
// Version: $Name$
//
-// Copyright (C) 2006, 2007 by the deal.II authors
+// Copyright (C) 2006, 2007, 2012 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
template <int dim>
void test ()
{
+ deallog << std::setprecision (4);
for (unsigned int i=1; i<4; ++i)
for (unsigned int j=i; j<4; ++j)
do_check (FE_Q<dim>(i), FE_Q<dim>(j));
// rt_5.cc,v 1.1 2003/06/09 15:59:07 wolf Exp
// Version:
//
-// Copyright (C) 2003, 2004, 2005, 2006, 2008, 2009, 2010 by the deal.II authors
+// Copyright (C) 2003, 2004, 2005, 2006, 2008, 2009, 2010, 2012 by the deal.II authors
//
// This file is subject to QPL and may not be distributed
// without copyright and license information. Please refer
#include <fstream>
#include <string>
-#define PRECISION 5
+#define PRECISION 6
DEAL::FE_RaviartThomas<2> (0)
-DEAL::0.50000 0 0 0
+DEAL::0.500000 0 0 0
DEAL::0 0 0 0
-DEAL::0 0 0.50000 0
+DEAL::0 0 0.500000 0
DEAL::0 0 0 0
DEAL::
DEAL::0 0 0 0
-DEAL::0 0.50000 0 0
-DEAL::0 0 0.50000 0
+DEAL::0 0.500000 0 0
+DEAL::0 0 0.500000 0
DEAL::0 0 0 0
DEAL::
-DEAL::0.50000 0 0 0
+DEAL::0.500000 0 0 0
DEAL::0 0 0 0
DEAL::0 0 0 0
-DEAL::0 0 0 0.50000
+DEAL::0 0 0 0.500000
DEAL::
DEAL::0 0 0 0
-DEAL::0 0.50000 0 0
+DEAL::0 0.500000 0 0
DEAL::0 0 0 0
-DEAL::0 0 0 0.50000
+DEAL::0 0 0 0.500000
DEAL::
DEAL::FE_RaviartThomas<3> (0)
-DEAL::0.25000 0 0 0 0 0
+DEAL::0.250000 0 0 0 0 0
DEAL::0 0 0 0 0 0
-DEAL::0 0 0.25000 0 0 0
+DEAL::0 0 0.250000 0 0 0
DEAL::0 0 0 0 0 0
-DEAL::0 0 0 0 0.25000 0
+DEAL::0 0 0 0 0.250000 0
DEAL::0 0 0 0 0 0
DEAL::
DEAL::0 0 0 0 0 0
-DEAL::0 0.25000 0 0 0 0
-DEAL::0 0 0.25000 0 0 0
+DEAL::0 0.250000 0 0 0 0
+DEAL::0 0 0.250000 0 0 0
DEAL::0 0 0 0 0 0
-DEAL::0 0 0 0 0.25000 0
+DEAL::0 0 0 0 0.250000 0
DEAL::0 0 0 0 0 0
DEAL::
-DEAL::0.25000 0 0 0 0 0
+DEAL::0.250000 0 0 0 0 0
DEAL::0 0 0 0 0 0
DEAL::0 0 0 0 0 0
-DEAL::0 0 0 0.25000 0 0
-DEAL::0 0 0 0 0.25000 0
+DEAL::0 0 0 0.250000 0 0
+DEAL::0 0 0 0 0.250000 0
DEAL::0 0 0 0 0 0
DEAL::
DEAL::0 0 0 0 0 0
-DEAL::0 0.25000 0 0 0 0
+DEAL::0 0.250000 0 0 0 0
DEAL::0 0 0 0 0 0
-DEAL::0 0 0 0.25000 0 0
-DEAL::0 0 0 0 0.25000 0
+DEAL::0 0 0 0.250000 0 0
+DEAL::0 0 0 0 0.250000 0
DEAL::0 0 0 0 0 0
DEAL::
-DEAL::0.25000 0 0 0 0 0
+DEAL::0.250000 0 0 0 0 0
DEAL::0 0 0 0 0 0
-DEAL::0 0 0.25000 0 0 0
+DEAL::0 0 0.250000 0 0 0
DEAL::0 0 0 0 0 0
DEAL::0 0 0 0 0 0
-DEAL::0 0 0 0 0 0.25000
+DEAL::0 0 0 0 0 0.250000
DEAL::
DEAL::0 0 0 0 0 0
-DEAL::0 0.25000 0 0 0 0
-DEAL::0 0 0.25000 0 0 0
+DEAL::0 0.250000 0 0 0 0
+DEAL::0 0 0.250000 0 0 0
DEAL::0 0 0 0 0 0
DEAL::0 0 0 0 0 0
-DEAL::0 0 0 0 0 0.25000
+DEAL::0 0 0 0 0 0.250000
DEAL::
-DEAL::0.25000 0 0 0 0 0
+DEAL::0.250000 0 0 0 0 0
DEAL::0 0 0 0 0 0
DEAL::0 0 0 0 0 0
-DEAL::0 0 0 0.25000 0 0
+DEAL::0 0 0 0.250000 0 0
DEAL::0 0 0 0 0 0
-DEAL::0 0 0 0 0 0.25000
+DEAL::0 0 0 0 0 0.250000
DEAL::
DEAL::0 0 0 0 0 0
-DEAL::0 0.25000 0 0 0 0
+DEAL::0 0.250000 0 0 0 0
DEAL::0 0 0 0 0 0
-DEAL::0 0 0 0.25000 0 0
+DEAL::0 0 0 0.250000 0 0
DEAL::0 0 0 0 0 0
-DEAL::0 0 0 0 0 0.25000
+DEAL::0 0 0 0 0 0.250000
DEAL::
DEAL::FE_RaviartThomas<2> (1)
-DEAL::0.50000 0 0 0 0 0 0 0 0 0 0 0
-DEAL::-0.43301 0.25000 0 0 0 0 0 0 0 0 0 0
+DEAL::0.500000 0 0 0 0 0 0 0 0 0 0 0
+DEAL::-0.433013 0.250000 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0.50000 0 0 0 0 0 0 0
-DEAL::0 0 0 0 -0.43301 0.25000 0 0 0 0 0 0
+DEAL::0 0 0 0 0.500000 0 0 0 0 0 0 0
+DEAL::0 0 0 0 -0.433013 0.250000 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0.25000 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0.25000 0 0
-DEAL::0 0 0 0 0 0 0 0 -0.21651 0 0.12500 0
-DEAL::0 0 0 0 0 0 0 0 0 -0.21651 0 0.12500
+DEAL::0 0 0 0 0 0 0 0 0.250000 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0.250000 0 0
+DEAL::0 0 0 0 0 0 0 0 -0.216506 0 0.125000 0
+DEAL::0 0 0 0 0 0 0 0 0 -0.216506 0 0.125000
DEAL::
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0.50000 0 0 0 0 0 0 0 0 0
-DEAL::0 0 -0.43301 0.25000 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0.50000 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0.43301 0.25000 0 0 0 0 0 0
+DEAL::0 0 0.500000 0 0 0 0 0 0 0 0 0
+DEAL::0 0 -0.433013 0.250000 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0.500000 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0.433013 0.250000 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0.25000 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0.25000 0 0
-DEAL::0 0 0 0 0 0 0 0 -0.21651 0 0.12500 0
-DEAL::0 0 0 0 0 0 0 0 0 0.21651 0 0.12500
+DEAL::0 0 0 0 0 0 0 0 0.250000 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0.250000 0 0
+DEAL::0 0 0 0 0 0 0 0 -0.216506 0 0.125000 0
+DEAL::0 0 0 0 0 0 0 0 0 0.216506 0 0.125000
DEAL::
-DEAL::0.50000 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0.43301 0.25000 0 0 0 0 0 0 0 0 0 0
+DEAL::0.500000 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0.433013 0.250000 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0.50000 0 0 0 0 0
-DEAL::0 0 0 0 0 0 -0.43301 0.25000 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0.25000 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0.25000 0 0
-DEAL::0 0 0 0 0 0 0 0 0.21651 0 0.12500 0
-DEAL::0 0 0 0 0 0 0 0 0 -0.21651 0 0.12500
+DEAL::0 0 0 0 0 0 0.500000 0 0 0 0 0
+DEAL::0 0 0 0 0 0 -0.433013 0.250000 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0.250000 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0.250000 0 0
+DEAL::0 0 0 0 0 0 0 0 0.216506 0 0.125000 0
+DEAL::0 0 0 0 0 0 0 0 0 -0.216506 0 0.125000
DEAL::
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0.50000 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0.43301 0.25000 0 0 0 0 0 0 0 0
+DEAL::0 0 0.500000 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0.433013 0.250000 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0.50000 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0.43301 0.25000 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0.25000 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0.25000 0 0
-DEAL::0 0 0 0 0 0 0 0 0.21651 0 0.12500 0
-DEAL::0 0 0 0 0 0 0 0 0 0.21651 0 0.12500
+DEAL::0 0 0 0 0 0 0.500000 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0.433013 0.250000 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0.250000 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0.250000 0 0
+DEAL::0 0 0 0 0 0 0 0 0.216506 0 0.125000 0
+DEAL::0 0 0 0 0 0 0 0 0 0.216506 0 0.125000
DEAL::
DEAL::FE_RaviartThomas<3> (1)
-DEAL::0.25000 0 0 0 0 0 0 0 0 0 0 0 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::-0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 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::-0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 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::0.18750 -0.10825 -0.10825 0.06250 0 0 0 0 0 0 0 0 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::0.250000 0 0 0 0 0 0 0 0 0 0 0 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::-0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 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::-0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 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::0.187500 -0.108253 -0.108253 0.062500 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0.25000 0 0 0 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::0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 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::0 0 0 0 0 0 0 0 -0.21651 0 0.12500 0 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::0 0 0 0 0 0 0 0 0.18750 -0.10825 -0.10825 0.06250 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::0 0 0 0 0 0 0 0 0.250000 0 0 0 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::0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 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::0 0 0 0 0 0 0 0 -0.216506 0 0.125000 0 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::0 0 0 0 0 0 0 0 0.187500 -0.108253 -0.108253 0.062500 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.18750 -0.10825 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.187500 -0.108253 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 -0.05413 0 0 0.03125 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 -0.05413 0 0 0.03125 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 -0.05413 0 0 0.03125
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 -0.054127 0 0 0.031250 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 -0.054127 0 0 0.031250 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 -0.054127 0 0 0.031250
DEAL::
DEAL::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0.25000 0 0 0 0 0 0 0 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::0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 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::0 0 0 0 -0.21651 0 0.12500 0 0 0 0 0 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::0 0 0 0 0.18750 -0.10825 -0.10825 0.06250 0 0 0 0 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::0 0 0 0 0 0 0 0 0.25000 0 0 0 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::0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 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::0 0 0 0 0 0 0 0 0.21651 0 0.12500 0 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::0 0 0 0 0 0 0 0 -0.18750 0.10825 -0.10825 0.06250 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::0 0 0 0 0.250000 0 0 0 0 0 0 0 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::0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 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::0 0 0 0 -0.216506 0 0.125000 0 0 0 0 0 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::0 0 0 0 0.187500 -0.108253 -0.108253 0.062500 0 0 0 0 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::0 0 0 0 0 0 0 0 0.250000 0 0 0 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::0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 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::0 0 0 0 0 0 0 0 0.216506 0 0.125000 0 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::0 0 0 0 0 0 0 0 -0.187500 0.108253 -0.108253 0.062500 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 -0.10825 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 -0.108253 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 -0.05413 0 0 0.03125 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0.05413 0 0 0.03125 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0.05413 0 0 0.03125
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 -0.054127 0 0 0.031250 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0.054127 0 0 0.031250 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0.054127 0 0 0.031250
DEAL::
-DEAL::0.25000 0 0 0 0 0 0 0 0 0 0 0 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::0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 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::-0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 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::-0.18750 -0.10825 0.10825 0.06250 0 0 0 0 0 0 0 0 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::0.250000 0 0 0 0 0 0 0 0 0 0 0 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::0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 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::-0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 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::-0.187500 -0.108253 0.108253 0.062500 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.18750 -0.10825 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 0.10825 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.187500 -0.108253 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 0.108253 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0.05413 0 0 0.03125 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 -0.05413 0 0 0.03125 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 -0.05413 0 0 0.03125
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0.054127 0 0 0.031250 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 -0.054127 0 0 0.031250 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 -0.054127 0 0 0.031250
DEAL::
DEAL::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0.25000 0 0 0 0 0 0 0 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::0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 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::0 0 0 0 -0.21651 0 0.12500 0 0 0 0 0 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::0 0 0 0 -0.18750 -0.10825 0.10825 0.06250 0 0 0 0 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::0 0 0 0 0.250000 0 0 0 0 0 0 0 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::0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 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::0 0 0 0 -0.216506 0 0.125000 0 0 0 0 0 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::0 0 0 0 -0.187500 -0.108253 0.108253 0.062500 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 0.10825 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.18750 0.10825 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 0.108253 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.187500 0.108253 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0.05413 0 0 0.03125 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0.05413 0 0 0.03125 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0.05413 0 0 0.03125
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0.054127 0 0 0.031250 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0.054127 0 0 0.031250 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0.054127 0 0 0.031250
DEAL::
-DEAL::0.25000 0 0 0 0 0 0 0 0 0 0 0 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::-0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 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::0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 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::-0.18750 0.10825 -0.10825 0.06250 0 0 0 0 0 0 0 0 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::0.250000 0 0 0 0 0 0 0 0 0 0 0 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::-0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 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::0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 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::-0.187500 0.108253 -0.108253 0.062500 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0.25000 0 0 0 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::0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 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::0 0 0 0 0 0 0 0 -0.21651 0 0.12500 0 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::0 0 0 0 0 0 0 0 -0.18750 -0.10825 0.10825 0.06250 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::0 0 0 0 0 0 0 0 0.250000 0 0 0 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::0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 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::0 0 0 0 0 0 0 0 -0.216506 0 0.125000 0 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::0 0 0 0 0 0 0 0 -0.187500 -0.108253 0.108253 0.062500 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.18750 -0.10825 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 -0.05413 0 0 0.03125 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 -0.05413 0 0 0.03125 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 -0.05413 0 0 0.03125
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.187500 -0.108253 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 -0.054127 0 0 0.031250 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 -0.054127 0 0 0.031250 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 -0.054127 0 0 0.031250
DEAL::
DEAL::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0.25000 0 0 0 0 0 0 0 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::0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 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::0 0 0 0 0.21651 0 0.12500 0 0 0 0 0 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::0 0 0 0 -0.18750 0.10825 -0.10825 0.06250 0 0 0 0 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::0 0 0 0 0 0 0 0 0.25000 0 0 0 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::0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 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::0 0 0 0 0 0 0 0 0.21651 0 0.12500 0 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::0 0 0 0 0 0 0 0 0.18750 0.10825 0.10825 0.06250 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::0 0 0 0 0.250000 0 0 0 0 0 0 0 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::0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 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::0 0 0 0 0.216506 0 0.125000 0 0 0 0 0 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::0 0 0 0 -0.187500 0.108253 -0.108253 0.062500 0 0 0 0 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::0 0 0 0 0 0 0 0 0.250000 0 0 0 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::0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 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::0 0 0 0 0 0 0 0 0.216506 0 0.125000 0 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::0 0 0 0 0 0 0 0 0.187500 0.108253 0.108253 0.062500 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 -0.10825 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 -0.05413 0 0 0.03125 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0.05413 0 0 0.03125 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0.05413 0 0 0.03125
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 -0.108253 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 -0.054127 0 0 0.031250 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0.054127 0 0 0.031250 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0.054127 0 0 0.031250
DEAL::
-DEAL::0.25000 0 0 0 0 0 0 0 0 0 0 0 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::0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 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::0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 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::0.18750 0.10825 0.10825 0.06250 0 0 0 0 0 0 0 0 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::0.250000 0 0 0 0 0 0 0 0 0 0 0 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::0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 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::0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 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::0.187500 0.108253 0.108253 0.062500 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 -0.10825 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 -0.108253 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 0.10825 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0.05413 0 0 0.03125 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 -0.05413 0 0 0.03125 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 -0.05413 0 0 0.03125
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 0.108253 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0.054127 0 0 0.031250 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 -0.054127 0 0 0.031250 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 -0.054127 0 0 0.031250
DEAL::
DEAL::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0.25000 0 0 0 0 0 0 0 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::0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 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::0 0 0 0 0.21651 0 0.12500 0 0 0 0 0 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::0 0 0 0 0.18750 0.10825 0.10825 0.06250 0 0 0 0 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::0 0 0 0 0.250000 0 0 0 0 0 0 0 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::0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 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::0 0 0 0 0.216506 0 0.125000 0 0 0 0 0 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::0 0 0 0 0.187500 0.108253 0.108253 0.062500 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.18750 0.10825 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.187500 0.108253 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
DEAL::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.18750 0.10825 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0.05413 0 0 0.03125 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0.05413 0 0 0.03125 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0.05413 0 0 0.03125
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.187500 0.108253 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0.054127 0 0 0.031250 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0.054127 0 0 0.031250 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0.054127 0 0 0.031250
DEAL::
DEAL::FE_RaviartThomas<2> (2)
-DEAL::0.50000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::-0.43301 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 -0.48412 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0.500000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::-0.433013 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 -0.484123 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
DEAL::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::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::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::0 0 0 0 0 0 0.50000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 -0.43301 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 -0.48412 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0.500000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 -0.433013 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 -0.484123 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
DEAL::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::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::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::0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0.12500 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0.12500 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0 0 0.12500 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0 0.06250 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.18750 0 -0.10825 0 -0.10825 0 0.06250 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0 0 0 0 0.12500 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0 0 0 0.06250 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.18750 0 -0.10825 0 0 0 -0.10825 0 0.06250 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 0 -0.12103 0 -0.05413 0 0.03125 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 0 -0.05413 0 0 0 -0.12103 0 0.03125
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0.125000 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0.125000 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0 0 0.125000 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0 0.062500 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.187500 0 -0.108253 0 -0.108253 0 0.062500 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0 0 0 0 0.125000 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0 0 0 0.062500 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.187500 0 -0.108253 0 0 0 -0.108253 0 0.062500 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 0 -0.121031 0 -0.054127 0 0.031250 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 0 -0.054127 0 0 0 -0.121031 0 0.031250
DEAL::
DEAL::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::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::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::0 0 0 0.50000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 -0.43301 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 -0.48412 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0.50000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0.43301 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0.48412 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0.500000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 -0.433013 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 -0.484123 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0.500000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0.433013 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0.484123 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
DEAL::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::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::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::0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0.12500 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0.12500 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0 0 0.12500 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0 0.06250 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 0 -0.10825 0 0.10825 0 0.06250 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0 0 0 0 0.12500 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0 0 0 0.06250 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 0 -0.10825 0 0 0 0.10825 0 0.06250 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 0 -0.12103 0 0.05413 0 0.03125 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 0 -0.05413 0 0 0 0.12103 0 0.03125
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0.125000 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0.125000 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0 0 0.125000 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0 0.062500 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 0 -0.108253 0 0.108253 0 0.062500 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0 0 0 0 0.125000 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0 0 0 0.062500 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 0 -0.108253 0 0 0 0.108253 0 0.062500 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 0 -0.121031 0 0.054127 0 0.031250 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 0 -0.054127 0 0 0 0.121031 0 0.031250
DEAL::
-DEAL::0.50000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0.43301 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0.48412 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0.500000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0.433013 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0.484123 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
DEAL::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::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::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::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::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::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::0 0 0 0 0 0 0 0 0 0.50000 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 -0.43301 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 -0.48412 0.12500 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0.12500 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0.12500 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0 0 0.12500 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0 0.06250 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 0 0.10825 0 -0.10825 0 0.06250 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0 0 0 0 0.12500 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0 0 0 0.06250 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 0 0.10825 0 0 0 -0.10825 0 0.06250 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 0 0.12103 0 -0.05413 0 0.03125 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 0 0.05413 0 0 0 -0.12103 0 0.03125
+DEAL::0 0 0 0 0 0 0 0 0 0.500000 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 -0.433013 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 -0.484123 0.125000 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0.125000 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0.125000 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0 0 0.125000 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0 0.062500 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 0 0.108253 0 -0.108253 0 0.062500 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0 0 0 0 0.125000 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0 0 0 0.062500 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 0 0.108253 0 0 0 -0.108253 0 0.062500 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 0 0.121031 0 -0.054127 0 0.031250 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 0 0.054127 0 0 0 -0.121031 0 0.031250
DEAL::
DEAL::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::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::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::0 0 0 0.50000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0.43301 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0.48412 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0.500000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0.433013 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0.484123 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
DEAL::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::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::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::0 0 0 0 0 0 0 0 0 0.50000 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0.43301 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0.48412 0.12500 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0.12500 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0.12500 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0 0 0.12500 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0 0.06250 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.18750 0 0.10825 0 0.10825 0 0.06250 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0 0 0 0 0.12500 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0 0 0 0.06250 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.18750 0 0.10825 0 0 0 0.10825 0 0.06250 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 0 0.12103 0 0.05413 0 0.03125 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 0 0.05413 0 0 0 0.12103 0 0.03125
+DEAL::0 0 0 0 0 0 0 0 0 0.500000 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0.433013 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0.484123 0.125000 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0.125000 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0.125000 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0 0 0.125000 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0 0.062500 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0.187500 0 0.108253 0 0.108253 0 0.062500 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0 0 0 0 0.125000 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0 0 0 0.062500 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0.187500 0 0.108253 0 0 0 0.108253 0 0.062500 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 0 0.121031 0 0.054127 0 0.031250 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 0 0.054127 0 0 0 0.121031 0 0.031250
DEAL::
DEAL::FE_RaviartThomas<3> (2)
-DEAL::0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::-0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 -0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::-0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.18750 -0.10825 0 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0.20963 -0.05413 0 -0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 -0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0.20963 -0.12103 0 -0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0.23437 -0.06052 0 -0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::-0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 -0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::-0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.187500 -0.108253 0 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0.209631 -0.054127 0 -0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 -0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0.209631 -0.121031 0 -0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0.234375 -0.060515 0 -0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.18750 -0.10825 0 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 -0.05413 0 -0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 -0.12103 0 -0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.23437 -0.06052 0 -0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.187500 -0.108253 0 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 -0.054127 0 -0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 -0.121031 0 -0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.234375 -0.060515 0 -0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.18750 -0.10825 0 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 -0.05413 0 -0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 -0.12103 0 -0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.23437 -0.06052 0 -0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.187500 -0.108253 0 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 -0.054127 0 -0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 -0.121031 0 -0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.234375 -0.060515 0 -0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.06052 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.02706 0 0 0 0 0 -0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.02706 0 0 0 0 0 -0.06052 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.06052 0 0 0 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0.03125 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0.01562 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.11719 0 0 -0.03026 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.08119 0 0 0.04687 0 0 0.04687 0 0 -0.02706 0 0 0 0 0 0 0 0 0.04687 0 0 -0.02706 0 0 -0.02706 0 0 0.01562 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0.03125 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.08119 0 0 0.04687 0 0 0 0 0 0.04687 0 0 -0.02706 0 0 0 0 0 0.04687 0 0 -0.02706 0 0 0 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 0.05241 0 0 0.02344 0 0 -0.01353 0 0 0 0 0 0 0 0 0.05241 0 0 -0.03026 0 0 -0.01353 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 0.02344 0 0 0 0 0 0.05241 0 0 -0.01353 0 0 0 0 0 0.05241 0 0 -0.01353 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.08119 0 0 0.04687 0 0 0 0 0 0.04688 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.04688 0 0 -0.02706 0 0 0 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 -0.06052 0 0 0 0 0 0 0 0 0 0 0 -0.02706 0 0 0 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.11719 0 0 -0.03026 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 0.02344 0 0 0 0 0 0.05241 0 0 -0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05241 0 0 -0.01353 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 0.05241 0 0 0.05241 0 0 -0.03026 0 0 0 0 0 0 0 0 0.02344 0 0 -0.01353 0 0 -0.01353 0 0 0.00781 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 0 0 0 -0.06052 0 0 0 0 0 0 0 0 -0.02706 0 0 0 0 0 0 0 0 0.01562 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 0 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0 0 0 0 0 0 0.01562 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.11719 0 0 0 0 0 -0.03026 0 0 0 0 0 0 0 0 0 0 0 -0.03026 0 0 0 0 0 0.00781 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 0.05241 0 0 0 0 0 0.05241 0 0 -0.03026 0 0 0 0 0 0.02344 0 0 -0.01353 0 0 0 0 0 -0.01353 0 0 0.00781 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 0.05241 0 0 0 0 0 0.02344 0 0 -0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05241 0 0 -0.03026 0 0 0 0 0 -0.01353 0 0 0.00781 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10149 0 0 0.05859 0 0 0.02620 0 0 -0.01513 0 0 0 0 0 0 0 0 0.02620 0 0 -0.01513 0 0 -0.00677 0 0 0.00391 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10149 0 0 0.02620 0 0 0 0 0 0.05859 0 0 -0.01513 0 0 0 0 0 0.02620 0 0 -0.00677 0 0 0 0 0 -0.01513 0 0 0.00391 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10149 0 0 0.02620 0 0 0 0 0 0.02620 0 0 -0.00677 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05859 0 0 -0.01513 0 0 0 0 0 -0.01513 0 0 0.00391
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.060515 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.027063 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.027063 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.060515 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0.031250 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.117188 0 0 -0.030258 0 0 0 0 0 -0.030258 0 0 0.007812 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.081190 0 0 0.046875 0 0 0.046875 0 0 -0.027063 0 0 0 0 0 0 0 0 0.046875 0 0 -0.027063 0 0 -0.027063 0 0 0.015625 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0.031250 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.081190 0 0 0.046875 0 0 0 0 0 0.046875 0 0 -0.027063 0 0 0 0 0 0.046875 0 0 -0.027063 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 0.052408 0 0 0.023437 0 0 -0.013532 0 0 0 0 0 0 0 0 0.052408 0 0 -0.030258 0 0 -0.013532 0 0 0.007812 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 0.023437 0 0 0 0 0 0.052408 0 0 -0.013532 0 0 0 0 0 0.052408 0 0 -0.013532 0 0 0 0 0 -0.030258 0 0 0.007812 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.081190 0 0 0.046875 0 0 0 0 0 0.046875 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.046875 0 0 -0.027063 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 -0.060515 0 0 0 0 0 0 0 0 0 0 0 -0.027063 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.117188 0 0 -0.030258 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.030258 0 0 0.007812 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 0.023437 0 0 0 0 0 0.052408 0 0 -0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.052408 0 0 -0.013532 0 0 0 0 0 -0.030258 0 0 0.007812 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 0.052408 0 0 0.052408 0 0 -0.030258 0 0 0 0 0 0 0 0 0.023437 0 0 -0.013532 0 0 -0.013532 0 0 0.007812 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 0 0 0 -0.060515 0 0 0 0 0 0 0 0 -0.027063 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 0 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.117188 0 0 0 0 0 -0.030258 0 0 0 0 0 0 0 0 0 0 0 -0.030258 0 0 0 0 0 0.007812 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 0.052408 0 0 0 0 0 0.052408 0 0 -0.030258 0 0 0 0 0 0.023437 0 0 -0.013532 0 0 0 0 0 -0.013532 0 0 0.007812 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 0.052408 0 0 0 0 0 0.023437 0 0 -0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.052408 0 0 -0.030258 0 0 0 0 0 -0.013532 0 0 0.007812 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.101487 0 0 0.058594 0 0 0.026204 0 0 -0.015129 0 0 0 0 0 0 0 0 0.026204 0 0 -0.015129 0 0 -0.006766 0 0 0.003906 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.101487 0 0 0.026204 0 0 0 0 0 0.058594 0 0 -0.015129 0 0 0 0 0 0.026204 0 0 -0.006766 0 0 0 0 0 -0.015129 0 0 0.003906 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.101487 0 0 0.026204 0 0 0 0 0 0.026204 0 0 -0.006766 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.058594 0 0 -0.015129 0 0 0 0 0 -0.015129 0 0 0.003906
DEAL::
DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 -0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 -0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.18750 -0.10825 0 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0.20963 -0.05413 0 -0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0.20963 -0.12103 0 -0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0.23437 -0.06052 0 -0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 0.10825 0 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 0.05413 0 -0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 0.12103 0 -0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.23437 0.06052 0 -0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 -0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 -0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.187500 -0.108253 0 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0.209631 -0.054127 0 -0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0.209631 -0.121031 0 -0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0.234375 -0.060515 0 -0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 0.108253 0 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 0.054127 0 -0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 0.121031 0 -0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.234375 0.060515 0 -0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 -0.10825 0 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 -0.05413 0 0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 -0.12103 0 0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.23438 -0.06052 0 0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 -0.108253 0 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 -0.054127 0 0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 -0.121031 0 0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.234375 -0.060515 0 0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.06052 0 0 0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.02706 0 0 0 0 0 0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.02706 0 0 0 0 0 0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.06052 0 0 0 0 0 0.02706 0 0 0.01562 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0.03125 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0.01563 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.11719 0 0 -0.03026 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.08119 0 0 0.04687 0 0 -0.04688 0 0 -0.02706 0 0 0 0 0 0 0 0 -0.04688 0 0 -0.02706 0 0 0.02706 0 0 0.01562 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0.03125 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.08119 0 0 0.04688 0 0 0 0 0 -0.04687 0 0 -0.02706 0 0 0 0 0 -0.04687 0 0 -0.02706 0 0 0 0 0 0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 0.05241 0 0 -0.02344 0 0 -0.01353 0 0 0 0 0 0 0 0 -0.05241 0 0 -0.03026 0 0 0.01353 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 0.02344 0 0 0 0 0 -0.05241 0 0 -0.01353 0 0 0 0 0 -0.05241 0 0 -0.01353 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.08119 0 0 0.04688 0 0 0 0 0 -0.04688 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.04688 0 0 -0.02706 0 0 0 0 0 0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 -0.06052 0 0 0 0 0 0 0 0 0 0 0 -0.02706 0 0 0 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.11719 0 0 -0.03026 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 0.02344 0 0 0 0 0 -0.05241 0 0 -0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05241 0 0 -0.01353 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 0.05241 0 0 -0.05241 0 0 -0.03026 0 0 0 0 0 0 0 0 -0.02344 0 0 -0.01353 0 0 0.01353 0 0 0.00781 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 0 0 0 -0.06052 0 0 0 0 0 0 0 0 -0.02706 0 0 0 0 0 0 0 0 0.01562 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 0 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0 0 0 0 0 0 0.01562 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.11719 0 0 0 0 0 -0.03026 0 0 0 0 0 0 0 0 0 0 0 -0.03026 0 0 0 0 0 0.00781 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 0.05241 0 0 0 0 0 -0.05241 0 0 -0.03026 0 0 0 0 0 -0.02344 0 0 -0.01353 0 0 0 0 0 0.01353 0 0 0.00781 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 0.05241 0 0 0 0 0 -0.02344 0 0 -0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05241 0 0 -0.03026 0 0 0 0 0 0.01353 0 0 0.00781 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10149 0 0 0.05859 0 0 -0.02620 0 0 -0.01513 0 0 0 0 0 0 0 0 -0.02620 0 0 -0.01513 0 0 0.00677 0 0 0.00391 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10149 0 0 0.02620 0 0 0 0 0 -0.05859 0 0 -0.01513 0 0 0 0 0 -0.02620 0 0 -0.00677 0 0 0 0 0 0.01513 0 0 0.00391 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10149 0 0 0.02620 0 0 0 0 0 -0.02620 0 0 -0.00677 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05859 0 0 -0.01513 0 0 0 0 0 0.01513 0 0 0.00391
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.060515 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.027063 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.027063 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.060515 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0.031250 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.117188 0 0 -0.030258 0 0 0 0 0 0.030258 0 0 0.007813 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.081190 0 0 0.046875 0 0 -0.046875 0 0 -0.027063 0 0 0 0 0 0 0 0 -0.046875 0 0 -0.027063 0 0 0.027063 0 0 0.015625 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0.031250 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.081190 0 0 0.046875 0 0 0 0 0 -0.046875 0 0 -0.027063 0 0 0 0 0 -0.046875 0 0 -0.027063 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 0.052408 0 0 -0.023437 0 0 -0.013532 0 0 0 0 0 0 0 0 -0.052408 0 0 -0.030258 0 0 0.013532 0 0 0.007812 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 0.023437 0 0 0 0 0 -0.052408 0 0 -0.013532 0 0 0 0 0 -0.052408 0 0 -0.013532 0 0 0 0 0 0.030258 0 0 0.007813 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.081190 0 0 0.046875 0 0 0 0 0 -0.046875 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.046875 0 0 -0.027063 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 -0.060515 0 0 0 0 0 0 0 0 0 0 0 -0.027063 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.117188 0 0 -0.030258 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.030258 0 0 0.007813 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 0.023438 0 0 0 0 0 -0.052408 0 0 -0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.052408 0 0 -0.013532 0 0 0 0 0 0.030258 0 0 0.007813 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 0.052408 0 0 -0.052408 0 0 -0.030258 0 0 0 0 0 0 0 0 -0.023437 0 0 -0.013532 0 0 0.013532 0 0 0.007812 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 0 0 0 -0.060515 0 0 0 0 0 0 0 0 -0.027063 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 0 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.117188 0 0 0 0 0 -0.030258 0 0 0 0 0 0 0 0 0 0 0 -0.030258 0 0 0 0 0 0.007812 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 0.052408 0 0 0 0 0 -0.052408 0 0 -0.030258 0 0 0 0 0 -0.023438 0 0 -0.013532 0 0 0 0 0 0.013532 0 0 0.007812 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 0.052408 0 0 0 0 0 -0.023438 0 0 -0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.052408 0 0 -0.030258 0 0 0 0 0 0.013532 0 0 0.007812 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.101487 0 0 0.058594 0 0 -0.026204 0 0 -0.015129 0 0 0 0 0 0 0 0 -0.026204 0 0 -0.015129 0 0 0.006766 0 0 0.003906 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.101487 0 0 0.026204 0 0 0 0 0 -0.058594 0 0 -0.015129 0 0 0 0 0 -0.026204 0 0 -0.006766 0 0 0 0 0 0.015129 0 0 0.003906 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.101487 0 0 0.026204 0 0 0 0 0 -0.026204 0 0 -0.006766 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.058594 0 0 -0.015129 0 0 0 0 0 0.015129 0 0 0.003906
DEAL::
-DEAL::0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::-0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::-0.18750 -0.10825 0 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 -0.20963 -0.05413 0 0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 -0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 -0.20963 -0.12103 0 0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 -0.23438 -0.06052 0 0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::-0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::-0.187500 -0.108253 0 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 -0.209631 -0.054127 0 0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 -0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 -0.209631 -0.121031 0 0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 -0.234375 -0.060515 0 0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.18750 -0.10825 0 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 -0.05413 0 -0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 -0.12103 0 -0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.23437 -0.06052 0 -0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 0.10825 0 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 0.05413 0 -0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 0.12103 0 -0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.23437 0.06052 0 -0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.187500 -0.108253 0 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 -0.054127 0 -0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 -0.121031 0 -0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.234375 -0.060515 0 -0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 0.108253 0 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 0.054127 0 -0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 0.121031 0 -0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.234375 0.060515 0 -0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.06052 0 0 -0.02706 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.02706 0 0 0 0 0 -0.06052 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.02706 0 0 0 0 0 -0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.06052 0 0 0 0 0 -0.02706 0 0 0.01563 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0.03125 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0.01562 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.11719 0 0 0.03026 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.08119 0 0 -0.04687 0 0 0.04687 0 0 -0.02706 0 0 0 0 0 0 0 0 -0.04688 0 0 0.02706 0 0 -0.02706 0 0 0.01562 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0.03125 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.08119 0 0 -0.04688 0 0 0 0 0 0.04687 0 0 -0.02706 0 0 0 0 0 -0.04688 0 0 0.02706 0 0 0 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 -0.05241 0 0 0.02344 0 0 -0.01353 0 0 0 0 0 0 0 0 -0.05241 0 0 0.03026 0 0 -0.01353 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 -0.02344 0 0 0 0 0 0.05241 0 0 -0.01353 0 0 0 0 0 -0.05241 0 0 0.01353 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.08119 0 0 -0.04687 0 0 0 0 0 0.04687 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.04688 0 0 0.02706 0 0 0 0 0 -0.02706 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 -0.06052 0 0 0 0 0 0 0 0 0 0 0 0.02706 0 0 0 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.11719 0 0 -0.03026 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 -0.02344 0 0 0 0 0 0.05241 0 0 -0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05241 0 0 0.01353 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 -0.05241 0 0 0.05241 0 0 -0.03026 0 0 0 0 0 0 0 0 -0.02344 0 0 0.01353 0 0 -0.01353 0 0 0.00781 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 0 0 0 -0.06052 0 0 0 0 0 0 0 0 0.02706 0 0 0 0 0 0 0 0 0.01562 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 0 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0 0 0 0 0 0 0.01563 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.11719 0 0 0 0 0 -0.03026 0 0 0 0 0 0 0 0 0 0 0 0.03026 0 0 0 0 0 0.00781 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 -0.05241 0 0 0 0 0 0.05241 0 0 -0.03026 0 0 0 0 0 -0.02344 0 0 0.01353 0 0 0 0 0 -0.01353 0 0 0.00781 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 -0.05241 0 0 0 0 0 0.02344 0 0 -0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05241 0 0 0.03026 0 0 0 0 0 -0.01353 0 0 0.00781 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10149 0 0 -0.05859 0 0 0.02620 0 0 -0.01513 0 0 0 0 0 0 0 0 -0.02620 0 0 0.01513 0 0 -0.00677 0 0 0.00391 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10149 0 0 -0.02620 0 0 0 0 0 0.05859 0 0 -0.01513 0 0 0 0 0 -0.02620 0 0 0.00677 0 0 0 0 0 -0.01513 0 0 0.00391 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10149 0 0 -0.02620 0 0 0 0 0 0.02620 0 0 -0.00677 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05859 0 0 0.01513 0 0 0 0 0 -0.01513 0 0 0.00391
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.060515 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.027063 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.027063 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.060515 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0.031250 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.117188 0 0 0.030258 0 0 0 0 0 -0.030258 0 0 0.007812 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.081190 0 0 -0.046875 0 0 0.046875 0 0 -0.027063 0 0 0 0 0 0 0 0 -0.046875 0 0 0.027063 0 0 -0.027063 0 0 0.015625 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0.031250 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.081190 0 0 -0.046875 0 0 0 0 0 0.046875 0 0 -0.027063 0 0 0 0 0 -0.046875 0 0 0.027063 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 -0.052408 0 0 0.023438 0 0 -0.013532 0 0 0 0 0 0 0 0 -0.052408 0 0 0.030258 0 0 -0.013532 0 0 0.007813 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 -0.023437 0 0 0 0 0 0.052408 0 0 -0.013532 0 0 0 0 0 -0.052408 0 0 0.013532 0 0 0 0 0 -0.030258 0 0 0.007812 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.081190 0 0 -0.046875 0 0 0 0 0 0.046875 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.046875 0 0 0.027063 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 -0.060515 0 0 0 0 0 0 0 0 0 0 0 0.027063 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.117188 0 0 -0.030258 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.030258 0 0 0.007812 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 -0.023438 0 0 0 0 0 0.052408 0 0 -0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.052408 0 0 0.013532 0 0 0 0 0 -0.030258 0 0 0.007812 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 -0.052408 0 0 0.052408 0 0 -0.030258 0 0 0 0 0 0 0 0 -0.023438 0 0 0.013532 0 0 -0.013532 0 0 0.007812 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 0 0 0 -0.060515 0 0 0 0 0 0 0 0 0.027063 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 0 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.117188 0 0 0 0 0 -0.030258 0 0 0 0 0 0 0 0 0 0 0 0.030258 0 0 0 0 0 0.007813 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 -0.052408 0 0 0 0 0 0.052408 0 0 -0.030258 0 0 0 0 0 -0.023437 0 0 0.013532 0 0 0 0 0 -0.013532 0 0 0.007812 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 -0.052408 0 0 0 0 0 0.023438 0 0 -0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.052408 0 0 0.030258 0 0 0 0 0 -0.013532 0 0 0.007813 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.101487 0 0 -0.058594 0 0 0.026204 0 0 -0.015129 0 0 0 0 0 0 0 0 -0.026204 0 0 0.015129 0 0 -0.006766 0 0 0.003906 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.101487 0 0 -0.026204 0 0 0 0 0 0.058594 0 0 -0.015129 0 0 0 0 0 -0.026204 0 0 0.006766 0 0 0 0 0 -0.015129 0 0 0.003906 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.101487 0 0 -0.026204 0 0 0 0 0 0.026204 0 0 -0.006766 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.058594 0 0 0.015129 0 0 0 0 0 -0.015129 0 0 0.003906
DEAL::
DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 -0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 -0.18750 -0.10825 0 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 -0.20963 -0.05413 0 0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 -0.12103 0 0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.23438 -0.06052 0 0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 -0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 -0.187500 -0.108253 0 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 -0.209631 -0.054127 0 0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 -0.121031 0 0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.234375 -0.060515 0 0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 0.10825 0 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 0.05413 0 -0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 0.12103 0 -0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.23437 0.06052 0 -0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.18750 0.10825 0 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 0.05413 0 0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 0.12103 0 0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.23437 0.06052 0 0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 0.108253 0 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 0.054127 0 -0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 0.121031 0 -0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.234375 0.060515 0 -0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.187500 0.108253 0 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 0.054127 0 0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 0.121031 0 0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.234375 0.060515 0 0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.06052 0 0 0.02706 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.02706 0 0 0 0 0 0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.02706 0 0 0 0 0 0.06052 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.06052 0 0 0 0 0 0.02706 0 0 0.01563 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0.03125 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0.01563 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.11719 0 0 0.03026 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.08119 0 0 -0.04687 0 0 -0.04688 0 0 -0.02706 0 0 0 0 0 0 0 0 0.04688 0 0 0.02706 0 0 0.02706 0 0 0.01562 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0.03125 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.08119 0 0 -0.04688 0 0 0 0 0 -0.04687 0 0 -0.02706 0 0 0 0 0 0.04688 0 0 0.02706 0 0 0 0 0 0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 -0.05241 0 0 -0.02344 0 0 -0.01353 0 0 0 0 0 0 0 0 0.05241 0 0 0.03026 0 0 0.01353 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 -0.02344 0 0 0 0 0 -0.05241 0 0 -0.01353 0 0 0 0 0 0.05241 0 0 0.01353 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.08119 0 0 -0.04688 0 0 0 0 0 -0.04688 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.04688 0 0 0.02706 0 0 0 0 0 0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 -0.06052 0 0 0 0 0 0 0 0 0 0 0 0.02706 0 0 0 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.11719 0 0 -0.03026 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 -0.02344 0 0 0 0 0 -0.05241 0 0 -0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05241 0 0 0.01353 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 -0.05241 0 0 -0.05241 0 0 -0.03026 0 0 0 0 0 0 0 0 0.02344 0 0 0.01353 0 0 0.01353 0 0 0.00781 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 0 0 0 -0.06052 0 0 0 0 0 0 0 0 0.02706 0 0 0 0 0 0 0 0 0.01562 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 0 0 0 -0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0 0 0 0 0 0 0.01563 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.11719 0 0 0 0 0 -0.03026 0 0 0 0 0 0 0 0 0 0 0 0.03026 0 0 0 0 0 0.00781 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 -0.05241 0 0 0 0 0 -0.05241 0 0 -0.03026 0 0 0 0 0 0.02344 0 0 0.01353 0 0 0 0 0 0.01353 0 0 0.00781 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 -0.05241 0 0 0 0 0 -0.02344 0 0 -0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05241 0 0 0.03026 0 0 0 0 0 0.01353 0 0 0.00781 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10149 0 0 -0.05859 0 0 -0.02620 0 0 -0.01513 0 0 0 0 0 0 0 0 0.02620 0 0 0.01513 0 0 0.00677 0 0 0.00391 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10149 0 0 -0.02620 0 0 0 0 0 -0.05859 0 0 -0.01513 0 0 0 0 0 0.02620 0 0 0.00677 0 0 0 0 0 0.01513 0 0 0.00391 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10149 0 0 -0.02620 0 0 0 0 0 -0.02620 0 0 -0.00677 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05859 0 0 0.01513 0 0 0 0 0 0.01513 0 0 0.00391
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.060515 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.027063 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.027063 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.060515 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0.031250 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.117187 0 0 0.030258 0 0 0 0 0 0.030258 0 0 0.007812 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.081190 0 0 -0.046875 0 0 -0.046875 0 0 -0.027063 0 0 0 0 0 0 0 0 0.046875 0 0 0.027063 0 0 0.027063 0 0 0.015625 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0.031250 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.081190 0 0 -0.046875 0 0 0 0 0 -0.046875 0 0 -0.027063 0 0 0 0 0 0.046875 0 0 0.027063 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 -0.052408 0 0 -0.023438 0 0 -0.013532 0 0 0 0 0 0 0 0 0.052408 0 0 0.030258 0 0 0.013532 0 0 0.007813 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 -0.023438 0 0 0 0 0 -0.052408 0 0 -0.013532 0 0 0 0 0 0.052408 0 0 0.013532 0 0 0 0 0 0.030258 0 0 0.007813 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.081190 0 0 -0.046875 0 0 0 0 0 -0.046875 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.046875 0 0 0.027063 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 -0.060515 0 0 0 0 0 0 0 0 0 0 0 0.027063 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.117188 0 0 -0.030258 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.030258 0 0 0.007813 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 -0.023438 0 0 0 0 0 -0.052408 0 0 -0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.052408 0 0 0.013532 0 0 0 0 0 0.030258 0 0 0.007812 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 -0.052408 0 0 -0.052408 0 0 -0.030258 0 0 0 0 0 0 0 0 0.023438 0 0 0.013532 0 0 0.013532 0 0 0.007813 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 0 0 0 -0.060515 0 0 0 0 0 0 0 0 0.027063 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 0 0 0 -0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.117188 0 0 0 0 0 -0.030258 0 0 0 0 0 0 0 0 0 0 0 0.030258 0 0 0 0 0 0.007813 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 -0.052408 0 0 0 0 0 -0.052408 0 0 -0.030258 0 0 0 0 0 0.023438 0 0 0.013532 0 0 0 0 0 0.013532 0 0 0.007813 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 -0.052408 0 0 0 0 0 -0.023438 0 0 -0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.052408 0 0 0.030258 0 0 0 0 0 0.013532 0 0 0.007813 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.101487 0 0 -0.058594 0 0 -0.026204 0 0 -0.015129 0 0 0 0 0 0 0 0 0.026204 0 0 0.015129 0 0 0.006766 0 0 0.003906 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.101487 0 0 -0.026204 0 0 0 0 0 -0.058594 0 0 -0.015129 0 0 0 0 0 0.026204 0 0 0.006766 0 0 0 0 0 0.015129 0 0 0.003906 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.101487 0 0 -0.026204 0 0 0 0 0 -0.026204 0 0 -0.006766 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.058594 0 0 0.015129 0 0 0 0 0 0.015129 0 0 0.003906
DEAL::
-DEAL::0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::-0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 -0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::-0.18750 0.10825 0 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 -0.20963 0.05413 0 -0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 -0.20963 0.12103 0 -0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 -0.23437 0.06052 0 -0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::-0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 -0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::-0.187500 0.108253 0 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 -0.209631 0.054127 0 -0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 -0.209631 0.121031 0 -0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 -0.234375 0.060515 0 -0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 -0.10825 0 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 -0.05413 0 0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 -0.12103 0 0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.23438 -0.06052 0 0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 -0.108253 0 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 -0.054127 0 0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 -0.121031 0 0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.234375 -0.060515 0 0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.18750 -0.10825 0 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 -0.05413 0 -0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 -0.12103 0 -0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.23437 -0.06052 0 -0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 -0.05413 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.06052 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.02706 0 0 0 0 0 -0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.02706 0 0 0 0 0 -0.06052 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 -0.06052 0 0 0 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0.03125 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0.01562 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.11719 0 0 -0.03026 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.08119 0 0 -0.04687 0 0 -0.04687 0 0 0.02706 0 0 0 0 0 0 0 0 0.04687 0 0 -0.02706 0 0 -0.02706 0 0 0.01562 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0.03125 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.08119 0 0 -0.04687 0 0 0 0 0 -0.04687 0 0 0.02706 0 0 0 0 0 0.04687 0 0 -0.02706 0 0 0 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 -0.05241 0 0 -0.02344 0 0 0.01353 0 0 0 0 0 0 0 0 0.05241 0 0 -0.03026 0 0 -0.01353 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 -0.02344 0 0 0 0 0 -0.05241 0 0 0.01353 0 0 0 0 0 0.05241 0 0 -0.01353 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.02706 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.08119 0 0 -0.04688 0 0 0 0 0 -0.04688 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.04687 0 0 -0.02706 0 0 0 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 0.06052 0 0 0 0 0 0 0 0 0 0 0 -0.02706 0 0 0 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.11719 0 0 0.03026 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 -0.02344 0 0 0 0 0 -0.05241 0 0 0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05241 0 0 -0.01353 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 -0.05241 0 0 -0.05241 0 0 0.03026 0 0 0 0 0 0 0 0 0.02344 0 0 -0.01353 0 0 -0.01353 0 0 0.00781 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 0 0 0 0.06052 0 0 0 0 0 0 0 0 -0.02706 0 0 0 0 0 0 0 0 0.01562 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 0 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0 0 0 0 0 0 0.01562 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.11719 0 0 0 0 0 0.03026 0 0 0 0 0 0 0 0 0 0 0 -0.03026 0 0 0 0 0 0.00781 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 -0.05241 0 0 0 0 0 -0.05241 0 0 0.03026 0 0 0 0 0 0.02344 0 0 -0.01353 0 0 0 0 0 -0.01353 0 0 0.00781 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 -0.05241 0 0 0 0 0 -0.02344 0 0 0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05241 0 0 -0.03026 0 0 0 0 0 -0.01353 0 0 0.00781 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10149 0 0 -0.05859 0 0 -0.02620 0 0 0.01513 0 0 0 0 0 0 0 0 0.02620 0 0 -0.01513 0 0 -0.00677 0 0 0.00391 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10149 0 0 -0.02620 0 0 0 0 0 -0.05859 0 0 0.01513 0 0 0 0 0 0.02620 0 0 -0.00677 0 0 0 0 0 -0.01513 0 0 0.00391 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10149 0 0 -0.02620 0 0 0 0 0 -0.02620 0 0 0.00677 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05859 0 0 -0.01513 0 0 0 0 0 -0.01513 0 0 0.00391
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.187500 -0.108253 0 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 -0.054127 0 -0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 -0.121031 0 -0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.234375 -0.060515 0 -0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 -0.054127 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.060515 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.027063 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.027063 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 -0.060515 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0.031250 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.117188 0 0 -0.030258 0 0 0 0 0 -0.030258 0 0 0.007812 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.081190 0 0 -0.046875 0 0 -0.046875 0 0 0.027063 0 0 0 0 0 0 0 0 0.046875 0 0 -0.027063 0 0 -0.027063 0 0 0.015625 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0.031250 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.081190 0 0 -0.046875 0 0 0 0 0 -0.046875 0 0 0.027063 0 0 0 0 0 0.046875 0 0 -0.027063 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 -0.052408 0 0 -0.023437 0 0 0.013532 0 0 0 0 0 0 0 0 0.052408 0 0 -0.030258 0 0 -0.013532 0 0 0.007812 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 -0.023437 0 0 0 0 0 -0.052408 0 0 0.013532 0 0 0 0 0 0.052408 0 0 -0.013532 0 0 0 0 0 -0.030258 0 0 0.007812 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.081190 0 0 -0.046875 0 0 0 0 0 -0.046875 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.046875 0 0 -0.027063 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 0.060515 0 0 0 0 0 0 0 0 0 0 0 -0.027063 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.117188 0 0 0.030258 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.030258 0 0 0.007812 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 -0.023438 0 0 0 0 0 -0.052408 0 0 0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.052408 0 0 -0.013532 0 0 0 0 0 -0.030258 0 0 0.007812 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 -0.052408 0 0 -0.052408 0 0 0.030258 0 0 0 0 0 0 0 0 0.023437 0 0 -0.013532 0 0 -0.013532 0 0 0.007812 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 0 0 0 0.060515 0 0 0 0 0 0 0 0 -0.027063 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 0 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.117188 0 0 0 0 0 0.030258 0 0 0 0 0 0 0 0 0 0 0 -0.030258 0 0 0 0 0 0.007813 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 -0.052408 0 0 0 0 0 -0.052408 0 0 0.030258 0 0 0 0 0 0.023437 0 0 -0.013532 0 0 0 0 0 -0.013532 0 0 0.007813 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 -0.052408 0 0 0 0 0 -0.023437 0 0 0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.052408 0 0 -0.030258 0 0 0 0 0 -0.013532 0 0 0.007813 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.101487 0 0 -0.058594 0 0 -0.026204 0 0 0.015129 0 0 0 0 0 0 0 0 0.026204 0 0 -0.015129 0 0 -0.006766 0 0 0.003906 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.101487 0 0 -0.026204 0 0 0 0 0 -0.058594 0 0 0.015129 0 0 0 0 0 0.026204 0 0 -0.006766 0 0 0 0 0 -0.015129 0 0 0.003906 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.101487 0 0 -0.026204 0 0 0 0 0 -0.026204 0 0 0.006766 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.058594 0 0 -0.015129 0 0 0 0 0 -0.015129 0 0 0.003906
DEAL::
DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 -0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 -0.18750 0.10825 0 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 -0.20963 0.05413 0 -0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 0.12103 0 -0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.23437 0.06052 0 -0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.18750 0.10825 0 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 0.05413 0 0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 0.12103 0 0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.23437 0.06052 0 0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 -0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 -0.187500 0.108253 0 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 -0.209631 0.054127 0 -0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 0.121031 0 -0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 -0.234375 0.060515 0 -0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.187500 0.108253 0 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 0.054127 0 0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 0.121031 0 0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.234375 0.060515 0 0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 -0.10825 0 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 -0.05413 0 0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 -0.12103 0 0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.23438 -0.06052 0 0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 -0.05413 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.06052 0 0 0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.02706 0 0 0 0 0 0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.02706 0 0 0 0 0 0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 -0.06052 0 0 0 0 0 0.02706 0 0 0.01562 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0.03125 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0.01563 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.11719 0 0 -0.03026 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.08119 0 0 -0.04687 0 0 0.04688 0 0 0.02706 0 0 0 0 0 0 0 0 -0.04688 0 0 -0.02706 0 0 0.02706 0 0 0.01562 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0.03125 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.08119 0 0 -0.04688 0 0 0 0 0 0.04688 0 0 0.02706 0 0 0 0 0 -0.04688 0 0 -0.02706 0 0 0 0 0 0.02706 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 -0.05241 0 0 0.02344 0 0 0.01353 0 0 0 0 0 0 0 0 -0.05241 0 0 -0.03026 0 0 0.01353 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 -0.02344 0 0 0 0 0 0.05241 0 0 0.01353 0 0 0 0 0 -0.05241 0 0 -0.01353 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.02706 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.02706 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.08119 0 0 -0.04687 0 0 0 0 0 0.04687 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.04687 0 0 -0.02706 0 0 0 0 0 0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 0.06052 0 0 0 0 0 0 0 0 0 0 0 -0.02706 0 0 0 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.11719 0 0 0.03026 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 -0.02344 0 0 0 0 0 0.05241 0 0 0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05241 0 0 -0.01353 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 -0.05241 0 0 0.05241 0 0 0.03026 0 0 0 0 0 0 0 0 -0.02344 0 0 -0.01353 0 0 0.01353 0 0 0.00781 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 0 0 0 0.06052 0 0 0 0 0 0 0 0 -0.02706 0 0 0 0 0 0 0 0 0.01562 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0 0 0 0 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0 0 0 0 0 0 0.01562 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.11719 0 0 0 0 0 0.03026 0 0 0 0 0 0 0 0 0 0 0 -0.03026 0 0 0 0 0 0.00781 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 -0.05241 0 0 0 0 0 0.05241 0 0 0.03026 0 0 0 0 0 -0.02344 0 0 -0.01353 0 0 0 0 0 0.01353 0 0 0.00781 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 -0.05241 0 0 0 0 0 0.02344 0 0 0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05241 0 0 -0.03026 0 0 0 0 0 0.01353 0 0 0.00781 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10149 0 0 -0.05859 0 0 0.02620 0 0 0.01513 0 0 0 0 0 0 0 0 -0.02620 0 0 -0.01513 0 0 0.00677 0 0 0.00391 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10149 0 0 -0.02620 0 0 0 0 0 0.05859 0 0 0.01513 0 0 0 0 0 -0.02620 0 0 -0.00677 0 0 0 0 0 0.01513 0 0 0.00391 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10149 0 0 -0.02620 0 0 0 0 0 0.02620 0 0 0.00677 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05859 0 0 -0.01513 0 0 0 0 0 0.01513 0 0 0.00391
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 -0.108253 0 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 -0.054127 0 0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 -0.121031 0 0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.234375 -0.060515 0 0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 -0.054127 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.060515 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.027063 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.027063 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 -0.060515 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0.031250 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.117188 0 0 -0.030258 0 0 0 0 0 0.030258 0 0 0.007813 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.081190 0 0 -0.046875 0 0 0.046875 0 0 0.027063 0 0 0 0 0 0 0 0 -0.046875 0 0 -0.027063 0 0 0.027063 0 0 0.015625 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0.031250 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.081190 0 0 -0.046875 0 0 0 0 0 0.046875 0 0 0.027063 0 0 0 0 0 -0.046875 0 0 -0.027063 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 -0.052408 0 0 0.023438 0 0 0.013532 0 0 0 0 0 0 0 0 -0.052408 0 0 -0.030258 0 0 0.013532 0 0 0.007813 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 -0.023438 0 0 0 0 0 0.052408 0 0 0.013532 0 0 0 0 0 -0.052408 0 0 -0.013532 0 0 0 0 0 0.030258 0 0 0.007813 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.081190 0 0 -0.046875 0 0 0 0 0 0.046875 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.046875 0 0 -0.027063 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 0.060515 0 0 0 0 0 0 0 0 0 0 0 -0.027063 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.117188 0 0 0.030258 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.030258 0 0 0.007813 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 -0.023438 0 0 0 0 0 0.052408 0 0 0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.052408 0 0 -0.013532 0 0 0 0 0 0.030258 0 0 0.007813 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 -0.052408 0 0 0.052408 0 0 0.030258 0 0 0 0 0 0 0 0 -0.023438 0 0 -0.013532 0 0 0.013532 0 0 0.007813 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 0 0 0 0.060515 0 0 0 0 0 0 0 0 -0.027063 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0 0 0 0 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.117188 0 0 0 0 0 0.030258 0 0 0 0 0 0 0 0 0 0 0 -0.030258 0 0 0 0 0 0.007813 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 -0.052408 0 0 0 0 0 0.052408 0 0 0.030258 0 0 0 0 0 -0.023437 0 0 -0.013532 0 0 0 0 0 0.013532 0 0 0.007813 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 -0.052408 0 0 0 0 0 0.023437 0 0 0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.052408 0 0 -0.030258 0 0 0 0 0 0.013532 0 0 0.007813 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.101487 0 0 -0.058594 0 0 0.026204 0 0 0.015129 0 0 0 0 0 0 0 0 -0.026204 0 0 -0.015129 0 0 0.006766 0 0 0.003906 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.101487 0 0 -0.026204 0 0 0 0 0 0.058594 0 0 0.015129 0 0 0 0 0 -0.026204 0 0 -0.006766 0 0 0 0 0 0.015129 0 0 0.003906 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.101487 0 0 -0.026204 0 0 0 0 0 0.026204 0 0 0.006766 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.058594 0 0 -0.015129 0 0 0 0 0 0.015129 0 0 0.003906
DEAL::
-DEAL::0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.18750 0.10825 0 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0.20963 0.05413 0 0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0.20963 0.12103 0 0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0.23437 0.06052 0 0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0.187500 0.108253 0 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0.209631 0.054127 0 0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0.209631 0.121031 0 0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0.234375 0.060515 0 0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 -0.10825 0 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 -0.05413 0 0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 -0.12103 0 0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.23438 -0.06052 0 0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 -0.108253 0 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 -0.054127 0 0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 -0.121031 0 0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.234375 -0.060515 0 0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.18750 0.10825 0 -0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 0.05413 0 -0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.20963 0.12103 0 -0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.23437 0.06052 0 -0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.06052 0 0 -0.02706 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.02706 0 0 0 0 0 -0.06052 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.02706 0 0 0 0 0 -0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.06052 0 0 0 0 0 -0.02706 0 0 0.01563 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0.03125 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0.01562 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.11719 0 0 0.03026 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.08119 0 0 0.04687 0 0 -0.04687 0 0 0.02706 0 0 0 0 0 0 0 0 -0.04688 0 0 0.02706 0 0 -0.02706 0 0 0.01562 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0.03125 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.08119 0 0 0.04688 0 0 0 0 0 -0.04687 0 0 0.02706 0 0 0 0 0 -0.04688 0 0 0.02706 0 0 0 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09375 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 0.05241 0 0 -0.02344 0 0 0.01353 0 0 0 0 0 0 0 0 -0.05241 0 0 0.03026 0 0 -0.01353 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 0.02344 0 0 0 0 0 -0.05241 0 0 0.01353 0 0 0 0 0 -0.05241 0 0 0.01353 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.02706 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10482 0 0 0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.08119 0 0 0.04687 0 0 0 0 0 -0.04688 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.04688 0 0 0.02706 0 0 0 0 0 -0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 0.06052 0 0 0 0 0 0 0 0 0 0 0 0.02706 0 0 0 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.11719 0 0 0.03026 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 0.02344 0 0 0 0 0 -0.05241 0 0 0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05241 0 0 0.01353 0 0 0 0 0 -0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 0.05241 0 0 -0.05241 0 0 0.03026 0 0 0 0 0 0 0 0 -0.02344 0 0 0.01353 0 0 -0.01353 0 0 0.00781 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 0 0 0 0.06052 0 0 0 0 0 0 0 0 0.02706 0 0 0 0 0 0 0 0 0.01562 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 0 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0 0 0 0 0 0 0.01563 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.11719 0 0 0 0 0 0.03026 0 0 0 0 0 0 0 0 0 0 0 0.03026 0 0 0 0 0 0.00781 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 0.05241 0 0 0 0 0 -0.05241 0 0 0.03026 0 0 0 0 0 -0.02344 0 0 0.01353 0 0 0 0 0 -0.01353 0 0 0.00781 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.09077 0 0 0.05241 0 0 0 0 0 -0.02344 0 0 0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05241 0 0 0.03026 0 0 0 0 0 -0.01353 0 0 0.00781 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10149 0 0 0.05859 0 0 -0.02620 0 0 0.01513 0 0 0 0 0 0 0 0 -0.02620 0 0 0.01513 0 0 -0.00677 0 0 0.00391 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10149 0 0 0.02620 0 0 0 0 0 -0.05859 0 0 0.01513 0 0 0 0 0 -0.02620 0 0 0.00677 0 0 0 0 0 -0.01513 0 0 0.00391 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.10149 0 0 0.02620 0 0 0 0 0 -0.02620 0 0 0.00677 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.05859 0 0 0.01513 0 0 0 0 0 -0.01513 0 0 0.00391
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.187500 0.108253 0 -0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 0.054127 0 -0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.209631 0.121031 0 -0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.234375 0.060515 0 -0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.060515 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.027063 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.027063 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.060515 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0.031250 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.117188 0 0 0.030258 0 0 0 0 0 -0.030258 0 0 0.007812 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.081190 0 0 0.046875 0 0 -0.046875 0 0 0.027063 0 0 0 0 0 0 0 0 -0.046875 0 0 0.027063 0 0 -0.027063 0 0 0.015625 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0.031250 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.081190 0 0 0.046875 0 0 0 0 0 -0.046875 0 0 0.027063 0 0 0 0 0 -0.046875 0 0 0.027063 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.093750 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 0.052408 0 0 -0.023438 0 0 0.013532 0 0 0 0 0 0 0 0 -0.052408 0 0 0.030258 0 0 -0.013532 0 0 0.007813 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 0.023437 0 0 0 0 0 -0.052408 0 0 0.013532 0 0 0 0 0 -0.052408 0 0 0.013532 0 0 0 0 0 -0.030258 0 0 0.007813 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.104816 0 0 0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.081190 0 0 0.046875 0 0 0 0 0 -0.046875 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.046875 0 0 0.027063 0 0 0 0 0 -0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 0.060515 0 0 0 0 0 0 0 0 0 0 0 0.027063 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.117188 0 0 0.030258 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.030258 0 0 0.007812 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 0.023438 0 0 0 0 0 -0.052408 0 0 0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.052408 0 0 0.013532 0 0 0 0 0 -0.030258 0 0 0.007813 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 0.052408 0 0 -0.052408 0 0 0.030258 0 0 0 0 0 0 0 0 -0.023438 0 0 0.013532 0 0 -0.013532 0 0 0.007813 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 0 0 0 0.060515 0 0 0 0 0 0 0 0 0.027063 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 0 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.117188 0 0 0 0 0 0.030258 0 0 0 0 0 0 0 0 0 0 0 0.030258 0 0 0 0 0 0.007812 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 0.052408 0 0 0 0 0 -0.052408 0 0 0.030258 0 0 0 0 0 -0.023438 0 0 0.013532 0 0 0 0 0 -0.013532 0 0 0.007813 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.090773 0 0 0.052408 0 0 0 0 0 -0.023438 0 0 0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.052408 0 0 0.030258 0 0 0 0 0 -0.013532 0 0 0.007813 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.101487 0 0 0.058594 0 0 -0.026204 0 0 0.015129 0 0 0 0 0 0 0 0 -0.026204 0 0 0.015129 0 0 -0.006766 0 0 0.003906 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.101487 0 0 0.026204 0 0 0 0 0 -0.058594 0 0 0.015129 0 0 0 0 0 -0.026204 0 0 0.006766 0 0 0 0 0 -0.015129 0 0 0.003906 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.101487 0 0 0.026204 0 0 0 0 0 -0.026204 0 0 0.006766 0 0 0 0 0 0 0 0 0 0 0 0 0 0 -0.058594 0 0 0.015129 0 0 0 0 0 -0.015129 0 0 0.003906
DEAL::
DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.18750 0.10825 0 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0.20963 0.05413 0 0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0.20963 0.12103 0 0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0.23437 0.06052 0 0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0.187500 0.108253 0 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0.209631 0.054127 0 0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0.209631 0.121031 0 0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0.234375 0.060515 0 0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.18750 0.10825 0 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 0.05413 0 0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 0.12103 0 0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.23437 0.06052 0 0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.187500 0.108253 0 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 0.054127 0 0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 0.121031 0 0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.234375 0.060515 0 0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.25000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.21651 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.18750 0.10825 0 0.10825 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 0.05413 0 0.12103 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.24206 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.20963 0.12103 0 0.05413 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.23437 0.06052 0 0.06052 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.06052 0 0 0.02706 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.02706 0 0 0 0 0 0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.02706 0 0 0 0 0 0.06052 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.06052 0 0 0 0 0 0.02706 0 0 0.01563 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0.03125 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0.01563 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.11719 0 0 0.03026 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.08119 0 0 0.04687 0 0 0.04688 0 0 0.02706 0 0 0 0 0 0 0 0 0.04688 0 0 0.02706 0 0 0.02706 0 0 0.01562 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0.03125 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10825 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06250 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.08119 0 0 0.04688 0 0 0 0 0 0.04687 0 0 0.02706 0 0 0 0 0 0.04688 0 0 0.02706 0 0 0 0 0 0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 0.05241 0 0 0.02344 0 0 0.01353 0 0 0 0 0 0 0 0 0.05241 0 0 0.03026 0 0 0.01353 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 0.02344 0 0 0 0 0 0.05241 0 0 0.01353 0 0 0 0 0 0.05241 0 0 0.01353 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.12103 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09375 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05413 0 0 0 0 0 0 0 0 0.03125 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.02706 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0.06052 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.02706 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.08119 0 0 0.04688 0 0 0 0 0 0.04688 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.04688 0 0 0.02706 0 0 0 0 0 0.02706 0 0 0.01562 0 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 0.06052 0 0 0 0 0 0 0 0 0 0 0 0.02706 0 0 0 0 0 0.01563 0 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.11719 0 0 0.03026 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 0.02344 0 0 0 0 0 0.05241 0 0 0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05241 0 0 0.01353 0 0 0 0 0 0.03026 0 0 0.00781 0 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 0.05241 0 0 0.05241 0 0 0.03026 0 0 0 0 0 0 0 0 0.02344 0 0 0.01353 0 0 0.01353 0 0 0.00781 0 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 0 0 0 0.06052 0 0 0 0 0 0 0 0 0.02706 0 0 0 0 0 0 0 0 0.01562 0 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10482 0 0 0 0 0 0 0 0 0.02706 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.06052 0 0 0 0 0 0 0 0 0.01563 0 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.11719 0 0 0 0 0 0.03026 0 0 0 0 0 0 0 0 0 0 0 0.03026 0 0 0 0 0 0.00781 0 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 0.05241 0 0 0 0 0 0.05241 0 0 0.03026 0 0 0 0 0 0.02344 0 0 0.01353 0 0 0 0 0 0.01353 0 0 0.00781 0 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.09077 0 0 0.05241 0 0 0 0 0 0.02344 0 0 0.01353 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05241 0 0 0.03026 0 0 0 0 0 0.01353 0 0 0.00781 0 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10149 0 0 0.05859 0 0 0.02620 0 0 0.01513 0 0 0 0 0 0 0 0 0.02620 0 0 0.01513 0 0 0.00677 0 0 0.00391 0 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10149 0 0 0.02620 0 0 0 0 0 0.05859 0 0 0.01513 0 0 0 0 0 0.02620 0 0 0.00677 0 0 0 0 0 0.01513 0 0 0.00391 0
-DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.10149 0 0 0.02620 0 0 0 0 0 0.02620 0 0 0.00677 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.05859 0 0 0.01513 0 0 0 0 0 0.01513 0 0 0.00391
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.250000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.216506 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.187500 0.108253 0 0.108253 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 0.054127 0 0.121031 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.242061 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.209631 0.121031 0 0.054127 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.234375 0.060515 0 0.060515 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.125000 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.060515 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.027063 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.027063 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 0 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.060515 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0.031250 0 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.117187 0 0 0.030258 0 0 0 0 0 0.030258 0 0 0.007812 0 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.081190 0 0 0.046875 0 0 0.046875 0 0 0.027063 0 0 0 0 0 0 0 0 0.046875 0 0 0.027063 0 0 0.027063 0 0 0.015625 0 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0.031250 0 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.108253 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.062500 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::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.081190 0 0 0.046875 0 0 0 0 0 0.046875 0 0 0.027063 0 0 0 0 0 0.046875 0 0 0.027063 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 0.052408 0 0 0.023438 0 0 0.013532 0 0 0 0 0 0 0 0 0.052408 0 0 0.030258 0 0 0.013532 0 0 0.007812 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 0.023438 0 0 0 0 0 0.052408 0 0 0.013532 0 0 0 0 0 0.052408 0 0 0.013532 0 0 0 0 0 0.030258 0 0 0.007812 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.121031 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.093750 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.054127 0 0 0 0 0 0 0 0 0.031250 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0.060515 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.081190 0 0 0.046875 0 0 0 0 0 0.046875 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.046875 0 0 0.027063 0 0 0 0 0 0.027063 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 0.060515 0 0 0 0 0 0 0 0 0 0 0 0.027063 0 0 0 0 0 0.015625 0 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.117188 0 0 0.030258 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.030258 0 0 0.007813 0 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 0.023438 0 0 0 0 0 0.052408 0 0 0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.052408 0 0 0.013532 0 0 0 0 0 0.030258 0 0 0.007812 0 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 0.052408 0 0 0.052408 0 0 0.030258 0 0 0 0 0 0 0 0 0.023438 0 0 0.013532 0 0 0.013532 0 0 0.007812 0 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 0 0 0 0.060515 0 0 0 0 0 0 0 0 0.027063 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.104816 0 0 0 0 0 0 0 0 0.027063 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.060515 0 0 0 0 0 0 0 0 0.015625 0 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.117188 0 0 0 0 0 0.030258 0 0 0 0 0 0 0 0 0 0 0 0.030258 0 0 0 0 0 0.007812 0 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 0.052408 0 0 0 0 0 0.052408 0 0 0.030258 0 0 0 0 0 0.023438 0 0 0.013532 0 0 0 0 0 0.013532 0 0 0.007812 0 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.090773 0 0 0.052408 0 0 0 0 0 0.023438 0 0 0.013532 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.052408 0 0 0.030258 0 0 0 0 0 0.013532 0 0 0.007812 0 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.101487 0 0 0.058594 0 0 0.026204 0 0 0.015129 0 0 0 0 0 0 0 0 0.026204 0 0 0.015129 0 0 0.006766 0 0 0.003906 0 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.101487 0 0 0.026204 0 0 0 0 0 0.058594 0 0 0.015129 0 0 0 0 0 0.026204 0 0 0.006766 0 0 0 0 0 0.015129 0 0 0.003906 0
+DEAL::0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.101487 0 0 0.026204 0 0 0 0 0 0.026204 0 0 0.006766 0 0 0 0 0 0 0 0 0 0 0 0 0 0 0.058594 0 0 0.015129 0 0 0 0 0 0.015129 0 0 0.003906
DEAL::