From: bangerth Date: Thu, 28 Dec 2006 04:53:24 +0000 (+0000) Subject: Implement plenty of functions for hp as well. Fix a number of bugs in various places... X-Git-Url: https://gitweb.dealii.org/cgi-bin/gitweb.cgi?a=commitdiff_plain;h=1bf2d77f7fd7956f9d889d247624f609b250d0af;p=dealii-svn.git Implement plenty of functions for hp as well. Fix a number of bugs in various places in the process. git-svn-id: https://svn.dealii.org/trunk@14279 0785d39b-7218-0410-832d-ea1e28bc413d --- diff --git a/deal.II/deal.II/include/numerics/matrices.h b/deal.II/deal.II/include/numerics/matrices.h index 6688d1a102..ad58be94fa 100644 --- a/deal.II/deal.II/include/numerics/matrices.h +++ b/deal.II/deal.II/include/numerics/matrices.h @@ -39,6 +39,14 @@ template class DoFHandler; template class MGDoFHandler; template class FEValues; +namespace hp +{ + template class QCollection; + template class MappingCollection; + template class DoFHandler; +} + + #ifdef DEAL_II_USE_PETSC namespace PETScWrappers { @@ -251,6 +259,52 @@ class MatrixCreator const Function &rhs, Vector &rhs_vector, const Function * const a = 0); + /** + * Same function as above, but for hp + * objects. + */ + template + static void create_mass_matrix (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const a = 0); + + /** + * Same function as above, but for hp + * objects. + */ + template + static void create_mass_matrix (const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const a = 0); + + /** + * Same function as above, but for hp + * objects. + */ + template + static void create_mass_matrix (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const a = 0); + + /** + * Same function as above, but for hp + * objects. + */ + template + static void create_mass_matrix (const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const a = 0); + /** * Assemble the mass matrix and a @@ -313,6 +367,49 @@ class MatrixCreator std::vector&dof_to_boundary_mapping, const Function * const a = 0); + /** + * Same function as above, but for hp + * objects. + */ + template + static + void create_boundary_mass_matrix (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const typename FunctionMap::type &boundary_functions, + Vector &rhs_vector, + std::vector&dof_to_boundary_mapping, + const Function * const a = 0); + + /** + * Same function as above, but for hp + * objects. + */ + static + void create_boundary_mass_matrix (const hp::MappingCollection<1> &mapping, + const hp::DoFHandler<1> &dof, + const hp::QCollection<0> &q, + SparseMatrix &matrix, + const FunctionMap<1>::type &boundary_functions, + Vector &rhs_vector, + std::vector&dof_to_boundary_mapping, + const Function<1> * const a = 0); + + /** + * Same function as above, but for hp + * objects. + */ + template + static + void create_boundary_mass_matrix (const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const typename FunctionMap::type &boundary_functions, + Vector &rhs_vector, + std::vector&dof_to_boundary_mapping, + const Function * const a = 0); + /** * Assemble the Laplace * matrix. If no coefficient is @@ -382,6 +479,56 @@ class MatrixCreator Vector &rhs_vector, const Function * const a = 0); + /** + * Like the functions above, but for hp + * dof handlers, mappings, and quadrature + * collections. + */ + template + static void create_laplace_matrix (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const a = 0); + + /** + * Like the functions above, but for hp + * dof handlers, mappings, and quadrature + * collections. + */ + template + static void create_laplace_matrix (const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const a = 0); + + /** + * Like the functions above, but for hp + * dof handlers, mappings, and quadrature + * collections. + */ + template + static void create_laplace_matrix (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const a = 0); + + /** + * Like the functions above, but for hp + * dof handlers, mappings, and quadrature + * collections. + */ + template + static void create_laplace_matrix (const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const a = 0); + /** * Exception */ @@ -394,15 +541,15 @@ class MatrixCreator * just like a * std::pair * but is templatized on the - * space dimension. + * dof handler that shouls be used. */ - template + template struct IteratorRange { /** * Typedef for the iterator type. */ - typedef typename DoFHandler::active_cell_iterator active_cell_iterator; + typedef typename DH::active_cell_iterator active_cell_iterator; /** * Abbreviation for a pair of @@ -450,7 +597,7 @@ class MatrixCreator const Quadrature &q, SparseMatrix &matrix, const Function * const a, - const IteratorRange range, + const IteratorRange > range, Threads::ThreadMutex &mutex); /** @@ -472,10 +619,37 @@ class MatrixCreator const Function &rhs, Vector &rhs_vector, const Function * const a, - const IteratorRange range, + const IteratorRange > range, Threads::ThreadMutex &mutex); /** + * Same function as above, but for hp + * objects. + */ + template + static + void create_mass_matrix_1 (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const a, + const IteratorRange > range, + Threads::ThreadMutex &mutex); + + template + static + void create_mass_matrix_2 (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const a, + const IteratorRange > range, + Threads::ThreadMutex &mutex); + + +/** * Version of the same function * (without suffix @p _1) with * the same argument list that @@ -492,7 +666,7 @@ class MatrixCreator const Quadrature &q, SparseMatrix &matrix, const Function * const a, - const IteratorRange range, + const IteratorRange > range, Threads::ThreadMutex &mutex); /** @@ -514,9 +688,51 @@ class MatrixCreator const Function &rhs, Vector &rhs_vector, const Function * const a, - const IteratorRange range, + const IteratorRange > range, + Threads::ThreadMutex &mutex); + + /** + * Version of the same function + * (without suffix @p _1) with + * the same argument list that + * operates only on an interval + * of iterators. Used for + * parallelization. The mutex is + * used to synchronise access to + * the matrix. + */ + template + static + void create_laplace_matrix_1 (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const a, + const IteratorRange > range, Threads::ThreadMutex &mutex); + /** + * Version of the same function + * (without suffix @p _2) with + * the same argument list that + * operates only on an interval + * of iterators. Used for + * parallelization. The mutex is + * used to synchronise access to + * the matrix. + */ + template + static + void create_laplace_matrix_2 (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const a, + const IteratorRange > range, + Threads::ThreadMutex &mutex); + /** * Version of the same function * (without suffix @p _1) with @@ -537,7 +753,23 @@ class MatrixCreator Vector &rhs_vector, std::vector&dof_to_boundary_mapping, const Function * const a, - const IteratorRange range, + const IteratorRange > range, + Threads::ThreadMutex &mutex); + + /** + * Same as above, but for hp. + */ + template + static + void create_boundary_mass_matrix_1 (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const typename FunctionMap::type &boundary_functions, + Vector &rhs_vector, + std::vector&dof_to_boundary_mapping, + const Function * const a, + const IteratorRange > range, Threads::ThreadMutex &mutex); }; diff --git a/deal.II/deal.II/source/dofs/dof_tools.cc b/deal.II/deal.II/source/dofs/dof_tools.cc index 9352ee66d5..ce8358561b 100644 --- a/deal.II/deal.II/source/dofs/dof_tools.cc +++ b/deal.II/deal.II/source/dofs/dof_tools.cc @@ -25,6 +25,7 @@ #include #include #include +#include #include #include #include @@ -869,7 +870,6 @@ DoFTools::make_sparsity_pattern ( SparsityPattern& sparsity) { const unsigned int n_dofs = dof.n_dofs(); - const unsigned int dofs_per_cell = dof.get_fe().dofs_per_cell; Assert (sparsity.n_rows() == n_dofs, ExcDimensionMismatch (sparsity.n_rows(), n_dofs)); @@ -880,55 +880,74 @@ DoFTools::make_sparsity_pattern ( Assert (couplings.n_cols() == dof.get_fe().n_components(), ExcDimensionMismatch(couplings.n_cols(), dof.get_fe().n_components())); - // first build a mask for each dof, - // not like the one given which - // represents components. make sure - // we do the right thing also with + const hp::FECollection fe_collection (dof.get_fe()); + + // first, for each finite element, build a + // mask for each dof, not like the one + // given which represents components. make + // sure we do the right thing also with // respect to non-primitive shape - // functions, which takes some - // additional thought - std::vector > dof_mask(dofs_per_cell, - std::vector(dofs_per_cell, false)); - for (unsigned int i=0; i > > dof_mask(fe_collection.size()); + for (unsigned int f=0; f(dofs_per_cell, false)); + + for (unsigned int i=0; i dofs_on_this_cell(dofs_per_cell); + std::vector dofs_on_this_cell(fe_collection.max_dofs_per_cell()); typename DH::active_cell_iterator cell = dof.begin_active(), endc = dof.end(); for (; cell!=endc; ++cell) { + const unsigned int fe_index + = cell->active_fe_index(); + + const unsigned int dofs_per_cell + = fe_collection[fe_index].dofs_per_cell; + + dofs_on_this_cell.resize (dofs_per_cell); cell->get_dof_indices (dofs_on_this_cell); + // make sparsity pattern for this cell for (unsigned int i=0; iget_fe().dofs_per_face; dofs_on_this_face.resize (dofs_per_face); - cell->face(f)->get_dof_indices (dofs_on_this_face); + cell->face(f)->get_dof_indices (dofs_on_this_face, + cell->active_fe_index()); // make sparsity pattern for this cell for (unsigned int i=0; iget_fe().dofs_per_face; dofs_on_face.resize (dofs_per_face); - cell->face(f)->get_dof_indices (dofs_on_face); + cell->face(f)->get_dof_indices (dofs_on_face, cell->active_fe_index()); for (unsigned int i=0; iget_fe().dofs_per_face; dofs_on_face.resize (dofs_per_face); - cell->face(f)->get_dof_indices (dofs_on_face); + cell->face(f)->get_dof_indices (dofs_on_face, cell->active_fe_index()); for (unsigned int i=0; i& couplings, const Table<2,Coupling>& flux_couplings); template void -DoFTools::make_sparsity_pattern,SparsityPattern> +DoFTools::make_sparsity_pattern, + SparsityPattern> (const DoFHandler &dof, SparsityPattern &sparsity); template void -DoFTools::make_sparsity_pattern,CompressedSparsityPattern> +DoFTools::make_sparsity_pattern, + CompressedSparsityPattern> (const DoFHandler &dof, CompressedSparsityPattern &sparsity); template void -DoFTools::make_sparsity_pattern,BlockSparsityPattern> +DoFTools::make_sparsity_pattern, + BlockSparsityPattern> (const DoFHandler &dof, BlockSparsityPattern &sparsity); template void -DoFTools::make_sparsity_pattern,CompressedBlockSparsityPattern> +DoFTools::make_sparsity_pattern, + CompressedBlockSparsityPattern> (const DoFHandler &dof, CompressedBlockSparsityPattern &sparsity); template void -DoFTools::make_sparsity_pattern,SparsityPattern> +DoFTools::make_sparsity_pattern, + SparsityPattern> (const hp::DoFHandler &dof, SparsityPattern &sparsity); template void -DoFTools::make_sparsity_pattern,CompressedSparsityPattern> +DoFTools::make_sparsity_pattern, + CompressedSparsityPattern> (const hp::DoFHandler &dof, CompressedSparsityPattern &sparsity); template void -DoFTools::make_sparsity_pattern,BlockSparsityPattern> +DoFTools::make_sparsity_pattern, + BlockSparsityPattern> (const hp::DoFHandler &dof, BlockSparsityPattern &sparsity); template void -DoFTools::make_sparsity_pattern,CompressedBlockSparsityPattern> +DoFTools::make_sparsity_pattern, + CompressedBlockSparsityPattern> (const hp::DoFHandler &dof, CompressedBlockSparsityPattern &sparsity); template void -DoFTools::make_sparsity_pattern,SparsityPattern> -(const DoFHandler&, const Table<2,Coupling>&, SparsityPattern&); +DoFTools::make_sparsity_pattern, + SparsityPattern> +(const DoFHandler&, + const Table<2,Coupling>&, + SparsityPattern&); template void -DoFTools::make_sparsity_pattern,CompressedSparsityPattern> -(const DoFHandler&, const Table<2,Coupling>&, CompressedSparsityPattern&); +DoFTools::make_sparsity_pattern, + CompressedSparsityPattern> +(const DoFHandler&, + const Table<2,Coupling>&, + CompressedSparsityPattern&); template void -DoFTools::make_sparsity_pattern,BlockSparsityPattern> -(const DoFHandler&, const Table<2,Coupling>&, BlockSparsityPattern&); +DoFTools::make_sparsity_pattern, + BlockSparsityPattern> +(const DoFHandler&, + const Table<2,Coupling>&, + BlockSparsityPattern&); template void -DoFTools::make_sparsity_pattern,CompressedBlockSparsityPattern> -(const DoFHandler&, const Table<2,Coupling>&, CompressedBlockSparsityPattern&); +DoFTools::make_sparsity_pattern, + CompressedBlockSparsityPattern> +(const DoFHandler&, + const Table<2,Coupling>&, + CompressedBlockSparsityPattern&); + + +template void +DoFTools::make_sparsity_pattern, + SparsityPattern> +(const hp::DoFHandler&, + const Table<2,Coupling>&, + SparsityPattern&); +template void +DoFTools::make_sparsity_pattern, + CompressedSparsityPattern> +(const hp::DoFHandler&, + const Table<2,Coupling>&, + CompressedSparsityPattern&); +template void +DoFTools::make_sparsity_pattern, + BlockSparsityPattern> +(const hp::DoFHandler&, + const Table<2,Coupling>&, + BlockSparsityPattern&); +template void +DoFTools::make_sparsity_pattern, + CompressedBlockSparsityPattern> +(const hp::DoFHandler&, + const Table<2,Coupling>&, + CompressedBlockSparsityPattern&); // #if deal_II_dimension > 1 template void @@ -5766,6 +5832,27 @@ DoFTools::map_dof_to_boundary_indices > #endif + +template +void +DoFTools::map_dof_to_boundary_indices > +(const hp::DoFHandler &, + const std::set &, + std::vector &); + +#if deal_II_dimension != 1 + +template +void +DoFTools::map_dof_to_boundary_indices > +(const hp::DoFHandler &, + std::vector &); + +#endif + + + + template void DoFTools::map_dofs_to_support_points diff --git a/deal.II/deal.II/source/dofs/hp_dof_handler.cc b/deal.II/deal.II/source/dofs/hp_dof_handler.cc index 418b2fb6a2..86da7eaa2d 100644 --- a/deal.II/deal.II/source/dofs/hp_dof_handler.cc +++ b/deal.II/deal.II/source/dofs/hp_dof_handler.cc @@ -2107,7 +2107,8 @@ namespace hp const unsigned int dofs_per_face = cell->get_fe().dofs_per_face; dofs_on_face.resize (dofs_per_face); - cell->face(f)->get_dof_indices (dofs_on_face); + cell->face(f)->get_dof_indices (dofs_on_face, + cell->active_fe_index()); for (unsigned int i=0; iget_fe().dofs_per_face; dofs_on_face.resize (dofs_per_face); - cell->face(f)->get_dof_indices (dofs_on_face); + cell->face(f)->get_dof_indices (dofs_on_face, + cell->active_fe_index()); for (unsigned int i=0; i #include #include +#include +#include #include #include #include @@ -40,11 +42,11 @@ DEAL_II_NAMESPACE_OPEN -template +template inline -MatrixCreator::IteratorRange:: +MatrixCreator::IteratorRange:: IteratorRange (const active_cell_iterator &first, - const active_cell_iterator &second) + const active_cell_iterator &second) : first (first), second (second) @@ -52,9 +54,9 @@ IteratorRange (const active_cell_iterator &first, -template +template inline -MatrixCreator::IteratorRange::IteratorRange (const iterator_pair &ip) +MatrixCreator::IteratorRange::IteratorRange (const iterator_pair &ip) : first (ip.first), second (ip.second) @@ -95,7 +97,7 @@ void MatrixCreator::create_mass_matrix (const Mapping &mapping, const Quadrature &q, SparseMatrix &matrix, const Function * const coefficient, - const IteratorRange range, + const IteratorRange > range, Threads::ThreadMutex &mutex); create_mass_matrix_1_t p = &MatrixCreator::template create_mass_matrix_1; for (unsigned int thread=0; thread &mapping, const Quadrature &q, SparseMatrix &matrix, const Function * const coefficient, - const IteratorRange range, + const IteratorRange > range, Threads::ThreadMutex &mutex) { UpdateFlags update_flags = UpdateFlags(update_values | update_JxW_values); @@ -343,7 +345,7 @@ void MatrixCreator::create_mass_matrix (const Mapping &mapping, const Function &rhs, Vector &rhs_vector, const Function * const coefficient, - const IteratorRange range, + const IteratorRange > range, Threads::ThreadMutex &mutex); create_mass_matrix_2_t p = &MatrixCreator::template create_mass_matrix_2; for (unsigned int thread=0; thread &mapping, const Function &rhs, Vector &rhs_vector, const Function * const coefficient, - const IteratorRange range, + const IteratorRange > range, Threads::ThreadMutex &mutex) { UpdateFlags update_flags = UpdateFlags(update_values | @@ -505,45 +507,25 @@ void MatrixCreator::create_mass_matrix (const DoFHandler &dof, } -#if deal_II_dimension == 1 -void MatrixCreator::create_boundary_mass_matrix (const Mapping<1> &, - const DoFHandler<1> &, - const Quadrature<0> &, - SparseMatrix &, - const FunctionMap<1>::type&, - Vector &, - std::vector &, - const Function<1> * const) +template +void MatrixCreator::create_mass_matrix (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient) { - // what would that be in 1d? the - // identity matrix on the boundary - // dofs? - Assert (false, ExcNotImplemented()); -} - - -#endif - - + Assert (matrix.m() == dof.n_dofs(), + ExcDimensionMismatch (matrix.m(), dof.n_dofs())); + Assert (matrix.n() == dof.n_dofs(), + ExcDimensionMismatch (matrix.n(), dof.n_dofs())); -template -void -MatrixCreator::create_boundary_mass_matrix (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const typename FunctionMap::type &boundary_functions, - Vector &rhs_vector, - std::vector &dof_to_boundary_mapping, - const Function * const coefficient) -{ const unsigned int n_threads = multithread_info.n_default_threads; Threads::ThreadGroup<> threads; // define starting and end point // for each thread - typedef typename DoFHandler::active_cell_iterator active_cell_iterator; + typedef typename hp::DoFHandler::active_cell_iterator active_cell_iterator; std::vector > thread_ranges = Threads::split_range (dof.begin_active(), dof.end(), n_threads); @@ -553,409 +535,1659 @@ MatrixCreator::create_boundary_mass_matrix (const Mapping &mapping, Threads::ThreadMutex mutex; // then assemble in parallel - typedef void (*create_boundary_mass_matrix_1_t) - (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const typename FunctionMap::type &boundary_functions, - Vector &rhs_vector, - std::vector &dof_to_boundary_mapping, - const Function * const coefficient, - const IteratorRange range, - Threads::ThreadMutex &mutex); - create_boundary_mass_matrix_1_t p = &MatrixCreator::template create_boundary_mass_matrix_1; + typedef void (*create_mass_matrix_1_t) (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient, + const IteratorRange > range, + Threads::ThreadMutex &mutex); + create_mass_matrix_1_t p = &MatrixCreator::template create_mass_matrix_1; for (unsigned int thread=0; thread +template void -MatrixCreator:: -create_boundary_mass_matrix_1 (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const typename FunctionMap::type &boundary_functions, - Vector &rhs_vector, - std::vector &dof_to_boundary_mapping, - const Function * const coefficient, - const IteratorRange range, - Threads::ThreadMutex &mutex) +MatrixCreator::create_mass_matrix_1 (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient, + const IteratorRange > range, + Threads::ThreadMutex &mutex) { - const FiniteElement &fe = dof.get_fe(); - const unsigned int n_components = fe.n_components(); - const bool fe_is_system = (n_components != 1); - - Assert (matrix.n() == dof.n_boundary_dofs(boundary_functions), - ExcInternalError()); - Assert (matrix.n() == matrix.m(), ExcInternalError()); - Assert (matrix.n() == rhs_vector.size(), ExcInternalError()); - Assert (boundary_functions.size() != 0, ExcInternalError()); - Assert (dof.get_fe() == fe, ExcInternalError()); - Assert (dof_to_boundary_mapping.size() == dof.n_dofs(), - ExcInternalError()); - Assert (n_components == boundary_functions.begin()->second->n_components, - ExcComponentMismatch()); - Assert (coefficient ==0 || - coefficient->n_components==1 || - coefficient->n_components==n_components, ExcComponentMismatch()); -#ifdef DEBUG - if (true) - { - unsigned int max_element = 0; - for (std::vector::const_iterator i=dof_to_boundary_mapping.begin(); - i!=dof_to_boundary_mapping.end(); ++i) - if ((*i != DoFHandler::invalid_dof_index) && - (*i > max_element)) - max_element = *i; - Assert (max_element == matrix.n()-1, ExcInternalError()); - }; -#endif - - const unsigned int dofs_per_cell = fe.dofs_per_cell, - dofs_per_face = fe.dofs_per_face; - - FullMatrix cell_matrix(dofs_per_cell, dofs_per_cell); - Vector cell_vector(dofs_per_cell); - + UpdateFlags update_flags = UpdateFlags(update_values | + update_JxW_values); + if (coefficient != 0) + update_flags = UpdateFlags (update_flags | update_q_points); - UpdateFlags update_flags = UpdateFlags (update_values | - update_JxW_values | - update_q_points); - FEFaceValues fe_values (mapping, fe, q, update_flags); + hp::FEValues x_fe_values (mapping, dof.get_fe(), q, update_flags); + + const unsigned int n_components = dof.get_fe().n_components(); - // two variables for the coefficient, - // one for the two cases indicated in - // the name - std::vector coefficient_values (fe_values.n_quadrature_points); - std::vector > coefficient_vector_values (fe_values.n_quadrature_points, - Vector(n_components)); + Assert(coefficient == 0 || + coefficient->n_components==1 || + coefficient->n_components==n_components, ExcComponentMismatch()); - std::vector rhs_values_scalar (fe_values.n_quadrature_points); - std::vector > rhs_values_system (fe_values.n_quadrature_points, - Vector(n_components)); + FullMatrix cell_matrix; + std::vector coefficient_values; + std::vector > coefficient_vector_values; + + std::vector dof_indices; + + typename hp::DoFHandler::active_cell_iterator cell = range.first; + for (; cell!=range.second; ++cell) + { + x_fe_values.reinit (cell); + const FEValues &fe_values = x_fe_values.get_present_fe_values (); - std::vector dofs (dofs_per_cell); - std::vector dofs_on_face_vector (dofs_per_face); + const unsigned int dofs_per_cell = fe_values.dofs_per_cell, + n_q_points = fe_values.n_quadrature_points; + const FiniteElement &fe = fe_values.get_fe(); - // for each dof on the cell, have a - // flag whether it is on the face - std::vector dof_is_on_face(dofs_per_cell); + cell_matrix.reinit (dofs_per_cell, dofs_per_cell); + coefficient_values.resize (n_q_points); + coefficient_vector_values.resize (n_q_points, + Vector (n_components)); + dof_indices.resize (dofs_per_cell); - typename DoFHandler::active_cell_iterator cell = range.first; - for (; cell!=range.second; ++cell) - for (unsigned int face=0; face::faces_per_cell; ++face) - // check if this face is on that part of - // the boundary we are interested in - if (boundary_functions.find(cell->face(face)->boundary_indicator()) != - boundary_functions.end()) + + cell_matrix = 0; + cell->get_dof_indices (dof_indices); + + if (coefficient != 0) { - cell_matrix = 0; - cell_vector = 0; - - fe_values.reinit (cell, face); - - if (fe_is_system) - // FE has several components + if (coefficient->n_components==1) { - boundary_functions.find(cell->face(face)->boundary_indicator()) - ->second->vector_value_list (fe_values.get_quadrature_points(), - rhs_values_system); - - if (coefficient != 0) + coefficient->value_list (fe_values.get_quadrature_points(), + coefficient_values); + for (unsigned int point=0; pointn_components==1) + const double weight = fe_values.JxW(point); + for (unsigned int i=0; ivalue_list (fe_values.get_quadrature_points(), - coefficient_values); - for (unsigned int point=0; pointvector_value_list (fe_values.get_quadrature_points(), + coefficient_vector_values); + for (unsigned int point=0; pointvector_value_list (fe_values.get_quadrature_points(), - coefficient_vector_values); - for (unsigned int point=0; point +void MatrixCreator::create_mass_matrix (const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient) +{ + Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping")); + create_mass_matrix(hp::StaticMappingQ1::mapping_collection, dof, q, matrix, coefficient); +} + + + +template +void MatrixCreator::create_mass_matrix (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient) +{ + Assert (matrix.m() == dof.n_dofs(), + ExcDimensionMismatch (matrix.m(), dof.n_dofs())); + Assert (matrix.n() == dof.n_dofs(), + ExcDimensionMismatch (matrix.n(), dof.n_dofs())); + + const unsigned int n_threads = multithread_info.n_default_threads; + Threads::ThreadGroup<> threads; + + // define starting and end point + // for each thread + typedef typename hp::DoFHandler::active_cell_iterator active_cell_iterator; + std::vector > thread_ranges + = Threads::split_range (dof.begin_active(), + dof.end(), n_threads); + + // mutex to synchronise access to + // the matrix + Threads::ThreadMutex mutex; + + // then assemble in parallel + typedef void (*create_mass_matrix_2_t) (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const IteratorRange > range, + Threads::ThreadMutex &mutex); + create_mass_matrix_2_t p = &MatrixCreator::template create_mass_matrix_2; + for (unsigned int thread=0; thread +void +MatrixCreator::create_mass_matrix_2 (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const IteratorRange > range, + Threads::ThreadMutex &mutex) +{ + UpdateFlags update_flags = UpdateFlags(update_values | + update_q_points | + update_JxW_values); + if (coefficient != 0) + update_flags = UpdateFlags (update_flags | update_q_points); + + hp::FEValues x_fe_values (mapping, dof.get_fe(), q, update_flags); + + const unsigned int n_components = dof.get_fe().n_components(); + + Assert(coefficient == 0 || + coefficient->n_components==1 || + coefficient->n_components==n_components, ExcComponentMismatch()); + + FullMatrix cell_matrix; + Vector local_rhs; + std::vector rhs_values; + std::vector coefficient_values; + std::vector > coefficient_vector_values; + + std::vector dof_indices; + + typename hp::DoFHandler::active_cell_iterator cell = range.first; + for (; cell!=range.second; ++cell) + { + x_fe_values.reinit (cell); + const FEValues &fe_values = x_fe_values.get_present_fe_values (); + + const unsigned int dofs_per_cell = fe_values.dofs_per_cell, + n_q_points = fe_values.n_quadrature_points; + const FiniteElement &fe = fe_values.get_fe(); + + cell_matrix.reinit (dofs_per_cell, dofs_per_cell); + local_rhs.reinit (dofs_per_cell); + rhs_values.resize (fe_values.n_quadrature_points); + coefficient_values.resize (n_q_points); + coefficient_vector_values.resize (n_q_points, + Vector (n_components)); + dof_indices.resize (dofs_per_cell); + + + cell_matrix = 0; + local_rhs = 0; + cell->get_dof_indices (dof_indices); + + rhs.value_list (fe_values.get_quadrature_points(), rhs_values); + + if (coefficient != 0) + { + if (coefficient->n_components==1) + { + coefficient->value_list (fe_values.get_quadrature_points(), + coefficient_values); + for (unsigned int point=0; pointvector_value_list (fe_values.get_quadrature_points(), + coefficient_vector_values); + for (unsigned int point=0; point +void MatrixCreator::create_mass_matrix (const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient) +{ + Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping")); + create_mass_matrix(hp::StaticMappingQ1::mapping_collection, dof, q, + matrix, rhs, rhs_vector, coefficient); +} + + + + +#if deal_II_dimension == 1 + +void MatrixCreator::create_boundary_mass_matrix (const Mapping<1> &, + const DoFHandler<1> &, + const Quadrature<0> &, + SparseMatrix &, + const FunctionMap<1>::type&, + Vector &, + std::vector &, + const Function<1> * const) +{ + // what would that be in 1d? the + // identity matrix on the boundary + // dofs? + Assert (false, ExcNotImplemented()); +} + + +#endif + + + +template +void +MatrixCreator::create_boundary_mass_matrix (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const typename FunctionMap::type &boundary_functions, + Vector &rhs_vector, + std::vector &dof_to_boundary_mapping, + const Function * const coefficient) +{ + const unsigned int n_threads = multithread_info.n_default_threads; + Threads::ThreadGroup<> threads; + + // define starting and end point + // for each thread + typedef typename DoFHandler::active_cell_iterator active_cell_iterator; + std::vector > thread_ranges + = Threads::split_range (dof.begin_active(), + dof.end(), n_threads); + + // mutex to synchronise access to + // the matrix + Threads::ThreadMutex mutex; + + // then assemble in parallel + typedef void (*create_boundary_mass_matrix_1_t) + (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const typename FunctionMap::type &boundary_functions, + Vector &rhs_vector, + std::vector &dof_to_boundary_mapping, + const Function * const coefficient, + const IteratorRange > range, + Threads::ThreadMutex &mutex); + create_boundary_mass_matrix_1_t p = &MatrixCreator::template create_boundary_mass_matrix_1; + for (unsigned int thread=0; thread +void +MatrixCreator:: +create_boundary_mass_matrix_1 (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const typename FunctionMap::type &boundary_functions, + Vector &rhs_vector, + std::vector &dof_to_boundary_mapping, + const Function * const coefficient, + const IteratorRange > range, + Threads::ThreadMutex &mutex) +{ + const FiniteElement &fe = dof.get_fe(); + const unsigned int n_components = fe.n_components(); + const bool fe_is_system = (n_components != 1); + + Assert (matrix.n() == dof.n_boundary_dofs(boundary_functions), + ExcInternalError()); + Assert (matrix.n() == matrix.m(), ExcInternalError()); + Assert (matrix.n() == rhs_vector.size(), ExcInternalError()); + Assert (boundary_functions.size() != 0, ExcInternalError()); + Assert (dof.get_fe() == fe, ExcInternalError()); + Assert (dof_to_boundary_mapping.size() == dof.n_dofs(), + ExcInternalError()); + Assert (n_components == boundary_functions.begin()->second->n_components, + ExcComponentMismatch()); + Assert (coefficient ==0 || + coefficient->n_components==1 || + coefficient->n_components==n_components, ExcComponentMismatch()); +#ifdef DEBUG + if (true) + { + unsigned int max_element = 0; + for (std::vector::const_iterator i=dof_to_boundary_mapping.begin(); + i!=dof_to_boundary_mapping.end(); ++i) + if ((*i != DoFHandler::invalid_dof_index) && + (*i > max_element)) + max_element = *i; + Assert (max_element == matrix.n()-1, ExcInternalError()); + }; +#endif + + const unsigned int dofs_per_cell = fe.dofs_per_cell, + dofs_per_face = fe.dofs_per_face; + + FullMatrix cell_matrix(dofs_per_cell, dofs_per_cell); + Vector cell_vector(dofs_per_cell); + + + UpdateFlags update_flags = UpdateFlags (update_values | + update_JxW_values | + update_q_points); + FEFaceValues fe_values (mapping, fe, q, update_flags); + + // two variables for the coefficient, + // one for the two cases indicated in + // the name + std::vector coefficient_values (fe_values.n_quadrature_points); + std::vector > coefficient_vector_values (fe_values.n_quadrature_points, + Vector(n_components)); + + std::vector rhs_values_scalar (fe_values.n_quadrature_points); + std::vector > rhs_values_system (fe_values.n_quadrature_points, + Vector(n_components)); + + std::vector dofs (dofs_per_cell); + std::vector dofs_on_face_vector (dofs_per_face); + + // for each dof on the cell, have a + // flag whether it is on the face + std::vector dof_is_on_face(dofs_per_cell); + + typename DoFHandler::active_cell_iterator cell = range.first; + for (; cell!=range.second; ++cell) + for (unsigned int face=0; face::faces_per_cell; ++face) + // check if this face is on that part of + // the boundary we are interested in + if (boundary_functions.find(cell->face(face)->boundary_indicator()) != + boundary_functions.end()) + { + cell_matrix = 0; + cell_vector = 0; + + fe_values.reinit (cell, face); + + if (fe_is_system) + // FE has several components + { + boundary_functions.find(cell->face(face)->boundary_indicator()) + ->second->vector_value_list (fe_values.get_quadrature_points(), + rhs_values_system); + + if (coefficient != 0) + { + if (coefficient->n_components==1) + { + coefficient->value_list (fe_values.get_quadrature_points(), + coefficient_values); + for (unsigned int point=0; pointvector_value_list (fe_values.get_quadrature_points(), + coefficient_vector_values); + for (unsigned int point=0; pointface(face)->boundary_indicator()) + ->second->value_list (fe_values.get_quadrature_points(), rhs_values_scalar); + + if (coefficient != 0) + { + coefficient->value_list (fe_values.get_quadrature_points(), + coefficient_values); + for (unsigned int point=0; pointget_dof_indices (dofs); + cell->face(face)->get_dof_indices (dofs_on_face_vector); + + // check for each of the + // dofs on this cell + // whether it is on the + // face + for (unsigned int i=0; i max_diag_entry) + max_diag_entry = std::fabs(cell_matrix(i,i)); +#endif + + // lock the matrix + Threads::ThreadMutex::ScopedLock lock (mutex); + for (unsigned int i=0; i +void MatrixCreator::create_boundary_mass_matrix (const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const typename FunctionMap::type &rhs, + Vector &rhs_vector, + std::vector &dof_to_boundary_mapping, + const Function * const a) +{ + Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping")); + create_boundary_mass_matrix(StaticMappingQ1::mapping, dof, q, + matrix,rhs, rhs_vector, dof_to_boundary_mapping, a); +} + + + +#if deal_II_dimension == 1 + +void MatrixCreator::create_boundary_mass_matrix (const hp::MappingCollection<1> &, + const hp::DoFHandler<1> &, + const hp::QCollection<0> &, + SparseMatrix &, + const FunctionMap<1>::type&, + Vector &, + std::vector &, + const Function<1> * const) +{ + // what would that be in 1d? the + // identity matrix on the boundary + // dofs? + Assert (false, ExcNotImplemented()); +} + + +#endif + + + +template +void +MatrixCreator::create_boundary_mass_matrix (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const typename FunctionMap::type &boundary_functions, + Vector &rhs_vector, + std::vector &dof_to_boundary_mapping, + const Function * const coefficient) +{ + const unsigned int n_threads = multithread_info.n_default_threads; + Threads::ThreadGroup<> threads; + + // define starting and end point + // for each thread + typedef typename hp::DoFHandler::active_cell_iterator active_cell_iterator; + std::vector > thread_ranges + = Threads::split_range (dof.begin_active(), + dof.end(), n_threads); + + // mutex to synchronise access to + // the matrix + Threads::ThreadMutex mutex; + + // then assemble in parallel + typedef void (*create_boundary_mass_matrix_1_t) + (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const typename FunctionMap::type &boundary_functions, + Vector &rhs_vector, + std::vector &dof_to_boundary_mapping, + const Function * const coefficient, + const IteratorRange > range, + Threads::ThreadMutex &mutex); + create_boundary_mass_matrix_1_t p = &MatrixCreator::template create_boundary_mass_matrix_1; + for (unsigned int thread=0; thread +void +MatrixCreator:: +create_boundary_mass_matrix_1 (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const typename FunctionMap::type &boundary_functions, + Vector &rhs_vector, + std::vector &dof_to_boundary_mapping, + const Function * const coefficient, + const IteratorRange > range, + Threads::ThreadMutex &mutex) +{ +/* + const FiniteElement &fe = dof.get_fe(); + const unsigned int n_components = fe.n_components(); + const bool fe_is_system = (n_components != 1); + + Assert (matrix.n() == dof.n_boundary_dofs(boundary_functions), + ExcInternalError()); + Assert (matrix.n() == matrix.m(), ExcInternalError()); + Assert (matrix.n() == rhs_vector.size(), ExcInternalError()); + Assert (boundary_functions.size() != 0, ExcInternalError()); + Assert (dof.get_fe() == fe, ExcInternalError()); + Assert (dof_to_boundary_mapping.size() == dof.n_dofs(), + ExcInternalError()); + Assert (n_components == boundary_functions.begin()->second->n_components, + ExcComponentMismatch()); + Assert (coefficient ==0 || + coefficient->n_components==1 || + coefficient->n_components==n_components, ExcComponentMismatch()); +#ifdef DEBUG + if (true) + { + unsigned int max_element = 0; + for (std::vector::const_iterator i=dof_to_boundary_mapping.begin(); + i!=dof_to_boundary_mapping.end(); ++i) + if ((*i != hp::DoFHandler::invalid_dof_index) && + (*i > max_element)) + max_element = *i; + Assert (max_element == matrix.n()-1, ExcInternalError()); + }; +#endif + + const unsigned int dofs_per_cell = fe.dofs_per_cell, + dofs_per_face = fe.dofs_per_face; + + FullMatrix cell_matrix(dofs_per_cell, dofs_per_cell); + Vector cell_vector(dofs_per_cell); + + + UpdateFlags update_flags = UpdateFlags (update_values | + update_JxW_values | + update_q_points); + FEFaceValues fe_values (mapping, fe, q, update_flags); + + // two variables for the coefficient, + // one for the two cases indicated in + // the name + std::vector coefficient_values (fe_values.n_quadrature_points); + std::vector > coefficient_vector_values (fe_values.n_quadrature_points, + Vector(n_components)); + + std::vector rhs_values_scalar (fe_values.n_quadrature_points); + std::vector > rhs_values_system (fe_values.n_quadrature_points, + Vector(n_components)); + + std::vector dofs (dofs_per_cell); + std::vector dofs_on_face_vector (dofs_per_face); + + // for each dof on the cell, have a + // flag whether it is on the face + std::vector dof_is_on_face(dofs_per_cell); + + typename hp::DoFHandler::active_cell_iterator cell = range.first; + for (; cell!=range.second; ++cell) + for (unsigned int face=0; face::faces_per_cell; ++face) + // check if this face is on that part of + // the boundary we are interested in + if (boundary_functions.find(cell->face(face)->boundary_indicator()) != + boundary_functions.end()) + { + cell_matrix = 0; + cell_vector = 0; + + fe_values.reinit (cell, face); + + if (fe_is_system) + // FE has several components + { + boundary_functions.find(cell->face(face)->boundary_indicator()) + ->second->vector_value_list (fe_values.get_quadrature_points(), + rhs_values_system); + + if (coefficient != 0) + { + if (coefficient->n_components==1) + { + coefficient->value_list (fe_values.get_quadrature_points(), + coefficient_values); + for (unsigned int point=0; pointvector_value_list (fe_values.get_quadrature_points(), + coefficient_vector_values); + for (unsigned int point=0; pointface(face)->boundary_indicator()) - ->second->value_list (fe_values.get_quadrature_points(), rhs_values_scalar); - - if (coefficient != 0) - { - coefficient->value_list (fe_values.get_quadrature_points(), - coefficient_values); - for (unsigned int point=0; pointface(face)->boundary_indicator()) + ->second->value_list (fe_values.get_quadrature_points(), rhs_values_scalar); + + if (coefficient != 0) + { + coefficient->value_list (fe_values.get_quadrature_points(), + coefficient_values); + for (unsigned int point=0; pointget_dof_indices (dofs); + cell->face(face)->get_dof_indices (dofs_on_face_vector); + + // check for each of the + // dofs on this cell + // whether it is on the + // face + for (unsigned int i=0; i max_diag_entry) + max_diag_entry = std::fabs(cell_matrix(i,i)); +#endif + + // lock the matrix + Threads::ThreadMutex::ScopedLock lock (mutex); + for (unsigned int i=0; i +void MatrixCreator::create_boundary_mass_matrix (const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const typename FunctionMap::type &rhs, + Vector &rhs_vector, + std::vector &dof_to_boundary_mapping, + const Function * const a) +{ + Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping")); + create_boundary_mass_matrix(hp::StaticMappingQ1::mapping_collection, dof, q, + matrix,rhs, rhs_vector, dof_to_boundary_mapping, a); +} + + + +template +void MatrixCreator::create_laplace_matrix (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function * const coefficient) +{ + Assert (matrix.m() == dof.n_dofs(), + ExcDimensionMismatch (matrix.m(), dof.n_dofs())); + Assert (matrix.n() == dof.n_dofs(), + ExcDimensionMismatch (matrix.n(), dof.n_dofs())); + + const unsigned int n_threads = multithread_info.n_default_threads; + Threads::ThreadGroup<> threads; + + // define starting and end point + // for each thread + typedef typename DoFHandler::active_cell_iterator active_cell_iterator; + std::vector > thread_ranges + = Threads::split_range (dof.begin_active(), + dof.end(), n_threads); + + // mutex to synchronise access to + // the matrix + Threads::ThreadMutex mutex; + + // then assemble in parallel + typedef void (*create_laplace_matrix_1_t) (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function * const coefficient, + const IteratorRange > range, + Threads::ThreadMutex &mutex); + create_laplace_matrix_1_t p = &MatrixCreator::template create_laplace_matrix_1; + for (unsigned int thread=0; thread +void MatrixCreator::create_laplace_matrix_1 (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function * const coefficient, + const IteratorRange > range, + Threads::ThreadMutex &mutex) +{ + UpdateFlags update_flags = UpdateFlags(update_JxW_values | + update_gradients); + if (coefficient != 0) + update_flags = UpdateFlags (update_flags | update_q_points); + + FEValues fe_values (mapping, dof.get_fe(), q, update_flags); + + const unsigned int dofs_per_cell = fe_values.dofs_per_cell, + n_q_points = fe_values.n_quadrature_points; + const FiniteElement &fe = fe_values.get_fe(); + const unsigned int n_components = fe.n_components(); + + Assert(coefficient == 0 || + coefficient->n_components==1 || + coefficient->n_components==n_components, ExcComponentMismatch()); + + FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); + std::vector coefficient_values (n_q_points); + std::vector > coefficient_vector_values (n_q_points, + Vector (n_components)); + + std::vector dof_indices (dofs_per_cell); + + typename DoFHandler::active_cell_iterator cell = range.first; + for (; cell!=range.second; ++cell) + { + fe_values.reinit (cell); + + cell_matrix = 0; + cell->get_dof_indices (dof_indices); + + if (coefficient != 0) + { + if (coefficient->n_components==1) + { + coefficient->value_list (fe_values.get_quadrature_points(), + coefficient_values); + for (unsigned int point=0; point& Dv = fe_values.shape_grad(i,point); + for (unsigned int j=0; j& Du = fe_values.shape_grad(j,point); + if ((n_components==1) || + (fe.system_to_component_index(i).first == + fe.system_to_component_index(j).first)) + cell_matrix(i,j) += (Du * Dv * weight * + coefficient_values[point]); + } + } + } + } + else + { + coefficient->vector_value_list (fe_values.get_quadrature_points(), + coefficient_vector_values); + for (unsigned int point=0; point& Dv = fe_values.shape_grad(i,point); + const unsigned int component_i= + fe.system_to_component_index(i).first; + for (unsigned int j=0; j& Du = fe_values.shape_grad(j,point); + if ((n_components==1) || + (fe.system_to_component_index(j).first == component_i)) + cell_matrix(i,j) += (Du * Dv * weight * + coefficient_vector_values[point](component_i)); + + } + } + } + } + } + else + for (unsigned int point=0; point& Dv = fe_values.shape_grad(i,point); + for (unsigned int j=0; j& Du = fe_values.shape_grad(j,point); + if ((n_components==1) || + (fe.system_to_component_index(i).first == + fe.system_to_component_index(j).first)) + cell_matrix(i,j) += (Du * Dv * weight); + } + } + } + + // transfer everything into the + // global object. lock the + // matrix meanwhile + Threads::ThreadMutex::ScopedLock lock (mutex); + for (unsigned int i=0; i +void MatrixCreator::create_laplace_matrix (const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function * const coefficient) +{ + Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping")); + create_laplace_matrix(StaticMappingQ1::mapping, dof, q, matrix, coefficient); +} + + + +template +void MatrixCreator::create_laplace_matrix (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient) +{ + Assert (matrix.m() == dof.n_dofs(), + ExcDimensionMismatch (matrix.m(), dof.n_dofs())); + Assert (matrix.n() == dof.n_dofs(), + ExcDimensionMismatch (matrix.n(), dof.n_dofs())); + + const unsigned int n_threads = multithread_info.n_default_threads; + Threads::ThreadGroup<> threads; + + // define starting and end point + // for each thread + typedef typename DoFHandler::active_cell_iterator active_cell_iterator; + std::vector > thread_ranges + = Threads::split_range (dof.begin_active(), + dof.end(), n_threads); + + // mutex to synchronise access to + // the matrix + Threads::ThreadMutex mutex; + + // then assemble in parallel + typedef void (*create_laplace_matrix_2_t) (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const IteratorRange > range, + Threads::ThreadMutex &mutex); + create_laplace_matrix_2_t p = &MatrixCreator::template create_laplace_matrix_2; + for (unsigned int thread=0; thread +void +MatrixCreator::create_laplace_matrix_2 (const Mapping &mapping, + const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient, + const IteratorRange > range, + Threads::ThreadMutex &mutex) +{ + UpdateFlags update_flags = UpdateFlags(update_values | + update_gradients | + update_q_points | + update_JxW_values); + if (coefficient != 0) + update_flags = UpdateFlags (update_flags | update_q_points); + + FEValues fe_values (mapping, dof.get_fe(), q, update_flags); + + const unsigned int dofs_per_cell = fe_values.dofs_per_cell, + n_q_points = fe_values.n_quadrature_points; + const FiniteElement &fe = fe_values.get_fe(); + const unsigned int n_components = fe.n_components(); + + Assert(coefficient == 0 || + coefficient->n_components==1 || + coefficient->n_components==n_components, ExcComponentMismatch()); + + FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); + Vector local_rhs (dofs_per_cell); + std::vector rhs_values (fe_values.n_quadrature_points); + std::vector coefficient_values (n_q_points); + std::vector > coefficient_vector_values (n_q_points, + Vector (n_components)); + + std::vector dof_indices (dofs_per_cell); + + typename DoFHandler::active_cell_iterator cell = range.first; + for (; cell!=range.second; ++cell) + { + fe_values.reinit (cell); + + cell_matrix = 0; + local_rhs = 0; + cell->get_dof_indices (dof_indices); + + rhs.value_list (fe_values.get_quadrature_points(), rhs_values); + + if (coefficient != 0) + { + if (coefficient->n_components==1) + { + coefficient->value_list (fe_values.get_quadrature_points(), + coefficient_values); + for (unsigned int point=0; point& Dv = fe_values.shape_grad(i,point); + for (unsigned int j=0; j& Du = fe_values.shape_grad(j,point); + if ((n_components==1) || + (fe.system_to_component_index(i).first == + fe.system_to_component_index(j).first)) + cell_matrix(i,j) += (Du * Dv * weight * + coefficient_values[point]); + local_rhs(i) += v * rhs_values[point] * weight; } - cell_vector(i) += v * rhs_values_scalar[point] * weight; } } } - - // now transfer cell matrix and vector - // to the whole boundary matrix - // - // in the following: dof[i] holds the - // global index of the i-th degree of - // freedom on the present cell. If it - // is also a dof on the boundary, it - // must be a nonzero entry in the - // dof_to_boundary_mapping and then - // the boundary index of this dof is - // dof_to_boundary_mapping[dof[i]]. - // - // if dof[i] is not on the boundary, - // it should be zero on the boundary - // therefore on all quadrature - // points and finally all of its - // entries in the cell matrix and - // vector should be zero. If not, we - // throw an error (note: because of - // the evaluation of the shape - // functions only up to machine - // precision, the term "must be zero" - // really should mean: "should be - // very small". since this is only an - // assertion and not part of the - // code, we may choose "very small" - // quite arbitrarily) - // - // the main problem here is that the - // matrix or vector entry should also - // be zero if the degree of freedom - // dof[i] is on the boundary, but not - // on the present face, i.e. on - // another face of the same cell also - // on the boundary. We can therefore - // not rely on the - // dof_to_boundary_mapping[dof[i]] - // being !=-1, we really have to - // determine whether dof[i] is a - // dof on the present face. We do so - // by getting the dofs on the - // face into @p{dofs_on_face_vector}, - // a vector as always. Usually, - // searching in a vector is - // inefficient, so we copy the dofs - // into a set, which enables binary - // searches. - cell->get_dof_indices (dofs); - cell->face(face)->get_dof_indices (dofs_on_face_vector); - - // check for each of the - // dofs on this cell - // whether it is on the - // face - for (unsigned int i=0; i max_diag_entry) - max_diag_entry = std::fabs(cell_matrix(i,i)); -#endif - - // lock the matrix - Threads::ThreadMutex::ScopedLock lock (mutex); - for (unsigned int i=0; ivector_value_list (fe_values.get_quadrature_points(), + coefficient_vector_values); + for (unsigned int point=0; point& Dv = fe_values.shape_grad(i,point); + const unsigned int component_i= + fe.system_to_component_index(i).first; + for (unsigned int j=0; j& Du = fe_values.shape_grad(j,point); + if ((n_components==1) || + (fe.system_to_component_index(j).first == component_i)) + cell_matrix(i,j) += (Du * Dv * weight * + coefficient_vector_values[point](component_i)); + local_rhs(i) += v * rhs_values[point] * weight; + } + } + } + } + } + else + for (unsigned int point=0; point& Dv = fe_values.shape_grad(i,point); + for (unsigned int j=0; j& Du = fe_values.shape_grad(j,point); + if ((n_components==1) || + (fe.system_to_component_index(i).first == + fe.system_to_component_index(j).first)) + cell_matrix(i,j) += (Du * Dv * weight); + local_rhs(i) += v * rhs_values[point] * weight; + } + } + } + + // transfer everything into the + // global object. lock the + // matrix meanwhile + Threads::ThreadMutex::ScopedLock lock (mutex); + for (unsigned int i=0; i -void MatrixCreator::create_boundary_mass_matrix (const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const typename FunctionMap::type &rhs, - Vector &rhs_vector, - std::vector &dof_to_boundary_mapping, - const Function * const a) +void MatrixCreator::create_laplace_matrix (const DoFHandler &dof, + const Quadrature &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient) { Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping")); - create_boundary_mass_matrix(StaticMappingQ1::mapping, dof, q, - matrix,rhs, rhs_vector, dof_to_boundary_mapping, a); + create_laplace_matrix(StaticMappingQ1::mapping, dof, q, + matrix, rhs, rhs_vector, coefficient); } template -void MatrixCreator::create_laplace_matrix (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, +void MatrixCreator::create_laplace_matrix (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, SparseMatrix &matrix, const Function * const coefficient) { @@ -969,7 +2201,7 @@ void MatrixCreator::create_laplace_matrix (const Mapping &mapping, // define starting and end point // for each thread - typedef typename DoFHandler::active_cell_iterator active_cell_iterator; + typedef typename hp::DoFHandler::active_cell_iterator active_cell_iterator; std::vector > thread_ranges = Threads::split_range (dof.begin_active(), dof.end(), n_threads); @@ -979,12 +2211,12 @@ void MatrixCreator::create_laplace_matrix (const Mapping &mapping, Threads::ThreadMutex mutex; // then assemble in parallel - typedef void (*create_laplace_matrix_1_t) (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, + typedef void (*create_laplace_matrix_1_t) (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, SparseMatrix &matrix, const Function * const coefficient, - const IteratorRange range, + const IteratorRange > range, Threads::ThreadMutex &mutex); create_laplace_matrix_1_t p = &MatrixCreator::template create_laplace_matrix_1; for (unsigned int thread=0; thread &mapping, template -void MatrixCreator::create_laplace_matrix_1 (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, - SparseMatrix &matrix, - const Function * const coefficient, - const IteratorRange range, - Threads::ThreadMutex &mutex) +void +MatrixCreator::create_laplace_matrix_1 (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient, + const IteratorRange > range, + Threads::ThreadMutex &mutex) { - UpdateFlags update_flags = UpdateFlags(update_JxW_values | - update_gradients); + UpdateFlags update_flags = UpdateFlags(update_gradients | + update_JxW_values); if (coefficient != 0) update_flags = UpdateFlags (update_flags | update_q_points); - FEValues fe_values (mapping, dof.get_fe(), q, update_flags); + hp::FEValues x_fe_values (mapping, dof.get_fe(), q, update_flags); - const unsigned int dofs_per_cell = fe_values.dofs_per_cell, - n_q_points = fe_values.n_quadrature_points; - const FiniteElement &fe = fe_values.get_fe(); - const unsigned int n_components = fe.n_components(); + const unsigned int n_components = dof.get_fe().n_components(); Assert(coefficient == 0 || coefficient->n_components==1 || coefficient->n_components==n_components, ExcComponentMismatch()); - FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); - std::vector coefficient_values (n_q_points); - std::vector > coefficient_vector_values (n_q_points, - Vector (n_components)); + FullMatrix cell_matrix; + std::vector coefficient_values; + std::vector > coefficient_vector_values; - std::vector dof_indices (dofs_per_cell); + std::vector dof_indices; - typename DoFHandler::active_cell_iterator cell = range.first; + typename hp::DoFHandler::active_cell_iterator cell = range.first; for (; cell!=range.second; ++cell) { - fe_values.reinit (cell); + x_fe_values.reinit (cell); + const FEValues &fe_values = x_fe_values.get_present_fe_values (); + + const unsigned int dofs_per_cell = fe_values.dofs_per_cell, + n_q_points = fe_values.n_quadrature_points; + const FiniteElement &fe = fe_values.get_fe(); + + cell_matrix.reinit (dofs_per_cell, dofs_per_cell); + coefficient_values.resize (n_q_points); + coefficient_vector_values.resize (n_q_points, + Vector (n_components)); + dof_indices.resize (dofs_per_cell); + cell_matrix = 0; cell->get_dof_indices (dof_indices); @@ -1042,53 +2283,52 @@ void MatrixCreator::create_laplace_matrix_1 (const Mapping &mapping, coefficient->value_list (fe_values.get_quadrature_points(), coefficient_values); for (unsigned int point=0; point& Dv = fe_values.shape_grad(i,point); - for (unsigned int j=0; j& Du = fe_values.shape_grad(j,point); - if ((n_components==1) || - (fe.system_to_component_index(i).first == - fe.system_to_component_index(j).first)) - cell_matrix(i,j) += (Du * Dv * weight * - coefficient_values[point]); - } - } - } + { + const double weight = fe_values.JxW(point); + for (unsigned int i=0; i& Dv = fe_values.shape_grad(i,point); + for (unsigned int j=0; j& Du = fe_values.shape_grad(j,point); + if ((n_components==1) || + (fe.system_to_component_index(i).first == + fe.system_to_component_index(j).first)) + cell_matrix(i,j) += (Du * Dv * weight * + coefficient_values[point]); + } + } + } } else { coefficient->vector_value_list (fe_values.get_quadrature_points(), coefficient_vector_values); for (unsigned int point=0; point& Dv = fe_values.shape_grad(i,point); - const unsigned int component_i= - fe.system_to_component_index(i).first; - for (unsigned int j=0; j& Du = fe_values.shape_grad(j,point); - if ((n_components==1) || - (fe.system_to_component_index(j).first == component_i)) - cell_matrix(i,j) += (Du * Dv * weight * - coefficient_vector_values[point](component_i)); - - } - } - } + { + const double weight = fe_values.JxW(point); + for (unsigned int i=0; i& Dv = fe_values.shape_grad(i,point); + const unsigned int component_i= + fe.system_to_component_index(i).first; + for (unsigned int j=0; j& Du = fe_values.shape_grad(j,point); + if ((n_components==1) || + (fe.system_to_component_index(j).first == component_i)) + cell_matrix(i,j) += (Du * Dv * weight * + coefficient_vector_values[point](component_i)); + } + } + } } } else for (unsigned int point=0; point& Dv = fe_values.shape_grad(i,point); for (unsigned int j=0; j &mapping, } } } - + // transfer everything into the // global object. lock the // matrix meanwhile @@ -1119,21 +2359,21 @@ void MatrixCreator::create_laplace_matrix_1 (const Mapping &mapping, template -void MatrixCreator::create_laplace_matrix (const DoFHandler &dof, - const Quadrature &q, +void MatrixCreator::create_laplace_matrix (const hp::DoFHandler &dof, + const hp::QCollection &q, SparseMatrix &matrix, const Function * const coefficient) { Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping")); - create_laplace_matrix(StaticMappingQ1::mapping, dof, q, matrix, coefficient); + create_laplace_matrix(hp::StaticMappingQ1::mapping_collection, dof, q, matrix, coefficient); } template -void MatrixCreator::create_laplace_matrix (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, +void MatrixCreator::create_laplace_matrix (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, SparseMatrix &matrix, const Function &rhs, Vector &rhs_vector, @@ -1149,7 +2389,7 @@ void MatrixCreator::create_laplace_matrix (const Mapping &mapping, // define starting and end point // for each thread - typedef typename DoFHandler::active_cell_iterator active_cell_iterator; + typedef typename hp::DoFHandler::active_cell_iterator active_cell_iterator; std::vector > thread_ranges = Threads::split_range (dof.begin_active(), dof.end(), n_threads); @@ -1159,14 +2399,14 @@ void MatrixCreator::create_laplace_matrix (const Mapping &mapping, Threads::ThreadMutex mutex; // then assemble in parallel - typedef void (*create_laplace_matrix_2_t) (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, + typedef void (*create_laplace_matrix_2_t) (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, SparseMatrix &matrix, const Function &rhs, Vector &rhs_vector, const Function * const coefficient, - const IteratorRange range, + const IteratorRange > range, Threads::ThreadMutex &mutex); create_laplace_matrix_2_t p = &MatrixCreator::template create_laplace_matrix_2; for (unsigned int thread=0; thread &mapping, template void -MatrixCreator::create_laplace_matrix_2 (const Mapping &mapping, - const DoFHandler &dof, - const Quadrature &q, +MatrixCreator::create_laplace_matrix_2 (const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, SparseMatrix &matrix, const Function &rhs, Vector &rhs_vector, const Function * const coefficient, - const IteratorRange range, + const IteratorRange > range, Threads::ThreadMutex &mutex) { UpdateFlags update_flags = UpdateFlags(update_values | @@ -1197,30 +2437,40 @@ MatrixCreator::create_laplace_matrix_2 (const Mapping &mapping, if (coefficient != 0) update_flags = UpdateFlags (update_flags | update_q_points); - FEValues fe_values (mapping, dof.get_fe(), q, update_flags); + hp::FEValues x_fe_values (mapping, dof.get_fe(), q, update_flags); - const unsigned int dofs_per_cell = fe_values.dofs_per_cell, - n_q_points = fe_values.n_quadrature_points; - const FiniteElement &fe = fe_values.get_fe(); - const unsigned int n_components = fe.n_components(); + const unsigned int n_components = dof.get_fe().n_components(); Assert(coefficient == 0 || coefficient->n_components==1 || coefficient->n_components==n_components, ExcComponentMismatch()); - FullMatrix cell_matrix (dofs_per_cell, dofs_per_cell); - Vector local_rhs (dofs_per_cell); - std::vector rhs_values (fe_values.n_quadrature_points); - std::vector coefficient_values (n_q_points); - std::vector > coefficient_vector_values (n_q_points, - Vector (n_components)); + FullMatrix cell_matrix; + Vector local_rhs; + std::vector rhs_values; + std::vector coefficient_values; + std::vector > coefficient_vector_values; - std::vector dof_indices (dofs_per_cell); + std::vector dof_indices; - typename DoFHandler::active_cell_iterator cell = range.first; + typename hp::DoFHandler::active_cell_iterator cell = range.first; for (; cell!=range.second; ++cell) { - fe_values.reinit (cell); + x_fe_values.reinit (cell); + const FEValues &fe_values = x_fe_values.get_present_fe_values (); + + const unsigned int dofs_per_cell = fe_values.dofs_per_cell, + n_q_points = fe_values.n_quadrature_points; + const FiniteElement &fe = fe_values.get_fe(); + + cell_matrix.reinit (dofs_per_cell, dofs_per_cell); + local_rhs.reinit (dofs_per_cell); + rhs_values.resize (fe_values.n_quadrature_points); + coefficient_values.resize (n_q_points); + coefficient_vector_values.resize (n_q_points, + Vector (n_components)); + dof_indices.resize (dofs_per_cell); + cell_matrix = 0; local_rhs = 0; @@ -1313,21 +2563,21 @@ MatrixCreator::create_laplace_matrix_2 (const Mapping &mapping, cell_matrix(i,j)); for (unsigned int i=0; i -void MatrixCreator::create_laplace_matrix (const DoFHandler &dof, - const Quadrature &q, +void MatrixCreator::create_laplace_matrix (const hp::DoFHandler &dof, + const hp::QCollection &q, SparseMatrix &matrix, const Function &rhs, Vector &rhs_vector, const Function * const coefficient) { Assert (DEAL_II_COMPAT_MAPPING, ExcCompatibility("mapping")); - create_laplace_matrix(StaticMappingQ1::mapping, dof, q, + create_laplace_matrix(hp::StaticMappingQ1::mapping_collection, dof, q, matrix, rhs, rhs_vector, coefficient); } @@ -1338,6 +2588,7 @@ void MatrixCreator::create_laplace_matrix (const DoFHandler &dof, // explicit instantiations +// non-hp version of create_mass_matrix template void MatrixCreator::create_mass_matrix (const Mapping &mapping, @@ -1401,6 +2652,71 @@ void MatrixCreator::create_mass_matrix Vector &rhs_vector, const Function * const coefficient); +// hp versions of functions +template +void MatrixCreator::create_mass_matrix +(const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient); +template +void MatrixCreator::create_mass_matrix +(const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient); +template +void MatrixCreator::create_mass_matrix +(const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient); +template +void MatrixCreator::create_mass_matrix +(const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient); + + +template +void MatrixCreator::create_mass_matrix +(const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient); +template +void MatrixCreator::create_mass_matrix +(const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient); +template +void MatrixCreator::create_mass_matrix +(const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient); +template +void MatrixCreator::create_mass_matrix +(const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient); + + #if deal_II_dimension != 1 template @@ -1425,13 +2741,41 @@ void MatrixCreator::create_boundary_mass_matrix Vector &rhs_vector, std::vector &dof_to_boundary_mapping, const Function * const a); + + +#if deal_II_dimension != 1 +template +void +MatrixCreator::create_boundary_mass_matrix +(const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const FunctionMap::type &boundary_functions, + Vector &rhs_vector, + std::vector &dof_to_boundary_mapping, + const Function * const a); +#endif + +template +void MatrixCreator::create_boundary_mass_matrix +(const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const FunctionMap::type &rhs, + Vector &rhs_vector, + std::vector &dof_to_boundary_mapping, + const Function * const a); + + + +// non-hp versions of create_laplace_matrix template void MatrixCreator::create_laplace_matrix (const DoFHandler &dof, const Quadrature &q, SparseMatrix &matrix, const Function * const coefficient); - template void MatrixCreator::create_laplace_matrix (const Mapping &mapping, @@ -1457,4 +2801,36 @@ void MatrixCreator::create_laplace_matrix Vector &rhs_vector, const Function * const coefficient); +// hp versions of create_laplace_matrix +template +void MatrixCreator::create_laplace_matrix +(const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient); +template +void MatrixCreator::create_laplace_matrix +(const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function * const coefficient); +template +void MatrixCreator::create_laplace_matrix +(const hp::MappingCollection &mapping, + const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient); +template +void MatrixCreator::create_laplace_matrix +(const hp::DoFHandler &dof, + const hp::QCollection &q, + SparseMatrix &matrix, + const Function &rhs, + Vector &rhs_vector, + const Function * const coefficient); + DEAL_II_NAMESPACE_CLOSE diff --git a/tests/hp/Makefile b/tests/hp/Makefile index 8ab1599d61..48ac8af961 100644 --- a/tests/hp/Makefile +++ b/tests/hp/Makefile @@ -35,7 +35,8 @@ tests_x = hp_dof_handler \ hp_*_dof_identities_* \ hp_hanging_nodes_* \ interpolate_* \ - hp_constraints_* + hp_constraints_* \ + matrices # from above list of regular expressions, generate the real set of # tests diff --git a/tests/hp/matrices.cc b/tests/hp/matrices.cc new file mode 100644 index 0000000000..086fbba620 --- /dev/null +++ b/tests/hp/matrices.cc @@ -0,0 +1,229 @@ +//---------------------------- matrices.cc --------------------------- +// $Id$ +// Version: $Name$ +// +// Copyright (C) 2000, 2001, 2003, 2004, 2006 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. +// +//---------------------------- matrices.cc --------------------------- + + +// like deal.II/matrices, but for hp objects. here, each hp object has only a +// single component, so we expect exactly the same output as for the old test + + + +#include "../tests.h" +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include +#include + +#include + + +template +class MySquareFunction : public Function +{ + public: + MySquareFunction () : Function(2) {}; + + virtual double value (const Point &p, + const unsigned int component) const + { return (component+1)*p.square(); }; + + virtual void vector_value (const Point &p, + Vector &values) const + { values(0) = value(p,0); + values(1) = value(p,1); }; +}; + + + + +template +void +check_boundary (const hp::DoFHandler &dof, + const hp::MappingCollection &mapping) +{ + MySquareFunction coefficient; + typename FunctionMap::type function_map; + function_map[0] = &coefficient; + + hp::QCollection face_quadrature; + face_quadrature.push_back (QGauss6()); + + std::vector dof_to_boundary_mapping; + DoFTools::map_dof_to_boundary_indices (dof, + dof_to_boundary_mapping); + + SparsityPattern sparsity(dof.n_boundary_dofs(function_map), + dof.max_couplings_between_boundary_dofs()); + DoFTools::make_boundary_sparsity_pattern (dof, + function_map, + dof_to_boundary_mapping, + sparsity); + sparsity.compress (); + + SparseMatrix matrix; + matrix.reinit (sparsity); + + Vector rhs (dof.n_boundary_dofs(function_map)); + MatrixTools:: + create_boundary_mass_matrix (mapping, dof, + face_quadrature, matrix, + function_map, rhs, + dof_to_boundary_mapping, + &coefficient); + + // since we only generate + // output with two digits after + // the dot, and since matrix + // entries are usually in the + // range of 1 or below, + // multiply matrix by 100 to + // make test more sensitive + for (unsigned int i=0; i &, + const hp::MappingCollection<1> &) +{} + + + + +template +void +check () +{ + Triangulation tr; + if (dim==2) + GridGenerator::hyper_ball(tr, Point(), 1); + else + GridGenerator::hyper_cube(tr, -1,1); + tr.refine_global (1); + tr.begin_active()->set_refine_flag (); + tr.execute_coarsening_and_refinement (); + if (dim==1) + tr.refine_global(2); + + // create a system element composed + // of one Q1 and one Q2 element + hp::FECollection element; + element.push_back (FESystem (FE_Q(1), 1, + FE_Q(2), 1)); + hp::DoFHandler dof(tr); + dof.distribute_dofs(element); + + // use a more complicated mapping + // of the domain and a quadrature + // formula suited to the elements + // we have here + hp::MappingCollection mapping; + mapping.push_back (MappingQ(3)); + + hp::QCollection quadrature; + quadrature.push_back (QGauss6()); + + // create sparsity pattern. note + // that different components should + // not couple, so use pattern + SparsityPattern sparsity (dof.n_dofs(), dof.n_dofs()); + std::vector > mask (2, std::vector(2, false)); + mask[0][0] = mask[1][1] = true; + DoFTools::make_sparsity_pattern (dof, mask, sparsity); + ConstraintMatrix constraints; + DoFTools::make_hanging_node_constraints (dof, constraints); + constraints.close (); + constraints.condense (sparsity); + sparsity.compress (); + + SparseMatrix matrix; + + Functions::ExpFunction coefficient; + + typename FunctionMap::type function_map; + function_map[0] = &coefficient; + + for (unsigned int test=0; test<2; ++test) + { + matrix.reinit(sparsity); + switch (test) + { + case 0: + MatrixTools:: + create_mass_matrix (mapping, dof, + quadrature, matrix, &coefficient); + break; + case 1: + MatrixTools:: + create_laplace_matrix (mapping, dof, + quadrature, matrix, &coefficient); + break; + default: + Assert (false, ExcInternalError()); + }; + + // since we only generate + // output with two digits after + // the dot, and since matrix + // entries are usually in the + // range of 1 or below, + // multiply matrix by 100 to + // make test more sensitive + for (unsigned int i=0; i 1) + check_boundary (dof, mapping); +} + + + +int main () +{ + std::ofstream logfile ("matrices/output"); + logfile.precision (2); + logfile.setf(std::ios::fixed); + deallog.attach(logfile); + deallog.depth_console (0); + + deallog.push ("1d"); + check<1> (); + deallog.pop (); + deallog.push ("2d"); + check<2> (); + deallog.pop (); + deallog.push ("3d"); + check<3> (); + deallog.pop (); +} diff --git a/tests/hp/matrices/cmp/generic b/tests/hp/matrices/cmp/generic new file mode 100644 index 0000000000..51d687ec32 --- /dev/null +++ b/tests/hp/matrices/cmp/generic @@ -0,0 +1,31260 @@ + +12.92 +4.73 +1.96 +5.08 +-0.95 +1.66 +-0.39 +0.83 +21.47 +4.73 +6.07 +8.57 +-0.95 +2.13 +-1.22 +2.13 +15.13 +1.66 +2.13 +27.56 +6.07 +7.80 +11.00 +-1.22 +2.74 +-1.56 +2.73 +19.42 +2.13 +2.74 +35.39 +7.80 +10.01 +14.13 +-1.56 +3.51 +-2.01 +3.51 +24.94 +2.73 +3.51 +21.30 +10.01 +8.79 +-2.01 +4.51 +32.02 +3.51 +4.51 +1.58 +0.82 +0.62 +-0.16 +0.31 +3.48 +0.82 +0.92 +1.39 +-0.16 +0.35 +-0.19 +0.35 +2.61 +0.31 +0.35 +3.94 +0.92 +1.05 +1.57 +-0.19 +0.39 +-0.21 +0.39 +2.96 +0.35 +0.39 +4.46 +1.05 +1.19 +1.78 +-0.21 +0.45 +-0.24 +0.45 +3.35 +0.39 +0.45 +5.06 +1.19 +1.35 +2.02 +-0.24 +0.50 +-0.27 +0.50 +3.80 +0.45 +0.50 +5.73 +1.35 +1.52 +2.29 +-0.27 +0.57 +-0.31 +0.57 +4.31 +0.50 +0.57 +6.50 +1.52 +1.73 +2.60 +-0.31 +0.65 +-0.35 +0.65 +4.88 +0.57 +0.65 +7.36 +1.96 +1.73 +2.94 +-0.39 +-0.35 +0.73 +0.73 +5.53 +0.65 +0.73 +6.26 +0.83 +0.73 +1206.46 +-454.44 +-752.02 +2803.85 +152.74 +-1138.70 +251.20 +-2069.08 +1037.95 +-454.44 +-583.51 +2403.28 +152.74 +-1290.02 +196.12 +-1462.12 +2428.73 +-1138.70 +-1290.02 +1332.76 +-583.51 +-749.25 +3085.88 +196.12 +-1656.42 +251.83 +-1877.40 +3118.55 +-1462.12 +-1656.42 +1711.30 +-749.25 +-962.05 +3962.34 +251.83 +-2126.89 +323.35 +-2410.63 +4004.29 +-1877.40 +-2126.89 +962.05 +-962.05 +2407.63 +323.35 +-2730.98 +5141.61 +-2410.63 +-2730.98 +313.49 +-313.49 +705.57 +104.71 +-810.29 +668.72 +-313.49 +-355.23 +1557.33 +104.71 +-862.52 +118.66 +-918.18 +1672.81 +-810.29 +-862.52 +757.76 +-355.23 +-402.53 +1764.68 +118.66 +-977.37 +134.46 +-1040.43 +1895.54 +-918.18 +-977.37 +858.65 +-402.53 +-456.12 +1999.65 +134.46 +-1107.50 +152.36 +-1178.96 +2147.93 +-1040.43 +-1107.50 +972.98 +-456.12 +-516.86 +2265.90 +152.36 +-1254.96 +172.64 +-1335.94 +2433.92 +-1178.96 +-1254.96 +1102.53 +-516.86 +-585.67 +2567.60 +172.64 +-1422.06 +195.63 +-1513.82 +2758.00 +-1335.94 +-1422.06 +1249.33 +-585.67 +-663.66 +2909.47 +195.63 +-1611.40 +221.68 +-1715.38 +3125.22 +-1513.82 +-1611.40 +1415.67 +-752.02 +-663.66 +3296.86 +251.20 +221.68 +-1825.96 +-1943.78 +3541.34 +-1715.38 +-1825.96 +4012.86 +-2069.08 +-1943.78 +1.11 +0.55 +0.44 +0.26 +0.00 +0.08 +0.04 +0.09 +0.17 +-0.05 +-0.03 +0.01 +0.07 +-0.02 +0.06 +-0.01 +0.03 +0.00 +0.00 +-0.01 +0.00 +0.00 +-0.01 +0.02 +0.02 +0.00 +0.01 +0.00 +0.00 +3.08 +0.55 +0.26 +1.41 +1.06 +0.47 +0.51 +-0.05 +0.01 +-0.11 +-0.02 +0.26 +0.12 +-0.03 +0.06 +-0.09 +0.02 +-0.05 +0.12 +-0.03 +0.06 +2.34 +0.44 +0.26 +0.90 +0.26 +0.13 +0.62 +0.19 +0.00 +0.00 +0.04 +0.09 +0.08 +0.37 +-0.03 +0.01 +-0.07 +0.06 +-0.02 +-0.01 +0.11 +0.03 +-0.02 +0.01 +-0.05 +-0.01 +0.11 +0.05 +-0.01 +0.03 +0.01 +-0.02 +-0.01 +0.03 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.01 +0.01 +0.01 +4.66 +0.26 +1.41 +0.90 +0.19 +0.92 +0.28 +0.47 +1.49 +0.74 +0.01 +-0.11 +-0.07 +-0.02 +0.18 +-0.03 +0.18 +0.05 +0.01 +-0.02 +-0.07 +0.18 +-0.02 +0.05 +0.01 +-0.02 +0.02 +-0.12 +-0.03 +-0.03 +0.18 +0.05 +-0.03 +0.05 +0.53 +0.07 +-0.02 +0.06 +-0.02 +-0.17 +0.03 +0.03 +0.23 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +1.79 +-0.02 +0.26 +-0.02 +0.18 +-0.17 +0.06 +0.05 +0.43 +-0.05 +-0.03 +-0.31 +0.06 +0.05 +0.43 +0.72 +0.06 +0.12 +-0.01 +-0.03 +0.03 +0.06 +-0.16 +0.37 +1.15 +-0.01 +-0.03 +0.11 +0.18 +0.03 +0.05 +-0.16 +0.29 +-0.01 +0.03 +-0.02 +0.05 +-0.12 +0.29 +2.64 +0.03 +0.06 +0.03 +0.05 +0.23 +0.43 +0.37 +0.29 +1.54 +0.00 +0.26 +0.45 +0.13 +0.24 +0.14 +0.54 +0.13 +0.00 +0.06 +0.03 +0.06 +0.23 +0.00 +-0.02 +0.00 +-0.03 +0.01 +0.07 +-0.01 +0.03 +-0.01 +0.02 +-0.02 +0.01 +-0.04 +-0.01 +0.07 +0.04 +-0.01 +0.02 +0.01 +-0.01 +-0.01 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +1.48 +0.13 +0.45 +0.57 +0.13 +0.57 +0.18 +0.22 +0.01 +-0.03 +-0.04 +0.06 +-0.01 +-0.01 +0.07 +0.02 +0.01 +-0.01 +-0.04 +0.07 +-0.01 +0.02 +0.01 +-0.01 +-0.01 +0.02 +2.67 +0.62 +0.19 +0.13 +0.57 +0.78 +0.18 +0.83 +0.24 +0.41 +-0.05 +0.01 +-0.01 +0.01 +-0.04 +-0.01 +0.08 +-0.01 +0.10 +0.02 +-0.06 +-0.01 +0.10 +0.02 +0.01 +-0.01 +-0.07 +0.11 +-0.02 +0.03 +0.01 +-0.02 +-0.02 +0.03 +0.55 +-0.01 +0.07 +0.06 +-0.01 +-0.08 +0.02 +0.02 +0.13 +-0.01 +0.02 +-0.01 +0.02 +-0.08 +0.13 +0.79 +0.11 +-0.02 +0.03 +-0.01 +-0.01 +0.08 +-0.08 +0.03 +0.02 +0.19 +-0.01 +-0.12 +0.02 +0.19 +0.34 +0.00 +0.05 +0.00 +0.03 +-0.01 +-0.01 +0.02 +0.03 +-0.08 +0.18 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.70 +-0.01 +-0.01 +0.07 +0.10 +0.02 +0.02 +-0.08 +0.14 +-0.01 +0.02 +-0.02 +0.03 +-0.11 +0.20 +1.29 +0.03 +0.02 +0.02 +0.02 +0.13 +0.19 +0.18 +0.14 +2.55 +0.19 +0.92 +0.78 +0.24 +0.99 +0.28 +0.39 +0.01 +-0.07 +-0.02 +-0.06 +-0.01 +0.11 +0.14 +0.03 +0.01 +-0.02 +-0.08 +0.13 +-0.02 +0.04 +0.01 +-0.02 +-0.02 +0.03 +1.17 +-0.02 +0.18 +0.05 +-0.01 +-0.12 +0.11 +0.03 +0.29 +-0.02 +0.03 +-0.03 +0.05 +-0.18 +0.29 +0.95 +-0.01 +-0.02 +-0.12 +0.10 +0.02 +0.14 +0.03 +0.19 +-0.02 +0.03 +-0.02 +0.04 +-0.15 +0.26 +1.92 +0.03 +0.05 +0.29 +0.02 +0.19 +0.03 +0.29 +0.19 +0.59 +0.00 +0.24 +0.28 +0.14 +0.06 +0.06 +0.03 +0.09 +0.00 +-0.02 +0.00 +-0.02 +0.01 +0.03 +-0.01 +0.04 +-0.01 +0.02 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +1.60 +0.14 +0.28 +0.77 +0.55 +0.26 +0.26 +0.01 +-0.02 +-0.06 +0.06 +-0.01 +-0.01 +0.13 +0.03 +-0.05 +0.01 +0.06 +-0.01 +-0.02 +0.03 +2.81 +0.54 +0.13 +0.14 +0.77 +0.62 +0.26 +0.90 +0.19 +0.45 +-0.04 +0.01 +-0.01 +0.01 +-0.06 +-0.01 +0.11 +-0.01 +0.11 +0.03 +-0.05 +-0.01 +0.11 +0.03 +0.01 +-0.07 +-0.01 +0.11 +-0.02 +0.03 +0.01 +-0.01 +-0.02 +0.03 +0.36 +-0.01 +0.03 +0.06 +-0.01 +-0.09 +0.02 +0.03 +0.18 +0.70 +0.07 +-0.01 +0.02 +-0.01 +-0.01 +0.11 +-0.09 +0.02 +0.03 +0.18 +-0.01 +-0.08 +0.03 +0.18 +0.29 +0.00 +0.04 +0.00 +0.04 +-0.01 +-0.01 +0.02 +0.02 +-0.09 +0.13 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.98 +-0.01 +-0.01 +0.13 +0.11 +0.03 +0.03 +-0.09 +0.24 +-0.02 +-0.02 +0.03 +0.03 +-0.17 +0.23 +1.44 +0.02 +0.02 +0.03 +0.03 +0.18 +0.18 +0.13 +0.24 +2.67 +0.13 +0.57 +0.18 +0.62 +0.19 +0.78 +0.83 +0.24 +0.41 +0.01 +-0.04 +0.01 +-0.01 +-0.01 +-0.05 +-0.01 +0.10 +0.08 +0.02 +0.01 +-0.01 +-0.06 +0.10 +-0.01 +0.02 +-0.07 +-0.02 +0.11 +0.03 +0.01 +-0.02 +-0.02 +0.03 +0.70 +-0.01 +0.07 +-0.01 +0.02 +0.02 +-0.01 +-0.08 +0.10 +0.02 +0.14 +-0.02 +-0.11 +0.03 +0.20 +0.79 +-0.01 +-0.01 +-0.08 +0.11 +0.03 +0.08 +0.02 +0.19 +-0.02 +0.03 +-0.01 +0.02 +-0.12 +0.19 +1.29 +0.02 +0.02 +0.13 +0.03 +0.18 +0.02 +0.14 +0.19 +3.08 +0.55 +0.26 +1.41 +1.06 +0.47 +0.51 +-0.05 +0.01 +-0.02 +-0.11 +0.12 +-0.03 +0.26 +0.06 +-0.09 +0.02 +0.12 +-0.03 +-0.05 +0.06 +4.66 +0.26 +0.90 +0.19 +1.41 +0.92 +0.28 +0.47 +1.49 +0.74 +0.01 +-0.07 +-0.02 +0.01 +-0.02 +-0.11 +-0.03 +0.18 +0.18 +0.05 +-0.07 +-0.02 +0.18 +0.05 +0.01 +-0.02 +0.02 +-0.12 +-0.03 +0.18 +-0.03 +0.05 +-0.03 +0.05 +0.72 +0.06 +-0.01 +0.03 +0.12 +-0.03 +-0.16 +0.06 +0.37 +1.15 +-0.01 +0.11 +0.03 +-0.01 +0.03 +-0.03 +0.18 +-0.16 +0.05 +0.29 +-0.02 +-0.12 +0.05 +0.29 +1.79 +-0.02 +-0.02 +-0.17 +0.26 +0.18 +0.06 +0.05 +0.43 +-0.05 +-0.03 +0.06 +0.05 +-0.31 +0.43 +2.64 +0.03 +0.03 +0.23 +0.06 +0.05 +0.37 +0.29 +0.43 +2.55 +0.19 +0.78 +0.92 +0.24 +0.99 +0.28 +0.39 +0.01 +-0.06 +-0.01 +-0.07 +-0.02 +0.14 +0.11 +0.03 +0.01 +-0.02 +-0.08 +-0.02 +0.13 +0.04 +0.01 +-0.02 +-0.02 +0.03 +0.95 +-0.01 +0.10 +0.02 +-0.02 +-0.12 +0.14 +0.03 +0.19 +-0.02 +0.03 +-0.02 +-0.15 +0.04 +0.26 +1.17 +-0.02 +-0.01 +-0.12 +0.18 +0.05 +0.11 +0.03 +0.29 +-0.02 +0.03 +-0.03 +0.05 +-0.18 +0.29 +1.92 +0.03 +0.02 +0.19 +0.05 +0.29 +0.03 +0.19 +0.29 +3.85 +0.18 +0.83 +0.24 +0.83 +0.24 +1.11 +1.11 +0.32 +0.61 +0.01 +-0.07 +-0.02 +0.01 +-0.02 +-0.07 +-0.02 +0.01 +-0.02 +0.15 +0.15 +0.04 +-0.09 +-0.02 +0.15 +0.04 +-0.09 +0.15 +-0.02 +0.04 +0.01 +-0.02 +-0.02 +0.04 +1.06 +-0.01 +0.11 +0.03 +-0.02 +0.03 +-0.02 +-0.11 +0.15 +0.04 +0.26 +-0.02 +-0.15 +0.04 +0.26 +1.06 +-0.01 +-0.02 +-0.11 +0.11 +0.03 +-0.02 +0.03 +0.15 +0.04 +0.26 +-0.02 +0.04 +-0.15 +0.26 +1.83 +0.02 +0.03 +0.20 +0.03 +0.20 +0.04 +0.26 +0.26 +4.65 +0.28 +0.24 +0.99 +1.11 +0.32 +1.36 +1.38 +0.42 +0.72 +0.01 +0.01 +-0.08 +-0.02 +-0.02 +-0.09 +-0.02 +0.18 +0.20 +0.05 +0.01 +-0.02 +-0.11 +0.18 +-0.03 +0.05 +-0.11 +-0.03 +0.02 +-0.03 +0.14 +0.04 +-0.02 +0.04 +1.23 +-0.02 +-0.02 +0.13 +0.03 +0.04 +-0.02 +-0.15 +0.18 +0.05 +0.35 +-0.03 +-0.18 +0.04 +0.25 +1.42 +-0.02 +-0.02 +-0.15 +0.15 +0.04 +0.20 +0.05 +0.35 +-0.02 +0.04 +-0.03 +0.05 +-0.21 +0.35 +2.45 +0.03 +0.04 +0.26 +0.04 +0.26 +0.05 +0.35 +0.35 +4.65 +0.24 +0.28 +0.99 +1.11 +0.32 +1.36 +0.42 +1.38 +0.72 +0.01 +0.01 +-0.08 +-0.02 +-0.02 +-0.09 +-0.02 +0.01 +-0.02 +0.20 +0.18 +0.05 +-0.11 +-0.03 +0.18 +0.05 +0.02 +-0.02 +-0.11 +-0.03 +0.14 +0.04 +-0.03 +0.04 +1.42 +-0.02 +-0.02 +-0.15 +0.15 +0.04 +-0.02 +0.04 +0.20 +0.05 +0.35 +-0.03 +-0.21 +0.05 +0.35 +1.23 +-0.02 +-0.02 +0.13 +0.04 +0.03 +-0.02 +-0.15 +0.18 +0.05 +0.35 +-0.03 +-0.18 +0.04 +0.25 +2.45 +0.03 +0.04 +0.26 +0.04 +0.26 +0.05 +0.35 +0.35 +4.42 +0.32 +1.36 +1.36 +0.42 +1.85 +0.42 +0.69 +0.01 +-0.11 +-0.03 +-0.11 +-0.03 +0.24 +0.24 +0.07 +0.02 +-0.16 +-0.04 +-0.02 +0.18 +0.05 +0.02 +-0.02 +-0.04 +0.05 +1.68 +-0.02 +0.18 +0.05 +-0.03 +-0.21 +0.24 +0.07 +0.47 +-0.03 +-0.04 +-0.27 +0.04 +0.05 +0.32 +1.68 +-0.02 +-0.03 +-0.21 +0.18 +0.05 +0.24 +0.07 +0.47 +-0.04 +0.05 +-0.03 +0.04 +-0.27 +0.32 +3.28 +0.04 +0.05 +0.35 +0.05 +0.35 +0.07 +0.47 +0.47 +5.96 +1.06 +0.47 +2.60 +2.05 +0.87 +1.00 +-0.09 +0.02 +-0.05 +-0.21 +0.53 +0.24 +-0.05 +0.13 +-0.18 +0.04 +-0.09 +0.24 +-0.05 +0.12 +7.77 +0.47 +1.49 +0.28 +1.38 +0.42 +2.60 +0.87 +2.50 +1.22 +0.02 +-0.12 +-0.03 +0.01 +-0.03 +-0.11 +-0.03 +0.02 +-0.03 +-0.21 +0.30 +-0.05 +0.30 +0.07 +0.04 +-0.20 +-0.05 +-0.05 +0.30 +0.07 +0.30 +0.07 +-0.05 +0.07 +3.28 +-0.05 +-0.03 +-0.31 +0.53 +0.30 +0.13 +0.07 +0.80 +-0.09 +-0.05 +-0.56 +0.12 +0.07 +0.79 +1.42 +0.12 +-0.03 +0.06 +0.24 +-0.05 +0.13 +-0.30 +0.74 +1.90 +-0.03 +0.18 +0.05 +-0.02 +0.05 +-0.03 +-0.18 +-0.05 +0.30 +0.07 +-0.30 +0.47 +0.07 +0.47 +4.85 +0.06 +0.05 +0.43 +0.13 +0.07 +0.80 +0.74 +0.47 +9.63 +2.05 +0.87 +4.06 +2.05 +0.87 +1.81 +-0.18 +0.04 +-0.09 +-0.35 +0.96 +0.48 +-0.09 +0.25 +-0.18 +0.04 +-0.09 +0.48 +-0.09 +0.25 +11.34 +0.42 +0.42 +1.85 +0.87 +2.50 +4.06 +0.87 +2.50 +1.90 +0.02 +0.02 +-0.16 +-0.04 +-0.04 +0.04 +-0.20 +-0.05 +-0.35 +0.45 +-0.09 +0.50 +0.12 +-0.05 +0.46 +0.12 +0.04 +-0.20 +-0.05 +-0.05 +-0.09 +0.50 +0.12 +0.12 +5.57 +-0.09 +-0.05 +-0.56 +0.96 +0.45 +0.25 +0.12 +1.47 +-0.09 +-0.05 +-0.56 +0.25 +0.12 +1.47 +2.82 +0.24 +-0.05 +0.12 +0.48 +-0.09 +0.25 +-0.56 +1.49 +3.15 +-0.03 +-0.04 +-0.27 +-0.05 +0.30 +0.07 +-0.09 +0.50 +0.12 +-0.56 +0.76 +0.07 +0.12 +0.77 +8.90 +0.12 +0.07 +0.79 +0.25 +0.12 +1.47 +1.49 +0.76 +1.75 +-0.03 +-0.02 +-0.18 +0.14 +0.04 +-0.02 +0.04 +0.30 +0.07 +-0.05 +0.07 +0.43 +-0.27 +0.43 +2.86 +0.05 +0.03 +0.29 +0.04 +0.25 +0.07 +0.47 +0.43 +2.48 +-0.02 +-0.02 +0.18 +0.05 +0.05 +-0.05 +0.46 +0.12 +-0.27 +0.65 +-0.05 +-0.27 +0.12 +0.65 +4.28 +0.04 +0.05 +0.32 +0.07 +0.12 +0.77 +0.43 +0.65 +5.96 +1.06 +0.47 +2.05 +0.87 +2.60 +1.00 +-0.09 +0.02 +-0.05 +-0.18 +0.04 +-0.09 +-0.21 +0.24 +-0.05 +0.53 +0.13 +0.24 +-0.05 +0.12 +7.77 +0.47 +1.49 +0.28 +1.38 +0.42 +0.87 +2.50 +2.60 +1.22 +0.02 +-0.12 +-0.03 +0.01 +-0.03 +-0.11 +-0.03 +0.02 +-0.03 +0.04 +-0.20 +-0.05 +-0.05 +-0.21 +-0.05 +0.30 +0.30 +0.07 +0.30 +0.07 +-0.05 +0.30 +0.07 +0.07 +1.42 +0.12 +-0.03 +0.06 +0.24 +-0.05 +-0.30 +0.13 +0.74 +1.90 +-0.03 +0.18 +0.05 +-0.02 +0.05 +-0.03 +-0.18 +-0.05 +0.30 +-0.30 +0.07 +0.47 +0.07 +0.47 +3.28 +-0.05 +-0.03 +-0.31 +-0.09 +-0.05 +-0.56 +0.53 +0.30 +0.13 +0.07 +0.80 +0.12 +0.07 +0.79 +4.85 +0.06 +0.05 +0.43 +0.13 +0.07 +0.74 +0.47 +0.80 +1.75 +-0.03 +-0.02 +-0.18 +0.14 +0.04 +-0.02 +0.04 +-0.05 +-0.27 +0.30 +0.07 +0.43 +0.07 +0.43 +2.86 +0.05 +0.03 +0.29 +0.04 +0.25 +0.07 +0.47 +0.43 +2.82 +0.48 +-0.09 +0.25 +0.24 +-0.05 +0.12 +-0.56 +1.49 +3.15 +-0.03 +-0.04 +-0.27 +-0.09 +0.50 +0.12 +0.12 +-0.05 +0.30 +0.07 +0.07 +-0.56 +0.76 +0.77 +8.90 +0.25 +0.12 +1.47 +0.12 +0.07 +0.79 +1.49 +0.76 +4.28 +0.04 +0.05 +0.32 +0.12 +0.65 +0.07 +0.43 +0.77 +0.28 +0.08 +0.00 +0.00 +0.06 +0.03 +0.14 +0.04 +0.05 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.02 +0.01 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.01 +0.22 +0.06 +0.06 +0.03 +0.12 +0.03 +0.03 +0.00 +0.00 +0.00 +-0.01 +0.01 +0.00 +0.00 +0.02 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.56 +0.04 +0.04 +0.03 +0.03 +0.14 +0.12 +0.16 +0.14 +0.09 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +-0.01 +0.00 +0.02 +0.00 +0.02 +0.01 +-0.01 +0.00 +0.00 +0.02 +0.01 +-0.01 +0.00 +0.02 +0.00 +0.01 +0.00 +0.00 +0.01 +0.07 +0.01 +0.00 +0.01 +0.00 +-0.02 +0.00 +0.00 +0.03 +0.18 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.02 +-0.02 +0.01 +0.01 +0.04 +0.00 +-0.03 +0.01 +0.01 +0.04 +0.08 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.01 +-0.02 +0.04 +0.15 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.02 +0.00 +0.01 +-0.02 +0.04 +0.00 +0.00 +0.01 +-0.02 +0.04 +0.31 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.03 +0.04 +0.04 +0.04 +0.35 +0.09 +0.09 +0.04 +0.16 +0.04 +0.06 +-0.01 +-0.01 +0.00 +-0.01 +0.00 +0.01 +0.00 +0.03 +0.01 +0.00 +0.00 +0.01 +0.00 +0.01 +0.12 +0.02 +0.00 +0.00 +-0.03 +0.01 +0.01 +0.01 +0.06 +0.11 +0.02 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.01 +-0.03 +0.05 +0.21 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.01 +0.03 +0.01 +-0.03 +0.05 +0.00 +0.01 +0.01 +-0.03 +0.05 +0.43 +0.01 +0.00 +0.00 +0.01 +0.01 +0.04 +0.01 +0.06 +0.05 +0.05 +0.28 +0.08 +0.06 +0.03 +0.14 +0.04 +0.04 +-0.01 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.02 +0.01 +0.01 +0.00 +0.01 +0.01 +0.07 +0.01 +0.01 +0.00 +0.00 +0.00 +-0.02 +0.00 +0.03 +0.18 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.01 +0.00 +0.01 +0.02 +-0.02 +0.01 +0.04 +-0.03 +0.01 +0.04 +0.08 +0.01 +0.00 +0.00 +-0.02 +0.01 +0.00 +0.01 +0.04 +0.31 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.04 +0.01 +0.03 +0.04 +0.04 +0.11 +0.01 +0.00 +0.01 +0.01 +0.00 +-0.03 +0.01 +0.06 +0.10 +0.01 +0.00 +0.00 +-0.03 +0.01 +0.01 +0.01 +0.05 +0.41 +0.00 +0.01 +0.00 +0.00 +0.00 +0.01 +0.01 +0.05 +0.01 +0.04 +0.06 +0.05 +143.84 +33.57 +-55.82 +-62.79 +0.00 +20.11 +-31.00 +-47.92 +121.88 +-18.07 +5.64 +-5.45 +-60.58 +31.44 +17.93 +9.68 +-46.80 +0.00 +0.00 +-10.65 +-2.29 +14.99 +5.76 +-54.60 +21.51 +6.28 +-36.67 +0.00 +0.00 +159.81 +33.57 +-21.49 +-181.70 +55.54 +-45.73 +145.49 +-18.07 +-0.48 +17.02 +11.72 +-211.69 +37.97 +-3.92 +-3.49 +-34.44 +-2.14 +28.59 +27.74 +-6.89 +12.59 +249.44 +-55.82 +-21.49 +31.82 +10.55 +-36.72 +-68.80 +-58.15 +0.00 +0.00 +-19.64 +-44.25 +13.05 +219.84 +5.64 +-0.48 +-24.24 +-53.64 +9.48 +1.88 +19.65 +-16.32 +-7.92 +-3.02 +4.82 +15.42 +-89.83 +13.62 +9.29 +-40.09 +-5.19 +26.97 +11.40 +-46.81 +0.00 +0.00 +0.00 +-1.08 +0.00 +0.00 +4.92 +0.00 +3.81 +0.00 +-8.77 +9.61 +0.00 +-47.84 +13.81 +-24.90 +404.65 +-62.79 +-181.70 +31.82 +-14.14 +-104.55 +-24.64 +-107.53 +58.88 +388.58 +-5.45 +17.02 +-24.24 +29.55 +-169.35 +25.76 +29.11 +-117.33 +-0.03 +6.53 +3.13 +-133.79 +-3.86 +12.50 +-0.74 +-5.37 +-8.49 +-42.03 +46.13 +30.92 +19.26 +-134.08 +13.92 +22.35 +152.09 +-60.58 +11.72 +-53.64 +29.55 +-30.27 +-16.53 +-48.45 +16.11 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +561.30 +31.44 +-211.69 +9.48 +-169.35 +-30.27 +-121.10 +2.55 +28.47 +54.29 +21.07 +-59.70 +-140.33 +15.45 +8.39 +337.77 +17.93 +37.97 +1.88 +25.76 +-16.53 +-121.10 +31.15 +-314.83 +538.16 +9.68 +-3.92 +19.65 +29.11 +-48.45 +2.55 +31.15 +-271.44 +2.60 +-12.70 +27.00 +-109.73 +15.88 +-229.55 +725.63 +-46.80 +-3.49 +-16.32 +-117.33 +16.11 +28.47 +-314.83 +-271.44 +161.49 +0.00 +10.55 +-52.41 +-10.66 +-31.50 +-31.89 +20.43 +-10.66 +0.00 +-28.28 +-34.75 +7.68 +149.62 +0.00 +-7.92 +0.00 +1.31 +-0.25 +-58.90 +5.41 +2.98 +-2.49 +10.17 +2.75 +-2.50 +-15.30 +9.31 +6.78 +-29.87 +15.24 +-44.82 +-0.25 +-2.49 +5.41 +10.17 +0.00 +2.28 +-2.93 +0.00 +0.00 +10.96 +0.00 +0.00 +-6.50 +-28.35 +16.12 +3.68 +-49.61 +0.00 +177.37 +-36.72 +-52.41 +-13.25 +-36.72 +-13.25 +-25.01 +177.46 +-3.02 +1.31 +-6.37 +-42.57 +16.21 +14.04 +-23.25 +-61.91 +-3.02 +14.04 +-6.37 +-23.25 +16.21 +-61.91 +-1.69 +7.66 +7.66 +-21.24 +214.06 +-68.80 +-14.14 +-10.66 +-13.25 +-19.91 +-25.01 +-28.77 +-33.52 +192.81 +4.82 +-0.03 +2.60 +-0.25 +-6.37 +4.18 +-66.22 +2.85 +-15.57 +-16.09 +-7.92 +4.31 +-23.73 +-13.76 +-1.69 +7.66 +-5.74 +-34.26 +9.13 +-26.54 +-2.27 +10.27 +10.27 +-28.46 +225.91 +15.42 +-58.90 +-42.57 +4.18 +-10.95 +-49.65 +10.09 +-31.31 +15.42 +-49.65 +4.18 +10.09 +-10.95 +-31.31 +279.47 +-89.83 +6.53 +-12.70 +5.41 +16.21 +-66.22 +-10.95 +-16.23 +-43.63 +-6.83 +25.12 +-14.26 +-50.00 +-22.09 +169.21 +0.00 +13.62 +0.00 +2.98 +14.04 +2.85 +-49.65 +-16.23 +10.57 +-147.39 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +280.88 +9.29 +-2.49 +-23.25 +-15.57 +10.09 +-43.63 +10.57 +-118.72 +7.66 +-21.24 +9.13 +-26.54 +0.07 +-76.26 +412.17 +-40.09 +10.17 +-61.91 +-16.09 +-31.31 +-6.83 +-147.39 +-118.72 +317.96 +-58.15 +-104.55 +-19.91 +-33.52 +-19.85 +-81.97 +318.39 +-5.19 +3.13 +27.00 +-7.92 +25.12 +-83.51 +-33.28 +-110.51 +-2.27 +10.27 +-11.77 +-40.60 +12.24 +-35.57 +-6.79 +30.80 +32.42 +-121.97 +491.91 +26.97 +-133.79 +-109.73 +4.31 +-14.26 +-83.51 +14.14 +-48.10 +8.52 +21.12 +38.39 +-123.90 +-25.12 +-66.96 +381.62 +11.40 +-3.86 +15.88 +-23.73 +-50.00 +-33.28 +14.14 +-168.54 +10.27 +-28.46 +12.24 +-35.57 +0.10 +-102.20 +626.87 +-46.81 +12.50 +-229.55 +-13.76 +-22.09 +-110.51 +-48.10 +-168.54 +51.70 +0.00 +-31.50 +16.82 +-13.33 +12.58 +-28.66 +-7.61 +40.97 +0.00 +2.75 +0.00 +-9.12 +-0.58 +7.52 +-2.11 +-31.22 +7.55 +3.86 +-7.30 +2.74 +0.00 +-29.29 +4.28 +7.94 +-2.34 +4.35 +0.00 +0.00 +142.49 +-31.89 +16.82 +-98.19 +33.57 +-62.79 +120.91 +-2.50 +-9.12 +10.66 +21.33 +7.46 +14.50 +-112.34 +-39.62 +-18.07 +-5.45 +17.93 +9.68 +31.44 +-46.80 +244.42 +20.43 +-36.72 +-13.33 +-98.19 +-68.80 +-21.49 +31.82 +-58.15 +217.27 +-15.30 +-3.02 +15.42 +-0.58 +10.66 +2.62 +26.80 +6.91 +-100.73 +-20.57 +4.82 +9.29 +-89.83 +-40.09 +-0.48 +-24.24 +1.88 +19.65 +9.48 +-16.32 +-5.19 +11.40 +26.97 +-46.81 +165.33 +9.31 +7.52 +21.33 +2.62 +17.12 +-37.48 +-21.68 +-164.07 +322.37 +6.78 +14.04 +-49.65 +-2.11 +7.46 +26.80 +17.12 +4.90 +-41.25 +-156.27 +2.85 +10.57 +-16.23 +-147.39 +87.70 +0.00 +-29.87 +0.00 +-31.22 +14.50 +6.91 +-37.48 +4.90 +-17.61 +2.17 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +279.41 +15.24 +7.55 +-112.34 +-100.73 +-21.68 +-41.25 +-17.61 +29.27 +11.72 +29.55 +-16.53 +-48.45 +-30.27 +16.11 +390.04 +-44.82 +3.86 +-39.62 +-20.57 +-164.07 +-156.27 +2.17 +29.27 +214.06 +-10.66 +-13.25 +-25.01 +-68.80 +-14.14 +-19.91 +-28.77 +-33.52 +192.81 +-0.25 +-6.37 +-1.69 +4.18 +7.66 +4.82 +2.85 +-15.57 +-66.22 +-16.09 +-0.03 +2.60 +-7.92 +-23.73 +4.31 +-13.76 +-5.74 +9.13 +-34.26 +-26.54 +-2.27 +10.27 +10.27 +-28.46 +280.88 +-2.49 +-23.25 +7.66 +10.09 +-21.24 +9.29 +10.57 +-15.57 +-43.63 +-118.72 +9.13 +0.07 +-26.54 +-76.26 +279.47 +5.41 +16.21 +-10.95 +-89.83 +-16.23 +-66.22 +-43.63 +-6.83 +6.53 +-12.70 +25.12 +-50.00 +-14.26 +-22.09 +412.17 +10.17 +-61.91 +-31.31 +-40.09 +-147.39 +-16.09 +-118.72 +-6.83 +159.81 +33.57 +-21.49 +-181.70 +55.54 +-45.73 +145.49 +-18.07 +-0.48 +11.72 +17.02 +37.97 +-3.92 +-211.69 +-3.49 +-34.44 +-2.14 +27.74 +-6.89 +28.59 +12.59 +404.65 +-62.79 +31.82 +-14.14 +-181.70 +-104.55 +-24.64 +-107.53 +58.88 +388.58 +-5.45 +-24.24 +29.55 +-0.03 +6.53 +17.02 +25.76 +29.11 +-169.35 +-117.33 +3.13 +-3.86 +-133.79 +12.50 +-0.74 +-5.37 +-8.49 +-42.03 +30.92 +19.26 +46.13 +-134.08 +13.92 +22.35 +337.77 +17.93 +1.88 +-16.53 +37.97 +25.76 +31.15 +-121.10 +-314.83 +538.16 +9.68 +19.65 +-48.45 +2.60 +-12.70 +-3.92 +29.11 +31.15 +2.55 +-271.44 +27.00 +15.88 +-109.73 +-229.55 +561.30 +31.44 +9.48 +-30.27 +-211.69 +-169.35 +-121.10 +2.55 +28.47 +54.29 +21.07 +-140.33 +15.45 +-59.70 +8.39 +725.63 +-46.80 +-16.32 +16.11 +-3.49 +-117.33 +-314.83 +-271.44 +28.47 +317.96 +-58.15 +-19.91 +-104.55 +-33.52 +-19.85 +-81.97 +318.39 +-5.19 +-7.92 +25.12 +3.13 +27.00 +-33.28 +-83.51 +-110.51 +-2.27 +10.27 +-11.77 +12.24 +-40.60 +-35.57 +-6.79 +30.80 +32.42 +-121.97 +381.62 +11.40 +-23.73 +-50.00 +-3.86 +15.88 +-33.28 +14.14 +-168.54 +10.27 +-28.46 +12.24 +0.10 +-35.57 +-102.20 +491.91 +26.97 +4.31 +-14.26 +-133.79 +-109.73 +-83.51 +14.14 +-48.10 +8.52 +21.12 +38.39 +-123.90 +-25.12 +-66.96 +626.87 +-46.81 +-13.76 +-22.09 +12.50 +-229.55 +-110.51 +-168.54 +-48.10 +271.66 +-25.01 +-28.77 +-33.52 +-28.77 +-33.52 +-38.56 +-38.56 +-44.93 +250.19 +-1.69 +-5.74 +9.13 +-2.27 +10.27 +-5.74 +9.13 +-2.27 +10.27 +-35.38 +-35.38 +-32.98 +-7.70 +12.24 +-45.92 +-35.57 +-7.70 +-45.92 +12.24 +-35.57 +-3.04 +13.76 +13.76 +-38.15 +339.94 +7.66 +-34.26 +-26.54 +10.27 +-28.46 +9.13 +0.07 +-35.38 +-32.98 +-84.02 +12.24 +0.10 +-35.57 +-102.20 +339.94 +7.66 +9.13 +0.07 +-34.26 +-26.54 +10.27 +-28.46 +-35.38 +-32.98 +-84.02 +12.24 +-35.57 +0.10 +-102.20 +427.84 +-21.24 +-26.54 +-76.26 +-26.54 +-76.26 +-32.98 +-84.02 +-84.02 +384.54 +-24.64 +-33.52 +-19.85 +-38.56 +-44.93 +-30.27 +-159.41 +-33.36 +345.03 +-0.74 +-2.27 +-11.77 +8.52 +12.24 +-7.70 +12.24 +-25.76 +-47.42 +-44.20 +-3.04 +13.76 +-14.70 +-40.30 +16.40 +-47.67 +13.18 +6.68 +-0.39 +6.04 +-138.75 +-31.74 +8.93 +-26.60 +504.60 +-5.37 +10.27 +-40.60 +21.12 +-35.57 +12.24 +0.10 +-25.76 +-44.20 +-112.61 +20.84 +26.74 +-86.54 +-245.24 +455.62 +10.27 +12.24 +0.10 +-45.92 +-35.57 +-47.42 +-44.20 +-112.61 +13.76 +-38.15 +16.40 +-47.67 +0.13 +-136.99 +573.43 +-28.46 +-35.57 +-102.20 +-35.57 +-102.20 +-44.20 +-112.61 +-112.61 +384.54 +-33.52 +-24.64 +-19.85 +-38.56 +-44.93 +-30.27 +-33.36 +-159.41 +345.03 +-2.27 +-0.74 +-11.77 +12.24 +8.52 +-7.70 +12.24 +-3.04 +13.76 +-47.42 +-25.76 +-44.20 +-14.70 +16.40 +-40.30 +-47.67 +-0.39 +8.93 +13.18 +6.68 +-138.75 +-31.74 +6.04 +-26.60 +455.62 +10.27 +12.24 +0.10 +-45.92 +-35.57 +13.76 +-38.15 +-47.42 +-44.20 +-112.61 +16.40 +0.13 +-47.67 +-136.99 +504.60 +10.27 +-5.37 +-40.60 +-35.57 +21.12 +12.24 +0.10 +-25.76 +-44.20 +-112.61 +20.84 +26.74 +-86.54 +-245.24 +573.43 +-28.46 +-35.57 +-102.20 +-35.57 +-102.20 +-44.20 +-112.61 +-112.61 +577.36 +-44.93 +-30.27 +-30.27 +-131.09 +-209.71 +-131.09 +573.90 +-3.04 +-14.70 +16.40 +-14.70 +16.40 +-57.71 +-57.71 +-59.24 +-11.90 +8.79 +60.89 +50.51 +-168.44 +-219.48 +-11.90 +50.51 +60.89 +-219.48 +688.14 +13.76 +-40.30 +-47.67 +16.40 +0.13 +-57.71 +-59.24 +-150.93 +25.59 +-8.02 +42.00 +-98.90 +29.54 +-352.79 +688.14 +13.76 +16.40 +0.13 +-40.30 +-47.67 +-57.71 +-59.24 +-150.93 +-8.02 +29.54 +25.59 +-98.90 +42.00 +-352.79 +768.57 +-38.15 +-47.67 +-136.99 +-47.67 +-136.99 +-59.24 +-150.93 +-150.93 +490.99 +55.54 +-107.53 +-337.41 +112.43 +-214.01 +459.39 +-34.44 +-8.49 +54.29 +38.56 +-419.92 +80.28 +25.43 +-149.43 +-68.47 +-18.93 +118.44 +67.02 +32.95 +-176.68 +678.18 +-45.73 +58.88 +-81.97 +-159.41 +-131.09 +-337.41 +-75.21 +93.77 +594.95 +-2.14 +-42.03 +21.07 +-6.79 +38.39 +13.18 +20.84 +-11.90 +25.59 +38.56 +-311.07 +9.34 +74.38 +-62.22 +-2.12 +-66.97 +29.33 +6.72 +54.89 +-48.75 +-221.72 +-100.99 +67.46 +-117.99 +944.45 +28.59 +46.13 +-59.70 +-419.92 +-311.07 +-83.00 +-124.50 +100.92 +45.11 +90.00 +-103.78 +-64.28 +-145.74 +56.79 +626.45 +27.74 +30.92 +-140.33 +80.28 +9.34 +-83.00 +60.34 +-611.73 +881.27 +-6.89 +19.26 +15.45 +30.80 +-123.90 +6.68 +26.74 +25.43 +74.38 +-124.50 +60.34 +-478.90 +-42.58 +-363.58 +1314.45 +12.59 +-134.08 +8.39 +-149.43 +-62.22 +100.92 +-611.73 +-478.90 +445.32 +112.43 +-75.21 +-519.75 +112.43 +-75.21 +493.69 +-68.47 +-2.12 +45.11 +56.24 +-721.39 +142.90 +-11.87 +-19.82 +-68.47 +-2.12 +45.11 +142.90 +-11.87 +-19.82 +1036.66 +-33.36 +-33.36 +-209.71 +-214.01 +93.77 +-519.75 +-214.01 +93.77 +1021.23 +-0.39 +-0.39 +8.79 +-8.02 +-8.02 +-18.93 +-66.97 +90.00 +56.24 +-487.74 +88.44 +82.54 +-354.78 +17.25 +-306.82 +25.00 +-18.93 +-66.97 +90.00 +17.25 +88.44 +82.54 +-354.78 +25.00 +1813.39 +118.44 +29.33 +-103.78 +-721.39 +-487.74 +-457.10 +7.61 +103.38 +118.44 +29.33 +-103.78 +-457.10 +7.61 +103.38 +1285.25 +67.02 +6.72 +-64.28 +142.90 +88.44 +-457.10 +114.05 +-1183.00 +1477.95 +6.04 +60.89 +42.00 +32.95 +54.89 +-145.74 +-11.87 +82.54 +7.61 +114.05 +-841.02 +-34.27 +-275.32 +-570.69 +2463.88 +-176.68 +-48.75 +56.79 +-19.82 +-354.78 +103.38 +-1183.00 +-841.02 +624.77 +13.92 +32.42 +-25.12 +-138.75 +-86.54 +50.51 +-98.90 +-221.72 +-42.58 +17.25 +-34.27 +-11.97 +-33.31 +-45.73 +920.09 +22.35 +-121.97 +-66.96 +-31.74 +-245.24 +-100.99 +-363.58 +-11.97 +1081.64 +8.93 +8.93 +-168.44 +29.54 +29.54 +67.46 +-306.82 +-275.32 +-33.31 +-100.50 +67.46 +-33.31 +-275.32 +-100.50 +1408.75 +-26.60 +-219.48 +-352.79 +-117.99 +25.00 +-570.69 +-45.73 +-100.50 +490.99 +55.54 +-107.53 +112.43 +-214.01 +-337.41 +459.39 +-34.44 +-8.49 +54.29 +-68.47 +-18.93 +118.44 +38.56 +80.28 +25.43 +-419.92 +-149.43 +67.02 +32.95 +-176.68 +678.18 +-45.73 +58.88 +-81.97 +-159.41 +-131.09 +-75.21 +93.77 +-337.41 +594.95 +-2.14 +-42.03 +21.07 +-6.79 +38.39 +13.18 +20.84 +-11.90 +25.59 +-2.12 +-66.97 +29.33 +67.46 +38.56 +9.34 +74.38 +-311.07 +-62.22 +-221.72 +-100.99 +6.72 +54.89 +-48.75 +-117.99 +626.45 +27.74 +30.92 +-140.33 +80.28 +9.34 +60.34 +-83.00 +-611.73 +881.27 +-6.89 +19.26 +15.45 +30.80 +-123.90 +6.68 +26.74 +25.43 +74.38 +60.34 +-124.50 +-478.90 +-42.58 +-363.58 +944.45 +28.59 +46.13 +-59.70 +45.11 +90.00 +-103.78 +-419.92 +-311.07 +-83.00 +-124.50 +100.92 +-64.28 +-145.74 +56.79 +1314.45 +12.59 +-134.08 +8.39 +-149.43 +-62.22 +-611.73 +-478.90 +100.92 +624.77 +13.92 +32.42 +-25.12 +-138.75 +-86.54 +50.51 +-98.90 +17.25 +-33.31 +-221.72 +-42.58 +-11.97 +-34.27 +-45.73 +920.09 +22.35 +-121.97 +-66.96 +-31.74 +-245.24 +-100.99 +-363.58 +-11.97 +1285.25 +142.90 +88.44 +-457.10 +67.02 +6.72 +-64.28 +114.05 +-1183.00 +1477.95 +6.04 +60.89 +42.00 +-11.87 +82.54 +7.61 +-275.32 +32.95 +54.89 +-145.74 +-34.27 +114.05 +-841.02 +-570.69 +2463.88 +-19.82 +-354.78 +103.38 +-176.68 +-48.75 +56.79 +-1183.00 +-841.02 +1408.75 +-26.60 +-219.48 +-352.79 +25.00 +-100.50 +-117.99 +-45.73 +-570.69 +92.94 +20.11 +0.00 +0.00 +12.58 +-31.14 +-73.96 +-20.53 +83.62 +-10.65 +0.00 +0.00 +0.00 +-7.30 +0.00 +-2.59 +8.15 +14.15 +-80.30 +13.83 +8.72 +-41.38 +-1.17 +10.70 +13.85 +0.59 +-10.22 +73.31 +-28.28 +-28.66 +-31.14 +21.27 +-6.50 +67.82 +2.28 +2.74 +-2.59 +-14.14 +-29.07 +14.84 +9.02 +12.91 +-42.45 +0.18 +-29.53 +3.53 +-2.84 +7.30 +182.10 +-31.00 +-19.64 +-34.75 +-7.61 +-73.96 +21.27 +34.05 +-70.46 +168.71 +-2.29 +-1.08 +0.00 +-2.93 +0.00 +0.00 +0.00 +8.15 +-14.14 +4.02 +-78.69 +-0.80 +23.59 +-4.19 +-19.77 +15.06 +7.27 +24.01 +-37.72 +7.03 +15.39 +-77.97 +10.12 +-45.45 +10.00 +0.52 +-8.85 +82.30 +-29.29 +14.15 +-29.07 +4.02 +-15.11 +-38.82 +5.14 +6.68 +205.88 +14.99 +0.00 +0.00 +0.00 +4.28 +0.00 +-80.30 +14.84 +-78.69 +-15.11 +-4.92 +-43.87 +20.05 +10.45 +-22.09 +-35.96 +-10.05 +20.48 +136.19 +0.00 +7.94 +0.00 +13.83 +9.02 +-0.80 +-38.82 +-4.92 +14.97 +-137.41 +279.39 +0.00 +10.96 +0.00 +-2.34 +0.00 +8.72 +12.91 +23.59 +5.14 +-43.87 +14.97 +-137.08 +-1.16 +-45.15 +-2.27 +13.87 +-137.69 +331.41 +0.00 +4.35 +0.00 +-41.38 +-42.45 +-4.19 +6.68 +20.05 +-137.41 +-137.08 +110.30 +-47.92 +-44.25 +-20.53 +34.05 +-31.66 +106.72 +5.76 +4.92 +-1.17 +-19.77 +10.45 +-52.57 +3.74 +36.42 +-26.52 +-2.37 +14.96 +-50.88 +6.68 +-36.38 +131.65 +-54.60 +10.70 +15.06 +-22.09 +-52.57 +-26.83 +-36.99 +35.66 +189.56 +21.51 +0.00 +0.00 +13.85 +7.27 +-35.96 +3.74 +-26.83 +21.98 +-195.12 +366.69 +6.28 +3.81 +0.00 +0.00 +0.00 +0.59 +24.01 +-10.05 +36.42 +-36.99 +21.98 +-190.63 +8.24 +-38.59 +-25.24 +19.94 +-186.43 +440.74 +-36.67 +0.00 +0.00 +-10.22 +-37.72 +20.48 +-26.52 +35.66 +-195.12 +-190.63 +87.88 +13.05 +7.68 +-6.50 +-70.46 +-31.66 +84.15 +-8.77 +-6.50 +0.18 +7.03 +-1.16 +-2.37 +8.24 +3.11 +-74.37 +8.51 +-1.41 +14.94 +9.01 +-40.60 +92.91 +-28.35 +-29.53 +15.39 +-45.15 +3.11 +-14.02 +8.20 +-2.56 +217.42 +0.00 +9.61 +0.00 +16.12 +0.00 +0.00 +0.00 +3.53 +-77.97 +-2.27 +14.96 +-38.59 +-74.37 +-14.02 +-48.40 +10.58 +-20.01 +-8.63 +12.04 +141.03 +3.68 +-2.84 +10.12 +13.87 +8.51 +8.20 +-48.40 +-134.17 +353.02 +0.00 +-49.61 +0.00 +0.00 +0.00 +7.30 +-45.45 +-137.69 +-1.41 +-2.56 +10.58 +-134.17 +131.32 +-47.84 +10.00 +-50.88 +-25.24 +14.94 +-20.01 +-36.74 +24.45 +173.90 +13.81 +0.52 +6.68 +19.94 +9.01 +-8.63 +-36.74 +-178.48 +439.16 +0.00 +-24.90 +0.00 +0.00 +0.00 +-8.85 +-36.38 +-186.43 +-40.60 +12.04 +24.45 +-178.48 +(0,0) 19.00 +(0,1) 0.00 +(0,2) 7.66 +(0,3) 0.00 +(0,4) 0.00 +(0,23) 3.17 +(0,24) 0.00 +(0,26) 0.00 +(1,1) 14.52 +(1,0) 0.00 +(1,2) 0.00 +(1,3) -3.20 +(1,4) 4.04 +(1,23) 0.00 +(1,24) -1.28 +(1,26) 2.27 +(2,2) 37.71 +(2,0) 7.66 +(2,1) 0.00 +(2,3) 0.00 +(2,4) 0.00 +(2,13) 7.66 +(2,14) 0.00 +(2,15) 0.00 +(3,3) 33.67 +(3,0) 0.00 +(3,1) -3.20 +(3,2) 0.00 +(3,4) 8.75 +(3,13) 0.00 +(3,14) -3.20 +(3,15) 8.75 +(4,4) 48.49 +(4,0) 0.00 +(4,1) 4.04 +(4,2) 0.00 +(4,3) 8.75 +(5,5) 29.32 +(5,6) 0.00 +(5,7) 7.66 +(5,8) 0.00 +(5,9) 0.00 +(5,23) 4.64 +(5,24) 0.00 +(5,25) 0.00 +(6,6) 25.72 +(6,5) 0.00 +(6,7) 0.00 +(6,8) -3.20 +(6,9) 8.75 +(6,23) 0.00 +(6,24) -1.87 +(6,25) 4.63 +(7,7) 25.93 +(7,5) 7.66 +(7,6) 0.00 +(7,8) 0.00 +(7,9) 0.00 +(7,10) 7.66 +(7,11) 0.00 +(7,12) 0.00 +(8,8) 19.53 +(8,5) 0.00 +(8,6) -3.20 +(8,7) 0.00 +(8,9) 4.04 +(8,10) 0.00 +(8,11) -3.20 +(8,12) 4.04 +(9,9) 48.49 +(9,5) 0.00 +(9,6) 8.75 +(9,7) 0.00 +(9,8) 4.04 +(10,10) 37.71 +(10,7) 7.66 +(10,8) 0.00 +(10,11) 0.00 +(10,12) 0.00 +(10,19) 7.66 +(10,20) 0.00 +(10,21) 0.00 +(11,11) 33.67 +(11,7) 0.00 +(11,8) -3.20 +(11,10) 0.00 +(11,12) 8.75 +(11,19) 0.00 +(11,20) -3.20 +(11,21) 8.75 +(12,12) 48.49 +(12,7) 0.00 +(12,8) 4.04 +(12,10) 0.00 +(12,11) 8.75 +(13,13) 25.93 +(13,2) 7.66 +(13,3) 0.00 +(13,14) 0.00 +(13,15) 0.00 +(13,16) 7.66 +(13,17) 0.00 +(13,18) 0.00 +(14,14) 19.53 +(14,2) 0.00 +(14,3) -3.20 +(14,13) 0.00 +(14,15) 4.04 +(14,16) 0.00 +(14,17) -3.20 +(14,18) 4.04 +(15,15) 48.49 +(15,2) 0.00 +(15,3) 8.75 +(15,13) 0.00 +(15,14) 4.04 +(16,16) 37.71 +(16,13) 7.66 +(16,14) 0.00 +(16,17) 0.00 +(16,18) 0.00 +(16,19) 7.66 +(16,20) 0.00 +(16,22) 0.00 +(17,17) 33.67 +(17,13) 0.00 +(17,14) -3.20 +(17,16) 0.00 +(17,18) 8.75 +(17,19) 0.00 +(17,20) -3.20 +(17,22) 8.75 +(18,18) 48.49 +(18,13) 0.00 +(18,14) 4.04 +(18,16) 0.00 +(18,17) 8.75 +(19,19) 25.93 +(19,10) 7.66 +(19,11) 0.00 +(19,16) 7.66 +(19,17) 0.00 +(19,20) 0.00 +(19,21) 0.00 +(19,22) 0.00 +(20,20) 19.53 +(20,10) 0.00 +(20,11) -3.20 +(20,16) 0.00 +(20,17) -3.20 +(20,19) 0.00 +(20,21) 4.04 +(20,22) 4.04 +(21,21) 48.49 +(21,10) 0.00 +(21,11) 8.75 +(21,19) 0.00 +(21,20) 4.04 +(22,22) 48.49 +(22,16) 0.00 +(22,17) 8.75 +(22,19) 0.00 +(22,20) 4.04 +(23,23) 15.03 +(23,0) 3.17 +(23,1) 0.00 +(23,5) 4.64 +(23,6) 0.00 +(23,24) 0.00 +(23,25) 0.00 +(23,26) 0.00 +(24,24) 11.87 +(24,0) 0.00 +(24,1) -1.28 +(24,5) 0.00 +(24,6) -1.87 +(24,23) 0.00 +(24,25) 2.86 +(24,26) 2.86 +(25,25) 29.63 +(25,5) 0.00 +(25,6) 4.63 +(25,23) 0.00 +(25,24) 2.86 +(26,26) 20.20 +(26,0) 0.00 +(26,1) 2.27 +(26,23) 0.00 +(26,24) 2.86 +1.20 +0.73 +0.73 +0.47 +0.73 +0.47 +0.47 +0.30 +0.00 +0.00 +0.00 +0.03 +0.02 +0.02 +0.01 +0.04 +0.04 +0.02 +0.05 +-0.02 +-0.02 +0.01 +-0.02 +0.01 +0.01 +0.00 +0.02 +-0.01 +0.02 +-0.01 +-0.01 +0.00 +-0.01 +0.00 +0.02 +-0.01 +-0.01 +0.00 +0.01 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +1.85 +0.73 +0.47 +1.20 +0.47 +1.20 +0.30 +0.77 +0.10 +-0.02 +0.01 +-0.04 +0.01 +-0.04 +0.00 +0.01 +-0.01 +0.04 +0.05 +-0.02 +0.00 +-0.02 +-0.02 +0.01 +-0.01 +0.04 +0.00 +-0.02 +0.00 +0.02 +0.02 +-0.01 +0.02 +-0.01 +0.01 +6.92 +0.73 +0.47 +3.17 +0.47 +0.30 +4.37 +2.05 +0.73 +0.47 +3.17 +0.47 +0.30 +2.05 +1.27 +0.82 +0.00 +0.00 +0.00 +0.03 +0.00 +0.00 +0.02 +0.07 +0.04 +0.07 +0.04 +0.09 +0.35 +-0.02 +0.01 +-0.09 +0.01 +0.00 +-0.13 +0.03 +0.05 +-0.02 +-0.01 +0.09 +-0.02 +0.01 +0.00 +-0.03 +-0.01 +0.00 +0.13 +-0.03 +0.02 +-0.01 +0.00 +0.04 +0.02 +-0.01 +0.01 +-0.02 +0.01 +-0.09 +0.01 +0.00 +0.03 +-0.01 +0.09 +0.05 +-0.02 +0.00 +-0.03 +-0.02 +0.01 +-0.01 +0.00 +-0.03 +0.00 +0.04 +0.02 +-0.01 +0.02 +-0.01 +0.01 +0.02 +-0.01 +-0.02 +-0.02 +0.01 +0.01 +0.01 +-0.01 +-0.01 +0.02 +-0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +8.08 +0.47 +1.20 +3.17 +0.30 +0.77 +2.05 +5.22 +1.27 +0.82 +3.25 +2.10 +0.49 +0.01 +-0.04 +-0.09 +0.00 +0.01 +0.03 +-0.19 +-0.02 +0.11 +-0.02 +0.26 +0.01 +-0.04 +0.01 +-0.10 +0.00 +-0.02 +-0.03 +0.19 +-0.01 +0.04 +-0.01 +0.10 +0.06 +-0.02 +0.02 +0.02 +-0.01 +-0.02 +0.01 +0.01 +-0.01 +-0.11 +0.04 +0.11 +-0.06 +-0.04 +0.02 +-0.04 +0.04 +-0.02 +0.06 +-0.02 +0.02 +6.92 +0.73 +0.47 +0.47 +0.30 +3.17 +4.37 +2.05 +0.00 +0.47 +0.73 +0.47 +3.17 +0.30 +2.05 +1.27 +0.82 +0.00 +0.00 +0.00 +0.03 +0.00 +0.02 +0.07 +0.04 +0.07 +0.04 +0.09 +0.35 +-0.02 +0.01 +0.01 +0.00 +-0.09 +-0.13 +0.03 +-0.01 +0.00 +-0.01 +0.00 +0.13 +-0.03 +0.09 +-0.03 +0.05 +-0.02 +-0.02 +0.01 +0.02 +-0.01 +0.02 +-0.01 +0.00 +0.04 +0.01 +0.00 +0.01 +0.00 +-0.02 +0.00 +0.00 +-0.02 +0.01 +-0.09 +0.00 +0.03 +-0.01 +0.05 +0.00 +-0.03 +-0.02 +0.01 +-0.01 +0.09 +0.00 +-0.03 +0.00 +0.04 +0.02 +-0.01 +0.02 +-0.01 +0.01 +0.02 +-0.01 +0.01 +-0.02 +0.01 +-0.02 +0.01 +-0.01 +0.02 +-0.01 +-0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +8.08 +0.47 +1.20 +0.30 +0.77 +3.17 +2.05 +5.22 +1.27 +0.82 +3.25 +2.10 +0.49 +0.01 +-0.04 +0.00 +0.01 +-0.09 +0.03 +-0.19 +0.00 +-0.02 +-0.02 +0.01 +-0.03 +0.19 +0.26 +-0.10 +-0.02 +0.11 +0.01 +-0.04 +-0.01 +0.04 +0.06 +-0.02 +-0.01 +0.10 +0.02 +0.02 +-0.01 +0.01 +-0.02 +0.01 +-0.01 +-0.11 +0.04 +-0.04 +-0.06 +0.02 +0.11 +-0.04 +0.04 +0.06 +-0.02 +-0.02 +0.02 +32.90 +0.47 +0.30 +4.37 +2.05 +4.37 +2.05 +13.84 +0.47 +0.30 +2.05 +4.37 +2.05 +13.84 +0.82 +5.56 +0.47 +0.30 +2.05 +2.05 +13.84 +0.82 +5.56 +0.82 +5.56 +2.24 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.03 +0.06 +0.06 +0.14 +0.06 +0.14 +0.14 +1.86 +0.01 +0.00 +-0.13 +0.03 +-0.13 +0.03 +-0.43 +-0.02 +0.01 +0.00 +-0.03 +0.38 +-0.10 +-0.03 +0.44 +-0.02 +0.01 +0.38 +-0.10 +0.06 +-0.02 +-0.01 +0.10 +-0.01 +0.10 +0.02 +0.01 +0.00 +0.03 +-0.13 +0.03 +-0.43 +0.00 +-0.03 +-0.02 +0.01 +-0.03 +0.44 +0.38 +-0.10 +-0.02 +0.01 +-0.10 +-0.01 +0.10 +0.06 +-0.02 +-0.01 +0.10 +0.02 +-0.01 +0.09 +0.01 +0.01 +-0.09 +-0.09 +0.02 +-0.02 +-0.02 +-0.01 +0.10 +0.02 +0.01 +0.00 +0.03 +0.03 +-0.43 +-0.02 +-0.02 +0.01 +-0.10 +0.01 +-0.10 +0.00 +-0.03 +-0.03 +0.44 +-0.01 +0.10 +-0.01 +0.10 +0.06 +-0.02 +0.02 +-0.01 +0.09 +0.02 +0.01 +-0.09 +0.01 +-0.09 +-0.02 +-0.01 +0.10 +-0.02 +0.02 +-0.01 +0.09 +0.01 +-0.09 +0.02 +0.01 +-0.09 +-0.01 +0.10 +-0.02 +-0.02 +0.02 +-0.02 +0.02 +0.02 +0.02 +-0.02 +-0.02 +-0.02 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.01 +0.01 +0.01 +0.01 +0.01 +0.00 +35.28 +0.30 +0.77 +2.05 +5.22 +2.05 +5.22 +13.84 +0.82 +5.56 +2.10 +14.18 +0.82 +5.56 +2.10 +14.18 +2.24 +5.70 +2.38 +0.00 +0.01 +0.03 +-0.19 +0.03 +-0.19 +-0.43 +0.01 +-0.04 +0.01 +-0.10 +-0.10 +0.55 +-0.10 +1.27 +0.01 +-0.04 +-0.10 +0.55 +-0.02 +0.13 +-0.02 +0.29 +-0.02 +0.29 +0.07 +-0.01 +0.09 +0.01 +-0.09 +0.02 +-0.02 +0.04 +-0.51 +-0.04 +0.02 +0.53 +-0.27 +-0.12 +0.12 +-0.06 +-0.02 +0.28 +0.07 +-0.01 +0.09 +0.02 +0.01 +-0.09 +-0.02 +0.04 +-0.51 +-0.12 +0.02 +-0.27 +-0.04 +0.53 +0.12 +-0.02 +0.28 +-0.06 +0.07 +-0.02 +0.02 +0.02 +-0.02 +0.11 +-0.11 +0.06 +-0.11 +0.12 +-0.06 +-0.06 +0.06 +0.28 +0.02 +-0.01 +0.05 +-0.02 +-0.01 +0.00 +-0.02 +0.01 +-0.11 +0.01 +0.02 +-0.11 +0.04 +0.00 +-0.01 +0.01 +0.00 +0.02 +-0.01 +0.11 +-0.04 +0.00 +0.01 +0.11 +-0.04 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.60 +-0.01 +0.04 +-0.02 +0.11 +0.00 +-0.02 +0.01 +-0.04 +-0.11 +0.02 +0.06 +0.04 +-0.23 +-0.01 +-0.02 +0.00 +0.02 +-0.01 +0.04 +-0.04 +0.23 +0.01 +0.02 +0.32 +-0.12 +0.12 +0.28 +0.02 +0.05 +-0.01 +-0.02 +-0.01 +-0.02 +0.00 +0.01 +0.01 +0.02 +-0.11 +0.00 +-0.01 +-0.11 +0.04 +0.01 +0.02 +0.00 +-0.01 +0.00 +0.01 +0.11 +-0.04 +0.11 +-0.04 +0.04 +1.37 +-0.01 +-0.02 +0.09 +0.26 +0.00 +0.01 +-0.03 +-0.10 +0.02 +0.06 +-0.11 +-0.01 +-0.02 +0.04 +-0.52 +0.00 +-0.01 +0.04 +0.10 +0.01 +0.02 +-0.04 +0.54 +0.32 +-0.12 +0.12 +-0.02 +0.01 +0.02 +-0.01 +-0.01 +0.01 +-0.06 +0.02 +0.06 +-0.29 +-0.02 +0.11 +-0.02 +0.02 +-0.11 +0.30 +-0.11 +0.12 +1.96 +-0.01 +0.00 +-0.02 +0.01 +0.13 +-0.03 +0.38 +-0.10 +-0.11 +0.04 +0.00 +-0.01 +-0.52 +0.04 +0.10 +0.02 +-0.01 +0.06 +-0.02 +0.32 +-0.12 +0.01 +0.02 +-0.04 +0.54 +0.12 +0.00 +-0.02 +0.00 +0.06 +0.00 +0.00 +-0.01 +0.00 +-0.03 +0.01 +-0.10 +-0.11 +0.02 +0.04 +-0.52 +-0.01 +-0.02 +0.00 +0.04 +-0.01 +0.10 +-0.04 +0.54 +0.01 +0.02 +0.32 +-0.12 +0.12 +0.01 +0.02 +0.11 +-0.01 +-0.02 +-0.01 +-0.02 +-0.11 +0.01 +0.02 +-0.11 +0.12 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +2.89 +0.00 +-0.02 +0.01 +-0.04 +-0.03 +0.19 +-0.10 +0.55 +0.04 +-0.23 +-0.01 +-0.02 +-0.52 +0.10 +0.29 +-0.01 +0.04 +-0.02 +0.13 +-0.12 +0.67 +0.02 +0.07 +-0.12 +1.54 +0.36 +0.01 +0.02 +0.11 +-0.01 +-0.02 +-0.11 +-0.04 +-0.12 +-0.62 +-0.02 +-0.06 +0.04 +0.12 +0.64 +0.02 +0.07 +-0.33 +0.34 +1.37 +-0.01 +-0.02 +0.00 +0.01 +0.09 +0.26 +-0.03 +-0.10 +0.00 +-0.01 +-0.11 +0.04 +0.04 +0.10 +-0.52 +0.02 +0.06 +-0.01 +-0.02 +0.01 +0.02 +0.32 +-0.12 +-0.04 +0.54 +0.12 +-0.02 +0.01 +-0.01 +0.02 +-0.01 +0.01 +-0.06 +0.02 +-0.02 +-0.29 +0.11 +0.06 +-0.02 +0.02 +0.30 +-0.11 +-0.11 +0.12 +6.60 +0.00 +0.01 +-0.03 +-0.10 +-0.03 +-0.10 +0.44 +1.27 +-0.01 +-0.02 +0.04 +-0.52 +0.10 +0.29 +-0.52 +-0.01 +-0.02 +0.10 +0.29 +0.02 +0.07 +-0.12 +1.54 +-0.12 +1.54 +0.36 +0.01 +-0.09 +-0.01 +0.10 +-0.02 +0.02 +0.02 +-0.27 +-0.02 +0.11 +0.28 +-1.41 +-0.06 +0.07 +-0.33 +-0.11 +1.46 +0.34 +0.01 +-0.09 +-0.02 +-0.01 +0.10 +0.02 +0.02 +-0.27 +-0.06 +0.11 +-1.41 +-0.02 +0.28 +0.07 +-0.11 +1.46 +-0.33 +0.34 +0.02 +-0.02 +-0.02 +0.02 +0.06 +-0.06 +0.30 +-0.06 +0.06 +-0.31 +-0.31 +0.32 +0.28 +0.02 +-0.01 +-0.01 +0.00 +0.05 +-0.02 +-0.02 +0.01 +0.01 +0.00 +0.01 +0.00 +0.02 +-0.01 +0.02 +-0.01 +-0.11 +-0.11 +0.04 +0.11 +-0.04 +0.11 +-0.04 +0.00 +0.01 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.60 +-0.01 +0.04 +0.00 +-0.02 +-0.02 +0.11 +0.01 +-0.04 +0.00 +0.02 +0.02 +-0.01 +-0.01 +0.04 +0.06 +-0.02 +-0.11 +0.04 +-0.23 +-0.04 +0.23 +0.32 +-0.12 +0.01 +0.02 +0.12 +1.96 +-0.01 +0.00 +0.13 +-0.03 +-0.02 +0.01 +0.38 +-0.10 +0.02 +-0.01 +0.00 +0.04 +0.06 +-0.02 +-0.01 +0.10 +-0.11 +0.04 +-0.52 +0.32 +-0.12 +-0.04 +0.54 +0.01 +0.02 +0.12 +-0.01 +0.00 +-0.03 +-0.02 +0.01 +-0.10 +0.00 +0.04 +0.02 +-0.01 +-0.01 +0.10 +0.06 +-0.02 +-0.11 +0.04 +-0.52 +-0.04 +0.54 +0.32 +-0.12 +0.01 +0.02 +0.12 +0.01 +0.02 +-0.01 +-0.01 +-0.02 +-0.02 +0.11 +-0.11 +-0.11 +0.01 +0.02 +0.12 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +2.89 +0.00 +-0.02 +-0.03 +0.19 +0.01 +-0.04 +-0.10 +0.55 +-0.01 +0.04 +-0.01 +0.10 +-0.02 +0.13 +-0.02 +0.29 +0.04 +-0.23 +-0.52 +-0.12 +0.67 +-0.12 +1.54 +0.02 +0.07 +0.36 +0.01 +0.02 +-0.01 +-0.02 +0.11 +-0.11 +-0.04 +-0.12 +0.04 +-0.02 +0.12 +-0.06 +-0.62 +0.64 +-0.33 +0.02 +0.07 +0.34 +1.66 +0.01 +0.00 +0.02 +-0.01 +0.02 +-0.01 +0.06 +-0.02 +0.11 +-0.04 +0.00 +0.01 +0.32 +-0.12 +0.01 +0.02 +0.11 +-0.04 +0.32 +-0.12 +-0.63 +0.04 +0.12 +0.04 +0.12 +0.65 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +3.50 +0.00 +0.02 +-0.01 +0.04 +-0.01 +0.04 +-0.02 +0.13 +-0.04 +0.23 +0.01 +0.02 +-0.12 +0.67 +0.02 +0.07 +-0.04 +0.23 +-0.12 +0.67 +-0.63 +0.12 +0.36 +0.12 +0.36 +1.86 +1.66 +0.01 +0.02 +0.00 +-0.01 +0.02 +0.06 +-0.01 +-0.02 +0.00 +0.01 +0.11 +-0.04 +0.01 +0.02 +0.32 +-0.12 +0.11 +0.32 +-0.04 +-0.12 +0.04 +0.12 +-0.63 +0.04 +0.12 +0.65 +8.00 +0.00 +-0.01 +0.04 +0.10 +-0.01 +-0.02 +0.10 +0.29 +0.01 +0.02 +-0.04 +0.54 +0.02 +0.07 +-0.12 +1.54 +-0.04 +-0.12 +0.54 +1.54 +0.12 +0.36 +-0.63 +0.12 +0.36 +1.86 +-0.01 +-0.02 +0.01 +0.02 +-0.11 +0.12 +-0.02 +-0.06 +0.02 +-0.11 +0.07 +-0.33 +-0.33 +0.34 +-1.71 +0.12 +0.34 +1.77 +1.66 +0.01 +0.02 +0.02 +0.06 +0.00 +-0.01 +-0.01 +-0.02 +0.11 +0.32 +0.11 +0.32 +-0.04 +-0.12 +-0.04 +-0.12 +0.00 +0.01 +0.01 +0.02 +0.04 +0.12 +0.04 +0.12 +-0.63 +0.65 +8.00 +0.00 +-0.01 +-0.01 +-0.02 +0.04 +0.10 +0.10 +0.29 +-0.04 +-0.12 +-0.04 +-0.12 +0.54 +1.54 +0.54 +1.54 +0.01 +0.02 +0.02 +0.07 +0.12 +0.36 +0.12 +0.36 +-0.63 +1.86 +-0.01 +-0.02 +-0.11 +0.01 +0.02 +0.12 +-0.02 +-0.06 +-0.33 +-0.11 +-0.33 +0.02 +0.07 +0.34 +0.12 +0.34 +-1.71 +1.77 +9.71 +0.00 +0.01 +0.01 +0.02 +0.01 +0.02 +0.02 +0.07 +0.04 +0.12 +0.04 +0.12 +0.12 +0.36 +0.12 +0.36 +0.04 +0.12 +0.12 +0.36 +0.65 +1.86 +0.65 +1.86 +0.65 +1.86 +1.20 +0.00 +0.73 +0.00 +0.47 +0.73 +0.47 +0.73 +0.47 +0.30 +0.00 +0.03 +0.02 +0.02 +0.01 +0.04 +0.04 +0.02 +0.05 +0.00 +-0.02 +0.00 +0.01 +0.00 +0.00 +0.00 +-0.01 +0.00 +-0.02 +0.01 +-0.02 +0.01 +0.00 +0.02 +-0.01 +0.02 +-0.01 +-0.01 +0.00 +-0.01 +0.00 +0.02 +-0.01 +0.00 +0.01 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +1.85 +0.47 +0.30 +0.73 +1.20 +0.47 +1.20 +0.77 +0.10 +0.01 +0.00 +0.00 +-0.02 +-0.04 +0.01 +-0.04 +0.01 +0.05 +-0.02 +-0.01 +0.04 +-0.02 +0.01 +0.00 +-0.02 +-0.01 +0.04 +-0.02 +0.02 +-0.01 +0.00 +0.02 +0.02 +-0.01 +0.01 +8.08 +3.17 +1.27 +2.05 +0.82 +0.47 +1.20 +0.30 +0.77 +5.22 +3.25 +2.10 +0.49 +-0.09 +0.02 +0.03 +-0.01 +-0.02 +0.01 +-0.03 +0.01 +-0.01 +0.01 +-0.04 +0.00 +0.01 +-0.19 +-0.02 +0.26 +-0.02 +0.11 +0.01 +-0.10 +0.01 +-0.04 +0.00 +-0.02 +0.19 +-0.01 +0.10 +-0.01 +0.04 +0.06 +-0.02 +0.02 +-0.11 +0.04 +-0.06 +0.11 +0.02 +-0.04 +-0.04 +-0.02 +0.04 +0.06 +-0.02 +0.02 +6.92 +0.00 +0.47 +0.47 +4.37 +0.73 +0.47 +0.30 +3.17 +2.05 +0.73 +0.47 +0.30 +3.17 +2.05 +1.27 +0.82 +0.00 +0.00 +0.00 +0.00 +0.03 +0.02 +0.07 +0.04 +0.07 +0.04 +0.09 +0.35 +0.00 +0.01 +0.01 +-0.13 +0.00 +-0.02 +0.00 +-0.02 +0.00 +-0.02 +0.01 +0.00 +-0.09 +0.03 +-0.01 +0.00 +-0.01 +0.00 +0.09 +-0.03 +0.13 +-0.03 +0.05 +-0.02 +0.01 +0.02 +-0.01 +0.02 +-0.01 +0.00 +0.04 +0.01 +-0.02 +0.01 +0.00 +-0.09 +0.03 +0.05 +-0.01 +-0.02 +0.01 +0.00 +-0.03 +-0.01 +0.00 +0.09 +-0.03 +0.02 +-0.01 +0.00 +0.04 +0.02 +-0.01 +0.01 +0.02 +-0.01 +-0.02 +0.01 +0.01 +-0.02 +0.01 +0.02 +-0.01 +-0.01 +-0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +8.08 +0.30 +2.05 +0.47 +1.20 +0.77 +3.17 +5.22 +1.27 +0.82 +3.25 +2.10 +0.49 +0.00 +0.03 +0.01 +0.01 +-0.04 +0.01 +-0.09 +-0.19 +-0.02 +0.01 +0.00 +-0.02 +0.26 +-0.10 +-0.03 +0.19 +-0.02 +0.11 +-0.04 +0.06 +-0.02 +-0.01 +0.04 +-0.01 +0.10 +0.02 +0.02 +-0.01 +0.01 +-0.02 +0.01 +-0.01 +-0.11 +0.04 +-0.06 +0.02 +-0.04 +0.11 +-0.04 +0.06 +-0.02 +0.04 +-0.02 +0.02 +35.28 +2.05 +0.82 +13.84 +5.56 +0.30 +0.77 +5.22 +2.05 +5.22 +2.10 +14.18 +0.82 +5.56 +2.24 +2.10 +14.18 +5.70 +2.38 +0.03 +-0.01 +-0.43 +0.09 +0.01 +-0.09 +-0.10 +0.02 +-0.02 +0.00 +0.01 +-0.19 +0.03 +-0.19 +0.01 +-0.10 +0.01 +-0.04 +-0.10 +1.27 +-0.10 +0.55 +0.01 +-0.04 +0.55 +-0.02 +0.29 +-0.02 +0.13 +-0.02 +0.29 +0.07 +0.04 +-0.51 +0.02 +-0.04 +-0.27 +0.53 +-0.12 +-0.06 +0.12 +-0.02 +0.28 +0.07 +-0.01 +0.09 +0.02 +0.01 +-0.09 +-0.02 +-0.02 +0.02 +0.02 +-0.02 +0.04 +-0.51 +0.02 +-0.27 +-0.12 +-0.04 +0.53 +-0.02 +0.28 +0.12 +-0.06 +0.07 +0.11 +0.06 +-0.11 +-0.11 +-0.06 +0.12 +-0.06 +0.06 +0.28 +-0.01 +0.00 +0.00 +0.02 +0.05 +-0.02 +-0.01 +-0.02 +0.01 +-0.11 +0.01 +0.02 +-0.11 +0.04 +0.00 +-0.01 +0.01 +0.02 +-0.01 +0.11 +-0.04 +0.00 +0.01 +0.11 +-0.04 +0.04 +1.37 +0.09 +-0.02 +-0.03 +0.01 +0.02 +-0.01 +0.04 +-0.01 +0.01 +-0.01 +-0.02 +0.26 +0.00 +0.01 +-0.10 +-0.11 +0.02 +0.06 +0.04 +-0.52 +-0.01 +-0.02 +0.00 +-0.01 +0.10 +-0.04 +0.54 +0.01 +0.02 +0.32 +-0.12 +0.12 +-0.06 +0.02 +-0.29 +0.06 +0.11 +-0.02 +-0.02 +-0.11 +0.02 +0.30 +-0.11 +0.12 +0.28 +0.00 +0.05 +0.00 +-0.02 +0.00 +0.00 +0.00 +0.02 +0.00 +0.02 +-0.01 +-0.02 +-0.01 +0.00 +0.01 +0.01 +0.02 +-0.11 +0.00 +-0.01 +-0.11 +0.04 +0.01 +0.00 +-0.01 +0.00 +0.01 +0.11 +-0.04 +0.11 +-0.04 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.60 +-0.02 +0.01 +-0.01 +-0.01 +0.04 +0.11 +0.00 +-0.02 +-0.04 +0.02 +0.06 +-0.11 +-0.01 +-0.02 +0.04 +-0.23 +0.00 +0.02 +0.04 +0.01 +0.02 +-0.04 +0.23 +0.32 +-0.12 +0.12 +1.37 +0.00 +-0.03 +-0.01 +-0.01 +-0.02 +0.01 +0.09 +0.26 +-0.10 +-0.11 +0.04 +0.00 +-0.01 +-0.52 +0.04 +0.10 +0.02 +0.06 +-0.02 +0.32 +-0.12 +0.01 +0.02 +-0.04 +0.54 +0.12 +-0.02 +0.01 +-0.01 +0.02 +-0.01 +0.01 +-0.06 +0.02 +-0.29 +0.11 +-0.02 +0.06 +-0.02 +0.30 +-0.11 +0.02 +-0.11 +0.12 +6.60 +-0.03 +0.01 +0.44 +-0.09 +-0.01 +0.10 +0.10 +-0.02 +0.02 +0.00 +0.01 +-0.10 +-0.03 +-0.10 +1.27 +0.04 +-0.52 +-0.01 +-0.02 +-0.52 +0.10 +0.29 +-0.01 +-0.02 +0.29 +-0.12 +1.54 +0.02 +0.07 +-0.12 +1.54 +0.36 +0.02 +-0.27 +0.11 +-0.02 +-1.41 +0.28 +-0.06 +-0.33 +0.07 +-0.11 +1.46 +0.34 +0.01 +-0.09 +-0.02 +-0.01 +0.10 +0.02 +0.02 +-0.02 +-0.02 +0.02 +0.02 +-0.27 +0.11 +-1.41 +-0.06 +-0.02 +0.28 +-0.11 +1.46 +0.07 +-0.33 +0.34 +0.06 +0.30 +-0.06 +-0.06 +-0.31 +0.06 +-0.31 +0.32 +1.96 +0.00 +-0.02 +-0.02 +0.38 +0.00 +0.06 +0.00 +0.06 +0.00 +-0.01 +0.00 +0.01 +0.13 +-0.03 +-0.10 +0.00 +-0.01 +-0.11 +0.04 +0.04 +0.10 +-0.52 +0.02 +-0.01 +-0.02 +0.01 +0.02 +0.32 +-0.12 +-0.04 +0.54 +0.12 +-0.01 +0.00 +0.01 +-0.03 +-0.10 +0.02 +-0.11 +-0.01 +-0.02 +0.04 +-0.52 +0.00 +-0.01 +0.04 +0.10 +0.01 +0.02 +-0.04 +0.54 +0.32 +-0.12 +0.12 +0.01 +0.02 +-0.01 +-0.02 +0.11 +-0.01 +-0.02 +0.01 +0.02 +-0.11 +-0.11 +0.12 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +2.89 +0.01 +-0.10 +-0.02 +0.00 +-0.02 +-0.04 +-0.03 +0.19 +0.55 +-0.01 +-0.02 +0.04 +-0.23 +0.10 +0.29 +-0.52 +-0.01 +0.04 +0.13 +0.02 +0.07 +-0.12 +0.67 +-0.12 +1.54 +0.36 +0.01 +0.02 +0.11 +-0.01 +-0.02 +-0.11 +-0.04 +-0.12 +-0.02 +-0.06 +-0.62 +0.04 +0.12 +0.02 +0.07 +0.64 +-0.33 +0.34 +0.28 +0.00 +-0.01 +0.00 +-0.02 +0.00 +0.00 +0.00 +-0.11 +0.00 +0.02 +-0.01 +0.00 +0.05 +-0.02 +0.01 +0.01 +0.00 +0.01 +0.00 +0.02 +-0.01 +0.02 +-0.01 +-0.11 +0.04 +0.11 +-0.04 +0.11 +-0.04 +0.00 +0.01 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.60 +0.00 +0.01 +0.04 +-0.01 +0.04 +-0.02 +-0.02 +0.11 +-0.04 +0.02 +-0.01 +0.00 +0.02 +0.06 +-0.02 +-0.01 +0.04 +-0.11 +-0.23 +0.32 +-0.12 +-0.04 +0.23 +0.01 +0.02 +0.12 +2.89 +-0.03 +0.01 +-0.10 +0.02 +-0.01 +-0.02 +-0.52 +0.11 +-0.11 +0.00 +-0.02 +0.19 +0.01 +-0.04 +0.55 +-0.01 +0.10 +-0.01 +0.04 +-0.02 +0.29 +-0.02 +0.13 +0.04 +-0.23 +-0.12 +1.54 +-0.12 +0.67 +0.02 +0.07 +0.36 +-0.04 +-0.12 +-0.02 +0.04 +-0.06 +0.12 +-0.62 +-0.33 +0.64 +0.02 +0.07 +0.34 +1.66 +0.00 +-0.01 +-0.04 +0.01 +0.02 +-0.01 +0.02 +0.06 +-0.02 +0.11 +-0.04 +0.00 +0.01 +0.32 +-0.12 +0.01 +0.02 +0.11 +0.32 +-0.12 +-0.63 +0.04 +0.12 +0.04 +0.12 +0.65 +8.00 +0.04 +-0.01 +0.10 +-0.02 +0.01 +0.02 +0.54 +-0.11 +0.12 +0.00 +-0.01 +0.10 +-0.01 +-0.02 +0.29 +-0.04 +0.54 +0.01 +0.02 +-0.12 +1.54 +0.02 +0.07 +-0.04 +-0.12 +1.54 +-0.63 +0.12 +0.36 +0.12 +0.36 +1.86 +-0.02 +-0.06 +-0.11 +0.02 +-0.33 +0.07 +-0.33 +-1.71 +0.34 +0.12 +0.34 +1.77 +1.66 +0.00 +0.02 +0.00 +0.06 +0.00 +0.00 +0.00 +0.32 +0.00 +0.01 +0.00 +-0.01 +0.02 +-0.01 +-0.02 +0.00 +0.01 +0.11 +-0.04 +0.01 +0.02 +0.32 +-0.12 +0.11 +-0.04 +-0.12 +0.04 +0.12 +-0.63 +0.04 +0.12 +0.65 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +3.50 +-0.01 +-0.02 +-0.12 +0.00 +0.02 +0.04 +-0.01 +0.04 +0.13 +0.01 +0.02 +-0.04 +0.23 +0.02 +0.07 +-0.12 +0.67 +-0.04 +0.23 +0.67 +0.12 +0.36 +-0.63 +0.12 +0.36 +1.86 +1.66 +0.02 +-0.01 +0.01 +0.01 +0.02 +0.06 +0.00 +-0.01 +-0.02 +0.11 +0.32 +0.11 +0.32 +-0.04 +-0.12 +-0.04 +-0.12 +0.00 +0.01 +0.02 +0.04 +0.12 +0.04 +0.12 +-0.63 +0.65 +8.00 +-0.01 +0.10 +0.02 +0.00 +-0.01 +-0.02 +0.04 +0.10 +0.29 +-0.04 +-0.12 +-0.04 +-0.12 +0.54 +1.54 +0.54 +1.54 +0.01 +0.02 +0.07 +0.12 +0.36 +0.12 +0.36 +-0.63 +1.86 +-0.01 +-0.02 +-0.11 +0.01 +0.02 +0.12 +-0.02 +-0.06 +-0.11 +-0.33 +-0.33 +0.02 +0.07 +0.12 +0.34 +0.34 +-1.71 +1.77 +9.71 +0.01 +0.02 +0.12 +0.00 +0.01 +0.02 +0.01 +0.02 +0.07 +0.04 +0.12 +0.04 +0.12 +0.12 +0.36 +0.12 +0.36 +0.04 +0.12 +0.36 +0.65 +1.86 +0.65 +1.86 +0.65 +1.86 +8.29 +1.27 +3.25 +0.82 +2.10 +3.25 +2.10 +5.35 +0.59 +0.02 +-0.11 +-0.01 +0.04 +-0.06 +0.02 +0.01 +-0.04 +-0.02 +-0.11 +0.04 +-0.06 +0.02 +-0.04 +-0.02 +-0.22 +0.31 +0.31 +-0.12 +-0.12 +0.23 +0.12 +0.12 +0.17 +-0.06 +0.07 +36.16 +0.82 +2.10 +5.56 +14.18 +2.10 +14.18 +5.35 +2.24 +5.70 +5.70 +14.53 +2.83 +-0.01 +0.04 +0.09 +-0.51 +0.02 +-0.27 +0.02 +-0.12 +-0.06 +0.04 +-0.51 +0.02 +-0.27 +-0.12 +-0.06 +-0.22 +-0.12 +-0.12 +1.51 +1.51 +0.66 +0.35 +0.35 +-0.06 +0.80 +0.19 +-0.02 +0.02 +0.11 +0.06 +-0.11 +-0.06 +0.11 +0.06 +-0.11 +-0.06 +-0.60 +-0.32 +-0.32 +0.62 +0.33 +0.33 +-0.17 +0.18 +1.62 +-0.02 +0.11 +0.01 +-0.04 +0.06 +-0.02 +-0.01 +0.04 +0.02 +-0.06 +0.02 +-0.29 +0.11 +-0.02 +-0.11 +0.31 +-0.12 +0.17 +-0.62 +-0.06 +0.12 +0.64 +0.07 +0.86 +-0.33 +0.34 +1.62 +-0.02 +-0.06 +0.01 +0.02 +-0.29 +0.11 +-0.01 +-0.02 +-0.11 +0.11 +-0.04 +0.06 +-0.02 +0.04 +0.02 +0.31 +-0.12 +0.17 +-0.06 +-0.62 +0.12 +0.07 +0.64 +0.86 +-0.33 +0.34 +7.84 +0.01 +-0.04 +-0.09 +0.53 +-0.02 +0.28 +-0.02 +0.12 +0.07 +0.02 +-0.27 +0.11 +-1.41 +-0.06 +-0.33 +-0.12 +1.51 +-0.62 +-0.06 +0.80 +0.35 +1.83 +0.19 +-0.33 +4.18 +0.97 +0.02 +-0.02 +-0.11 +-0.06 +0.12 +0.06 +0.06 +0.30 +-0.06 +-0.31 +-0.32 +-1.67 +-0.17 +0.33 +1.73 +0.18 +-0.89 +0.92 +7.84 +0.01 +0.02 +-0.09 +-0.27 +0.11 +-1.41 +-0.02 +-0.06 +-0.33 +-0.04 +0.53 +-0.02 +0.28 +0.12 +0.07 +-0.12 +1.51 +-0.06 +-0.62 +0.80 +0.35 +0.19 +1.83 +-0.33 +4.18 +0.97 +0.02 +-0.02 +0.06 +0.30 +-0.06 +-0.31 +-0.11 +-0.06 +0.12 +0.06 +-0.32 +-0.17 +-1.67 +0.33 +0.18 +1.73 +-0.89 +0.92 +3.43 +0.01 +-0.04 +0.02 +-0.12 +-0.02 +-0.06 +0.11 +-0.62 +-0.33 +-0.04 +-0.12 +-0.02 +-0.06 +-0.62 +-0.33 +0.23 +0.66 +0.12 +0.12 +0.35 +0.35 +1.83 +1.83 +0.07 +0.19 +0.97 +9.51 +-0.01 +0.04 +-0.02 +0.12 +0.02 +0.07 +-0.11 +0.64 +0.34 +-0.02 +-0.06 +-0.11 +-0.33 +-0.33 +-1.71 +0.12 +0.35 +0.64 +0.07 +1.83 +0.19 +1.83 +0.97 +0.34 +0.97 +5.06 +9.51 +-0.01 +-0.02 +-0.02 +-0.06 +-0.11 +-0.33 +-0.11 +-0.33 +-1.71 +0.04 +0.12 +0.02 +0.07 +0.64 +0.34 +0.12 +0.35 +0.07 +0.64 +0.19 +1.83 +1.83 +0.97 +0.34 +0.97 +5.06 +4.51 +0.02 +0.06 +-0.01 +-0.02 +0.30 +-0.11 +0.01 +0.02 +0.12 +0.06 +-0.02 +0.30 +-0.11 +0.02 +0.12 +0.17 +-0.06 +0.86 +0.86 +-0.33 +-0.33 +0.07 +0.34 +0.34 +-1.71 +1.77 +21.76 +-0.01 +-0.02 +0.10 +0.28 +-0.11 +1.46 +0.02 +0.07 +0.34 +-0.02 +0.28 +-0.11 +1.46 +0.07 +0.34 +-0.06 +0.80 +-0.33 +-0.33 +4.18 +4.18 +0.19 +0.97 +0.97 +-1.71 +5.06 +-0.02 +0.02 +-0.06 +-0.31 +0.06 +0.32 +-0.06 +-0.31 +0.06 +0.32 +-0.17 +-0.89 +-0.89 +0.18 +0.92 +0.92 +-4.64 +4.80 +26.39 +0.01 +0.02 +0.02 +0.07 +0.12 +0.34 +0.12 +0.34 +1.77 +0.02 +0.07 +0.12 +0.34 +0.34 +1.77 +0.07 +0.19 +0.34 +0.34 +0.97 +0.97 +0.97 +5.06 +5.06 +1.77 +5.06 +1.20 +0.00 +0.00 +0.73 +0.47 +0.00 +0.73 +0.73 +0.47 +0.47 +0.30 +0.03 +0.02 +0.02 +0.01 +0.04 +0.04 +0.02 +0.05 +0.00 +0.00 +-0.02 +0.01 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +-0.01 +0.00 +0.00 +-0.02 +0.01 +0.01 +0.00 +0.02 +0.02 +-0.01 +0.00 +-0.01 +0.00 +0.02 +-0.01 +-0.01 +0.00 +0.01 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +1.85 +0.47 +0.30 +0.47 +0.73 +1.20 +1.20 +0.77 +0.10 +0.01 +0.00 +0.00 +0.01 +0.00 +-0.02 +-0.04 +-0.04 +0.01 +-0.01 +-0.01 +0.04 +-0.02 +0.04 +-0.02 +0.05 +-0.02 +-0.02 +0.01 +0.02 +-0.01 +0.02 +-0.01 +0.00 +0.02 +0.01 +8.08 +3.17 +1.27 +2.05 +0.82 +0.30 +0.47 +1.20 +0.77 +5.22 +3.25 +2.10 +0.49 +-0.09 +0.02 +0.03 +-0.01 +-0.03 +0.01 +-0.02 +0.01 +-0.01 +0.00 +0.01 +0.01 +-0.04 +0.01 +-0.19 +0.00 +-0.02 +-0.02 +0.19 +0.11 +-0.04 +-0.02 +0.26 +0.01 +-0.10 +-0.01 +0.10 +0.06 +-0.02 +-0.01 +0.04 +0.02 +-0.11 +0.04 +-0.04 +0.11 +-0.04 +-0.06 +0.02 +-0.02 +0.06 +-0.02 +0.04 +0.02 +8.08 +0.30 +2.05 +3.17 +1.27 +0.82 +0.47 +1.20 +0.77 +5.22 +3.25 +2.10 +0.49 +0.00 +0.03 +0.01 +-0.09 +0.02 +-0.01 +-0.02 +0.01 +-0.03 +0.01 +-0.01 +0.01 +-0.04 +0.01 +-0.19 +-0.02 +0.00 +0.11 +-0.04 +-0.02 +0.19 +-0.02 +0.01 +0.26 +-0.10 +0.06 +-0.02 +-0.01 +0.10 +-0.01 +0.04 +0.02 +-0.11 +0.04 +0.11 +-0.04 +-0.04 +-0.06 +0.02 +0.06 +-0.02 +-0.02 +0.04 +0.02 +35.28 +2.05 +0.82 +13.84 +5.56 +2.05 +0.82 +5.56 +2.24 +0.30 +0.77 +5.22 +5.22 +2.10 +14.18 +2.10 +14.18 +5.70 +2.38 +0.03 +-0.01 +-0.43 +0.09 +-0.10 +0.02 +0.01 +-0.09 +-0.02 +0.03 +-0.01 +0.09 +0.01 +-0.09 +-0.10 +0.02 +-0.02 +-0.02 +0.02 +0.02 +-0.02 +0.00 +0.01 +-0.19 +-0.19 +0.01 +0.01 +-0.04 +0.55 +-0.04 +0.55 +0.01 +-0.10 +-0.10 +1.27 +-0.02 +0.29 +-0.02 +0.29 +-0.02 +0.13 +0.07 +0.04 +-0.51 +-0.12 +-0.04 +0.53 +0.02 +-0.27 +-0.06 +-0.02 +0.28 +0.12 +0.07 +0.04 +-0.51 +-0.04 +0.53 +-0.12 +0.02 +-0.27 +-0.02 +0.28 +-0.06 +0.12 +0.07 +0.11 +-0.11 +-0.11 +0.06 +-0.06 +-0.06 +0.12 +0.06 +0.28 +0.00 +0.00 +-0.01 +-0.02 +0.00 +-0.11 +0.00 +0.00 +0.00 +0.00 +0.05 +0.00 +0.02 +0.00 +0.00 +0.02 +-0.01 +0.00 +-0.02 +0.01 +0.01 +-0.11 +0.04 +0.00 +-0.01 +0.01 +0.00 +0.02 +-0.01 +0.11 +-0.04 +0.00 +0.01 +0.11 +-0.04 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.28 +0.00 +0.00 +0.05 +-0.02 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +-0.11 +0.00 +0.00 +0.02 +-0.01 +-0.02 +0.00 +0.01 +0.01 +0.00 +-0.01 +-0.11 +0.04 +0.01 +0.02 +0.00 +-0.01 +0.00 +0.01 +0.11 +-0.04 +0.11 +-0.04 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.60 +0.00 +0.01 +0.04 +-0.02 +-0.01 +-0.01 +0.04 +-0.02 +0.11 +-0.04 +-0.11 +0.00 +-0.23 +0.02 +0.04 +0.02 +-0.01 +0.06 +-0.02 +0.32 +-0.12 +0.01 +0.02 +-0.04 +0.23 +0.12 +2.89 +-0.03 +0.01 +-0.10 +0.02 +-0.52 +0.11 +-0.01 +-0.02 +-0.11 +0.01 +-0.02 +0.00 +-0.02 +0.19 +-0.04 +0.55 +0.04 +-0.01 +-0.23 +0.04 +0.13 +-0.01 +0.10 +-0.02 +0.29 +-0.12 +1.54 +0.02 +0.07 +-0.12 +0.67 +0.36 +-0.04 +-0.12 +-0.62 +0.04 +0.12 +-0.02 +-0.06 +-0.33 +0.02 +0.07 +0.64 +0.34 +0.60 +-0.02 +0.01 +-0.01 +0.00 +0.04 +-0.01 +0.04 +0.11 +-0.02 +-0.04 +0.00 +-0.11 +0.02 +0.04 +-0.23 +0.02 +0.06 +-0.01 +-0.02 +0.01 +0.02 +0.32 +-0.12 +-0.04 +0.23 +0.12 +2.89 +0.01 +-0.10 +-0.02 +-0.03 +0.01 +0.02 +-0.01 +-0.02 +-0.52 +0.11 +-0.11 +0.00 +-0.02 +-0.04 +0.19 +0.55 +-0.01 +0.04 +0.04 +0.13 +-0.23 +-0.01 +-0.02 +0.10 +0.29 +0.02 +0.07 +-0.12 +1.54 +-0.12 +0.67 +0.36 +-0.04 +-0.12 +0.04 +0.12 +-0.62 +-0.02 +-0.06 +0.02 +0.07 +-0.33 +0.64 +0.34 +0.28 +-0.01 +0.00 +0.00 +-0.01 +0.00 +0.02 +0.05 +-0.02 +-0.02 +0.01 +0.01 +0.01 +0.02 +-0.01 +0.02 +-0.01 +-0.11 +-0.11 +0.04 +0.11 +-0.04 +0.11 +-0.04 +0.00 +0.01 +0.04 +1.37 +0.09 +-0.02 +-0.03 +0.01 +0.04 +-0.01 +0.02 +-0.01 +0.01 +0.00 +-0.01 +-0.01 +-0.02 +0.26 +0.01 +-0.10 +0.00 +0.02 +-0.01 +0.10 +0.06 +-0.02 +-0.11 +0.04 +-0.52 +-0.04 +0.54 +0.32 +-0.12 +0.01 +0.02 +0.12 +-0.06 +0.02 +-0.02 +0.06 +-0.02 +-0.29 +0.11 +-0.11 +0.30 +-0.11 +0.02 +0.12 +1.37 +0.00 +-0.03 +-0.01 +0.09 +-0.02 +0.01 +0.02 +-0.01 +0.04 +-0.01 +0.01 +-0.01 +-0.02 +0.01 +0.26 +-0.10 +0.02 +0.00 +0.06 +-0.02 +-0.01 +0.10 +-0.11 +0.04 +-0.52 +0.32 +-0.12 +-0.04 +0.54 +0.01 +0.02 +0.12 +-0.06 +0.02 +0.06 +-0.02 +-0.02 +-0.29 +0.11 +0.30 +-0.11 +-0.11 +0.02 +0.12 +6.60 +-0.03 +0.01 +0.44 +-0.09 +0.10 +-0.02 +-0.01 +0.10 +0.02 +-0.03 +0.01 +-0.09 +-0.01 +0.10 +0.10 +-0.02 +0.02 +0.02 +-0.02 +-0.02 +0.02 +0.00 +0.01 +-0.10 +-0.10 +1.27 +-0.01 +-0.01 +-0.02 +0.29 +-0.02 +0.29 +0.04 +-0.52 +-0.52 +-0.12 +1.54 +-0.12 +1.54 +0.02 +0.07 +0.36 +0.02 +-0.27 +-0.06 +-0.02 +0.28 +0.11 +-1.41 +-0.33 +-0.11 +1.46 +0.07 +0.34 +0.02 +-0.27 +-0.02 +0.28 +-0.06 +0.11 +-1.41 +-0.11 +1.46 +-0.33 +0.07 +0.34 +0.06 +-0.06 +-0.06 +0.30 +-0.31 +-0.31 +0.06 +0.32 +1.66 +0.00 +-0.01 +-0.04 +0.02 +0.01 +0.01 +0.02 +-0.01 +0.06 +-0.02 +0.11 +0.00 +0.32 +-0.12 +0.01 +0.02 +0.11 +-0.04 +0.32 +-0.12 +-0.63 +0.04 +0.12 +0.04 +0.12 +0.65 +8.00 +0.04 +-0.01 +0.10 +-0.02 +0.54 +-0.11 +0.01 +0.02 +0.12 +-0.01 +0.02 +0.00 +-0.01 +0.10 +-0.02 +0.29 +-0.04 +0.01 +-0.12 +1.54 +0.02 +0.07 +-0.04 +0.54 +-0.12 +1.54 +-0.63 +0.12 +0.36 +0.12 +0.36 +1.86 +-0.02 +-0.06 +-0.33 +0.02 +0.07 +-0.11 +-0.33 +-1.71 +0.12 +0.34 +0.34 +1.77 +1.66 +0.02 +-0.01 +0.01 +0.00 +-0.04 +0.01 +0.02 +0.06 +-0.01 +-0.02 +0.00 +0.11 +0.01 +0.02 +0.32 +-0.12 +0.11 +0.32 +-0.04 +-0.12 +0.04 +0.12 +-0.63 +0.04 +0.12 +0.65 +8.00 +-0.01 +0.10 +0.02 +0.04 +-0.01 +-0.02 +0.01 +0.02 +0.54 +-0.11 +0.12 +0.00 +-0.01 +-0.02 +0.10 +0.29 +0.01 +-0.04 +0.02 +0.07 +-0.12 +1.54 +-0.04 +-0.12 +0.54 +1.54 +0.12 +0.36 +-0.63 +0.12 +0.36 +1.86 +-0.02 +-0.06 +0.02 +0.07 +-0.33 +-0.11 +-0.33 +0.12 +0.34 +-1.71 +0.34 +1.77 +1.66 +0.00 +0.00 +0.02 +0.06 +0.00 +0.32 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.32 +0.00 +0.00 +0.01 +0.00 +-0.01 +-0.01 +-0.02 +0.11 +0.11 +-0.04 +-0.12 +-0.04 +-0.12 +0.00 +0.01 +0.01 +0.02 +0.04 +0.12 +0.04 +0.12 +-0.63 +0.65 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +3.50 +-0.01 +-0.02 +-0.12 +-0.01 +-0.12 +0.00 +0.02 +0.04 +0.04 +0.13 +-0.04 +-0.04 +0.23 +0.67 +0.23 +0.67 +0.01 +0.02 +0.02 +0.07 +0.12 +0.36 +0.12 +0.36 +-0.63 +1.86 +9.71 +0.01 +0.02 +0.12 +0.01 +0.12 +0.00 +0.01 +0.02 +0.02 +0.07 +0.04 +0.04 +0.12 +0.36 +0.12 +0.36 +0.04 +0.12 +0.12 +0.36 +0.65 +1.86 +0.65 +1.86 +0.65 +1.86 +8.29 +1.27 +3.25 +0.82 +2.10 +3.25 +2.10 +5.35 +0.59 +0.02 +-0.11 +-0.01 +0.04 +0.01 +-0.04 +-0.06 +0.02 +-0.02 +-0.11 +0.04 +-0.04 +-0.06 +0.02 +-0.02 +-0.22 +0.23 +0.31 +-0.12 +0.31 +-0.12 +0.12 +0.17 +-0.06 +0.12 +0.07 +36.16 +0.82 +2.10 +5.56 +14.18 +2.24 +5.70 +2.10 +14.18 +5.35 +5.70 +14.53 +2.83 +-0.01 +0.04 +0.09 +-0.51 +0.02 +-0.12 +0.02 +-0.27 +-0.06 +-0.02 +0.02 +0.11 +-0.11 +0.06 +-0.06 +0.04 +-0.51 +-0.12 +0.02 +-0.27 +-0.06 +-0.22 +0.66 +-0.12 +1.51 +-0.12 +1.51 +0.35 +-0.06 +0.80 +0.35 +0.19 +0.11 +-0.11 +0.06 +-0.06 +-0.60 +0.62 +-0.32 +-0.32 +0.33 +-0.17 +0.33 +0.18 +3.43 +0.01 +-0.04 +0.02 +-0.12 +0.11 +-0.62 +-0.02 +-0.06 +-0.33 +-0.04 +-0.12 +-0.62 +-0.02 +-0.06 +-0.33 +0.23 +0.66 +0.12 +0.35 +0.12 +0.35 +1.83 +0.07 +0.19 +1.83 +0.97 +1.62 +-0.02 +-0.06 +0.01 +0.02 +-0.01 +-0.02 +-0.29 +0.11 +-0.11 +0.11 +-0.04 +0.04 +0.06 +-0.02 +0.02 +0.31 +-0.12 +0.12 +-0.62 +0.17 +-0.06 +0.07 +0.86 +-0.33 +0.64 +0.34 +7.84 +0.01 +0.02 +-0.09 +-0.27 +-0.02 +-0.06 +0.11 +-1.41 +-0.33 +0.02 +-0.02 +0.06 +-0.06 +0.30 +-0.31 +-0.04 +0.53 +0.12 +-0.02 +0.28 +0.07 +-0.12 +1.51 +0.35 +-0.62 +-0.06 +0.80 +0.19 +-0.33 +4.18 +1.83 +0.97 +-0.11 +0.12 +-0.06 +0.06 +-0.32 +0.33 +-1.67 +-0.17 +0.18 +-0.89 +1.73 +0.92 +1.62 +-0.02 +0.11 +0.01 +-0.04 +-0.01 +0.04 +0.06 +-0.02 +0.02 +-0.06 +0.02 +-0.02 +-0.29 +0.11 +-0.11 +0.31 +-0.12 +0.12 +0.17 +-0.06 +-0.62 +0.64 +0.86 +-0.33 +0.07 +0.34 +7.84 +0.01 +-0.04 +-0.09 +0.53 +-0.02 +0.12 +-0.02 +0.28 +0.07 +0.02 +-0.02 +-0.11 +0.12 +-0.06 +0.06 +0.02 +-0.27 +-0.06 +0.11 +-1.41 +-0.33 +-0.12 +1.51 +0.35 +-0.06 +0.80 +-0.62 +1.83 +-0.33 +4.18 +0.19 +0.97 +0.06 +-0.06 +0.30 +-0.31 +-0.32 +0.33 +-0.17 +-1.67 +1.73 +-0.89 +0.18 +0.92 +9.51 +-0.01 +0.04 +-0.02 +0.12 +-0.11 +0.64 +0.02 +0.07 +0.34 +-0.02 +-0.06 +-0.33 +-0.11 +-0.33 +-1.71 +0.12 +0.35 +1.83 +0.07 +0.19 +0.64 +1.83 +0.34 +0.97 +0.97 +5.06 +4.51 +0.02 +0.06 +-0.01 +-0.02 +0.01 +0.02 +0.30 +-0.11 +0.12 +0.06 +-0.02 +0.02 +0.30 +-0.11 +0.12 +0.17 +-0.06 +0.07 +0.86 +-0.33 +0.86 +-0.33 +0.34 +-1.71 +0.34 +1.77 +21.76 +-0.01 +-0.02 +0.10 +0.28 +0.02 +0.07 +-0.11 +1.46 +0.34 +-0.02 +0.02 +-0.06 +0.06 +-0.31 +0.32 +-0.02 +0.28 +0.07 +-0.11 +1.46 +0.34 +-0.06 +0.80 +0.19 +-0.33 +4.18 +-0.33 +4.18 +0.97 +-1.71 +0.97 +5.06 +-0.06 +0.06 +-0.31 +0.32 +-0.17 +0.18 +-0.89 +-0.89 +0.92 +-4.64 +0.92 +4.80 +9.51 +-0.01 +-0.02 +-0.02 +-0.06 +-0.11 +-0.33 +-0.11 +-0.33 +-1.71 +0.04 +0.12 +0.64 +0.02 +0.07 +0.34 +0.12 +0.35 +1.83 +0.64 +1.83 +0.07 +0.19 +0.97 +0.34 +0.97 +5.06 +26.39 +0.01 +0.02 +0.02 +0.07 +0.12 +0.34 +0.12 +0.34 +1.77 +0.02 +0.07 +0.34 +0.12 +0.34 +1.77 +0.07 +0.19 +0.97 +0.34 +0.97 +0.34 +0.97 +5.06 +1.77 +5.06 +5.06 +8.29 +0.82 +1.27 +3.25 +2.10 +3.25 +2.10 +5.35 +0.59 +-0.01 +0.02 +-0.11 +0.04 +-0.06 +0.02 +0.01 +-0.04 +-0.02 +-0.11 +0.04 +-0.04 +-0.06 +0.02 +-0.02 +-0.22 +0.31 +-0.12 +0.23 +0.31 +-0.12 +0.17 +-0.06 +0.12 +0.12 +0.07 +36.16 +5.56 +2.24 +0.82 +2.10 +14.18 +5.70 +2.10 +14.18 +5.70 +5.35 +14.53 +2.83 +0.09 +-0.02 +0.02 +-0.01 +0.04 +-0.51 +0.02 +-0.27 +0.02 +-0.12 +-0.06 +0.11 +0.06 +-0.11 +-0.06 +0.04 +-0.51 +-0.12 +0.02 +-0.27 +-0.06 +0.11 +-0.11 +0.06 +-0.06 +-0.22 +-0.12 +1.51 +0.66 +-0.12 +1.51 +-0.06 +0.80 +0.35 +0.35 +0.19 +-0.60 +-0.32 +0.62 +-0.32 +-0.17 +0.33 +0.33 +0.18 +1.62 +0.01 +-0.02 +-0.06 +0.02 +-0.29 +0.11 +-0.01 +-0.02 +-0.11 +0.11 +-0.04 +0.04 +0.06 +-0.02 +0.02 +0.31 +-0.12 +-0.62 +0.12 +0.17 +-0.06 +0.86 +-0.33 +0.07 +0.64 +0.34 +7.84 +-0.09 +0.02 +-0.02 +0.01 +0.02 +-0.27 +0.11 +-1.41 +-0.02 +-0.06 +-0.33 +0.06 +0.30 +-0.06 +-0.31 +-0.04 +0.53 +0.12 +-0.02 +0.28 +0.07 +-0.11 +0.12 +-0.06 +0.06 +-0.12 +1.51 +-0.62 +0.35 +-0.06 +0.80 +-0.33 +4.18 +0.19 +1.83 +0.97 +-0.32 +-1.67 +0.33 +-0.17 +-0.89 +0.18 +1.73 +0.92 +3.43 +0.02 +0.01 +-0.04 +-0.12 +-0.02 +-0.06 +0.11 +-0.62 +-0.33 +-0.04 +-0.12 +-0.62 +-0.02 +-0.06 +-0.33 +0.23 +0.66 +0.12 +0.35 +0.12 +0.35 +0.07 +0.19 +1.83 +1.83 +0.97 +1.62 +0.01 +-0.02 +0.11 +-0.04 +0.06 +-0.02 +-0.01 +0.04 +0.02 +-0.06 +0.02 +-0.02 +-0.29 +0.11 +-0.11 +0.31 +-0.12 +0.17 +-0.06 +0.12 +-0.62 +0.86 +-0.33 +0.64 +0.07 +0.34 +7.84 +-0.09 +0.02 +-0.02 +0.01 +-0.04 +0.53 +-0.02 +0.28 +-0.02 +0.12 +0.07 +-0.11 +-0.06 +0.12 +0.06 +0.02 +-0.27 +-0.06 +0.11 +-1.41 +-0.33 +0.06 +-0.06 +0.30 +-0.31 +-0.12 +1.51 +-0.06 +0.80 +0.35 +-0.62 +-0.33 +4.18 +1.83 +0.19 +0.97 +-0.32 +-0.17 +0.33 +-1.67 +-0.89 +1.73 +0.18 +0.92 +4.51 +-0.01 +0.02 +0.06 +-0.02 +0.30 +-0.11 +0.01 +0.02 +0.12 +0.06 +-0.02 +0.02 +0.30 +-0.11 +0.12 +0.17 +-0.06 +0.86 +-0.33 +0.07 +0.86 +-0.33 +-1.71 +0.34 +0.34 +1.77 +21.76 +0.10 +-0.02 +0.02 +-0.01 +-0.02 +0.28 +-0.11 +1.46 +0.02 +0.07 +0.34 +-0.06 +-0.31 +0.06 +0.32 +-0.02 +0.28 +0.07 +-0.11 +1.46 +0.34 +-0.06 +0.06 +-0.31 +0.32 +-0.06 +0.80 +-0.33 +4.18 +0.19 +-0.33 +4.18 +-1.71 +0.97 +0.97 +5.06 +-0.17 +-0.89 +0.18 +-0.89 +-4.64 +0.92 +0.92 +4.80 +9.51 +-0.02 +-0.01 +0.04 +0.12 +0.02 +0.07 +-0.11 +0.64 +0.34 +-0.02 +-0.06 +-0.33 +-0.11 +-0.33 +-1.71 +0.12 +0.35 +0.07 +0.19 +1.83 +0.64 +1.83 +0.34 +0.97 +0.97 +5.06 +9.51 +-0.02 +-0.01 +-0.02 +-0.06 +-0.11 +-0.33 +-0.11 +-0.33 +-1.71 +0.04 +0.12 +0.64 +0.02 +0.07 +0.34 +0.12 +0.35 +0.64 +1.83 +1.83 +0.07 +0.19 +0.34 +0.97 +0.97 +5.06 +26.39 +0.02 +0.01 +0.02 +0.07 +0.12 +0.34 +0.12 +0.34 +1.77 +0.02 +0.07 +0.34 +0.12 +0.34 +1.77 +0.07 +0.19 +0.34 +0.97 +0.97 +0.34 +0.97 +1.77 +5.06 +5.06 +5.06 +37.06 +2.24 +5.70 +5.70 +14.53 +5.70 +14.53 +14.53 +3.36 +-0.02 +0.11 +0.06 +0.11 +0.06 +-0.60 +-0.32 +-0.32 +-0.17 +0.11 +0.06 +-0.60 +-0.32 +-0.32 +-0.17 +-0.60 +-0.32 +-0.32 +-0.17 +1.79 +1.79 +1.79 +0.95 +0.95 +0.95 +0.51 +9.32 +0.02 +-0.11 +-0.06 +0.06 +0.30 +-0.32 +-1.67 +-0.17 +-0.89 +-0.11 +-0.06 +0.62 +0.33 +0.33 +0.18 +-0.32 +-1.67 +-0.17 +-0.89 +1.79 +0.95 +0.95 +4.96 +0.51 +4.96 +2.64 +9.32 +0.02 +0.06 +0.30 +-0.11 +-0.06 +-0.32 +-0.17 +-1.67 +-0.89 +-0.11 +-0.06 +-0.32 +-1.67 +-0.17 +-0.89 +0.62 +0.33 +0.33 +0.18 +1.79 +0.95 +0.95 +0.51 +4.96 +4.96 +2.64 +9.32 +0.02 +-0.11 +-0.06 +-0.11 +-0.06 +0.62 +0.33 +0.33 +0.18 +0.06 +0.30 +-0.32 +-0.17 +-1.67 +-0.89 +-0.32 +-0.17 +-1.67 +-0.89 +1.79 +0.95 +0.95 +4.96 +4.96 +0.51 +2.64 +25.86 +-0.02 +0.12 +0.06 +-0.06 +-0.31 +0.33 +1.73 +0.18 +0.92 +-0.06 +-0.31 +0.33 +0.18 +1.73 +0.92 +-0.17 +-0.89 +-0.89 +-4.64 +0.95 +4.96 +0.51 +4.96 +2.64 +2.64 +13.77 +25.86 +-0.02 +-0.06 +-0.31 +0.12 +0.06 +0.33 +0.18 +1.73 +0.92 +-0.06 +-0.31 +-0.17 +-0.89 +-0.89 +-4.64 +0.33 +0.18 +1.73 +0.92 +0.95 +0.51 +4.96 +4.96 +2.64 +2.64 +13.77 +25.86 +-0.02 +-0.06 +-0.31 +-0.06 +-0.31 +-0.17 +-0.89 +-0.89 +-4.64 +0.12 +0.06 +0.33 +1.73 +0.18 +0.92 +0.33 +1.73 +0.18 +0.92 +0.95 +4.96 +4.96 +0.51 +2.64 +2.64 +13.77 +71.72 +0.02 +0.06 +0.32 +0.06 +0.32 +0.18 +0.92 +0.92 +4.80 +0.06 +0.32 +0.18 +0.92 +0.92 +4.80 +0.18 +0.92 +0.92 +4.80 +0.51 +2.64 +2.64 +2.64 +13.77 +13.77 +13.77 +0.03 +0.02 +0.02 +0.01 +0.02 +0.01 +0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.10 +0.03 +0.00 +0.00 +0.00 +0.02 +0.01 +0.06 +0.01 +0.06 +0.01 +0.03 +0.02 +0.02 +0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.10 +0.00 +0.00 +0.03 +0.00 +0.02 +0.01 +0.06 +0.01 +0.01 +0.06 +0.03 +0.02 +0.02 +0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.29 +0.02 +0.03 +0.00 +0.00 +0.02 +0.00 +0.01 +0.06 +0.06 +0.01 +0.03 +0.03 +0.17 +0.09 +0.01 +0.05 +0.09 +0.01 +0.05 +0.02 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.10 +0.00 +0.00 +0.00 +0.03 +0.02 +0.01 +0.01 +0.01 +0.06 +0.06 +0.03 +0.02 +0.02 +0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.29 +0.02 +0.00 +0.03 +0.00 +0.00 +0.02 +0.01 +0.06 +0.01 +0.03 +0.06 +0.03 +0.17 +0.01 +0.09 +0.05 +0.09 +0.01 +0.05 +0.02 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.29 +0.00 +0.00 +0.00 +0.02 +0.03 +0.02 +0.01 +0.01 +0.06 +0.03 +0.06 +0.03 +0.17 +0.01 +0.09 +0.05 +0.01 +0.09 +0.05 +0.02 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.86 +0.01 +0.02 +0.02 +0.03 +0.01 +0.02 +0.01 +0.01 +0.03 +0.03 +0.17 +0.03 +0.17 +0.17 +0.05 +0.05 +0.27 +0.05 +0.05 +0.27 +0.09 +0.05 +0.05 +0.27 +0.09 +0.09 +0.05 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +-0.01 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.03 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.03 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.03 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.08 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +-0.01 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.02 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.03 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.08 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.01 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.02 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.03 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.03 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.08 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +-0.01 +0.00 +0.02 +0.00 +0.02 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.02 +0.13 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.01 +0.00 +0.02 +-0.01 +0.00 +0.01 +0.00 +0.01 +0.03 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +0.00 +0.00 +0.00 +0.03 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.02 +0.13 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.01 +0.02 +0.00 +0.01 +-0.01 +0.00 +0.01 +0.03 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +0.00 +0.03 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.02 +0.13 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.02 +0.01 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +-0.01 +0.03 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.03 +0.20 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.01 +0.02 +0.03 +0.02 +0.03 +0.02 +0.03 +0.21 +0.04 +0.07 +0.02 +0.09 +0.01 +0.05 +0.02 +0.12 +0.03 +0.02 +0.04 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.21 +0.04 +0.07 +0.02 +0.01 +0.09 +0.05 +0.02 +0.12 +0.03 +0.02 +0.04 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.62 +0.02 +0.04 +0.04 +0.06 +0.01 +0.05 +0.05 +0.27 +0.12 +0.12 +0.02 +0.09 +0.20 +0.02 +0.09 +0.20 +0.03 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.02 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.02 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.06 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.01 +-0.01 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.03 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +-0.01 +0.01 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.14 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +-0.01 +0.01 +-0.01 +0.00 +0.01 +0.00 +0.00 +0.03 +0.00 +0.03 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +-0.02 +0.00 +0.00 +-0.01 +0.00 +0.03 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +0.01 +0.00 +0.00 +0.03 +-0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +-0.01 +0.01 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.06 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +-0.01 +0.02 +0.00 +0.03 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.02 +-0.01 +0.00 +0.00 +0.01 +0.10 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.02 +0.00 +0.00 +0.01 +0.02 +0.00 +0.01 +0.00 +0.01 +0.05 +0.07 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +-0.02 +0.00 +0.00 +0.03 +0.21 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.02 +0.00 +0.00 +0.03 +0.00 +0.03 +0.01 +-0.02 +0.00 +0.01 +0.05 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +-0.01 +0.01 +-0.03 +0.00 +0.01 +0.05 +0.07 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.03 +0.21 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.03 +0.02 +0.03 +0.00 +0.00 +0.01 +0.00 +0.01 +-0.02 +0.05 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +-0.01 +0.00 +0.00 +0.01 +0.00 +0.01 +-0.03 +0.05 +0.33 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.03 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.01 +0.05 +0.03 +0.05 +0.03 +0.05 +0.21 +0.07 +0.04 +0.02 +0.09 +0.01 +0.05 +0.03 +0.02 +0.02 +0.12 +0.04 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.21 +0.04 +0.07 +0.02 +0.01 +0.09 +0.05 +0.02 +0.12 +0.03 +0.02 +0.04 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.62 +0.04 +0.06 +0.02 +0.04 +0.01 +0.05 +0.05 +0.27 +0.02 +0.09 +0.12 +0.12 +0.20 +0.02 +0.09 +0.03 +0.20 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.01 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.01 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.01 +0.00 +0.00 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.14 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +-0.01 +0.00 +-0.01 +0.01 +0.00 +0.01 +0.00 +0.03 +0.00 +0.00 +0.03 +0.01 +0.00 +0.00 +0.00 +-0.02 +0.01 +0.00 +-0.01 +0.00 +0.00 +0.03 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +0.00 +0.01 +0.00 +0.03 +0.00 +-0.01 +0.01 +0.00 +0.00 +0.00 +-0.01 +0.00 +-0.01 +0.01 +0.06 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.01 +0.00 +0.00 +-0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.03 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.02 +-0.01 +0.01 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.06 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +-0.01 +0.00 +0.03 +0.02 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +-0.01 +0.02 +0.00 +0.00 +0.01 +0.07 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +-0.02 +0.00 +0.00 +0.00 +0.03 +0.21 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.02 +0.00 +0.00 +0.03 +0.00 +0.00 +0.03 +-0.02 +0.01 +0.00 +0.01 +0.05 +0.00 +0.00 +0.00 +-0.01 +0.00 +-0.01 +-0.03 +0.01 +0.00 +0.01 +0.05 +0.10 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.02 +0.01 +0.02 +0.00 +0.01 +0.00 +0.01 +0.05 +0.07 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.03 +0.21 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.02 +0.03 +0.03 +0.00 +0.00 +0.00 +0.01 +0.01 +-0.02 +0.05 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +-0.01 +0.00 +0.00 +0.00 +0.01 +0.01 +-0.03 +0.05 +0.33 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.03 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.01 +0.00 +0.01 +0.03 +0.05 +0.05 +0.03 +0.05 +0.45 +0.09 +0.14 +0.02 +0.09 +0.04 +0.20 +0.04 +0.20 +0.03 +0.06 +0.06 +0.03 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.02 +0.01 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.03 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.02 +0.00 +0.02 +-0.01 +0.01 +0.03 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.02 +0.02 +-0.01 +0.01 +0.11 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +-0.01 +0.02 +-0.01 +0.00 +0.01 +0.00 +0.03 +0.00 +-0.01 +0.06 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +-0.02 +0.00 +0.00 +0.03 +0.00 +-0.01 +0.01 +0.11 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +-0.01 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.02 +0.00 +-0.01 +0.01 +0.00 +0.00 +0.03 +-0.01 +0.06 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +0.00 +0.03 +-0.01 +0.01 +0.05 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +-0.01 +0.00 +0.00 +0.00 +0.00 +-0.01 +-0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.03 +0.03 +0.00 +0.00 +0.01 +0.17 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.01 +0.00 +0.00 +0.00 +-0.01 +-0.01 +-0.03 +0.00 +0.02 +0.00 +0.03 +0.00 +0.03 +0.01 +0.01 +0.01 +0.09 +0.17 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +-0.01 +-0.03 +0.00 +0.00 +0.00 +0.00 +0.02 +0.01 +0.00 +0.00 +0.02 +0.00 +0.03 +0.03 +0.01 +0.01 +0.01 +0.09 +0.11 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.02 +0.02 +-0.01 +-0.01 +0.00 +0.01 +0.01 +-0.03 +0.05 +0.35 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.03 +0.00 +0.01 +0.00 +0.01 +0.00 +0.03 +0.00 +0.01 +0.01 +-0.01 +-0.01 +0.06 +0.06 +0.00 +0.01 +0.01 +-0.03 +0.09 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.01 +0.00 +-0.01 +0.00 +0.01 +-0.01 +-0.01 +0.00 +0.01 +0.01 +-0.06 +0.09 +0.55 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.01 +0.05 +0.00 +0.00 +0.00 +0.01 +0.01 +0.05 +0.00 +0.01 +0.01 +0.01 +0.01 +0.01 +0.09 +0.09 +0.05 +0.09 +0.21 +0.07 +0.04 +0.02 +0.09 +0.01 +0.05 +0.03 +0.02 +0.02 +0.12 +0.04 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.21 +0.07 +0.04 +0.02 +0.01 +0.09 +0.05 +0.03 +0.02 +0.02 +0.12 +0.04 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.62 +0.04 +0.06 +0.04 +0.02 +0.01 +0.05 +0.05 +0.27 +0.02 +0.09 +0.02 +0.09 +0.03 +0.12 +0.12 +0.20 +0.20 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.02 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +-0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.01 +0.00 +0.06 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.03 +0.00 +0.00 +0.02 +0.01 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.02 +0.01 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.06 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.01 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.03 +0.02 +0.01 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.02 +0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.02 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.04 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.01 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.14 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.01 +0.00 +0.01 +0.00 +-0.01 +-0.01 +0.00 +0.03 +0.00 +0.03 +0.00 +0.01 +0.00 +0.00 +0.00 +0.01 +0.00 +-0.02 +-0.01 +0.00 +0.03 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +-0.02 +0.00 +0.03 +-0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +-0.01 +-0.01 +0.00 +0.01 +0.07 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +-0.02 +0.00 +0.00 +0.00 +0.03 +0.21 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.03 +0.00 +0.00 +0.00 +0.02 +0.00 +0.03 +-0.02 +0.00 +0.01 +0.01 +0.05 +0.00 +-0.01 +0.00 +0.00 +0.00 +-0.01 +-0.03 +0.00 +0.01 +0.01 +0.05 +0.07 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +0.03 +0.21 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.03 +0.00 +0.00 +0.02 +0.03 +0.00 +0.01 +-0.02 +0.01 +0.05 +0.00 +0.00 +0.00 +-0.01 +0.00 +-0.01 +0.00 +0.01 +-0.03 +0.01 +0.05 +0.10 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +0.00 +0.00 +0.01 +0.02 +0.01 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.05 +0.33 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.03 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.01 +0.03 +0.05 +0.03 +0.05 +0.05 +0.45 +0.09 +0.14 +0.02 +0.09 +0.04 +0.20 +0.03 +0.06 +0.04 +0.20 +0.06 +0.03 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.02 +0.00 +0.02 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.05 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +-0.01 +0.00 +0.00 +-0.01 +0.00 +0.00 +-0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.03 +0.00 +0.00 +0.03 +0.01 +0.03 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.02 +-0.01 +0.02 +0.01 +0.11 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.02 +0.00 +-0.01 +0.00 +0.01 +0.00 +-0.01 +0.06 +0.03 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +0.00 +-0.01 +0.03 +0.01 +0.03 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.02 +0.02 +-0.01 +0.00 +0.01 +0.11 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +-0.01 +0.02 +0.00 +0.00 +0.01 +-0.01 +0.03 +-0.01 +0.06 +0.00 +0.01 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +-0.02 +0.03 +-0.01 +0.00 +0.01 +0.17 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.01 +0.00 +0.00 +-0.01 +0.00 +-0.01 +-0.03 +0.00 +0.03 +0.00 +0.00 +0.02 +0.03 +0.01 +0.01 +0.01 +0.09 +0.11 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.02 +-0.01 +0.02 +-0.01 +0.01 +-0.03 +0.01 +0.05 +0.35 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.03 +0.01 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.01 +0.00 +0.01 +0.00 +0.00 +0.03 +0.01 +0.01 +0.00 +-0.01 +0.06 +-0.01 +0.06 +0.01 +-0.03 +0.01 +0.09 +0.00 +0.00 +-0.01 +0.01 +0.00 +-0.01 +-0.01 +0.01 +-0.06 +0.01 +0.09 +0.17 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +-0.01 +-0.03 +0.00 +0.00 +0.02 +0.00 +0.00 +0.01 +0.00 +0.03 +0.02 +0.03 +0.00 +0.00 +0.01 +0.01 +0.01 +0.09 +0.55 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.05 +0.00 +0.00 +0.01 +0.00 +0.01 +0.05 +0.00 +0.01 +0.01 +0.01 +0.01 +0.01 +0.09 +0.05 +0.09 +0.09 +0.45 +0.14 +0.09 +0.02 +0.09 +0.03 +0.04 +0.20 +0.06 +0.04 +0.20 +0.06 +0.03 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.01 +0.00 +0.02 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.03 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.02 +-0.01 +0.00 +0.02 +0.01 +0.11 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +-0.01 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +-0.01 +0.00 +0.00 +0.01 +-0.01 +0.06 +0.00 +0.03 +0.01 +-0.02 +0.00 +0.00 +-0.01 +0.00 +0.03 +0.01 +0.05 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +-0.01 +0.00 +0.00 +-0.01 +0.00 +0.00 +-0.01 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.03 +0.03 +0.01 +0.03 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.02 +-0.01 +0.02 +0.00 +0.01 +0.11 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +-0.01 +0.00 +0.00 +0.00 +-0.01 +0.02 +0.00 +0.01 +0.00 +-0.01 +-0.01 +0.06 +0.03 +0.00 +0.01 +0.00 +0.00 +-0.02 +-0.01 +0.03 +0.00 +0.01 +0.11 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.02 +-0.01 +0.00 +0.02 +-0.01 +-0.03 +0.01 +0.01 +0.05 +0.35 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.03 +0.00 +0.01 +0.00 +-0.01 +0.00 +0.01 +0.00 +0.01 +0.00 +0.00 +0.03 +0.01 +0.00 +0.00 +-0.01 +0.01 +0.01 +-0.01 +0.06 +0.00 +-0.01 +0.06 +-0.03 +0.01 +0.01 +0.09 +-0.01 +0.00 +-0.01 +-0.06 +0.01 +0.01 +0.09 +0.17 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.01 +0.00 +0.00 +-0.01 +0.00 +-0.01 +-0.03 +0.00 +0.00 +0.00 +0.03 +0.02 +0.03 +0.01 +0.01 +0.01 +0.09 +0.17 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.01 +-0.01 +-0.03 +0.00 +0.00 +0.02 +0.00 +0.00 +0.01 +0.00 +0.02 +0.03 +0.03 +0.00 +0.00 +0.01 +0.01 +0.01 +0.09 +0.55 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.01 +0.05 +0.00 +0.00 +0.01 +0.00 +0.01 +0.05 +0.00 +0.01 +0.01 +0.01 +0.01 +0.01 +0.05 +0.09 +0.09 +0.09 +0.08 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +-0.01 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +-0.01 +0.01 +0.01 +0.04 +0.00 +0.04 +0.02 +0.08 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +-0.01 +0.00 +0.00 +0.00 +-0.02 +0.00 +-0.01 +0.01 +0.00 +0.00 +0.00 +0.01 +0.01 +0.00 +0.04 +0.04 +0.02 +0.08 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +-0.01 +0.00 +0.00 +-0.02 +-0.01 +0.01 +0.01 +0.04 +0.04 +0.00 +0.02 +0.27 +0.01 +0.00 +0.00 +0.00 +0.00 +-0.01 +0.00 +0.03 +0.00 +0.01 +0.00 +-0.01 +0.00 +0.00 +0.03 +0.01 +0.00 +-0.01 +-0.01 +-0.06 +0.04 +0.00 +0.04 +0.02 +0.02 +0.14 +0.27 +0.01 +0.00 +0.00 +-0.01 +0.00 +0.00 +0.00 +0.00 +0.03 +0.01 +0.00 +-0.01 +0.00 +-0.01 +-0.01 +-0.06 +0.00 +0.00 +0.03 +0.01 +0.00 +0.04 +0.04 +0.02 +0.02 +0.14 +0.27 +0.01 +0.00 +0.00 +-0.01 +0.00 +-0.01 +0.00 +-0.01 +-0.01 +-0.06 +0.00 +0.00 +0.00 +0.03 +0.00 +0.01 +0.00 +0.03 +0.00 +0.01 +0.04 +0.04 +0.00 +0.02 +0.02 +0.14 +0.91 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.01 +0.00 +0.01 +0.01 +0.09 +0.00 +0.01 +0.00 +0.01 +0.01 +0.09 +0.00 +0.01 +0.01 +0.09 +0.02 +0.02 +0.02 +0.14 +0.14 +0.14 +16.03 +1.29 +1.29 +-3.87 +1.29 +-3.87 +-3.87 +-5.54 +0.00 +0.00 +0.00 +0.10 +-0.62 +-0.62 +-0.74 +0.01 +0.01 +-0.87 +3.73 +-0.50 +-0.50 +-0.02 +-0.50 +-0.02 +-0.02 +0.09 +-0.41 +0.37 +-0.41 +0.37 +0.37 +-0.22 +0.37 +-0.22 +-0.41 +0.37 +0.37 +-0.22 +-0.75 +0.37 +-0.75 +0.37 +-0.75 +0.37 +-0.53 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.10 +0.00 +0.00 +0.01 +0.06 +-0.03 +0.06 +-0.03 +0.08 +-0.13 +-0.13 +-0.01 +-0.09 +0.00 +0.08 +0.10 +0.08 +-0.05 +-0.09 +0.10 +-0.28 +-0.27 +0.12 +-0.27 +0.12 +-0.25 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +19.02 +1.29 +-3.87 +0.27 +-3.87 +0.27 +-5.54 +-7.57 +5.60 +-0.50 +-0.02 +-0.94 +-0.02 +-0.94 +0.09 +-0.09 +0.37 +-0.99 +0.25 +0.53 +-0.22 +0.84 +0.53 +-0.44 +0.37 +-0.99 +-0.22 +0.84 +0.37 +-1.63 +-1.60 +0.85 +-1.60 +0.85 +-1.29 +79.51 +1.29 +-3.87 +3.77 +-3.87 +-5.54 +4.05 +-18.10 +1.29 +-3.87 +3.77 +-3.87 +-5.54 +-18.10 +-10.53 +-15.05 +0.00 +0.00 +0.00 +-1.03 +0.00 +0.00 +-1.22 +0.02 +-1.44 +0.02 +-1.44 +-0.24 +20.96 +-0.50 +-0.02 +-2.31 +-0.02 +0.09 +-3.25 +-0.15 +0.25 +0.53 +0.37 +-2.09 +0.53 +-0.44 +-0.22 +1.85 +0.37 +-0.22 +-3.08 +1.85 +-1.60 +0.85 +0.37 +-3.67 +-1.60 +0.85 +-1.29 +-0.50 +-0.02 +-2.31 +-0.02 +0.09 +-0.15 +0.37 +-2.09 +0.25 +0.53 +-0.22 +1.85 +0.53 +-0.44 +0.37 +-0.22 +1.85 +0.37 +-3.67 +-1.60 +0.85 +-1.60 +0.85 +-1.29 +-0.06 +0.24 +1.01 +1.01 +-0.61 +-0.61 +-0.61 +1.01 +1.01 +-2.04 +1.01 +-1.43 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.06 +0.00 +0.00 +-0.21 +-0.01 +0.00 +0.13 +0.00 +-0.08 +0.16 +0.00 +0.19 +0.00 +0.00 +0.00 +-0.21 +-0.01 +0.00 +0.13 +0.00 +-0.08 +0.16 +0.00 +0.19 +0.00 +0.00 +0.00 +-0.29 +-0.02 +-0.02 +0.20 +0.20 +-0.25 +-0.66 +-0.66 +-0.61 +0.28 +-0.62 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +78.27 +-3.87 +0.27 +3.77 +-5.54 +-7.57 +-18.10 +-1.84 +-10.53 +-15.05 +0.74 +-20.57 +26.33 +-0.02 +-0.94 +-2.31 +0.09 +-0.09 +-0.15 +-4.28 +0.53 +0.16 +0.53 +0.84 +-0.44 +1.27 +-0.44 +2.72 +-0.22 +0.84 +1.85 +-5.03 +0.85 +-3.51 +0.85 +-7.85 +-2.98 +1.84 +-3.07 +-0.06 +0.24 +1.01 +-0.61 +-0.61 +1.01 +-2.56 +-0.25 +-2.68 +1.45 +2.27 +-1.20 +2.27 +-4.44 +2.31 +-4.34 +2.31 +-3.50 +79.51 +1.29 +-3.87 +-3.87 +-5.54 +3.77 +4.05 +-18.10 +0.00 +-3.87 +1.29 +-3.87 +3.77 +-5.54 +-18.10 +-10.53 +-15.05 +0.00 +0.00 +0.00 +-1.03 +0.00 +-1.22 +0.02 +-1.44 +0.02 +-1.44 +-0.24 +20.96 +-0.50 +-0.02 +-0.02 +0.09 +-2.31 +-3.25 +-0.15 +0.37 +-0.22 +0.37 +-0.22 +-3.08 +1.85 +-2.09 +1.85 +0.25 +0.53 +0.53 +-0.44 +-1.60 +0.85 +-1.60 +0.85 +0.37 +-3.67 +-1.29 +0.00 +-0.02 +0.00 +0.53 +0.00 +0.00 +-0.50 +-0.02 +-2.31 +0.09 +-0.15 +0.37 +0.25 +-0.22 +1.85 +0.53 +-0.44 +0.37 +-2.09 +-0.22 +1.85 +0.37 +-3.67 +-1.60 +0.85 +-1.60 +0.85 +-1.29 +-0.06 +0.24 +-0.61 +1.01 +-0.61 +1.01 +-0.61 +1.01 +-2.04 +1.01 +1.01 +-1.43 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +-0.06 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.21 +-0.01 +0.00 +0.00 +0.16 +0.13 +-0.08 +0.00 +0.00 +0.00 +0.19 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.21 +-0.01 +0.16 +0.00 +0.13 +0.00 +-0.08 +0.00 +0.19 +0.00 +0.00 +0.00 +-0.29 +-0.25 +-0.02 +0.20 +-0.02 +0.20 +-0.66 +-0.61 +0.28 +-0.66 +-0.62 +0.00 +0.00 +0.00 +0.00 +78.27 +-3.87 +0.27 +-5.54 +-7.57 +3.77 +-18.10 +-1.84 +-10.53 +-15.05 +0.74 +-20.57 +26.33 +-0.02 +-0.94 +0.09 +-0.09 +-2.31 +-0.15 +-4.28 +-0.22 +0.84 +0.53 +-0.44 +1.85 +-5.03 +0.84 +2.72 +0.53 +0.16 +-0.44 +1.27 +0.85 +-3.51 +-2.98 +1.84 +0.85 +-7.85 +-3.07 +-0.06 +0.24 +-0.61 +1.01 +-0.61 +1.01 +-2.56 +-0.25 +2.27 +1.45 +-1.20 +-2.68 +2.27 +-4.44 +-4.34 +2.31 +2.31 +-3.50 +343.37 +-3.87 +-5.54 +4.05 +-18.10 +4.05 +-18.10 +8.42 +-3.87 +-5.54 +-18.10 +4.05 +-18.10 +8.42 +-15.05 +-49.19 +-3.87 +-5.54 +-18.10 +-18.10 +8.42 +-15.05 +-49.19 +-15.05 +-49.19 +-40.91 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-2.01 +-2.37 +-2.37 +-0.40 +-2.37 +-0.40 +-0.40 +104.71 +-0.02 +0.09 +-3.25 +-0.15 +-3.25 +-0.15 +-10.56 +0.53 +-0.44 +-0.22 +1.85 +1.00 +2.72 +1.85 +-10.72 +0.53 +-0.44 +1.00 +2.72 +-2.98 +1.84 +0.85 +-7.85 +0.85 +-7.85 +-3.07 +-0.02 +0.09 +-0.15 +-3.25 +-0.15 +-10.56 +-0.22 +1.85 +0.53 +-0.44 +1.85 +-10.72 +1.00 +2.72 +0.53 +-0.44 +2.72 +0.85 +-7.85 +-2.98 +1.84 +0.85 +-7.85 +-3.07 +0.24 +-0.40 +-0.61 +-0.61 +5.03 +5.03 +-1.20 +2.31 +2.31 +1.01 +-9.98 +-3.50 +-0.02 +0.09 +-0.15 +-0.15 +-10.56 +0.53 +0.53 +-0.44 +2.72 +-0.44 +2.72 +-0.22 +1.85 +1.85 +-10.72 +0.85 +-7.85 +0.85 +-7.85 +-2.98 +1.84 +-3.07 +0.24 +-0.40 +-1.20 +-0.61 +5.03 +-0.61 +5.03 +2.31 +1.01 +-9.98 +2.31 +-3.50 +0.24 +-0.40 +-0.61 +5.03 +-1.20 +-0.61 +5.03 +1.01 +-9.98 +2.31 +2.31 +-3.50 +0.65 +-1.66 +-1.66 +-1.66 +2.74 +2.74 +2.74 +-3.88 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.03 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +0.00 +0.00 +-0.13 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.00 +0.00 +0.00 +-0.13 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.48 +0.32 +0.32 +0.00 +0.47 +0.00 +-0.02 +0.00 +0.00 +0.00 +-0.13 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.48 +0.32 +0.32 +0.00 +0.47 +0.00 +-0.48 +0.32 +0.32 +0.00 +0.47 +0.00 +-0.14 +-0.14 +-0.14 +-1.51 +-1.51 +-1.51 +-1.54 +321.02 +-5.54 +-7.57 +-18.10 +-1.84 +-18.10 +-1.84 +8.42 +-15.05 +-49.19 +-20.57 +-5.01 +-15.05 +-49.19 +-20.57 +-5.01 +-40.91 +-55.90 +123.85 +0.09 +-0.09 +-0.15 +-4.28 +-0.15 +-4.28 +-10.56 +-0.44 +1.27 +-0.44 +2.72 +2.72 +0.00 +2.72 +2.28 +-0.44 +1.27 +2.72 +0.00 +1.84 +-6.71 +1.84 +-14.82 +1.84 +-14.82 +-7.02 +0.24 +-0.40 +-0.61 +5.03 +-1.20 +2.31 +-0.25 +-11.64 +2.27 +-1.20 +-13.68 +7.39 +3.44 +-9.55 +4.99 +2.31 +-21.33 +-8.35 +0.24 +-0.40 +-1.20 +-0.61 +5.03 +2.31 +-0.25 +-11.64 +3.44 +-1.20 +7.39 +2.27 +-13.68 +-9.55 +2.31 +-21.33 +4.99 +-8.35 +0.65 +-1.66 +-1.66 +2.74 +-0.67 +6.18 +-3.26 +6.18 +-12.07 +6.29 +6.29 +-9.53 +13.94 +-0.41 +0.37 +0.25 +0.53 +0.37 +-0.22 +0.53 +-0.44 +-2.01 +-0.75 +-1.60 +-2.01 +-0.48 +0.37 +0.85 +-0.75 +0.37 +-1.60 +0.85 +-3.35 +2.56 +-0.53 +-1.29 +-3.35 +2.56 +-4.77 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +27.52 +0.37 +-0.99 +0.53 +0.16 +-0.22 +0.84 +-0.44 +1.27 +-2.01 +-1.60 +-2.98 +-0.48 +-3.52 +0.85 +1.84 +0.37 +-1.63 +0.85 +-3.51 +2.56 +-7.83 +-1.29 +-3.07 +-1.33 +4.18 +-10.44 +13.94 +-0.41 +0.25 +0.37 +0.53 +0.37 +0.53 +-0.22 +-0.44 +-0.75 +-1.60 +-2.01 +0.37 +0.85 +-2.01 +-0.48 +-0.75 +-1.60 +0.37 +0.85 +-0.53 +-1.29 +-3.35 +2.56 +-3.35 +2.56 +-4.77 +65.43 +0.37 +0.53 +-2.09 +0.84 +-0.22 +-0.44 +1.85 +2.72 +-1.60 +-2.98 +-2.01 +0.85 +1.84 +-0.48 +-8.99 +0.37 +0.85 +-3.67 +-7.85 +-1.29 +-3.07 +2.56 +-16.95 +-1.33 +4.18 +-10.44 +1.01 +-0.61 +-2.04 +1.01 +1.01 +-1.43 +1.45 +-1.20 +-4.34 +-5.47 +2.31 +-1.30 +2.31 +-3.50 +6.95 +-9.12 +6.95 +-12.98 +92.95 +0.37 +-0.22 +0.53 +-0.44 +-3.08 +1.85 +1.00 +2.72 +-2.01 +-0.48 +0.37 +0.85 +-8.99 +-3.67 +-7.85 +-1.60 +0.85 +-2.98 +1.84 +-1.33 +4.18 +-1.29 +-3.07 +2.56 +-16.95 +-10.44 +0.00 +0.53 +0.00 +-2.98 +0.00 +0.00 +0.37 +-0.22 +1.85 +-0.44 +2.72 +-2.01 +-1.60 +-0.48 +-8.99 +0.85 +1.84 +0.37 +-3.67 +0.85 +-7.85 +2.56 +-16.95 +-1.29 +-3.07 +-1.33 +4.18 +-10.44 +-0.61 +-1.20 +-1.30 +1.01 +2.31 +1.01 +2.31 +6.95 +-1.43 +-3.50 +6.95 +-12.98 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +128.89 +-0.22 +0.84 +-0.44 +1.27 +1.85 +-5.03 +2.72 +0.00 +-0.48 +-3.52 +0.85 +1.84 +-8.99 +-7.85 +-14.82 +0.85 +-3.51 +1.84 +-6.71 +4.18 +-4.95 +-3.07 +-7.02 +4.18 +-8.57 +-20.61 +-0.61 +-1.20 +-1.30 +1.01 +2.31 +6.95 +2.27 +3.44 +-9.57 +2.31 +4.99 +-4.44 +-9.55 +-21.29 +-3.50 +-8.35 +11.37 +-28.37 +65.43 +0.37 +0.53 +-0.22 +-0.44 +-2.09 +0.84 +1.85 +2.72 +0.37 +0.85 +-2.01 +-0.48 +-3.67 +-7.85 +-8.99 +-1.60 +-2.98 +0.85 +1.84 +-1.29 +-3.07 +-1.33 +4.18 +2.56 +-16.95 +-10.44 +1.01 +-0.61 +1.01 +-2.04 +1.01 +-1.43 +1.45 +-1.20 +2.31 +-5.47 +-1.30 +-4.34 +2.31 +-3.50 +-9.12 +6.95 +6.95 +-12.98 +306.74 +-0.22 +-0.44 +1.85 +2.72 +1.85 +2.72 +-10.72 +2.28 +0.85 +1.84 +-0.48 +-8.99 +-7.85 +-14.82 +-8.99 +0.85 +1.84 +-7.85 +-14.82 +-3.07 +-7.02 +4.18 +-8.57 +4.18 +-8.57 +-20.61 +-0.61 +5.03 +1.01 +-9.98 +2.31 +-3.50 +-1.20 +7.39 +2.31 +-1.30 +-21.33 +-24.43 +4.99 +-8.35 +11.37 +6.95 +-46.07 +-28.37 +-0.61 +5.03 +2.31 +1.01 +-9.98 +-3.50 +-1.20 +7.39 +4.99 +-1.30 +-24.43 +2.31 +-21.33 +-8.35 +6.95 +-46.07 +11.37 +-28.37 +-1.66 +2.74 +2.74 +-3.88 +-3.26 +6.29 +-3.54 +6.29 +-9.53 +18.88 +18.88 +-35.27 +13.94 +-0.41 +0.37 +0.37 +-0.22 +0.25 +0.53 +0.53 +-0.44 +-0.75 +0.37 +-0.75 +0.37 +-1.60 +0.85 +-1.60 +0.85 +-2.01 +-2.01 +-0.48 +-3.35 +2.56 +-3.35 +2.56 +-0.53 +-1.29 +-4.77 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +27.52 +0.37 +-0.99 +-0.22 +0.84 +0.53 +0.16 +-0.44 +1.27 +0.37 +-1.63 +-1.60 +0.85 +0.85 +-3.51 +-2.98 +1.84 +-2.01 +-0.48 +-3.52 +2.56 +-7.83 +-1.33 +4.18 +-1.29 +-3.07 +-10.44 +92.95 +0.37 +-0.22 +-3.08 +1.85 +0.53 +-0.44 +1.00 +2.72 +-1.60 +0.85 +0.37 +-3.67 +-2.98 +1.84 +0.85 +-7.85 +-2.01 +-0.48 +-8.99 +-1.33 +4.18 +2.56 +-16.95 +-1.29 +-3.07 +-10.44 +0.37 +-0.22 +1.85 +0.53 +-0.44 +2.72 +0.37 +-3.67 +-1.60 +0.85 +0.85 +-7.85 +-2.98 +1.84 +-2.01 +-0.48 +-8.99 +2.56 +-16.95 +-1.33 +4.18 +-1.29 +-3.07 +-10.44 +-0.61 +-1.20 +1.01 +1.01 +2.31 +2.31 +-1.30 +6.95 +6.95 +-1.43 +-3.50 +-12.98 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +128.89 +-0.22 +0.84 +1.85 +-5.03 +-0.44 +1.27 +2.72 +0.00 +0.85 +-3.51 +0.85 +-7.85 +1.84 +-6.71 +1.84 +-14.82 +-0.48 +-3.52 +-8.99 +4.18 +-4.95 +4.18 +-8.57 +-3.07 +-7.02 +-20.61 +-0.61 +-1.20 +1.01 +2.31 +-1.30 +6.95 +2.27 +3.44 +-4.44 +2.31 +-9.55 +4.99 +-9.57 +-21.29 +11.37 +-3.50 +-8.35 +-28.37 +67.11 +-0.75 +0.37 +-1.60 +0.85 +-1.60 +0.85 +-2.98 +1.84 +-3.35 +2.56 +-0.53 +-1.29 +-1.33 +4.18 +-1.29 +-3.07 +-3.35 +2.56 +-1.33 +4.18 +-6.26 +-4.77 +-10.44 +-4.77 +-10.44 +-25.35 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +130.48 +0.37 +-1.63 +0.85 +-3.51 +0.85 +-3.51 +1.84 +-6.71 +2.56 +-7.83 +-1.29 +-3.07 +4.18 +-4.95 +-3.07 +-7.02 +2.56 +-7.83 +4.18 +-4.95 +-6.26 +-10.44 +-20.61 +-10.44 +-20.61 +-24.13 +67.11 +-0.75 +-1.60 +0.37 +0.85 +-1.60 +-2.98 +0.85 +1.84 +-0.53 +-1.29 +-3.35 +2.56 +-1.29 +-3.07 +-1.33 +4.18 +-3.35 +-1.33 +2.56 +4.18 +-4.77 +-10.44 +-6.26 +-4.77 +-10.44 +-25.35 +312.91 +0.37 +0.85 +-3.67 +-7.85 +0.85 +1.84 +-7.85 +-14.82 +-1.29 +-3.07 +2.56 +-16.95 +-3.07 +-7.02 +4.18 +-8.57 +2.56 +4.18 +-16.95 +-8.57 +-10.44 +-20.61 +-6.26 +-10.44 +-20.61 +-24.13 +1.01 +2.31 +-1.43 +-3.50 +6.95 +-12.98 +2.31 +4.99 +-3.50 +6.95 +-8.35 +11.37 +11.37 +-28.37 +-17.02 +-12.98 +-28.37 +-68.90 +67.11 +-0.75 +-1.60 +-1.60 +-2.98 +0.37 +0.85 +0.85 +1.84 +-3.35 +-1.33 +-3.35 +-1.33 +2.56 +4.18 +2.56 +4.18 +-0.53 +-1.29 +-1.29 +-3.07 +-4.77 +-10.44 +-4.77 +-10.44 +-6.26 +-25.35 +312.91 +0.37 +0.85 +0.85 +1.84 +-3.67 +-7.85 +-7.85 +-14.82 +2.56 +4.18 +2.56 +4.18 +-16.95 +-8.57 +-16.95 +-8.57 +-1.29 +-3.07 +-3.07 +-7.02 +-10.44 +-20.61 +-10.44 +-20.61 +-6.26 +-24.13 +1.01 +2.31 +6.95 +-1.43 +-3.50 +-12.98 +2.31 +4.99 +11.37 +6.95 +11.37 +-3.50 +-8.35 +-28.37 +-12.98 +-28.37 +-17.02 +-68.90 +307.83 +-0.53 +-1.29 +-1.29 +-3.07 +-1.29 +-3.07 +-3.07 +-7.02 +-4.77 +-10.44 +-4.77 +-10.44 +-10.44 +-20.61 +-10.44 +-20.61 +-4.77 +-10.44 +-10.44 +-20.61 +-25.35 +-24.13 +-25.35 +-24.13 +-25.35 +-24.13 +16.03 +0.00 +1.29 +0.00 +-3.87 +1.29 +-3.87 +1.29 +-3.87 +-5.54 +0.00 +0.10 +-0.62 +-0.62 +-0.74 +0.01 +0.01 +-0.87 +3.73 +0.00 +-0.50 +0.00 +-0.02 +0.00 +0.00 +0.00 +0.37 +0.00 +-0.50 +-0.02 +-0.50 +-0.02 +0.09 +-0.41 +0.37 +-0.41 +0.37 +0.37 +-0.22 +0.37 +-0.22 +-0.41 +0.37 +-0.22 +-0.75 +0.37 +-0.75 +0.37 +-0.75 +0.37 +-0.53 +0.00 +0.00 +0.00 +0.00 +-0.10 +0.00 +0.00 +0.01 +0.06 +-0.03 +0.06 +-0.03 +0.08 +0.00 +0.00 +0.00 +-0.13 +-0.13 +-0.01 +0.00 +0.08 +-0.09 +0.08 +-0.05 +0.10 +-0.09 +0.10 +-0.27 +0.12 +-0.28 +-0.27 +0.12 +-0.25 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +19.02 +-3.87 +-5.54 +1.29 +0.27 +-3.87 +0.27 +-7.57 +5.60 +-0.02 +0.09 +-0.22 +-0.50 +-0.94 +-0.02 +-0.94 +-0.09 +0.25 +0.53 +0.37 +-0.99 +0.53 +-0.44 +-0.22 +0.84 +0.37 +-0.99 +0.84 +-1.60 +0.85 +0.37 +-1.63 +-1.60 +0.85 +-1.29 +78.27 +3.77 +-10.53 +-18.10 +-15.05 +-3.87 +0.27 +-5.54 +-7.57 +-1.84 +0.74 +-20.57 +26.33 +-2.31 +-0.06 +-0.15 +0.24 +1.01 +-0.61 +1.85 +-0.61 +1.01 +-0.02 +-0.94 +0.09 +-0.09 +-4.28 +0.53 +0.84 +0.53 +0.16 +-0.44 +2.72 +-0.44 +1.27 +-0.22 +0.84 +-5.03 +0.85 +-7.85 +0.85 +-3.51 +-2.98 +1.84 +-3.07 +-2.56 +-0.25 +1.45 +-2.68 +-1.20 +2.27 +2.27 +2.31 +-4.44 +-4.34 +2.31 +-3.50 +79.51 +0.00 +-3.87 +-3.87 +4.05 +1.29 +-3.87 +-5.54 +3.77 +-18.10 +1.29 +-3.87 +-5.54 +3.77 +-18.10 +-10.53 +-15.05 +0.00 +0.00 +0.00 +0.00 +-1.03 +-1.22 +0.02 +-1.44 +0.02 +-1.44 +-0.24 +20.96 +0.00 +-0.02 +-0.02 +-3.25 +0.00 +0.53 +0.00 +0.53 +0.00 +-0.50 +-0.02 +0.09 +-2.31 +-0.15 +0.37 +-0.22 +0.37 +-0.22 +-2.09 +1.85 +-3.08 +1.85 +0.25 +0.53 +-0.44 +-1.60 +0.85 +-1.60 +0.85 +0.37 +-3.67 +-1.29 +-0.50 +-0.02 +0.09 +-2.31 +-0.15 +0.25 +0.37 +0.53 +-0.44 +-0.22 +1.85 +0.37 +-0.22 +-2.09 +1.85 +-1.60 +0.85 +0.37 +-3.67 +-1.60 +0.85 +-1.29 +-0.06 +0.24 +1.01 +-0.61 +-0.61 +1.01 +-0.61 +-2.04 +1.01 +1.01 +1.01 +-1.43 +0.00 +0.00 +0.00 +0.00 +0.00 +0.02 +0.00 +0.00 +0.00 +0.00 +-0.06 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.21 +-0.01 +0.00 +0.00 +0.13 +-0.08 +0.16 +0.00 +0.00 +0.00 +0.19 +0.00 +0.00 +0.00 +0.00 +-0.21 +-0.01 +0.16 +0.00 +0.00 +0.13 +-0.08 +0.00 +0.00 +0.00 +0.19 +0.00 +0.00 +0.00 +0.00 +-0.29 +-0.02 +0.20 +-0.25 +-0.02 +0.20 +-0.61 +0.28 +-0.66 +-0.66 +-0.62 +0.00 +78.27 +-5.54 +-18.10 +-3.87 +0.27 +-7.57 +3.77 +-1.84 +-10.53 +-15.05 +0.74 +-20.57 +26.33 +0.09 +-0.15 +-0.44 +-0.02 +-0.94 +-0.09 +-2.31 +-4.28 +0.53 +-0.44 +-0.22 +0.84 +0.84 +2.72 +1.85 +-5.03 +0.53 +0.16 +1.27 +-2.98 +1.84 +0.85 +-3.51 +0.85 +-7.85 +-3.07 +-0.06 +0.24 +-0.61 +1.01 +-0.61 +1.01 +-2.56 +-0.25 +1.45 +-1.20 +2.27 +-2.68 +2.27 +-4.34 +2.31 +-4.44 +2.31 +-3.50 +321.02 +-18.10 +-15.05 +8.42 +-49.19 +-5.54 +-7.57 +-1.84 +-18.10 +-1.84 +-20.57 +-5.01 +-15.05 +-49.19 +-40.91 +-20.57 +-5.01 +-55.90 +123.85 +-0.15 +0.24 +-10.56 +-0.40 +-0.61 +5.03 +2.72 +-1.20 +2.31 +0.09 +-0.09 +-4.28 +-0.15 +-4.28 +-0.44 +2.72 +-0.44 +1.27 +2.72 +2.28 +2.72 +0.00 +-0.44 +1.27 +0.00 +1.84 +-14.82 +1.84 +-6.71 +1.84 +-14.82 +-7.02 +-0.25 +-11.64 +-1.20 +2.27 +7.39 +-13.68 +3.44 +4.99 +-9.55 +2.31 +-21.33 +-8.35 +0.24 +-0.40 +-1.20 +-0.61 +5.03 +2.31 +0.65 +-1.66 +-1.66 +2.74 +-0.25 +-11.64 +-1.20 +7.39 +3.44 +2.27 +-13.68 +2.31 +-21.33 +-9.55 +4.99 +-8.35 +-0.67 +-3.26 +6.18 +6.18 +6.29 +-12.07 +6.29 +-9.53 +13.94 +0.37 +-0.22 +0.37 +-0.41 +0.25 +0.53 +0.37 +0.53 +-0.44 +-2.01 +-0.75 +-1.60 +-2.01 +-0.48 +0.37 +0.85 +-0.75 +-1.60 +0.85 +-3.35 +2.56 +-0.53 +-1.29 +-3.35 +2.56 +-4.77 +65.43 +-2.09 +1.01 +1.85 +-0.61 +-2.04 +1.01 +-3.67 +1.01 +-1.43 +0.37 +0.53 +0.84 +-0.22 +-0.44 +2.72 +-2.01 +-1.60 +-2.98 +-0.48 +-8.99 +0.85 +1.84 +0.37 +0.85 +-7.85 +2.56 +-16.95 +-1.29 +-3.07 +-1.33 +4.18 +-10.44 +1.45 +-1.20 +-5.47 +-4.34 +-1.30 +2.31 +2.31 +6.95 +-3.50 +-9.12 +6.95 +-12.98 +13.94 +0.00 +0.25 +0.00 +0.53 +0.00 +0.00 +0.00 +-1.60 +0.00 +-0.41 +0.37 +0.53 +0.37 +-0.22 +-0.44 +-0.75 +-1.60 +-2.01 +0.37 +0.85 +-2.01 +-0.48 +-0.75 +0.37 +0.85 +-0.53 +-1.29 +-3.35 +2.56 +-3.35 +2.56 +-4.77 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +27.52 +0.53 +-0.44 +0.85 +0.37 +-0.99 +0.16 +-0.22 +0.84 +1.27 +-1.60 +-2.98 +-2.01 +0.85 +1.84 +-0.48 +-3.52 +0.37 +-1.63 +-3.51 +-1.29 +-3.07 +2.56 +-7.83 +-1.33 +4.18 +-10.44 +65.43 +-0.22 +1.85 +0.85 +0.37 +0.53 +-0.44 +-2.09 +0.84 +2.72 +-2.01 +-0.48 +0.37 +0.85 +-8.99 +-3.67 +-7.85 +-1.60 +-2.98 +1.84 +-1.33 +4.18 +-1.29 +-3.07 +2.56 +-16.95 +-10.44 +1.01 +-0.61 +1.01 +-2.04 +1.01 +-1.43 +1.45 +-1.20 +-5.47 +-1.30 +2.31 +-4.34 +2.31 +-9.12 +6.95 +-3.50 +6.95 +-12.98 +306.74 +1.85 +-0.61 +-10.72 +5.03 +1.01 +-9.98 +-7.85 +2.31 +-3.50 +-0.22 +-0.44 +2.72 +1.85 +2.72 +2.28 +-0.48 +-8.99 +0.85 +1.84 +-8.99 +-7.85 +-14.82 +0.85 +1.84 +-14.82 +4.18 +-8.57 +-3.07 +-7.02 +4.18 +-8.57 +-20.61 +-1.20 +7.39 +-1.30 +2.31 +-24.43 +-21.33 +4.99 +11.37 +-8.35 +6.95 +-46.07 +-28.37 +-0.61 +5.03 +2.31 +1.01 +-9.98 +-3.50 +-1.66 +2.74 +2.74 +-3.88 +-1.20 +7.39 +-1.30 +-24.43 +4.99 +2.31 +-21.33 +6.95 +-46.07 +-8.35 +11.37 +-28.37 +-3.26 +-3.54 +6.29 +6.29 +18.88 +-9.53 +18.88 +-35.27 +92.95 +0.00 +0.53 +0.53 +1.00 +0.00 +-2.98 +0.00 +-2.98 +0.00 +0.37 +-0.22 +-0.44 +-3.08 +1.85 +2.72 +0.37 +0.85 +-2.01 +-0.48 +-3.67 +-7.85 +-8.99 +-1.60 +0.85 +1.84 +-1.29 +-3.07 +-1.33 +4.18 +2.56 +-16.95 +-10.44 +0.37 +-0.22 +-0.44 +1.85 +2.72 +-1.60 +-2.01 +0.85 +1.84 +-0.48 +-8.99 +0.37 +0.85 +-3.67 +-7.85 +-1.29 +-3.07 +2.56 +-16.95 +-1.33 +4.18 +-10.44 +-0.61 +-1.20 +1.01 +2.31 +-1.30 +1.01 +2.31 +-1.43 +-3.50 +6.95 +6.95 +-12.98 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +128.89 +-0.44 +2.72 +1.84 +-0.22 +0.84 +1.27 +1.85 +-5.03 +0.00 +0.85 +1.84 +-0.48 +-3.52 +-7.85 +-14.82 +-8.99 +0.85 +-3.51 +-6.71 +-3.07 +-7.02 +4.18 +-4.95 +4.18 +-8.57 +-20.61 +-0.61 +-1.20 +-1.30 +1.01 +2.31 +6.95 +2.27 +3.44 +2.31 +4.99 +-9.57 +-4.44 +-9.55 +-3.50 +-8.35 +-21.29 +11.37 +-28.37 +13.94 +0.00 +0.37 +0.00 +0.53 +0.00 +0.00 +0.00 +-2.01 +0.00 +-0.41 +0.37 +-0.22 +0.25 +0.53 +-0.44 +-0.75 +0.37 +-0.75 +0.37 +-1.60 +0.85 +-1.60 +0.85 +-2.01 +-0.48 +-3.35 +2.56 +-3.35 +2.56 +-0.53 +-1.29 +-4.77 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +27.52 +-0.22 +-0.44 +-0.48 +0.37 +-0.99 +0.84 +0.53 +0.16 +1.27 +-1.60 +0.85 +0.37 +-1.63 +-2.98 +1.84 +0.85 +-3.51 +-2.01 +-3.52 +-1.33 +4.18 +2.56 +-7.83 +-1.29 +-3.07 +-10.44 +128.89 +1.85 +-0.61 +2.72 +-1.20 +1.01 +2.31 +-8.99 +-1.30 +6.95 +-0.22 +0.84 +-5.03 +-0.44 +1.27 +0.00 +0.85 +-7.85 +0.85 +-3.51 +1.84 +-14.82 +1.84 +-6.71 +-0.48 +-3.52 +4.18 +-8.57 +4.18 +-4.95 +-3.07 +-7.02 +-20.61 +2.27 +3.44 +2.31 +-4.44 +4.99 +-9.55 +-9.57 +11.37 +-21.29 +-3.50 +-8.35 +-28.37 +67.11 +0.37 +0.85 +2.56 +-0.75 +-1.60 +0.85 +-1.60 +-2.98 +1.84 +-3.35 +2.56 +-0.53 +-1.29 +-1.33 +4.18 +-1.29 +-3.07 +-3.35 +-1.33 +4.18 +-6.26 +-4.77 +-10.44 +-4.77 +-10.44 +-25.35 +312.91 +-3.67 +1.01 +-7.85 +2.31 +-1.43 +-3.50 +-16.95 +6.95 +-12.98 +0.37 +0.85 +-7.85 +0.85 +1.84 +-14.82 +2.56 +-16.95 +-1.29 +-3.07 +4.18 +-8.57 +-3.07 +-7.02 +2.56 +4.18 +-8.57 +-6.26 +-10.44 +-20.61 +-10.44 +-20.61 +-24.13 +2.31 +4.99 +6.95 +-3.50 +11.37 +-8.35 +11.37 +-17.02 +-28.37 +-12.98 +-28.37 +-68.90 +67.11 +0.00 +-1.60 +0.00 +-2.98 +0.00 +0.00 +0.00 +-1.33 +0.00 +-0.75 +0.37 +0.85 +-1.60 +0.85 +1.84 +-0.53 +-1.29 +-3.35 +2.56 +-1.29 +-3.07 +-1.33 +4.18 +-3.35 +2.56 +4.18 +-4.77 +-10.44 +-6.26 +-4.77 +-10.44 +-25.35 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +130.48 +0.85 +1.84 +4.18 +0.37 +-1.63 +-3.51 +0.85 +-3.51 +-6.71 +-1.29 +-3.07 +2.56 +-7.83 +-3.07 +-7.02 +4.18 +-4.95 +2.56 +-7.83 +-4.95 +-10.44 +-20.61 +-6.26 +-10.44 +-20.61 +-24.13 +67.11 +-1.60 +0.85 +-1.29 +-0.75 +-1.60 +-2.98 +0.37 +0.85 +1.84 +-3.35 +-1.33 +-3.35 +-1.33 +2.56 +4.18 +2.56 +4.18 +-0.53 +-1.29 +-3.07 +-4.77 +-10.44 +-4.77 +-10.44 +-6.26 +-25.35 +312.91 +0.85 +-7.85 +-3.07 +0.37 +0.85 +1.84 +-3.67 +-7.85 +-14.82 +2.56 +4.18 +2.56 +4.18 +-16.95 +-8.57 +-16.95 +-8.57 +-1.29 +-3.07 +-7.02 +-10.44 +-20.61 +-10.44 +-20.61 +-6.26 +-24.13 +1.01 +2.31 +6.95 +-1.43 +-3.50 +-12.98 +2.31 +4.99 +6.95 +11.37 +11.37 +-3.50 +-8.35 +-12.98 +-28.37 +-28.37 +-17.02 +-68.90 +307.83 +-1.29 +-3.07 +-10.44 +-0.53 +-1.29 +-3.07 +-1.29 +-3.07 +-7.02 +-4.77 +-10.44 +-4.77 +-10.44 +-10.44 +-20.61 +-10.44 +-20.61 +-4.77 +-10.44 +-20.61 +-25.35 +-24.13 +-25.35 +-24.13 +-25.35 +-24.13 +72.26 +-10.53 +0.74 +-15.05 +-20.57 +0.74 +-20.57 +-7.03 +30.24 +-0.06 +-2.56 +0.24 +-0.25 +1.45 +-1.20 +-0.61 +2.27 +2.31 +-2.56 +-0.25 +1.45 +-1.20 +2.27 +2.31 +-4.69 +0.44 +0.44 +3.44 +3.44 +-6.39 +-9.55 +-9.55 +-8.11 +4.99 +-8.35 +294.25 +-15.05 +-20.57 +-49.19 +-5.01 +-20.57 +-5.01 +-7.03 +-40.91 +-55.90 +-55.90 +-19.11 +142.07 +0.24 +-0.25 +-0.40 +-11.64 +-1.20 +7.39 +-1.20 +3.44 +4.99 +-0.25 +-11.64 +-1.20 +7.39 +3.44 +4.99 +-4.69 +3.44 +3.44 +0.00 +0.00 +-1.18 +-18.24 +-18.24 +4.99 +-40.28 +-19.09 +0.65 +-1.66 +-0.67 +-3.26 +6.18 +6.29 +-0.67 +-3.26 +6.18 +6.29 +-12.74 +9.35 +9.35 +-17.38 +-25.95 +-25.95 +13.57 +-22.70 +74.82 +1.01 +-2.68 +-0.61 +2.27 +-4.34 +2.31 +1.01 +-4.44 +-3.50 +1.45 +-1.20 +-5.47 +-1.30 +2.31 +6.95 +0.44 +3.44 +-8.11 +-9.57 +4.99 +-9.55 +-21.29 +-8.35 +-3.61 +11.37 +-28.37 +74.82 +1.01 +1.45 +-0.61 +-1.20 +-5.47 +-1.30 +1.01 +2.31 +6.95 +-2.68 +2.27 +-4.34 +2.31 +-4.44 +-3.50 +0.44 +3.44 +-8.11 +4.99 +-9.57 +-9.55 +-8.35 +-21.29 +-3.61 +11.37 +-28.37 +350.37 +-0.61 +2.27 +5.03 +-13.68 +2.31 +-21.33 +2.31 +-9.55 +-8.35 +-1.20 +7.39 +-1.30 +-24.43 +4.99 +11.37 +3.44 +0.00 +-9.57 +4.99 +-40.28 +-18.24 +-13.47 +-19.09 +11.37 +-23.29 +-56.01 +-1.66 +2.74 +6.18 +6.29 +-12.07 +-9.53 +-3.26 +-3.54 +6.29 +18.88 +9.35 +-26.01 +13.57 +-25.95 +-57.86 +-22.70 +30.92 +-77.12 +350.37 +-0.61 +-1.20 +5.03 +7.39 +-1.30 +-24.43 +2.31 +4.99 +11.37 +2.27 +-13.68 +2.31 +-21.33 +-9.55 +-8.35 +3.44 +0.00 +4.99 +-9.57 +-40.28 +-18.24 +-19.09 +-13.47 +11.37 +-23.29 +-56.01 +-1.66 +2.74 +-3.26 +-3.54 +6.29 +18.88 +6.18 +6.29 +-12.07 +-9.53 +9.35 +13.57 +-26.01 +-25.95 +-22.70 +-57.86 +30.92 +-77.12 +146.99 +-0.61 +2.27 +-1.20 +3.44 +2.31 +4.99 +-1.30 +-9.57 +11.37 +2.27 +3.44 +2.31 +4.99 +-9.57 +11.37 +-6.39 +-1.18 +-9.55 +-9.55 +-18.24 +-18.24 +-13.47 +-13.47 +-8.35 +-19.09 +-56.01 +354.69 +1.01 +-4.44 +2.31 +-9.55 +-3.50 +-8.35 +6.95 +-21.29 +-28.37 +2.31 +4.99 +6.95 +11.37 +11.37 +-17.02 +-9.55 +-18.24 +-21.29 +-8.35 +-13.47 +-19.09 +-13.47 +-56.01 +-28.37 +-56.01 +-65.60 +354.69 +1.01 +2.31 +2.31 +4.99 +6.95 +11.37 +6.95 +11.37 +-17.02 +-4.44 +-9.55 +-3.50 +-8.35 +-21.29 +-28.37 +-9.55 +-18.24 +-8.35 +-21.29 +-19.09 +-13.47 +-13.47 +-56.01 +-28.37 +-56.01 +-65.60 +182.42 +-2.04 +-4.34 +1.01 +2.31 +-9.12 +6.95 +-1.43 +-3.50 +-12.98 +-4.34 +2.31 +-9.12 +6.95 +-3.50 +-12.98 +-8.11 +4.99 +-3.61 +-3.61 +11.37 +11.37 +-8.35 +-28.37 +-28.37 +-17.02 +-68.90 +850.57 +1.01 +2.31 +-9.98 +-21.33 +6.95 +-46.07 +-3.50 +-8.35 +-28.37 +2.31 +-21.33 +6.95 +-46.07 +-8.35 +-28.37 +4.99 +-40.28 +11.37 +11.37 +-23.29 +-23.29 +-19.09 +-56.01 +-56.01 +-17.02 +-65.60 +2.74 +-3.88 +6.29 +18.88 +-9.53 +-35.27 +6.29 +18.88 +-9.53 +-35.27 +13.57 +30.92 +30.92 +-22.70 +-77.12 +-77.12 +-46.28 +-187.29 +836.77 +-1.43 +-3.50 +-3.50 +-8.35 +-12.98 +-28.37 +-12.98 +-28.37 +-68.90 +-3.50 +-8.35 +-12.98 +-28.37 +-28.37 +-68.90 +-8.35 +-19.09 +-28.37 +-28.37 +-56.01 +-56.01 +-56.01 +-65.60 +-65.60 +-68.90 +-65.60 +16.03 +0.00 +0.00 +1.29 +-3.87 +0.00 +1.29 +1.29 +-3.87 +-3.87 +-5.54 +0.10 +-0.62 +-0.62 +-0.74 +0.01 +0.01 +-0.87 +3.73 +0.00 +0.00 +-0.50 +-0.02 +0.00 +0.37 +0.00 +0.00 +0.00 +0.00 +-0.50 +0.00 +0.37 +0.00 +0.00 +-0.50 +-0.02 +-0.02 +0.09 +-0.41 +-0.41 +0.37 +-0.22 +0.37 +-0.22 +-0.41 +0.37 +0.37 +-0.22 +-0.75 +0.37 +-0.75 +0.37 +-0.75 +0.37 +-0.53 +-0.10 +0.00 +0.00 +0.01 +0.06 +-0.03 +0.06 +-0.03 +0.08 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.13 +-0.13 +-0.01 +-0.09 +0.10 +-0.09 +0.10 +0.00 +0.08 +0.08 +-0.05 +-0.27 +0.12 +-0.27 +0.12 +-0.28 +-0.25 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +19.02 +-3.87 +-5.54 +-3.87 +1.29 +0.27 +0.27 +-7.57 +5.60 +-0.02 +0.09 +-0.22 +-0.02 +-0.22 +-0.50 +-0.94 +-0.94 +-0.09 +0.37 +0.37 +-0.99 +0.84 +-0.99 +0.84 +0.25 +0.53 +0.53 +-0.44 +-1.60 +0.85 +-1.60 +0.85 +0.37 +-1.63 +-1.29 +78.27 +3.77 +-10.53 +-18.10 +-15.05 +-5.54 +-3.87 +0.27 +-7.57 +-1.84 +0.74 +-20.57 +26.33 +-2.31 +-0.06 +-0.15 +0.24 +1.85 +-0.61 +1.01 +-0.61 +1.01 +0.09 +-0.44 +-0.02 +-0.94 +-0.09 +-4.28 +-0.22 +0.53 +0.84 +-5.03 +0.16 +1.27 +0.53 +0.84 +-0.44 +2.72 +0.85 +-7.85 +-2.98 +1.84 +0.85 +-3.51 +-3.07 +-2.56 +-0.25 +2.27 +-2.68 +2.27 +1.45 +-1.20 +2.31 +-4.34 +2.31 +-4.44 +-3.50 +78.27 +-5.54 +-18.10 +3.77 +-10.53 +-15.05 +-3.87 +0.27 +-7.57 +-1.84 +0.74 +-20.57 +26.33 +0.09 +-0.15 +-0.44 +-2.31 +-0.06 +0.24 +1.01 +-0.61 +1.85 +-0.61 +1.01 +-0.02 +-0.94 +-0.09 +-4.28 +0.53 +-0.22 +0.16 +1.27 +0.84 +-5.03 +0.53 +-0.44 +0.84 +2.72 +-2.98 +1.84 +0.85 +-7.85 +0.85 +-3.51 +-3.07 +-2.56 +-0.25 +-2.68 +2.27 +2.27 +1.45 +-1.20 +-4.34 +2.31 +2.31 +-4.44 +-3.50 +321.02 +-18.10 +-15.05 +8.42 +-49.19 +-18.10 +-15.05 +-49.19 +-40.91 +-5.54 +-7.57 +-1.84 +-1.84 +-20.57 +-5.01 +-20.57 +-5.01 +-55.90 +123.85 +-0.15 +0.24 +-10.56 +-0.40 +2.72 +-1.20 +-0.61 +5.03 +2.31 +-0.15 +0.24 +-0.40 +-0.61 +5.03 +2.72 +-1.20 +2.31 +0.65 +-1.66 +-1.66 +2.74 +0.09 +-0.09 +-4.28 +-4.28 +-0.44 +-0.44 +1.27 +0.00 +1.27 +0.00 +-0.44 +2.72 +2.72 +2.28 +1.84 +-14.82 +1.84 +-14.82 +1.84 +-6.71 +-7.02 +-0.25 +-11.64 +3.44 +2.27 +-13.68 +-1.20 +7.39 +4.99 +2.31 +-21.33 +-9.55 +-8.35 +-0.25 +-11.64 +2.27 +-13.68 +3.44 +-1.20 +7.39 +2.31 +-21.33 +4.99 +-9.55 +-8.35 +-0.67 +6.18 +6.18 +-3.26 +6.29 +6.29 +-12.07 +-9.53 +13.94 +0.00 +0.00 +0.37 +0.53 +0.00 +-2.01 +0.00 +0.00 +0.00 +0.00 +0.25 +0.00 +-1.60 +0.00 +0.00 +-0.41 +0.37 +-0.22 +0.53 +-0.44 +-0.75 +-2.01 +-0.48 +0.37 +0.85 +-0.75 +0.37 +-1.60 +0.85 +-3.35 +2.56 +-0.53 +-1.29 +-3.35 +2.56 +-4.77 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +13.94 +0.00 +0.00 +0.25 +0.53 +0.00 +-1.60 +0.00 +0.00 +0.00 +0.00 +0.37 +0.00 +-2.01 +0.00 +0.00 +-0.41 +0.37 +0.53 +-0.22 +-0.44 +-0.75 +0.37 +0.85 +-2.01 +-0.48 +-0.75 +-1.60 +0.37 +0.85 +-0.53 +-1.29 +-3.35 +2.56 +-3.35 +2.56 +-4.77 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +27.52 +-0.22 +-0.44 +-0.48 +0.53 +0.85 +0.37 +-0.99 +0.84 +0.16 +1.27 +-2.01 +0.37 +-3.52 +-1.63 +-3.51 +-1.60 +0.85 +-2.98 +1.84 +-1.33 +4.18 +-1.29 +-3.07 +2.56 +-7.83 +-10.44 +128.89 +1.85 +-0.61 +2.72 +-1.20 +-8.99 +-1.30 +1.01 +2.31 +6.95 +-0.44 +1.84 +-0.22 +0.84 +-5.03 +1.27 +0.00 +-0.48 +0.85 +-3.52 +-3.51 +-6.71 +0.85 +-7.85 +1.84 +-14.82 +4.18 +-8.57 +-3.07 +-7.02 +4.18 +-4.95 +-20.61 +2.27 +3.44 +-9.57 +-4.44 +-9.55 +2.31 +4.99 +11.37 +-3.50 +-8.35 +-21.29 +-28.37 +27.52 +0.53 +-0.44 +0.85 +-0.22 +-0.48 +0.37 +-0.99 +0.16 +0.84 +1.27 +0.37 +-2.01 +-1.63 +-3.51 +-3.52 +-1.60 +-2.98 +0.85 +1.84 +-1.29 +-3.07 +-1.33 +4.18 +2.56 +-7.83 +-10.44 +128.89 +-0.44 +2.72 +1.84 +1.85 +-0.61 +-1.20 +1.01 +2.31 +-8.99 +-1.30 +6.95 +-0.22 +0.84 +1.27 +-5.03 +0.00 +0.85 +-0.48 +-3.51 +-6.71 +-3.52 +0.85 +1.84 +-7.85 +-14.82 +-3.07 +-7.02 +4.18 +-8.57 +4.18 +-4.95 +-20.61 +2.27 +3.44 +-4.44 +-9.55 +-9.57 +2.31 +4.99 +-3.50 +-8.35 +11.37 +-21.29 +-28.37 +13.94 +0.37 +-0.22 +0.37 +0.37 +0.37 +-0.41 +0.25 +0.53 +0.53 +-0.44 +-0.75 +-0.75 +-1.60 +0.85 +-1.60 +0.85 +-2.01 +-2.01 +-0.48 +-3.35 +2.56 +-3.35 +2.56 +-0.53 +-1.29 +-4.77 +65.43 +-2.09 +1.01 +1.85 +-0.61 +-3.67 +1.01 +-2.04 +1.01 +-1.43 +-0.22 +0.85 +0.37 +0.53 +0.84 +-0.44 +2.72 +0.37 +-1.60 +0.85 +-7.85 +-2.98 +1.84 +-2.01 +-0.48 +-8.99 +2.56 +-16.95 +-1.33 +4.18 +-1.29 +-3.07 +-10.44 +1.45 +-1.20 +2.31 +-4.34 +2.31 +-5.47 +-1.30 +6.95 +-9.12 +6.95 +-3.50 +-12.98 +65.43 +-0.22 +1.85 +0.85 +-2.09 +1.01 +-0.61 +-2.04 +1.01 +-3.67 +1.01 +-1.43 +0.37 +0.53 +-0.44 +0.84 +2.72 +-1.60 +0.37 +-2.98 +1.84 +0.85 +-7.85 +-2.01 +-0.48 +-8.99 +-1.33 +4.18 +2.56 +-16.95 +-1.29 +-3.07 +-10.44 +1.45 +-1.20 +-4.34 +2.31 +2.31 +-5.47 +-1.30 +-9.12 +6.95 +6.95 +-3.50 +-12.98 +306.74 +1.85 +-0.61 +-10.72 +5.03 +-7.85 +2.31 +1.01 +-9.98 +-3.50 +1.85 +-0.61 +5.03 +1.01 +-9.98 +-7.85 +2.31 +-3.50 +-1.66 +2.74 +2.74 +-3.88 +-0.22 +-0.44 +2.72 +2.72 +2.28 +0.85 +0.85 +1.84 +-14.82 +1.84 +-14.82 +-0.48 +-8.99 +-8.99 +4.18 +-8.57 +4.18 +-8.57 +-3.07 +-7.02 +-20.61 +-1.20 +7.39 +4.99 +2.31 +-21.33 +-1.30 +-24.43 +11.37 +6.95 +-46.07 +-8.35 +-28.37 +-1.20 +7.39 +2.31 +-21.33 +4.99 +-1.30 +-24.43 +6.95 +-46.07 +11.37 +-8.35 +-28.37 +-3.26 +6.29 +6.29 +-3.54 +18.88 +18.88 +-9.53 +-35.27 +67.11 +0.37 +0.85 +2.56 +-1.60 +-1.29 +-0.75 +-1.60 +0.85 +-2.98 +1.84 +-3.35 +-0.53 +-1.33 +4.18 +-1.29 +-3.07 +-3.35 +2.56 +-1.33 +4.18 +-6.26 +-4.77 +-10.44 +-4.77 +-10.44 +-25.35 +312.91 +-3.67 +1.01 +-7.85 +2.31 +-16.95 +6.95 +-1.43 +-3.50 +-12.98 +0.85 +-3.07 +0.37 +0.85 +-7.85 +1.84 +-14.82 +2.56 +-1.29 +4.18 +-8.57 +-3.07 +-7.02 +2.56 +-16.95 +4.18 +-8.57 +-6.26 +-10.44 +-20.61 +-10.44 +-20.61 +-24.13 +2.31 +4.99 +11.37 +-3.50 +-8.35 +6.95 +11.37 +-17.02 +-12.98 +-28.37 +-28.37 +-68.90 +67.11 +-1.60 +0.85 +-1.29 +0.37 +2.56 +-0.75 +-1.60 +-2.98 +0.85 +1.84 +-0.53 +-3.35 +-1.29 +-3.07 +-1.33 +4.18 +-3.35 +-1.33 +2.56 +4.18 +-4.77 +-10.44 +-6.26 +-4.77 +-10.44 +-25.35 +312.91 +0.85 +-7.85 +-3.07 +-3.67 +1.01 +2.31 +-1.43 +-3.50 +-16.95 +6.95 +-12.98 +0.37 +0.85 +1.84 +-7.85 +-14.82 +-1.29 +2.56 +-3.07 +-7.02 +4.18 +-8.57 +2.56 +4.18 +-16.95 +-8.57 +-10.44 +-20.61 +-6.26 +-10.44 +-20.61 +-24.13 +2.31 +4.99 +-3.50 +-8.35 +11.37 +6.95 +11.37 +-12.98 +-28.37 +-17.02 +-28.37 +-68.90 +67.11 +0.00 +0.00 +-1.60 +-2.98 +0.00 +-1.33 +0.00 +0.00 +0.00 +0.00 +-1.60 +0.00 +-1.33 +0.00 +0.00 +-0.75 +0.37 +0.85 +0.85 +1.84 +-3.35 +-3.35 +2.56 +4.18 +2.56 +4.18 +-0.53 +-1.29 +-1.29 +-3.07 +-4.77 +-10.44 +-4.77 +-10.44 +-6.26 +-25.35 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +130.48 +0.85 +1.84 +4.18 +0.85 +4.18 +0.37 +-1.63 +-3.51 +-3.51 +-6.71 +2.56 +2.56 +-7.83 +-4.95 +-7.83 +-4.95 +-1.29 +-3.07 +-3.07 +-7.02 +-10.44 +-20.61 +-10.44 +-20.61 +-6.26 +-24.13 +307.83 +-1.29 +-3.07 +-10.44 +-1.29 +-10.44 +-0.53 +-1.29 +-3.07 +-3.07 +-7.02 +-4.77 +-4.77 +-10.44 +-20.61 +-10.44 +-20.61 +-4.77 +-10.44 +-10.44 +-20.61 +-25.35 +-24.13 +-25.35 +-24.13 +-25.35 +-24.13 +72.26 +-10.53 +0.74 +-15.05 +-20.57 +0.74 +-20.57 +-7.03 +30.24 +-0.06 +-2.56 +0.24 +-0.25 +-0.61 +2.27 +1.45 +-1.20 +2.31 +-2.56 +-0.25 +2.27 +1.45 +-1.20 +2.31 +-4.69 +-6.39 +0.44 +3.44 +0.44 +3.44 +-9.55 +-8.11 +4.99 +-9.55 +-8.35 +294.25 +-15.05 +-20.57 +-49.19 +-5.01 +-40.91 +-55.90 +-20.57 +-5.01 +-7.03 +-55.90 +-19.11 +142.07 +0.24 +-0.25 +-0.40 +-11.64 +-1.20 +3.44 +-1.20 +7.39 +4.99 +0.65 +-1.66 +-0.67 +6.18 +-3.26 +6.29 +-0.25 +-11.64 +3.44 +-1.20 +7.39 +4.99 +-4.69 +-1.18 +3.44 +0.00 +3.44 +0.00 +-18.24 +4.99 +-40.28 +-18.24 +-19.09 +-0.67 +6.18 +-3.26 +6.29 +-12.74 +-17.38 +9.35 +9.35 +-25.95 +13.57 +-25.95 +-22.70 +146.99 +-0.61 +2.27 +-1.20 +3.44 +-1.30 +-9.57 +2.31 +4.99 +11.37 +2.27 +3.44 +-9.57 +2.31 +4.99 +11.37 +-6.39 +-1.18 +-9.55 +-18.24 +-9.55 +-18.24 +-13.47 +-8.35 +-19.09 +-13.47 +-56.01 +74.82 +1.01 +1.45 +-0.61 +-1.20 +1.01 +2.31 +-5.47 +-1.30 +6.95 +-2.68 +2.27 +-4.44 +-4.34 +2.31 +-3.50 +0.44 +3.44 +-9.55 +-9.57 +-8.11 +4.99 +-8.35 +-3.61 +11.37 +-21.29 +-28.37 +350.37 +-0.61 +-1.20 +5.03 +7.39 +2.31 +4.99 +-1.30 +-24.43 +11.37 +-1.66 +2.74 +-3.26 +6.29 +-3.54 +18.88 +2.27 +-13.68 +-9.55 +2.31 +-21.33 +-8.35 +3.44 +0.00 +-18.24 +-9.57 +4.99 +-40.28 +-19.09 +11.37 +-23.29 +-13.47 +-56.01 +6.18 +-12.07 +6.29 +-9.53 +9.35 +-25.95 +-26.01 +13.57 +-22.70 +30.92 +-57.86 +-77.12 +74.82 +1.01 +-2.68 +-0.61 +2.27 +1.01 +-4.44 +-4.34 +2.31 +-3.50 +1.45 +-1.20 +2.31 +-5.47 +-1.30 +6.95 +0.44 +3.44 +-9.55 +-8.11 +4.99 +-9.57 +-21.29 +-3.61 +11.37 +-8.35 +-28.37 +350.37 +-0.61 +2.27 +5.03 +-13.68 +2.31 +-9.55 +2.31 +-21.33 +-8.35 +-1.66 +2.74 +6.18 +-12.07 +6.29 +-9.53 +-1.20 +7.39 +4.99 +-1.30 +-24.43 +11.37 +3.44 +0.00 +-18.24 +4.99 +-40.28 +-9.57 +-13.47 +11.37 +-23.29 +-19.09 +-56.01 +-3.26 +6.29 +-3.54 +18.88 +9.35 +-25.95 +13.57 +-26.01 +-57.86 +30.92 +-22.70 +-77.12 +354.69 +1.01 +-4.44 +2.31 +-9.55 +6.95 +-21.29 +-3.50 +-8.35 +-28.37 +2.31 +4.99 +11.37 +6.95 +11.37 +-17.02 +-9.55 +-18.24 +-13.47 +-8.35 +-19.09 +-21.29 +-13.47 +-28.37 +-56.01 +-56.01 +-65.60 +182.42 +-2.04 +-4.34 +1.01 +2.31 +-1.43 +-3.50 +-9.12 +6.95 +-12.98 +-4.34 +2.31 +-3.50 +-9.12 +6.95 +-12.98 +-8.11 +4.99 +-8.35 +-3.61 +11.37 +-3.61 +11.37 +-28.37 +-17.02 +-28.37 +-68.90 +850.57 +1.01 +2.31 +-9.98 +-21.33 +-3.50 +-8.35 +6.95 +-46.07 +-28.37 +2.74 +-3.88 +6.29 +-9.53 +18.88 +-35.27 +2.31 +-21.33 +-8.35 +6.95 +-46.07 +-28.37 +4.99 +-40.28 +-19.09 +11.37 +-23.29 +11.37 +-23.29 +-56.01 +-17.02 +-56.01 +-65.60 +6.29 +-9.53 +18.88 +-35.27 +13.57 +-22.70 +30.92 +30.92 +-77.12 +-46.28 +-77.12 +-187.29 +354.69 +1.01 +2.31 +2.31 +4.99 +6.95 +11.37 +6.95 +11.37 +-17.02 +-4.44 +-9.55 +-21.29 +-3.50 +-8.35 +-28.37 +-9.55 +-18.24 +-13.47 +-21.29 +-13.47 +-8.35 +-19.09 +-56.01 +-28.37 +-56.01 +-65.60 +836.77 +-1.43 +-3.50 +-3.50 +-8.35 +-12.98 +-28.37 +-12.98 +-28.37 +-68.90 +-3.50 +-8.35 +-28.37 +-12.98 +-28.37 +-68.90 +-8.35 +-19.09 +-56.01 +-28.37 +-56.01 +-28.37 +-56.01 +-65.60 +-68.90 +-65.60 +-65.60 +72.26 +-15.05 +-10.53 +0.74 +-20.57 +0.74 +-20.57 +-7.03 +30.24 +0.24 +-0.06 +-2.56 +-0.25 +1.45 +-1.20 +-0.61 +2.27 +2.31 +-2.56 +-0.25 +2.27 +1.45 +-1.20 +2.31 +-4.69 +0.44 +3.44 +-6.39 +0.44 +3.44 +-8.11 +4.99 +-9.55 +-9.55 +-8.35 +294.25 +-49.19 +-40.91 +-15.05 +-20.57 +-5.01 +-55.90 +-20.57 +-5.01 +-55.90 +-7.03 +-19.11 +142.07 +-0.40 +0.65 +-1.66 +0.24 +-0.25 +-11.64 +-1.20 +7.39 +-1.20 +3.44 +4.99 +-0.67 +-3.26 +6.18 +6.29 +-0.25 +-11.64 +3.44 +-1.20 +7.39 +4.99 +-0.67 +6.18 +-3.26 +6.29 +-4.69 +3.44 +0.00 +-1.18 +3.44 +0.00 +4.99 +-40.28 +-18.24 +-18.24 +-19.09 +-12.74 +9.35 +-17.38 +9.35 +13.57 +-25.95 +-25.95 +-22.70 +74.82 +-0.61 +1.01 +1.45 +-1.20 +-5.47 +-1.30 +1.01 +2.31 +6.95 +-2.68 +2.27 +-4.44 +-4.34 +2.31 +-3.50 +0.44 +3.44 +-9.57 +-9.55 +-8.11 +4.99 +-3.61 +11.37 +-8.35 +-21.29 +-28.37 +350.37 +5.03 +-1.66 +2.74 +-0.61 +-1.20 +7.39 +-1.30 +-24.43 +2.31 +4.99 +11.37 +-3.26 +-3.54 +6.29 +18.88 +2.27 +-13.68 +-9.55 +2.31 +-21.33 +-8.35 +6.18 +-12.07 +6.29 +-9.53 +3.44 +0.00 +-9.57 +-18.24 +4.99 +-40.28 +11.37 +-23.29 +-19.09 +-13.47 +-56.01 +9.35 +-26.01 +-25.95 +13.57 +30.92 +-22.70 +-57.86 +-77.12 +146.99 +-1.20 +-0.61 +2.27 +3.44 +2.31 +4.99 +-1.30 +-9.57 +11.37 +2.27 +3.44 +-9.57 +2.31 +4.99 +11.37 +-6.39 +-1.18 +-9.55 +-18.24 +-9.55 +-18.24 +-8.35 +-19.09 +-13.47 +-13.47 +-56.01 +74.82 +-0.61 +1.01 +-2.68 +2.27 +-4.34 +2.31 +1.01 +-4.44 +-3.50 +1.45 +-1.20 +2.31 +-5.47 +-1.30 +6.95 +0.44 +3.44 +-8.11 +4.99 +-9.55 +-9.57 +-3.61 +11.37 +-21.29 +-8.35 +-28.37 +350.37 +5.03 +-1.66 +2.74 +-0.61 +2.27 +-13.68 +2.31 +-21.33 +2.31 +-9.55 +-8.35 +6.18 +6.29 +-12.07 +-9.53 +-1.20 +7.39 +4.99 +-1.30 +-24.43 +11.37 +-3.26 +6.29 +-3.54 +18.88 +3.44 +0.00 +4.99 +-40.28 +-18.24 +-9.57 +11.37 +-23.29 +-13.47 +-19.09 +-56.01 +9.35 +13.57 +-25.95 +-26.01 +30.92 +-57.86 +-22.70 +-77.12 +182.42 +1.01 +-2.04 +-4.34 +2.31 +-9.12 +6.95 +-1.43 +-3.50 +-12.98 +-4.34 +2.31 +-3.50 +-9.12 +6.95 +-12.98 +-8.11 +4.99 +-3.61 +11.37 +-8.35 +-3.61 +11.37 +-17.02 +-28.37 +-28.37 +-68.90 +850.57 +-9.98 +2.74 +-3.88 +1.01 +2.31 +-21.33 +6.95 +-46.07 +-3.50 +-8.35 +-28.37 +6.29 +18.88 +-9.53 +-35.27 +2.31 +-21.33 +-8.35 +6.95 +-46.07 +-28.37 +6.29 +-9.53 +18.88 +-35.27 +4.99 +-40.28 +11.37 +-23.29 +-19.09 +11.37 +-23.29 +-17.02 +-56.01 +-56.01 +-65.60 +13.57 +30.92 +-22.70 +30.92 +-46.28 +-77.12 +-77.12 +-187.29 +354.69 +2.31 +1.01 +-4.44 +-9.55 +-3.50 +-8.35 +6.95 +-21.29 +-28.37 +2.31 +4.99 +11.37 +6.95 +11.37 +-17.02 +-9.55 +-18.24 +-8.35 +-19.09 +-13.47 +-21.29 +-13.47 +-28.37 +-56.01 +-56.01 +-65.60 +354.69 +2.31 +1.01 +2.31 +4.99 +6.95 +11.37 +6.95 +11.37 +-17.02 +-4.44 +-9.55 +-21.29 +-3.50 +-8.35 +-28.37 +-9.55 +-18.24 +-21.29 +-13.47 +-13.47 +-8.35 +-19.09 +-28.37 +-56.01 +-56.01 +-65.60 +836.77 +-3.50 +-1.43 +-3.50 +-8.35 +-12.98 +-28.37 +-12.98 +-28.37 +-68.90 +-3.50 +-8.35 +-28.37 +-12.98 +-28.37 +-68.90 +-8.35 +-19.09 +-28.37 +-56.01 +-56.01 +-28.37 +-56.01 +-68.90 +-65.60 +-65.60 +-65.60 +265.95 +-40.91 +-55.90 +-55.90 +-19.11 +-55.90 +-19.11 +-19.11 +162.77 +0.65 +-0.67 +-3.26 +-0.67 +-3.26 +-12.74 +9.35 +9.35 +13.57 +-0.67 +-3.26 +-12.74 +9.35 +9.35 +13.57 +-12.74 +9.35 +9.35 +13.57 +-3.22 +-3.22 +-3.22 +-49.58 +-49.58 +-49.58 +-51.88 +399.55 +-1.66 +6.18 +6.29 +-3.26 +-3.54 +9.35 +-26.01 +13.57 +30.92 +6.18 +6.29 +-17.38 +-25.95 +-25.95 +-22.70 +9.35 +-26.01 +13.57 +30.92 +-3.22 +-49.58 +-49.58 +-36.60 +-51.88 +-36.60 +-152.26 +399.55 +-1.66 +-3.26 +-3.54 +6.18 +6.29 +9.35 +13.57 +-26.01 +30.92 +6.18 +6.29 +9.35 +-26.01 +13.57 +30.92 +-17.38 +-25.95 +-25.95 +-22.70 +-3.22 +-49.58 +-49.58 +-51.88 +-36.60 +-36.60 +-152.26 +399.55 +-1.66 +6.18 +6.29 +6.18 +6.29 +-17.38 +-25.95 +-25.95 +-22.70 +-3.26 +-3.54 +9.35 +13.57 +-26.01 +30.92 +9.35 +13.57 +-26.01 +30.92 +-3.22 +-49.58 +-49.58 +-36.60 +-36.60 +-51.88 +-152.26 +964.16 +2.74 +-12.07 +-9.53 +6.29 +18.88 +-25.95 +-57.86 +-22.70 +-77.12 +6.29 +18.88 +-25.95 +-22.70 +-57.86 +-77.12 +13.57 +30.92 +30.92 +-46.28 +-49.58 +-36.60 +-51.88 +-36.60 +-152.26 +-152.26 +-178.32 +964.16 +2.74 +6.29 +18.88 +-12.07 +-9.53 +-25.95 +-22.70 +-57.86 +-77.12 +6.29 +18.88 +13.57 +30.92 +30.92 +-46.28 +-25.95 +-22.70 +-57.86 +-77.12 +-49.58 +-51.88 +-36.60 +-36.60 +-152.26 +-152.26 +-178.32 +964.16 +2.74 +6.29 +18.88 +6.29 +18.88 +13.57 +30.92 +30.92 +-46.28 +-12.07 +-9.53 +-25.95 +-57.86 +-22.70 +-77.12 +-25.95 +-57.86 +-22.70 +-77.12 +-49.58 +-36.60 +-36.60 +-51.88 +-152.26 +-152.26 +-178.32 +2274.58 +-3.88 +-9.53 +-35.27 +-9.53 +-35.27 +-22.70 +-77.12 +-77.12 +-187.29 +-9.53 +-35.27 +-22.70 +-77.12 +-77.12 +-187.29 +-22.70 +-77.12 +-77.12 +-187.29 +-51.88 +-152.26 +-152.26 +-152.26 +-178.32 +-178.32 +-178.32 +1.40 +0.06 +0.06 +-0.38 +0.06 +-0.38 +-0.38 +-0.45 +0.39 +-0.06 +-0.06 +0.00 +-0.06 +0.00 +0.00 +0.01 +-0.03 +0.04 +-0.03 +0.04 +0.04 +-0.02 +0.04 +-0.02 +-0.03 +0.04 +0.04 +-0.02 +-0.11 +0.05 +-0.11 +0.05 +-0.11 +0.05 +-0.10 +3.96 +0.10 +0.00 +0.00 +0.00 +0.06 +-0.38 +0.11 +-0.38 +0.11 +-0.45 +-1.15 +-0.62 +-0.62 +-0.74 +1.21 +-0.10 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.06 +0.00 +-0.17 +0.00 +-0.17 +0.01 +-0.01 +0.04 +-0.11 +0.00 +0.05 +-0.02 +0.12 +0.05 +-0.03 +0.04 +-0.11 +-0.02 +0.12 +0.05 +-0.36 +-0.16 +0.07 +-0.16 +0.07 +-0.15 +0.00 +0.00 +0.01 +0.06 +-0.06 +0.06 +-0.03 +0.06 +-0.03 +0.06 +-0.03 +0.08 +-0.19 +0.08 +-0.19 +0.08 +-0.16 +3.96 +0.00 +0.00 +0.10 +0.00 +0.06 +-0.38 +0.11 +-0.38 +-0.45 +0.11 +-1.15 +-0.62 +-0.62 +-0.74 +1.21 +0.00 +0.00 +0.00 +-0.10 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.06 +0.00 +-0.17 +0.00 +0.01 +-0.17 +-0.01 +0.00 +0.05 +0.04 +-0.11 +0.05 +-0.03 +-0.02 +0.12 +0.04 +-0.02 +-0.11 +0.12 +-0.16 +0.07 +0.05 +-0.36 +-0.16 +0.07 +-0.15 +0.00 +0.00 +0.01 +-0.06 +0.06 +0.06 +0.06 +-0.03 +-0.03 +0.06 +-0.03 +-0.19 +0.08 +0.08 +-0.19 +0.08 +-0.16 +11.23 +-0.62 +-1.03 +0.00 +0.00 +-0.62 +0.00 +-0.38 +0.11 +0.11 +-0.45 +-1.15 +-1.15 +0.10 +0.18 +-0.74 +-1.90 +0.18 +-0.74 +-1.90 +-1.22 +3.70 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.17 +-0.17 +0.01 +-0.01 +-0.01 +-0.52 +0.05 +0.00 +0.05 +0.00 +-0.03 +0.15 +-0.03 +0.15 +-0.02 +0.12 +0.12 +-0.37 +0.07 +-0.51 +0.07 +-0.51 +-0.22 +0.10 +-0.23 +-0.29 +0.01 +-0.01 +0.08 +0.06 +-0.18 +-0.05 +-0.03 +0.20 +-0.03 +0.20 +0.12 +0.08 +-0.59 +-0.27 +0.12 +-0.25 +-0.29 +0.01 +-0.01 +0.06 +-0.18 +0.08 +-0.03 +0.20 +-0.05 +-0.03 +0.20 +0.08 +-0.59 +0.12 +-0.27 +0.12 +-0.25 +0.02 +0.11 +0.11 +-0.06 +-0.06 +-0.06 +0.13 +0.13 +-0.31 +0.13 +-0.26 +3.96 +0.00 +0.00 +0.00 +0.10 +0.06 +-0.38 +-0.38 +-0.45 +0.11 +0.11 +-1.15 +-0.62 +-0.62 +-0.74 +1.21 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.10 +0.00 +0.00 +0.00 +-0.06 +0.00 +0.00 +0.01 +-0.17 +-0.17 +-0.01 +0.04 +-0.02 +0.04 +-0.02 +-0.11 +0.12 +-0.11 +0.12 +0.00 +0.05 +0.05 +-0.03 +-0.16 +0.07 +-0.16 +0.07 +0.05 +-0.36 +-0.15 +0.00 +0.00 +0.01 +0.06 +-0.03 +0.06 +-0.03 +-0.06 +0.06 +0.06 +-0.03 +-0.19 +0.08 +-0.19 +0.08 +0.08 +-0.16 +11.23 +-0.62 +0.00 +-1.03 +0.00 +0.00 +-0.62 +-0.38 +0.11 +-0.45 +-1.15 +0.11 +-1.15 +0.10 +-0.74 +0.18 +-1.90 +0.18 +-0.74 +-1.90 +-1.22 +3.70 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.17 +0.01 +-0.01 +-0.17 +-0.01 +-0.52 +-0.02 +0.12 +0.05 +-0.03 +0.12 +-0.37 +0.00 +0.15 +0.05 +0.00 +-0.03 +0.15 +0.07 +-0.51 +-0.22 +0.10 +0.07 +-0.51 +-0.23 +0.01 +-0.29 +-0.01 +-0.03 +0.06 +-0.03 +0.20 +-0.18 +0.20 +0.08 +-0.05 +0.12 +-0.27 +0.12 +0.08 +-0.59 +-0.25 +-0.29 +0.01 +-0.01 +-0.03 +0.20 +0.08 +-0.05 +0.06 +-0.18 +-0.03 +0.20 +0.08 +-0.59 +-0.27 +0.12 +0.12 +-0.25 +0.02 +-0.06 +0.11 +-0.06 +0.11 +-0.06 +0.13 +-0.31 +0.13 +0.13 +-0.26 +11.23 +0.00 +0.00 +0.00 +-0.62 +-1.03 +-0.62 +-0.38 +-0.45 +0.11 +-1.15 +0.11 +-1.15 +0.10 +-0.74 +0.18 +-1.90 +-0.74 +0.18 +-1.90 +-1.22 +3.70 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +-0.17 +-0.01 +-0.17 +-0.01 +-0.52 +0.05 +-0.03 +-0.02 +0.12 +0.00 +0.15 +0.12 +-0.37 +0.05 +-0.03 +0.00 +0.15 +-0.22 +0.10 +0.07 +-0.51 +0.07 +-0.51 +-0.23 +0.01 +-0.29 +-0.01 +0.06 +-0.03 +-0.03 +-0.18 +0.20 +0.20 +0.08 +-0.05 +-0.27 +0.12 +0.12 +0.08 +-0.59 +-0.25 +0.01 +-0.29 +-0.01 +0.08 +-0.05 +-0.03 +0.20 +0.06 +-0.03 +-0.18 +0.20 +-0.27 +0.12 +0.08 +-0.59 +0.12 +-0.25 +0.02 +0.11 +-0.06 +-0.06 +0.11 +-0.06 +-0.31 +0.13 +0.13 +0.13 +-0.26 +31.79 +-0.74 +-1.22 +-1.22 +-2.01 +-0.74 +-1.22 +-0.74 +-0.45 +-1.15 +-1.15 +0.10 +-1.15 +0.10 +0.10 +-1.90 +-1.90 +0.16 +-1.90 +-1.90 +0.16 +-3.13 +-1.90 +-1.90 +0.16 +-3.13 +-3.13 +11.33 +0.01 +0.02 +0.02 +0.03 +0.00 +0.00 +0.00 +0.00 +0.00 +0.01 +0.02 +0.00 +0.00 +0.00 +0.00 +0.01 +0.00 +0.00 +0.00 +0.01 +-0.01 +-0.01 +-0.52 +-0.01 +-0.52 +-0.52 +-0.03 +0.15 +-0.03 +0.15 +0.15 +-0.05 +0.15 +-0.05 +-0.03 +0.15 +0.15 +-0.05 +0.10 +-0.71 +0.10 +-0.71 +0.10 +-0.71 +-0.34 +-0.01 +-0.01 +-0.87 +-0.05 +-0.03 +0.20 +0.25 +0.20 +-0.61 +-0.05 +0.25 +0.17 +0.12 +-0.84 +0.12 +-0.84 +-0.37 +-0.01 +-0.01 +-0.87 +-0.03 +0.20 +-0.05 +0.20 +-0.61 +0.25 +-0.05 +0.25 +0.12 +-0.84 +0.17 +0.12 +-0.84 +-0.37 +-0.02 +-0.06 +-0.06 +0.33 +0.33 +-0.08 +0.19 +0.19 +0.13 +-0.97 +-0.41 +-0.01 +-0.01 +-0.87 +-0.05 +0.25 +-0.05 +0.25 +-0.03 +0.20 +0.20 +-0.61 +0.12 +-0.84 +0.12 +-0.84 +0.17 +-0.37 +-0.02 +-0.08 +-0.06 +0.33 +-0.06 +0.33 +0.19 +0.13 +-0.97 +0.19 +-0.41 +-0.02 +-0.06 +0.33 +-0.08 +-0.06 +0.33 +0.13 +-0.97 +0.19 +0.19 +-0.41 +-0.09 +-0.09 +-0.09 +0.21 +0.21 +0.21 +-0.44 +1.62 +-0.03 +0.04 +0.00 +0.05 +0.04 +-0.02 +0.05 +-0.03 +-0.19 +-0.11 +-0.16 +-0.19 +-0.03 +0.05 +0.07 +-0.11 +0.05 +-0.16 +0.07 +-0.29 +0.23 +-0.10 +-0.15 +-0.29 +0.23 +-0.61 +4.96 +0.06 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.04 +-0.11 +0.05 +0.00 +-0.02 +0.12 +-0.03 +0.15 +-0.19 +-0.16 +-0.22 +-0.03 +-0.57 +0.07 +0.10 +0.05 +-0.36 +0.07 +-0.51 +0.23 +-0.94 +-0.15 +-0.23 +-0.20 +0.29 +-0.88 +0.08 +-0.03 +-0.05 +-0.32 +-0.19 +-0.27 +-0.06 +0.08 +0.12 +0.08 +0.12 +0.38 +-0.16 +-0.25 +-0.48 +0.38 +-1.00 +1.62 +-0.03 +0.00 +0.04 +0.05 +0.04 +0.05 +-0.02 +-0.03 +-0.11 +-0.16 +-0.19 +0.05 +0.07 +-0.19 +-0.03 +-0.11 +-0.16 +0.05 +0.07 +-0.10 +-0.15 +-0.29 +0.23 +-0.29 +0.23 +-0.61 +4.96 +0.00 +0.00 +0.00 +0.06 +0.00 +0.00 +0.00 +0.00 +0.00 +0.04 +0.05 +-0.11 +0.00 +-0.02 +-0.03 +0.12 +0.15 +-0.16 +-0.22 +-0.19 +0.07 +0.10 +-0.03 +-0.57 +0.05 +0.07 +-0.36 +-0.51 +-0.15 +-0.23 +0.23 +-0.94 +-0.20 +0.29 +-0.88 +0.08 +-0.03 +-0.05 +-0.19 +-0.27 +-0.32 +0.08 +0.12 +-0.06 +0.08 +0.12 +-0.16 +-0.25 +0.38 +-0.48 +0.38 +-1.00 +4.96 +0.00 +0.00 +0.00 +0.00 +0.00 +0.06 +0.00 +0.00 +0.00 +0.04 +-0.02 +0.05 +-0.03 +-0.11 +0.12 +0.00 +0.15 +-0.19 +-0.03 +0.05 +0.07 +-0.57 +-0.36 +-0.51 +-0.16 +0.07 +-0.22 +0.10 +-0.20 +0.29 +-0.15 +-0.23 +0.23 +-0.94 +-0.88 +-0.03 +0.08 +-0.05 +-0.32 +-0.06 +0.08 +0.12 +-0.19 +0.08 +-0.27 +0.12 +-0.48 +0.38 +-0.16 +-0.25 +0.38 +-1.00 +15.15 +-0.03 +0.00 +-0.06 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.03 +0.00 +0.00 +0.00 +-0.02 +0.12 +-0.03 +0.15 +0.12 +-0.37 +0.15 +-0.05 +-0.03 +-0.57 +0.07 +0.10 +-0.57 +-0.51 +-0.71 +0.07 +-0.51 +0.10 +-0.71 +0.29 +-0.69 +-0.23 +-0.34 +0.29 +-0.69 +-1.25 +-0.05 +0.20 +0.25 +-0.06 +0.08 +0.12 +-0.94 +-0.59 +-0.84 +0.12 +0.17 +0.48 +-0.25 +-0.37 +0.38 +-1.55 +-1.45 +0.20 +-0.05 +0.25 +-0.06 +-0.94 +0.12 +0.17 +0.08 +-0.59 +0.12 +-0.84 +0.38 +-1.55 +-0.25 +-0.37 +0.48 +-1.45 +-0.08 +-0.09 +0.13 +0.19 +0.13 +0.19 +0.62 +-0.26 +-0.41 +0.62 +-1.66 +4.96 +0.00 +0.00 +0.00 +0.00 +0.00 +0.06 +0.00 +0.00 +0.00 +0.04 +0.05 +-0.02 +-0.03 +-0.11 +0.00 +0.12 +0.15 +0.05 +0.07 +-0.19 +-0.03 +-0.36 +-0.51 +-0.57 +-0.16 +-0.22 +0.07 +0.10 +-0.15 +-0.23 +-0.20 +0.29 +0.23 +-0.94 +-0.88 +0.08 +-0.03 +-0.05 +0.08 +0.12 +-0.32 +-0.06 +-0.19 +-0.27 +0.08 +0.12 +-0.16 +-0.25 +-0.48 +0.38 +0.38 +-1.00 +15.15 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.03 +-0.06 +0.00 +0.00 +0.00 +0.00 +-0.03 +0.00 +0.00 +0.00 +-0.02 +-0.03 +0.12 +0.15 +0.12 +0.15 +-0.37 +-0.05 +0.07 +0.10 +-0.03 +-0.57 +-0.51 +-0.71 +-0.57 +0.07 +0.10 +-0.51 +-0.71 +-0.23 +-0.34 +0.29 +-0.69 +0.29 +-0.69 +-1.25 +-0.05 +0.20 +0.25 +0.08 +0.12 +-0.06 +-0.59 +-0.84 +-0.94 +0.12 +0.17 +-0.25 +-0.37 +0.48 +0.38 +-1.55 +-1.45 +-0.05 +0.20 +0.25 +0.12 +0.17 +-0.06 +-0.94 +0.08 +0.12 +-0.59 +-0.84 +-0.25 +-0.37 +0.38 +-1.55 +0.48 +-1.45 +-0.08 +0.13 +0.19 +-0.09 +0.13 +0.19 +-0.26 +-0.41 +0.62 +0.62 +-1.66 +1.62 +-0.03 +0.04 +0.04 +-0.02 +0.00 +0.05 +0.05 +-0.03 +-0.11 +0.05 +-0.11 +0.05 +-0.16 +0.07 +-0.16 +0.07 +-0.19 +-0.19 +-0.03 +-0.29 +0.23 +-0.29 +0.23 +-0.10 +-0.15 +-0.61 +4.96 +0.06 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.04 +-0.11 +-0.02 +0.12 +0.05 +0.00 +-0.03 +0.15 +0.05 +-0.36 +-0.16 +0.07 +0.07 +-0.51 +-0.22 +0.10 +-0.19 +-0.03 +-0.57 +0.23 +-0.94 +-0.20 +0.29 +-0.15 +-0.23 +-0.88 +-0.03 +0.08 +-0.05 +0.08 +-0.19 +0.08 +0.12 +-0.27 +0.12 +-0.32 +-0.06 +0.38 +-0.48 +0.38 +-0.16 +-0.25 +-1.00 +4.96 +0.00 +0.00 +0.00 +0.06 +0.00 +0.00 +0.00 +0.00 +0.00 +0.04 +-0.02 +-0.11 +0.12 +0.05 +-0.03 +0.00 +0.15 +-0.16 +0.07 +0.05 +-0.36 +-0.22 +0.10 +0.07 +-0.51 +-0.19 +-0.03 +-0.57 +-0.20 +0.29 +0.23 +-0.94 +-0.15 +-0.23 +-0.88 +-0.03 +0.08 +-0.05 +-0.19 +0.08 +0.08 +-0.27 +0.12 +0.12 +-0.32 +-0.06 +-0.48 +0.38 +0.38 +-0.16 +-0.25 +-1.00 +15.15 +-0.03 +-0.06 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.03 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.02 +0.12 +0.12 +-0.37 +-0.03 +0.15 +0.15 +-0.05 +0.07 +-0.51 +0.07 +-0.51 +0.10 +-0.71 +0.10 +-0.71 +-0.03 +-0.57 +-0.57 +0.29 +-0.69 +0.29 +-0.69 +-0.23 +-0.34 +-1.25 +0.20 +-0.05 +0.25 +0.12 +0.08 +-0.59 +0.17 +0.12 +-0.84 +-0.06 +-0.94 +0.48 +0.38 +-1.55 +-0.25 +-0.37 +-1.45 +0.20 +-0.05 +0.25 +0.08 +-0.59 +0.12 +0.12 +-0.84 +0.17 +-0.06 +-0.94 +0.38 +-1.55 +0.48 +-0.25 +-0.37 +-1.45 +-0.08 +0.13 +0.13 +0.19 +0.19 +-0.09 +0.62 +0.62 +-0.26 +-0.41 +-1.66 +6.48 +-0.11 +0.05 +-0.16 +0.07 +-0.16 +0.07 +-0.22 +0.10 +-0.29 +0.23 +-0.10 +-0.15 +-0.20 +0.29 +-0.15 +-0.23 +-0.29 +0.23 +-0.20 +0.29 +-0.51 +-0.61 +-0.88 +-0.61 +-0.88 +-2.04 +19.71 +0.08 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.05 +-0.36 +0.07 +-0.51 +0.07 +-0.51 +0.10 +-0.71 +0.23 +-0.94 +-0.15 +-0.23 +0.29 +-0.69 +-0.23 +-0.34 +0.23 +-0.94 +0.29 +-0.69 +-0.51 +-0.88 +-1.25 +-0.88 +-1.25 +-2.03 +0.12 +0.12 +0.17 +0.38 +-0.16 +-0.25 +0.48 +-0.25 +-0.37 +0.38 +0.48 +-0.84 +-1.00 +-1.45 +-1.00 +-1.45 +-3.37 +6.48 +-0.11 +-0.16 +0.05 +0.07 +-0.16 +-0.22 +0.07 +0.10 +-0.10 +-0.15 +-0.29 +0.23 +-0.15 +-0.23 +-0.20 +0.29 +-0.29 +-0.20 +0.23 +0.29 +-0.61 +-0.88 +-0.51 +-0.61 +-0.88 +-2.04 +19.71 +0.00 +0.00 +0.00 +0.08 +0.00 +0.00 +0.00 +0.00 +0.00 +0.05 +0.07 +-0.36 +-0.51 +0.07 +0.10 +-0.51 +-0.71 +-0.15 +-0.23 +0.23 +-0.94 +-0.23 +-0.34 +0.29 +-0.69 +0.23 +0.29 +-0.94 +-0.69 +-0.88 +-1.25 +-0.51 +-0.88 +-1.25 +-2.03 +0.12 +0.12 +0.17 +-0.16 +-0.25 +0.38 +-0.25 +-0.37 +0.48 +0.38 +0.48 +-1.00 +-1.45 +-0.84 +-1.00 +-1.45 +-3.37 +6.48 +-0.11 +-0.16 +-0.16 +-0.22 +0.05 +0.07 +0.07 +0.10 +-0.29 +-0.20 +-0.29 +-0.20 +0.23 +0.29 +0.23 +0.29 +-0.10 +-0.15 +-0.15 +-0.23 +-0.61 +-0.88 +-0.61 +-0.88 +-0.51 +-2.04 +19.71 +0.00 +0.00 +0.00 +0.00 +0.00 +0.08 +0.00 +0.00 +0.00 +0.05 +0.07 +0.07 +0.10 +-0.36 +-0.51 +-0.51 +-0.71 +0.23 +0.29 +0.23 +0.29 +-0.94 +-0.69 +-0.94 +-0.69 +-0.15 +-0.23 +-0.23 +-0.34 +-0.88 +-1.25 +-0.88 +-1.25 +-0.51 +-2.03 +0.12 +0.12 +0.17 +0.38 +0.48 +0.38 +0.48 +-0.16 +-0.25 +-0.25 +-0.37 +-1.00 +-1.45 +-1.00 +-1.45 +-0.84 +-3.37 +24.65 +-0.10 +-0.15 +-0.15 +-0.23 +-0.15 +-0.23 +-0.23 +-0.34 +-0.61 +-0.88 +-0.61 +-0.88 +-0.88 +-1.25 +-0.88 +-1.25 +-0.61 +-0.88 +-0.88 +-1.25 +-2.04 +-2.03 +-2.04 +-2.03 +-2.04 +-2.03 +7.75 +0.01 +0.02 +-0.62 +0.18 +-0.74 +-1.90 +-0.87 +-0.13 +-1.03 +-1.22 +-1.44 +2.82 +-0.13 +-0.21 +0.00 +-0.29 +0.01 +-0.01 +0.08 +-0.05 +-0.03 +0.20 +0.12 +-0.01 +-0.39 +-0.01 +0.08 +-0.01 +0.12 +-0.05 +0.25 +0.10 +-0.31 +-0.40 +0.12 +-0.84 +-0.37 +0.17 +-0.37 +0.00 +0.02 +0.11 +-0.06 +-0.06 +0.13 +-0.01 +-0.15 +0.13 +0.16 +-0.08 +0.16 +-0.46 +0.19 +-0.44 +0.19 +-0.41 +7.75 +0.01 +0.02 +-0.62 +-0.74 +0.18 +-1.90 +-0.87 +-0.13 +-1.03 +-1.22 +-1.44 +2.82 +-0.13 +-0.21 +0.00 +0.01 +-0.29 +-0.01 +-0.03 +0.20 +0.08 +-0.05 +0.12 +-0.01 +-0.39 +0.10 +0.08 +-0.05 +-0.31 +-0.01 +0.25 +-0.01 +0.12 +-0.40 +-0.37 +0.17 +0.12 +-0.84 +-0.37 +0.00 +0.02 +-0.06 +0.11 +-0.06 +0.13 +-0.01 +0.16 +0.13 +-0.08 +-0.15 +0.16 +-0.46 +-0.44 +0.19 +0.19 +-0.41 +21.89 +-0.87 +-1.44 +-1.44 +-2.37 +-0.74 +-1.90 +-1.90 +0.16 +-0.13 +-0.13 +-1.22 +-3.13 +-0.22 +-1.22 +-3.13 +-0.22 +-2.01 +8.62 +-0.01 +-0.01 +-0.01 +-0.02 +0.01 +-0.01 +-0.01 +-0.87 +-0.05 +0.25 +-0.05 +0.25 +0.17 +-0.39 +-0.39 +0.12 +-0.05 +0.25 +-0.07 +0.25 +-0.09 +0.12 +-0.07 +-0.55 +0.17 +-1.16 +0.17 +-1.16 +-0.57 +0.02 +-0.02 +-0.06 +0.33 +-0.08 +0.19 +-0.65 +0.16 +-0.08 +-0.50 +0.41 +0.20 +-0.66 +0.28 +0.19 +-1.38 +-0.62 +0.02 +-0.02 +-0.08 +-0.06 +0.33 +0.19 +-0.65 +0.20 +-0.08 +0.41 +0.16 +-0.50 +-0.66 +0.19 +-1.38 +0.28 +-0.62 +0.03 +-0.09 +-0.09 +0.21 +0.26 +-0.13 +0.26 +-0.76 +0.32 +0.32 +-0.67 +3.76 +-0.09 +0.06 +0.08 +-0.03 +-0.05 +-0.32 +-0.06 +0.08 +0.12 +0.38 +-0.01 +0.10 +0.12 +-0.27 +-0.37 +-0.42 +0.12 +0.17 +-0.28 +-0.40 +-0.76 +-0.25 +-0.37 +-0.34 +0.48 +-1.45 +2.68 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.06 +0.06 +0.06 +-0.03 +-0.19 +0.08 +-0.19 +0.08 +-0.16 +0.08 +0.08 +-0.05 +-0.27 +-0.32 +0.12 +-0.32 +-0.06 +-0.27 +0.12 +-0.25 +-0.48 +0.38 +-0.48 +0.38 +-1.00 +8.18 +0.08 +0.13 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.06 +-0.18 +-0.03 +0.20 +-0.27 +0.12 +0.08 +-0.59 +-0.25 +-0.01 +-0.05 +0.25 +-0.37 +-0.32 +0.17 +-0.06 +-0.94 +0.12 +-0.84 +-0.37 +0.38 +-1.55 +-0.34 +0.48 +-1.45 +0.11 +-0.06 +-0.31 +0.13 +0.13 +-0.26 +-0.08 +-0.44 +-0.52 +0.19 +-0.09 +0.19 +-0.41 +0.62 +-0.79 +0.62 +-1.66 +11.49 +0.10 +0.16 +-0.03 +-0.05 +0.20 +0.25 +-0.06 +-0.94 +0.12 +0.17 +0.48 +0.12 +-0.31 +-0.07 +-0.42 +0.12 +0.17 +-0.84 +-1.16 +-0.40 +-0.55 +-0.59 +-0.37 +-0.57 +0.48 +-1.14 +-2.06 +-0.06 +-0.08 +-0.09 +0.13 +0.19 +0.62 +0.20 +-0.69 +0.19 +0.28 +-0.46 +-0.66 +-1.25 +-0.41 +-0.62 +0.79 +-2.40 +8.18 +0.08 +0.00 +0.13 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.06 +-0.03 +-0.18 +0.20 +0.08 +-0.59 +-0.27 +0.12 +-0.25 +-0.05 +-0.01 +0.25 +0.12 +-0.32 +-0.06 +-0.84 +-0.94 +-0.37 +0.17 +-0.37 +-0.34 +0.48 +0.38 +-1.55 +-1.45 +0.11 +-0.06 +0.13 +-0.31 +0.13 +-0.26 +-0.08 +0.19 +-0.52 +-0.09 +-0.44 +0.19 +-0.41 +-0.79 +0.62 +0.62 +-1.66 +24.98 +-0.05 +-0.08 +-0.08 +-0.13 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.03 +0.20 +0.20 +-0.61 +0.12 +-0.84 +0.12 +-0.84 +-0.37 +0.25 +0.25 +-0.09 +0.17 +-0.06 +-0.94 +-1.16 +-0.94 +0.17 +-1.16 +-0.57 +0.48 +-1.14 +0.48 +-1.14 +-2.06 +-0.06 +0.33 +0.13 +-0.97 +0.19 +-0.41 +0.41 +0.19 +-0.09 +-1.38 +-1.56 +0.28 +-0.62 +0.79 +0.62 +-2.56 +-2.40 +-0.06 +0.33 +0.19 +0.13 +-0.97 +-0.41 +0.41 +0.28 +-0.09 +-1.56 +0.19 +-1.38 +-0.62 +0.62 +-2.56 +0.79 +-2.40 +-0.09 +0.21 +0.21 +-0.44 +0.32 +-0.15 +0.32 +-0.67 +1.02 +1.02 +-2.73 +3.76 +-0.09 +0.06 +-0.03 +0.08 +-0.05 +0.08 +0.12 +-0.32 +-0.06 +0.38 +0.10 +-0.01 +0.12 +-0.28 +-0.27 +0.12 +-0.40 +-0.37 +0.17 +-0.42 +-0.76 +-0.34 +0.48 +-0.25 +-0.37 +-1.45 +11.49 +0.10 +0.16 +-0.03 +0.20 +-0.05 +0.25 +0.12 +0.17 +-0.06 +-0.94 +0.48 +-0.31 +0.12 +-0.07 +-0.40 +0.12 +-0.84 +-0.55 +0.17 +-1.16 +-0.42 +-0.59 +0.48 +-1.14 +-0.37 +-0.57 +-2.06 +-0.06 +-0.08 +0.13 +0.19 +-0.09 +0.62 +0.20 +-0.46 +0.19 +-0.66 +0.28 +-0.69 +-1.25 +0.79 +-0.41 +-0.62 +-2.40 +14.90 +-0.28 +0.08 +0.12 +0.12 +0.17 +0.38 +0.48 +0.38 +0.48 +-0.84 +-0.40 +-0.40 +-0.55 +-0.76 +-0.25 +-0.37 +-0.59 +-0.37 +-0.57 +-0.76 +-0.59 +-1.45 +-2.06 +-1.45 +-2.06 +-3.35 +10.68 +-0.27 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.19 +0.08 +-0.27 +0.12 +-0.16 +-0.25 +-0.48 +0.38 +-1.00 +0.12 +-0.37 +0.17 +-0.25 +-0.48 +0.38 +-0.37 +-0.34 +0.48 +-0.34 +0.48 +-1.45 +-0.84 +-1.00 +-1.45 +-3.37 +32.50 +0.12 +0.19 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.08 +-0.59 +0.12 +-0.84 +-0.25 +-0.37 +0.38 +-1.55 +-1.45 +-0.84 +0.17 +-1.16 +-0.37 +0.38 +-1.55 +-0.57 +0.48 +-1.14 +0.48 +-1.14 +-2.06 +-0.84 +-1.45 +-2.06 +-3.35 +0.13 +0.19 +-0.26 +-0.41 +0.62 +-1.66 +0.28 +-0.41 +0.62 +-0.62 +0.79 +0.79 +-2.40 +-1.39 +-1.66 +-2.40 +-5.55 +10.68 +-0.27 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.19 +-0.27 +0.08 +0.12 +-0.48 +0.38 +-0.16 +-0.25 +-1.00 +-0.37 +0.12 +0.17 +-0.34 +-0.48 +-0.34 +0.48 +0.38 +0.48 +-0.25 +-0.37 +-1.45 +-1.00 +-1.45 +-0.84 +-3.37 +32.50 +0.12 +0.00 +0.19 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.08 +0.12 +-0.59 +-0.84 +0.38 +-1.55 +-0.25 +-0.37 +-1.45 +0.17 +-0.84 +-1.16 +0.48 +0.38 +0.48 +-1.14 +-1.55 +-1.14 +-0.37 +-0.57 +-2.06 +-1.45 +-2.06 +-0.84 +-3.35 +0.13 +0.19 +0.62 +-0.26 +-0.41 +-1.66 +0.28 +0.79 +0.62 +0.79 +-0.41 +-0.62 +-2.40 +-1.66 +-2.40 +-1.39 +-5.55 +40.65 +-0.25 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.16 +-0.25 +-0.25 +-0.37 +-1.00 +-1.45 +-1.00 +-1.45 +-3.37 +-0.37 +-0.37 +-0.57 +-1.45 +-1.00 +-1.45 +-2.06 +-1.45 +-2.06 +-1.45 +-2.06 +-3.35 +-3.37 +-3.35 +-3.37 +-3.35 +7.75 +0.02 +0.01 +-0.62 +0.18 +-0.74 +-1.90 +-1.03 +-1.22 +-0.87 +-0.13 +-1.44 +2.82 +-0.21 +-0.13 +0.00 +-0.29 +0.01 +-0.01 +0.08 +-0.05 +-0.03 +0.20 +0.12 +0.00 +0.02 +0.11 +-0.06 +-0.06 +0.13 +-0.01 +-0.39 +0.08 +-0.01 +-0.01 +-0.05 +0.25 +0.12 +0.10 +-0.31 +0.12 +-0.84 +-0.40 +-0.37 +0.17 +-0.37 +-0.01 +0.13 +-0.15 +-0.08 +0.16 +0.16 +0.19 +-0.46 +-0.44 +0.19 +-0.41 +7.75 +0.01 +0.02 +-0.62 +-0.74 +0.18 +-1.90 +-0.87 +-0.13 +-1.03 +-1.22 +-1.44 +2.82 +-0.13 +-0.21 +0.00 +0.01 +-0.29 +-0.01 +-0.03 +0.20 +0.08 +-0.05 +0.12 +-0.01 +-0.39 +0.08 +-0.05 +0.10 +-0.01 +0.25 +-0.31 +-0.01 +0.12 +-0.37 +0.17 +-0.40 +0.12 +-0.84 +-0.37 +0.00 +0.02 +-0.06 +0.11 +-0.06 +0.13 +-0.01 +0.13 +-0.08 +0.16 +-0.15 +0.16 +-0.44 +0.19 +-0.46 +0.19 +-0.41 +21.89 +-1.44 +-2.37 +-0.87 +-1.44 +-0.74 +-1.90 +-1.90 +0.16 +-1.22 +-3.13 +-0.13 +-0.13 +-0.22 +-1.22 +-3.13 +-2.01 +-0.22 +8.62 +-0.01 +-0.02 +-0.01 +-0.01 +0.01 +-0.01 +-0.01 +-0.87 +-0.05 +0.25 +-0.05 +0.25 +0.17 +0.02 +-0.02 +-0.06 +0.33 +-0.08 +0.19 +-0.39 +-0.39 +-0.05 +0.25 +0.12 +0.25 +-0.09 +-0.07 +0.12 +-0.07 +0.17 +-1.16 +-0.55 +0.17 +-1.16 +-0.57 +-0.65 +-0.08 +0.16 +0.41 +-0.50 +0.20 +0.28 +-0.66 +0.19 +-1.38 +-0.62 +0.02 +-0.02 +-0.08 +-0.06 +0.33 +0.19 +0.03 +-0.09 +-0.09 +0.21 +-0.65 +-0.08 +0.41 +0.20 +0.16 +-0.50 +0.19 +-1.38 +-0.66 +0.28 +-0.62 +-0.13 +0.26 +0.26 +0.32 +-0.76 +0.32 +-0.67 +2.68 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.06 +0.06 +0.06 +-0.03 +-0.19 +0.08 +-0.19 +0.08 +-0.16 +0.08 +0.08 +-0.05 +-0.32 +-0.27 +-0.32 +-0.06 +0.12 +-0.27 +0.12 +-0.48 +0.38 +-0.25 +-0.48 +0.38 +-1.00 +8.18 +0.00 +0.13 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.08 +0.00 +0.00 +0.00 +0.00 +0.00 +0.06 +-0.18 +-0.03 +0.20 +-0.27 +0.12 +0.08 +-0.59 +-0.25 +0.11 +-0.06 +-0.31 +0.13 +0.13 +-0.26 +-0.01 +-0.05 +0.25 +-0.32 +-0.37 +-0.06 +-0.94 +0.17 +0.12 +-0.84 +0.38 +-1.55 +-0.37 +-0.34 +0.48 +-1.45 +-0.08 +-0.52 +-0.44 +-0.09 +0.19 +0.19 +0.62 +-0.41 +-0.79 +0.62 +-1.66 +3.76 +-0.09 +0.06 +0.08 +-0.03 +-0.05 +-0.32 +-0.06 +0.08 +0.12 +0.38 +-0.01 +0.10 +0.12 +-0.27 +-0.37 +0.12 +0.17 +-0.42 +-0.28 +-0.40 +-0.25 +-0.37 +-0.76 +-0.34 +0.48 +-1.45 +8.18 +0.00 +0.00 +0.00 +0.00 +0.00 +0.08 +0.13 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.06 +-0.03 +-0.18 +0.20 +0.08 +-0.59 +-0.27 +0.12 +-0.25 +-0.05 +-0.01 +0.25 +-0.32 +-0.06 +0.12 +-0.94 +-0.84 +-0.37 +0.17 +-0.34 +0.48 +-0.37 +0.38 +-1.55 +-1.45 +0.11 +-0.06 +0.13 +-0.31 +0.13 +-0.26 +-0.08 +-0.52 +-0.09 +0.19 +-0.44 +0.19 +-0.79 +0.62 +-0.41 +0.62 +-1.66 +24.98 +0.00 +-0.08 +0.00 +-0.13 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.05 +-0.08 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.03 +0.20 +0.20 +-0.61 +0.12 +-0.84 +0.12 +-0.84 +-0.37 +-0.06 +0.33 +0.13 +-0.97 +0.19 +-0.41 +0.25 +0.25 +-0.09 +-0.06 +-0.94 +0.17 +-0.94 +-1.16 +0.17 +-1.16 +0.48 +-1.14 +-0.57 +0.48 +-1.14 +-2.06 +0.41 +-0.09 +0.19 +-1.56 +-1.38 +0.28 +0.79 +-0.62 +0.62 +-2.56 +-2.40 +-0.06 +0.33 +0.19 +0.13 +-0.97 +-0.41 +-0.09 +0.21 +0.21 +-0.44 +0.41 +-0.09 +-1.56 +0.28 +0.19 +-1.38 +0.62 +-2.56 +-0.62 +0.79 +-2.40 +-0.15 +0.32 +0.32 +1.02 +-0.67 +1.02 +-2.73 +11.49 +0.10 +0.16 +-0.03 +-0.05 +0.20 +0.25 +-0.06 +-0.94 +0.12 +0.17 +0.48 +0.12 +-0.31 +-0.07 +0.12 +0.17 +-0.42 +-0.84 +-1.16 +-0.40 +-0.55 +-0.37 +-0.57 +-0.59 +0.48 +-1.14 +-2.06 +-0.06 +-0.08 +-0.09 +0.13 +0.19 +0.62 +0.20 +0.19 +0.28 +-0.69 +-0.46 +-0.66 +-0.41 +-0.62 +-1.25 +0.79 +-2.40 +3.76 +-0.09 +0.06 +-0.03 +0.08 +-0.05 +0.08 +0.12 +-0.32 +-0.06 +0.38 +0.10 +-0.01 +0.12 +-0.27 +0.12 +-0.28 +-0.37 +0.17 +-0.40 +-0.42 +-0.34 +0.48 +-0.76 +-0.25 +-0.37 +-1.45 +11.49 +0.16 +0.10 +-0.03 +0.20 +-0.05 +0.25 +0.12 +0.17 +-0.06 +-0.94 +0.48 +-0.06 +-0.08 +0.13 +0.19 +-0.09 +0.62 +-0.31 +0.12 +-0.07 +0.12 +-0.84 +-0.40 +0.17 +-1.16 +-0.55 +-0.42 +0.48 +-1.14 +-0.59 +-0.37 +-0.57 +-2.06 +0.20 +0.19 +-0.46 +0.28 +-0.66 +-0.69 +0.79 +-1.25 +-0.41 +-0.62 +-2.40 +10.68 +0.00 +0.00 +0.00 +-0.27 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.19 +0.08 +-0.27 +0.12 +-0.16 +-0.25 +-0.48 +0.38 +-1.00 +0.12 +-0.37 +0.17 +-0.48 +0.38 +-0.25 +-0.34 +0.48 +-0.37 +-0.34 +0.48 +-0.84 +-1.45 +-1.00 +-1.45 +-3.37 +32.50 +0.00 +0.19 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.12 +0.00 +0.00 +0.00 +0.00 +0.00 +0.08 +-0.59 +0.12 +-0.84 +-0.25 +-0.37 +0.38 +-1.55 +-1.45 +0.13 +0.19 +-0.26 +-0.41 +0.62 +-1.66 +-0.84 +0.17 +-1.16 +0.38 +-1.55 +-0.37 +0.48 +-1.14 +-0.57 +0.48 +-1.14 +-0.84 +-2.06 +-1.45 +-2.06 +-3.35 +0.28 +0.62 +-0.41 +0.79 +-0.62 +0.79 +-1.39 +-2.40 +-1.66 +-2.40 +-5.55 +14.90 +-0.28 +0.08 +0.12 +0.12 +0.17 +0.38 +0.48 +0.38 +0.48 +-0.84 +-0.40 +-0.40 +-0.55 +-0.25 +-0.37 +-0.76 +-0.37 +-0.57 +-0.59 +-0.76 +-0.59 +-1.45 +-2.06 +-1.45 +-2.06 +-3.35 +10.68 +0.00 +0.00 +0.00 +-0.27 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.19 +-0.27 +0.08 +0.12 +-0.48 +0.38 +-0.16 +-0.25 +-1.00 +-0.37 +0.12 +0.17 +-0.48 +-0.34 +-0.34 +0.38 +0.48 +0.48 +-0.25 +-0.37 +-1.00 +-1.45 +-1.45 +-0.84 +-3.37 +32.50 +0.00 +0.00 +0.00 +0.00 +0.00 +0.12 +0.19 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.08 +0.12 +-0.59 +-0.84 +0.38 +-1.55 +-0.25 +-0.37 +-1.45 +0.17 +-0.84 +-1.16 +0.38 +0.48 +0.48 +-1.55 +-1.14 +-1.14 +-0.37 +-0.57 +-1.45 +-2.06 +-2.06 +-0.84 +-3.35 +0.13 +0.19 +0.62 +-0.26 +-0.41 +-1.66 +0.28 +0.62 +0.79 +0.79 +-0.41 +-0.62 +-1.66 +-2.40 +-2.40 +-1.39 +-5.55 +40.65 +0.00 +0.00 +0.00 +-0.25 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.16 +-0.25 +-0.25 +-0.37 +-1.00 +-1.45 +-1.00 +-1.45 +-3.37 +-0.37 +-0.37 +-0.57 +-1.00 +-1.45 +-1.45 +-1.45 +-2.06 +-2.06 +-1.45 +-2.06 +-3.37 +-3.35 +-3.35 +-3.37 +-3.35 +15.04 +-0.24 +-0.40 +-1.22 +-3.13 +-1.44 +-0.22 +-1.44 +-0.22 +-2.01 +-2.37 +-2.37 +6.55 +-0.29 +-0.48 +0.02 +-0.02 +-0.08 +-0.01 +-0.65 +-0.08 +0.41 +0.20 +0.28 +-0.01 +-0.65 +-0.08 +0.41 +0.20 +0.28 +0.20 +0.20 +-0.12 +-0.12 +-0.08 +-0.91 +-0.91 +0.28 +-1.92 +-0.93 +0.03 +-0.09 +-0.02 +-0.13 +0.26 +0.32 +-0.02 +-0.13 +0.26 +0.32 +0.32 +0.32 +-0.42 +-1.08 +-1.08 +0.47 +-1.02 +6.21 +-0.02 +0.11 +-0.06 +0.13 +-0.15 +0.16 +-0.44 +0.19 +-0.46 +-0.41 +0.13 +-0.08 +-0.52 +-0.09 +0.19 +0.62 +0.20 +-0.61 +-0.69 +0.28 +-0.66 +-1.25 +-0.62 +-0.55 +0.79 +-2.40 +6.21 +-0.02 +0.11 +-0.06 +0.13 +0.13 +-0.08 +-0.52 +-0.09 +0.19 +0.62 +-0.15 +0.16 +-0.44 +0.19 +-0.46 +-0.41 +0.20 +-0.61 +0.28 +-0.69 +-0.66 +-0.62 +-1.25 +-0.55 +0.79 +-2.40 +18.95 +0.20 +0.32 +-0.06 +0.33 +0.19 +0.16 +-0.50 +0.19 +-1.38 +-0.66 +-0.62 +-0.08 +0.41 +-0.09 +-1.56 +0.28 +0.79 +-0.12 +-0.69 +0.28 +-1.92 +-0.91 +-0.97 +-0.93 +0.79 +-1.88 +-3.40 +-0.09 +0.21 +0.26 +0.32 +-0.76 +-0.67 +-0.13 +-0.15 +0.32 +1.02 +-1.14 +0.47 +-1.08 +-2.07 +-1.02 +1.31 +-3.95 +18.95 +0.20 +0.32 +-0.06 +0.33 +0.19 +-0.08 +0.41 +-0.09 +-1.56 +0.28 +0.79 +0.16 +-0.50 +0.19 +-1.38 +-0.66 +-0.62 +-0.12 +0.28 +-0.69 +-1.92 +-0.91 +-0.93 +-0.97 +0.79 +-1.88 +-3.40 +-0.09 +0.21 +-0.13 +-0.15 +0.32 +1.02 +0.26 +0.32 +-0.76 +-0.67 +0.47 +-1.14 +-1.08 +-1.02 +-2.07 +1.31 +-3.95 +8.71 +-0.25 +-0.06 +-0.08 +-0.09 +0.16 +0.20 +0.19 +0.28 +-0.69 +0.79 +0.16 +0.20 +0.19 +0.28 +-0.69 +0.79 +-0.08 +-0.66 +-0.66 +-0.91 +-0.91 +-0.97 +-0.97 +-0.62 +-0.93 +-3.40 +24.56 +-0.66 +0.13 +0.19 +0.62 +-0.46 +-0.66 +-0.41 +-0.62 +-1.25 +-2.40 +0.19 +0.28 +0.62 +0.79 +0.79 +-1.39 +-0.91 +-1.25 +-0.62 +-0.97 +-0.93 +-0.97 +-3.40 +-2.40 +-3.40 +-5.52 +24.56 +-0.66 +0.13 +0.19 +0.62 +0.19 +0.28 +0.62 +0.79 +0.79 +-1.39 +-0.46 +-0.66 +-0.41 +-0.62 +-1.25 +-2.40 +-0.91 +-0.62 +-1.25 +-0.93 +-0.97 +-0.97 +-3.40 +-2.40 +-3.40 +-5.52 +17.60 +0.00 +-0.61 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.31 +0.13 +-0.26 +-0.44 +0.19 +-0.79 +0.62 +-0.41 +-1.66 +-0.44 +0.19 +-0.79 +0.62 +-0.41 +-1.66 +0.28 +-0.55 +-0.55 +0.79 +0.79 +-0.62 +-2.40 +-2.40 +-1.39 +-5.55 +53.59 +0.00 +0.28 +0.00 +0.47 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.13 +-0.97 +-0.41 +0.19 +-1.38 +0.62 +-2.56 +-0.62 +-2.40 +0.19 +-1.38 +0.62 +-2.56 +-0.62 +-2.40 +-1.92 +0.79 +0.79 +-1.88 +-1.88 +-0.93 +-3.40 +-3.40 +-1.39 +-5.52 +0.21 +-0.44 +0.32 +1.02 +-0.67 +-2.73 +0.32 +1.02 +-0.67 +-2.73 +1.31 +1.31 +-1.02 +-3.95 +-3.95 +-2.29 +-9.15 +67.02 +0.00 +-0.62 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.26 +-0.41 +-1.66 +-0.41 +-0.62 +-1.66 +-2.40 +-2.40 +-5.55 +-0.41 +-0.62 +-1.66 +-2.40 +-2.40 +-5.55 +-0.93 +-2.40 +-2.40 +-3.40 +-3.40 +-3.40 +-5.52 +-5.52 +-5.55 +-5.52 +7.75 +0.02 +0.01 +-0.62 +0.18 +-0.74 +-1.90 +-1.03 +-1.22 +-0.87 +-0.13 +-1.44 +2.82 +-0.21 +-0.13 +0.00 +-0.29 +0.01 +-0.01 +-0.03 +0.20 +0.08 +-0.05 +0.12 +0.00 +0.02 +-0.06 +0.11 +-0.06 +0.13 +-0.01 +-0.39 +0.10 +-0.31 +-0.01 +0.12 +0.08 +-0.01 +-0.05 +0.25 +0.12 +-0.84 +-0.37 +0.17 +-0.40 +-0.37 +-0.01 +0.16 +-0.15 +0.16 +0.13 +-0.08 +0.19 +-0.44 +0.19 +-0.46 +-0.41 +7.75 +0.02 +0.01 +-0.62 +-0.74 +0.18 +-1.90 +-1.03 +-1.22 +-0.87 +-0.13 +-1.44 +2.82 +-0.21 +-0.13 +0.00 +0.01 +-0.29 +-0.01 +0.08 +-0.05 +-0.03 +0.20 +0.12 +0.00 +0.02 +0.11 +-0.06 +-0.06 +0.13 +-0.01 +-0.39 +-0.01 +0.12 +0.10 +-0.31 +0.08 +-0.05 +-0.01 +0.25 +-0.37 +0.17 +0.12 +-0.84 +-0.40 +-0.37 +-0.01 +-0.15 +0.16 +0.16 +0.13 +-0.08 +-0.44 +0.19 +0.19 +-0.46 +-0.41 +21.89 +-1.44 +-2.37 +-1.44 +-0.87 +-0.74 +-1.90 +-1.90 +0.16 +-1.22 +-3.13 +-1.22 +-3.13 +-2.01 +-0.13 +-0.13 +-0.22 +-0.22 +8.62 +-0.01 +-0.02 +-0.01 +-0.01 +0.01 +-0.01 +-0.01 +-0.87 +-0.05 +0.25 +-0.05 +0.25 +0.17 +0.02 +-0.02 +-0.08 +-0.06 +0.33 +0.19 +0.02 +-0.02 +-0.06 +0.33 +-0.08 +0.19 +0.03 +-0.09 +-0.09 +0.21 +-0.39 +-0.39 +0.12 +-0.07 +0.12 +-0.07 +-0.05 +0.25 +0.25 +-0.09 +0.17 +-1.16 +0.17 +-1.16 +-0.55 +-0.57 +-0.65 +0.20 +0.16 +-0.50 +-0.08 +0.41 +0.28 +0.19 +-1.38 +-0.66 +-0.62 +-0.65 +0.16 +-0.50 +0.20 +-0.08 +0.41 +0.19 +-1.38 +0.28 +-0.66 +-0.62 +0.26 +0.26 +-0.13 +0.32 +0.32 +-0.76 +-0.67 +3.76 +-0.09 +0.06 +-0.03 +0.08 +-0.05 +-0.32 +-0.06 +0.08 +0.12 +0.38 +0.10 +-0.01 +0.12 +-0.42 +-0.28 +-0.40 +-0.27 +0.12 +-0.37 +0.17 +-0.34 +0.48 +-0.25 +-0.37 +-0.76 +-1.45 +11.49 +0.16 +0.10 +-0.03 +0.20 +-0.05 +0.25 +-0.06 +-0.94 +0.12 +0.17 +0.48 +-0.06 +-0.08 +-0.09 +0.13 +0.19 +0.62 +-0.31 +0.12 +-0.07 +-0.42 +-0.40 +-0.55 +0.12 +-0.84 +0.17 +-1.16 +0.48 +-1.14 +-0.37 +-0.57 +-0.59 +-2.06 +0.20 +-0.69 +-0.46 +-0.66 +0.19 +0.28 +0.79 +-0.41 +-0.62 +-1.25 +-2.40 +3.76 +-0.09 +0.06 +0.08 +-0.03 +-0.05 +0.08 +0.12 +-0.32 +-0.06 +0.38 +-0.01 +0.10 +0.12 +-0.28 +-0.40 +-0.42 +-0.27 +-0.37 +0.12 +0.17 +-0.25 +-0.37 +-0.34 +0.48 +-0.76 +-1.45 +11.49 +0.16 +0.10 +-0.03 +-0.05 +0.20 +0.25 +0.12 +0.17 +-0.06 +-0.94 +0.48 +-0.06 +-0.08 +0.13 +0.19 +-0.09 +0.62 +0.12 +-0.31 +-0.07 +-0.40 +-0.55 +-0.42 +0.12 +0.17 +-0.84 +-1.16 +-0.37 +-0.57 +0.48 +-1.14 +-0.59 +-2.06 +0.20 +-0.46 +-0.66 +-0.69 +0.19 +0.28 +-0.41 +-0.62 +0.79 +-1.25 +-2.40 +2.68 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.06 +0.06 +0.06 +-0.03 +-0.19 +0.08 +-0.19 +0.08 +-0.16 +0.08 +0.08 +-0.05 +-0.27 +0.12 +-0.27 +0.12 +-0.32 +-0.32 +-0.06 +-0.48 +0.38 +-0.48 +0.38 +-0.25 +-1.00 +8.18 +0.00 +0.00 +0.13 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.08 +0.00 +0.00 +0.00 +0.06 +-0.18 +-0.03 +0.20 +0.08 +-0.59 +-0.27 +0.12 +-0.25 +0.11 +-0.06 +0.13 +-0.31 +0.13 +-0.26 +-0.01 +-0.05 +0.25 +0.12 +-0.84 +-0.37 +0.17 +-0.32 +-0.06 +-0.94 +0.38 +-1.55 +-0.34 +0.48 +-0.37 +-1.45 +-0.08 +0.19 +-0.44 +0.19 +-0.52 +-0.09 +0.62 +-0.79 +0.62 +-0.41 +-1.66 +8.18 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.13 +0.00 +0.00 +0.00 +0.00 +0.08 +0.00 +0.00 +0.00 +0.06 +-0.03 +-0.18 +0.20 +-0.27 +0.12 +0.08 +-0.59 +-0.25 +0.11 +-0.06 +-0.31 +0.13 +0.13 +-0.26 +-0.05 +-0.01 +0.25 +-0.37 +0.17 +0.12 +-0.84 +-0.32 +-0.06 +-0.94 +-0.34 +0.48 +0.38 +-1.55 +-0.37 +-1.45 +-0.08 +-0.44 +0.19 +0.19 +-0.52 +-0.09 +-0.79 +0.62 +0.62 +-0.41 +-1.66 +24.98 +0.00 +0.00 +-0.08 +-0.13 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.08 +0.00 +0.00 +0.00 +0.00 +-0.05 +0.00 +0.00 +0.00 +-0.03 +0.20 +0.20 +-0.61 +0.12 +-0.84 +0.12 +-0.84 +-0.37 +-0.06 +0.33 +0.19 +0.13 +-0.97 +-0.41 +-0.06 +0.33 +0.13 +-0.97 +0.19 +-0.41 +-0.09 +0.21 +0.21 +-0.44 +0.25 +0.25 +-0.09 +0.17 +-1.16 +0.17 +-1.16 +-0.06 +-0.94 +-0.94 +0.48 +-1.14 +0.48 +-1.14 +-0.57 +-2.06 +0.41 +0.28 +0.19 +-1.38 +-0.09 +-1.56 +0.79 +0.62 +-2.56 +-0.62 +-2.40 +0.41 +0.19 +-1.38 +0.28 +-0.09 +-1.56 +0.62 +-2.56 +0.79 +-0.62 +-2.40 +0.32 +0.32 +-0.15 +1.02 +1.02 +-0.67 +-2.73 +10.68 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.27 +0.00 +0.00 +0.00 +-0.19 +0.08 +-0.27 +0.12 +-0.48 +0.38 +-0.16 +-0.25 +-1.00 +0.12 +-0.37 +0.17 +-0.34 +0.48 +-0.25 +-0.37 +-0.48 +0.38 +-0.34 +0.48 +-0.84 +-1.00 +-1.45 +-1.45 +-3.37 +32.50 +0.00 +0.00 +0.19 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.12 +0.00 +0.00 +0.00 +0.08 +-0.59 +0.12 +-0.84 +0.38 +-1.55 +-0.25 +-0.37 +-1.45 +0.13 +0.19 +0.62 +-0.26 +-0.41 +-1.66 +-0.84 +0.17 +-1.16 +0.48 +-1.14 +-0.37 +-0.57 +0.38 +-1.55 +0.48 +-1.14 +-0.84 +-1.45 +-2.06 +-2.06 +-3.35 +0.28 +0.79 +-0.41 +-0.62 +0.62 +0.79 +-1.39 +-1.66 +-2.40 +-2.40 +-5.55 +10.68 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.27 +0.00 +0.00 +0.00 +-0.19 +-0.27 +0.08 +0.12 +-0.16 +-0.25 +-0.48 +0.38 +-1.00 +-0.37 +0.12 +0.17 +-0.25 +-0.37 +-0.34 +0.48 +-0.48 +-0.34 +0.38 +0.48 +-1.00 +-1.45 +-0.84 +-1.45 +-3.37 +32.50 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.19 +0.00 +0.00 +0.00 +0.00 +0.12 +0.00 +0.00 +0.00 +0.08 +0.12 +-0.59 +-0.84 +-0.25 +-0.37 +0.38 +-1.55 +-1.45 +0.13 +0.19 +-0.26 +-0.41 +0.62 +-1.66 +0.17 +-0.84 +-1.16 +-0.37 +-0.57 +0.48 +-1.14 +0.38 +0.48 +-1.55 +-1.14 +-1.45 +-2.06 +-0.84 +-2.06 +-3.35 +0.28 +-0.41 +-0.62 +0.79 +0.62 +0.79 +-1.66 +-2.40 +-1.39 +-2.40 +-5.55 +14.90 +-0.28 +0.08 +0.12 +0.12 +0.17 +0.38 +0.48 +0.38 +0.48 +-0.84 +-0.40 +-0.40 +-0.55 +-0.76 +-0.59 +-0.76 +-0.59 +-0.25 +-0.37 +-0.37 +-0.57 +-1.45 +-2.06 +-1.45 +-2.06 +-3.35 +40.65 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.25 +0.00 +0.00 +0.00 +-0.16 +-0.25 +-0.25 +-0.37 +-1.00 +-1.45 +-1.00 +-1.45 +-3.37 +-0.37 +-0.37 +-0.57 +-1.45 +-2.06 +-1.45 +-2.06 +-1.00 +-1.45 +-1.45 +-2.06 +-3.37 +-3.35 +-3.37 +-3.35 +-3.35 +15.04 +-0.24 +-0.40 +-1.22 +-3.13 +-1.44 +-0.22 +-2.01 +-2.37 +-1.44 +-0.22 +-2.37 +6.55 +-0.29 +-0.48 +0.02 +-0.02 +-0.08 +-0.01 +-0.65 +0.20 +-0.08 +0.41 +0.28 +0.03 +-0.09 +-0.02 +0.26 +-0.13 +0.32 +-0.01 +-0.65 +0.20 +-0.08 +0.41 +0.28 +-0.08 +0.20 +-0.12 +0.20 +-0.12 +-0.91 +0.28 +-1.92 +-0.91 +-0.93 +-0.02 +0.26 +-0.13 +0.32 +-0.42 +0.32 +0.32 +-1.08 +0.47 +-1.08 +-1.02 +8.71 +-0.25 +-0.06 +-0.08 +-0.09 +0.16 +0.20 +-0.69 +0.19 +0.28 +0.79 +0.16 +0.20 +-0.69 +0.19 +0.28 +0.79 +-0.08 +-0.66 +-0.91 +-0.66 +-0.91 +-0.97 +-0.62 +-0.93 +-0.97 +-3.40 +6.21 +-0.02 +0.11 +-0.06 +0.13 +0.13 +-0.08 +0.19 +-0.52 +-0.09 +0.62 +-0.15 +0.16 +-0.46 +-0.44 +0.19 +-0.41 +0.20 +-0.66 +-0.69 +-0.61 +0.28 +-0.62 +-0.55 +0.79 +-1.25 +-2.40 +18.95 +0.20 +0.32 +-0.06 +0.33 +0.19 +-0.08 +0.41 +0.28 +-0.09 +-1.56 +0.79 +-0.09 +0.21 +-0.13 +0.32 +-0.15 +1.02 +0.16 +-0.50 +-0.66 +0.19 +-1.38 +-0.62 +-0.12 +-0.91 +-0.69 +0.28 +-1.92 +-0.93 +0.79 +-1.88 +-0.97 +-3.40 +0.26 +-0.76 +0.32 +-0.67 +-1.08 +-1.14 +0.47 +-1.02 +1.31 +-2.07 +-3.95 +6.21 +-0.02 +0.11 +-0.06 +0.13 +-0.15 +0.16 +-0.46 +-0.44 +0.19 +-0.41 +0.13 +-0.08 +0.19 +-0.52 +-0.09 +0.62 +0.20 +-0.66 +-0.61 +0.28 +-0.69 +-1.25 +-0.55 +0.79 +-0.62 +-2.40 +18.95 +0.20 +0.32 +-0.06 +0.33 +0.19 +0.16 +-0.50 +-0.66 +0.19 +-1.38 +-0.62 +-0.09 +0.21 +0.26 +-0.76 +0.32 +-0.67 +-0.08 +0.41 +0.28 +-0.09 +-1.56 +0.79 +-0.12 +-0.91 +0.28 +-1.92 +-0.69 +-0.97 +0.79 +-1.88 +-0.93 +-3.40 +-0.13 +0.32 +-0.15 +1.02 +-1.08 +0.47 +-1.14 +-2.07 +1.31 +-1.02 +-3.95 +24.56 +-0.66 +0.13 +0.19 +0.62 +-0.46 +-0.66 +-1.25 +-0.41 +-0.62 +-2.40 +0.19 +0.28 +0.79 +0.62 +0.79 +-1.39 +-0.91 +-0.97 +-0.62 +-0.93 +-1.25 +-0.97 +-2.40 +-3.40 +-3.40 +-5.52 +17.60 +0.00 +0.00 +-0.61 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.31 +0.13 +-0.26 +-0.44 +0.19 +-0.41 +-0.79 +0.62 +-1.66 +-0.44 +0.19 +-0.41 +-0.79 +0.62 +-1.66 +0.28 +-0.62 +-0.55 +0.79 +-0.55 +0.79 +-2.40 +-1.39 +-2.40 +-5.55 +53.59 +0.00 +0.00 +0.28 +0.47 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.13 +-0.97 +-0.41 +0.19 +-1.38 +-0.62 +0.62 +-2.56 +-2.40 +0.21 +-0.44 +0.32 +-0.67 +1.02 +-2.73 +0.19 +-1.38 +-0.62 +0.62 +-2.56 +-2.40 +-1.92 +-0.93 +0.79 +-1.88 +0.79 +-1.88 +-3.40 +-1.39 +-3.40 +-5.52 +0.32 +-0.67 +1.02 +-2.73 +-1.02 +1.31 +1.31 +-3.95 +-2.29 +-3.95 +-9.15 +24.56 +-0.66 +0.13 +0.19 +0.62 +0.19 +0.28 +0.79 +0.62 +0.79 +-1.39 +-0.46 +-0.66 +-1.25 +-0.41 +-0.62 +-2.40 +-0.91 +-0.97 +-1.25 +-0.97 +-0.62 +-0.93 +-3.40 +-2.40 +-3.40 +-5.52 +67.02 +0.00 +0.00 +-0.62 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.26 +-0.41 +-1.66 +-0.41 +-0.62 +-2.40 +-1.66 +-2.40 +-5.55 +-0.41 +-0.62 +-2.40 +-1.66 +-2.40 +-5.55 +-0.93 +-3.40 +-2.40 +-3.40 +-2.40 +-3.40 +-5.52 +-5.55 +-5.52 +-5.52 +15.04 +-0.40 +-0.24 +-1.22 +-3.13 +-2.01 +-1.44 +-0.22 +-2.37 +-1.44 +-0.22 +-2.37 +6.55 +-0.48 +-0.29 +0.02 +-0.02 +-0.08 +0.03 +-0.09 +-0.01 +-0.65 +-0.08 +0.41 +0.20 +0.28 +-0.02 +-0.13 +0.26 +0.32 +-0.01 +-0.65 +0.20 +-0.08 +0.41 +0.28 +-0.02 +0.26 +-0.13 +0.32 +0.20 +-0.12 +-0.08 +0.20 +-0.12 +0.28 +-1.92 +-0.91 +-0.91 +-0.93 +0.32 +-0.42 +0.32 +0.47 +-1.08 +-1.08 +-1.02 +6.21 +-0.02 +0.11 +-0.06 +0.13 +0.13 +-0.08 +-0.52 +-0.09 +0.19 +0.62 +-0.15 +0.16 +-0.46 +-0.44 +0.19 +-0.41 +0.20 +-0.69 +-0.66 +-0.61 +0.28 +-0.55 +0.79 +-0.62 +-1.25 +-2.40 +18.95 +0.32 +0.20 +-0.06 +0.33 +0.19 +-0.09 +0.21 +-0.08 +0.41 +-0.09 +-1.56 +0.28 +0.79 +-0.13 +-0.15 +0.32 +1.02 +0.16 +-0.50 +-0.66 +0.19 +-1.38 +-0.62 +0.26 +-0.76 +0.32 +-0.67 +-0.12 +-0.69 +-0.91 +0.28 +-1.92 +0.79 +-1.88 +-0.93 +-0.97 +-3.40 +-1.14 +-1.08 +0.47 +1.31 +-1.02 +-2.07 +-3.95 +8.71 +-0.25 +-0.06 +-0.08 +-0.09 +0.16 +0.20 +0.19 +0.28 +-0.69 +0.79 +0.16 +0.20 +-0.69 +0.19 +0.28 +0.79 +-0.08 +-0.66 +-0.91 +-0.66 +-0.91 +-0.62 +-0.93 +-0.97 +-0.97 +-3.40 +6.21 +-0.02 +0.11 +-0.06 +0.13 +-0.15 +0.16 +-0.44 +0.19 +-0.46 +-0.41 +0.13 +-0.08 +0.19 +-0.52 +-0.09 +0.62 +0.20 +-0.61 +0.28 +-0.66 +-0.69 +-0.55 +0.79 +-1.25 +-0.62 +-2.40 +18.95 +0.32 +0.20 +-0.06 +0.33 +0.19 +-0.09 +0.21 +0.16 +-0.50 +0.19 +-1.38 +-0.66 +-0.62 +0.26 +0.32 +-0.76 +-0.67 +-0.08 +0.41 +0.28 +-0.09 +-1.56 +0.79 +-0.13 +0.32 +-0.15 +1.02 +-0.12 +0.28 +-1.92 +-0.91 +-0.69 +0.79 +-1.88 +-0.97 +-0.93 +-3.40 +0.47 +-1.08 +-1.14 +1.31 +-2.07 +-1.02 +-3.95 +17.60 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.61 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.31 +0.13 +-0.26 +-0.44 +0.19 +-0.79 +0.62 +-0.41 +-1.66 +-0.44 +0.19 +-0.41 +-0.79 +0.62 +-1.66 +0.28 +-0.55 +0.79 +-0.62 +-0.55 +0.79 +-1.39 +-2.40 +-2.40 +-5.55 +53.59 +0.00 +0.00 +0.00 +0.47 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.28 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.13 +-0.97 +-0.41 +0.21 +-0.44 +0.19 +-1.38 +0.62 +-2.56 +-0.62 +-2.40 +0.32 +1.02 +-0.67 +-2.73 +0.19 +-1.38 +-0.62 +0.62 +-2.56 +-2.40 +0.32 +-0.67 +1.02 +-2.73 +-1.92 +0.79 +-1.88 +-0.93 +0.79 +-1.88 +-1.39 +-3.40 +-3.40 +-5.52 +1.31 +-1.02 +1.31 +-2.29 +-3.95 +-3.95 +-9.15 +24.56 +-0.66 +0.13 +0.19 +0.62 +-0.46 +-0.66 +-0.41 +-0.62 +-1.25 +-2.40 +0.19 +0.28 +0.79 +0.62 +0.79 +-1.39 +-0.91 +-0.62 +-0.93 +-0.97 +-1.25 +-0.97 +-2.40 +-3.40 +-3.40 +-5.52 +24.56 +-0.66 +0.13 +0.19 +0.62 +0.19 +0.28 +0.62 +0.79 +0.79 +-1.39 +-0.46 +-0.66 +-1.25 +-0.41 +-0.62 +-2.40 +-0.91 +-1.25 +-0.97 +-0.97 +-0.62 +-0.93 +-2.40 +-3.40 +-3.40 +-5.52 +67.02 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.62 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.26 +-0.41 +-1.66 +-0.41 +-0.62 +-1.66 +-2.40 +-2.40 +-5.55 +-0.41 +-0.62 +-2.40 +-1.66 +-2.40 +-5.55 +-0.93 +-2.40 +-3.40 +-3.40 +-2.40 +-3.40 +-5.55 +-5.52 +-5.52 +-5.52 +14.37 +-0.14 +-0.09 +0.26 +0.32 +-0.13 +-0.15 +0.32 +-1.14 +0.47 +1.31 +0.26 +0.32 +-0.42 +-1.08 +-1.08 +-1.02 +0.32 +-1.14 +0.47 +1.31 +-1.51 +-1.51 +-1.60 +-1.54 +-1.60 +-5.60 +14.37 +-0.14 +-0.09 +-0.13 +-0.15 +0.26 +0.32 +0.32 +0.47 +-1.14 +1.31 +0.26 +0.32 +0.32 +-1.14 +0.47 +1.31 +-0.42 +-1.08 +-1.08 +-1.02 +-1.51 +-1.51 +-1.54 +-1.60 +-1.60 +-5.60 +14.37 +-0.14 +-0.09 +0.26 +0.32 +0.26 +0.32 +-0.42 +-1.08 +-1.08 +-1.02 +-0.13 +-0.15 +0.32 +0.47 +-1.14 +1.31 +0.32 +0.47 +-1.14 +1.31 +-1.51 +-1.51 +-1.60 +-1.60 +-1.54 +-5.60 +40.50 +-1.51 +0.21 +-0.76 +-0.67 +0.32 +1.02 +-1.08 +-2.07 +-1.02 +-3.95 +0.32 +1.02 +-1.08 +-1.02 +-2.07 +-3.95 +0.47 +1.31 +1.31 +-2.29 +-1.60 +-1.54 +-1.60 +-5.60 +-5.60 +-9.10 +40.50 +-1.51 +0.21 +0.32 +1.02 +-0.76 +-0.67 +-1.08 +-1.02 +-2.07 +-3.95 +0.32 +1.02 +0.47 +1.31 +1.31 +-2.29 +-1.08 +-1.02 +-2.07 +-3.95 +-1.54 +-1.60 +-1.60 +-5.60 +-5.60 +-9.10 +40.50 +-1.51 +0.21 +0.32 +1.02 +0.32 +1.02 +0.47 +1.31 +1.31 +-2.29 +-0.76 +-0.67 +-1.08 +-2.07 +-1.02 +-3.95 +-1.08 +-2.07 +-1.02 +-3.95 +-1.60 +-1.60 +-1.54 +-5.60 +-5.60 +-9.10 +110.49 +0.00 +0.00 +0.00 +-1.54 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +0.00 +-0.44 +-0.67 +-2.73 +-0.67 +-2.73 +-1.02 +-3.95 +-3.95 +-9.15 +-0.67 +-2.73 +-1.02 +-3.95 +-3.95 +-9.15 +-1.02 +-3.95 +-3.95 +-9.15 +-5.60 +-5.60 +-5.60 +-9.10 +-9.10 +-9.10 +(0,0) 73.33 +(0,1) 0.00 +(0,2) 21.11 +(0,3) 0.00 +(0,4) 21.11 +(0,5) 0.00 +(0,6) 4.44 +(0,7) 0.00 +(0,8) 0.00 +(0,9) 0.00 +(0,10) 0.00 +(0,11) 0.00 +(0,12) 0.00 +(0,13) 21.11 +(0,14) 0.00 +(0,15) 4.44 +(0,16) 0.00 +(0,17) 0.00 +(0,18) 0.00 +(0,19) 0.00 +(0,20) 0.00 +(0,21) 4.44 +(0,22) 0.00 +(0,23) 0.00 +(0,24) 0.00 +(0,25) 0.00 +(1,1) 27.43 +(1,0) 0.00 +(1,2) 0.00 +(1,3) -3.81 +(1,4) 0.00 +(1,5) -3.81 +(1,6) 0.00 +(1,7) 0.38 +(1,8) 9.40 +(1,9) -0.98 +(1,10) 9.40 +(1,11) -0.98 +(1,12) 2.41 +(1,13) 0.00 +(1,14) -3.81 +(1,15) 0.00 +(1,16) 0.38 +(1,17) 9.40 +(1,18) -0.98 +(1,19) -0.98 +(1,20) 2.41 +(1,21) 0.00 +(1,22) 0.38 +(1,23) -0.98 +(1,24) -0.98 +(1,25) 2.41 +(2,2) 75.56 +(2,0) 21.11 +(2,1) 0.00 +(2,3) 0.00 +(2,4) 4.44 +(2,5) 0.00 +(2,6) 15.56 +(2,7) 0.00 +(2,8) 0.00 +(2,9) 0.00 +(2,10) 0.00 +(2,11) 0.00 +(2,12) 0.00 +(2,13) 4.44 +(2,14) 0.00 +(2,17) 0.00 +(2,21) 15.56 +(2,22) 0.00 +(2,23) 0.00 +(2,24) 0.00 +(2,25) 0.00 +(2,39) 4.44 +(2,40) 0.00 +(2,47) 0.00 +(2,50) 21.11 +(2,51) 0.00 +(2,52) 4.44 +(2,53) 0.00 +(2,54) 0.00 +(2,55) 0.00 +(2,56) 0.00 +(2,57) 0.00 +(2,58) 0.00 +(2,61) 0.00 +(3,3) 25.90 +(3,0) 0.00 +(3,1) -3.81 +(3,2) 0.00 +(3,4) 0.00 +(3,5) 0.38 +(3,6) 0.00 +(3,7) -2.48 +(3,8) -0.98 +(3,9) 6.73 +(3,10) 5.84 +(3,11) -0.54 +(3,12) 1.52 +(3,13) 0.00 +(3,14) 0.38 +(3,17) -0.98 +(3,21) 0.00 +(3,22) -2.48 +(3,23) -0.54 +(3,24) 6.73 +(3,25) 1.52 +(3,39) 0.00 +(3,40) 0.38 +(3,47) -0.54 +(3,50) 0.00 +(3,51) -3.81 +(3,52) 0.00 +(3,53) 0.38 +(3,54) -0.98 +(3,55) 5.84 +(3,56) -0.54 +(3,57) 1.52 +(3,58) -0.98 +(3,61) 1.52 +(4,4) 75.56 +(4,0) 21.11 +(4,1) 0.00 +(4,2) 4.44 +(4,3) 0.00 +(4,5) 0.00 +(4,6) 15.56 +(4,7) 0.00 +(4,8) 0.00 +(4,9) 0.00 +(4,10) 0.00 +(4,11) 0.00 +(4,12) 0.00 +(4,13) 4.44 +(4,14) 0.00 +(4,15) 15.56 +(4,16) 0.00 +(4,17) 0.00 +(4,18) 0.00 +(4,19) 0.00 +(4,20) 0.00 +(4,73) 4.44 +(4,74) 0.00 +(4,77) 0.00 +(4,84) 21.11 +(4,85) 0.00 +(4,86) 4.44 +(4,87) 0.00 +(4,88) 0.00 +(4,89) 0.00 +(4,90) 0.00 +(4,91) 0.00 +(4,92) 0.00 +(4,93) 0.00 +(5,5) 25.90 +(5,0) 0.00 +(5,1) -3.81 +(5,2) 0.00 +(5,3) 0.38 +(5,4) 0.00 +(5,6) 0.00 +(5,7) -2.48 +(5,8) 5.84 +(5,9) -0.54 +(5,10) -0.98 +(5,11) 6.73 +(5,12) 1.52 +(5,13) 0.00 +(5,14) 0.38 +(5,15) 0.00 +(5,16) -2.48 +(5,17) -0.98 +(5,18) 6.73 +(5,19) -0.54 +(5,20) 1.52 +(5,73) 0.00 +(5,74) 0.38 +(5,77) -0.54 +(5,84) 0.00 +(5,85) -3.81 +(5,86) 0.00 +(5,87) 0.38 +(5,88) 5.84 +(5,89) -0.54 +(5,90) -0.98 +(5,91) 1.52 +(5,92) -0.98 +(5,93) 1.52 +(6,6) 53.33 +(6,0) 4.44 +(6,1) 0.00 +(6,2) 15.56 +(6,3) 0.00 +(6,4) 15.56 +(6,5) 0.00 +(6,7) 0.00 +(6,8) 0.00 +(6,9) 0.00 +(6,10) 0.00 +(6,11) 0.00 +(6,12) 0.00 +(6,50) 4.44 +(6,51) 0.00 +(6,52) 15.56 +(6,53) 0.00 +(6,54) 0.00 +(6,55) 0.00 +(6,56) 0.00 +(6,57) 0.00 +(6,84) 4.44 +(6,85) 0.00 +(6,86) 15.56 +(6,87) 0.00 +(6,88) 0.00 +(6,89) 0.00 +(6,90) 0.00 +(6,91) 0.00 +(6,108) 4.44 +(6,109) 0.00 +(6,110) 0.00 +(6,111) 0.00 +(6,112) 0.00 +(7,7) 15.24 +(7,0) 0.00 +(7,1) 0.38 +(7,2) 0.00 +(7,3) -2.48 +(7,4) 0.00 +(7,5) -2.48 +(7,6) 0.00 +(7,8) -0.54 +(7,9) 3.17 +(7,10) -0.54 +(7,11) 3.17 +(7,12) 0.63 +(7,50) 0.00 +(7,51) 0.38 +(7,52) 0.00 +(7,53) -2.48 +(7,54) -0.54 +(7,55) -0.54 +(7,56) 3.17 +(7,57) 0.63 +(7,84) 0.00 +(7,85) 0.38 +(7,86) 0.00 +(7,87) -2.48 +(7,88) -0.54 +(7,89) 3.17 +(7,90) -0.54 +(7,91) 0.63 +(7,108) 0.00 +(7,109) 0.38 +(7,110) -0.54 +(7,111) -0.54 +(7,112) 0.63 +(8,8) 58.92 +(8,0) 0.00 +(8,1) 9.40 +(8,2) 0.00 +(8,3) -0.98 +(8,4) 0.00 +(8,5) 5.84 +(8,6) 0.00 +(8,7) -0.54 +(8,9) -5.84 +(8,10) 2.41 +(8,11) 1.52 +(8,12) 15.24 +(8,13) 0.00 +(8,14) -0.98 +(8,15) 0.00 +(8,16) -0.54 +(8,17) 2.41 +(8,18) 1.52 +(8,19) -5.84 +(8,20) 15.24 +(9,9) 37.59 +(9,0) 0.00 +(9,1) -0.98 +(9,2) 0.00 +(9,3) 6.73 +(9,4) 0.00 +(9,5) -0.54 +(9,6) 0.00 +(9,7) 3.17 +(9,8) -5.84 +(9,10) 1.52 +(9,11) 0.63 +(9,12) 8.13 +(9,50) 0.00 +(9,51) -0.98 +(9,52) 0.00 +(9,53) -0.54 +(9,54) -5.84 +(9,55) 1.52 +(9,56) 0.63 +(9,57) 8.13 +(10,10) 58.92 +(10,0) 0.00 +(10,1) 9.40 +(10,2) 0.00 +(10,3) 5.84 +(10,4) 0.00 +(10,5) -0.98 +(10,6) 0.00 +(10,7) -0.54 +(10,8) 2.41 +(10,9) 1.52 +(10,11) -5.84 +(10,12) 15.24 +(10,13) 0.00 +(10,14) -0.98 +(10,17) 2.41 +(10,21) 0.00 +(10,22) -0.54 +(10,23) -5.84 +(10,24) 1.52 +(10,25) 15.24 +(11,11) 37.59 +(11,0) 0.00 +(11,1) -0.98 +(11,2) 0.00 +(11,3) -0.54 +(11,4) 0.00 +(11,5) 6.73 +(11,6) 0.00 +(11,7) 3.17 +(11,8) 1.52 +(11,9) 0.63 +(11,10) -5.84 +(11,12) 8.13 +(11,84) 0.00 +(11,85) -0.98 +(11,86) 0.00 +(11,87) -0.54 +(11,88) 1.52 +(11,89) 0.63 +(11,90) -5.84 +(11,91) 8.13 +(12,12) 89.40 +(12,0) 0.00 +(12,1) 2.41 +(12,2) 0.00 +(12,3) 1.52 +(12,4) 0.00 +(12,5) 1.52 +(12,6) 0.00 +(12,7) 0.63 +(12,8) 15.24 +(12,9) 8.13 +(12,10) 15.24 +(12,11) 8.13 +(13,13) 47.78 +(13,0) 21.11 +(13,1) 0.00 +(13,2) 4.44 +(13,3) 0.00 +(13,4) 4.44 +(13,5) 0.00 +(13,8) 0.00 +(13,10) 0.00 +(13,14) 0.00 +(13,15) 7.78 +(13,16) 0.00 +(13,17) 0.00 +(13,18) 0.00 +(13,19) 0.00 +(13,20) 0.00 +(13,21) 7.78 +(13,22) 0.00 +(13,23) 0.00 +(13,24) 0.00 +(13,25) 0.00 +(13,129) 5.14 +(13,130) 0.00 +(13,131) 1.15 +(13,132) 0.00 +(13,135) 0.00 +(13,137) 1.15 +(13,138) 0.00 +(13,139) 0.00 +(13,142) 2.22 +(13,143) 0.00 +(13,144) 0.00 +(13,145) 0.00 +(13,146) 0.00 +(13,147) 0.00 +(13,148) 2.22 +(13,149) 0.00 +(13,150) 0.00 +(13,151) 0.00 +(13,152) 0.00 +(14,14) 16.32 +(14,0) 0.00 +(14,1) -3.81 +(14,2) 0.00 +(14,3) 0.38 +(14,4) 0.00 +(14,5) 0.38 +(14,8) -0.98 +(14,10) -0.98 +(14,13) 0.00 +(14,15) 0.00 +(14,16) -1.24 +(14,17) 5.84 +(14,18) -0.54 +(14,19) 3.37 +(14,20) 1.52 +(14,21) 0.00 +(14,22) -1.24 +(14,23) 3.37 +(14,24) -0.54 +(14,25) 1.52 +(14,129) 0.00 +(14,130) -0.88 +(14,131) 0.00 +(14,132) 0.09 +(14,135) -0.23 +(14,137) 0.00 +(14,138) 0.09 +(14,139) -0.23 +(14,142) 0.00 +(14,143) -0.36 +(14,144) 1.64 +(14,145) -0.17 +(14,146) 0.88 +(14,147) 0.43 +(14,148) 0.00 +(14,149) -0.36 +(14,150) 0.88 +(14,151) -0.17 +(14,152) 0.43 +(15,15) 42.92 +(15,0) 4.44 +(15,1) 0.00 +(15,4) 15.56 +(15,5) 0.00 +(15,8) 0.00 +(15,13) 7.78 +(15,14) 0.00 +(15,16) 0.00 +(15,17) 0.00 +(15,18) 0.00 +(15,19) 0.00 +(15,20) 0.00 +(15,62) 7.78 +(15,63) 0.00 +(15,64) 4.44 +(15,65) 0.00 +(15,68) 0.00 +(15,73) 15.56 +(15,74) 0.00 +(15,75) 0.00 +(15,76) 0.00 +(15,77) 0.00 +(15,78) 0.00 +(15,84) 4.44 +(15,85) 0.00 +(15,88) 0.00 +(15,92) 0.00 +(15,93) 0.00 +(15,131) 0.80 +(15,132) 0.00 +(15,142) 1.53 +(15,143) 0.00 +(15,145) 0.00 +(15,173) 1.53 +(15,174) 0.00 +(15,176) 0.00 +(15,178) 0.00 +(15,179) 0.00 +(15,180) 0.00 +(16,16) 12.33 +(16,0) 0.00 +(16,1) 0.38 +(16,4) 0.00 +(16,5) -2.48 +(16,8) -0.54 +(16,13) 0.00 +(16,14) -1.24 +(16,15) 0.00 +(16,17) -0.54 +(16,18) 3.17 +(16,19) 1.59 +(16,20) 0.63 +(16,62) 0.00 +(16,63) -1.24 +(16,64) 0.00 +(16,65) 0.38 +(16,68) -0.54 +(16,73) 0.00 +(16,74) -2.48 +(16,75) 1.59 +(16,76) -0.54 +(16,77) 3.17 +(16,78) 0.63 +(16,84) 0.00 +(16,85) 0.38 +(16,88) -0.54 +(16,92) -0.54 +(16,93) 0.63 +(16,131) 0.00 +(16,132) 0.07 +(16,142) 0.00 +(16,143) -0.24 +(16,145) -0.12 +(16,173) 0.00 +(16,174) -0.24 +(16,176) -0.12 +(16,178) 0.43 +(16,179) 0.43 +(16,180) 0.21 +(17,17) 58.92 +(17,0) 0.00 +(17,1) 9.40 +(17,2) 0.00 +(17,3) -0.98 +(17,4) 0.00 +(17,5) -0.98 +(17,8) 2.41 +(17,10) 2.41 +(17,13) 0.00 +(17,14) 5.84 +(17,15) 0.00 +(17,16) -0.54 +(17,18) -5.84 +(17,19) 1.52 +(17,20) 15.24 +(17,21) 0.00 +(17,22) -0.54 +(17,23) 1.52 +(17,24) -5.84 +(17,25) 15.24 +(18,18) 37.59 +(18,0) 0.00 +(18,1) -0.98 +(18,4) 0.00 +(18,5) 6.73 +(18,8) 1.52 +(18,13) 0.00 +(18,14) -0.54 +(18,15) 0.00 +(18,16) 3.17 +(18,17) -5.84 +(18,19) 0.63 +(18,20) 8.13 +(18,73) 0.00 +(18,74) -0.54 +(18,77) 0.63 +(18,84) 0.00 +(18,85) -0.98 +(18,88) 1.52 +(18,92) -5.84 +(18,93) 8.13 +(19,19) 18.79 +(19,0) 0.00 +(19,1) -0.98 +(19,4) 0.00 +(19,5) -0.54 +(19,8) -5.84 +(19,13) 0.00 +(19,14) 3.37 +(19,15) 0.00 +(19,16) 1.59 +(19,17) 1.52 +(19,18) 0.63 +(19,20) 8.13 +(20,20) 89.40 +(20,0) 0.00 +(20,1) 2.41 +(20,4) 0.00 +(20,5) 1.52 +(20,8) 15.24 +(20,13) 0.00 +(20,14) 1.52 +(20,15) 0.00 +(20,16) 0.63 +(20,17) 15.24 +(20,18) 8.13 +(20,19) 8.13 +(21,21) 42.92 +(21,0) 4.44 +(21,1) 0.00 +(21,2) 15.56 +(21,3) 0.00 +(21,10) 0.00 +(21,13) 7.78 +(21,14) 0.00 +(21,17) 0.00 +(21,22) 0.00 +(21,23) 0.00 +(21,24) 0.00 +(21,25) 0.00 +(21,26) 7.78 +(21,27) 0.00 +(21,28) 4.44 +(21,29) 0.00 +(21,36) 0.00 +(21,39) 15.56 +(21,40) 0.00 +(21,43) 0.00 +(21,47) 0.00 +(21,48) 0.00 +(21,49) 0.00 +(21,50) 4.44 +(21,51) 0.00 +(21,55) 0.00 +(21,58) 0.00 +(21,61) 0.00 +(21,137) 0.80 +(21,138) 0.00 +(21,148) 1.53 +(21,149) 0.00 +(21,151) 0.00 +(21,159) 1.53 +(21,160) 0.00 +(21,161) 0.00 +(21,164) 0.00 +(21,165) 0.00 +(21,166) 0.00 +(22,22) 12.33 +(22,0) 0.00 +(22,1) 0.38 +(22,2) 0.00 +(22,3) -2.48 +(22,10) -0.54 +(22,13) 0.00 +(22,14) -1.24 +(22,17) -0.54 +(22,21) 0.00 +(22,23) 1.59 +(22,24) 3.17 +(22,25) 0.63 +(22,26) 0.00 +(22,27) -1.24 +(22,28) 0.00 +(22,29) 0.38 +(22,36) -0.54 +(22,39) 0.00 +(22,40) -2.48 +(22,43) -0.54 +(22,47) 3.17 +(22,48) 1.59 +(22,49) 0.63 +(22,50) 0.00 +(22,51) 0.38 +(22,55) -0.54 +(22,58) -0.54 +(22,61) 0.63 +(22,137) 0.00 +(22,138) 0.07 +(22,148) 0.00 +(22,149) -0.24 +(22,151) -0.12 +(22,159) 0.00 +(22,160) -0.24 +(22,161) -0.12 +(22,164) 0.43 +(22,165) 0.43 +(22,166) 0.21 +(23,23) 18.79 +(23,0) 0.00 +(23,1) -0.98 +(23,2) 0.00 +(23,3) -0.54 +(23,10) -5.84 +(23,13) 0.00 +(23,14) 3.37 +(23,17) 1.52 +(23,21) 0.00 +(23,22) 1.59 +(23,24) 0.63 +(23,25) 8.13 +(24,24) 37.59 +(24,0) 0.00 +(24,1) -0.98 +(24,2) 0.00 +(24,3) 6.73 +(24,10) 1.52 +(24,13) 0.00 +(24,14) -0.54 +(24,17) -5.84 +(24,21) 0.00 +(24,22) 3.17 +(24,23) 0.63 +(24,25) 8.13 +(24,39) 0.00 +(24,40) -0.54 +(24,47) 0.63 +(24,50) 0.00 +(24,51) -0.98 +(24,55) 1.52 +(24,58) -5.84 +(24,61) 8.13 +(25,25) 89.40 +(25,0) 0.00 +(25,1) 2.41 +(25,2) 0.00 +(25,3) 1.52 +(25,10) 15.24 +(25,13) 0.00 +(25,14) 1.52 +(25,17) 15.24 +(25,21) 0.00 +(25,22) 0.63 +(25,23) 8.13 +(25,24) 8.13 +(26,26) 47.78 +(26,21) 7.78 +(26,22) 0.00 +(26,27) 0.00 +(26,28) 21.11 +(26,29) 0.00 +(26,30) 7.78 +(26,31) 0.00 +(26,32) 4.44 +(26,33) 0.00 +(26,34) 0.00 +(26,35) 0.00 +(26,36) 0.00 +(26,37) 0.00 +(26,38) 0.00 +(26,39) 4.44 +(26,40) 0.00 +(26,43) 0.00 +(26,47) 0.00 +(26,48) 0.00 +(26,49) 0.00 +(26,118) 5.14 +(26,119) 0.00 +(26,122) 1.15 +(26,123) 0.00 +(26,125) 0.00 +(26,137) 1.15 +(26,138) 0.00 +(26,140) 0.00 +(26,153) 2.22 +(26,154) 0.00 +(26,155) 0.00 +(26,156) 0.00 +(26,157) 0.00 +(26,158) 0.00 +(26,159) 2.22 +(26,160) 0.00 +(26,161) 0.00 +(26,162) 0.00 +(26,163) 0.00 +(27,27) 16.32 +(27,21) 0.00 +(27,22) -1.24 +(27,26) 0.00 +(27,28) 0.00 +(27,29) -3.81 +(27,30) 0.00 +(27,31) -1.24 +(27,32) 0.00 +(27,33) 0.38 +(27,34) 3.37 +(27,35) -0.98 +(27,36) 5.84 +(27,37) -0.54 +(27,38) 1.52 +(27,39) 0.00 +(27,40) 0.38 +(27,43) -0.98 +(27,47) -0.54 +(27,48) 3.37 +(27,49) 1.52 +(27,118) 0.00 +(27,119) -0.88 +(27,122) 0.00 +(27,123) 0.09 +(27,125) -0.23 +(27,137) 0.00 +(27,138) 0.09 +(27,140) -0.23 +(27,153) 0.00 +(27,154) -0.36 +(27,155) 0.88 +(27,156) 1.64 +(27,157) -0.17 +(27,158) 0.43 +(27,159) 0.00 +(27,160) -0.36 +(27,161) -0.17 +(27,162) 0.88 +(27,163) 0.43 +(28,28) 73.33 +(28,21) 4.44 +(28,22) 0.00 +(28,26) 21.11 +(28,27) 0.00 +(28,29) 0.00 +(28,30) 4.44 +(28,31) 0.00 +(28,32) 21.11 +(28,33) 0.00 +(28,34) 0.00 +(28,35) 0.00 +(28,36) 0.00 +(28,37) 0.00 +(28,38) 0.00 +(28,39) 21.11 +(28,40) 0.00 +(28,41) 4.44 +(28,42) 0.00 +(28,43) 0.00 +(28,44) 0.00 +(28,45) 0.00 +(28,46) 0.00 +(28,47) 0.00 +(28,48) 0.00 +(28,49) 0.00 +(29,29) 27.43 +(29,21) 0.00 +(29,22) 0.38 +(29,26) 0.00 +(29,27) -3.81 +(29,28) 0.00 +(29,30) 0.00 +(29,31) 0.38 +(29,32) 0.00 +(29,33) -3.81 +(29,34) -0.98 +(29,35) 9.40 +(29,36) 9.40 +(29,37) -0.98 +(29,38) 2.41 +(29,39) 0.00 +(29,40) -3.81 +(29,41) 0.00 +(29,42) 0.38 +(29,43) 9.40 +(29,44) -0.98 +(29,45) -0.98 +(29,46) 2.41 +(29,47) -0.98 +(29,48) -0.98 +(29,49) 2.41 +(30,30) 42.92 +(30,26) 7.78 +(30,27) 0.00 +(30,28) 4.44 +(30,29) 0.00 +(30,31) 0.00 +(30,32) 15.56 +(30,33) 0.00 +(30,34) 0.00 +(30,35) 0.00 +(30,36) 0.00 +(30,37) 0.00 +(30,38) 0.00 +(30,62) 7.78 +(30,63) 0.00 +(30,64) 4.44 +(30,65) 0.00 +(30,66) 15.56 +(30,67) 0.00 +(30,68) 0.00 +(30,69) 0.00 +(30,70) 0.00 +(30,71) 0.00 +(30,72) 0.00 +(30,96) 4.44 +(30,97) 0.00 +(30,98) 0.00 +(30,99) 0.00 +(30,100) 0.00 +(30,122) 0.80 +(30,123) 0.00 +(30,153) 1.53 +(30,154) 0.00 +(30,157) 0.00 +(30,167) 1.53 +(30,168) 0.00 +(30,170) 0.00 +(30,181) 0.00 +(30,182) 0.00 +(30,183) 0.00 +(31,31) 12.33 +(31,26) 0.00 +(31,27) -1.24 +(31,28) 0.00 +(31,29) 0.38 +(31,30) 0.00 +(31,32) 0.00 +(31,33) -2.48 +(31,34) 1.59 +(31,35) -0.54 +(31,36) -0.54 +(31,37) 3.17 +(31,38) 0.63 +(31,62) 0.00 +(31,63) -1.24 +(31,64) 0.00 +(31,65) 0.38 +(31,66) 0.00 +(31,67) -2.48 +(31,68) -0.54 +(31,69) 3.17 +(31,70) 1.59 +(31,71) -0.54 +(31,72) 0.63 +(31,96) 0.00 +(31,97) 0.38 +(31,98) -0.54 +(31,99) -0.54 +(31,100) 0.63 +(31,122) 0.00 +(31,123) 0.07 +(31,153) 0.00 +(31,154) -0.24 +(31,157) -0.12 +(31,167) 0.00 +(31,168) -0.24 +(31,170) -0.12 +(31,181) 0.43 +(31,182) 0.43 +(31,183) 0.21 +(32,32) 75.56 +(32,26) 4.44 +(32,27) 0.00 +(32,28) 21.11 +(32,29) 0.00 +(32,30) 15.56 +(32,31) 0.00 +(32,33) 0.00 +(32,34) 0.00 +(32,35) 0.00 +(32,36) 0.00 +(32,37) 0.00 +(32,38) 0.00 +(32,39) 4.44 +(32,40) 0.00 +(32,41) 15.56 +(32,42) 0.00 +(32,43) 0.00 +(32,44) 0.00 +(32,45) 0.00 +(32,46) 0.00 +(32,66) 4.44 +(32,67) 0.00 +(32,69) 0.00 +(32,96) 21.11 +(32,97) 0.00 +(32,98) 0.00 +(32,99) 0.00 +(32,100) 0.00 +(32,101) 4.44 +(32,102) 0.00 +(32,103) 0.00 +(32,104) 0.00 +(32,105) 0.00 +(33,33) 25.90 +(33,26) 0.00 +(33,27) 0.38 +(33,28) 0.00 +(33,29) -3.81 +(33,30) 0.00 +(33,31) -2.48 +(33,32) 0.00 +(33,34) -0.54 +(33,35) 5.84 +(33,36) -0.98 +(33,37) 6.73 +(33,38) 1.52 +(33,39) 0.00 +(33,40) 0.38 +(33,41) 0.00 +(33,42) -2.48 +(33,43) -0.98 +(33,44) 6.73 +(33,45) -0.54 +(33,46) 1.52 +(33,66) 0.00 +(33,67) 0.38 +(33,69) -0.54 +(33,96) 0.00 +(33,97) -3.81 +(33,98) 5.84 +(33,99) -0.98 +(33,100) 1.52 +(33,101) 0.00 +(33,102) 0.38 +(33,103) -0.98 +(33,104) -0.54 +(33,105) 1.52 +(34,34) 18.79 +(34,26) 0.00 +(34,27) 3.37 +(34,28) 0.00 +(34,29) -0.98 +(34,30) 0.00 +(34,31) 1.59 +(34,32) 0.00 +(34,33) -0.54 +(34,35) -5.84 +(34,36) 1.52 +(34,37) 0.63 +(34,38) 8.13 +(35,35) 58.92 +(35,26) 0.00 +(35,27) -0.98 +(35,28) 0.00 +(35,29) 9.40 +(35,30) 0.00 +(35,31) -0.54 +(35,32) 0.00 +(35,33) 5.84 +(35,34) -5.84 +(35,36) 2.41 +(35,37) 1.52 +(35,38) 15.24 +(35,39) 0.00 +(35,40) -0.98 +(35,41) 0.00 +(35,42) -0.54 +(35,43) 2.41 +(35,44) 1.52 +(35,45) -5.84 +(35,46) 15.24 +(36,36) 58.92 +(36,21) 0.00 +(36,22) -0.54 +(36,26) 0.00 +(36,27) 5.84 +(36,28) 0.00 +(36,29) 9.40 +(36,30) 0.00 +(36,31) -0.54 +(36,32) 0.00 +(36,33) -0.98 +(36,34) 1.52 +(36,35) 2.41 +(36,37) -5.84 +(36,38) 15.24 +(36,39) 0.00 +(36,40) -0.98 +(36,43) 2.41 +(36,47) -5.84 +(36,48) 1.52 +(36,49) 15.24 +(37,37) 37.59 +(37,26) 0.00 +(37,27) -0.54 +(37,28) 0.00 +(37,29) -0.98 +(37,30) 0.00 +(37,31) 3.17 +(37,32) 0.00 +(37,33) 6.73 +(37,34) 0.63 +(37,35) 1.52 +(37,36) -5.84 +(37,38) 8.13 +(37,66) 0.00 +(37,67) -0.54 +(37,69) 0.63 +(37,96) 0.00 +(37,97) -0.98 +(37,98) 1.52 +(37,99) -5.84 +(37,100) 8.13 +(38,38) 89.40 +(38,26) 0.00 +(38,27) 1.52 +(38,28) 0.00 +(38,29) 2.41 +(38,30) 0.00 +(38,31) 0.63 +(38,32) 0.00 +(38,33) 1.52 +(38,34) 8.13 +(38,35) 15.24 +(38,36) 15.24 +(38,37) 8.13 +(39,39) 75.56 +(39,2) 4.44 +(39,3) 0.00 +(39,21) 15.56 +(39,22) 0.00 +(39,24) 0.00 +(39,26) 4.44 +(39,27) 0.00 +(39,28) 21.11 +(39,29) 0.00 +(39,32) 4.44 +(39,33) 0.00 +(39,35) 0.00 +(39,36) 0.00 +(39,40) 0.00 +(39,41) 15.56 +(39,42) 0.00 +(39,43) 0.00 +(39,44) 0.00 +(39,45) 0.00 +(39,46) 0.00 +(39,47) 0.00 +(39,48) 0.00 +(39,49) 0.00 +(39,50) 21.11 +(39,51) 0.00 +(39,52) 4.44 +(39,53) 0.00 +(39,54) 0.00 +(39,55) 0.00 +(39,58) 0.00 +(39,59) 0.00 +(39,60) 0.00 +(39,61) 0.00 +(40,40) 25.90 +(40,2) 0.00 +(40,3) 0.38 +(40,21) 0.00 +(40,22) -2.48 +(40,24) -0.54 +(40,26) 0.00 +(40,27) 0.38 +(40,28) 0.00 +(40,29) -3.81 +(40,32) 0.00 +(40,33) 0.38 +(40,35) -0.98 +(40,36) -0.98 +(40,39) 0.00 +(40,41) 0.00 +(40,42) -2.48 +(40,43) 5.84 +(40,44) -0.54 +(40,45) 6.73 +(40,46) 1.52 +(40,47) 6.73 +(40,48) -0.54 +(40,49) 1.52 +(40,50) 0.00 +(40,51) -3.81 +(40,52) 0.00 +(40,53) 0.38 +(40,54) -0.98 +(40,55) -0.98 +(40,58) 5.84 +(40,59) -0.54 +(40,60) 1.52 +(40,61) 1.52 +(41,41) 53.33 +(41,28) 4.44 +(41,29) 0.00 +(41,32) 15.56 +(41,33) 0.00 +(41,35) 0.00 +(41,39) 15.56 +(41,40) 0.00 +(41,42) 0.00 +(41,43) 0.00 +(41,44) 0.00 +(41,45) 0.00 +(41,46) 0.00 +(41,50) 4.44 +(41,51) 0.00 +(41,52) 15.56 +(41,53) 0.00 +(41,54) 0.00 +(41,58) 0.00 +(41,59) 0.00 +(41,60) 0.00 +(41,96) 4.44 +(41,97) 0.00 +(41,98) 0.00 +(41,101) 15.56 +(41,102) 0.00 +(41,103) 0.00 +(41,104) 0.00 +(41,105) 0.00 +(41,108) 4.44 +(41,109) 0.00 +(41,110) 0.00 +(41,113) 0.00 +(41,114) 0.00 +(42,42) 15.24 +(42,28) 0.00 +(42,29) 0.38 +(42,32) 0.00 +(42,33) -2.48 +(42,35) -0.54 +(42,39) 0.00 +(42,40) -2.48 +(42,41) 0.00 +(42,43) -0.54 +(42,44) 3.17 +(42,45) 3.17 +(42,46) 0.63 +(42,50) 0.00 +(42,51) 0.38 +(42,52) 0.00 +(42,53) -2.48 +(42,54) -0.54 +(42,58) -0.54 +(42,59) 3.17 +(42,60) 0.63 +(42,96) 0.00 +(42,97) 0.38 +(42,98) -0.54 +(42,101) 0.00 +(42,102) -2.48 +(42,103) -0.54 +(42,104) 3.17 +(42,105) 0.63 +(42,108) 0.00 +(42,109) 0.38 +(42,110) -0.54 +(42,113) -0.54 +(42,114) 0.63 +(43,43) 58.92 +(43,21) 0.00 +(43,22) -0.54 +(43,26) 0.00 +(43,27) -0.98 +(43,28) 0.00 +(43,29) 9.40 +(43,32) 0.00 +(43,33) -0.98 +(43,35) 2.41 +(43,36) 2.41 +(43,39) 0.00 +(43,40) 5.84 +(43,41) 0.00 +(43,42) -0.54 +(43,44) -5.84 +(43,45) 1.52 +(43,46) 15.24 +(43,47) 1.52 +(43,48) -5.84 +(43,49) 15.24 +(44,44) 37.59 +(44,28) 0.00 +(44,29) -0.98 +(44,32) 0.00 +(44,33) 6.73 +(44,35) 1.52 +(44,39) 0.00 +(44,40) -0.54 +(44,41) 0.00 +(44,42) 3.17 +(44,43) -5.84 +(44,45) 0.63 +(44,46) 8.13 +(44,96) 0.00 +(44,97) -0.98 +(44,98) 1.52 +(44,101) 0.00 +(44,102) -0.54 +(44,103) -5.84 +(44,104) 0.63 +(44,105) 8.13 +(45,45) 37.59 +(45,28) 0.00 +(45,29) -0.98 +(45,32) 0.00 +(45,33) -0.54 +(45,35) -5.84 +(45,39) 0.00 +(45,40) 6.73 +(45,41) 0.00 +(45,42) 3.17 +(45,43) 1.52 +(45,44) 0.63 +(45,46) 8.13 +(45,50) 0.00 +(45,51) -0.98 +(45,52) 0.00 +(45,53) -0.54 +(45,54) -5.84 +(45,58) 1.52 +(45,59) 0.63 +(45,60) 8.13 +(46,46) 89.40 +(46,28) 0.00 +(46,29) 2.41 +(46,32) 0.00 +(46,33) 1.52 +(46,35) 15.24 +(46,39) 0.00 +(46,40) 1.52 +(46,41) 0.00 +(46,42) 0.63 +(46,43) 15.24 +(46,44) 8.13 +(46,45) 8.13 +(47,47) 37.59 +(47,2) 0.00 +(47,3) -0.54 +(47,21) 0.00 +(47,22) 3.17 +(47,24) 0.63 +(47,26) 0.00 +(47,27) -0.54 +(47,28) 0.00 +(47,29) -0.98 +(47,36) -5.84 +(47,39) 0.00 +(47,40) 6.73 +(47,43) 1.52 +(47,48) 0.63 +(47,49) 8.13 +(47,50) 0.00 +(47,51) -0.98 +(47,55) -5.84 +(47,58) 1.52 +(47,61) 8.13 +(48,48) 18.79 +(48,21) 0.00 +(48,22) 1.59 +(48,26) 0.00 +(48,27) 3.37 +(48,28) 0.00 +(48,29) -0.98 +(48,36) 1.52 +(48,39) 0.00 +(48,40) -0.54 +(48,43) -5.84 +(48,47) 0.63 +(48,49) 8.13 +(49,49) 89.40 +(49,21) 0.00 +(49,22) 0.63 +(49,26) 0.00 +(49,27) 1.52 +(49,28) 0.00 +(49,29) 2.41 +(49,36) 15.24 +(49,39) 0.00 +(49,40) 1.52 +(49,43) 15.24 +(49,47) 8.13 +(49,48) 8.13 +(50,50) 73.33 +(50,2) 21.11 +(50,3) 0.00 +(50,6) 4.44 +(50,7) 0.00 +(50,9) 0.00 +(50,21) 4.44 +(50,22) 0.00 +(50,24) 0.00 +(50,39) 21.11 +(50,40) 0.00 +(50,41) 4.44 +(50,42) 0.00 +(50,45) 0.00 +(50,47) 0.00 +(50,51) 0.00 +(50,52) 21.11 +(50,53) 0.00 +(50,54) 0.00 +(50,55) 0.00 +(50,56) 0.00 +(50,57) 0.00 +(50,58) 0.00 +(50,59) 0.00 +(50,60) 0.00 +(50,61) 0.00 +(51,51) 27.43 +(51,2) 0.00 +(51,3) -3.81 +(51,6) 0.00 +(51,7) 0.38 +(51,9) -0.98 +(51,21) 0.00 +(51,22) 0.38 +(51,24) -0.98 +(51,39) 0.00 +(51,40) -3.81 +(51,41) 0.00 +(51,42) 0.38 +(51,45) -0.98 +(51,47) -0.98 +(51,50) 0.00 +(51,52) 0.00 +(51,53) -3.81 +(51,54) 9.40 +(51,55) 9.40 +(51,56) -0.98 +(51,57) 2.41 +(51,58) 9.40 +(51,59) -0.98 +(51,60) 2.41 +(51,61) 2.41 +(52,52) 75.56 +(52,2) 4.44 +(52,3) 0.00 +(52,6) 15.56 +(52,7) 0.00 +(52,9) 0.00 +(52,39) 4.44 +(52,40) 0.00 +(52,41) 15.56 +(52,42) 0.00 +(52,45) 0.00 +(52,50) 21.11 +(52,51) 0.00 +(52,53) 0.00 +(52,54) 0.00 +(52,55) 0.00 +(52,56) 0.00 +(52,57) 0.00 +(52,58) 0.00 +(52,59) 0.00 +(52,60) 0.00 +(52,86) 4.44 +(52,87) 0.00 +(52,89) 0.00 +(52,101) 4.44 +(52,102) 0.00 +(52,104) 0.00 +(52,108) 21.11 +(52,109) 0.00 +(52,110) 0.00 +(52,111) 0.00 +(52,112) 0.00 +(52,113) 0.00 +(52,114) 0.00 +(53,53) 25.90 +(53,2) 0.00 +(53,3) 0.38 +(53,6) 0.00 +(53,7) -2.48 +(53,9) -0.54 +(53,39) 0.00 +(53,40) 0.38 +(53,41) 0.00 +(53,42) -2.48 +(53,45) -0.54 +(53,50) 0.00 +(53,51) -3.81 +(53,52) 0.00 +(53,54) 5.84 +(53,55) -0.98 +(53,56) 6.73 +(53,57) 1.52 +(53,58) -0.98 +(53,59) 6.73 +(53,60) 1.52 +(53,86) 0.00 +(53,87) 0.38 +(53,89) -0.54 +(53,101) 0.00 +(53,102) 0.38 +(53,104) -0.54 +(53,108) 0.00 +(53,109) -3.81 +(53,110) 5.84 +(53,111) -0.98 +(53,112) 1.52 +(53,113) -0.98 +(53,114) 1.52 +(54,54) 58.92 +(54,2) 0.00 +(54,3) -0.98 +(54,6) 0.00 +(54,7) -0.54 +(54,9) -5.84 +(54,39) 0.00 +(54,40) -0.98 +(54,41) 0.00 +(54,42) -0.54 +(54,45) -5.84 +(54,50) 0.00 +(54,51) 9.40 +(54,52) 0.00 +(54,53) 5.84 +(54,55) 2.41 +(54,56) 1.52 +(54,57) 15.24 +(54,58) 2.41 +(54,59) 1.52 +(54,60) 15.24 +(55,55) 58.92 +(55,2) 0.00 +(55,3) 5.84 +(55,6) 0.00 +(55,7) -0.54 +(55,9) 1.52 +(55,21) 0.00 +(55,22) -0.54 +(55,24) 1.52 +(55,39) 0.00 +(55,40) -0.98 +(55,47) -5.84 +(55,50) 0.00 +(55,51) 9.40 +(55,52) 0.00 +(55,53) -0.98 +(55,54) 2.41 +(55,56) -5.84 +(55,57) 15.24 +(55,58) 2.41 +(55,61) 15.24 +(56,56) 37.59 +(56,2) 0.00 +(56,3) -0.54 +(56,6) 0.00 +(56,7) 3.17 +(56,9) 0.63 +(56,50) 0.00 +(56,51) -0.98 +(56,52) 0.00 +(56,53) 6.73 +(56,54) 1.52 +(56,55) -5.84 +(56,57) 8.13 +(56,86) 0.00 +(56,87) -0.54 +(56,89) 0.63 +(56,108) 0.00 +(56,109) -0.98 +(56,110) 1.52 +(56,111) -5.84 +(56,112) 8.13 +(57,57) 89.40 +(57,2) 0.00 +(57,3) 1.52 +(57,6) 0.00 +(57,7) 0.63 +(57,9) 8.13 +(57,50) 0.00 +(57,51) 2.41 +(57,52) 0.00 +(57,53) 1.52 +(57,54) 15.24 +(57,55) 15.24 +(57,56) 8.13 +(58,58) 58.92 +(58,2) 0.00 +(58,3) -0.98 +(58,21) 0.00 +(58,22) -0.54 +(58,24) -5.84 +(58,39) 0.00 +(58,40) 5.84 +(58,41) 0.00 +(58,42) -0.54 +(58,45) 1.52 +(58,47) 1.52 +(58,50) 0.00 +(58,51) 9.40 +(58,52) 0.00 +(58,53) -0.98 +(58,54) 2.41 +(58,55) 2.41 +(58,59) -5.84 +(58,60) 15.24 +(58,61) 15.24 +(59,59) 37.59 +(59,39) 0.00 +(59,40) -0.54 +(59,41) 0.00 +(59,42) 3.17 +(59,45) 0.63 +(59,50) 0.00 +(59,51) -0.98 +(59,52) 0.00 +(59,53) 6.73 +(59,54) 1.52 +(59,58) -5.84 +(59,60) 8.13 +(59,101) 0.00 +(59,102) -0.54 +(59,104) 0.63 +(59,108) 0.00 +(59,109) -0.98 +(59,110) 1.52 +(59,113) -5.84 +(59,114) 8.13 +(60,60) 89.40 +(60,39) 0.00 +(60,40) 1.52 +(60,41) 0.00 +(60,42) 0.63 +(60,45) 8.13 +(60,50) 0.00 +(60,51) 2.41 +(60,52) 0.00 +(60,53) 1.52 +(60,54) 15.24 +(60,58) 15.24 +(60,59) 8.13 +(61,61) 89.40 +(61,2) 0.00 +(61,3) 1.52 +(61,21) 0.00 +(61,22) 0.63 +(61,24) 8.13 +(61,39) 0.00 +(61,40) 1.52 +(61,47) 8.13 +(61,50) 0.00 +(61,51) 2.41 +(61,55) 15.24 +(61,58) 15.24 +(62,62) 47.78 +(62,15) 7.78 +(62,16) 0.00 +(62,30) 7.78 +(62,31) 0.00 +(62,63) 0.00 +(62,64) 21.11 +(62,65) 0.00 +(62,66) 4.44 +(62,67) 0.00 +(62,68) 0.00 +(62,69) 0.00 +(62,70) 0.00 +(62,71) 0.00 +(62,72) 0.00 +(62,73) 4.44 +(62,74) 0.00 +(62,75) 0.00 +(62,76) 0.00 +(62,77) 0.00 +(62,78) 0.00 +(62,120) 5.14 +(62,121) 0.00 +(62,122) 1.15 +(62,123) 0.00 +(62,127) 0.00 +(62,131) 1.15 +(62,132) 0.00 +(62,134) 0.00 +(62,167) 2.22 +(62,168) 0.00 +(62,169) 0.00 +(62,170) 0.00 +(62,171) 0.00 +(62,172) 0.00 +(62,173) 2.22 +(62,174) 0.00 +(62,175) 0.00 +(62,176) 0.00 +(62,177) 0.00 +(63,63) 16.32 +(63,15) 0.00 +(63,16) -1.24 +(63,30) 0.00 +(63,31) -1.24 +(63,62) 0.00 +(63,64) 0.00 +(63,65) -3.81 +(63,66) 0.00 +(63,67) 0.38 +(63,68) 5.84 +(63,69) -0.54 +(63,70) 3.37 +(63,71) -0.98 +(63,72) 1.52 +(63,73) 0.00 +(63,74) 0.38 +(63,75) 3.37 +(63,76) -0.98 +(63,77) -0.54 +(63,78) 1.52 +(63,120) 0.00 +(63,121) -0.88 +(63,122) 0.00 +(63,123) 0.09 +(63,127) -0.23 +(63,131) 0.00 +(63,132) 0.09 +(63,134) -0.23 +(63,167) 0.00 +(63,168) -0.36 +(63,169) 1.64 +(63,170) -0.17 +(63,171) 0.88 +(63,172) 0.43 +(63,173) 0.00 +(63,174) -0.36 +(63,175) 0.88 +(63,176) -0.17 +(63,177) 0.43 +(64,64) 73.33 +(64,15) 4.44 +(64,16) 0.00 +(64,30) 4.44 +(64,31) 0.00 +(64,62) 21.11 +(64,63) 0.00 +(64,65) 0.00 +(64,66) 21.11 +(64,67) 0.00 +(64,68) 0.00 +(64,69) 0.00 +(64,70) 0.00 +(64,71) 0.00 +(64,72) 0.00 +(64,73) 21.11 +(64,74) 0.00 +(64,75) 0.00 +(64,76) 0.00 +(64,77) 0.00 +(64,78) 0.00 +(64,79) 4.44 +(64,80) 0.00 +(64,81) 0.00 +(64,82) 0.00 +(64,83) 0.00 +(65,65) 27.43 +(65,15) 0.00 +(65,16) 0.38 +(65,30) 0.00 +(65,31) 0.38 +(65,62) 0.00 +(65,63) -3.81 +(65,64) 0.00 +(65,66) 0.00 +(65,67) -3.81 +(65,68) 9.40 +(65,69) -0.98 +(65,70) -0.98 +(65,71) 9.40 +(65,72) 2.41 +(65,73) 0.00 +(65,74) -3.81 +(65,75) -0.98 +(65,76) 9.40 +(65,77) -0.98 +(65,78) 2.41 +(65,79) 0.00 +(65,80) 0.38 +(65,81) -0.98 +(65,82) -0.98 +(65,83) 2.41 +(66,66) 75.56 +(66,30) 15.56 +(66,31) 0.00 +(66,32) 4.44 +(66,33) 0.00 +(66,37) 0.00 +(66,62) 4.44 +(66,63) 0.00 +(66,64) 21.11 +(66,65) 0.00 +(66,67) 0.00 +(66,68) 0.00 +(66,69) 0.00 +(66,70) 0.00 +(66,71) 0.00 +(66,72) 0.00 +(66,73) 4.44 +(66,74) 0.00 +(66,76) 0.00 +(66,79) 15.56 +(66,80) 0.00 +(66,81) 0.00 +(66,82) 0.00 +(66,83) 0.00 +(66,96) 21.11 +(66,97) 0.00 +(66,98) 0.00 +(66,99) 0.00 +(66,100) 0.00 +(66,101) 4.44 +(66,102) 0.00 +(66,103) 0.00 +(66,106) 0.00 +(66,107) 0.00 +(67,67) 25.90 +(67,30) 0.00 +(67,31) -2.48 +(67,32) 0.00 +(67,33) 0.38 +(67,37) -0.54 +(67,62) 0.00 +(67,63) 0.38 +(67,64) 0.00 +(67,65) -3.81 +(67,66) 0.00 +(67,68) -0.98 +(67,69) 6.73 +(67,70) -0.54 +(67,71) 5.84 +(67,72) 1.52 +(67,73) 0.00 +(67,74) 0.38 +(67,76) -0.98 +(67,79) 0.00 +(67,80) -2.48 +(67,81) -0.54 +(67,82) 6.73 +(67,83) 1.52 +(67,96) 0.00 +(67,97) -3.81 +(67,98) -0.98 +(67,99) 5.84 +(67,100) 1.52 +(67,101) 0.00 +(67,102) 0.38 +(67,103) -0.98 +(67,106) -0.54 +(67,107) 1.52 +(68,68) 58.92 +(68,15) 0.00 +(68,16) -0.54 +(68,30) 0.00 +(68,31) -0.54 +(68,62) 0.00 +(68,63) 5.84 +(68,64) 0.00 +(68,65) 9.40 +(68,66) 0.00 +(68,67) -0.98 +(68,69) -5.84 +(68,70) 1.52 +(68,71) 2.41 +(68,72) 15.24 +(68,73) 0.00 +(68,74) -0.98 +(68,75) 1.52 +(68,76) 2.41 +(68,77) -5.84 +(68,78) 15.24 +(69,69) 37.59 +(69,30) 0.00 +(69,31) 3.17 +(69,32) 0.00 +(69,33) -0.54 +(69,37) 0.63 +(69,62) 0.00 +(69,63) -0.54 +(69,64) 0.00 +(69,65) -0.98 +(69,66) 0.00 +(69,67) 6.73 +(69,68) -5.84 +(69,70) 0.63 +(69,71) 1.52 +(69,72) 8.13 +(69,96) 0.00 +(69,97) -0.98 +(69,98) -5.84 +(69,99) 1.52 +(69,100) 8.13 +(70,70) 18.79 +(70,30) 0.00 +(70,31) 1.59 +(70,62) 0.00 +(70,63) 3.37 +(70,64) 0.00 +(70,65) -0.98 +(70,66) 0.00 +(70,67) -0.54 +(70,68) 1.52 +(70,69) 0.63 +(70,71) -5.84 +(70,72) 8.13 +(71,71) 58.92 +(71,30) 0.00 +(71,31) -0.54 +(71,62) 0.00 +(71,63) -0.98 +(71,64) 0.00 +(71,65) 9.40 +(71,66) 0.00 +(71,67) 5.84 +(71,68) 2.41 +(71,69) 1.52 +(71,70) -5.84 +(71,72) 15.24 +(71,73) 0.00 +(71,74) -0.98 +(71,76) 2.41 +(71,79) 0.00 +(71,80) -0.54 +(71,81) -5.84 +(71,82) 1.52 +(71,83) 15.24 +(72,72) 89.40 +(72,30) 0.00 +(72,31) 0.63 +(72,62) 0.00 +(72,63) 1.52 +(72,64) 0.00 +(72,65) 2.41 +(72,66) 0.00 +(72,67) 1.52 +(72,68) 15.24 +(72,69) 8.13 +(72,70) 8.13 +(72,71) 15.24 +(73,73) 75.56 +(73,4) 4.44 +(73,5) 0.00 +(73,15) 15.56 +(73,16) 0.00 +(73,18) 0.00 +(73,62) 4.44 +(73,63) 0.00 +(73,64) 21.11 +(73,65) 0.00 +(73,66) 4.44 +(73,67) 0.00 +(73,68) 0.00 +(73,71) 0.00 +(73,74) 0.00 +(73,75) 0.00 +(73,76) 0.00 +(73,77) 0.00 +(73,78) 0.00 +(73,79) 15.56 +(73,80) 0.00 +(73,81) 0.00 +(73,82) 0.00 +(73,83) 0.00 +(73,84) 21.11 +(73,85) 0.00 +(73,86) 4.44 +(73,87) 0.00 +(73,88) 0.00 +(73,90) 0.00 +(73,92) 0.00 +(73,93) 0.00 +(73,94) 0.00 +(73,95) 0.00 +(74,74) 25.90 +(74,4) 0.00 +(74,5) 0.38 +(74,15) 0.00 +(74,16) -2.48 +(74,18) -0.54 +(74,62) 0.00 +(74,63) 0.38 +(74,64) 0.00 +(74,65) -3.81 +(74,66) 0.00 +(74,67) 0.38 +(74,68) -0.98 +(74,71) -0.98 +(74,73) 0.00 +(74,75) -0.54 +(74,76) 5.84 +(74,77) 6.73 +(74,78) 1.52 +(74,79) 0.00 +(74,80) -2.48 +(74,81) 6.73 +(74,82) -0.54 +(74,83) 1.52 +(74,84) 0.00 +(74,85) -3.81 +(74,86) 0.00 +(74,87) 0.38 +(74,88) -0.98 +(74,90) -0.98 +(74,92) 5.84 +(74,93) 1.52 +(74,94) -0.54 +(74,95) 1.52 +(75,75) 18.79 +(75,15) 0.00 +(75,16) 1.59 +(75,62) 0.00 +(75,63) 3.37 +(75,64) 0.00 +(75,65) -0.98 +(75,68) 1.52 +(75,73) 0.00 +(75,74) -0.54 +(75,76) -5.84 +(75,77) 0.63 +(75,78) 8.13 +(76,76) 58.92 +(76,15) 0.00 +(76,16) -0.54 +(76,62) 0.00 +(76,63) -0.98 +(76,64) 0.00 +(76,65) 9.40 +(76,66) 0.00 +(76,67) -0.98 +(76,68) 2.41 +(76,71) 2.41 +(76,73) 0.00 +(76,74) 5.84 +(76,75) -5.84 +(76,77) 1.52 +(76,78) 15.24 +(76,79) 0.00 +(76,80) -0.54 +(76,81) 1.52 +(76,82) -5.84 +(76,83) 15.24 +(77,77) 37.59 +(77,4) 0.00 +(77,5) -0.54 +(77,15) 0.00 +(77,16) 3.17 +(77,18) 0.63 +(77,62) 0.00 +(77,63) -0.54 +(77,64) 0.00 +(77,65) -0.98 +(77,68) -5.84 +(77,73) 0.00 +(77,74) 6.73 +(77,75) 0.63 +(77,76) 1.52 +(77,78) 8.13 +(77,84) 0.00 +(77,85) -0.98 +(77,88) -5.84 +(77,92) 1.52 +(77,93) 8.13 +(78,78) 89.40 +(78,15) 0.00 +(78,16) 0.63 +(78,62) 0.00 +(78,63) 1.52 +(78,64) 0.00 +(78,65) 2.41 +(78,68) 15.24 +(78,73) 0.00 +(78,74) 1.52 +(78,75) 8.13 +(78,76) 15.24 +(78,77) 8.13 +(79,79) 53.33 +(79,64) 4.44 +(79,65) 0.00 +(79,66) 15.56 +(79,67) 0.00 +(79,71) 0.00 +(79,73) 15.56 +(79,74) 0.00 +(79,76) 0.00 +(79,80) 0.00 +(79,81) 0.00 +(79,82) 0.00 +(79,83) 0.00 +(79,84) 4.44 +(79,85) 0.00 +(79,86) 15.56 +(79,87) 0.00 +(79,90) 0.00 +(79,92) 0.00 +(79,94) 0.00 +(79,95) 0.00 +(79,96) 4.44 +(79,97) 0.00 +(79,99) 0.00 +(79,101) 15.56 +(79,102) 0.00 +(79,103) 0.00 +(79,106) 0.00 +(79,107) 0.00 +(79,108) 4.44 +(79,109) 0.00 +(79,111) 0.00 +(79,113) 0.00 +(79,115) 0.00 +(80,80) 15.24 +(80,64) 0.00 +(80,65) 0.38 +(80,66) 0.00 +(80,67) -2.48 +(80,71) -0.54 +(80,73) 0.00 +(80,74) -2.48 +(80,76) -0.54 +(80,79) 0.00 +(80,81) 3.17 +(80,82) 3.17 +(80,83) 0.63 +(80,84) 0.00 +(80,85) 0.38 +(80,86) 0.00 +(80,87) -2.48 +(80,90) -0.54 +(80,92) -0.54 +(80,94) 3.17 +(80,95) 0.63 +(80,96) 0.00 +(80,97) 0.38 +(80,99) -0.54 +(80,101) 0.00 +(80,102) -2.48 +(80,103) -0.54 +(80,106) 3.17 +(80,107) 0.63 +(80,108) 0.00 +(80,109) 0.38 +(80,111) -0.54 +(80,113) -0.54 +(80,115) 0.63 +(81,81) 37.59 +(81,64) 0.00 +(81,65) -0.98 +(81,66) 0.00 +(81,67) -0.54 +(81,71) -5.84 +(81,73) 0.00 +(81,74) 6.73 +(81,76) 1.52 +(81,79) 0.00 +(81,80) 3.17 +(81,82) 0.63 +(81,83) 8.13 +(81,84) 0.00 +(81,85) -0.98 +(81,86) 0.00 +(81,87) -0.54 +(81,90) -5.84 +(81,92) 1.52 +(81,94) 0.63 +(81,95) 8.13 +(82,82) 37.59 +(82,64) 0.00 +(82,65) -0.98 +(82,66) 0.00 +(82,67) 6.73 +(82,71) 1.52 +(82,73) 0.00 +(82,74) -0.54 +(82,76) -5.84 +(82,79) 0.00 +(82,80) 3.17 +(82,81) 0.63 +(82,83) 8.13 +(82,96) 0.00 +(82,97) -0.98 +(82,99) 1.52 +(82,101) 0.00 +(82,102) -0.54 +(82,103) -5.84 +(82,106) 0.63 +(82,107) 8.13 +(83,83) 89.40 +(83,64) 0.00 +(83,65) 2.41 +(83,66) 0.00 +(83,67) 1.52 +(83,71) 15.24 +(83,73) 0.00 +(83,74) 1.52 +(83,76) 15.24 +(83,79) 0.00 +(83,80) 0.63 +(83,81) 8.13 +(83,82) 8.13 +(84,84) 73.33 +(84,4) 21.11 +(84,5) 0.00 +(84,6) 4.44 +(84,7) 0.00 +(84,11) 0.00 +(84,15) 4.44 +(84,16) 0.00 +(84,18) 0.00 +(84,73) 21.11 +(84,74) 0.00 +(84,77) 0.00 +(84,79) 4.44 +(84,80) 0.00 +(84,81) 0.00 +(84,85) 0.00 +(84,86) 21.11 +(84,87) 0.00 +(84,88) 0.00 +(84,89) 0.00 +(84,90) 0.00 +(84,91) 0.00 +(84,92) 0.00 +(84,93) 0.00 +(84,94) 0.00 +(84,95) 0.00 +(85,85) 27.43 +(85,4) 0.00 +(85,5) -3.81 +(85,6) 0.00 +(85,7) 0.38 +(85,11) -0.98 +(85,15) 0.00 +(85,16) 0.38 +(85,18) -0.98 +(85,73) 0.00 +(85,74) -3.81 +(85,77) -0.98 +(85,79) 0.00 +(85,80) 0.38 +(85,81) -0.98 +(85,84) 0.00 +(85,86) 0.00 +(85,87) -3.81 +(85,88) 9.40 +(85,89) -0.98 +(85,90) 9.40 +(85,91) 2.41 +(85,92) 9.40 +(85,93) 2.41 +(85,94) -0.98 +(85,95) 2.41 +(86,86) 75.56 +(86,4) 4.44 +(86,5) 0.00 +(86,6) 15.56 +(86,7) 0.00 +(86,11) 0.00 +(86,52) 4.44 +(86,53) 0.00 +(86,56) 0.00 +(86,73) 4.44 +(86,74) 0.00 +(86,79) 15.56 +(86,80) 0.00 +(86,81) 0.00 +(86,84) 21.11 +(86,85) 0.00 +(86,87) 0.00 +(86,88) 0.00 +(86,89) 0.00 +(86,90) 0.00 +(86,91) 0.00 +(86,92) 0.00 +(86,94) 0.00 +(86,95) 0.00 +(86,101) 4.44 +(86,102) 0.00 +(86,106) 0.00 +(86,108) 21.11 +(86,109) 0.00 +(86,110) 0.00 +(86,111) 0.00 +(86,112) 0.00 +(86,113) 0.00 +(86,115) 0.00 +(87,87) 25.90 +(87,4) 0.00 +(87,5) 0.38 +(87,6) 0.00 +(87,7) -2.48 +(87,11) -0.54 +(87,52) 0.00 +(87,53) 0.38 +(87,56) -0.54 +(87,73) 0.00 +(87,74) 0.38 +(87,79) 0.00 +(87,80) -2.48 +(87,81) -0.54 +(87,84) 0.00 +(87,85) -3.81 +(87,86) 0.00 +(87,88) -0.98 +(87,89) 6.73 +(87,90) 5.84 +(87,91) 1.52 +(87,92) -0.98 +(87,94) 6.73 +(87,95) 1.52 +(87,101) 0.00 +(87,102) 0.38 +(87,106) -0.54 +(87,108) 0.00 +(87,109) -3.81 +(87,110) -0.98 +(87,111) 5.84 +(87,112) 1.52 +(87,113) -0.98 +(87,115) 1.52 +(88,88) 58.92 +(88,4) 0.00 +(88,5) 5.84 +(88,6) 0.00 +(88,7) -0.54 +(88,11) 1.52 +(88,15) 0.00 +(88,16) -0.54 +(88,18) 1.52 +(88,73) 0.00 +(88,74) -0.98 +(88,77) -5.84 +(88,84) 0.00 +(88,85) 9.40 +(88,86) 0.00 +(88,87) -0.98 +(88,89) -5.84 +(88,90) 2.41 +(88,91) 15.24 +(88,92) 2.41 +(88,93) 15.24 +(89,89) 37.59 +(89,4) 0.00 +(89,5) -0.54 +(89,6) 0.00 +(89,7) 3.17 +(89,11) 0.63 +(89,52) 0.00 +(89,53) -0.54 +(89,56) 0.63 +(89,84) 0.00 +(89,85) -0.98 +(89,86) 0.00 +(89,87) 6.73 +(89,88) -5.84 +(89,90) 1.52 +(89,91) 8.13 +(89,108) 0.00 +(89,109) -0.98 +(89,110) -5.84 +(89,111) 1.52 +(89,112) 8.13 +(90,90) 58.92 +(90,4) 0.00 +(90,5) -0.98 +(90,6) 0.00 +(90,7) -0.54 +(90,11) -5.84 +(90,73) 0.00 +(90,74) -0.98 +(90,79) 0.00 +(90,80) -0.54 +(90,81) -5.84 +(90,84) 0.00 +(90,85) 9.40 +(90,86) 0.00 +(90,87) 5.84 +(90,88) 2.41 +(90,89) 1.52 +(90,91) 15.24 +(90,92) 2.41 +(90,94) 1.52 +(90,95) 15.24 +(91,91) 89.40 +(91,4) 0.00 +(91,5) 1.52 +(91,6) 0.00 +(91,7) 0.63 +(91,11) 8.13 +(91,84) 0.00 +(91,85) 2.41 +(91,86) 0.00 +(91,87) 1.52 +(91,88) 15.24 +(91,89) 8.13 +(91,90) 15.24 +(92,92) 58.92 +(92,4) 0.00 +(92,5) -0.98 +(92,15) 0.00 +(92,16) -0.54 +(92,18) -5.84 +(92,73) 0.00 +(92,74) 5.84 +(92,77) 1.52 +(92,79) 0.00 +(92,80) -0.54 +(92,81) 1.52 +(92,84) 0.00 +(92,85) 9.40 +(92,86) 0.00 +(92,87) -0.98 +(92,88) 2.41 +(92,90) 2.41 +(92,93) 15.24 +(92,94) -5.84 +(92,95) 15.24 +(93,93) 89.40 +(93,4) 0.00 +(93,5) 1.52 +(93,15) 0.00 +(93,16) 0.63 +(93,18) 8.13 +(93,73) 0.00 +(93,74) 1.52 +(93,77) 8.13 +(93,84) 0.00 +(93,85) 2.41 +(93,88) 15.24 +(93,92) 15.24 +(94,94) 37.59 +(94,73) 0.00 +(94,74) -0.54 +(94,79) 0.00 +(94,80) 3.17 +(94,81) 0.63 +(94,84) 0.00 +(94,85) -0.98 +(94,86) 0.00 +(94,87) 6.73 +(94,90) 1.52 +(94,92) -5.84 +(94,95) 8.13 +(94,101) 0.00 +(94,102) -0.54 +(94,106) 0.63 +(94,108) 0.00 +(94,109) -0.98 +(94,111) 1.52 +(94,113) -5.84 +(94,115) 8.13 +(95,95) 89.40 +(95,73) 0.00 +(95,74) 1.52 +(95,79) 0.00 +(95,80) 0.63 +(95,81) 8.13 +(95,84) 0.00 +(95,85) 2.41 +(95,86) 0.00 +(95,87) 1.52 +(95,90) 15.24 +(95,92) 15.24 +(95,94) 8.13 +(96,96) 73.33 +(96,30) 4.44 +(96,31) 0.00 +(96,32) 21.11 +(96,33) 0.00 +(96,37) 0.00 +(96,41) 4.44 +(96,42) 0.00 +(96,44) 0.00 +(96,66) 21.11 +(96,67) 0.00 +(96,69) 0.00 +(96,79) 4.44 +(96,80) 0.00 +(96,82) 0.00 +(96,97) 0.00 +(96,98) 0.00 +(96,99) 0.00 +(96,100) 0.00 +(96,101) 21.11 +(96,102) 0.00 +(96,103) 0.00 +(96,104) 0.00 +(96,105) 0.00 +(96,106) 0.00 +(96,107) 0.00 +(97,97) 27.43 +(97,30) 0.00 +(97,31) 0.38 +(97,32) 0.00 +(97,33) -3.81 +(97,37) -0.98 +(97,41) 0.00 +(97,42) 0.38 +(97,44) -0.98 +(97,66) 0.00 +(97,67) -3.81 +(97,69) -0.98 +(97,79) 0.00 +(97,80) 0.38 +(97,82) -0.98 +(97,96) 0.00 +(97,98) 9.40 +(97,99) 9.40 +(97,100) 2.41 +(97,101) 0.00 +(97,102) -3.81 +(97,103) 9.40 +(97,104) -0.98 +(97,105) 2.41 +(97,106) -0.98 +(97,107) 2.41 +(98,98) 58.92 +(98,30) 0.00 +(98,31) -0.54 +(98,32) 0.00 +(98,33) 5.84 +(98,37) 1.52 +(98,41) 0.00 +(98,42) -0.54 +(98,44) 1.52 +(98,66) 0.00 +(98,67) -0.98 +(98,69) -5.84 +(98,96) 0.00 +(98,97) 9.40 +(98,99) 2.41 +(98,100) 15.24 +(98,101) 0.00 +(98,102) -0.98 +(98,103) 2.41 +(98,104) -5.84 +(98,105) 15.24 +(99,99) 58.92 +(99,30) 0.00 +(99,31) -0.54 +(99,32) 0.00 +(99,33) -0.98 +(99,37) -5.84 +(99,66) 0.00 +(99,67) 5.84 +(99,69) 1.52 +(99,79) 0.00 +(99,80) -0.54 +(99,82) 1.52 +(99,96) 0.00 +(99,97) 9.40 +(99,98) 2.41 +(99,100) 15.24 +(99,101) 0.00 +(99,102) -0.98 +(99,103) 2.41 +(99,106) -5.84 +(99,107) 15.24 +(100,100) 89.40 +(100,30) 0.00 +(100,31) 0.63 +(100,32) 0.00 +(100,33) 1.52 +(100,37) 8.13 +(100,66) 0.00 +(100,67) 1.52 +(100,69) 8.13 +(100,96) 0.00 +(100,97) 2.41 +(100,98) 15.24 +(100,99) 15.24 +(101,101) 75.56 +(101,32) 4.44 +(101,33) 0.00 +(101,41) 15.56 +(101,42) 0.00 +(101,44) 0.00 +(101,52) 4.44 +(101,53) 0.00 +(101,59) 0.00 +(101,66) 4.44 +(101,67) 0.00 +(101,79) 15.56 +(101,80) 0.00 +(101,82) 0.00 +(101,86) 4.44 +(101,87) 0.00 +(101,94) 0.00 +(101,96) 21.11 +(101,97) 0.00 +(101,98) 0.00 +(101,99) 0.00 +(101,102) 0.00 +(101,103) 0.00 +(101,104) 0.00 +(101,105) 0.00 +(101,106) 0.00 +(101,107) 0.00 +(101,108) 21.11 +(101,109) 0.00 +(101,110) 0.00 +(101,111) 0.00 +(101,113) 0.00 +(101,114) 0.00 +(101,115) 0.00 +(102,102) 25.90 +(102,32) 0.00 +(102,33) 0.38 +(102,41) 0.00 +(102,42) -2.48 +(102,44) -0.54 +(102,52) 0.00 +(102,53) 0.38 +(102,59) -0.54 +(102,66) 0.00 +(102,67) 0.38 +(102,79) 0.00 +(102,80) -2.48 +(102,82) -0.54 +(102,86) 0.00 +(102,87) 0.38 +(102,94) -0.54 +(102,96) 0.00 +(102,97) -3.81 +(102,98) -0.98 +(102,99) -0.98 +(102,101) 0.00 +(102,103) 5.84 +(102,104) 6.73 +(102,105) 1.52 +(102,106) 6.73 +(102,107) 1.52 +(102,108) 0.00 +(102,109) -3.81 +(102,110) -0.98 +(102,111) -0.98 +(102,113) 5.84 +(102,114) 1.52 +(102,115) 1.52 +(103,103) 58.92 +(103,32) 0.00 +(103,33) -0.98 +(103,41) 0.00 +(103,42) -0.54 +(103,44) -5.84 +(103,66) 0.00 +(103,67) -0.98 +(103,79) 0.00 +(103,80) -0.54 +(103,82) -5.84 +(103,96) 0.00 +(103,97) 9.40 +(103,98) 2.41 +(103,99) 2.41 +(103,101) 0.00 +(103,102) 5.84 +(103,104) 1.52 +(103,105) 15.24 +(103,106) 1.52 +(103,107) 15.24 +(104,104) 37.59 +(104,32) 0.00 +(104,33) -0.54 +(104,41) 0.00 +(104,42) 3.17 +(104,44) 0.63 +(104,52) 0.00 +(104,53) -0.54 +(104,59) 0.63 +(104,96) 0.00 +(104,97) -0.98 +(104,98) -5.84 +(104,101) 0.00 +(104,102) 6.73 +(104,103) 1.52 +(104,105) 8.13 +(104,108) 0.00 +(104,109) -0.98 +(104,110) -5.84 +(104,113) 1.52 +(104,114) 8.13 +(105,105) 89.40 +(105,32) 0.00 +(105,33) 1.52 +(105,41) 0.00 +(105,42) 0.63 +(105,44) 8.13 +(105,96) 0.00 +(105,97) 2.41 +(105,98) 15.24 +(105,101) 0.00 +(105,102) 1.52 +(105,103) 15.24 +(105,104) 8.13 +(106,106) 37.59 +(106,66) 0.00 +(106,67) -0.54 +(106,79) 0.00 +(106,80) 3.17 +(106,82) 0.63 +(106,86) 0.00 +(106,87) -0.54 +(106,94) 0.63 +(106,96) 0.00 +(106,97) -0.98 +(106,99) -5.84 +(106,101) 0.00 +(106,102) 6.73 +(106,103) 1.52 +(106,107) 8.13 +(106,108) 0.00 +(106,109) -0.98 +(106,111) -5.84 +(106,113) 1.52 +(106,115) 8.13 +(107,107) 89.40 +(107,66) 0.00 +(107,67) 1.52 +(107,79) 0.00 +(107,80) 0.63 +(107,82) 8.13 +(107,96) 0.00 +(107,97) 2.41 +(107,99) 15.24 +(107,101) 0.00 +(107,102) 1.52 +(107,103) 15.24 +(107,106) 8.13 +(108,108) 73.33 +(108,6) 4.44 +(108,7) 0.00 +(108,41) 4.44 +(108,42) 0.00 +(108,52) 21.11 +(108,53) 0.00 +(108,56) 0.00 +(108,59) 0.00 +(108,79) 4.44 +(108,80) 0.00 +(108,86) 21.11 +(108,87) 0.00 +(108,89) 0.00 +(108,94) 0.00 +(108,101) 21.11 +(108,102) 0.00 +(108,104) 0.00 +(108,106) 0.00 +(108,109) 0.00 +(108,110) 0.00 +(108,111) 0.00 +(108,112) 0.00 +(108,113) 0.00 +(108,114) 0.00 +(108,115) 0.00 +(109,109) 27.43 +(109,6) 0.00 +(109,7) 0.38 +(109,41) 0.00 +(109,42) 0.38 +(109,52) 0.00 +(109,53) -3.81 +(109,56) -0.98 +(109,59) -0.98 +(109,79) 0.00 +(109,80) 0.38 +(109,86) 0.00 +(109,87) -3.81 +(109,89) -0.98 +(109,94) -0.98 +(109,101) 0.00 +(109,102) -3.81 +(109,104) -0.98 +(109,106) -0.98 +(109,108) 0.00 +(109,110) 9.40 +(109,111) 9.40 +(109,112) 2.41 +(109,113) 9.40 +(109,114) 2.41 +(109,115) 2.41 +(110,110) 58.92 +(110,6) 0.00 +(110,7) -0.54 +(110,41) 0.00 +(110,42) -0.54 +(110,52) 0.00 +(110,53) 5.84 +(110,56) 1.52 +(110,59) 1.52 +(110,86) 0.00 +(110,87) -0.98 +(110,89) -5.84 +(110,101) 0.00 +(110,102) -0.98 +(110,104) -5.84 +(110,108) 0.00 +(110,109) 9.40 +(110,111) 2.41 +(110,112) 15.24 +(110,113) 2.41 +(110,114) 15.24 +(111,111) 58.92 +(111,6) 0.00 +(111,7) -0.54 +(111,52) 0.00 +(111,53) -0.98 +(111,56) -5.84 +(111,79) 0.00 +(111,80) -0.54 +(111,86) 0.00 +(111,87) 5.84 +(111,89) 1.52 +(111,94) 1.52 +(111,101) 0.00 +(111,102) -0.98 +(111,106) -5.84 +(111,108) 0.00 +(111,109) 9.40 +(111,110) 2.41 +(111,112) 15.24 +(111,113) 2.41 +(111,115) 15.24 +(112,112) 89.40 +(112,6) 0.00 +(112,7) 0.63 +(112,52) 0.00 +(112,53) 1.52 +(112,56) 8.13 +(112,86) 0.00 +(112,87) 1.52 +(112,89) 8.13 +(112,108) 0.00 +(112,109) 2.41 +(112,110) 15.24 +(112,111) 15.24 +(113,113) 58.92 +(113,41) 0.00 +(113,42) -0.54 +(113,52) 0.00 +(113,53) -0.98 +(113,59) -5.84 +(113,79) 0.00 +(113,80) -0.54 +(113,86) 0.00 +(113,87) -0.98 +(113,94) -5.84 +(113,101) 0.00 +(113,102) 5.84 +(113,104) 1.52 +(113,106) 1.52 +(113,108) 0.00 +(113,109) 9.40 +(113,110) 2.41 +(113,111) 2.41 +(113,114) 15.24 +(113,115) 15.24 +(114,114) 89.40 +(114,41) 0.00 +(114,42) 0.63 +(114,52) 0.00 +(114,53) 1.52 +(114,59) 8.13 +(114,101) 0.00 +(114,102) 1.52 +(114,104) 8.13 +(114,108) 0.00 +(114,109) 2.41 +(114,110) 15.24 +(114,113) 15.24 +(115,115) 89.40 +(115,79) 0.00 +(115,80) 0.63 +(115,86) 0.00 +(115,87) 1.52 +(115,94) 8.13 +(115,101) 0.00 +(115,102) 1.52 +(115,106) 8.13 +(115,108) 0.00 +(115,109) 2.41 +(115,111) 15.24 +(115,113) 15.24 +(116,116) 21.25 +(116,117) 0.00 +(116,118) 6.53 +(116,119) 0.00 +(116,120) 6.53 +(116,121) 0.00 +(116,122) 1.49 +(116,123) 0.00 +(116,124) 0.00 +(116,125) 0.00 +(116,126) 0.00 +(116,127) 0.00 +(116,128) 0.00 +(116,129) 6.53 +(116,130) 0.00 +(116,131) 1.49 +(116,132) 0.00 +(116,133) 0.00 +(116,134) 0.00 +(116,135) 0.00 +(116,136) 0.00 +(116,137) 1.49 +(116,138) 0.00 +(116,139) 0.00 +(116,140) 0.00 +(116,141) 0.00 +(117,117) 7.38 +(117,116) 0.00 +(117,118) 0.00 +(117,119) -1.10 +(117,120) 0.00 +(117,121) -1.10 +(117,122) 0.00 +(117,123) 0.12 +(117,124) 2.53 +(117,125) -0.28 +(117,126) 2.53 +(117,127) -0.28 +(117,128) 0.65 +(117,129) 0.00 +(117,130) -1.10 +(117,131) 0.00 +(117,132) 0.12 +(117,133) 2.53 +(117,134) -0.28 +(117,135) -0.28 +(117,136) 0.65 +(117,137) 0.00 +(117,138) 0.12 +(117,139) -0.28 +(117,140) -0.28 +(117,141) 0.65 +(118,118) 22.78 +(118,26) 5.14 +(118,27) 0.00 +(118,116) 6.53 +(118,117) 0.00 +(118,119) 0.00 +(118,120) 1.49 +(118,121) 0.00 +(118,122) 5.14 +(118,123) 0.00 +(118,124) 0.00 +(118,125) 0.00 +(118,126) 0.00 +(118,127) 0.00 +(118,128) 0.00 +(118,129) 1.49 +(118,130) 0.00 +(118,133) 0.00 +(118,137) 5.14 +(118,138) 0.00 +(118,139) 0.00 +(118,140) 0.00 +(118,141) 0.00 +(118,153) 1.15 +(118,154) 0.00 +(118,155) 0.00 +(118,156) 0.00 +(118,157) 0.00 +(118,158) 0.00 +(118,159) 1.15 +(118,160) 0.00 +(118,161) 0.00 +(118,162) 0.00 +(118,163) 0.00 +(119,119) 7.62 +(119,26) 0.00 +(119,27) -0.88 +(119,116) 0.00 +(119,117) -1.10 +(119,118) 0.00 +(119,120) 0.00 +(119,121) 0.12 +(119,122) 0.00 +(119,123) -0.82 +(119,124) -0.28 +(119,125) 1.98 +(119,126) 1.87 +(119,127) -0.20 +(119,128) 0.48 +(119,129) 0.00 +(119,130) 0.12 +(119,133) -0.28 +(119,137) 0.00 +(119,138) -0.82 +(119,139) -0.20 +(119,140) 1.98 +(119,141) 0.48 +(119,153) 0.00 +(119,154) 0.09 +(119,155) -0.23 +(119,156) 1.87 +(119,157) -0.20 +(119,158) 0.48 +(119,159) 0.00 +(119,160) 0.09 +(119,161) -0.20 +(119,162) -0.23 +(119,163) 0.48 +(120,120) 22.78 +(120,62) 5.14 +(120,63) 0.00 +(120,116) 6.53 +(120,117) 0.00 +(120,118) 1.49 +(120,119) 0.00 +(120,121) 0.00 +(120,122) 5.14 +(120,123) 0.00 +(120,124) 0.00 +(120,125) 0.00 +(120,126) 0.00 +(120,127) 0.00 +(120,128) 0.00 +(120,129) 1.49 +(120,130) 0.00 +(120,131) 5.14 +(120,132) 0.00 +(120,133) 0.00 +(120,134) 0.00 +(120,135) 0.00 +(120,136) 0.00 +(120,167) 1.15 +(120,168) 0.00 +(120,169) 0.00 +(120,170) 0.00 +(120,171) 0.00 +(120,172) 0.00 +(120,173) 1.15 +(120,174) 0.00 +(120,175) 0.00 +(120,176) 0.00 +(120,177) 0.00 +(121,121) 7.62 +(121,62) 0.00 +(121,63) -0.88 +(121,116) 0.00 +(121,117) -1.10 +(121,118) 0.00 +(121,119) 0.12 +(121,120) 0.00 +(121,122) 0.00 +(121,123) -0.82 +(121,124) 1.87 +(121,125) -0.20 +(121,126) -0.28 +(121,127) 1.98 +(121,128) 0.48 +(121,129) 0.00 +(121,130) 0.12 +(121,131) 0.00 +(121,132) -0.82 +(121,133) -0.28 +(121,134) 1.98 +(121,135) -0.20 +(121,136) 0.48 +(121,167) 0.00 +(121,168) 0.09 +(121,169) 1.87 +(121,170) -0.20 +(121,171) -0.23 +(121,172) 0.48 +(121,173) 0.00 +(121,174) 0.09 +(121,175) -0.23 +(121,176) -0.20 +(121,177) 0.48 +(122,122) 17.22 +(122,26) 1.15 +(122,27) 0.00 +(122,30) 0.80 +(122,31) 0.00 +(122,62) 1.15 +(122,63) 0.00 +(122,116) 1.49 +(122,117) 0.00 +(122,118) 5.14 +(122,119) 0.00 +(122,120) 5.14 +(122,121) 0.00 +(122,123) 0.00 +(122,124) 0.00 +(122,125) 0.00 +(122,126) 0.00 +(122,127) 0.00 +(122,128) 0.00 +(122,153) 3.75 +(122,154) 0.00 +(122,155) 0.00 +(122,156) 0.00 +(122,157) 0.00 +(122,158) 0.00 +(122,167) 3.75 +(122,168) 0.00 +(122,169) 0.00 +(122,170) 0.00 +(122,171) 0.00 +(122,172) 0.00 +(122,181) 0.00 +(122,182) 0.00 +(122,183) 0.00 +(123,123) 5.40 +(123,26) 0.00 +(123,27) 0.09 +(123,30) 0.00 +(123,31) 0.07 +(123,62) 0.00 +(123,63) 0.09 +(123,116) 0.00 +(123,117) 0.12 +(123,118) 0.00 +(123,119) -0.82 +(123,120) 0.00 +(123,121) -0.82 +(123,122) 0.00 +(123,124) -0.20 +(123,125) 1.31 +(123,126) -0.20 +(123,127) 1.31 +(123,128) 0.32 +(123,153) 0.00 +(123,154) -0.60 +(123,155) -0.14 +(123,156) -0.20 +(123,157) 1.31 +(123,158) 0.32 +(123,167) 0.00 +(123,168) -0.60 +(123,169) -0.20 +(123,170) 1.31 +(123,171) -0.14 +(123,172) 0.32 +(123,181) -0.14 +(123,182) -0.14 +(123,183) 0.32 +(124,124) 17.46 +(124,116) 0.00 +(124,117) 2.53 +(124,118) 0.00 +(124,119) -0.28 +(124,120) 0.00 +(124,121) 1.87 +(124,122) 0.00 +(124,123) -0.20 +(124,125) -1.92 +(124,126) 0.65 +(124,127) 0.48 +(124,128) 4.51 +(124,129) 0.00 +(124,130) -0.28 +(124,131) 0.00 +(124,132) -0.20 +(124,133) 0.65 +(124,134) 0.48 +(124,135) -1.92 +(124,136) 4.51 +(125,125) 13.02 +(125,26) 0.00 +(125,27) -0.23 +(125,116) 0.00 +(125,117) -0.28 +(125,118) 0.00 +(125,119) 1.98 +(125,120) 0.00 +(125,121) -0.20 +(125,122) 0.00 +(125,123) 1.31 +(125,124) -1.92 +(125,126) 0.48 +(125,127) 0.32 +(125,128) 3.17 +(125,153) 0.00 +(125,154) -0.14 +(125,155) -1.48 +(125,156) 0.48 +(125,157) 0.32 +(125,158) 3.17 +(126,126) 17.46 +(126,116) 0.00 +(126,117) 2.53 +(126,118) 0.00 +(126,119) 1.87 +(126,120) 0.00 +(126,121) -0.28 +(126,122) 0.00 +(126,123) -0.20 +(126,124) 0.65 +(126,125) 0.48 +(126,127) -1.92 +(126,128) 4.51 +(126,129) 0.00 +(126,130) -0.28 +(126,133) 0.65 +(126,137) 0.00 +(126,138) -0.20 +(126,139) -1.92 +(126,140) 0.48 +(126,141) 4.51 +(127,127) 13.02 +(127,62) 0.00 +(127,63) -0.23 +(127,116) 0.00 +(127,117) -0.28 +(127,118) 0.00 +(127,119) -0.20 +(127,120) 0.00 +(127,121) 1.98 +(127,122) 0.00 +(127,123) 1.31 +(127,124) 0.48 +(127,125) 0.32 +(127,126) -1.92 +(127,128) 3.17 +(127,167) 0.00 +(127,168) -0.14 +(127,169) 0.48 +(127,170) 0.32 +(127,171) -1.48 +(127,172) 3.17 +(128,128) 30.48 +(128,116) 0.00 +(128,117) 0.65 +(128,118) 0.00 +(128,119) 0.48 +(128,120) 0.00 +(128,121) 0.48 +(128,122) 0.00 +(128,123) 0.32 +(128,124) 4.51 +(128,125) 3.17 +(128,126) 4.51 +(128,127) 3.17 +(129,129) 22.78 +(129,13) 5.14 +(129,14) 0.00 +(129,116) 6.53 +(129,117) 0.00 +(129,118) 1.49 +(129,119) 0.00 +(129,120) 1.49 +(129,121) 0.00 +(129,124) 0.00 +(129,126) 0.00 +(129,130) 0.00 +(129,131) 5.14 +(129,132) 0.00 +(129,133) 0.00 +(129,134) 0.00 +(129,135) 0.00 +(129,136) 0.00 +(129,137) 5.14 +(129,138) 0.00 +(129,139) 0.00 +(129,140) 0.00 +(129,141) 0.00 +(129,142) 1.15 +(129,143) 0.00 +(129,144) 0.00 +(129,145) 0.00 +(129,146) 0.00 +(129,147) 0.00 +(129,148) 1.15 +(129,149) 0.00 +(129,150) 0.00 +(129,151) 0.00 +(129,152) 0.00 +(130,130) 7.62 +(130,13) 0.00 +(130,14) -0.88 +(130,116) 0.00 +(130,117) -1.10 +(130,118) 0.00 +(130,119) 0.12 +(130,120) 0.00 +(130,121) 0.12 +(130,124) -0.28 +(130,126) -0.28 +(130,129) 0.00 +(130,131) 0.00 +(130,132) -0.82 +(130,133) 1.87 +(130,134) -0.20 +(130,135) 1.98 +(130,136) 0.48 +(130,137) 0.00 +(130,138) -0.82 +(130,139) 1.98 +(130,140) -0.20 +(130,141) 0.48 +(130,142) 0.00 +(130,143) 0.09 +(130,144) 1.87 +(130,145) -0.20 +(130,146) -0.23 +(130,147) 0.48 +(130,148) 0.00 +(130,149) 0.09 +(130,150) -0.23 +(130,151) -0.20 +(130,152) 0.48 +(131,131) 17.22 +(131,13) 1.15 +(131,14) 0.00 +(131,15) 0.80 +(131,16) 0.00 +(131,62) 1.15 +(131,63) 0.00 +(131,116) 1.49 +(131,117) 0.00 +(131,120) 5.14 +(131,121) 0.00 +(131,124) 0.00 +(131,129) 5.14 +(131,130) 0.00 +(131,132) 0.00 +(131,133) 0.00 +(131,134) 0.00 +(131,135) 0.00 +(131,136) 0.00 +(131,142) 3.75 +(131,143) 0.00 +(131,144) 0.00 +(131,145) 0.00 +(131,146) 0.00 +(131,147) 0.00 +(131,169) 0.00 +(131,173) 3.75 +(131,174) 0.00 +(131,175) 0.00 +(131,176) 0.00 +(131,177) 0.00 +(131,178) 0.00 +(131,179) 0.00 +(131,180) 0.00 +(132,132) 5.40 +(132,13) 0.00 +(132,14) 0.09 +(132,15) 0.00 +(132,16) 0.07 +(132,62) 0.00 +(132,63) 0.09 +(132,116) 0.00 +(132,117) 0.12 +(132,120) 0.00 +(132,121) -0.82 +(132,124) -0.20 +(132,129) 0.00 +(132,130) -0.82 +(132,131) 0.00 +(132,133) -0.20 +(132,134) 1.31 +(132,135) 1.31 +(132,136) 0.32 +(132,142) 0.00 +(132,143) -0.60 +(132,144) -0.20 +(132,145) 1.31 +(132,146) -0.14 +(132,147) 0.32 +(132,169) -0.20 +(132,173) 0.00 +(132,174) -0.60 +(132,175) -0.14 +(132,176) 1.31 +(132,177) 0.32 +(132,178) -0.14 +(132,179) -0.14 +(132,180) 0.32 +(133,133) 17.46 +(133,116) 0.00 +(133,117) 2.53 +(133,118) 0.00 +(133,119) -0.28 +(133,120) 0.00 +(133,121) -0.28 +(133,124) 0.65 +(133,126) 0.65 +(133,129) 0.00 +(133,130) 1.87 +(133,131) 0.00 +(133,132) -0.20 +(133,134) -1.92 +(133,135) 0.48 +(133,136) 4.51 +(133,137) 0.00 +(133,138) -0.20 +(133,139) 0.48 +(133,140) -1.92 +(133,141) 4.51 +(134,134) 13.02 +(134,62) 0.00 +(134,63) -0.23 +(134,116) 0.00 +(134,117) -0.28 +(134,120) 0.00 +(134,121) 1.98 +(134,124) 0.48 +(134,129) 0.00 +(134,130) -0.20 +(134,131) 0.00 +(134,132) 1.31 +(134,133) -1.92 +(134,135) 0.32 +(134,136) 3.17 +(134,169) 0.48 +(134,173) 0.00 +(134,174) -0.14 +(134,175) -1.48 +(134,176) 0.32 +(134,177) 3.17 +(135,135) 13.02 +(135,13) 0.00 +(135,14) -0.23 +(135,116) 0.00 +(135,117) -0.28 +(135,120) 0.00 +(135,121) -0.20 +(135,124) -1.92 +(135,129) 0.00 +(135,130) 1.98 +(135,131) 0.00 +(135,132) 1.31 +(135,133) 0.48 +(135,134) 0.32 +(135,136) 3.17 +(135,142) 0.00 +(135,143) -0.14 +(135,144) 0.48 +(135,145) 0.32 +(135,146) -1.48 +(135,147) 3.17 +(136,136) 30.48 +(136,116) 0.00 +(136,117) 0.65 +(136,120) 0.00 +(136,121) 0.48 +(136,124) 4.51 +(136,129) 0.00 +(136,130) 0.48 +(136,131) 0.00 +(136,132) 0.32 +(136,133) 4.51 +(136,134) 3.17 +(136,135) 3.17 +(137,137) 17.22 +(137,13) 1.15 +(137,14) 0.00 +(137,21) 0.80 +(137,22) 0.00 +(137,26) 1.15 +(137,27) 0.00 +(137,116) 1.49 +(137,117) 0.00 +(137,118) 5.14 +(137,119) 0.00 +(137,126) 0.00 +(137,129) 5.14 +(137,130) 0.00 +(137,133) 0.00 +(137,138) 0.00 +(137,139) 0.00 +(137,140) 0.00 +(137,141) 0.00 +(137,144) 0.00 +(137,148) 3.75 +(137,149) 0.00 +(137,150) 0.00 +(137,151) 0.00 +(137,152) 0.00 +(137,156) 0.00 +(137,159) 3.75 +(137,160) 0.00 +(137,161) 0.00 +(137,162) 0.00 +(137,163) 0.00 +(137,164) 0.00 +(137,165) 0.00 +(137,166) 0.00 +(138,138) 5.40 +(138,13) 0.00 +(138,14) 0.09 +(138,21) 0.00 +(138,22) 0.07 +(138,26) 0.00 +(138,27) 0.09 +(138,116) 0.00 +(138,117) 0.12 +(138,118) 0.00 +(138,119) -0.82 +(138,126) -0.20 +(138,129) 0.00 +(138,130) -0.82 +(138,133) -0.20 +(138,137) 0.00 +(138,139) 1.31 +(138,140) 1.31 +(138,141) 0.32 +(138,144) -0.20 +(138,148) 0.00 +(138,149) -0.60 +(138,150) -0.14 +(138,151) 1.31 +(138,152) 0.32 +(138,156) -0.20 +(138,159) 0.00 +(138,160) -0.60 +(138,161) 1.31 +(138,162) -0.14 +(138,163) 0.32 +(138,164) -0.14 +(138,165) -0.14 +(138,166) 0.32 +(139,139) 13.02 +(139,13) 0.00 +(139,14) -0.23 +(139,116) 0.00 +(139,117) -0.28 +(139,118) 0.00 +(139,119) -0.20 +(139,126) -1.92 +(139,129) 0.00 +(139,130) 1.98 +(139,133) 0.48 +(139,137) 0.00 +(139,138) 1.31 +(139,140) 0.32 +(139,141) 3.17 +(139,144) 0.48 +(139,148) 0.00 +(139,149) -0.14 +(139,150) -1.48 +(139,151) 0.32 +(139,152) 3.17 +(140,140) 13.02 +(140,26) 0.00 +(140,27) -0.23 +(140,116) 0.00 +(140,117) -0.28 +(140,118) 0.00 +(140,119) 1.98 +(140,126) 0.48 +(140,129) 0.00 +(140,130) -0.20 +(140,133) -1.92 +(140,137) 0.00 +(140,138) 1.31 +(140,139) 0.32 +(140,141) 3.17 +(140,156) 0.48 +(140,159) 0.00 +(140,160) -0.14 +(140,161) 0.32 +(140,162) -1.48 +(140,163) 3.17 +(141,141) 30.48 +(141,116) 0.00 +(141,117) 0.65 +(141,118) 0.00 +(141,119) 0.48 +(141,126) 4.51 +(141,129) 0.00 +(141,130) 0.48 +(141,133) 4.51 +(141,137) 0.00 +(141,138) 0.32 +(141,139) 3.17 +(141,140) 3.17 +(142,142) 7.22 +(142,13) 2.22 +(142,14) 0.00 +(142,15) 1.53 +(142,16) 0.00 +(142,129) 1.15 +(142,130) 0.00 +(142,131) 3.75 +(142,132) 0.00 +(142,135) 0.00 +(142,143) 0.00 +(142,144) 0.00 +(142,145) 0.00 +(142,146) 0.00 +(142,147) 0.00 +(142,173) 0.80 +(142,174) 0.00 +(142,176) 0.00 +(142,178) 0.00 +(142,179) 0.00 +(142,180) 0.00 +(143,143) 2.25 +(143,13) 0.00 +(143,14) -0.36 +(143,15) 0.00 +(143,16) -0.24 +(143,129) 0.00 +(143,130) 0.09 +(143,131) 0.00 +(143,132) -0.60 +(143,135) -0.14 +(143,142) 0.00 +(143,144) -0.17 +(143,145) 1.09 +(143,146) 0.54 +(143,147) 0.26 +(143,173) 0.00 +(143,174) 0.07 +(143,176) -0.14 +(143,178) -0.12 +(143,179) 0.54 +(143,180) 0.26 +(144,144) 13.90 +(144,13) 0.00 +(144,14) 1.64 +(144,129) 0.00 +(144,130) 1.87 +(144,131) 0.00 +(144,132) -0.20 +(144,135) 0.48 +(144,137) 0.00 +(144,138) -0.20 +(144,139) 0.48 +(144,142) 0.00 +(144,143) -0.17 +(144,145) -1.48 +(144,146) 0.43 +(144,147) 3.62 +(144,148) 0.00 +(144,149) -0.17 +(144,150) 0.43 +(144,151) -1.48 +(144,152) 3.62 +(145,145) 9.46 +(145,13) 0.00 +(145,14) -0.17 +(145,15) 0.00 +(145,16) -0.12 +(145,129) 0.00 +(145,130) -0.20 +(145,131) 0.00 +(145,132) 1.31 +(145,135) 0.32 +(145,142) 0.00 +(145,143) 1.09 +(145,144) -1.48 +(145,146) 0.26 +(145,147) 2.29 +(145,173) 0.00 +(145,174) -0.14 +(145,176) 0.32 +(145,178) -1.03 +(145,179) 0.26 +(145,180) 2.29 +(146,146) 5.62 +(146,13) 0.00 +(146,14) 0.88 +(146,129) 0.00 +(146,130) -0.23 +(146,131) 0.00 +(146,132) -0.14 +(146,135) -1.48 +(146,142) 0.00 +(146,143) 0.54 +(146,144) 0.43 +(146,145) 0.26 +(146,147) 2.73 +(147,147) 23.37 +(147,13) 0.00 +(147,14) 0.43 +(147,129) 0.00 +(147,130) 0.48 +(147,131) 0.00 +(147,132) 0.32 +(147,135) 3.17 +(147,142) 0.00 +(147,143) 0.26 +(147,144) 3.62 +(147,145) 2.29 +(147,146) 2.73 +(148,148) 7.22 +(148,13) 2.22 +(148,14) 0.00 +(148,21) 1.53 +(148,22) 0.00 +(148,129) 1.15 +(148,130) 0.00 +(148,137) 3.75 +(148,138) 0.00 +(148,139) 0.00 +(148,144) 0.00 +(148,149) 0.00 +(148,150) 0.00 +(148,151) 0.00 +(148,152) 0.00 +(148,159) 0.80 +(148,160) 0.00 +(148,161) 0.00 +(148,164) 0.00 +(148,165) 0.00 +(148,166) 0.00 +(149,149) 2.25 +(149,13) 0.00 +(149,14) -0.36 +(149,21) 0.00 +(149,22) -0.24 +(149,129) 0.00 +(149,130) 0.09 +(149,137) 0.00 +(149,138) -0.60 +(149,139) -0.14 +(149,144) -0.17 +(149,148) 0.00 +(149,150) 0.54 +(149,151) 1.09 +(149,152) 0.26 +(149,159) 0.00 +(149,160) 0.07 +(149,161) -0.14 +(149,164) 0.54 +(149,165) -0.12 +(149,166) 0.26 +(150,150) 5.62 +(150,13) 0.00 +(150,14) 0.88 +(150,129) 0.00 +(150,130) -0.23 +(150,137) 0.00 +(150,138) -0.14 +(150,139) -1.48 +(150,144) 0.43 +(150,148) 0.00 +(150,149) 0.54 +(150,151) 0.26 +(150,152) 2.73 +(151,151) 9.46 +(151,13) 0.00 +(151,14) -0.17 +(151,21) 0.00 +(151,22) -0.12 +(151,129) 0.00 +(151,130) -0.20 +(151,137) 0.00 +(151,138) 1.31 +(151,139) 0.32 +(151,144) -1.48 +(151,148) 0.00 +(151,149) 1.09 +(151,150) 0.26 +(151,152) 2.29 +(151,159) 0.00 +(151,160) -0.14 +(151,161) 0.32 +(151,164) 0.26 +(151,165) -1.03 +(151,166) 2.29 +(152,152) 23.37 +(152,13) 0.00 +(152,14) 0.43 +(152,129) 0.00 +(152,130) 0.48 +(152,137) 0.00 +(152,138) 0.32 +(152,139) 3.17 +(152,144) 3.62 +(152,148) 0.00 +(152,149) 0.26 +(152,150) 2.73 +(152,151) 2.29 +(153,153) 7.22 +(153,26) 2.22 +(153,27) 0.00 +(153,30) 1.53 +(153,31) 0.00 +(153,118) 1.15 +(153,119) 0.00 +(153,122) 3.75 +(153,123) 0.00 +(153,125) 0.00 +(153,154) 0.00 +(153,155) 0.00 +(153,156) 0.00 +(153,157) 0.00 +(153,158) 0.00 +(153,167) 0.80 +(153,168) 0.00 +(153,170) 0.00 +(153,181) 0.00 +(153,182) 0.00 +(153,183) 0.00 +(154,154) 2.25 +(154,26) 0.00 +(154,27) -0.36 +(154,30) 0.00 +(154,31) -0.24 +(154,118) 0.00 +(154,119) 0.09 +(154,122) 0.00 +(154,123) -0.60 +(154,125) -0.14 +(154,153) 0.00 +(154,155) 0.54 +(154,156) -0.17 +(154,157) 1.09 +(154,158) 0.26 +(154,167) 0.00 +(154,168) 0.07 +(154,170) -0.14 +(154,181) 0.54 +(154,182) -0.12 +(154,183) 0.26 +(155,155) 5.62 +(155,26) 0.00 +(155,27) 0.88 +(155,118) 0.00 +(155,119) -0.23 +(155,122) 0.00 +(155,123) -0.14 +(155,125) -1.48 +(155,153) 0.00 +(155,154) 0.54 +(155,156) 0.43 +(155,157) 0.26 +(155,158) 2.73 +(156,156) 13.90 +(156,26) 0.00 +(156,27) 1.64 +(156,118) 0.00 +(156,119) 1.87 +(156,122) 0.00 +(156,123) -0.20 +(156,125) 0.48 +(156,137) 0.00 +(156,138) -0.20 +(156,140) 0.48 +(156,153) 0.00 +(156,154) -0.17 +(156,155) 0.43 +(156,157) -1.48 +(156,158) 3.62 +(156,159) 0.00 +(156,160) -0.17 +(156,161) -1.48 +(156,162) 0.43 +(156,163) 3.62 +(157,157) 9.46 +(157,26) 0.00 +(157,27) -0.17 +(157,30) 0.00 +(157,31) -0.12 +(157,118) 0.00 +(157,119) -0.20 +(157,122) 0.00 +(157,123) 1.31 +(157,125) 0.32 +(157,153) 0.00 +(157,154) 1.09 +(157,155) 0.26 +(157,156) -1.48 +(157,158) 2.29 +(157,167) 0.00 +(157,168) -0.14 +(157,170) 0.32 +(157,181) 0.26 +(157,182) -1.03 +(157,183) 2.29 +(158,158) 23.37 +(158,26) 0.00 +(158,27) 0.43 +(158,118) 0.00 +(158,119) 0.48 +(158,122) 0.00 +(158,123) 0.32 +(158,125) 3.17 +(158,153) 0.00 +(158,154) 0.26 +(158,155) 2.73 +(158,156) 3.62 +(158,157) 2.29 +(159,159) 7.22 +(159,21) 1.53 +(159,22) 0.00 +(159,26) 2.22 +(159,27) 0.00 +(159,118) 1.15 +(159,119) 0.00 +(159,137) 3.75 +(159,138) 0.00 +(159,140) 0.00 +(159,148) 0.80 +(159,149) 0.00 +(159,151) 0.00 +(159,156) 0.00 +(159,160) 0.00 +(159,161) 0.00 +(159,162) 0.00 +(159,163) 0.00 +(159,164) 0.00 +(159,165) 0.00 +(159,166) 0.00 +(160,160) 2.25 +(160,21) 0.00 +(160,22) -0.24 +(160,26) 0.00 +(160,27) -0.36 +(160,118) 0.00 +(160,119) 0.09 +(160,137) 0.00 +(160,138) -0.60 +(160,140) -0.14 +(160,148) 0.00 +(160,149) 0.07 +(160,151) -0.14 +(160,156) -0.17 +(160,159) 0.00 +(160,161) 1.09 +(160,162) 0.54 +(160,163) 0.26 +(160,164) -0.12 +(160,165) 0.54 +(160,166) 0.26 +(161,161) 9.46 +(161,21) 0.00 +(161,22) -0.12 +(161,26) 0.00 +(161,27) -0.17 +(161,118) 0.00 +(161,119) -0.20 +(161,137) 0.00 +(161,138) 1.31 +(161,140) 0.32 +(161,148) 0.00 +(161,149) -0.14 +(161,151) 0.32 +(161,156) -1.48 +(161,159) 0.00 +(161,160) 1.09 +(161,162) 0.26 +(161,163) 2.29 +(161,164) -1.03 +(161,165) 0.26 +(161,166) 2.29 +(162,162) 5.62 +(162,26) 0.00 +(162,27) 0.88 +(162,118) 0.00 +(162,119) -0.23 +(162,137) 0.00 +(162,138) -0.14 +(162,140) -1.48 +(162,156) 0.43 +(162,159) 0.00 +(162,160) 0.54 +(162,161) 0.26 +(162,163) 2.73 +(163,163) 23.37 +(163,26) 0.00 +(163,27) 0.43 +(163,118) 0.00 +(163,119) 0.48 +(163,137) 0.00 +(163,138) 0.32 +(163,140) 3.17 +(163,156) 3.62 +(163,159) 0.00 +(163,160) 0.26 +(163,161) 2.29 +(163,162) 2.73 +(164,164) 3.84 +(164,21) 0.00 +(164,22) 0.43 +(164,137) 0.00 +(164,138) -0.14 +(164,148) 0.00 +(164,149) 0.54 +(164,151) 0.26 +(164,159) 0.00 +(164,160) -0.12 +(164,161) -1.03 +(164,165) 0.21 +(164,166) 1.84 +(165,165) 3.84 +(165,21) 0.00 +(165,22) 0.43 +(165,137) 0.00 +(165,138) -0.14 +(165,148) 0.00 +(165,149) -0.12 +(165,151) -1.03 +(165,159) 0.00 +(165,160) 0.54 +(165,161) 0.26 +(165,164) 0.21 +(165,166) 1.84 +(166,166) 16.25 +(166,21) 0.00 +(166,22) 0.21 +(166,137) 0.00 +(166,138) 0.32 +(166,148) 0.00 +(166,149) 0.26 +(166,151) 2.29 +(166,159) 0.00 +(166,160) 0.26 +(166,161) 2.29 +(166,164) 1.84 +(166,165) 1.84 +(167,167) 7.22 +(167,30) 1.53 +(167,31) 0.00 +(167,62) 2.22 +(167,63) 0.00 +(167,120) 1.15 +(167,121) 0.00 +(167,122) 3.75 +(167,123) 0.00 +(167,127) 0.00 +(167,153) 0.80 +(167,154) 0.00 +(167,157) 0.00 +(167,168) 0.00 +(167,169) 0.00 +(167,170) 0.00 +(167,171) 0.00 +(167,172) 0.00 +(167,181) 0.00 +(167,182) 0.00 +(167,183) 0.00 +(168,168) 2.25 +(168,30) 0.00 +(168,31) -0.24 +(168,62) 0.00 +(168,63) -0.36 +(168,120) 0.00 +(168,121) 0.09 +(168,122) 0.00 +(168,123) -0.60 +(168,127) -0.14 +(168,153) 0.00 +(168,154) 0.07 +(168,157) -0.14 +(168,167) 0.00 +(168,169) -0.17 +(168,170) 1.09 +(168,171) 0.54 +(168,172) 0.26 +(168,181) -0.12 +(168,182) 0.54 +(168,183) 0.26 +(169,169) 13.90 +(169,62) 0.00 +(169,63) 1.64 +(169,120) 0.00 +(169,121) 1.87 +(169,122) 0.00 +(169,123) -0.20 +(169,127) 0.48 +(169,131) 0.00 +(169,132) -0.20 +(169,134) 0.48 +(169,167) 0.00 +(169,168) -0.17 +(169,170) -1.48 +(169,171) 0.43 +(169,172) 3.62 +(169,173) 0.00 +(169,174) -0.17 +(169,175) 0.43 +(169,176) -1.48 +(169,177) 3.62 +(170,170) 9.46 +(170,30) 0.00 +(170,31) -0.12 +(170,62) 0.00 +(170,63) -0.17 +(170,120) 0.00 +(170,121) -0.20 +(170,122) 0.00 +(170,123) 1.31 +(170,127) 0.32 +(170,153) 0.00 +(170,154) -0.14 +(170,157) 0.32 +(170,167) 0.00 +(170,168) 1.09 +(170,169) -1.48 +(170,171) 0.26 +(170,172) 2.29 +(170,181) -1.03 +(170,182) 0.26 +(170,183) 2.29 +(171,171) 5.62 +(171,62) 0.00 +(171,63) 0.88 +(171,120) 0.00 +(171,121) -0.23 +(171,122) 0.00 +(171,123) -0.14 +(171,127) -1.48 +(171,167) 0.00 +(171,168) 0.54 +(171,169) 0.43 +(171,170) 0.26 +(171,172) 2.73 +(172,172) 23.37 +(172,62) 0.00 +(172,63) 0.43 +(172,120) 0.00 +(172,121) 0.48 +(172,122) 0.00 +(172,123) 0.32 +(172,127) 3.17 +(172,167) 0.00 +(172,168) 0.26 +(172,169) 3.62 +(172,170) 2.29 +(172,171) 2.73 +(173,173) 7.22 +(173,15) 1.53 +(173,16) 0.00 +(173,62) 2.22 +(173,63) 0.00 +(173,120) 1.15 +(173,121) 0.00 +(173,131) 3.75 +(173,132) 0.00 +(173,134) 0.00 +(173,142) 0.80 +(173,143) 0.00 +(173,145) 0.00 +(173,169) 0.00 +(173,174) 0.00 +(173,175) 0.00 +(173,176) 0.00 +(173,177) 0.00 +(173,178) 0.00 +(173,179) 0.00 +(173,180) 0.00 +(174,174) 2.25 +(174,15) 0.00 +(174,16) -0.24 +(174,62) 0.00 +(174,63) -0.36 +(174,120) 0.00 +(174,121) 0.09 +(174,131) 0.00 +(174,132) -0.60 +(174,134) -0.14 +(174,142) 0.00 +(174,143) 0.07 +(174,145) -0.14 +(174,169) -0.17 +(174,173) 0.00 +(174,175) 0.54 +(174,176) 1.09 +(174,177) 0.26 +(174,178) 0.54 +(174,179) -0.12 +(174,180) 0.26 +(175,175) 5.62 +(175,62) 0.00 +(175,63) 0.88 +(175,120) 0.00 +(175,121) -0.23 +(175,131) 0.00 +(175,132) -0.14 +(175,134) -1.48 +(175,169) 0.43 +(175,173) 0.00 +(175,174) 0.54 +(175,176) 0.26 +(175,177) 2.73 +(176,176) 9.46 +(176,15) 0.00 +(176,16) -0.12 +(176,62) 0.00 +(176,63) -0.17 +(176,120) 0.00 +(176,121) -0.20 +(176,131) 0.00 +(176,132) 1.31 +(176,134) 0.32 +(176,142) 0.00 +(176,143) -0.14 +(176,145) 0.32 +(176,169) -1.48 +(176,173) 0.00 +(176,174) 1.09 +(176,175) 0.26 +(176,177) 2.29 +(176,178) 0.26 +(176,179) -1.03 +(176,180) 2.29 +(177,177) 23.37 +(177,62) 0.00 +(177,63) 0.43 +(177,120) 0.00 +(177,121) 0.48 +(177,131) 0.00 +(177,132) 0.32 +(177,134) 3.17 +(177,169) 3.62 +(177,173) 0.00 +(177,174) 0.26 +(177,175) 2.73 +(177,176) 2.29 +(178,178) 3.84 +(178,15) 0.00 +(178,16) 0.43 +(178,131) 0.00 +(178,132) -0.14 +(178,142) 0.00 +(178,143) -0.12 +(178,145) -1.03 +(178,173) 0.00 +(178,174) 0.54 +(178,176) 0.26 +(178,179) 0.21 +(178,180) 1.84 +(179,179) 3.84 +(179,15) 0.00 +(179,16) 0.43 +(179,131) 0.00 +(179,132) -0.14 +(179,142) 0.00 +(179,143) 0.54 +(179,145) 0.26 +(179,173) 0.00 +(179,174) -0.12 +(179,176) -1.03 +(179,178) 0.21 +(179,180) 1.84 +(180,180) 16.25 +(180,15) 0.00 +(180,16) 0.21 +(180,131) 0.00 +(180,132) 0.32 +(180,142) 0.00 +(180,143) 0.26 +(180,145) 2.29 +(180,173) 0.00 +(180,174) 0.26 +(180,176) 2.29 +(180,178) 1.84 +(180,179) 1.84 +(181,181) 3.84 +(181,30) 0.00 +(181,31) 0.43 +(181,122) 0.00 +(181,123) -0.14 +(181,153) 0.00 +(181,154) 0.54 +(181,157) 0.26 +(181,167) 0.00 +(181,168) -0.12 +(181,170) -1.03 +(181,182) 0.21 +(181,183) 1.84 +(182,182) 3.84 +(182,30) 0.00 +(182,31) 0.43 +(182,122) 0.00 +(182,123) -0.14 +(182,153) 0.00 +(182,154) -0.12 +(182,157) -1.03 +(182,167) 0.00 +(182,168) 0.54 +(182,170) 0.26 +(182,181) 0.21 +(182,183) 1.84 +(183,183) 16.25 +(183,30) 0.00 +(183,31) 0.21 +(183,122) 0.00 +(183,123) 0.32 +(183,153) 0.00 +(183,154) 0.26 +(183,157) 2.29 +(183,167) 0.00 +(183,168) 0.26 +(183,170) 2.29 +(183,181) 1.84 +(183,182) 1.84