diff --git a/dumux/mixeddimension/CMakeLists.txt b/dumux/mixeddimension/CMakeLists.txt deleted file mode 100644 index e3e31cbac76852a1ab731f840664b415196c050e..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/CMakeLists.txt +++ /dev/null @@ -1,14 +0,0 @@ -add_subdirectory("embedded") -add_subdirectory("facet") -add_subdirectory("glue") - -install(FILES -assembler.hh -integrationpointsource.hh -model.hh -newtoncontroller.hh -problem.hh -properties.hh -subproblemlocaljacobian.hh -subproblemproperties.hh -DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/mixeddimension) diff --git a/dumux/mixeddimension/assembler.hh b/dumux/mixeddimension/assembler.hh deleted file mode 100644 index b66efd7f4fb983ef36a1fff23473d4ea02aaaeff..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/assembler.hh +++ /dev/null @@ -1,464 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup MixedDimension - * \brief An assembler for the global Jacobian matrix for models of mixed dimension. - * We assume a bulk domain and a lower dimensional domain on separate grids. - */ -#ifndef DUMUX_MIXEDDIMENSION_ASSEMBLER_HH -#define DUMUX_MIXEDDIMENSION_ASSEMBLER_HH - -#include <dune/istl/matrixindexset.hh> - -#include <dumux/common/exceptions.hh> -#include <dumux/mixeddimension/properties.hh> - -namespace Dumux { - -/*! - * \ingroup MixedDimension - * \brief An assembler for the global Jacobian matrix for models of mixed dimension. - * We assume a bulk domain and a lower dimensional domain on separate grids. - */ -template<class TypeTag> -class MixedDimensionAssembler -{ - using Implementation = typename GET_PROP_TYPE(TypeTag, JacobianAssembler); - - using Model = typename GET_PROP_TYPE(TypeTag, Model); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - - // obtain the type tags of the sub problems - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); - using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); - - using BulkElement = typename BulkGridView::template Codim<0>::Entity; - using LowDimElement = typename LowDimGridView::template Codim<0>::Entity; - - using SolutionVector = typename GET_PROP_TYPE(TypeTag, SolutionVector); - using JacobianMatrix = typename GET_PROP_TYPE(TypeTag, JacobianMatrix); - using SubProblemBlockIndices = typename GET_PROP(TypeTag, SubProblemBlockIndices); - using BulkMatrixBlock = typename GET_PROP(TypeTag, JacobianMatrix)::MatrixBlockBulk; - using BulkCouplingMatrixBlock = typename GET_PROP(TypeTag, JacobianMatrix)::MatrixBlockBulkCoupling; - using LowDimMatrixBlock = typename GET_PROP(TypeTag, JacobianMatrix)::MatrixBlockLowDim; - using LowDimCouplingMatrixBlock = typename GET_PROP(TypeTag, JacobianMatrix)::MatrixBlockLowDimCoupling; - - typename SubProblemBlockIndices::BulkIdx bulkIdx; - typename SubProblemBlockIndices::LowDimIdx lowDimIdx; - - enum { - bulkDim = BulkGridView::dimension, - lowDimDim = LowDimGridView::dimension, - dimWorld = BulkGridView::dimensionworld - }; - - enum { - bulkIsBox = GET_PROP_VALUE(BulkProblemTypeTag, ImplicitIsBox), - lowDimIsBox = GET_PROP_VALUE(LowDimProblemTypeTag, ImplicitIsBox) - }; - -public: - // copying the jacobian assembler is not a good idea - MixedDimensionAssembler(const MixedDimensionAssembler &) = delete; - - MixedDimensionAssembler() : problemPtr_(nullptr) {} - - /*! - * \brief Initialize the jacobian assembler. - * - * At this point we can assume that all objects in the problem and - * the model have been allocated :. We can not assume that they are - * fully initialized, though. - * - * \param problem The problem object - */ - void init(Problem& problem) - { - // save problem pointer - problemPtr_ = &problem; - - // initialize the multitype matrix - asImp_().createMatrix_(); - - // initialize the jacobian matrix with zeros - *matrix_ = 0.0; - - // allocate the residual vector (right-hand-side) - residual_[bulkIdx].resize(problem.model().bulkNumDofs()); - residual_[lowDimIdx].resize(problem.model().lowDimNumDofs()); - } - - /*! - * \brief Assemble the global Jacobian of the residual and the residual for the current solution. - * - * The current state of affairs (esp. the previous and the current - * solutions) is represented by the model object. - */ - void assemble() - { - bool succeeded; - try - { - asImp_().assemble_(); - succeeded = true; - } - catch (Dumux::NumericalProblem &e) - { - std::cout << " caught an exception while assembling:" << e.what() << std::endl; - succeeded = false; - } - - if (!succeeded) - DUNE_THROW(NumericalProblem, "A process did not succeed in linearizing the system"); - } - - /*! - * \brief Return constant reference to global Jacobian matrix. - */ - const JacobianMatrix& matrix() const - { return *matrix_; } - - JacobianMatrix& matrix() - { return *matrix_; } - - /*! - * \brief Return constant reference to global residual vector. - */ - const SolutionVector& residual() const - { return residual_; } - - SolutionVector& residual() - { return residual_; } - -protected: - // reset the global linear system of equations. - void resetSystem_() - { - // reset the right hand side. - residual_ = 0.0; - - // reset the matrix - *matrix_ = 0.0; - } - - // linearize the whole system - void assemble_() - { - resetSystem_(); - - // assemble the elements of the bulk problem - for (const auto& element : elements(problem_().bulkGridView())) - problem_().model().bulkLocalJacobian().assemble(element, - (*matrix_)[bulkIdx][bulkIdx], - (*matrix_)[bulkIdx][lowDimIdx], - residual_[bulkIdx]); - - // assemble the elements of the lowdim problem - for (const auto& element : elements(problem_().lowDimGridView())) - problem_().model().lowDimLocalJacobian().assemble(element, - (*matrix_)[lowDimIdx][lowDimIdx], - (*matrix_)[lowDimIdx][bulkIdx], - residual_[lowDimIdx]); - } - - template <class T = BulkProblemTypeTag, typename std::enable_if<((!GET_PROP_VALUE(T, ImplicitIsBox))), bool>::type = 0> - void buildBulkMatrixBlocks_(BulkMatrixBlock& m, BulkCouplingMatrixBlock& cm) - { - // get occupation pattern of the matrix - Dune::MatrixIndexSet bulkPattern, bulkCouplingPattern; - bulkPattern.resize(m.N(), m.M()); - bulkCouplingPattern.resize(cm.N(), cm.M()); - - const auto& assemblyMap = this->problem_().bulkProblem().model().localJacobian().assemblyMap(); - for (const auto& element : elements(problem_().bulkGridView())) - { - const auto globalI = problem_().model().bulkElementMapper().index(element); - - bulkPattern.add(globalI, globalI); - for (const auto& dataJ : assemblyMap[globalI]) - bulkPattern.add(dataJ.globalJ, globalI); - - // reserve index for additional user defined DOF dependencies - const auto& additionalDofDependencies = problem_().bulkProblem().getAdditionalDofDependencies(globalI); - for (auto globalJ : additionalDofDependencies) - bulkPattern.add(globalI, globalJ); - - const auto& couplingStencil = problem_().couplingManager().couplingStencil(element); - for (auto globalJ : couplingStencil) - bulkCouplingPattern.add(globalI, globalJ); - } - - // export occupation patterns to matrices - bulkPattern.exportIdx(m); - bulkCouplingPattern.exportIdx(cm); - } - - template <class T = LowDimProblemTypeTag, typename std::enable_if<((!GET_PROP_VALUE(T, ImplicitIsBox))), bool>::type = 0> - void buildLowDimMatrixBlocks_(LowDimMatrixBlock& m, LowDimCouplingMatrixBlock& cm) - { - // get occupation pattern of the matrix - Dune::MatrixIndexSet lowDimPattern, lowDimCouplingPattern; - lowDimPattern.resize(m.N(), m.M()); - lowDimCouplingPattern.resize(cm.N(), cm.M()); - - const auto& assemblyMap = this->problem_().lowDimProblem().model().localJacobian().assemblyMap(); - for (const auto& element : elements(problem_().lowDimGridView())) - { - const auto globalI = problem_().model().lowDimElementMapper().index(element); - - lowDimPattern.add(globalI, globalI); - for (const auto& dataJ : assemblyMap[globalI]) - lowDimPattern.add(dataJ.globalJ, globalI); - - // reserve index for additional user defined DOF dependencies - const auto& additionalDofDependencies = problem_().lowDimProblem().getAdditionalDofDependencies(globalI); - for (auto globalJ : additionalDofDependencies) - lowDimPattern.add(globalI, globalJ); - - const auto& couplingStencil = problem_().couplingManager().couplingStencil(element); - for (auto globalJ : couplingStencil) - lowDimCouplingPattern.add(globalI, globalJ); - } - - // export occupation patterns to matrices - lowDimPattern.exportIdx(m); - lowDimCouplingPattern.exportIdx(cm); - } - - template <class T = BulkProblemTypeTag, typename std::enable_if<((GET_PROP_VALUE(T, ImplicitIsBox))), bool>::type = 0> - void buildBulkMatrixBlocks_(BulkMatrixBlock& m, BulkCouplingMatrixBlock& cm) - { - // get occupation pattern of the matrix - Dune::MatrixIndexSet bulkPattern, bulkCouplingPattern; - bulkPattern.resize(m.N(), m.M()); - bulkCouplingPattern.resize(cm.N(), cm.M()); - - for (const auto& element : elements(problem_().bulkGridView())) - { - const auto& couplingStencil = problem_().couplingManager().couplingStencil(element); - - for (unsigned int vIdx = 0; vIdx < element.subEntities(bulkDim); ++vIdx) - { - const auto globalI = problem_().model().bulkVertexMapper().subIndex(element, vIdx, bulkDim); - for (unsigned int vIdx2 = vIdx; vIdx2 < element.subEntities(bulkDim); ++vIdx2) - { - const auto globalJ = problem_().model().bulkVertexMapper().subIndex(element, vIdx2, bulkDim); - bulkPattern.add(globalI, globalJ); - bulkPattern.add(globalJ, globalI); - } - - for (auto&& globalJ : couplingStencil) - bulkCouplingPattern.add(globalI, globalJ); - - //TODO: additionalDofDependencies - } - } - - // export occupation patterns to matrices - bulkPattern.exportIdx(m); - bulkCouplingPattern.exportIdx(cm); - } - - template <class T = LowDimProblemTypeTag, typename std::enable_if<((GET_PROP_VALUE(T, ImplicitIsBox))), bool>::type = 0> - void buildLowDimMatrixBlocks_(LowDimMatrixBlock& m, LowDimCouplingMatrixBlock& cm) - { - // get occupation pattern of the matrix - Dune::MatrixIndexSet lowDimPattern, lowDimCouplingPattern; - lowDimPattern.resize(m.N(), m.M()); - lowDimCouplingPattern.resize(cm.N(), cm.M()); - - for (const auto& element : elements(problem_().lowDimGridView())) - { - const auto& couplingStencil = problem_().couplingManager().couplingStencil(element); - - for (unsigned int vIdx = 0; vIdx < element.subEntities(lowDimDim); ++vIdx) - { - const auto globalI = problem_().model().lowDimVertexMapper().subIndex(element, vIdx, lowDimDim); - for (unsigned int vIdx2 = vIdx; vIdx2 < element.subEntities(lowDimDim); ++vIdx2) - { - const auto globalJ = problem_().model().lowDimVertexMapper().subIndex(element, vIdx2, lowDimDim); - lowDimPattern.add(globalI, globalJ); - lowDimPattern.add(globalJ, globalI); - } - - for (auto&& globalJ : couplingStencil) - lowDimCouplingPattern.add(globalI, globalJ); - - //TODO: additionalDofDependencies - } - } - - // export occupation patterns to matrices - lowDimPattern.exportIdx(m); - lowDimCouplingPattern.exportIdx(cm); - } - - // Construct the multitype matrix for the global jacobian - void createMatrix_() - { - // create the multitype matrix - matrix_ = std::make_shared<JacobianMatrix>(); - - // get sub matrix sizes - const auto bulkSize = problem_().model().bulkNumDofs(); - const auto lowDimSize = problem_().model().lowDimNumDofs(); - - // allocate the sub matrices - auto A11 = BulkMatrixBlock(bulkSize, bulkSize, BulkMatrixBlock::random); - auto A12 = BulkCouplingMatrixBlock(bulkSize, lowDimSize, BulkCouplingMatrixBlock::random); - auto A22 = LowDimMatrixBlock(lowDimSize, lowDimSize, LowDimMatrixBlock::random); - auto A21 = LowDimCouplingMatrixBlock(lowDimSize, bulkSize, LowDimCouplingMatrixBlock::random); - - buildBulkMatrixBlocks_(A11, A12); - buildLowDimMatrixBlocks_(A22, A21); - - (*matrix_)[bulkIdx][bulkIdx] = A11; - (*matrix_)[bulkIdx][lowDimIdx] = A12; - (*matrix_)[lowDimIdx][bulkIdx] = A21; - (*matrix_)[lowDimIdx][lowDimIdx] = A22; - } - - // assemble a bulk element - // void assembleElement_(const BulkElement &element) - // { - // problem_().model().bulkLocalJacobian().assemble(element); - - // if (!bulkIsBox) - // { - // int globalI = problem_().model().bulkElementMapper().index(element); - - // // update the right hand side - // residual_[bulkIdx][globalI] = problem_().model().bulkLocalJacobian().residual(0); - // for (int j = 0; j < residual_[bulkIdx][globalI].dimension; ++j) - // assert(std::isfinite(residual_[bulkIdx][globalI][j])); - - // const auto& stencil = problem_().couplingManager().stencil(element); - // const auto& couplingStencil = problem_().couplingManager().couplingStencil(element); - - // int j = 0; - // for (auto&& globalJ : stencil) - // (*matrix_)[bulkIdx][bulkIdx][globalI][globalJ] = problem_().model().bulkLocalJacobian().mat(bulkIdx, 0, j++); - - // j = 0; - // for (auto&& globalJ : couplingStencil) - // (*matrix_)[bulkIdx][lowDimIdx][globalI][globalJ] = problem_().model().bulkLocalJacobian().mat(lowDimIdx, 0, j++); - // } - // else - // { - // const auto& stencil = problem_().couplingManager().stencil(element); - // const auto& couplingStencil = problem_().couplingManager().couplingStencil(element); - - // for (unsigned int scvIdx = 0; scvIdx < element.subEntities(bulkDim); ++scvIdx) - // { - // auto globalI = problem_().model().bulkVertexMapper().subIndex(element, scvIdx, bulkDim); - - // // update the right hand side - // residual_[bulkIdx][globalI] += problem_().model().bulkLocalJacobian().residual(scvIdx); - // for (int j = 0; j < residual_[bulkIdx][globalI].dimension; ++j) - // assert(std::isfinite(residual_[bulkIdx][globalI][j])); - - // int j = 0; - // for (auto&& globalJ : stencil) - // (*matrix_)[bulkIdx][bulkIdx][globalI][globalJ] += problem_().model().bulkLocalJacobian().mat(bulkIdx, scvIdx, j++); - - // j = 0; - // for (auto&& globalJ : couplingStencil) - // (*matrix_)[bulkIdx][lowDimIdx][globalI][globalJ] += problem_().model().bulkLocalJacobian().mat(lowDimIdx, scvIdx, j++); - // } - // } - // } - - // // assemble a bulk element - // void assembleElement_(const LowDimElement &element) - // { - // problem_().model().lowDimLocalJacobian().assemble(element); - - // if (!lowDimIsBox) - // { - // int globalI = problem_().model().lowDimElementMapper().index(element); - - // // update the right hand side - // residual_[lowDimIdx][globalI] = problem_().model().lowDimLocalJacobian().residual(0); - // for (int j = 0; j < residual_[lowDimIdx][globalI].dimension; ++j) - // assert(std::isfinite(residual_[lowDimIdx][globalI][j])); - - // const auto& stencil = problem_().couplingManager().stencil(element); - // const auto& couplingStencil = problem_().couplingManager().couplingStencil(element); - - // int j = 0; - // for (auto&& globalJ : stencil) - // (*matrix_)[lowDimIdx][lowDimIdx][globalI][globalJ] = problem_().model().lowDimLocalJacobian().mat(lowDimIdx, 0, j++); - - // j = 0; - // for (auto&& globalJ : couplingStencil) - // (*matrix_)[lowDimIdx][bulkIdx][globalI][globalJ] = problem_().model().lowDimLocalJacobian().mat(bulkIdx, 0, j++); - // } - // else - // { - // const auto& stencil = problem_().couplingManager().stencil(element); - // const auto& couplingStencil = problem_().couplingManager().couplingStencil(element); - - // for (unsigned int scvIdx = 0; scvIdx < element.subEntities(lowDimDim); ++scvIdx) - // { - // auto globalI = problem_().model().lowDimVertexMapper().subIndex(element, scvIdx, lowDimDim); - - // // update the right hand side - // residual_[lowDimIdx][globalI] += problem_().model().lowDimLocalJacobian().residual(scvIdx); - // for (int j = 0; j < residual_[lowDimIdx][globalI].dimension; ++j) - // assert(std::isfinite(residual_[lowDimIdx][globalI][j])); - - // int j = 0; - // for (auto&& globalJ : stencil) - // (*matrix_)[lowDimIdx][lowDimIdx][globalI][globalJ] += problem_().model().lowDimLocalJacobian().mat(lowDimIdx, scvIdx, j++); - - // j = 0; - // for (auto&& globalJ : couplingStencil) - // (*matrix_)[lowDimIdx][bulkIdx][globalI][globalJ] += problem_().model().lowDimLocalJacobian().mat(bulkIdx, scvIdx, j++); - // } - // } - // } - - Problem &problem_() - { return *problemPtr_; } - const Problem &problem_() const - { return *problemPtr_; } - - // the multidimension problem - Problem *problemPtr_; - - // the jacobian matrix - std::shared_ptr<JacobianMatrix> matrix_; - // the right-hand side - SolutionVector residual_; - -private: - Implementation &asImp_() - { return *static_cast<Implementation*>(this); } - const Implementation &asImp_() const - { return *static_cast<const Implementation*>(this); } -}; - -} // namespace Dumux - -#endif diff --git a/dumux/mixeddimension/embedded/CMakeLists.txt b/dumux/mixeddimension/embedded/CMakeLists.txt deleted file mode 100644 index a2f10ebf0abf26b8dd0a0bdf6787b6a36c8df9fc..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/embedded/CMakeLists.txt +++ /dev/null @@ -1 +0,0 @@ -add_subdirectory("cellcentered") diff --git a/dumux/mixeddimension/embedded/cellcentered/CMakeLists.txt b/dumux/mixeddimension/embedded/cellcentered/CMakeLists.txt deleted file mode 100644 index 34bfec0cc6a2a705e158f3cbb25486fb82c32823..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/embedded/cellcentered/CMakeLists.txt +++ /dev/null @@ -1,7 +0,0 @@ - -#install headers -install(FILES -bboxtreecouplingmanager.hh -bboxtreecouplingmanagersimple.hh -pointsourcedata.hh -DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/mixeddimension/embedded/cellcentered) diff --git a/dumux/mixeddimension/embedded/cellcentered/bboxtreecouplingmanager.hh b/dumux/mixeddimension/embedded/cellcentered/bboxtreecouplingmanager.hh deleted file mode 100644 index 29adbfbfee78dc6648e77169f4f44fdfa41d4f53..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/embedded/cellcentered/bboxtreecouplingmanager.hh +++ /dev/null @@ -1,647 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup EmbeddedCoupling - * \ingroup CCModel - * \brief Coupling manager for low-dimensional domains embedded in the bulk - * domain. Point sources on each integration point are computed by an AABB tree. - * Both domain are assumed to be discretized using a cc finite volume scheme. - */ - -#ifndef DUMUX_CC_BBOXTREE_EMBEDDEDCOUPLINGMANAGER_HH -#define DUMUX_CC_BBOXTREE_EMBEDDEDCOUPLINGMANAGER_HH - -#include <iostream> -#include <fstream> -#include <string> -#include <utility> - -#include <dune/common/timer.hh> -#include <dune/geometry/quadraturerules.hh> -#include <dune/geometry/referenceelements.hh> - -#include <dumux/mixeddimension/glue/glue.hh> -#include <dumux/mixeddimension/embedded/cellcentered/pointsourcedata.hh> - -namespace Dumux -{ - -namespace Properties -{ -// Property forward declarations -NEW_PROP_TAG(BulkProblemTypeTag); -NEW_PROP_TAG(LowDimProblemTypeTag); -NEW_PROP_TAG(GridView); -} // namespace Properties - -/*! - * \ingroup EmbeddedCoupling - * \ingroup CCModel - * \brief Manages the coupling between bulk elements and lower dimensional elements - * Point sources on each integration point are computed by an AABB tree. - * Both domain are assumed to be discretized using a cc finite volume scheme. - */ -template<class TypeTag> -class CCBBoxTreeEmbeddedCouplingManager -{ - using Implementation = typename GET_PROP_TYPE(TypeTag, CouplingManager); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using PointSourceData = Dumux::PointSourceDataCircleAverage<TypeTag>; - - // obtain the type tags of the sub problems - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); - using BulkProblem = typename GET_PROP_TYPE(BulkProblemTypeTag, Problem); - using BulkPointSource = typename GET_PROP_TYPE(BulkProblemTypeTag, PointSource); - using BulkPrimaryVariables = typename GET_PROP_TYPE(BulkProblemTypeTag, PrimaryVariables); - using BulkElementSolutionVector = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementSolutionVector); - using BulkVolumeVariables = typename GET_PROP_TYPE(BulkProblemTypeTag, VolumeVariables); - using BulkElementVolumeVariables = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementVolumeVariables); - using BulkFVElementGeometry = typename GET_PROP_TYPE(BulkProblemTypeTag, FVElementGeometry); - using BulkElementBoundaryTypes = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementBoundaryTypes); - using BulkElementFluxVariablesCache = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementFluxVariablesCache); - using BulkElement = typename BulkGridView::template Codim<0>::Entity; - - using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); - using LowDimProblem = typename GET_PROP_TYPE(LowDimProblemTypeTag, Problem); - using LowDimPointSource = typename GET_PROP_TYPE(LowDimProblemTypeTag, PointSource); - using LowDimPrimaryVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, PrimaryVariables); - using LowDimVolumeVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, VolumeVariables); - using LowDimElementVolumeVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, ElementVolumeVariables); - using LowDimFVElementGeometry = typename GET_PROP_TYPE(LowDimProblemTypeTag, FVElementGeometry); - using LowDimElementBoundaryTypes = typename GET_PROP_TYPE(LowDimProblemTypeTag, ElementBoundaryTypes); - using LowDimElementFluxVariablesCache = typename GET_PROP_TYPE(LowDimProblemTypeTag, ElementFluxVariablesCache); - using LowDimElement = typename LowDimGridView::template Codim<0>::Entity; - - enum { - bulkDim = BulkGridView::dimension, - lowDimDim = LowDimGridView::dimension, - dimWorld = BulkGridView::dimensionworld - }; - - using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; -public: - - /*! - * \brief Constructor - */ - CCBBoxTreeEmbeddedCouplingManager(BulkProblem& bulkProblem, LowDimProblem& lowDimProblem) - : bulkProblem_(bulkProblem), lowDimProblem_(lowDimProblem) - { - // Check if we are using the cellcentered method in both domains - static_assert(lowDimDim == 1, "The bounding box coupling manager only works with one-dimensional low-dim grids"); - } - - /*! - * \brief Methods to be accessed by the coupled problem - */ - // \{ - - /*! - * \brief Called by the coupled problem before - * initializing the subproblems / models - */ - void preInit() - { - asImp_().computePointSourceData(); - } - - /*! - * \brief Called by the coupled problem after - * initializing the subproblems / models - */ - void postInit() - { - glue_ = std::make_shared<CCMultiDimensionGlue<TypeTag>>(bulkProblem(), lowDimProblem()); - asImp_().computeLowDimVolumeFractions(); - } - - /*! - * \brief Update after the grid has changed - */ - void update() - { - asImp_().computePointSourceData(); - asImp_().computeLowDimVolumeFractions(); - } - - /*! - * \brief The bulk coupling stencil, i.e. which low-dimensional dofs - * the given bulk element dof depends on. - */ - const std::vector<unsigned int>& couplingStencil(const BulkElement& element) const - { - const unsigned int eIdx = bulkProblem().elementMapper().index(element); - if (bulkCouplingStencils_.count(eIdx)) - return bulkCouplingStencils_.at(eIdx); - else - return emptyStencil_; - } - - /*! - * \brief The low dim coupling stencil, i.e. which bulk dofs - * the given low dimensional element dof depends on. - */ - const std::vector<unsigned int>& couplingStencil(const LowDimElement& element) const - { - const unsigned int eIdx = lowDimProblem().elementMapper().index(element); - if (lowDimCouplingStencils_.count(eIdx)) - return lowDimCouplingStencils_.at(eIdx); - else - return emptyStencil_; - } - - //! evaluate coupling residual for the derivative bulk DOF with respect to low dim DOF - //! we only need to evaluate the part of the residual that will be influence by the low dim DOF - BulkPrimaryVariables evalCouplingResidual(const BulkElement& element, - const BulkFVElementGeometry& fvGeometry, - const BulkElementVolumeVariables& curElemVolVars, - const BulkElementBoundaryTypes& elemBcTypes, - const BulkElementFluxVariablesCache& elemFluxVarsCache, - const LowDimElement& lowDimElement) - { - const auto bulkElementIdx = bulkProblem().elementMapper().index(element); - auto&& scv = fvGeometry.scv(bulkElementIdx); - auto couplingSource = bulkProblem().scvPointSources(element, fvGeometry, curElemVolVars, scv); - couplingSource *= -scv.volume()*curElemVolVars[scv].extrusionFactor(); - return couplingSource; - } - - //! evaluate coupling residual for the derivative low dim DOF with respect to bulk DOF - //! we only need to evaluate the part of the residual that will be influence by the bulk DOF - LowDimPrimaryVariables evalCouplingResidual(const LowDimElement& element, - const LowDimFVElementGeometry& fvGeometry, - const LowDimElementVolumeVariables& curElemVolVars, - const LowDimElementBoundaryTypes& elemBcTypes, - const LowDimElementFluxVariablesCache& elemFluxVarsCache, - const BulkElement& bulkElement) - { - const auto lowDimElementIdx = lowDimProblem().elementMapper().index(element); - auto&& scv = fvGeometry.scv(lowDimElementIdx); - auto couplingSource = lowDimProblem().scvPointSources(element, fvGeometry, curElemVolVars, scv); - couplingSource *= -scv.volume()*curElemVolVars[scv].extrusionFactor(); - return couplingSource; - } - - // \} - - /* \brief Compute integration point point sources and associated data - * - * This method uses grid glue to intersect the given grids. Over each intersection - * we later need to integrate a source term. This method places point sources - * at each quadrature point and provides the point source with the necessary - * information to compute integrals (quadrature weight and integration element) - * \param order The order of the quadrature rule for integration of sources over an intersection - * \param verbose If the point source computation is verbose - */ - void computePointSourceData(unsigned int order = 1, bool verbose = false) - { - // Initialize the bulk bounding box tree - const auto& bulkTree = this->bulkProblem().boundingBoxTree(); - - // initilize the maps - // do some logging and profiling - Dune::Timer watch; - std::cout << "Initializing the point sources..." << std::endl; - - // clear all internal members like pointsource vectors and stencils - // initializes the point source id counter - clear(); - - // iterate over all lowdim elements - for (const auto& lowDimElement : elements(this->lowDimGridView())) - { - // get the Gaussian quadrature rule for the low dim element - auto lowDimGeometry = lowDimElement.geometry(); - const auto& quad = Dune::QuadratureRules<Scalar, lowDimDim>::rule(lowDimGeometry.type(), order); - - const unsigned int lowDimElementIdx = this->lowDimProblem().elementMapper().index(lowDimElement); - - // apply the Gaussian quadrature rule and define point sources at each quadrature point - // note that the approximation is not optimal if - // (a) the one-dimensional elements are too large, - // (b) whenever a one-dimensional element is split between two or more elements, - // (c) when gradients of important quantities in the three-dimensional domain are large. - - // iterate over all quadrature points - for (auto&& qp : quad) - { - // global position of the quadrature point - const auto globalPos = lowDimGeometry.global(qp.position()); - - auto bulkElementIndices = bulkTree.computeEntityCollisions(globalPos); - - // do not add a point source if the qp is outside of the 3d grid - // this is equivalent to having a source of zero for that qp - if (bulkElementIndices.empty()) - continue; - - ////////////////////////////////////////////////////////// - // get circle average connectivity and interpolation data - ////////////////////////////////////////////////////////// - - auto numIp = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, int, MixedDimension, NumCircleSegments); - const auto radius = this->lowDimProblem().spatialParams().radius(lowDimElementIdx); - const auto normal = lowDimGeometry.corner(1)-lowDimGeometry.corner(0); - auto length = 2*M_PI*radius/numIp; - - auto circlePoints = this->getCirclePoints_(globalPos, normal, radius, numIp); - std::vector<Scalar> circleIpWeight; - std::vector<unsigned int> circleStencil; - for (const auto& p : circlePoints) - { - auto bulkElementIndices = bulkTree.computeEntityCollisions(p); - if (bulkElementIndices.empty()) - continue; - - for (auto bulkElementIdx : bulkElementIndices) - { - circleStencil.push_back(bulkElementIdx); - circleIpWeight.push_back(length); - } - } - - // export low dim circle stencil - lowDimCircleStencils_[lowDimElementIdx].insert(lowDimCircleStencils_[lowDimElementIdx].end(), - circleStencil.begin(), - circleStencil.end()); - - for (auto bulkElementIdx : bulkElementIndices) - { - const auto id = idCounter_++; - const auto ie = lowDimGeometry.integrationElement(qp.position()); - const auto qpweight = qp.weight(); - - this->bulkPointSources().emplace_back(globalPos, id, qpweight, ie, std::vector<unsigned int>({bulkElementIdx})); - this->bulkPointSources().back().setEmbeddings(bulkElementIndices.size()); - this->lowDimPointSources().emplace_back(globalPos, id, qpweight, ie, std::vector<unsigned int>({lowDimElementIdx})); - this->lowDimPointSources().back().setEmbeddings(bulkElementIndices.size()); - - // pre compute additional data used for the evaluation of - // the actual solution dependent source term - PointSourceData psData; - psData.addLowDimInterpolation(lowDimElementIdx); - psData.addBulkInterpolation(bulkElementIdx); - // add data needed to compute integral over the circle - psData.addCircleInterpolation(circleIpWeight, circleStencil); - - // publish point source data in the global vector - pointSourceData_.push_back(psData); - - // compute the coupling stencils - bulkCouplingStencils_[bulkElementIdx].push_back(lowDimElementIdx); - - // export bulk circle stencil - bulkCircleStencils_[bulkElementIdx].insert(bulkCircleStencils_[bulkElementIdx].end(), - circleStencil.begin(), - circleStencil.end()); - } - } - } - - // make the circle stencils unique - for (auto&& stencil : bulkCircleStencils_) - { - std::sort(stencil.second.begin(), stencil.second.end()); - stencil.second.erase(std::unique(stencil.second.begin(), stencil.second.end()), stencil.second.end()); - stencil.second.erase(std::remove_if(stencil.second.begin(), stencil.second.end(), - [&](auto i){ return i == stencil.first; }), - stencil.second.end()); - } - - for (auto&& stencil : lowDimCircleStencils_) - { - std::sort(stencil.second.begin(), stencil.second.end()); - stencil.second.erase(std::unique(stencil.second.begin(), stencil.second.end()), stencil.second.end()); - } - - // coupling stencils - for (auto&& stencil : bulkCouplingStencils_) - { - std::sort(stencil.second.begin(), stencil.second.end()); - stencil.second.erase(std::unique(stencil.second.begin(), stencil.second.end()), stencil.second.end()); - } - - // the low dim coupling stencil - for (auto&& stencil : lowDimCouplingStencils_) - { - // add the circle stencil to the coupling stencil - stencil.second.insert(stencil.second.end(), - lowDimCircleStencils_.at(stencil.first).begin(), - lowDimCircleStencils_.at(stencil.first).end()); - std::sort(stencil.second.begin(), stencil.second.end()); - stencil.second.erase(std::unique(stencil.second.begin(), stencil.second.end()), stencil.second.end()); - } - - std::cout << "took " << watch.elapsed() << " seconds." << std::endl; - } - - //! Compute the low dim volume fraction in the bulk domain cells - void computeLowDimVolumeFractions() - { - // intersect the bounding box trees - glue_->build(); - - // resize the storage vector - lowDimVolumeInBulkElement_.resize(bulkProblem().gridView().size(0)); - - // compute the low dim volume fractions - for (const auto& is : intersections(*glue_)) - { - // all inside elements are identical... - const auto& inside = is.inside(0); - const auto intersectionGeometry = is.geometry(); - const unsigned int lowDimElementIdx = lowDimProblem().elementMapper().index(inside); - - // compute the volume the low-dim domain occupies in the bulk domain if it were full-dimensional - const auto radius = lowDimProblem().spatialParams().radius(lowDimElementIdx); - for (unsigned int outsideIdx = 0; outsideIdx < is.neighbor(0); ++outsideIdx) - { - const auto& outside = is.outside(outsideIdx); - const unsigned int bulkElementIdx = bulkProblem().elementMapper().index(outside); - lowDimVolumeInBulkElement_[bulkElementIdx] += intersectionGeometry.volume()*M_PI*radius*radius; - } - } - } - - /*! - * \brief Methods to be accessed by the subproblems - */ - // \{ - - //! Return a reference to the bulk problem - Scalar radius(unsigned int id) const - { - const auto& data = pointSourceData_[id]; - return lowDimProblem().spatialParams().radius(data.lowDimElementIdx()); - } - - //! The volume the lower dimensional domain occupies in the bulk domain element - // For one-dimensional low dim domain we assume radial tubes - Scalar lowDimVolume(const BulkElement& element) const - { - auto eIdx = bulkProblem().elementMapper().index(element); - return lowDimVolumeInBulkElement_[eIdx]; - } - - //! The volume fraction the lower dimensional domain occupies in the bulk domain element - // For one-dimensional low dim domain we assume radial tubes - Scalar lowDimVolumeFraction(const BulkElement& element) const - { - auto totalVolume = element.geometry().volume(); - return asImp_().lowDimVolume(element) / totalVolume; - } - - //! Return a reference to the pointSource data - const PointSourceData& pointSourceData(unsigned int id) const - { - return pointSourceData_[id]; - } - - //! Return a reference to the bulk problem - const BulkProblem& bulkProblem() const - { - return bulkProblem_; - } - - //! Return a reference to the low dimensional problem - const LowDimProblem& lowDimProblem() const - { - return lowDimProblem_; - } - - //! Return a reference to the bulk problem - BulkProblem& bulkProblem() - { - return bulkProblem_; - } - - //! Return a reference to the low dimensional problem - LowDimProblem& lowDimProblem() - { - return lowDimProblem_; - } - - //! Return a reference to the bulk problem - const BulkGridView& bulkGridView() const - { - return bulkProblem().gridView(); - } - - //! Return a reference to the low dimensional problem - const LowDimGridView& lowDimGridView() const - { - return lowDimProblem().gridView(); - } - - //! Return a reference to the point sources - const std::vector<BulkPointSource>& bulkPointSources() const - { - return bulkPointSources_; - } - - //! Return a reference to the low dimensional problem - const std::vector<LowDimPointSource>& lowDimPointSources() const - { - return lowDimPointSources_; - } - - //! Return data for a bulk point source with the identifier id - BulkPrimaryVariables bulkPriVars(unsigned int id) const - { - auto& data = pointSourceData_[id]; - return data.interpolateBulk(bulkProblem().model().curSol()); - } - - //! Return data for a low dim point source with the identifier id - LowDimPrimaryVariables lowDimPriVars(unsigned int id) const - { - auto& data = pointSourceData_[id]; - return data.interpolateLowDim(lowDimProblem().model().curSol()); - } - - //! Compute bulk volume variables for the identifier id - BulkVolumeVariables bulkVolVars(unsigned int id) const - { - // use circle interpolated data and construct volVar object for the interpolated privars - auto& data = pointSourceData_[id]; - auto bulkPriVars = data.interpolateBulk(bulkProblem().model().curSol()); - - const auto element = bulkProblem().model().fvGridGeometry().element(data.bulkElementIdx()); - auto fvGeometry = localView(bulkProblem().model().fvGridGeometry()); - fvGeometry.bindElement(element); - - BulkVolumeVariables volVars; - volVars.update(BulkElementSolutionVector(bulkPriVars), - bulkProblem(), - element, - fvGeometry.scv(data.bulkElementIdx())); - - return volVars; - } - - //! Compute lowDim volume variables for the identifier id - LowDimVolumeVariables lowDimVolVars(unsigned int id) const - { - const auto& data = pointSourceData_[id]; - const auto element = lowDimProblem().model().fvGridGeometry().element(data.lowDimElementIdx()); - auto fvGeometry = localView(lowDimProblem().model().fvGridGeometry()); - fvGeometry.bindElement(element); - - const auto& curSol = lowDimProblem().model().curSol(); - LowDimVolumeVariables volVars; - volVars.update(lowDimProblem().model().elementSolution(element, curSol), - lowDimProblem(), - element, - fvGeometry.scv(data.lowDimElementIdx())); - - return volVars; - } - // \} - - //! Clear all internal data members - void clear() - { - bulkPointSources_.clear(); - lowDimPointSources_.clear(); - pointSourceData_.clear(); - bulkCouplingStencils_.clear(); - lowDimCouplingStencils_.clear(); - idCounter_ = 0; - } - - const std::vector<unsigned int>& getAdditionalDofDependencies(unsigned int bulkElementIdx) const - { return bulkCircleStencils_.count(bulkElementIdx) ? bulkCircleStencils_.at(bulkElementIdx) : emptyStencil_; } - -protected: - //! Return reference to point source data vector member - std::vector<PointSourceData>& pointSourceData() - { return pointSourceData_; } - - //! Return reference to bulk point sources - std::vector<BulkPointSource>& bulkPointSources() - { return bulkPointSources_; } - - //! Return reference to low dim point sources - std::vector<LowDimPointSource>& lowDimPointSources() - { return lowDimPointSources_; } - - //! Return reference to bulk coupling stencil member - std::unordered_map<unsigned int, std::vector<unsigned int> >& bulkCouplingStencils() - { return bulkCouplingStencils_; } - - //! Return reference to low dim coupling stencil member - std::unordered_map<unsigned int, std::vector<unsigned int> >& lowDimCouplingStencils() - { return lowDimCouplingStencils_; } - - //! Return a reference to an empty stencil - std::vector<unsigned int>& emptyStencil() - { return emptyStencil_; } - -private: - //! Returns the implementation of the problem (i.e. static polymorphism) - Implementation &asImp_() - { return *static_cast<Implementation *>(this); } - - //! Returns the implementation of the problem (i.e. static polymorphism) - const Implementation &asImp_() const - { return *static_cast<const Implementation *>(this); } - - std::vector<GlobalPosition> getCirclePoints_(const GlobalPosition& center, - const GlobalPosition& normal, - const Scalar radius, - const unsigned int numIp = 20) - { - const Scalar eps = 1.5e-7; - static_assert(dimWorld == 3, "Only implemented for world dimension 3"); - - std::vector<GlobalPosition> points(numIp); - - // make sure n is a unit vector - auto n = normal; - n /= n.two_norm(); - - // caculate a vector u perpendicular to n - GlobalPosition u; - if (std::abs(n[0]) < eps && std::abs(n[1]) < eps) - if (std::abs(n[2]) < eps) - DUNE_THROW(Dune::MathError, "The normal vector has to be non-zero!"); - else - u = {0, 1, 0}; - else - u = {-n[1], n[0], 0}; - - u *= radius/u.two_norm(); - - // the circle parameterization is p(t) = r*cos(t)*u + r*sin(t)*(n x u) + c - auto tangent = crossProduct(u, n); - tangent *= radius/tangent.two_norm(); - - // the parameter with an offset - Scalar t = 0 + 0.1; - // insert the vertices - for (unsigned int i = 0; i < numIp; ++i) - { - points[i] = GlobalPosition({u[0]*std::cos(t) + tangent[0]*std::sin(t) + center[0], - u[1]*std::cos(t) + tangent[1]*std::sin(t) + center[1], - u[2]*std::cos(t) + tangent[2]*std::sin(t) + center[2]}); - - t += 2*M_PI/numIp; - - // periodic t - if(t > 2*M_PI) - t -= 2*M_PI; - } - - return points; - } - - BulkProblem& bulkProblem_; - LowDimProblem& lowDimProblem_; - - std::vector<BulkPointSource> bulkPointSources_; - std::vector<LowDimPointSource> lowDimPointSources_; - - mutable std::vector<PointSourceData> pointSourceData_; - - std::unordered_map<unsigned int, std::vector<unsigned int> > bulkCouplingStencils_; - std::unordered_map<unsigned int, std::vector<unsigned int> > lowDimCouplingStencils_; - std::vector<unsigned int> emptyStencil_; - - // circle stencils - std::unordered_map<unsigned int, std::vector<unsigned int> > bulkCircleStencils_; - std::unordered_map<unsigned int, std::vector<unsigned int> > lowDimCircleStencils_; - - //! vector for the volume fraction of the lowdim domain in the bulk domain cells - std::vector<Scalar> lowDimVolumeInBulkElement_; - - //! id generator for point sources - unsigned int idCounter_; - - //! The glue object - std::shared_ptr<CCMultiDimensionGlue<TypeTag>> glue_; -}; - -} // end namespace Dumux - -#endif diff --git a/dumux/mixeddimension/embedded/cellcentered/bboxtreecouplingmanagersimple.hh b/dumux/mixeddimension/embedded/cellcentered/bboxtreecouplingmanagersimple.hh deleted file mode 100644 index 4e30e1cd745d06791c4bda54290bbbadd0da4e8b..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/embedded/cellcentered/bboxtreecouplingmanagersimple.hh +++ /dev/null @@ -1,527 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup EmbeddedCoupling - * \ingroup CCModel - * \brief Coupling manager for low-dimensional domains embedded in the bulk - * domain. Point sources on each integration point are computed by an AABB tree. - * Both domain are assumed to be discretized using a cc finite volume scheme. - */ - -#ifndef DUMUX_CC_BBOXTREE_EMBEDDEDCOUPLINGMANAGER_SIMPLE_HH -#define DUMUX_CC_BBOXTREE_EMBEDDEDCOUPLINGMANAGER_SIMPLE_HH - -#include <iostream> -#include <fstream> -#include <string> -#include <utility> - -#include <dune/common/timer.hh> -#include <dune/geometry/quadraturerules.hh> -#include <dune/geometry/referenceelements.hh> - -#include <dumux/mixeddimension/glue/glue.hh> -#include <dumux/mixeddimension/embedded/cellcentered/pointsourcedata.hh> - -namespace Dumux -{ - -namespace Properties -{ -// Property forward declarations -NEW_PROP_TAG(BulkProblemTypeTag); -NEW_PROP_TAG(LowDimProblemTypeTag); -NEW_PROP_TAG(GridView); -} // namespace Properties - -/*! - * \ingroup EmbeddedCoupling - * \ingroup CCModel - * \brief Manages the coupling between bulk elements and lower dimensional elements - * Point sources on each integration point are computed by an AABB tree. - * Both domain are assumed to be discretized using a cc finite volume scheme. - */ -template<class TypeTag> -class CCBBoxTreeEmbeddedCouplingManagerSimple -{ - using Implementation = typename GET_PROP_TYPE(TypeTag, CouplingManager); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using PointSourceData = Dumux::PointSourceData<TypeTag>; - - // obtain the type tags of the sub problems - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); - using BulkProblem = typename GET_PROP_TYPE(BulkProblemTypeTag, Problem); - using BulkPointSource = typename GET_PROP_TYPE(BulkProblemTypeTag, PointSource); - using BulkPrimaryVariables = typename GET_PROP_TYPE(BulkProblemTypeTag, PrimaryVariables); - using BulkElementSolutionVector = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementSolutionVector); - using BulkVolumeVariables = typename GET_PROP_TYPE(BulkProblemTypeTag, VolumeVariables); - using BulkElementVolumeVariables = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementVolumeVariables); - using BulkFVElementGeometry = typename GET_PROP_TYPE(BulkProblemTypeTag, FVElementGeometry); - using BulkElementBoundaryTypes = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementBoundaryTypes); - using BulkElementFluxVariablesCache = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementFluxVariablesCache); - using BulkElement = typename BulkGridView::template Codim<0>::Entity; - - using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); - using LowDimProblem = typename GET_PROP_TYPE(LowDimProblemTypeTag, Problem); - using LowDimPointSource = typename GET_PROP_TYPE(LowDimProblemTypeTag, PointSource); - using LowDimPrimaryVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, PrimaryVariables); - using LowDimElementSolutionVector = typename GET_PROP_TYPE(LowDimProblemTypeTag, ElementSolutionVector); - using LowDimVolumeVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, VolumeVariables); - using LowDimElementVolumeVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, ElementVolumeVariables); - using LowDimFVElementGeometry = typename GET_PROP_TYPE(LowDimProblemTypeTag, FVElementGeometry); - using LowDimElementBoundaryTypes = typename GET_PROP_TYPE(LowDimProblemTypeTag, ElementBoundaryTypes); - using LowDimElementFluxVariablesCache = typename GET_PROP_TYPE(LowDimProblemTypeTag, ElementFluxVariablesCache); - using LowDimElement = typename LowDimGridView::template Codim<0>::Entity; - - enum { - bulkDim = BulkGridView::dimension, - lowDimDim = LowDimGridView::dimension, - dimWorld = BulkGridView::dimensionworld - }; - -public: - - /*! - * \brief Constructor - */ - CCBBoxTreeEmbeddedCouplingManagerSimple(BulkProblem& bulkProblem, LowDimProblem& lowDimProblem) - : bulkProblem_(bulkProblem), lowDimProblem_(lowDimProblem) - { - // Check if we are using the cellcentered method in both domains - static_assert(lowDimDim == 1, "The bounding box coupling manager only works with one-dimensional low-dim grids"); - } - - /*! - * \brief Methods to be accessed by the coupled problem - */ - // \{ - - /*! - * \brief Called by the coupled problem before - * initializing the subproblems / models - */ - void preInit() - { - glue_ = std::make_shared<CCMultiDimensionGlue<TypeTag>>(bulkProblem(), lowDimProblem()); - asImp_().computePointSourceData(); - } - - /*! - * \brief Called by the coupled problem after - * initializing the subproblems / models - */ - void postInit() - { - asImp_().computeLowDimVolumeFractions(); - } - - /*! - * \brief Update after the grid has changed - */ - void update() - { - asImp_().computePointSourceData(); - asImp_().computeLowDimVolumeFractions(); - } - - /*! - * \brief The bulk coupling stencil, i.e. which low-dimensional dofs - * the given bulk element dof depends on. - */ - const std::vector<unsigned int>& couplingStencil(const BulkElement& element) const - { - const unsigned int eIdx = bulkProblem().elementMapper().index(element); - if (bulkCouplingStencils_.count(eIdx)) - return bulkCouplingStencils_.at(eIdx); - else - return emptyStencil_; - } - - /*! - * \brief The low dim coupling stencil, i.e. which bulk dofs - * the given low dimensional element dof depends on. - */ - const std::vector<unsigned int>& couplingStencil(const LowDimElement& element) const - { - const unsigned int eIdx = lowDimProblem().elementMapper().index(element); - if (lowDimCouplingStencils_.count(eIdx)) - return lowDimCouplingStencils_.at(eIdx); - else - return emptyStencil_; - } - - //! evaluate coupling residual for the derivative bulk DOF with respect to low dim DOF - //! we only need to evaluate the part of the residual that will be influence by the low dim DOF - BulkPrimaryVariables evalCouplingResidual(const BulkElement& element, - const BulkFVElementGeometry& fvGeometry, - const BulkElementVolumeVariables& curElemVolVars, - const BulkElementBoundaryTypes& elemBcTypes, - const BulkElementFluxVariablesCache& elemFluxVarsCache, - const LowDimElement& lowDimElement) - { - const auto bulkElementIdx = bulkProblem().elementMapper().index(element); - auto&& scv = fvGeometry.scv(bulkElementIdx); - auto couplingSource = bulkProblem().scvPointSources(element, fvGeometry, curElemVolVars, scv); - couplingSource *= -scv.volume()*curElemVolVars[scv].extrusionFactor(); - return couplingSource; - } - - //! evaluate coupling residual for the derivative low dim DOF with respect to bulk DOF - //! we only need to evaluate the part of the residual that will be influence by the bulk DOF - LowDimPrimaryVariables evalCouplingResidual(const LowDimElement& element, - const LowDimFVElementGeometry& fvGeometry, - const LowDimElementVolumeVariables& curElemVolVars, - const LowDimElementBoundaryTypes& elemBcTypes, - const LowDimElementFluxVariablesCache& elemFluxVarsCache, - const BulkElement& bulkElement) - { - const auto lowDimElementIdx = lowDimProblem().elementMapper().index(element); - auto&& scv = fvGeometry.scv(lowDimElementIdx); - auto couplingSource = lowDimProblem().scvPointSources(element, fvGeometry, curElemVolVars, scv); - couplingSource *= -scv.volume()*curElemVolVars[scv].extrusionFactor(); - return couplingSource; - } - - // \} - - /* \brief Compute integration point point sources and associated data - * - * This method uses grid glue to intersect the given grids. Over each intersection - * we later need to integrate a source term. This method places point sources - * at each quadrature point and provides the point source with the necessary - * information to compute integrals (quadrature weight and integration element) - * \param order The order of the quadrature rule for integration of sources over an intersection - * \param verbose If the point source computation is verbose - */ - void computePointSourceData(unsigned int order = 1, bool verbose = false) - { - // initilize the maps - // do some logging and profiling - Dune::Timer watch; - std::cout << "Initializing the point sources..." << std::endl; - - // clear all internal members like pointsource vectors and stencils - // initializes the point source id counter - clear(); - - // intersect the bounding box trees - glue_->build(); - - for (const auto& is : intersections(*glue_)) - { - // all inside elements are identical... - const auto& inside = is.inside(0); - // get the intersection geometry for integrating over it - const auto intersectionGeometry = is.geometry(); - - // get the Gaussian quadrature rule for the local intersection - const auto& quad = Dune::QuadratureRules<Scalar, lowDimDim>::rule(intersectionGeometry.type(), order); - const unsigned int lowDimElementIdx = lowDimProblem().elementMapper().index(inside); - - // iterate over all quadrature points - for (auto&& qp : quad) - { - // compute the coupling stencils - for (unsigned int outsideIdx = 0; outsideIdx < is.neighbor(0); ++outsideIdx) - { - const auto& outside = is.outside(outsideIdx); - const unsigned int bulkElementIdx = bulkProblem().elementMapper().index(outside); - - // each quadrature point will be a point source for the sub problem - const auto globalPos = intersectionGeometry.global(qp.position()); - const auto id = idCounter_++; - const auto qpweight = qp.weight(); - const auto ie = intersectionGeometry.integrationElement(qp.position()); - bulkPointSources_.emplace_back(globalPos, id, qpweight, ie, std::vector<unsigned int>({bulkElementIdx})); - bulkPointSources_.back().setEmbeddings(is.neighbor(0)); - lowDimPointSources_.emplace_back(globalPos, id, qpweight, ie, std::vector<unsigned int>({lowDimElementIdx})); - lowDimPointSources_.back().setEmbeddings(is.neighbor(0)); - - // pre compute additional data used for the evaluation of - // the actual solution dependent source term - PointSourceData psData; - psData.addLowDimInterpolation(lowDimElementIdx); - psData.addBulkInterpolation(bulkElementIdx); - - // publish point source data in the global vector - pointSourceData_.push_back(psData); - - // compute the coupling stencils - bulkCouplingStencils_[bulkElementIdx].push_back(lowDimElementIdx); - // add this bulk element to the low dim coupling stencil - lowDimCouplingStencils_[lowDimElementIdx].push_back(bulkElementIdx); - } - } - } - - // coupling stencils - for (auto&& stencil : bulkCouplingStencils_) - { - std::sort(stencil.second.begin(), stencil.second.end()); - stencil.second.erase(std::unique(stencil.second.begin(), stencil.second.end()), stencil.second.end()); - } - // the low dim coupling stencil - for (auto&& stencil : lowDimCouplingStencils_) - { - std::sort(stencil.second.begin(), stencil.second.end()); - stencil.second.erase(std::unique(stencil.second.begin(), stencil.second.end()), stencil.second.end()); - } - - std::cout << "took " << watch.elapsed() << " seconds." << std::endl; - } - - //! Compute the low dim volume fraction in the bulk domain cells - void computeLowDimVolumeFractions() - { - // resize the storage vector - lowDimVolumeInBulkElement_.resize(this->bulkGridView().size(0)); - - // compute the low dim volume fractions - for (const auto& is : intersections(*glue_)) - { - // all inside elements are identical... - const auto& inside = is.inside(0); - const auto intersectionGeometry = is.geometry(); - const unsigned int lowDimElementIdx = lowDimProblem().elementMapper().index(inside); - - // compute the volume the low-dim domain occupies in the bulk domain if it were full-dimensional - const auto radius = lowDimProblem().spatialParams().radius(lowDimElementIdx); - for (unsigned int outsideIdx = 0; outsideIdx < is.neighbor(0); ++outsideIdx) - { - const auto& outside = is.outside(outsideIdx); - const unsigned int bulkElementIdx = bulkProblem().elementMapper().index(outside); - lowDimVolumeInBulkElement_[bulkElementIdx] += intersectionGeometry.volume()*M_PI*radius*radius; - } - } - } - - /*! - * \brief Methods to be accessed by the subproblems - */ - // \{ - - //! Return a reference to the bulk problem - Scalar radius(unsigned int id) const - { - const auto& data = pointSourceData_[id]; - return lowDimProblem().spatialParams().radius(data.lowDimElementIdx()); - } - - //! The volume the lower dimensional domain occupies in the bulk domain element - // For one-dimensional low dim domain we assume radial tubes - Scalar lowDimVolume(const BulkElement& element) const - { - auto eIdx = bulkProblem().elementMapper().index(element); - return lowDimVolumeInBulkElement_[eIdx]; - } - - //! The volume fraction the lower dimensional domain occupies in the bulk domain element - // For one-dimensional low dim domain we assume radial tubes - Scalar lowDimVolumeFraction(const BulkElement& element) const - { - auto totalVolume = element.geometry().volume(); - return asImp_().lowDimVolume(element) / totalVolume; - } - - //! Return a reference to the pointSource data - const PointSourceData& pointSourceData(unsigned int id) const - { - return pointSourceData_[id]; - } - - //! Return a reference to the bulk problem - const BulkProblem& bulkProblem() const - { - return bulkProblem_; - } - - //! Return a reference to the low dimensional problem - const LowDimProblem& lowDimProblem() const - { - return lowDimProblem_; - } - - //! Return a reference to the bulk problem - BulkProblem& bulkProblem() - { - return bulkProblem_; - } - - //! Return a reference to the low dimensional problem - LowDimProblem& lowDimProblem() - { - return lowDimProblem_; - } - - //! Return a reference to the bulk problem - const BulkGridView& bulkGridView() const - { - return bulkProblem().gridView(); - } - - //! Return a reference to the low dimensional problem - const LowDimGridView& lowDimGridView() const - { - return lowDimProblem().gridView(); - } - - //! Return a reference to the point sources - const std::vector<BulkPointSource>& bulkPointSources() const - { - return bulkPointSources_; - } - - //! Return a reference to the low dimensional problem - const std::vector<LowDimPointSource>& lowDimPointSources() const - { - return lowDimPointSources_; - } - - //! Return data for a bulk point source with the identifier id - BulkPrimaryVariables bulkPriVars(unsigned int id) const - { - auto& data = pointSourceData_[id]; - return data.interpolateBulk(bulkProblem().model().curSol()); - } - - //! Return data for a low dim point source with the identifier id - LowDimPrimaryVariables lowDimPriVars(unsigned int id) const - { - auto& data = pointSourceData_[id]; - return data.interpolateLowDim(lowDimProblem().model().curSol()); - } - - //! Compute bulk volume variables for the identifier id - BulkVolumeVariables bulkVolVars(unsigned int id) const - { - // use circle interpolated data and construct volVar object for the interpolated privars - auto& data = pointSourceData_[id]; - auto bulkPriVars = data.interpolateBulk(bulkProblem().model().curSol()); - - const auto element = bulkProblem().model().fvGridGeometry().element(data.bulkElementIdx()); - auto fvGeometry = localView(bulkProblem().model().fvGridGeometry()); - fvGeometry.bindElement(element); - - BulkVolumeVariables volVars; - volVars.update(BulkElementSolutionVector(bulkPriVars), - bulkProblem(), - element, - fvGeometry.scv(data.bulkElementIdx())); - - return volVars; - } - - //! Compute lowDim volume variables for the identifier id - LowDimVolumeVariables lowDimVolVars(unsigned int id) const - { - auto& data = pointSourceData_[id]; - auto lowDimPriVars = data.interpolateLowDim(lowDimProblem().model().curSol()); - - const auto element = lowDimProblem().model().fvGridGeometry().element(data.lowDimElementIdx()); - auto fvGeometry = localView(lowDimProblem().model().fvGridGeometry()); - fvGeometry.bindElement(element); - - LowDimVolumeVariables volVars; - volVars.update(LowDimElementSolutionVector(lowDimPriVars), - lowDimProblem(), - element, - fvGeometry.scv(data.lowDimElementIdx())); - - return volVars; - } - // \} - - //! Clear all internal data members - void clear() - { - bulkPointSources_.clear(); - lowDimPointSources_.clear(); - pointSourceData_.clear(); - bulkCouplingStencils_.clear(); - lowDimCouplingStencils_.clear(); - idCounter_ = 0; - } - - const std::vector<unsigned int>& getAdditionalDofDependencies(unsigned int bulkElementIdx) const - { return emptyStencil_; } - -protected: - //! Return reference to point source data vector member - std::vector<PointSourceData>& pointSourceData() - { return pointSourceData_; } - - //! Return reference to bulk point sources - std::vector<BulkPointSource>& bulkPointSources() - { return bulkPointSources_; } - - //! Return reference to low dim point sources - std::vector<LowDimPointSource>& lowDimPointSources() - { return lowDimPointSources_; } - - //! Return reference to bulk coupling stencil member - std::unordered_map<unsigned int, std::vector<unsigned int> >& bulkCouplingStencils() - { return bulkCouplingStencils_; } - - //! Return reference to low dim coupling stencil member - std::unordered_map<unsigned int, std::vector<unsigned int> >& lowDimCouplingStencils() - { return lowDimCouplingStencils_; } - - //! Return a reference to an empty stencil - std::vector<unsigned int>& emptyStencil() - { return emptyStencil_; } - -private: - //! Returns the implementation of the problem (i.e. static polymorphism) - Implementation &asImp_() - { return *static_cast<Implementation *>(this); } - - //! Returns the implementation of the problem (i.e. static polymorphism) - const Implementation &asImp_() const - { return *static_cast<const Implementation *>(this); } - - BulkProblem& bulkProblem_; - LowDimProblem& lowDimProblem_; - - std::vector<BulkPointSource> bulkPointSources_; - std::vector<LowDimPointSource> lowDimPointSources_; - - mutable std::vector<PointSourceData> pointSourceData_; - - std::unordered_map<unsigned int, std::vector<unsigned int> > bulkCouplingStencils_; - std::unordered_map<unsigned int, std::vector<unsigned int> > lowDimCouplingStencils_; - std::vector<unsigned int> emptyStencil_; - - //! vector for the volume fraction of the lowdim domain in the bulk domain cells - std::vector<Scalar> lowDimVolumeInBulkElement_; - - //! id generator for point sources - unsigned int idCounter_; - - //! The glue object - std::shared_ptr<CCMultiDimensionGlue<TypeTag>> glue_; -}; - -} // end namespace Dumux - -#endif diff --git a/dumux/mixeddimension/embedded/cellcentered/pointsourcedata.hh b/dumux/mixeddimension/embedded/cellcentered/pointsourcedata.hh deleted file mode 100644 index f0dd5ad8d1efc163a6fd947accb80ca9883d57cb..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/embedded/cellcentered/pointsourcedata.hh +++ /dev/null @@ -1,262 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup EmbeddedCoupling - * \brief Data associated with a point source - */ - -#ifndef DUMUX_POINTSOURCEDATA_HH -#define DUMUX_POINTSOURCEDATA_HH - -namespace Dumux -{ - -namespace Properties -{ -// Property forward declarations -NEW_PROP_TAG(BulkProblemTypeTag); -NEW_PROP_TAG(LowDimProblemTypeTag); -NEW_PROP_TAG(Scalar); -NEW_PROP_TAG(PrimaryVariables); -} // namespace Properties - - -/*! - * \ingroup EmbeddedCoupling - * \brief A point source data class used for integration in multidimension models - * \note The point source and related data are connected via an identifier (id) - */ -template<class TypeTag> -class PointSourceData -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using ShapeValues = typename std::vector<Dune::FieldVector<Scalar, 1> >; - - // obtain the type tags of the sub problems - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - using BulkPrimaryVariables = typename GET_PROP_TYPE(BulkProblemTypeTag, PrimaryVariables); - using LowDimPrimaryVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, PrimaryVariables); - - using BulkSolutionVector = typename GET_PROP_TYPE(BulkProblemTypeTag, SolutionVector); - using LowDimSolutionVector = typename GET_PROP_TYPE(LowDimProblemTypeTag, SolutionVector); - - enum { - bulkIsBox = GET_PROP_VALUE(BulkProblemTypeTag, ImplicitIsBox), - lowDimIsBox = GET_PROP_VALUE(LowDimProblemTypeTag, ImplicitIsBox) - }; - -public: - void addBulkInterpolation(const ShapeValues& shapeValues, - const std::vector<unsigned int>& cornerIndices, - unsigned int eIdx) - { - bulkElementIdx_ = eIdx; - bulkCornerIndices_ = cornerIndices; - bulkShapeValues_ = shapeValues; - } - - void addLowDimInterpolation(const ShapeValues& shapeValues, - const std::vector<unsigned int>& cornerIndices, - unsigned int eIdx) - { - lowDimElementIdx_ = eIdx; - lowDimCornerIndices_ = cornerIndices; - lowDimShapeValues_ = shapeValues; - } - - void addBulkInterpolation(unsigned int eIdx) - { - bulkElementIdx_ = eIdx; - } - - void addLowDimInterpolation(unsigned int eIdx) - { - lowDimElementIdx_ = eIdx; - } - - BulkPrimaryVariables interpolateBulk(const BulkSolutionVector& sol) - { - BulkPrimaryVariables bulkPriVars(0.0); - if (bulkIsBox) - { - for (unsigned int i = 0; i < bulkCornerIndices_.size(); ++i) - for (unsigned int priVarIdx = 0; priVarIdx < bulkPriVars_.size(); ++priVarIdx) - bulkPriVars_[priVarIdx] += sol[bulkCornerIndices_[i]][priVarIdx]*bulkShapeValues_[i]; - } - else - { - bulkPriVars = sol[bulkElementIdx()]; - } - return bulkPriVars; - } - - LowDimPrimaryVariables interpolateLowDim(const LowDimSolutionVector& sol) - { - LowDimPrimaryVariables lowDimPriVars(0.0); - if (lowDimIsBox) - { - for (unsigned int i = 0; i < lowDimCornerIndices_.size(); ++i) - for (unsigned int priVarIdx = 0; priVarIdx < lowDimPriVars_.size(); ++priVarIdx) - lowDimPriVars_[priVarIdx] += sol[lowDimCornerIndices_[i]][priVarIdx]*lowDimShapeValues_[i]; - } - else - { - lowDimPriVars = sol[lowDimElementIdx()]; - } - return lowDimPriVars; - } - - unsigned int lowDimElementIdx() const - { return lowDimElementIdx_; } - - unsigned int bulkElementIdx() const - { return bulkElementIdx_; } - -private: - ShapeValues bulkShapeValues_, lowDimShapeValues_; - std::vector<unsigned int> bulkCornerIndices_, lowDimCornerIndices_; - BulkPrimaryVariables bulkPriVars_; - LowDimPrimaryVariables lowDimPriVars_; - unsigned int lowDimElementIdx_; - unsigned int bulkElementIdx_; -}; - -/*! - * \ingroup EmbeddedCoupling - * \brief A point source data class used for integration in multidimension models - * \note The point source and related data are connected via an identifier (id) - * When explicitly computing the circle average, i.e. the pressure for - * the source term is computed as an integral over the circle describing - * the surface of the one-dimensional tube. This exact determination of the bulk pressure - * is necessary for convergence studies. - */ -template<class TypeTag> -class PointSourceDataCircleAverage : public PointSourceData<TypeTag> -{ - using ParentType = PointSourceData<TypeTag>; - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using ShapeValues = typename std::vector<Dune::FieldVector<Scalar, 1> >; - - // obtain the type tags of the sub problems - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - using BulkPrimaryVariables = typename GET_PROP_TYPE(BulkProblemTypeTag, PrimaryVariables); - using LowDimPrimaryVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, PrimaryVariables); - - using BulkSolutionVector = typename GET_PROP_TYPE(BulkProblemTypeTag, SolutionVector); - using LowDimSolutionVector = typename GET_PROP_TYPE(LowDimProblemTypeTag, SolutionVector); - - enum { - bulkIsBox = GET_PROP_VALUE(BulkProblemTypeTag, ImplicitIsBox), - lowDimIsBox = GET_PROP_VALUE(LowDimProblemTypeTag, ImplicitIsBox) - }; - -public: - PointSourceDataCircleAverage() : enableBulkCircleInterpolation_(false) {} - - BulkPrimaryVariables interpolateBulk(const BulkSolutionVector& sol) - { - // bulk interpolation on the circle is only enabled for source in the - // lower dimensional domain if we use a circle distributed bulk sources - // (see coupling manager circle sources) - BulkPrimaryVariables bulkPriVars(sol[0]); - bulkPriVars = 0.0; - if (enableBulkCircleInterpolation_) - { - // compute the average of the bulk privars over the circle around the integration point - // this computes $\bar{p} = \frac{1}{2\pi R} int_0^2*\pi p R \text{d}\theta. - if (bulkIsBox) - { - assert(circleCornerIndices_.size() == circleShapeValues_.size()); - - Scalar weightSum = 0.0; - for (unsigned int j = 0; j < circleStencil_.size(); ++j) - { - BulkPrimaryVariables priVars(0.0); - for (unsigned int i = 0; i < circleCornerIndices_[j].size(); ++i) - for (unsigned int priVarIdx = 0; priVarIdx < priVars.size(); ++priVarIdx) - priVars[priVarIdx] += sol[circleCornerIndices_[j][i]][priVarIdx]*circleShapeValues_[j][i]; - // multiply with weight and add - priVars *= circleIpWeight_[j]; - weightSum += circleIpWeight_[j]; - bulkPriVars += priVars; - } - bulkPriVars /= weightSum; - } - else - { - Scalar weightSum = 0.0; - for (unsigned int j = 0; j < circleStencil_.size(); ++j) - { - for (unsigned int priVarIdx = 0; priVarIdx < bulkPriVars.size(); ++priVarIdx) - bulkPriVars[priVarIdx] += sol[circleStencil_[j]][priVarIdx]*circleIpWeight_[j]; - - weightSum += circleIpWeight_[j]; - } - bulkPriVars /= weightSum; - } - return bulkPriVars; - } - else - { - return ParentType::interpolateBulk(sol); - } - } - - void addCircleInterpolation(const std::vector<std::vector<unsigned int> >& circleCornerIndices, - const std::vector<ShapeValues>& circleShapeValues, - const std::vector<Scalar>& circleIpWeight, - const std::vector<unsigned int>& circleStencil) - { - circleCornerIndices_ = circleCornerIndices; - circleShapeValues_ = circleShapeValues; - circleIpWeight_ = circleIpWeight; - circleStencil_ = circleStencil; - enableBulkCircleInterpolation_ = true; - - } - - void addCircleInterpolation(const std::vector<Scalar>& circleIpWeight, - const std::vector<unsigned int>& circleStencil) - { - circleIpWeight_ = circleIpWeight; - circleStencil_ = circleStencil; - enableBulkCircleInterpolation_ = true; - } - - const std::vector<unsigned int>& circleStencil() - { - return circleStencil_; - } - -private: - std::vector<std::vector<unsigned int> > circleCornerIndices_; - std::vector<ShapeValues> circleShapeValues_; - std::vector<Scalar> circleIpWeight_; - std::vector<unsigned int> circleStencil_; - bool enableBulkCircleInterpolation_; -}; - -} // end namespace Dumux - -#endif diff --git a/dumux/mixeddimension/embedded/start.hh b/dumux/mixeddimension/embedded/start.hh deleted file mode 100644 index 10042a416848afccaf6c15eb5226d99f627152d5..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/embedded/start.hh +++ /dev/null @@ -1,197 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup EmbeddedCoupling - * \brief Provides a starting algorithm (a default main function) for multidimension problems - */ -#ifndef DUMUX_START_EMBEDDED_MIXEDDIMENSION_HH -#define DUMUX_START_EMBEDDED_MIXEDDIMENSION_HH - -#include <ctime> -#include <iostream> - -#include <dune/common/parallel/mpihelper.hh> -#include <dune/grid/io/file/dgfparser/dgfexception.hh> - -#include <dumux/common/propertysystem.hh> -#include <dumux/common/parameters.hh> -#include <dumux/common/dumuxmessage.hh> -#include <dumux/common/defaultusagemessage.hh> - -namespace Dumux -{ -// forward declaration of property tags -namespace Properties -{ -NEW_PROP_TAG(LowDimProblemTypeTag); -NEW_PROP_TAG(BulkProblemTypeTag); -} - -template <class TypeTag> -int start_(int argc, - char **argv, - void (*usage)(const char *, const std::string &)) -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using ParameterTree = typename GET_PROP(TypeTag, ParameterTree); - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - using BulkGridCreator = typename GET_PROP_TYPE(BulkProblemTypeTag, GridCreator); - using LowDimGridCreator = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridCreator); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - - // initialize MPI, finalize is done automatically on exit - const auto& mpiHelper = Dune::MPIHelper::instance(argc, argv); - - // print dumux start message - if (mpiHelper.rank() == 0) - DumuxMessage::print(/*firstCall=*/true); - - //////////////////////////////////////////////////////////// - // parse the command line arguments and input file - //////////////////////////////////////////////////////////// - - // if the user just wanted to see the help / usage message show usage and stop program - if(!ParameterParser::parseCommandLineArguments(argc, argv, ParameterTree::tree(), usage)) - { - usage(argv[0], defaultUsageMessage(argv[0])); - return 0; - } - - // parse the input file into the parameter tree - // check first if the user provided an input file through the command line, if not use the default - const auto parameterFileName = ParameterTree::tree().hasKey("ParameterFile") ? GET_RUNTIME_PARAM(TypeTag, std::string, ParameterFile) : ""; - ParameterParser::parseInputFile(argc, argv, ParameterTree::tree(), parameterFileName, usage); - - //////////////////////////////////////////////////////////// - // check for some user debugging parameters - //////////////////////////////////////////////////////////// - - bool printProps = false; // per default don't print all properties - if (ParameterTree::tree().hasKey("PrintProperties") || ParameterTree::tree().hasKey("TimeManager.PrintProperties")) - printProps = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, bool, TimeManager, PrintProperties); - - if (printProps && mpiHelper.rank() == 0) - Properties::print<TypeTag>(); - - bool printParams = true; // per default print all properties - if (ParameterTree::tree().hasKey("PrintParameters") || ParameterTree::tree().hasKey("TimeManager.PrintParameters")) - printParams = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, bool, TimeManager, PrintParameters); - - ////////////////////////////////////////////////////////////////////// - // try to create a grid (from the given grid file or the input file) - ///////////////////////////////////////////////////////////////////// - - try { BulkGridCreator::makeGrid(); } - catch (...) { - std::string usageMessage = "\n\t -> Creation of the bulk grid failed! <- \n\n"; - usageMessage += defaultUsageMessage(argv[0]); - usage(argv[0], usageMessage); - throw; - } - BulkGridCreator::loadBalance(); - - try { LowDimGridCreator::makeGrid(); } - catch (...) { - std::string usageMessage = "\n\t -> Creation of the low dim grid failed! <- \n\n"; - usageMessage += defaultUsageMessage(argv[0]); - usage(argv[0], usageMessage); - throw; - } - LowDimGridCreator::loadBalance(); - - - ////////////////////////////////////////////////////////////////////// - // run the simulation - ///////////////////////////////////////////////////////////////////// - - // read the initial time step and the end time (mandatory parameters) - auto tEnd = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, TEnd); - auto dt = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, DtInitial); - - // check if we are about to restart a previously interrupted simulation - bool restart = false; - Scalar restartTime = 0; - if (ParameterTree::tree().hasKey("Restart") || ParameterTree::tree().hasKey("TimeManager.Restart")) - { - restart = true; - restartTime = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, Restart); - } - - // instantiate and run the concrete problem - TimeManager timeManager; - Problem problem(timeManager, BulkGridCreator::grid().leafGridView(), LowDimGridCreator::grid().leafGridView()); - timeManager.init(problem, restartTime, dt, tEnd, restart); - timeManager.run(); - - // print dumux end message and maybe the parameters for debugging - if (mpiHelper.rank() == 0) - { - DumuxMessage::print(/*firstCall=*/false); - - if (printParams) - Parameters::print<TypeTag>(); - } - - return 0; -} - -/*! - * \ingroup Start - * - * \brief Provides a main function with error handling - * - * \tparam TypeTag The type tag of the problem which needs to be solved - * - * \param argc The number of command line arguments of the program - * \param argv The contents of the command line arguments of the program - * \param usage Callback function for printing the usage message - */ -template <class TypeTag> -int start(int argc, - char **argv, - void (*usage)(const char *, const std::string &)) -{ - try { - return start_<TypeTag>(argc, argv, usage); - } - catch (ParameterException &e) { - Parameters::print<TypeTag>(); - std::cerr << std::endl << e << ". Abort!" << std::endl; - return 1; - } - catch (Dune::DGFException & e) { - std::cerr << "DGF exception thrown (" << e << - "). Most likely, the DGF file name is wrong " - "or the DGF file is corrupted, " - "e.g. missing hash at end of file or wrong number (dimensions) of entries." - << std::endl; - return 2; - } - catch (Dune::Exception &e) { - std::cerr << "Dune reported error: " << e << std::endl; - return 3; - } -} - -} // end namespace Dumux - -#endif diff --git a/dumux/mixeddimension/facet/CMakeLists.txt b/dumux/mixeddimension/facet/CMakeLists.txt deleted file mode 100644 index a272c20bcc8d839debb534390f2768907e6dffa1..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/facet/CMakeLists.txt +++ /dev/null @@ -1,6 +0,0 @@ -add_subdirectory("mpfa") - -install(FILES -gmshdualfacetgridcreator.hh -start.hh -DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/mixeddimension/facet) \ No newline at end of file diff --git a/dumux/mixeddimension/facet/gmshdualfacetgridcreator.hh b/dumux/mixeddimension/facet/gmshdualfacetgridcreator.hh deleted file mode 100644 index 395081562d13936834e41abadc8a63e83a681cbb..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/facet/gmshdualfacetgridcreator.hh +++ /dev/null @@ -1,463 +0,0 @@ -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief Reads gmsh files where fractures are defined as lines in surfaces - * or surfaces in volumes and constructs a grid for the bulk part and a - * lower-dimensional grid for the lines/surfaces. - */ - -#ifndef DUMUX_GMSHDUALFACETGRIDCREATOR_HH -#define DUMUX_GMSHDUALFACETGRIDCREATOR_HH - -#include <algorithm> -#include <iostream> -#include <fstream> -#include <sstream> -#include <iomanip> - -#include <dune/common/version.hh> -#include <dune/grid/common/mcmgmapper.hh> -#include <dune/grid/common/gridfactory.hh> - -#include <dumux/common/math.hh> -#include <dumux/common/propertysystem.hh> -#include <dumux/common/parameters.hh> -#include <dumux/common/valgrind.hh> - -namespace Dumux -{ - -namespace Properties -{ -NEW_PROP_TAG(Scalar); -} - -/*! - * \brief Reads gmsh files where fractures are defined as lines in surfaces - * or surfaces in volumes and constructs a grid for the bulk part and a - * lower-dimensional grid for the lines/surfaces. - */ -template <class TypeTag> -class GmshDualFacetGridCreator -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - - // obtain the type tags of the sub problems - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - // obtain the grid types of the sub problems - using BulkGrid = typename GET_PROP_TYPE(BulkProblemTypeTag, Grid); - using LowDimGrid = typename GET_PROP_TYPE(LowDimProblemTypeTag, Grid); - using LowDimElement = typename LowDimGrid::template Codim<0>::Entity; - - // The Bulk Element Mapper - using BulkElementMapper = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementMapper); - - static constexpr int bulkDim = BulkGrid::dimension; - static constexpr int lowDimDim = LowDimGrid::dimension; - static constexpr int dimWorld = BulkGrid::dimensionworld; - static constexpr int lowDimDimWorld = LowDimGrid::dimensionworld; - static_assert(dimWorld == lowDimDimWorld, "dimWorld cannot be different for the two sub-domains!"); - - static constexpr int invalidIndex = -5; - - using GlobalPosition = Dune::FieldVector<double, dimWorld>; - using BulkIndexType = typename BulkGrid::LeafGridView::IndexSet::IndexType; - using LowDimIndexType = typename LowDimGrid::LeafGridView::IndexSet::IndexType; - -public: - /*! - * \brief Create the Grid. - * Specialization for bulk dim = 2 and lowDim dim = 1 - */ - template<class T = TypeTag> - static typename std::enable_if<bulkDim == 2 && lowDimDim == 1>::type - makeGrid() - { - const std::string fileName = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Grid, File); - - // set up the grid factories - auto& bulkFactory = bulkFactory_(); - auto& lowDimFactory = lowDimFactory_(); - - // open the mesh file - std::cout << "Opening " << fileName << std::endl; - std::ifstream mshFile(fileName.c_str()); - if (mshFile.fail()) - DUNE_THROW(Dune::InvalidStateException, "Could not open the given .msh file. Make sure it exists"); - if (getFileExtension_(fileName) != "msh") - DUNE_THROW(Dune::InvalidStateException, "Please provide a .msh file for this grid creator"); - - // read file until we get to the list of nodes - std::string line; - std::getline(mshFile, line); - while (line.compare(0, 6, "$Nodes") != 0) - std::getline(mshFile, line); - - // get total number of nodes - std::getline(mshFile, line); - const auto numVertices = stringToNumber_(line); - - // read vertices line by line - std::getline(mshFile, line); - std::vector<GlobalPosition> bulkVertices(numVertices); - unsigned int vertexCounter = 0; - while (line.compare(0, 9, "$EndNodes") != 0) - { - // read the coordinates of the vertex - std::string buf; - std::stringstream stream(line); - - // drop first entry in line - stream >> buf; - std::vector<std::string> coords; - while (stream >> buf) - coords.push_back(buf); - - // "create" a vertex - GlobalPosition v; - for (int i = 0; i < dimWorld; ++i) - v[i] = stringToNumber_(coords[i]); - - // insert vertex into container and the bulk grid factory - bulkVertices[vertexCounter] = v; - bulkFactory.insertVertex(v); - std::getline(mshFile, line); - vertexCounter++; - } - - // we should always find as many vertices as the mesh file states - assert(vertexCounter == numVertices); - - // read file until we get to the list of elements - while(line.compare(0, 9, "$Elements") != 0) - std::getline(mshFile, line); - - // get total number of elements - std::getline(mshFile, line); - const auto numElements = stringToNumber_(line); - - // while inserting the low dim vertices, keep track of indices that have - // been inserted already and element vertex indices in "original" indexing - std::vector<GlobalPosition> lowDimVertices; - std::vector<LowDimIndexType> lowDimVertexIndices; - std::vector<std::vector<BulkIndexType>> lowDimElemVertices; - - lowDimVertices.reserve(numVertices); - lowDimVertexIndices.reserve(numVertices); - lowDimElemVertices.reserve(numElements); - - // the coupling data container lowDim -> bulk - auto& lowDimCouplingMap = lowDimCouplingElements_(); - - // read in the elements line by line - std::getline(mshFile, line); - BulkIndexType bulkElementCounter = 0; - LowDimIndexType lowDimElementCounter = 0; - while (line.compare(0, 12, "$EndElements") != 0) - { - // read the data of this element - std::string buf; - std::stringstream stream(line); - std::vector<unsigned int> elemData; - while (stream >> buf) - elemData.push_back(stringToNumber_(buf)); - - // get number of gmsh tags for this element - const auto noOfTags = elemData[2]; - - // get element type, make container of indexvertices and insert element - const auto elemType = elemData[1]; - - switch (elemType) - { - case 15: // points - { - // do nothing for points - break; - } - - case 1: // 2-node line - { - // get the connected vertex indices - std::vector<LowDimIndexType> elemVertexIndices(2); - - const auto vIdx1 = elemData[3 + noOfTags]; - const auto vIdx2 = elemData[3 + noOfTags + 1]; - - elemVertexIndices[0] = findIndexInVector_(lowDimVertexIndices, vIdx1); - elemVertexIndices[1] = findIndexInVector_(lowDimVertexIndices, vIdx2); - - if (elemVertexIndices[0] == invalidIndex) - { - const auto v1 = bulkVertices[vIdx1-1]; - - lowDimVertices.push_back(v1); - lowDimVertexIndices.push_back(vIdx1); - lowDimFactory.insertVertex(v1); - - elemVertexIndices[0] = lowDimVertices.size()-1; - } - if (elemVertexIndices[1] == invalidIndex) - { - const auto v2 = bulkVertices[vIdx2-1]; - - lowDimVertices.push_back(v2); - lowDimVertexIndices.push_back(vIdx2); - lowDimFactory.insertVertex(v2); - - elemVertexIndices[1] = lowDimVertices.size()-1; - } - - // store the low dim elements' vertices - lowDimElemVertices.push_back(std::vector<BulkIndexType>({vIdx1, vIdx2})); - - // insert element into the factory - lowDimFactory.insertElement(Dune::GeometryTypes::line, elemVertexIndices); - - // increase low dim element counter - lowDimElementCounter++; - break; - } - - case 2: // 3-node triangle - { - // we know that the low dim elements have been read already - if (lowDimCouplingMap.empty()) - lowDimCouplingMap.resize(lowDimElementCounter); - - // get the vertex indices of this bulk element - std::vector<BulkIndexType> elemVertexIndices(3); - elemVertexIndices[0] = elemData[3 + noOfTags]; - elemVertexIndices[1] = elemData[3 + noOfTags + 1]; - elemVertexIndices[2] = elemData[3 + noOfTags + 2]; - - // get the insertion indices of the low dim elements connected to this element - const auto lowDimElemIndices = obtainLowDimConnections_(lowDimElemVertices, elemVertexIndices); - - // if we found some, insert the connections in the map - for (auto lowDimElemIdx : lowDimElemIndices) - lowDimCouplingMap[lowDimElemIdx].push_back(bulkElementCounter); - - // subtract 1 from the element indices (gmsh starts at index 1) - elemVertexIndices[0] -= 1; - elemVertexIndices[1] -= 1; - elemVertexIndices[2] -= 1; - - // insert bulk element into the factory - bulkFactory.insertElement(Dune::GeometryTypes::triangle, elemVertexIndices); - - // increase bulk element counter - bulkElementCounter++; - break; - } - - default: - DUNE_THROW(Dune::NotImplemented, "GmshDualFacetGridCreator for given element type"); - } - - // get next line - std::getline(mshFile, line); - } - - std::cout << bulkElementCounter << " bulk elements and " - << lowDimElementCounter << " low dim elements have been created." << std::endl; - - - bulkGridPtr_() = std::shared_ptr<BulkGrid>(bulkFactory.createGrid()); - lowDimGridPtr_() = std::shared_ptr<LowDimGrid>(lowDimFactory.createGrid()); - - // set up the map from insertion to actual global indices for bulk elements - BulkElementMapper elementMapper(bulkGrid().leafGridView(), Dune::mcmgElementLayout()); - auto& map = bulkInsertionToGlobalIdxMap_(); - map.resize(bulkElementCounter); - for (const auto& element : elements(bulkGrid().leafGridView())) - map[bulkFactory.insertionIndex(element)] = elementMapper.index(element); - } - - /*! - * \brief Returns a reference to the bulk grid. - */ - static BulkGrid& bulkGrid() - { return *bulkGridPtr_(); } - - /*! - * \brief Returns a reference to the lower dimensional facet grid. - */ - static LowDimGrid& lowDimGrid() - { return *lowDimGridPtr_(); } - - /*! - * \brief Distributes the grid on all processes of a parallel - * computation. - */ - static void loadBalance() - { - bulkGrid().loadBalance(); - lowDimGrid().loadBalance(); - } - - static std::vector<BulkIndexType> getCoupledBulkElementIndices(const LowDimElement& lowDimElement) - { - const auto& insertionIndices = lowDimCouplingElements_()[lowDimFactory_().insertionIndex(lowDimElement)]; - const auto& bulkInsertionToGlobalMap = bulkInsertionToGlobalIdxMap_(); - - const auto n = insertionIndices.size(); - std::vector<BulkIndexType> globalIndices(n); - for (unsigned int i = 0; i < n; ++i) - globalIndices[i] = bulkInsertionToGlobalMap[insertionIndices[i]]; - - return globalIndices; - } - -private: - - /*! - * \brief Returns a reference to the vector containing lists of bulk element indices - * that are connected to the low dim elements. Note that the access occurs - * with the insertion index of a low dim element. - */ - static std::vector<std::vector<BulkIndexType>>& lowDimCouplingElements_() - { - static std::vector<std::vector<BulkIndexType>> couplingMap_; - return couplingMap_; - } - - /*! - * \brief Returns a reference to the map mapping bulk element insertion indices - * to actual global indices - */ - static std::vector<BulkIndexType>& bulkInsertionToGlobalIdxMap_() - { - static std::vector<BulkIndexType> insertionIdxMap_; - return insertionIdxMap_; - } - - /*! - * \brief Returns a reference to the bulk grid pointer (std::shared_ptr<BulkGrid>) - */ - static std::shared_ptr<BulkGrid>& bulkGridPtr_() - { - static std::shared_ptr<BulkGrid> bulkGridPtr_; - return bulkGridPtr_; - } - - /*! - * \brief Returns a reference to the lowDim grid pointer (std::shared_ptr<LowDimGrid>) - */ - static std::shared_ptr<LowDimGrid>& lowDimGridPtr_() - { - static std::shared_ptr<LowDimGrid> lowDimGridPtr_; - return lowDimGridPtr_; - } - - static Dune::GridFactory<BulkGrid>& bulkFactory_() - { - static Dune::GridFactory<BulkGrid> bulkFactory_; - return bulkFactory_; - } - - static Dune::GridFactory<LowDimGrid>& lowDimFactory_() - { - static Dune::GridFactory<LowDimGrid> lowDimFactory_; - return lowDimFactory_; - } - - /*! - * \brief Returns a list of low dim elements that are connected to this bulk element - */ - static std::vector<LowDimIndexType> obtainLowDimConnections_(const std::vector<std::vector<LowDimIndexType>>& lowDimElemData, - const std::vector<BulkIndexType>& bulkElemVertices) - { - std::vector<LowDimIndexType> lowDimElemIndices = std::vector<LowDimIndexType>(); - - // check for each low dim element if it is contained - unsigned int lowDimElementIdx = 0; - for (const auto& lowDimElem : lowDimElemData) - { - const bool isContained = [&lowDimElem, &bulkElemVertices] () - { - for (auto idx : lowDimElem) - if (findIndexInVector_(bulkElemVertices, idx) == invalidIndex) - return false; - return true; - } (); - - // insert in list if low dim element is in bulk element - if (isContained) - lowDimElemIndices.push_back(lowDimElementIdx); - - // keep track of the low dim element insertion index - lowDimElementIdx++; - } - - return lowDimElemIndices; - } - - /*! - * \brief Returns the local index of a given value in a given vector - */ - template<typename IdxType1, typename IdxType2> - static int findIndexInVector_(const std::vector<IdxType1>& vector, const IdxType2 globalIdx) - { - auto it = std::find(vector.begin(), vector.end(), globalIdx); - - // we use the -5 here to detect whether or not an index exists already - if (it != vector.end()) - return std::distance(vector.begin(), it); - else - return invalidIndex; - } - - /*! - * \brief Returns the filename extension of a given filename - */ - static std::string getFileExtension_(const std::string& fileName) - { - std::size_t i = fileName.rfind('.', fileName.length()); - if (i != std::string::npos) - return(fileName.substr(i+1, fileName.length() - i)); - else - DUNE_THROW(Dune::IOError, "Please provide and extension for your grid file ('"<< fileName << "')!"); - } - - /*! - * \brief Turns a number in form of a string into a Scalar - */ - static Scalar stringToNumber_(const std::string& numberAsString) - { - Scalar value; - - std::stringstream stream(numberAsString); - stream >> value; - - if (stream.fail()) - { - std::runtime_error e(numberAsString); - throw e; - } - - return value; - } -}; - -} // end namespace - -#endif // DUMUX_GMSHDUALFACETGRIDCREATOR_HH diff --git a/dumux/mixeddimension/facet/mpfa/CMakeLists.txt b/dumux/mixeddimension/facet/mpfa/CMakeLists.txt deleted file mode 100644 index 22c0ab9868fa789c48a0042e636e2d8bcb87cefe..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/facet/mpfa/CMakeLists.txt +++ /dev/null @@ -1,10 +0,0 @@ -install(FILES -couplingmanager.hh -couplingmapper.hh -darcyslaw.hh -fickslaw.hh -fourierslaw.hh -interactionvolume.hh -interiorboundarydata.hh -properties.hh -DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/mixeddimension/facet) \ No newline at end of file diff --git a/dumux/mixeddimension/facet/mpfa/couplingmanager.hh b/dumux/mixeddimension/facet/mpfa/couplingmanager.hh deleted file mode 100644 index e6c415d8060d91cd99b74a36f288cac56798b14f..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/facet/mpfa/couplingmanager.hh +++ /dev/null @@ -1,304 +0,0 @@ -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup FacetCoupling - * \brief Manages the coupling between bulk elements and lower dimensional elements on the element facets - */ - -#ifndef DUMUX_MIXEDDIMENSION_CCMPFA_FACET_COUPLINGMANAGER_HH -#define DUMUX_MIXEDDIMENSION_CCMPFA_FACET_COUPLINGMANAGER_HH - -#include <dumux/implicit/properties.hh> -#include <dumux/mixeddimension/facet/mpfa/couplingmapper.hh> - -namespace Dumux -{ - -/*! - * \ingroup FacetCoupling - * \brief Manages the interaction between the bulk and lower dimensional (facet) elements - */ -template<class TypeTag> -class CCMpfaFacetCouplingManager -{ - using Implementation = typename GET_PROP_TYPE(TypeTag, CouplingManager); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using GlobalProblem = typename GET_PROP_TYPE(TypeTag, Problem); - using GridCreator = typename GET_PROP_TYPE(TypeTag, GridCreator); - - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); - using BulkElement = typename BulkGridView::template Codim<0>::Entity; - using BulkIntersection = typename BulkGridView::Intersection; - using BulkIndexType = typename BulkGridView::IndexSet::IndexType; - using BulkProblem = typename GET_PROP_TYPE(BulkProblemTypeTag, Problem); - using BulkMpfaHelper = typename GET_PROP_TYPE(BulkProblemTypeTag, MpfaHelper); - using BulkLocalResidual = typename GET_PROP_TYPE(BulkProblemTypeTag, LocalResidual); - using BulkPrimaryVariables = typename GET_PROP_TYPE(BulkProblemTypeTag, PrimaryVariables); - using BulkFVElementGeometry = typename GET_PROP_TYPE(BulkProblemTypeTag, FVElementGeometry); - using BulkSubControlVolumeFace = typename GET_PROP_TYPE(BulkProblemTypeTag, SubControlVolumeFace); - using BulkElementBoundaryTypes = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementBoundaryTypes); - using BulkElementVolumeVariables = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementVolumeVariables); - using BulkElementFluxVariablesCache = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementFluxVariablesCache); - - using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); - using LowDimElement = typename LowDimGridView::template Codim<0>::Entity; - using LowDimIndexType = typename LowDimGridView::IndexSet::IndexType; - using LowDimProblem = typename GET_PROP_TYPE(LowDimProblemTypeTag, Problem); - using LowDimLocalResidual = typename GET_PROP_TYPE(LowDimProblemTypeTag, LocalResidual); - using LowDimPrimaryVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, PrimaryVariables); - using LowDimSubControlVolume = typename GET_PROP_TYPE(LowDimProblemTypeTag, SubControlVolume); - using LowDimFVElementGeometry = typename GET_PROP_TYPE(LowDimProblemTypeTag, FVElementGeometry); - using LowDimElementBoundaryTypes = typename GET_PROP_TYPE(LowDimProblemTypeTag, ElementBoundaryTypes); - using LowDimVolumeVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, VolumeVariables); - using LowDimElementVolumeVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, ElementVolumeVariables); - using LowDimElementFluxVariablesCache = typename GET_PROP_TYPE(LowDimProblemTypeTag, ElementFluxVariablesCache); - - static constexpr int dimWorld = BulkGridView::dimensionworld; - static constexpr int lowDimDimWorld = LowDimGridView::dimensionworld; - static_assert(dimWorld == lowDimDimWorld, "dimWorld cannot be different for the two sub-domains!"); - - using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; - -public: - - /*! - * \brief Constructor - */ - CCMpfaFacetCouplingManager(BulkProblem& bulkProblem, LowDimProblem& lowDimProblem) - : bulkProblemPtr_(&bulkProblem), - lowDimProblemPtr_(&lowDimProblem), - couplingMapper_(bulkProblem, lowDimProblem) - { - // initialize the local residuals - bulkLocalResidual_.init(bulkProblem); - lowDimLocalResidual_.init(lowDimProblem); - } - - void preInit() {} - - void postInit() - { - // abfrage ob no flow tip?? - couplingMapper_.init(); - } - - //! evaluates if an intersection is on an interior boundary - bool isInteriorBoundary(const BulkElement& element, const BulkIntersection& is) const - { - // TODO: Facet elements that are on the bulk domain boundary - if (is.boundary()) - return false; - - const auto insideIdx = bulkProblem().elementMapper().index(element); - const auto outsideIdx = bulkProblem().elementMapper().index(is.outside()); - return isInteriorBoundary_(insideIdx, outsideIdx); - } - - //! evaluates if an scvf is on an interior boundary - bool isInteriorBoundary(const BulkElement& element, const BulkSubControlVolumeFace& scvf) const - { - // TODO: Facet elements that are on the bulk domain boundary - if (scvf.boundary()) - return false; - - if (couplingMapper_.isInitialized()) - { - const auto& couplingData = couplingMapper_.getBulkCouplingData(element); - - // if the element is coupled, check if the scvf is so as well - if (!couplingData.isCoupled) - return false; - return couplingData.getScvfCouplingData(scvf).first; - } - - // If the mapper has not been initialized yet, use the private function - return isInteriorBoundary_(scvf.insideScvIdx(), scvf.outsideScvIdx()); - } - - const std::vector<LowDimIndexType>& couplingStencil(const BulkElement& element) - { return couplingMapper_.getBulkCouplingData(element).couplingStencil; } - - const std::vector<BulkIndexType>& couplingStencil(const LowDimElement& element) - { return couplingMapper_.getLowDimCouplingData(element).couplingStencil; } - - //! evaluate coupling residual for the derivative bulk DOF with respect to low dim DOF - //! we only need to evaluate the part of the residual that will be influence by the low dim DOF - BulkPrimaryVariables evalCouplingResidual(const BulkElement& element, - const BulkFVElementGeometry& fvGeometry, - const BulkElementVolumeVariables& curElemVolVars, - const BulkElementBoundaryTypes& elemBcTypes, - const BulkElementFluxVariablesCache& elemFluxVarsCache, - const LowDimElement& lowDimElement) - { - const auto& couplingData = couplingMapper_.getBulkCouplingData(element); - - if (!couplingData.isCoupled) - return BulkPrimaryVariables(0.0); - - // calculate the local residual of the bulk element - auto prevElemVolVars = localView(bulkProblem().model().prevGridVolVars()); - prevElemVolVars.bindElement(element, fvGeometry, bulkProblem().model().prevSol()); - bulkLocalResidual_.eval(element, fvGeometry, prevElemVolVars, curElemVolVars, elemBcTypes, elemFluxVarsCache); - return bulkLocalResidual_.residual(0); - } - - //! evaluate coupling residual for the derivative low dim DOF with respect to bulk DOF - //! we only need to evaluate the part of the residual that will be influence by the bulk DOF - LowDimPrimaryVariables evalCouplingResidual(const LowDimElement& element, - const LowDimFVElementGeometry& fvGeometry, - const LowDimElementVolumeVariables& curElemVolVars, - const LowDimElementBoundaryTypes& elemBcTypes, - const LowDimElementFluxVariablesCache& elemFluxVarsCache, - const BulkElement& bulkElement) - { - const auto& couplingData = couplingMapper_.getLowDimCouplingData(element); - - if (!couplingData.isCoupled) - return LowDimPrimaryVariables(0.0); - - // calculate the source term of the low dim element - const auto eIdx = lowDimProblem().elementMapper().index(element); - const auto& scv = fvGeometry.scv(eIdx); - - auto source = lowDimLocalResidual_.computeSource(element, fvGeometry, curElemVolVars, scv); - source *= -scv.volume()*curElemVolVars[scv].extrusionFactor(); - return source; - } - - //! evaluates the sources in the low dim domain coming from the bulk domain - //! i.e. the fluxes from the bulk domain into the given low dim element. We return bulk priVars here, - //! the low dim problem itself needs to transform that into suitable information - BulkPrimaryVariables evalSourcesFromBulk(const LowDimElement& element, - const LowDimFVElementGeometry& fvGeometry, - const LowDimElementVolumeVariables& curElemVolVars, - const LowDimSubControlVolume& scv) const - { - const auto& couplingData = couplingMapper_.getLowDimCouplingData(element); - - if (!couplingData.isCoupled) - return BulkPrimaryVariables(0.0); - - // evaluate the fluxes over each scvf in each bulk neighbor. Prepare the local views - // of the first element, the necessary quantities for all the scvfs will be in there, - // as the scvfs in the other elements are the "flipped" scvfs of the ones in the first element - const auto& firstPair = couplingData.elementScvfList[0]; - const auto firstBulkElement = bulkProblem().model().fvGridGeometry().element(firstPair.first); - - auto bulkFvGeometry = localView(bulkProblem().model().fvGridGeometry()); - bulkFvGeometry.bind(firstBulkElement); - - auto bulkElemVolVars = localView(bulkProblem().model().curGridVolVars()); - bulkElemVolVars.bind(firstBulkElement, bulkFvGeometry, bulkProblem().model().curSol()); - - auto bulkElemFluxVarsCache = localView(bulkProblem().model().gridFluxVarsCache()); - bulkElemFluxVarsCache.bind(firstBulkElement, bulkFvGeometry, bulkElemVolVars); - - BulkPrimaryVariables flux(0.0); - for (const auto& pair : couplingData.elementScvfList) - { - const auto bulkElement = bulkProblem().model().fvGridGeometry().element(pair.first); - for (auto scvfIdx : pair.second) - flux += bulkLocalResidual_.computeFlux(bulkElement, - bulkFvGeometry, - bulkElemVolVars, - bulkFvGeometry.scvf(scvfIdx), - bulkElemFluxVarsCache); - } - - // The source has to be formulated per volume - flux /= scv.volume()*curElemVolVars[scv].extrusionFactor(); - return flux; - } - - //! Compute lowDim volume variables for given bulk element and scvf - LowDimVolumeVariables lowDimVolVars(const BulkElement& element, - const BulkFVElementGeometry& fvGeometry, - const BulkSubControlVolumeFace& scvf) const - { - const auto& scvfCouplingData = couplingMapper_.getBulkCouplingData(element).getScvfCouplingData(scvf); - - assert(scvfCouplingData.first && "no coupled facet element found for given scvf!"); - const auto lowDimElement = lowDimProblem().model().fvGridGeometry().element(scvfCouplingData.second); - auto lowDimFvGeometry = localView(lowDimProblem().model().fvGridGeometry()); - lowDimFvGeometry.bindElement(lowDimElement); - - const auto& lowDimCurSol = lowDimProblem().model().curSol(); - LowDimVolumeVariables lowDimVolVars; - lowDimVolVars.update(lowDimProblem().model().elementSolution(lowDimElement, lowDimCurSol), - lowDimProblem(), - lowDimElement, - lowDimFvGeometry.scv(scvfCouplingData.second)); - return lowDimVolVars; - } - - const BulkProblem& bulkProblem() const - { return *bulkProblemPtr_; } - - const LowDimProblem& lowDimProblem() const - { return *lowDimProblemPtr_; } - - const CCMpfaFacetCouplingMapper<TypeTag>& couplingMapper() const - { return couplingMapper_; } - -private: - - //! evaluates if there is an interior boundary between two bulk elements - bool isInteriorBoundary_(BulkIndexType eIdxInside, BulkIndexType eIdxOutside) const - { - for (const auto& lowDimElement : elements(lowDimProblem().gridView())) - { - // The indices of bulk elements in which the actual low dim element is a facet - const auto& bulkElementIndices = GridCreator::getCoupledBulkElementIndices(lowDimElement); - - // if inside & outside element are contained in them, this is a "coupling" intersection - if (BulkMpfaHelper::contains(bulkElementIndices, eIdxInside) && BulkMpfaHelper::contains(bulkElementIndices, eIdxOutside)) - return true; - } - - return false; - } - - BulkProblem& bulkProblem() - { return *bulkProblemPtr_; } - - LowDimProblem& lowDimProblem() - { return *lowDimProblemPtr_; } - - //! Returns the implementation of the problem (i.e. static polymorphism) - Implementation &asImp_() - { return *static_cast<Implementation *>(this); } - - //! \copydoc asImp_() - const Implementation &asImp_() const - { return *static_cast<const Implementation *>(this); } - - BulkProblem *bulkProblemPtr_; - LowDimProblem *lowDimProblemPtr_; - - mutable BulkLocalResidual bulkLocalResidual_; - mutable LowDimLocalResidual lowDimLocalResidual_; - - CCMpfaFacetCouplingMapper<TypeTag> couplingMapper_; -}; - -} // end namespace - -#endif // DUMUX_FACETCOUPLINGMANAGER_HH diff --git a/dumux/mixeddimension/facet/mpfa/couplingmapper.hh b/dumux/mixeddimension/facet/mpfa/couplingmapper.hh deleted file mode 100644 index e91b7682451da3d59448f1e713f851f29a537b8b..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/facet/mpfa/couplingmapper.hh +++ /dev/null @@ -1,257 +0,0 @@ -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup Facet - * \brief Creates mappings of the entities from the bulk and the facet subdomain - */ - -#ifndef DUMUX_MIXEDDIMENSION_CCMPFA_FACET_COUPLINGMAPPER_HH -#define DUMUX_MIXEDDIMENSION_CCMPFA_FACET_COUPLINGMAPPER_HH - -#include <dune/common/version.hh> -#include <dune/grid/common/mcmgmapper.hh> -#include <dune/grid/common/gridfactory.hh> - -#include <dumux/common/math.hh> -#include <dumux/common/propertysystem.hh> -#include <dumux/common/parameters.hh> -#include <dumux/common/valgrind.hh> - -namespace Dumux -{ - -namespace Properties -{ -NEW_PROP_TAG(Scalar); -NEW_PROP_TAG(BulkProblemTypeTag); -NEW_PROP_TAG(LowDimProblemTypeTag); -} - -/*! - * \ingroup FacetCoupling - * \brief Creates mappings of the entities from the bulk and the facet subdomain - */ -template<class TypeTag> -class CCMpfaFacetCouplingMapper -{ - using GridCreator = typename GET_PROP_TYPE(TypeTag, GridCreator); - - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - using BulkProblem = typename GET_PROP_TYPE(BulkProblemTypeTag, Problem); - using LowDimProblem = typename GET_PROP_TYPE(LowDimProblemTypeTag, Problem); - - using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); - using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); - - using BulkIndexType = typename BulkGridView::IndexSet::IndexType; - using LowDimIndexType = typename LowDimGridView::IndexSet::IndexType; - - using BulkElement = typename BulkGridView::template Codim<0>::Entity; - using LowDimElement = typename LowDimGridView::template Codim<0>::Entity; - - using BulkSubControlVolumeFace = typename GET_PROP_TYPE(BulkProblemTypeTag, SubControlVolumeFace); - using BulkMpfaHelper = typename GET_PROP_TYPE(BulkProblemTypeTag, MpfaHelper); - - static constexpr int lowDimDim = LowDimGridView::dimension; - -public: - - struct BulkDataInLowDim - { - // indicates whether or not this element is coupled - bool isCoupled; - - // The list of bulk element indices connected to a low dim element - std::vector<BulkIndexType> couplingStencil; - - // We store for each directly connected element a list of - // global scvf indices over which the two domains are coupled - std::vector<std::pair<BulkIndexType, std::vector<BulkIndexType>>> elementScvfList; - - // The constructor - BulkDataInLowDim() : isCoupled(false) {} - }; - - struct LowDimDataInBulk - { - // indicates whether or not this element is coupled - bool isCoupled; - - // The list of low dim elements with influence on this bulk element - std::vector<LowDimIndexType> couplingStencil; - - // to each scvf of the bulk element we store - // the low dim element index that it is connected to - std::vector<std::pair<BulkIndexType, LowDimIndexType>> scvfToLowDimData; - - // The constructor - LowDimDataInBulk() : isCoupled(false) {} - - // For a given scvf of the element this method returns a pair of a bool and an index. The boolean - // indicates if this scvf does couple to a low dim element, the index is the low dim element index - std::pair<bool, LowDimIndexType> getScvfCouplingData(const BulkSubControlVolumeFace& scvf) const - { return getScvfCouplingData(scvf.index()); } - - std::pair<bool, LowDimIndexType> getScvfCouplingData(BulkIndexType scvfIdx) const - { - for (const auto& pair : scvfToLowDimData) - if (pair.first == scvfIdx) - return std::make_pair(true, pair.second); - return std::make_pair(false, 0); - } - }; - - //! The constructor - CCMpfaFacetCouplingMapper(BulkProblem &bulkProblem, LowDimProblem &lowDimProblem) - : isInitialized_(false), - bulkProblemPtr_(&bulkProblem), - lowDimProblemPtr_(&lowDimProblem) - {} - - /*! - * \brief initializes the maps - * - * \param bulkProblem The bulk sub problem - * \param lowDimProblem The lower-dimensional sub problem - */ - void init() - { - const auto& bulkGridView = bulkProblem_().gridView(); - const auto& lowDimGridView = lowDimProblem_().gridView(); - - lowDimCouplingData_.resize(lowDimGridView.size(0)); - bulkCouplingData_.resize(bulkGridView.size(0)); - - for (const auto& lowDimElement : elements(lowDimGridView)) - { - const auto lowDimElementGlobalIdx = lowDimProblem_().elementMapper().index(lowDimElement); - - // The indices of bulk elements in which the actual low dim element is a facet - const auto& bulkElementIndices = GridCreator::getCoupledBulkElementIndices(lowDimElement); - if (bulkElementIndices.size() > 1) - { - lowDimCouplingData_[lowDimElementGlobalIdx].isCoupled = true; - - for (auto bulkElementIdx : bulkElementIndices) - { - bulkCouplingData_[bulkElementIdx].isCoupled = true; - - const auto bulkElement = bulkProblem_().model().fvGridGeometry().element(bulkElementIdx); - auto bulkFvGeometry = localView(bulkProblem_().model().fvGridGeometry()); - bulkFvGeometry.bindElement(bulkElement); - - // find the scvfs in the bulk element that "touch" the facet element - std::vector<BulkIndexType> scvfIndices; - for (const auto& scvf : scvfs(bulkFvGeometry)) - { - if (scvf.boundary()) - continue; - - const auto anyOtherIdx = bulkElementIndices[0] == bulkElementIdx ? - bulkElementIndices[1] : - bulkElementIndices[0]; - - // check if any of the other bulk indices is in the outside indices of the scvf - if (BulkMpfaHelper::contains(scvf.outsideScvIndices(), anyOtherIdx)) - { - scvfIndices.push_back(scvf.index()); - - // add data to the bulk data map - bulkCouplingData_[bulkElementIdx].scvfToLowDimData.emplace_back(std::make_pair(scvf.index(), lowDimElementGlobalIdx)); - - // also, insert scvf stencil to the coupling stencil of the low dim element - const auto scvfStencil = [&] () - { - if (bulkProblem_().model().fvGridGeometry().isInBoundaryInteractionVolume(scvf)) - return bulkProblem_().model().fvGridGeometry().boundaryInteractionVolumeSeed(scvf).globalScvIndices(); - else - return bulkProblem_().model().fvGridGeometry().interactionVolumeSeed(scvf).globalScvIndices(); - } (); - - auto& lowDimCouplingStencil = lowDimCouplingData_[lowDimElementGlobalIdx].couplingStencil; - lowDimCouplingStencil.insert(lowDimCouplingStencil.end(), scvfStencil.begin(), scvfStencil.end()); - - // also, all the bulk elements in the scvf stencil will be coupled to the actual low dim element - for (auto bulkIdx : scvfStencil) - { - bulkCouplingData_[bulkIdx].isCoupled = true; - bulkCouplingData_[bulkIdx].couplingStencil.push_back(lowDimElementGlobalIdx); - } - } - } - - // insert data into the low dim map - lowDimCouplingData_[lowDimElementGlobalIdx].elementScvfList.emplace_back(std::make_pair(bulkElementIdx, std::move(scvfIndices))); - } - } - else if (bulkElementIndices.size() == 1) - DUNE_THROW(Dune::NotImplemented, "Coupled facet elements on the bulk boundary"); - - // make the coupling stencil of the low dim element unique - auto& stencil = lowDimCouplingData_[lowDimElementGlobalIdx].couplingStencil; - std::sort(stencil.begin(), stencil.end()); - stencil.erase(std::unique(stencil.begin(), stencil.end()), stencil.end()); - } - - // make the coupling stencils in the bulk map unique - for (auto& data : bulkCouplingData_) - { - auto& stencil = data.couplingStencil; - std::sort(stencil.begin(), stencil.end()); - stencil.erase(std::unique(stencil.begin(), stencil.end()), stencil.end()); - } - - // state the initialization status - isInitialized_ = true; - } - - const LowDimDataInBulk& getBulkCouplingData(const BulkElement& bulkElement) const - { return getBulkCouplingData(bulkProblem_().elementMapper().index(bulkElement)); } - - const LowDimDataInBulk& getBulkCouplingData(BulkIndexType bulkElementIdx) const - { return bulkCouplingData_[bulkElementIdx]; } - - const BulkDataInLowDim& getLowDimCouplingData(const LowDimElement& lowDimElement) const - { return getLowDimCouplingData(lowDimProblem_().elementMapper().index(lowDimElement)); } - - const BulkDataInLowDim& getLowDimCouplingData(LowDimIndexType lowDimElementIdx) const - { return lowDimCouplingData_[lowDimElementIdx]; } - - bool isInitialized() const - { return isInitialized_; } - -private: - const BulkProblem& bulkProblem_() const - { return *bulkProblemPtr_; } - - const LowDimProblem& lowDimProblem_() const - { return *lowDimProblemPtr_; } - - bool isInitialized_; - const BulkProblem* bulkProblemPtr_; - const LowDimProblem* lowDimProblemPtr_; - - std::vector<LowDimDataInBulk> bulkCouplingData_; - std::vector<BulkDataInLowDim> lowDimCouplingData_; -}; - -} // end namespace - -#endif // DUMUX_FACETCOUPLINGMAPPER_HH diff --git a/dumux/mixeddimension/facet/mpfa/darcyslaw.hh b/dumux/mixeddimension/facet/mpfa/darcyslaw.hh deleted file mode 100644 index e8c4a64218aef387d9bdc519bf80934e9072cced..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/facet/mpfa/darcyslaw.hh +++ /dev/null @@ -1,288 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \brief This file contains the data which is required to calculate volume and mass fluxes of - * fluid phases over a face of a finite volume by means of the Darcy approximation in the - * presence of lower dimensional (coupled) elements living on the this domain's element facets. - */ -#ifndef DUMUX_DISCRETIZATION_CC_MPFA_FACET_DARCYS_LAW_HH -#define DUMUX_DISCRETIZATION_CC_MPFA_FACET_DARCYS_LAW_HH - -#include <dumux/discretization/cellcentered/mpfa/darcyslaw.hh> -#include <dumux/discretization/cellcentered/mpfa/facetypes.hh> - -namespace Dumux -{ - -/*! - * \ingroup DarcysLaw - * \brief Specialization of Darcy's Law for the CCMpfa method with lower dimensional - * elements living on the bulk elements' facets. - */ -template <class TypeTag> -class CCMpfaFacetCouplingDarcysLaw : public DarcysLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using MpfaHelper = typename GET_PROP_TYPE(TypeTag, MpfaHelper); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); - using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables); - using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); - using ElementFluxVariablesCache = typename GET_PROP_TYPE(TypeTag, ElementFluxVariablesCache); - using FluxVariablesCache = typename GET_PROP_TYPE(TypeTag, FluxVariablesCache); - using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); - - // Always use the dynamic type for vectors (compatibility with the boundary) - using BoundaryInteractionVolume = typename GET_PROP_TYPE(TypeTag, BoundaryInteractionVolume); - using CoefficientVector = typename BoundaryInteractionVolume::Vector; - - static constexpr int numPhases = GET_PROP_VALUE(TypeTag, NumPhases); - static constexpr bool useTpfaBoundary = GET_PROP_VALUE(TypeTag, UseTpfaBoundary); - static constexpr bool enableInteriorBoundaries = GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries); - - //! The cache used in conjunction with the mpfa Darcy's Law - class MpfaFacetCouplingDarcysLawCache - { - // We always use the dynamic types here to be compatible on the boundary - using Stencil = typename BoundaryInteractionVolume::GlobalIndexSet; - using PositionVector = typename BoundaryInteractionVolume::PositionVector; - - public: - //! update cached objects - template<class InteractionVolume> - void updateAdvection(const InteractionVolume& iv, const SubControlVolumeFace &scvf) - { - const auto& localFaceData = iv.getLocalFaceData(scvf); - // update the quantities that are equal for all phases - advectionVolVarsStencil_ = iv.volVarsStencil(); - advectionVolVarsPositions_ = iv.volVarsPositions(); - advectionTij_ = iv.getTransmissibilities(localFaceData); - - // we will need the neumann flux transformation on interior Neumann boundaries - advectionCij_ = iv.getNeumannFluxTransformationCoefficients(localFaceData); - - // The neumann fluxes always have to be set per phase - for (unsigned int phaseIdx = 0; phaseIdx < numPhases; ++phaseIdx) - phaseNeumannFluxes_[phaseIdx] = iv.getNeumannFlux(localFaceData, phaseIdx); - } - - //! Returns the volume variables indices necessary for flux computation - //! This includes all participating boundary volume variables. Since we - //! do not allow mixed BC for the mpfa this is the same for all phases. - const Stencil& advectionVolVarsStencil() const - { return advectionVolVarsStencil_; } - - //! Returns the position on which the volume variables live. This is - //! necessary as we need to evaluate gravity also for the boundary volvars - const PositionVector& advectionVolVarsPositions() const - { return advectionVolVarsPositions_; } - - //! Returns the transmissibilities associated with the volume variables - //! All phases flow through the same rock, thus, tij are equal for all phases - const CoefficientVector& advectionTij() const - { return advectionTij_; } - - //! Returns the vector of coefficients with which the vector of neumann boundary conditions - //! has to be multiplied in order to transform them on the scvf this cache belongs to - const CoefficientVector& advectionCij() const - { return advectionCij_; } - - //! If the useTpfaBoundary property is set to false, the boundary conditions - //! are put into the local systems leading to possible contributions on all faces - Scalar advectionNeumannFlux(unsigned int phaseIdx) const - { return phaseNeumannFluxes_[phaseIdx]; } - - private: - // Quantities associated with advection - Stencil advectionVolVarsStencil_; - PositionVector advectionVolVarsPositions_; - CoefficientVector advectionTij_; - CoefficientVector advectionCij_; - std::array<Scalar, numPhases> phaseNeumannFluxes_; - }; - -public: - // state the discretization method this implementation belongs to - static const DiscretizationMethods myDiscretizationMethod = DiscretizationMethods::CCMpfa; - - // state the new type for the corresponding cache - using Cache = MpfaFacetCouplingDarcysLawCache; - - static Scalar flux(const Problem& problem, - const Element& element, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const SubControlVolumeFace& scvf, - const unsigned int phaseIdx, - const ElementFluxVariablesCache& elemFluxVarsCache) - { - static const bool gravity = GET_PARAM_FROM_GROUP(TypeTag, bool, Problem, EnableGravity); - - const auto& fluxVarsCache = elemFluxVarsCache[scvf]; - const auto& volVarsStencil = fluxVarsCache.advectionVolVarsStencil(); - const auto& volVarsPositions = fluxVarsCache.advectionVolVarsPositions(); - const auto& tij = fluxVarsCache.advectionTij(); - - const bool isInteriorBoundary = enableInteriorBoundaries && fluxVarsCache.isInteriorBoundary(); - - // Calculate the interface density for gravity evaluation - const auto rho = interpolateDensity(fvGeometry, elemVolVars, scvf, fluxVarsCache, phaseIdx, isInteriorBoundary); - - // calculate Tij*pj - Scalar flux(0.0); - unsigned int localIdx = 0; - for (const auto volVarIdx : volVarsStencil) - { - const auto& volVars = elemVolVars[volVarIdx]; - Scalar h = volVars.pressure(phaseIdx); - - // if gravity is enabled, add gravitational acceleration - if (gravity) - { - // gravitational acceleration in the center of the actual element - const auto x = volVarsPositions[localIdx]; - const auto g = problem.gravityAtPos(x); - - h -= rho*(g*x); - } - - flux += tij[localIdx++]*h; - } - - // if no interior boundaries are present, return the flux - if (!enableInteriorBoundaries) - return useTpfaBoundary ? flux : flux + fluxVarsCache.advectionNeumannFlux(phaseIdx); - - // Handle interior boundaries - flux += computeInteriorBoundaryContribution(problem, fvGeometry, elemVolVars, fluxVarsCache, phaseIdx, rho); - - // return overall resulting flux - return useTpfaBoundary ? flux : flux + fluxVarsCache.advectionNeumannFlux(phaseIdx); - } - - static Scalar interpolateDensity(const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const SubControlVolumeFace& scvf, - const FluxVariablesCache& fluxVarsCache, - const unsigned int phaseIdx, - const bool isInteriorBoundary) - { - static const bool gravity = GET_PARAM_FROM_GROUP(TypeTag, bool, Problem, EnableGravity); - - if (!gravity) - return Scalar(0.0); - else - { - // Return facet density on interior boundaries - if (isInteriorBoundary) - return fluxVarsCache.interiorBoundaryDataSelf().facetVolVars(fvGeometry).density(phaseIdx); - - // use arithmetic mean of the densities around the scvf - if (!scvf.boundary()) - { - Scalar rho = elemVolVars[scvf.insideScvIdx()].density(phaseIdx); - for (auto outsideIdx : scvf.outsideScvIndices()) - rho += elemVolVars[outsideIdx].density(phaseIdx); - return rho/(scvf.outsideScvIndices().size()+1); - } - else - return elemVolVars[scvf.outsideScvIdx()].density(phaseIdx); - } - } - - static Scalar computeInteriorBoundaryContribution(const Problem& problem, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const FluxVariablesCache& fluxVarsCache, - unsigned int phaseIdx, Scalar rho) - { - static const bool gravity = GET_PARAM_FROM_GROUP(TypeTag, bool, Problem, EnableGravity); - - // obtain the transmissibilites associated with all pressures - const auto& tij = fluxVarsCache.advectionTij(); - - // the interior dirichlet boundaries local indices start after - // the cell and the domain Dirichlet boundary pressures - const auto startIdx = fluxVarsCache.advectionVolVarsStencil().size(); - - // The vector of interior neumann fluxes - const auto& cij = fluxVarsCache.advectionCij(); - CoefficientVector facetCouplingFluxes(cij.size(), 0.0); - - // add interior Dirichlet boundary contributions - Scalar flux = 0.0; - for (auto&& data : fluxVarsCache.interiorBoundaryData()) - { - // Add additional Dirichlet fluxes for interior Dirichlet faces - if (data.faceType() == MpfaFaceTypes::interiorDirichlet) - { - Scalar h = data.facetVolVars(fvGeometry).pressure(phaseIdx); - - if (gravity) - { - const auto x = fvGeometry.scvf(data.scvfIndex()).ipGlobal(); - const auto g = problem.gravityAtPos(x); - - h -= rho*(g*x); - } - - flux += tij[startIdx + data.localIndexInInteractionVolume()]*h; - } - - // add neumann contributions - if (data.faceType() == MpfaFaceTypes::interiorNeumann) - { - // get the scvf corresponding to actual interior neumann face - const auto& curScvf = fvGeometry.scvf(data.scvfIndex()); - - // get the volvars of the actual interior neumann face - const auto facetVolVars = data.facetVolVars(fvGeometry, curScvf); - - // calculate "leakage factor" - const auto n = curScvf.unitOuterNormal(); - const auto v = [&] () - { - auto res = n; - res *= -0.5*facetVolVars.extrusionFactor(); - res += curScvf.ipGlobal(); - res -= curScvf.facetCorner(); - res /= res.two_norm2(); - return res; - } (); - - // add value to vector of interior neumann fluxes - facetCouplingFluxes[data.localIndexInInteractionVolume()] += facetVolVars.pressure(phaseIdx)* - curScvf.area()* - elemVolVars[curScvf.insideScvIdx()].extrusionFactor()* - MpfaHelper::nT_M_v(n, facetVolVars.permeability(), v); - } - } - - return flux + cij*facetCouplingFluxes; - } -}; - -} // end namespace - -#endif diff --git a/dumux/mixeddimension/facet/mpfa/fickslaw.hh b/dumux/mixeddimension/facet/mpfa/fickslaw.hh deleted file mode 100644 index 74bd92b394f8d590e5e72b5d3e1fb66d4007a661..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/facet/mpfa/fickslaw.hh +++ /dev/null @@ -1,356 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \brief This file contains the data which is required to calculate - * molar and mass fluxes of a component in a fluid phase over a face of a finite volume by means - * of Fick's Law for cell-centered MPFA models in the presence of lower dimensional (coupled) elements - * living on the this domain's element facets. - */ -#ifndef DUMUX_DISCRETIZATION_CC_MPFA_FACET_FICKS_LAW_HH -#define DUMUX_DISCRETIZATION_CC_MPFA_FACET_FICKS_LAW_HH - -#include <dumux/discretization/cellcentered/mpfa/fickslaw.hh> -#include <dumux/discretization/cellcentered/mpfa/facetypes.hh> - -namespace Dumux -{ -/*! - * \ingroup CCMpfaFicksLaw - * \brief Specialization of Fick's Law for the CCMpfa method with lower dimensional - * elements living on the bulk elements' facets. - */ -template <class TypeTag> -class CCMpfaFacetCouplingFicksLaw : public FicksLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using Model = typename GET_PROP_TYPE(TypeTag, Model); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using MpfaHelper = typename GET_PROP_TYPE(TypeTag, MpfaHelper); - using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables); - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using EffDiffModel = typename GET_PROP_TYPE(TypeTag, EffectiveDiffusivityModel); - using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem); - using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); - using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); - using ElementFluxVariablesCache = typename GET_PROP_TYPE(TypeTag, ElementFluxVariablesCache); - using FluxVariablesCache = typename GET_PROP_TYPE(TypeTag, FluxVariablesCache); - - // Always use the dynamic type for vectors (compatibility with the boundary) - using BoundaryInteractionVolume = typename GET_PROP_TYPE(TypeTag, BoundaryInteractionVolume); - using CoefficientVector = typename BoundaryInteractionVolume::Vector; - - using Element = typename GridView::template Codim<0>::Entity; - using IndexType = typename GridView::IndexSet::IndexType; - - static constexpr int numPhases = GET_PROP_VALUE(TypeTag, NumPhases); - static constexpr int numComponents = GET_PROP_VALUE(TypeTag,NumComponents); - static constexpr bool useTpfaBoundary = GET_PROP_VALUE(TypeTag, UseTpfaBoundary); - static constexpr bool enableInteriorBoundaries = GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries); - using ComponentFluxVector = Dune::FieldVector<Scalar, numComponents>; - - //! The cache used in conjunction with the mpfa Fick's Law - class MpfaFacetCouplingFicksLawCache - { - static const int numComponents = GET_PROP_VALUE(TypeTag, NumComponents); - - // We always use the dynamic types here to be compatible on the boundary - using Stencil = typename BoundaryInteractionVolume::GlobalIndexSet; - using PositionVector = typename BoundaryInteractionVolume::PositionVector; - - public: - //! The constructor. Initializes the Neumann flux to zero - MpfaFacetCouplingFicksLawCache() { componentNeumannFluxes_.fill(0.0); } - - // update cached objects for the diffusive fluxes - template<typename InteractionVolume> - void updateDiffusion(const InteractionVolume& iv, const SubControlVolumeFace &scvf, - unsigned int phaseIdx, unsigned int compIdx) - { - const auto& localFaceData = iv.getLocalFaceData(scvf); - diffusionTij_[phaseIdx][compIdx] = iv.getTransmissibilities(localFaceData); - // get the stencil only for the first call - if (phaseIdx == 0 && compIdx == 0) - diffusionVolVarsStencil_ = iv.volVarsStencil(); - - // we will need the neumann flux transformation on interior Neumann boundaries - diffusionCij_[phaseIdx][compIdx] = iv.getNeumannFluxTransformationCoefficients(localFaceData); - - //! For compositional models, we associate neumann fluxes with the phases (main components) - //! This is done in the AdvectionCache. However, in single-phasic models we solve the phase AND - //! the component mass balance equations. Thus, in this case we have diffusive neumann contributions. - //! we assume compIdx = eqIdx - if (numPhases == 1 && phaseIdx != compIdx) - componentNeumannFluxes_[compIdx] = iv.getNeumannFlux(localFaceData, compIdx); - - } - - //! Returns the volume variables indices necessary for diffusive flux - //! computation. This includes all participating boundary volume variables - //! and it can be different for the phases & components. - const Stencil& diffusionVolVarsStencil(unsigned int phaseIdx, unsigned int compIdx) const - { return diffusionVolVarsStencil_; } - - //! Returns the transmissibilities associated with the volume variables - //! This can be different for the phases & components. - const CoefficientVector& diffusionTij(unsigned int phaseIdx, unsigned int compIdx) const - { return diffusionTij_[phaseIdx][compIdx]; } - - //! Returns the vector of coefficients with which the vector of neumann boundary conditions - //! has to be multiplied in order to transform them on the scvf this cache belongs to - const CoefficientVector& diffusionCij(unsigned int phaseIdx, unsigned int compIdx) const - { return diffusionCij_[phaseIdx][compIdx]; } - - //! If the useTpfaBoundary property is set to false, the boundary conditions - //! are put into the local systems leading to possible contributions on all faces - Scalar componentNeumannFlux(unsigned int compIdx) const - { - assert(numPhases == 1); - return componentNeumannFluxes_[compIdx]; - } - - private: - // Quantities associated with molecular diffusion - Stencil diffusionVolVarsStencil_; - std::array< std::array<CoefficientVector, numComponents>, numPhases> diffusionTij_; - std::array< std::array<CoefficientVector, numComponents>, numPhases> diffusionCij_; - - // diffusive neumann flux for single-phasic models - std::array<Scalar, numComponents> componentNeumannFluxes_; - }; - -public: - // state the discretization method this implementation belongs to - static const DiscretizationMethods myDiscretizationMethod = DiscretizationMethods::CCMpfa; - - // state the new type for the corresponding cache - using Cache = MpfaFacetCouplingFicksLawCache; - - static ComponentFluxVector flux(const Problem& problem, - const Element& element, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const SubControlVolumeFace& scvf, - int phaseIdx, - const ElementFluxVariablesCache& elemFluxVarsCache, - bool useMoles = true) - { - ComponentFluxVector componentFlux(0.0); - for (int compIdx = 0; compIdx < numComponents; compIdx++) - { - if(compIdx == FluidSystem::getMainComponent(phaseIdx)) - continue; - - const auto& fluxVarsCache = elemFluxVarsCache[scvf]; - const auto& volVarsStencil = fluxVarsCache.diffusionVolVarsStencil(phaseIdx, compIdx); - const auto& tij = fluxVarsCache.diffusionTij(phaseIdx, compIdx); - - const bool isInteriorBoundary = enableInteriorBoundaries && fluxVarsCache.isInteriorBoundary(); - - // get the scaling factor for the effective diffusive fluxes - const auto effFactor = computeEffectivityFactor(fvGeometry, elemVolVars, scvf, fluxVarsCache, phaseIdx, isInteriorBoundary); - - // if factor is zero, the flux will end up zero anyway - if (effFactor == 0.0) - { - componentFlux[compIdx] = 0.0; - continue; - } - - // lambda functions depending on if we use mole or mass fractions - auto getX = [useMoles, phaseIdx, compIdx] (const auto& volVars) - { return useMoles ? volVars.moleFraction(phaseIdx, compIdx) : volVars.massFraction(phaseIdx, compIdx); }; - - auto getRho = [useMoles, phaseIdx] (const auto& volVars) - { return useMoles ? volVars.molarDensity(phaseIdx) : volVars.density(phaseIdx); }; - - // calculate the density at the interface - const auto rho = interpolateDensity(fvGeometry, elemVolVars, scvf, fluxVarsCache, getRho, isInteriorBoundary); - - // calculate Tij*xj - Scalar flux(0.0); - unsigned int localIdx = 0; - for (const auto volVarIdx : volVarsStencil) - flux += tij[localIdx++]*getX(elemVolVars[volVarIdx]); - - // if no interior boundaries are present, return effective mass flux - if (!enableInteriorBoundaries) - componentFlux[compIdx] = useTpfaBoundary ? flux*rho*effFactor : flux*rho*effFactor + fluxVarsCache.componentNeumannFlux(compIdx); - else - { - // Handle interior boundaries - flux += computeInteriorBoundaryContribution(fvGeometry, elemVolVars, fluxVarsCache, getX, phaseIdx, compIdx); - - // return overall resulting flux - componentFlux[compIdx] = useTpfaBoundary ? flux*rho*effFactor : flux*rho*effFactor + fluxVarsCache.componentNeumannFlux(compIdx); - } - } - - // accumulate the phase component flux - for(int compIdx = 0; compIdx < numComponents; compIdx++) - if(compIdx != FluidSystem::getMainComponent(phaseIdx) && Model::mainComponentIsBalanced(phaseIdx) && !FluidSystem::isTracerFluidSystem()) - componentFlux[FluidSystem::getMainComponent(phaseIdx)] -= componentFlux[compIdx]; - - return componentFlux; - } - - template<typename GetRhoFunction> - static Scalar interpolateDensity(const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const SubControlVolumeFace& scvf, - const FluxVariablesCache& fluxVarsCache, - const GetRhoFunction& getRho, - const bool isInteriorBoundary) - { - - // maybe use the density of the interior BC on the facet - if (isInteriorBoundary) - return getRho(fluxVarsCache.interiorBoundaryDataSelf().facetVolVars(fvGeometry)); - - // use arithmetic mean of the densities around the scvf - if (!scvf.boundary()) - { - Scalar rho = getRho(elemVolVars[scvf.insideScvIdx()]); - for (auto outsideIdx : scvf.outsideScvIndices()) - rho += getRho(elemVolVars[outsideIdx]); - return rho/(scvf.outsideScvIndices().size()+1); - } - else - return getRho(elemVolVars[scvf.outsideScvIdx()]); - } - - //! Here we want to calculate the factors with which the diffusion coefficient has to be - //! scaled to get the effective diffusivity. For this we use the effective diffusivity with - //! a diffusion coefficient of 1.0 as input. Then we scale the transmissibilites during flux - //! calculation (above) with the harmonic average of the two factors - static Scalar computeEffectivityFactor(const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const SubControlVolumeFace& scvf, - const FluxVariablesCache& fluxVarsCache, - const unsigned int phaseIdx, - const bool isInteriorBoundary) - { - if (isInteriorBoundary) - { - // use harmonic mean between the interior and the facet volvars - const auto& data = fluxVarsCache.interiorBoundaryDataSelf(); - - const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; - const auto factor = EffDiffModel::effectiveDiffusivity(insideVolVars.porosity(), - insideVolVars.saturation(phaseIdx), - /*Diffusion coefficient*/ 1.0); - - const auto facetVolVars = data.facetVolVars(fvGeometry); - const auto outsideFactor = EffDiffModel::effectiveDiffusivity(facetVolVars.porosity(), - facetVolVars.saturation(phaseIdx), - /*Diffusion coefficient*/ 1.0); - - return harmonicMean(factor, outsideFactor); - } - - // use the harmonic mean between inside and outside - const auto& insideVolVars = elemVolVars[scvf.insideScvIdx()]; - const auto factor = EffDiffModel::effectiveDiffusivity(insideVolVars.porosity(), - insideVolVars.saturation(phaseIdx), - /*Diffusion coefficient*/ 1.0); - - if (!scvf.boundary()) - { - // interpret outside factor as arithmetic mean - Scalar outsideFactor = 0.0; - for (auto outsideIdx : scvf.outsideScvIndices()) - { - const auto& outsideVolVars = elemVolVars[outsideIdx]; - outsideFactor += EffDiffModel::effectiveDiffusivity(outsideVolVars.porosity(), - outsideVolVars.saturation(phaseIdx), - /*Diffusion coefficient*/ 1.0); - } - outsideFactor /= scvf.outsideScvIndices().size(); - - // use the harmonic mean of the two - return harmonicMean(factor, outsideFactor); - } - - return factor; - } - - template<typename GetXFunction> - static Scalar computeInteriorBoundaryContribution(const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const FluxVariablesCache& fluxVarsCache, - const GetXFunction& getX, - unsigned int phaseIdx, unsigned int compIdx) - { - // obtain the transmissibilites associated with all pressures - const auto& tij = fluxVarsCache.diffusionTij(phaseIdx, compIdx); - - // the interior dirichlet boundaries local indices start after - // the cell and the domain Dirichlet boundary pressures - const auto startIdx = fluxVarsCache.diffusionVolVarsStencil(phaseIdx, compIdx).size(); - - // The vector of interior neumann fluxes - const auto& cij = fluxVarsCache.diffusionCij(phaseIdx, compIdx); - CoefficientVector facetCouplingFluxes(cij.size(), 0.0); - - // add interior Dirichlet boundary contributions - Scalar flux = 0.0; - for (auto&& data : fluxVarsCache.interiorBoundaryData()) - { - // Add additional Dirichlet fluxes for interior Dirichlet faces - if (data.faceType() == MpfaFaceTypes::interiorDirichlet) - flux += tij[startIdx + data.localIndexInInteractionVolume()]*getX(data.facetVolVars(fvGeometry)); - - // add neumann contributions - if (data.faceType() == MpfaFaceTypes::interiorNeumann) - { - // get the scvf corresponding to actual interior neumann face - const auto& curScvf = fvGeometry.scvf(data.scvfIndex()); - - // get the volvars of the actual interior neumann face - const auto facetVolVars = data.facetVolVars(fvGeometry, curScvf); - - // calculate "leakage factor" - const auto n = curScvf.unitOuterNormal(); - const auto v = [&] () - { - auto res = n; - res *= -0.5*facetVolVars.extrusionFactor(); - res += curScvf.ipGlobal(); - res -= curScvf.facetCorner(); - res /= res.two_norm2(); - return res; - } (); - - // add value to vector of interior neumann fluxes - facetCouplingFluxes[data.localIndexInInteractionVolume()] += getX(facetVolVars)* - curScvf.area()* - elemVolVars[curScvf.insideScvIdx()].extrusionFactor()* - MpfaHelper::nT_M_v(n, facetVolVars.diffusionCoefficient(phaseIdx, compIdx), v); - } - } - - return flux + cij*facetCouplingFluxes; - } -}; - -} // end namespace - -#endif diff --git a/dumux/mixeddimension/facet/mpfa/fourierslaw.hh b/dumux/mixeddimension/facet/mpfa/fourierslaw.hh deleted file mode 100644 index 402ad57c4274b803a76c2a0d7f3d2422631ce33e..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/facet/mpfa/fourierslaw.hh +++ /dev/null @@ -1,210 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \brief This file contains the data which is required to calculate - * heat conduction fluxes with Fourier's law for cell-centered MPFA models - * in the presence of lower dimensional (coupled) elements living on this - * domain's element facets. - */ -#ifndef DUMUX_DISCRETIZATION_CC_MPFA_FACET_FOURIERS_LAW_HH -#define DUMUX_DISCRETIZATION_CC_MPFA_FACET_FOURIERS_LAW_HH - -#include <dumux/discretization/cellcentered/mpfa/fourierslaw.hh> -#include <dumux/discretization/cellcentered/mpfa/facetypes.hh> - -namespace Dumux -{ - -/*! - * \ingroup FouriersLaw - * \brief Specialization of Fourier's Law for the CCMpfa method with lower dimensional - * elements living on the bulk elements' facets. - */ -template <class TypeTag> -class CCMpfaFacetCouplingFouriersLaw : public FouriersLawImplementation<TypeTag, DiscretizationMethods::CCMpfa> -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using MpfaHelper = typename GET_PROP_TYPE(TypeTag, MpfaHelper); - using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); - using ElementFluxVarsCache = typename GET_PROP_TYPE(TypeTag, ElementFluxVariablesCache); - using FluxVariablesCache = typename GET_PROP_TYPE(TypeTag, FluxVariablesCache); - using ThermalConductivityModel = typename GET_PROP_TYPE(TypeTag, ThermalConductivityModel); - - // Always use the dynamic type for vectors (compatibility with the boundary) - using BoundaryInteractionVolume = typename GET_PROP_TYPE(TypeTag, BoundaryInteractionVolume); - using CoefficientVector = typename BoundaryInteractionVolume::Vector; - - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using IndexType = typename GridView::IndexSet::IndexType; - - static constexpr bool useTpfaBoundary = GET_PROP_VALUE(TypeTag, UseTpfaBoundary); - static constexpr bool enableInteriorBoundaries = GET_PROP_VALUE(TypeTag, EnableInteriorBoundaries); - - static constexpr int energyEqIdx = GET_PROP_TYPE(TypeTag, Indices)::energyEqIdx; - - //! The cache used in conjunction with the mpfa Fourier's Law - class MpfaFacetCouplingFouriersLawCache - { - using Stencil = typename BoundaryInteractionVolume::GlobalIndexSet; - public: - // update cached objects for heat conduction - template<typename InteractionVolume> - void updateHeatConduction(const InteractionVolume& iv, const SubControlVolumeFace &scvf) - { - const auto& localFaceData = iv.getLocalFaceData(scvf); - heatConductionVolVarsStencil_ = iv.volVarsStencil(); - heatConductionTij_ = iv.getTransmissibilities(localFaceData); - heatNeumannFlux_ = iv.getNeumannFlux(localFaceData, energyEqIdx); - heatConductionCij_ = iv.getNeumannFluxTransformationCoefficients(localFaceData); - } - - //! Returns the volume variables indices necessary for heat conduction flux - //! computation. This includes all participating boundary volume variables - //! and it can be different for the phases & components. - const Stencil& heatConductionVolVarsStencil() const - { return heatConductionVolVarsStencil_; } - - //! Returns the transmissibilities associated with the volume variables - //! This can be different for the phases & components. - const CoefficientVector& heatConductionTij() const - { return heatConductionTij_; } - - //! Returns the vector of coefficients with which the vector of neumann boundary conditions - //! has to be multiplied in order to transform them on the scvf this cache belongs to - const CoefficientVector& heatConductionCij() const - { return heatConductionCij_; } - - //! If the useTpfaBoundary property is set to false, the boundary conditions - //! are put into the local systems leading to possible contributions on all faces - Scalar heatNeumannFlux() const - { return heatNeumannFlux_; } - - private: - // Quantities associated with heat conduction - Stencil heatConductionVolVarsStencil_; - CoefficientVector heatConductionTij_; - CoefficientVector heatConductionCij_; - Scalar heatNeumannFlux_; - }; - -public: - // state the discretization method this implementation belongs to - static const DiscretizationMethods myDiscretizationMethod = DiscretizationMethods::CCMpfa; - - // state the new type for the corresponding cache - using Cache = MpfaFacetCouplingFouriersLawCache; - - static Scalar flux(const Problem& problem, - const Element& element, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const SubControlVolumeFace& scvf, - const ElementFluxVarsCache& elemFluxVarsCache) - { - const auto& fluxVarsCache = elemFluxVarsCache[scvf]; - const auto& volVarsStencil = fluxVarsCache.heatConductionVolVarsStencil(); - const auto& tij = fluxVarsCache.heatConductionTij(); - - // calculate Tij*tj - Scalar flux(0.0); - unsigned int localIdx = 0; - for (const auto volVarIdx : volVarsStencil) - flux += tij[localIdx++]*elemVolVars[volVarIdx].temperature(); - - // if no interior boundaries are present, return heat conduction flux - if (!enableInteriorBoundaries) - return useTpfaBoundary ? flux : flux + fluxVarsCache.heatNeumannFlux(); - - // Handle interior boundaries - flux += computeInteriorBoundaryContribution(fvGeometry, elemVolVars, fluxVarsCache); - - // return overall resulting flux - return useTpfaBoundary ? flux : flux + fluxVarsCache.heatNeumannFlux(); - } - - static Scalar computeInteriorBoundaryContribution(const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const FluxVariablesCache& fluxVarsCache) - { - // obtain the transmissibilites associated with all pressures - const auto& tij = fluxVarsCache.heatConductionTij(); - - // the interior dirichlet boundaries local indices start after - // the cell and the domain Dirichlet boundary pressures - const auto startIdx = fluxVarsCache.heatConductionVolVarsStencil().size(); - - // The vector of interior neumann fluxes - const auto& cij = fluxVarsCache.heatConductionCij(); - CoefficientVector facetCouplingFluxes(cij.size(), 0.0); - - // add interior Dirichlet boundary contributions - Scalar flux = 0.0; - for (auto&& data : fluxVarsCache.interiorBoundaryData()) - { - // Add additional Dirichlet fluxes for interior Dirichlet faces - if (data.faceType() == MpfaFaceTypes::interiorDirichlet) - flux += tij[startIdx + data.localIndexInInteractionVolume()]*data.facetVolVars(fvGeometry).temperature(); - - // add neumann contributions - if (data.faceType() == MpfaFaceTypes::interiorNeumann) - { - // get the scvf corresponding to actual interior neumann face - const auto& curScvf = fvGeometry.scvf(data.scvfIndex()); - - // get the volvars of the actual interior neumann face - const auto completeFacetData = data.completeCoupledFacetData(fvGeometry); - - // calculate "leakage factor" - const auto n = curScvf.unitOuterNormal(); - const auto v = [&] () - { - auto res = n; - res *= -0.5*completeFacetData.volVars().extrusionFactor(); - res += curScvf.ipGlobal(); - res -= curScvf.facetCorner(); - res /= res.two_norm2(); - return res; - } (); - - // get the thermal conductivity in the facet element - const auto facetLambda = ThermalConductivityModel::effectiveThermalConductivity(completeFacetData.volVars(), - completeFacetData.spatialParams(), - completeFacetData.element(), - completeFacetData.fvGeometry(), - completeFacetData.scv()); - // add value to vector of interior neumann fluxes - facetCouplingFluxes[data.localIndexInInteractionVolume()] += completeFacetData.volVars().temperature()* - curScvf.area()* - elemVolVars[curScvf.insideScvIdx()].extrusionFactor()* - MpfaHelper::nT_M_v(n, facetLambda, v); - } - } - - return flux + cij*facetCouplingFluxes; - } -}; - -} // end namespace Dumux - -#endif diff --git a/dumux/mixeddimension/facet/mpfa/interactionvolume.hh b/dumux/mixeddimension/facet/mpfa/interactionvolume.hh deleted file mode 100644 index a0831c8a92a69113433480d9861103dc26d9a062..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/facet/mpfa/interactionvolume.hh +++ /dev/null @@ -1,148 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \brief Base classes for interaction volumes of mpfa models with active coupling over the element facets. - */ -#ifndef DUMUX_MIXEDDIMENSION_FACET_MPFA_O_INTERACTIONVOLUME_HH -#define DUMUX_MIXEDDIMENSION_FACET_MPFA_O_INTERACTIONVOLUME_HH - -#include <dumux/discretization/cellcentered/mpfa/interactionvolume.hh> -#include <dumux/discretization/cellcentered/mpfa/facetypes.hh> -#include <dumux/discretization/cellcentered/mpfa/methods.hh> - -namespace Dumux -{ -//! Forward declaration -template<class TypeTag> class CCMpfaOFacetCouplingInteractionVolume; - -//! Specialization of the interaction volume traits class for the o-method in coupled models -template<class TypeTag> -class CCMpfaOFacetCouplingInteractionVolumeTraits : public CCMpfaOInteractionVolumeTraits<TypeTag> -{ -public: - using BoundaryInteractionVolume = CCMpfaOFacetCouplingInteractionVolume<TypeTag>; -}; - -// the o-method interaction volume is substituted by the one including data on the facet element's -// tensorial quantities into the local system to be solved. -template<class TypeTag> -class CCMpfaOFacetCouplingInteractionVolume : public CCMpfaOInteractionVolume<TypeTag, - CCMpfaOFacetCouplingInteractionVolumeTraits<TypeTag>, - CCMpfaOFacetCouplingInteractionVolume<TypeTag>> -{ - using Traits = CCMpfaOFacetCouplingInteractionVolumeTraits<TypeTag>; - using ThisType = CCMpfaOFacetCouplingInteractionVolume<TypeTag>; - using ParentType = CCMpfaOInteractionVolume<TypeTag, Traits, ThisType>; - - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using MpfaHelper = typename GET_PROP_TYPE(TypeTag, MpfaHelper); - using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); - using InteriorBoundaryData = typename GET_PROP_TYPE(TypeTag, InteriorBoundaryData); - using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); - - using LocalScvfType = typename Traits::LocalScvfType; - - static constexpr bool useTpfaBoundary = GET_PROP_VALUE(TypeTag, UseTpfaBoundary); - -public: - using typename ParentType::LocalIndexType; - using typename ParentType::Seed; - - CCMpfaOFacetCouplingInteractionVolume(const Seed& seed, - const Problem& problem, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars) - : ParentType(seed, problem, fvGeometry, elemVolVars) - {} - -public: - // We include data on the tensorial quantities of the facet elements here - template<typename GetTensorFunction> - Scalar interiorNeumannTerm(const GetTensorFunction& getTensor, - const Element& element, - const LocalScvfType& localScvf, - const InteriorBoundaryData& data) const - { - // obtain the complete data on the facet element - const auto completeFacetData = data.completeCoupledFacetData(this->fvGeometry_()); - - // calculate "leakage factor" - const auto n = localScvf.unitOuterNormal(); - const auto v = [&] () - { - auto res = n; - res *= -0.5*completeFacetData.volVars().extrusionFactor(); - res += localScvf.ip(); - res -= localScvf.globalScvf().facetCorner(); - res /= res.two_norm2(); - return res; - } (); - - // substract (n*T*v)*Area from diagonal matrix entry - const auto facetTensor = getTensor(completeFacetData.problem(), - completeFacetData.element(), - completeFacetData.volVars(), - completeFacetData.fvGeometry(), - completeFacetData.scv()); - - return localScvf.area()* - this->elemVolVars_()[localScvf.insideGlobalScvIndex()].extrusionFactor()* - MpfaHelper::nT_M_v(n, facetTensor, v); - } - - void assembleNeumannFluxVector() - { - // initialize the neumann fluxes vector to zero - this->neumannFluxes_.resize(this->fluxFaceIndexSet_.size(), PrimaryVariables(0.0)); - - if (!this->onDomainOrInteriorBoundary() || useTpfaBoundary) - return; - - LocalIndexType fluxFaceIdx = 0; - for (auto localFluxFaceIdx : this->fluxFaceIndexSet_) - { - const auto& localScvf = this->localScvf_(localFluxFaceIdx); - const auto faceType = localScvf.faceType(); - - if (faceType == MpfaFaceTypes::neumann) - { - const auto& element = this->localElement_(localScvf.insideLocalScvIndex()); - const auto& globalScvf = this->fvGeometry_().scvf(localScvf.insideGlobalScvfIndex()); - auto neumannFlux = this->problem_().neumann(element, this->fvGeometry_(), this->elemVolVars_(), globalScvf); - neumannFlux *= globalScvf.area(); - neumannFlux *= this->elemVolVars_()[globalScvf.insideScvIdx()].extrusionFactor(); - - // The flux is assumed to be prescribed in the form of -D*gradU - this->neumannFluxes_[fluxFaceIdx] = neumannFlux; - } - - fluxFaceIdx++; - } - } -}; - -} // end namespace - -#endif diff --git a/dumux/mixeddimension/facet/mpfa/interiorboundarydata.hh b/dumux/mixeddimension/facet/mpfa/interiorboundarydata.hh deleted file mode 100644 index 43d75d32d1331a4a975d49f7548e5e30d5bd262a..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/facet/mpfa/interiorboundarydata.hh +++ /dev/null @@ -1,201 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \brief A class to store info on interior boundaries - */ -#ifndef DUMUX_DISCRETIZATION_CC_MPFA_FACET_INTERIORBOUNDARYDATA_HH -#define DUMUX_DISCRETIZATION_CC_MPFA_FACET_INTERIORBOUNDARYDATA_HH - -#include <dumux/discretization/cellcentered/mpfa/facetypes.hh> -#include <dumux/mixeddimension/properties.hh> - -namespace Dumux -{ - -template<class TypeTag> -class CCMpfaFacetCouplingInteriorBoundaryData -{ - // types associated with the low dim domain - using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(GlobalProblemTypeTag, LowDimProblemTypeTag); - - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using SpatialParams = typename GET_PROP_TYPE(TypeTag, SpatialParams); - using VolumeVariables = typename GET_PROP_TYPE(TypeTag, VolumeVariables); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); - using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); - using BoundaryInteractionVolume = typename GET_PROP_TYPE(TypeTag, BoundaryInteractionVolume); - - using IndexType = typename GridView::IndexSet::IndexType; - using LocalIndexType = typename BoundaryInteractionVolume::LocalIndexType; - - using LowDimProblem = typename GET_PROP_TYPE(LowDimProblemTypeTag, Problem); - using LowDimSpatialParams = typename GET_PROP_TYPE(LowDimProblemTypeTag, SpatialParams); - using LowDimVolumeVariables = typename GET_PROP_TYPE(LowDimProblemTypeTag, VolumeVariables); - using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); - using LowDimElement = typename LowDimGridView::template Codim<0>::Entity; - using LowDimFVElementGeometry = typename GET_PROP_TYPE(LowDimProblemTypeTag, FVElementGeometry); - using LowDimSubControlVolume = typename GET_PROP_TYPE(LowDimProblemTypeTag, SubControlVolume); - - //! Dummy type for the CompleteCoupledFacetData struct. - //! Implementations need to have at least the provided interfaces. - //! Note that the return types are also "wrong" (Here just to satisfy the compiler) - struct CompleteCoupledFacetData - { - const LowDimProblem& problem() const - { return *lowDimProblemPtr_; } - - const LowDimSpatialParams& spatialParams() const - { return *lowDimSpatialParamsPtr_; } - - const LowDimVolumeVariables& volVars() const - { return lowDimVolVars_; } - - const LowDimElement& element() const - { return lowDimElement_;} - - const LowDimFVElementGeometry& fvGeometry() const - { return lowDimFvGeometry_; } - - const LowDimSubControlVolume& scv() const - { return lowDimScv_; } - - CompleteCoupledFacetData(const LowDimProblem& problem, - const IndexType elementIndex, - LowDimElement&& element, - LowDimFVElementGeometry&& fvGeometry, - LowDimVolumeVariables&& volVars) - : lowDimProblemPtr_(&problem), - lowDimSpatialParamsPtr_(&problem.spatialParams()), - lowDimElement_(std::move(element)), - lowDimFvGeometry_(std::move(fvGeometry)), - lowDimVolVars_(std::move(volVars)), - lowDimScv_(lowDimFvGeometry_.scv(elementIndex)) - {} - - private: - const LowDimProblem* lowDimProblemPtr_; - const LowDimSpatialParams* lowDimSpatialParamsPtr_; - - LowDimElement lowDimElement_; - LowDimFVElementGeometry lowDimFvGeometry_; - LowDimVolumeVariables lowDimVolVars_; - const LowDimSubControlVolume& lowDimScv_; - }; - -public: - //! the constructor - CCMpfaFacetCouplingInteriorBoundaryData(const Problem& problem, - IndexType elementIndex, - IndexType scvfIndex, - LocalIndexType localIndex, - MpfaFaceTypes faceType) - : problemPtr_(&problem), - elementIndex_(elementIndex), - scvfIndex_(scvfIndex), - localIndex_(localIndex), - faceType_(faceType) - {} - - //! returns the global index of the element/scv connected to the interior boundary - IndexType elementIndex() const - { return elementIndex_; } - - //! returns the global index of the scvf connected to the interior boundary - IndexType scvfIndex() const - { return scvfIndex_; } - - //! returns the local index i of the scvf within the interaction volume. - //! This is either: - //! - the i-th flux face index (interior neumann boundaries) - //! - the i-th interior dirichlet face (interior dirichlet boundaries) - LocalIndexType localIndexInInteractionVolume() const - { return localIndex_; } - - //! returns the face type of this scvf - MpfaFaceTypes faceType() const - { return faceType_; } - - //! returns the volume variables for interior dirichlet boundaries - LowDimVolumeVariables facetVolVars(const FVElementGeometry& fvGeometry) const - { - return problem_().couplingManager().lowDimVolVars(problem_().model().fvGridGeometry().element(elementIndex()), - fvGeometry, - fvGeometry.scvf(scvfIndex())); - } - - //! returns the volume variables for interior dirichlet boundaries - LowDimVolumeVariables facetVolVars(const FVElementGeometry& fvGeometry, const SubControlVolumeFace& scvf) const - { - assert(scvf.index() == scvfIndex() && "calling facet volume variables for an scvf other than the bound one"); - return problem_().couplingManager().lowDimVolVars(problem_().model().fvGridGeometry().element(elementIndex()), - fvGeometry, - scvf); - } - - //! The following interface is here for compatibility reasonsto be overloaded for problems using facet coupling. - //! prepares all the necessary variables of the other domain. - //! Note that also an implementation of the CompleteFacetData structure has to be provided. - CompleteCoupledFacetData completeCoupledFacetData(const FVElementGeometry& fvGeometry) const - { - const auto& couplingMapper = problem_().couplingManager().couplingMapper(); - - // get coupling data for this scvf - const auto element = problem_().model().fvGridGeometry().element(elementIndex()); - const auto& scvfCouplingData = couplingMapper.getBulkCouplingData(element).getScvfCouplingData(fvGeometry.scvf(scvfIndex())); - - // obtain data necessary to fully instantiate the complete coupled facet data - assert(scvfCouplingData.first && "no coupled facet element found for given scvf!"); - const auto& lowDimProblem = problem_().couplingManager().lowDimProblem(); - - auto lowDimElement = lowDimProblem.model().fvGridGeometry().element(scvfCouplingData.second); - auto lowDimFvGeometry = localView(lowDimProblem.model().fvGridGeometry()); - lowDimFvGeometry.bindElement(lowDimElement); - - LowDimVolumeVariables lowDimVolVars; - lowDimVolVars.update(lowDimProblem.model().elementSolution(lowDimElement, lowDimProblem.model().curSol()), - lowDimProblem, - lowDimElement, - lowDimFvGeometry.scv(scvfCouplingData.second)); - - return CompleteCoupledFacetData(lowDimProblem, - scvfCouplingData.second, - std::move(lowDimElement), - std::move(lowDimFvGeometry), - std::move(lowDimVolVars)); - } - -private: - const Problem& problem_() const - { return *problemPtr_; } - - const Problem* problemPtr_; - - IndexType elementIndex_; - IndexType scvfIndex_; - LocalIndexType localIndex_; - MpfaFaceTypes faceType_; -}; -} // end namespace - -#endif diff --git a/dumux/mixeddimension/facet/mpfa/properties.hh b/dumux/mixeddimension/facet/mpfa/properties.hh deleted file mode 100644 index 78fad39a0f17e9e4a17f1a6f796caf3381a1713e..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/facet/mpfa/properties.hh +++ /dev/null @@ -1,68 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup MixedDimension - * \brief Base properties for the bulk problems in mixed dimensional models - * with a lower dimensional model living on the element facets. - */ - -#ifndef DUMUX_FACET_MIXEDDIMENSION_PROPERTIES_HH -#define DUMUX_FACET_MIXEDDIMENSION_PROPERTIES_HH - -#include <dumux/mixeddimension/subproblemproperties.hh> -#include <dumux/mixeddimension/facet/mpfa/interactionvolume.hh> -#include <dumux/mixeddimension/facet/mpfa/interiorboundarydata.hh> -#include <dumux/mixeddimension/facet/mpfa/darcyslaw.hh> -#include <dumux/mixeddimension/facet/mpfa/fickslaw.hh> -#include <dumux/mixeddimension/facet/mpfa/fourierslaw.hh> - -namespace Dumux -{ - -namespace Properties -{ -NEW_TYPE_TAG(FacetCouplingBulkMpfaModel, INHERITS_FROM(CCMpfaModel)); - -//! The boundary interaction volume class (we use the facet coupling specialized o-method interaction volume) -SET_TYPE_PROP(FacetCouplingBulkMpfaModel, BoundaryInteractionVolume, CCMpfaOFacetCouplingInteractionVolume<TypeTag>); - -//! The interior boundary data class -SET_TYPE_PROP(FacetCouplingBulkMpfaModel, InteriorBoundaryData, CCMpfaFacetCouplingInteriorBoundaryData<TypeTag>); - -//! Ẃe always enable interior boundaries -SET_BOOL_PROP(FacetCouplingBulkMpfaModel, EnableInteriorBoundaries, true); - -//! Facet coupling is always true here -SET_BOOL_PROP(FacetCouplingBulkMpfaModel, MpfaFacetCoupling, true); - -//! Darcy's Law -SET_TYPE_PROP(FacetCouplingBulkMpfaModel, AdvectionType, CCMpfaFacetCouplingDarcysLaw<TypeTag>); - -//! Ficks's Law -SET_TYPE_PROP(FacetCouplingBulkMpfaModel, MolecularDiffusionType, CCMpfaFacetCouplingFicksLaw<TypeTag>); - -//! Fourier's Law -SET_TYPE_PROP(FacetCouplingBulkMpfaModel, HeatConductionType, CCMpfaFacetCouplingFouriersLaw<TypeTag>); - -}//end namespace Properties - -}//end namespace Dumux - -#endif diff --git a/dumux/mixeddimension/facet/start.hh b/dumux/mixeddimension/facet/start.hh deleted file mode 100644 index 8c47579921221158999e3b1f35d6cbccddfecb6c..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/facet/start.hh +++ /dev/null @@ -1,193 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \brief Provides a few default main functions for convenience. - */ -#ifndef DUMUX_MIXEDDIMENSION_FACET_START_HH -#define DUMUX_MIXEDDIMENSION_FACET_START_HH - -#include <ctime> -#include <iostream> - -#include <dune/common/parallel/mpihelper.hh> -#include <dune/grid/io/file/dgfparser/dgfexception.hh> - -#include <dumux/common/propertysystem.hh> -#include <dumux/common/parameters.hh> -#include <dumux/common/dumuxmessage.hh> -#include <dumux/common/defaultusagemessage.hh> - -namespace Dumux -{ - -/*! - * \ingroup Start - * - * \brief Provides a main function which reads in parameters from the - * command line and a parameter file. - * - * \tparam TypeTag The type tag of the problem which needs to be solved - * - * \param argc The 'argc' argument of the main function: count of arguments (1 if there are no arguments) - * \param argv The 'argv' argument of the main function: array of pointers to the argument strings - * \param usage Callback function for printing the usage message - */ -template <class TypeTag> -int start_(int argc, - char **argv, - void (*usage)(const char *, const std::string &)) -{ - // some aliases for better readability - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using GridCreator = typename GET_PROP_TYPE(TypeTag, GridCreator); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using ParameterTree = typename GET_PROP(TypeTag, ParameterTree); - - // initialize MPI, finalize is done automatically on exit - const auto& mpiHelper = Dune::MPIHelper::instance(argc, argv); - - // print dumux start message - if (mpiHelper.rank() == 0) - DumuxMessage::print(/*firstCall=*/true); - - //////////////////////////////////////////////////////////// - // parse the command line arguments and input file - //////////////////////////////////////////////////////////// - - // if the user just wanted to see the help / usage message show usage and stop program - if(!ParameterParser::parseCommandLineArguments(argc, argv, ParameterTree::tree(), usage)) - { - usage(argv[0], defaultUsageMessage(argv[0])); - return 0; - } - // parse the input file into the parameter tree - // check first if the user provided an input file through the command line, if not use the default - const auto parameterFileName = ParameterTree::tree().hasKey("ParameterFile") ? GET_RUNTIME_PARAM(TypeTag, std::string, ParameterFile) : ""; - ParameterParser::parseInputFile(argc, argv, ParameterTree::tree(), parameterFileName, usage); - - //////////////////////////////////////////////////////////// - // check for some user debugging parameters - //////////////////////////////////////////////////////////// - - bool printProps = false; // per default don't print all properties - if (ParameterTree::tree().hasKey("PrintProperties") || ParameterTree::tree().hasKey("TimeManager.PrintProperties")) - printProps = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, bool, TimeManager, PrintProperties); - - if (printProps && mpiHelper.rank() == 0) - Properties::print<TypeTag>(); - - bool printParams = true; // per default print all properties - if (ParameterTree::tree().hasKey("PrintParameters") || ParameterTree::tree().hasKey("TimeManager.PrintParameters")) - printParams = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, bool, TimeManager, PrintParameters); - - ////////////////////////////////////////////////////////////////////// - // try to create a grid (from the given grid file or the input file) - ///////////////////////////////////////////////////////////////////// - - try { GridCreator::makeGrid(); } - catch (...) { - std::string usageMessage = "\n\t -> Creation of the grid failed! <- \n\n"; - usageMessage += defaultUsageMessage(argv[0]); - usage(argv[0], usageMessage); - throw; - } - GridCreator::loadBalance(); - - ////////////////////////////////////////////////////////////////////// - // run the simulation - ///////////////////////////////////////////////////////////////////// - - // read the initial time step and the end time (mandatory parameters) - auto tEnd = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, TEnd); - auto dt = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, DtInitial); - - // check if we are about to restart a previously interrupted simulation - bool restart = false; - Scalar restartTime = 0; - if (ParameterTree::tree().hasKey("Restart") || ParameterTree::tree().hasKey("TimeManager.Restart")) - { - restart = true; - restartTime = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, Restart); - } - - // instantiate and run the problem - TimeManager timeManager; - Problem problem(timeManager, GridCreator::bulkGrid().leafGridView(), GridCreator::lowDimGrid().leafGridView()); - timeManager.init(problem, restartTime, dt, tEnd, restart); - timeManager.run(); - - // print dumux end message and maybe the parameters for debugging - if (mpiHelper.rank() == 0) - { - DumuxMessage::print(/*firstCall=*/false); - - if (printParams) - Parameters::print<TypeTag>(); - } - - return 0; -} - -/*! - * \ingroup Start - * - * \brief Provides a main function with error handling - * - * \tparam TypeTag The type tag of the problem which needs to be solved - * - * \param argc The number of command line arguments of the program - * \param argv The contents of the command line arguments of the program - * \param usage Callback function for printing the usage message - */ -template <class TypeTag> -int start(int argc, - char **argv, - void (*usage)(const char *, const std::string &)) -{ - try { - return start_<TypeTag>(argc, argv, usage); - } - catch (ParameterException &e) { - Parameters::print<TypeTag>(); - std::cerr << std::endl << e << ". Abort!" << std::endl; - return 1; - } - catch (Dune::DGFException & e) { - std::cerr << "DGF exception thrown (" << e << - "). Most likely, the DGF file name is wrong " - "or the DGF file is corrupted, " - "e.g. missing hash at end of file or wrong number (dimensions) of entries." - << std::endl; - return 2; - } - catch (Dune::Exception &e) { - std::cerr << "Dune reported error: " << e << std::endl; - return 3; - } - catch (...) { - std::cerr << "Unknown exception thrown!\n"; - return 4; - } -} - -} // end namespace Dumux - -#endif diff --git a/dumux/mixeddimension/glue/CMakeLists.txt b/dumux/mixeddimension/glue/CMakeLists.txt deleted file mode 100644 index 726d4493a65cc1c0da954a0b254dffa6ffef3217..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/glue/CMakeLists.txt +++ /dev/null @@ -1,3 +0,0 @@ -install(FILES -glue.hh -DESTINATION ${CMAKE_INSTALL_INCLUDEDIR}/dumux/mixeddimension/glue) diff --git a/dumux/mixeddimension/glue/glue.hh b/dumux/mixeddimension/glue/glue.hh deleted file mode 100644 index 644c69f1b86097d8f20e6cb599ede03d25d441f9..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/glue/glue.hh +++ /dev/null @@ -1,268 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup EmbeddedCoupling - * \brief A class glueing two grids of different dimension geometrically - * Intersections are computed using axis-aligned bounding box trees - */ - -#ifndef DUMUX_MULTIDIMENSION_GLUE_HH -#define DUMUX_MULTIDIMENSION_GLUE_HH - -#include <iostream> -#include <fstream> -#include <string> -#include <utility> - -#include <dune/common/timer.hh> -#include <dune/common/iteratorrange.hh> -#include <dune/geometry/affinegeometry.hh> - -#include <dumux/common/geometrycollision.hh> -#include <dumux/common/boundingboxtree.hh> - -namespace Dumux -{ - -namespace Properties -{ -// Property forward declarations -NEW_PROP_TAG(BulkProblemTypeTag); -NEW_PROP_TAG(LowDimProblemTypeTag); -NEW_PROP_TAG(GridView); -} // namespace Properties - -// forward declaration -template<class TypeTag> -class CCMultiDimensionGlue; - -//! Range generator to iterate with range-based for loops over all intersections -//! as follows: for (const auto& is : intersections(glue)) { ... } -template<typename TypeTag> -Dune::IteratorRange<typename CCMultiDimensionGlue<TypeTag>::Intersections::const_iterator> -intersections(const CCMultiDimensionGlue<TypeTag>& glue) -{ return {glue.ibegin(), glue.iend()}; } - -namespace Glue -{ - -template<class TypeTag> -class Intersection -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - - // obtain the type tags of the sub problems - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); - using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); - - enum { - bulkDim = BulkGridView::dimension, - lowDimDim = LowDimGridView::dimension, - dimWorld = BulkGridView::dimensionworld, - dimIs = LowDimGridView::dimension, - }; - - using BulkElement = typename BulkGridView::template Codim<0>::Entity; - using LowDimElement = typename LowDimGridView::template Codim<0>::Entity; - - using LowDimTree = Dumux::BoundingBoxTree<LowDimGridView>; - using BulkTree = Dumux::BoundingBoxTree<BulkGridView>; - - using Geometry = Dune::AffineGeometry<Scalar, dimIs, dimWorld>; - using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; - -public: - Intersection(const BulkTree& bulkTree, const LowDimTree& lowDimTree) - : bulkTree_(bulkTree), lowDimTree_(lowDimTree) {} - - //! set the intersection geometry corners - void setCorners(const std::vector<GlobalPosition>& corners) - { - corners_ = corners; - assert(corners.size() == dimIs + 1); - type_.makeSimplex(dimIs); - } - - //! add a pair of neighbor elements - void addNeighbors(unsigned int bulk, unsigned int lowDim) - { - neighbors_[0].push_back(bulk); - neighbors_[1].push_back(lowDim); - } - - //! get the intersection geometry - Geometry geometry() const - { return Geometry(type_, corners_); } - - //! get the number of neigbors - std::size_t neighbor(unsigned int side) const - { return neighbors_[side].size(); } - - //! get the inside neighbor - LowDimElement inside(unsigned int n) const - { return lowDimTree_.entity(neighbors_[1][n]); } - - //! get the outside neighbor - BulkElement outside(unsigned int n) const - { return bulkTree_.entity(neighbors_[0][n]); } - -private: - std::array<std::vector<unsigned int>, 2> neighbors_; - std::vector<GlobalPosition> corners_; - Dune::GeometryType type_; - - const BulkTree& bulkTree_; - const LowDimTree& lowDimTree_; -}; -} - -/*! - * \ingroup EmbeddedCoupling - * \ingroup CCModel - * \brief Manages the coupling between bulk elements and lower dimensional elements - * Point sources on each integration point are computed by an AABB tree. - * Both domain are assumed to be discretized using a cc finite volume scheme. - */ -template<class TypeTag> -class CCMultiDimensionGlue -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - - // obtain the type tags of the sub problems - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); - using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); - - using BulkProblem = typename GET_PROP_TYPE(BulkProblemTypeTag, Problem); - using LowDimProblem = typename GET_PROP_TYPE(LowDimProblemTypeTag, Problem); - - enum { - bulkDim = BulkGridView::dimension, - lowDimDim = LowDimGridView::dimension, - dimWorld = BulkGridView::dimensionworld - }; - - enum { - bulkIsBox = GET_PROP_VALUE(BulkProblemTypeTag, ImplicitIsBox), - lowDimIsBox = GET_PROP_VALUE(LowDimProblemTypeTag, ImplicitIsBox) - }; - - using BulkElement = typename BulkGridView::template Codim<0>::Entity; - using LowDimElement = typename LowDimGridView::template Codim<0>::Entity; - - using LowDimTree = Dumux::BoundingBoxTree<LowDimGridView>; - using BulkTree = Dumux::BoundingBoxTree<BulkGridView>; - - using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; - -public: - // export intersection container type - using Intersections = std::vector<Dumux::Glue::Intersection<TypeTag>>; - - /*! - * \brief Constructor - */ - CCMultiDimensionGlue(BulkProblem& bulkProblem, LowDimProblem& lowDimProblem) - : bulkProblem_(bulkProblem), lowDimProblem_(lowDimProblem) - { - // Check if we are using the cellcentered method in both domains - static_assert(!bulkIsBox && !lowDimIsBox, "Using the cell-centered glue for problems using box discretization!"); - } - - void build() - { - // Initialize the bulk and the lowdim bounding box tree - const auto& bulkTree = bulkProblem().boundingBoxTree(); - const auto& lowDimTree = lowDimProblem().boundingBoxTree(); - - // compute raw intersections - Dune::Timer timer; - auto rawIntersections = bulkTree.computeEntityCollisions(lowDimTree); - std::cout << "Computed tree intersections in " << timer.elapsed() << std::endl; - - // create a map to check whether intersection geometries were already inserted - std::vector<std::vector<std::vector<GlobalPosition>>> intersectionMap; - std::vector<std::vector<unsigned int>> intersectionIndex; - intersectionMap.resize(lowDimProblem().gridView().size(0)); - intersectionIndex.resize(lowDimProblem().gridView().size(0)); - - for (const auto& rawIntersection : rawIntersections) - { - bool add = true; - for (int i = 0; i < intersectionMap[rawIntersection.second()].size(); ++i) - { - if (rawIntersection.cornersMatch(intersectionMap[rawIntersection.second()][i])) - { - add = false; - // only add the pair of neighbors using the insertionIndex - auto idx = intersectionIndex[rawIntersection.second()][i]; - intersections_[idx].addNeighbors(rawIntersection.first(), rawIntersection.second()); - break; - } - } - if(add) - { - // add to the map - intersectionMap[rawIntersection.second()].push_back(rawIntersection.corners()); - intersectionIndex[rawIntersection.second()].push_back(intersections_.size()); - // add new intersection and add the neighbors - intersections_.emplace_back(bulkTree, lowDimTree); - intersections_.back().setCorners(rawIntersection.corners()); - intersections_.back().addNeighbors(rawIntersection.first(), rawIntersection.second()); - } - } - } - - //! Return a reference to the bulk problem - BulkProblem& bulkProblem() - { return bulkProblem_; } - - //! Return a reference to the low dimensional problem - LowDimProblem& lowDimProblem() - { return lowDimProblem_; } - - //! Return begin iterator to intersection container - typename Intersections::const_iterator ibegin() const - { return intersections_.begin(); } - - //! Return end iterator to intersection container - typename Intersections::const_iterator iend() const - { return intersections_.end(); } - - //! the number of intersections - std::size_t size() const - { return intersections_.size(); } - -private: - BulkProblem& bulkProblem_; - LowDimProblem& lowDimProblem_; - - Intersections intersections_; -}; - -} // namespace Dumux - -#endif diff --git a/dumux/mixeddimension/integrationpointsource.hh b/dumux/mixeddimension/integrationpointsource.hh deleted file mode 100644 index ecc268ba30e2cbb92f42a4f773de9b9d4722754f..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/integrationpointsource.hh +++ /dev/null @@ -1,185 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup EmbeddedCoupling - * \brief An integration point source class, - * i.e. sources located at a single point in space - * associated with a quadrature point - */ - -#ifndef DUMUX_INTEGRATION_POINTSOURCE_HH -#define DUMUX_INTEGRATION_POINTSOURCE_HH - -#include <dumux/common/pointsource.hh> - -namespace Dumux -{ - -/*! - * \ingroup EmbeddedCoupling - * \brief An integration point source class with an identifier to attach data - * and a quadrature weight and integration element - */ -template<class TypeTag, typename IdType> -class IntegrationPointSource : public Dumux::IdPointSource<TypeTag, IdType> -{ - using ParentType = Dumux::IdPointSource<TypeTag, IdType>; - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); - - static const int dimworld = GridView::dimensionworld; - using GlobalPosition = Dune::FieldVector<Scalar, dimworld>; - -public: - //! Constructor for integration point sources - IntegrationPointSource(GlobalPosition pos, PrimaryVariables values, IdType id, - Scalar qpweight, Scalar integrationElement, - const std::vector<unsigned int>& elementIndices) - : ParentType(pos, values, id), - qpweight_(qpweight), integrationElement_(integrationElement), - elementIndices_(elementIndices) {} - - //! Constructor for integration point sources, when there is no - // value known at the time of initialization - IntegrationPointSource(GlobalPosition pos, IdType id, - Scalar qpweight, Scalar integrationElement, - const std::vector<unsigned int>& elementIndices) - : ParentType(pos, id), - qpweight_(qpweight), integrationElement_(integrationElement), - elementIndices_(elementIndices) {} - - - Scalar quadratureWeight() const - { - return qpweight_; - } - - Scalar integrationElement() const - { - return integrationElement_; - } - - const std::vector<unsigned int>& elementIndices() const - { - return elementIndices_; - } - - //! Convenience = operator overload modifying only the values - IntegrationPointSource& operator= (const PrimaryVariables& values) - { - ParentType::operator=(values); - return *this; - } - - //! Convenience = operator overload modifying only the values - IntegrationPointSource& operator= (Scalar s) - { - ParentType::operator=(s); - return *this; - } - -private: - Scalar qpweight_; - Scalar integrationElement_; - std::vector<unsigned int> elementIndices_; -}; - -/*! - * \ingroup EmbeddedCoupling - * \brief A helper class calculating a DOF-index to point source map - */ -template<class TypeTag> -class IntegrationPointSourceHelper -{ - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using PointSource = typename GET_PROP_TYPE(TypeTag, PointSource); - - static const int dim = GridView::dimension; - static const int dimworld = GridView::dimensionworld; - - using BoundingBoxTree = Dumux::BoundingBoxTree<GridView>; - - enum { isBox = GET_PROP_VALUE(TypeTag, ImplicitIsBox) }; - enum { dofCodim = isBox ? dim : 0 }; - -public: - //! calculate a DOF index to point source map from given vector of point sources - static void computePointSourceMap(const Problem& problem, - const BoundingBoxTree& boundingBoxTree, - std::vector<PointSource>& sources, - std::map<std::pair<unsigned int, unsigned int>, std::vector<PointSource> >& pointSourceMap) - { - for (auto&& source : sources) - { - // compute in which elements the point source falls - std::vector<unsigned int> entities = source.elementIndices(); - // split the source values equally among all concerned entities - source.setEmbeddings(source.embeddings()*entities.size()); - // loop over all concernes elements - for (unsigned int eIdx : entities) - { - if(isBox) - { - // check in which subcontrolvolume(s) we are - const auto element = boundingBoxTree.entity(eIdx); - auto fvGeometry = localView(problem.model().fvGridGeometry()); - fvGeometry.bindElement(element); - const auto globalPos = source.position(); - // loop over all sub control volumes and check if the point source is inside - std::vector<unsigned int> scvIndices; - for (auto&& scv : scvs(fvGeometry)) - { - if (BoundingBoxTreeHelper<dimworld>::pointInGeometry(scv.geometry(), globalPos)) - scvIndices.push_back(scv.indexInElement()); - } - // for all scvs that where tested positiv add the point sources - // to the element/scv to point source map - for (auto scvIdx : scvIndices) - { - const auto key = std::make_pair(eIdx, scvIdx); - if (pointSourceMap.count(key)) - pointSourceMap.at(key).push_back(source); - else - pointSourceMap.insert({key, {source}}); - // split equally on the number of matched scvs - auto& s = pointSourceMap.at(key).back(); - s.setEmbeddings(scvIndices.size()*s.embeddings()); - } - } - else - { - // add the pointsource to the DOF map - const auto key = std::make_pair(eIdx, /*scvIdx=*/ 0); - if (pointSourceMap.count(key)) - pointSourceMap.at(key).push_back(source); - else - pointSourceMap.insert({key, {source}}); - } - } - } - } -}; - -} // end namespace Dumux - -#endif diff --git a/dumux/mixeddimension/model.hh b/dumux/mixeddimension/model.hh deleted file mode 100644 index bc806d13932eeb884937867d1c09e1f75e1a70f9..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/model.hh +++ /dev/null @@ -1,556 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup MixedDimension - * \brief Base class for the coupled models of mixed dimension - */ -#ifndef DUMUX_MIXEDDIMENSION_MODEL_HH -#define DUMUX_MIXEDDIMENSION_MODEL_HH - -#include <dune/geometry/type.hh> -#include <dune/istl/bvector.hh> - -#include <dumux/mixeddimension/properties.hh> -#include <dumux/mixeddimension/assembler.hh> -#include <dumux/mixeddimension/subproblemlocaljacobian.hh> -#include <dumux/mixeddimension/newtoncontroller.hh> -#include <dumux/implicit/adaptive/gridadaptproperties.hh> -#include <dumux/common/valgrind.hh> - -namespace Dumux -{ - -/*! - * \ingroup MixedDimension - * \brief The base class for implicit models of mixed dimension. - */ -template<class TypeTag> -class MixedDimensionModel -{ - using Implementation = typename GET_PROP_TYPE(TypeTag, Model); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using SolutionVector = typename GET_PROP_TYPE(TypeTag, SolutionVector); - using JacobianAssembler = typename GET_PROP_TYPE(TypeTag, JacobianAssembler); - using BulkLocalJacobian = typename GET_PROP_TYPE(TypeTag, BulkLocalJacobian); - using LowDimLocalJacobian = typename GET_PROP_TYPE(TypeTag, LowDimLocalJacobian); - using NewtonMethod = typename GET_PROP_TYPE(TypeTag, NewtonMethod); - using NewtonController = typename GET_PROP_TYPE(TypeTag, NewtonController); - using SubProblemBlockIndices = typename GET_PROP(TypeTag, SubProblemBlockIndices); - - // obtain the type tags of the sub problems - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); - using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); - - using BulkLocalResidual = typename GET_PROP_TYPE(BulkProblemTypeTag, LocalResidual); - using LowDimLocalResidual = typename GET_PROP_TYPE(LowDimProblemTypeTag, LocalResidual); - - using BulkVertexMapper = typename GET_PROP_TYPE(BulkProblemTypeTag, VertexMapper); - using LowDimVertexMapper = typename GET_PROP_TYPE(LowDimProblemTypeTag, VertexMapper); - - using BulkElementMapper = typename GET_PROP_TYPE(BulkProblemTypeTag, ElementMapper); - using LowDimElementMapper = typename GET_PROP_TYPE(LowDimProblemTypeTag, ElementMapper); - - enum { - bulkDim = BulkGridView::dimension, - lowDimDim = LowDimGridView::dimension, - dimWorld = BulkGridView::dimensionworld - }; - - enum { - bulkIsBox = GET_PROP_VALUE(BulkProblemTypeTag, ImplicitIsBox), - lowDimIsBox = GET_PROP_VALUE(LowDimProblemTypeTag, ImplicitIsBox), - bulkDofCodim = bulkIsBox ? bulkDim : 0, - lowDimDofCodim = lowDimIsBox ? lowDimDim : 0 - }; - - typename SubProblemBlockIndices::BulkIdx bulkIdx; - typename SubProblemBlockIndices::LowDimIdx lowDimIdx; - - using BulkElement = typename BulkGridView::template Codim<0>::Entity; - using LowDimElement = typename LowDimGridView::template Codim<0>::Entity; - - using BulkReferenceElements = Dune::ReferenceElements<Scalar, bulkDim>; - using LowDimReferenceElements = Dune::ReferenceElements<Scalar, lowDimDim>; - -public: - // copying a model is not a good idea - MixedDimensionModel(const MixedDimensionModel&) = delete; - - /*! - * \brief The constructor. - */ - MixedDimensionModel() - : problemPtr_(nullptr) {} - - /*! - * \brief Apply the initial conditions to the model. - * - * \param problem The object representing the problem which needs to - * be simulated. - * \note at this point the sub problems are already initialized - */ - void init(Problem &problem) - { - problemPtr_ = &problem; - - // resize the current and previous solution - const unsigned int bulkNumDofs = asImp_().bulkNumDofs(); - const unsigned int lowDimNumDofs = asImp_().lowDimNumDofs(); - uCur_[bulkIdx].resize(bulkNumDofs); - uCur_[lowDimIdx].resize(lowDimNumDofs); - uPrev_[bulkIdx].resize(bulkNumDofs); - uPrev_[lowDimIdx].resize(lowDimNumDofs); - - // initialize local jocabian and jacobian assembler - // \note these local jacobians are not the localjacobian objects of the submodels - // \todo generalize so that there is only one unique local jac object - bulkLocalJacobian_.init(problem_()); - lowDimLocalJacobian_.init(problem_()); - jacAsm_ = std::make_shared<JacobianAssembler>(); - jacAsm_->init(problem_()); - - // set the model to the state of the initial solution - // defined by the problem - asImp_().copySubProblemSolutions_(); - - // also set the solution of the "previous" time step to the - // initial solution. - uPrev_ = uCur_; - } - - /*! - * \brief Compute the global residual for an arbitrary solution - * vector. - * - * \param residual Stores the result - * \param u The solution for which the residual ought to be calculated - */ - Scalar globalResidual(SolutionVector &residual, - const SolutionVector &u) - { - SolutionVector tmp(curSol()); - curSol() = u; - Scalar res = globalResidual(residual); - curSol() = tmp; - return res; - } - - /*! - * \brief Compute the global residual for the current solution - * vector. - * - * \param residual Stores the result - */ - Scalar globalResidual(SolutionVector &residual) - { - residual = 0; - - for (const auto& element : elements(bulkGridView_())) - { - bulkLocalResidual().eval(element); - - if (bulkIsBox) - { - for (int i = 0; i < element.subEntities(bulkDim); ++i) - { - const unsigned int dofIdxGlobal = problem_().bulkProblem().model().dofMapper().subIndex(element, i, bulkDim); - residual[bulkIdx][dofIdxGlobal] += bulkLocalResidual().residual(i); - } - } - else - { - const unsigned int dofIdxGlobal = problem_().bulkProblem().model().dofMapper().index(element); - residual[bulkIdx][dofIdxGlobal] = bulkLocalResidual().residual(0); - } - } - - for (const auto& element : elements(lowDimGridView_())) - { - lowDimLocalResidual().eval(element); - - if (lowDimIsBox) - { - for (int i = 0; i < element.subEntities(lowDimDim); ++i) - { - const unsigned int dofIdxGlobal = problem_().lowDimProblem().model().dofMapper().subIndex(element, i, lowDimDim); - residual[lowDimIdx][dofIdxGlobal] += lowDimLocalResidual().residual(i); - } - } - else - { - const unsigned int dofIdxGlobal = problem_().lowDimProblem().model().dofMapper().index(element); - residual[lowDimIdx][dofIdxGlobal] = lowDimLocalResidual().residual(0); - } - } - - // calculate the square norm of the residual - return residual.two_norm(); - } - - void adaptVariableSize() - { - uCur_[bulkIdx].resize(asImp_().bulkNumDofs()); - uCur_[lowDimIdx].resize(asImp_().lowDimNumDofs()); - } - - /*! - * \brief Reference to the current solution as a block vector. - */ - const SolutionVector &curSol() const - { return uCur_; } - - /*! - * \brief Reference to the current solution as a block vector. - */ - SolutionVector &curSol() - { return uCur_; } - - /*! - * \brief Reference to the previous solution as a block vector. - */ - const SolutionVector &prevSol() const - { return uPrev_; } - - /*! - * \brief Reference to the previous solution as a block vector. - */ - SolutionVector &prevSol() - { return uPrev_; } - - /*! - * \brief Returns the operator assembler for the global jacobian of - * the problem. - */ - JacobianAssembler &jacobianAssembler() - { return *jacAsm_; } - - /*! - * \copydoc jacobianAssembler() - */ - const JacobianAssembler &jacobianAssembler() const - { return *jacAsm_; } - - /*! - * \brief Returns the local jacobian which calculates the local - * stiffness matrix for an arbitrary bulk element. - * - * The local stiffness matrices of the element are used by - * the jacobian assembler to produce a global linerization of the - * problem. - */ - BulkLocalJacobian &bulkLocalJacobian() - { return bulkLocalJacobian_; } - /*! - * \copydoc bulkLocalJacobian() - */ - const BulkLocalJacobian &bulkLocalJacobian() const - { return bulkLocalJacobian_; } - - /*! - * \brief Returns the local jacobian which calculates the local - * stiffness matrix for an arbitrary low dimensional element. - * - * The local stiffness matrices of the element are used by - * the jacobian assembler to produce a global linerization of the - * problem. - */ - LowDimLocalJacobian &lowDimLocalJacobian() - { return lowDimLocalJacobian_; } - /*! - * \copydoc lowDimLocalJacobian() - */ - const LowDimLocalJacobian &lowDimLocalJacobian() const - { return lowDimLocalJacobian_; } - - /*! - * \brief Returns the bulk local residual function. - */ - BulkLocalResidual& bulkLocalResidual() - { return bulkLocalJacobian().localResidual(); } - /*! - * \copydoc bulkLocalResidual() - */ - const BulkLocalResidual& bulkLocalResidual() const - { return bulkLocalJacobian().localResidual(); } - - /*! - * \brief Returns the low dim local residual function. - */ - LowDimLocalResidual& lowDimLocalResidual() - { return lowDimLocalJacobian().localResidual(); } - /*! - * \copydoc lowDimLocalResidual() - */ - const LowDimLocalResidual& lowDimLocalResidual() const - { return lowDimLocalJacobian().localResidual(); } - - /*! - * \brief Returns the maximum relative shift between two vectors of - * primary variables. - * - * \param priVars1 The first vector of primary variables - * \param priVars2 The second vector of primary variables - */ - template <class PrimaryVariableVector> - Scalar relativeShiftAtDof(const PrimaryVariableVector &priVars1, - const PrimaryVariableVector &priVars2) - { - Scalar result = 0.0; - for (int j = 0; j < priVars1.size(); ++j) - { - Scalar eqErr = std::abs(priVars1[j] - priVars2[j]); - eqErr /= std::max<Scalar>(1.0, std::abs(priVars1[j] + priVars2[j])/2); - - result = std::max(result, eqErr); - } - return result; - } - - /*! - * \brief Try to progress the model to the next timestep. - * - * \param solver The non-linear solver - * \param controller The controller which specifies the behaviour - * of the non-linear solver - */ - bool update(NewtonMethod &solver, - NewtonController &controller) - { - asImp_().updateBegin(); - bool converged = solver.execute(controller); - - if (converged) - asImp_().updateSuccessful(); - else - asImp_().updateFailed(); - - return converged; - } - - /*! - * \brief Check the plausibility of the current solution - * - * This has to be done by the actual model, it knows - * best, what (ranges of) variables to check. - * This is primarily a hook - * which the actual model can overload. - */ - void checkPlausibility() const - { } - - /*! - * \brief Called by the update() method before it tries to - * apply the newton method. This is primarily a hook - * which the actual model can overload. - */ - void updateBegin() - { - problem_().bulkProblem().model().updateBegin(); - problem_().lowDimProblem().model().updateBegin(); - - if (problem_().bulkProblem().gridChanged() || problem_().lowDimProblem().gridChanged()) - { - // resize matrix adjust prev sol - uPrev_ = uCur_; - //! Recompute the assembly map in the localjacobian - bulkLocalJacobian_.init(problem_()); - lowDimLocalJacobian_.init(problem_()); - jacAsm_->init(problem_()); - } - } - - - /*! - * \brief Called by the update() method if it was - * successful. This is primarily a hook which the actual - * model can overload. - */ - void updateSuccessful() - {} - - void newtonEndStep() - { - problem_().bulkProblem().model().newtonEndStep(); - problem_().lowDimProblem().model().newtonEndStep(); - - //this is needed in case one of the subproblems has a phaseswitch during a newton step - asImp_().copySubProblemSolutions_(); - } - - /*! - * \brief Called by the update() method if it was - * unsuccessful. This is primarily a hook which the actual - * model can overload. - */ - void updateFailed() - { - // call the respective methods in the sub problems - problem_().lowDimProblem().model().updateFailed(); - problem_().bulkProblem().model().updateFailed(); - - // Reset the current solution to the one of the - // previous time step so that we can start the next - // update at a physically meaningful solution. - uCur_ = uPrev_; - } - - /*! - * \brief Called by the problem if a time integration was - * successful, post processing of the solution is done and - * the result has been written to disk. - * - * This should prepare the model for the next time integration. - */ - void advanceTimeLevel() - { - // call the respective methods in the sub problems - problem_().lowDimProblem().model().advanceTimeLevel(); - problem_().bulkProblem().model().advanceTimeLevel(); - - // make the current solution the previous one. - uPrev_ = uCur_; - } - - /*! - * \brief Returns the number of global degrees of freedoms (DOFs) of the bulk problem - */ - std::size_t bulkNumDofs() const - { return problem_().bulkProblem().model().numDofs(); } - - /*! - * \brief Returns the number of global degrees of freedoms (DOFs) of the low dim problem - */ - std::size_t lowDimNumDofs() const - { return problem_().lowDimProblem().model().numDofs(); } - - /*! - * \brief Returns the number of global degrees of freedoms (DOFs) - */ - std::size_t numDofs() const - { return asImp_().bulkNumDofs() + asImp_().lowDimNumDofs(); } - - /*! - * \brief Mapper for the entities of the subproblems - */ - const BulkVertexMapper& bulkVertexMapper() const - { - return problem_().bulkProblem().vertexMapper(); - } - - const BulkElementMapper& bulkElementMapper() const - { - return problem_().bulkProblem().elementMapper(); - } - - const LowDimVertexMapper& lowDimVertexMapper() const - { - return problem_().lowDimProblem().vertexMapper(); - } - - const LowDimElementMapper& lowDimElementMapper() const - { - return problem_().lowDimProblem().elementMapper(); - } - - /*! - * \brief Resets the Jacobian matrix assembler, so that the - * boundary types can be altered. - */ - void resetJacobianAssembler () - { - jacAsm_ = std::make_shared<JacobianAssembler>(); - jacAsm_->init(problem_()); - } - - /*! - * \brief Copies the global solution vector to the sub problems - */ - void copySolutionToSubProblems() - { - problem_().bulkProblem().model().curSol() = uCur_[bulkIdx]; - problem_().lowDimProblem().model().curSol() = uCur_[lowDimIdx]; - } - -protected: - /*! - * \brief A reference to the problem on which the model is applied. - */ - Problem &problem_() - { return *problemPtr_; } - /*! - * \copydoc problem_() - */ - const Problem &problem_() const - { return *problemPtr_; } - - /*! - * \brief Reference to the grid view of the spatial domain. - */ - const BulkGridView &bulkGridView_() const - { return problem_().bulkProblem().gridView(); } - - /*! - * \brief Reference to the grid view of the spatial domain. - */ - const LowDimGridView &lowDimGridView_() const - { return problem_().lowDimProblem().gridView(); } - - /*! - * \brief Copies the solution vectors of the sub problems - */ - void copySubProblemSolutions_() - { - uCur_[bulkIdx] = problem_().bulkProblem().model().curSol(); - uCur_[lowDimIdx] = problem_().lowDimProblem().model().curSol(); - } - - // the problem we want to solve. defines the constitutive - // relations, matxerial laws, etc. - Problem *problemPtr_; - - // calculates the local jacobian matrix for a given bulk/lowdim element - BulkLocalJacobian bulkLocalJacobian_; - LowDimLocalJacobian lowDimLocalJacobian_; - - // Linearizes the problem at the current time step using the - // local jacobian - std::shared_ptr<JacobianAssembler> jacAsm_; - - // cur is the current iterative solution, prev the converged - // solution of the previous time step - SolutionVector uCur_; - SolutionVector uPrev_; - -private: - - Implementation &asImp_() - { return *static_cast<Implementation*>(this); } - const Implementation &asImp_() const - { return *static_cast<const Implementation*>(this); } - -}; - -} // end namespace Dumux - -#endif diff --git a/dumux/mixeddimension/newtoncontroller.hh b/dumux/mixeddimension/newtoncontroller.hh deleted file mode 100644 index 6bac3215bcef98f301629eebc5a3a0a3ff9ea69a..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/newtoncontroller.hh +++ /dev/null @@ -1,685 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/**************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup MixedDimension - * \brief Reference implementation of a controller class for the Newton solver. - * - * Usually this controller should be sufficient. - */ -#ifndef DUMUX_MIXEDDIMENSION_NEWTON_CONTROLLER_HH -#define DUMUX_MIXEDDIMENSION_NEWTON_CONTROLLER_HH - -#include <dumux/common/propertysystem.hh> -#include <dumux/common/exceptions.hh> -#include <dumux/common/math.hh> -#include <dumux/linear/seqsolverbackend.hh> -#include <dumux/linear/linearsolveracceptsmultitypematrix.hh> -#include <dumux/linear/matrixconverter.hh> - -namespace Dumux -{ -template <class TypeTag> -class MixedDimensionNewtonController; - -namespace Properties -{ -//! Specifies the implementation of the Newton controller -NEW_PROP_TAG(NewtonController); - -//! Specifies the type of the actual Newton method -NEW_PROP_TAG(NewtonMethod); - -//! Specifies the type of a solution -NEW_PROP_TAG(SolutionVector); - -//! Specifies the type of a global Jacobian matrix -NEW_PROP_TAG(JacobianMatrix); - -//! specifies the type of the time manager -NEW_PROP_TAG(TimeManager); - -/*! - * \brief Specifies whether the update should be done using the line search - * method instead of the plain Newton method. - * - * Whether this property has any effect depends on whether the line - * search method is implemented for the actual model's Newton - * controller's update() method. By default line search is not used. - */ -NEW_PROP_TAG(NewtonUseLineSearch); - -//! indicate whether the shift criterion should be used -NEW_PROP_TAG(NewtonEnableShiftCriterion); - -//! the value for the maximum relative shift below which convergence is declared -NEW_PROP_TAG(NewtonMaxRelativeShift); - -//! indicate whether the residual criterion should be used -NEW_PROP_TAG(NewtonEnableResidualCriterion); - -//! the value for the residual reduction below which convergence is declared -NEW_PROP_TAG(NewtonResidualReduction); - -//! indicate whether both of the criteria should be satisfied to declare convergence -NEW_PROP_TAG(NewtonSatisfyResidualAndShiftCriterion); - -/*! - * \brief The number of iterations at which the Newton method - * should aim at. - * - * This is used to control the time-step size. The heuristic used - * is to scale the last time-step size by the deviation of the - * number of iterations used from the target steps. - */ -NEW_PROP_TAG(NewtonTargetSteps); - -//! Number of maximum iterations for the Newton method. -NEW_PROP_TAG(NewtonMaxSteps); - -} // end namespace Properties - -/*! - * \ingroup MixedDimension - * \brief A reference implementation of a Newton controller specific - * for the coupled problems of mixed dimension. - * - * If you want to specialize only some methods but are happy with the - * defaults of the reference controller, derive your controller from - * this class and simply overload the required methods. - */ -template <class TypeTag> -class MixedDimensionNewtonController -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using Implementation = typename GET_PROP_TYPE(TypeTag, NewtonController); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using Model = typename GET_PROP_TYPE(TypeTag, Model); - using NewtonMethod = typename GET_PROP_TYPE(TypeTag, NewtonMethod); - using JacobianMatrix = typename GET_PROP_TYPE(TypeTag, JacobianMatrix); - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using SolutionVector = typename GET_PROP_TYPE(TypeTag, SolutionVector); - using LinearSolver = typename GET_PROP_TYPE(TypeTag, LinearSolver); - using SubProblemBlockIndices = typename GET_PROP(TypeTag, SubProblemBlockIndices); - - typename SubProblemBlockIndices::BulkIdx bulkIdx; - typename SubProblemBlockIndices::LowDimIdx lowDimIdx; - - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - enum { - numEqBulk = GET_PROP_VALUE(BulkProblemTypeTag, NumEq), - numEqLowDim = GET_PROP_VALUE(LowDimProblemTypeTag, NumEq) - }; - -public: - /*! - * \brief Constructor - */ - MixedDimensionNewtonController(const Problem &problem) - : endIterMsgStream_(std::ostringstream::out), linearSolver_(problem) - { - useLineSearch_ = GET_PARAM_FROM_GROUP(TypeTag, bool, Newton, UseLineSearch); - enableShiftCriterion_ = GET_PARAM_FROM_GROUP(TypeTag, bool, Newton, EnableShiftCriterion); - enableResidualCriterion_ = GET_PARAM_FROM_GROUP(TypeTag, bool, Newton, EnableResidualCriterion); - satisfyResidualAndShiftCriterion_ = GET_PARAM_FROM_GROUP(TypeTag, bool, Newton, SatisfyResidualAndShiftCriterion); - if (!enableShiftCriterion_ && !enableResidualCriterion_) - { - DUNE_THROW(Dune::NotImplemented, - "at least one of NewtonEnableShiftCriterion or " - << "NewtonEnableResidualCriterion has to be set to true"); - } - - setMaxRelativeShift(GET_PARAM_FROM_GROUP(TypeTag, Scalar, Newton, MaxRelativeShift)); - setResidualReduction(GET_PARAM_FROM_GROUP(TypeTag, Scalar, Newton, ResidualReduction)); - setTargetSteps(GET_PARAM_FROM_GROUP(TypeTag, int, Newton, TargetSteps)); - setMaxSteps(GET_PARAM_FROM_GROUP(TypeTag, int, Newton, MaxSteps)); - - verbose_ = true; - numSteps_ = 0; - } - - /*! - * \brief Set the maximum acceptable difference of any primary variable - * between two iterations for declaring convergence. - * - * \param tolerance The maximum relative shift between two Newton - * iterations at which the scheme is considered finished - */ - void setMaxRelativeShift(Scalar tolerance) - { shiftTolerance_ = tolerance; } - - /*! - * \brief Set the maximum acceptable residual norm reduction. - * - * \param tolerance The maximum reduction of the residual norm - * at which the scheme is considered finished - */ - void setResidualReduction(Scalar tolerance) - { reductionTolerance_ = tolerance; } - - /*! - * \brief Set the number of iterations at which the Newton method - * should aim at. - * - * This is used to control the time-step size. The heuristic used - * is to scale the last time-step size by the deviation of the - * number of iterations used from the target steps. - * - * \param targetSteps Number of iterations which are considered "optimal" - */ - void setTargetSteps(int targetSteps) - { targetSteps_ = targetSteps; } - - /*! - * \brief Set the number of iterations after which the Newton - * method gives up. - * - * \param maxSteps Number of iterations after we give up - */ - void setMaxSteps(int maxSteps) - { maxSteps_ = maxSteps; } - - /*! - * \brief Returns true if another iteration should be done. - * - * \param uCurrentIter The solution of the current Newton iteration - */ - bool newtonProceed(const SolutionVector &uCurrentIter) - { - if (numSteps_ < 2) - return true; // we always do at least two iterations - else if (asImp_().newtonConverged()) { - return false; // we are below the desired tolerance - } - else if (numSteps_ >= maxSteps_) { - // We have exceeded the allowed number of steps. If the - // maximum relative shift was reduced by a factor of at least 4, - // we proceed even if we are above the maximum number of steps. - if (enableShiftCriterion_) - return shift_*4.0 < lastShift_; - else - return reduction_*4.0 < lastReduction_; - } - - return true; - } - - /*! - * \brief Returns true if the error of the solution is below the - * tolerance. - */ - bool newtonConverged() const - { - if (enableShiftCriterion_ && !enableResidualCriterion_) - { - return shift_ <= shiftTolerance_; - } - else if (!enableShiftCriterion_ && enableResidualCriterion_) - { - return reduction_ <= reductionTolerance_; - } - else if (satisfyResidualAndShiftCriterion_) - { - return shift_ <= shiftTolerance_ - && reduction_ <= reductionTolerance_; - } - else - { - return shift_ <= shiftTolerance_ - || reduction_ <= reductionTolerance_; - } - - return false; - } - - /*! - * \brief Called before the Newton method is applied to an - * non-linear system of equations. - * - * \param method The object where the NewtonMethod is executed - * \param u The initial solution - */ - void newtonBegin(NewtonMethod &method, const SolutionVector &u) - { - method_ = &method; - numSteps_ = 0; - } - - /*! - * \brief Indicates the beginning of a Newton iteration. - */ - void newtonBeginStep() - { - lastShift_ = shift_; - if (numSteps_ == 0) - { - lastReduction_ = 1.0; - } - else - { - lastReduction_ = reduction_; - } - } - - /*! - * \brief Returns the number of steps done since newtonBegin() was - * called. - */ - int newtonNumSteps() - { return numSteps_; } - - /*! - * \brief Update the maximum relative shift of the solution compared to - * the previous iteration. - * - * \param uLastIter The current iterative solution - * \param deltaU The difference between the current and the next solution - */ - void newtonUpdateShift(const SolutionVector &uLastIter, - const SolutionVector &deltaU) - { - shift_ = 0; - - for (std::size_t i = 0; i < uLastIter[bulkIdx].size(); ++i) - { - auto uNewI = uLastIter[bulkIdx][i]; - uNewI -= deltaU[bulkIdx][i]; - - const Scalar shiftAtDof = model_().relativeShiftAtDof(uLastIter[bulkIdx][i], - uNewI); - shift_ = std::max(shift_, shiftAtDof); - } - - for (std::size_t i = 0; i < uLastIter[lowDimIdx].size(); ++i) - { - auto uNewI = uLastIter[lowDimIdx][i]; - uNewI -= deltaU[lowDimIdx][i]; - - const Scalar shiftAtDof = model_().relativeShiftAtDof(uLastIter[lowDimIdx][i], - uNewI); - shift_ = std::max(shift_, shiftAtDof); - } - } - - /*! - * \brief Solve the linear system of equations \f$\mathbf{A}x - b = 0\f$. - * - * Throws Dumux::NumericalProblem if the linear solver didn't - * converge. - * - * If the linear solver doesn't accept multitype matrices we copy the matrix - * into a 1x1 block BCRS matrix for solving. - * - * \param A The matrix of the linear system of equations - * \param x The vector which solves the linear system - * \param b The right hand side of the linear system - */ - template<typename T = TypeTag> - typename std::enable_if<!LinearSolverAcceptsMultiTypeMatrix<T>::value, void>::type - newtonSolveLinear(JacobianMatrix &A, - SolutionVector &x, - SolutionVector &b) - { - try - { - if (numSteps_ == 0) - initialResidual_ = b.two_norm(); - - // check matrix sizes - assert(A[bulkIdx][bulkIdx].N() == A[bulkIdx][lowDimIdx].N()); - assert(A[lowDimIdx][bulkIdx].N() == A[lowDimIdx][lowDimIdx].N()); - - // create the bcrs matrix the IterativeSolver backend can handle - const auto M = MatrixConverter<JacobianMatrix>::multiTypeToBCRSMatrix(A); - - // get the new matrix sizes - const std::size_t numRows = M.N(); - assert(numRows == M.M()); - - // create the vector the IterativeSolver backend can handle - const auto bTmp = VectorConverter<SolutionVector>::multiTypeToBlockVector(b); - assert(bTmp.size() == numRows); - - // create a blockvector to which the linear solver writes the solution - using VectorBlock = typename Dune::FieldVector<Scalar, 1>; - using BlockVector = typename Dune::BlockVector<VectorBlock>; - BlockVector y; - y.resize(numRows); - - // solve - bool converged = linearSolver_.solve(M, y, bTmp); - - // copy back the result y into x - VectorConverter<SolutionVector>::retrieveValues(x, y); - - if (!converged) - DUNE_THROW(NumericalProblem, "Linear solver did not converge"); - } - catch (const Dune::Exception &e) - { - Dumux::NumericalProblem p; - p.message(e.what()); - throw p; - } - } - - /*! - * \brief Solve the linear system of equations \f$\mathbf{A}x - b = 0\f$. - * - * Throws Dumux::NumericalProblem if the linear solver didn't - * converge. - * - * \param A The matrix of the linear system of equations - * \param x The vector which solves the linear system - * \param b The right hand side of the linear system - */ - template<typename T = TypeTag> - typename std::enable_if<LinearSolverAcceptsMultiTypeMatrix<T>::value, void>::type - newtonSolveLinear(JacobianMatrix &A, - SolutionVector &x, - SolutionVector &b) - { - try - { - if (numSteps_ == 0) - initialResidual_ = b.two_norm(); - - bool converged = linearSolver_.solve(A, x, b); - - if (!converged) - DUNE_THROW(NumericalProblem, "Linear solver did not converge"); - } - catch (const Dune::Exception &e) - { - Dumux::NumericalProblem p; - p.message(e.what()); - throw p; - } - } - - /*! - * \brief Update the current solution with a delta vector. - * - * The error estimates required for the newtonConverged() and - * newtonProceed() methods should be updated inside this method. - * - * Different update strategies, such as line search and chopped - * updates can be implemented. The default behavior is just to - * subtract deltaU from uLastIter, i.e. - * \f[ u^{k+1} = u^k - \Delta u^k \f] - * - * \param uCurrentIter The solution vector after the current iteration - * \param uLastIter The solution vector after the last iteration - * \param deltaU The delta as calculated from solving the linear - * system of equations. This parameter also stores - * the updated solution. - */ - void newtonUpdate(SolutionVector &uCurrentIter, - const SolutionVector &uLastIter, - const SolutionVector &deltaU) - { - if (enableShiftCriterion_) - newtonUpdateShift(uLastIter, deltaU); - - if (useLineSearch_) - lineSearchUpdate_(uCurrentIter, uLastIter, deltaU); - else - { - for (std::size_t i = 0; i < uLastIter[bulkIdx].size(); ++i) - { - uCurrentIter[bulkIdx][i] = uLastIter[bulkIdx][i]; - uCurrentIter[bulkIdx][i] -= deltaU[bulkIdx][i]; - } - for (std::size_t i = 0; i < uLastIter[lowDimIdx].size(); ++i) - { - uCurrentIter[lowDimIdx][i] = uLastIter[lowDimIdx][i]; - uCurrentIter[lowDimIdx][i] -= deltaU[lowDimIdx][i]; - } - - if (enableResidualCriterion_) - { - SolutionVector tmp(uLastIter); - reduction_ = model_().globalResidual(tmp, uCurrentIter); - reduction_ /= initialResidual_; - } - } - - // copy the global solution to the sub problems - model_().copySolutionToSubProblems(); - } - - /*! - * \brief Indicates that one Newton iteration was finished. - * - * \param uCurrentIter The solution after the current Newton iteration - * \param uLastIter The solution at the beginning of the current Newton iteration - */ - void newtonEndStep(const SolutionVector &uCurrentIter, - const SolutionVector &uLastIter) - { - // Eventuall update the volume variables - this->model_().newtonEndStep(); - - ++numSteps_; - - if (verbose()) - { - std::cout << "\rNewton iteration " << numSteps_ << " done"; - if (enableShiftCriterion_) - std::cout << ", maximum relative shift = " << shift_; - if (enableResidualCriterion_) - std::cout << ", residual reduction = " << reduction_; - std::cout << endIterMsg().str() << "\n"; - } - endIterMsgStream_.str(""); - - // When the newton iteration is done: ask the model to check if it makes sense. - model_().checkPlausibility(); - } - - /*! - * \brief Indicates that we're done solving the non-linear system - * of equations. - */ - void newtonEnd() - {} - - /*! - * \brief Called if the Newton method broke down. - * - * This method is called _after_ newtonEnd() - */ - void newtonFail() - { - numSteps_ = targetSteps_*2; - } - - /*! - * \brief Called when the Newton method was successful. - * - * This method is called _after_ newtonEnd() - */ - void newtonSucceed() - {} - - /*! - * \brief Suggest a new time-step size based on the old time-step - * size. - * - * The default behavior is to suggest the old time-step size - * scaled by the ratio between the target iterations and the - * iterations required to actually solve the last time-step. - */ - Scalar suggestTimeStepSize(Scalar oldTimeStep) const - { - // be aggressive reducing the time-step size but - // conservative when increasing it. the rationale is - // that we want to avoid failing in the next Newton - // iteration which would require another linearization - // of the problem. - if (numSteps_ > targetSteps_) { - Scalar percent = Scalar(numSteps_ - targetSteps_)/targetSteps_; - return oldTimeStep/(1.0 + percent); - } - - Scalar percent = Scalar(targetSteps_ - numSteps_)/targetSteps_; - return oldTimeStep*(1.0 + percent/1.2); - } - - /*! - * \brief Returns a reference to the current Newton method - * which is controlled by this controller. - */ - NewtonMethod &method() - { return *method_; } - - /*! - * \brief Returns a reference to the current Newton method - * which is controlled by this controller. - */ - const NewtonMethod &method() const - { return *method_; } - - std::ostringstream &endIterMsg() - { return endIterMsgStream_; } - - /*! - * \brief Specifies if the Newton method ought to be chatty. - */ - void setVerbose(bool val) - { verbose_ = val; } - - /*! - * \brief Returns true if the Newton method ought to be chatty. - */ - bool verbose() const - { return verbose_; } - -protected: - - /*! - * \brief Returns a reference to the problem. - */ - Problem &problem_() - { return method_->problem(); } - - /*! - * \brief Returns a reference to the problem. - */ - const Problem &problem_() const - { return method_->problem(); } - - /*! - * \brief Returns a reference to the time manager. - */ - TimeManager &timeManager_() - { return problem_().timeManager(); } - - /*! - * \brief Returns a reference to the time manager. - */ - const TimeManager &timeManager_() const - { return problem_().timeManager(); } - - /*! - * \brief Returns a reference to the problem. - */ - Model &model_() - { return problem_().model(); } - - /*! - * \brief Returns a reference to the problem. - */ - const Model &model_() const - { return problem_().model(); } - - // returns the actual implementation for the controller we do - // it this way in order to allow "poor man's virtual methods", - // i.e. methods of subclasses which can be called by the base - // class. - Implementation &asImp_() - { return *static_cast<Implementation*>(this); } - const Implementation &asImp_() const - { return *static_cast<const Implementation*>(this); } - - void lineSearchUpdate_(SolutionVector &uCurrentIter, - const SolutionVector &uLastIter, - const SolutionVector &deltaU) - { - Scalar lambda = 1.0; - SolutionVector tmp(uLastIter); - - while (true) - { - uCurrentIter = deltaU; - uCurrentIter *= -lambda; - uCurrentIter += uLastIter; - - // calculate the residual of the current solution - reduction_ = this->method().model().globalResidual(tmp, uCurrentIter); - reduction_ /= initialResidual_; - - if (reduction_ < lastReduction_ || lambda <= 0.125) - { - this->endIterMsg() << ", residual reduction " << lastReduction_ << "->" << reduction_ << "@lambda=" << lambda; - return; - } - - // try with a smaller update - lambda /= 2.0; - } - } - - std::ostringstream endIterMsgStream_; - - NewtonMethod *method_; - bool verbose_; - - // shift criterion variables - Scalar shift_; - Scalar lastShift_; - Scalar shiftTolerance_; - - // residual criterion variables - Scalar reduction_; - Scalar lastReduction_; - Scalar initialResidual_; - Scalar reductionTolerance_; - - // optimal number of iterations we want to achieve - int targetSteps_; - // maximum number of iterations we do before giving up - int maxSteps_; - // actual number of steps done so far - int numSteps_; - - // the linear solver - LinearSolver linearSolver_; - - bool useLineSearch_; - bool enableShiftCriterion_; - bool enableResidualCriterion_; - bool satisfyResidualAndShiftCriterion_; -}; - -} // namespace Dumux - -#endif diff --git a/dumux/mixeddimension/problem.hh b/dumux/mixeddimension/problem.hh deleted file mode 100644 index d3dc407a734c8ccefc3dc848540fa1d36371f385..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/problem.hh +++ /dev/null @@ -1,589 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup MixedDimension - * \brief Base class for problems with which involve two sub problems - * of different dimensions. - */ - -#ifndef DUMUX_MIXEDDIMENSION_PROBLEM_HH -#define DUMUX_MIXEDDIMENSION_PROBLEM_HH - -#include <dune/common/exceptions.hh> -#include <dumux/common/exceptions.hh> -#include <dumux/mixeddimension/properties.hh> -#include <dumux/mixeddimension/model.hh> - -namespace Dumux -{ - -/*! - * \ingroup MixedDimension - * \brief Base class for probems which involve two sub problems of different dimensions - */ -template<class TypeTag> -class MixedDimensionProblem -{ - using Implementation = typename GET_PROP_TYPE(TypeTag, Problem); - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using CouplingManager = typename GET_PROP_TYPE(TypeTag, CouplingManager); - using NewtonMethod = typename GET_PROP_TYPE(TypeTag, NewtonMethod); - using NewtonController = typename GET_PROP_TYPE(TypeTag, NewtonController); - using Model = typename GET_PROP_TYPE(TypeTag, Model); - - // obtain the type tags of the sub problems - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - // obtain types from the sub problem type tags - using BulkProblem = typename GET_PROP_TYPE(BulkProblemTypeTag, Problem); - using LowDimProblem = typename GET_PROP_TYPE(LowDimProblemTypeTag, Problem); - - using BulkTimeManager = typename GET_PROP_TYPE(BulkProblemTypeTag, TimeManager); - using LowDimTimeManager = typename GET_PROP_TYPE(LowDimProblemTypeTag, TimeManager); - - using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); - using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); - - using BulkSolutionVector = typename GET_PROP_TYPE(BulkProblemTypeTag, SolutionVector); - using LowDimSolutionVector = typename GET_PROP_TYPE(LowDimProblemTypeTag, SolutionVector); - -public: - MixedDimensionProblem(TimeManager &timeManager, - const BulkGridView &bulkGridView, - const LowDimGridView &lowDimGridView) - : timeManager_(timeManager), - bulkGridView_(bulkGridView), - lowDimGridView_(lowDimGridView), - bulkProblem_(bulkTimeManager_, bulkGridView), - lowDimProblem_(lowDimTimeManager_, lowDimGridView), - couplingManager_(std::make_shared<CouplingManager>(bulkProblem_, lowDimProblem_)), - newtonMethod_(asImp_()), - newtonCtl_(asImp_()) - { - // check if we got the right dimensions - static_assert(int(BulkGridView::dimension) > int(LowDimGridView::dimension), "The bulk grid dimension has to be greater than the low-dimensional grid dimension."); - static_assert(int(BulkGridView::dimensionworld) == int(LowDimGridView::dimensionworld), "The subproblems have to live in the same world dimension."); - - // iterative or monolithic - useIterativeSolver_ = GET_PARAM_FROM_GROUP(TypeTag, bool, MixedDimension, UseIterativeSolver); - - // read data from the input file - name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name); - episodeTime_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, EpisodeTime); - maxTimeStepSize_ = GET_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, MaxTimeStepSize); - - if (useIterativeSolver_) - { - maxIterations_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, int, IterativeAlgorithm, MaxIterations); - tolerance_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, IterativeAlgorithm, Tolerance); - verbose_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, bool, IterativeAlgorithm, Verbose); - } - } - - /*! - * \brief Called by the Dumux::TimeManager in order to - * initialize the problem and the sub-problems. - * - * If you overload this method don't forget to call - * ParentType::init() - */ - void init() - { - Scalar tStart = timeManager().time(); - Scalar tEnd = timeManager().endTime(); - - const bool restart = tStart > 0; - - Scalar dtBulkProblem; - Scalar dtLowDimProblem; - - // get initial time step size for the subproblems - if (useIterativeSolver_) - { - dtBulkProblem = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, DtInitialBulkProblem); - dtLowDimProblem = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, DtInitialLowDimProblem); - } - else - { - dtBulkProblem = timeManager().timeStepSize(); - dtLowDimProblem = timeManager().timeStepSize(); - } - - // start new episode - // episode are used to keep the subproblems in sync. At the end of each episode - // of the coupled problem the subproblem need to arrive at the same time. - // this is relevant if the time step sizes of the subproblems are different. - timeManager().startNextEpisode(episodeTime_); - bulkTimeManager().startNextEpisode(episodeTime_); - lowDimTimeManager().startNextEpisode(episodeTime_); - - // initialize the problem coupler prior to the problems - couplingManager().preInit(); - - // set the coupling manager in the sub problems - bulkProblem().setCouplingManager(couplingManager_); - lowDimProblem().setCouplingManager(couplingManager_); - - // initialize the subproblem time managers (this also initializes the subproblems) - // the lowDim time manager is initialized first as the bulk problem might need some data from the - // lowDim problem for its initialization (e.g. for models using facet coupling with the global caching) - lowDimTimeManager().init(lowDimProblem(), tStart, dtLowDimProblem, tEnd, restart); - bulkTimeManager().init(bulkProblem(), tStart, dtBulkProblem, tEnd, restart); - - // finalize the problem coupler - couplingManager().postInit(); - - if (!useIterativeSolver_) - model().init(asImp_()); - } - - /*! - * \brief This method writes the complete state of the simulation - * to the harddisk. - * - * The file will start with the prefix returned by the name() - * method, has the current time of the simulation clock in it's - * name and uses the extension <tt>.drs</tt>. (Dumux ReStart - * file.) See Dumux::Restart for details. - */ - void serialize() - {} - - /*! - * \brief Called by the time manager before the time integration. - */ - void preTimeStep() - { - if (useIterativeSolver_) - { - previousSolBulk_ = bulkProblem().model().curSol(); - previousSolLowDim_ = lowDimProblem().model().curSol(); - } - else - { - // call low dim problem first because it might grow and the - // coupling maps might need to be updated before the bulkproblem - lowDimProblem().preTimeStep(); - bulkProblem().preTimeStep(); - } - } - - /*! - * \brief Called by Dumux::TimeManager in order to do a time - * integration on the model. Algorithms for the time integration are - * implemented here. - */ - void timeIntegration() - { - if (useIterativeSolver_) - asImp_().timeIntegrationIterative(); - else - asImp_().timeIntegrationMonolithic(); - } - - /*! - * \brief Time integration for the iterative solver. - */ - void timeIntegrationIterative() - { - std::cout << std::endl; - std::cout << "Start coupled time integration starting at t = " << timeManager().time() << std::endl; - - Scalar error = 1.0; - Scalar pBulkNorm = 0.0; - Scalar pLowDimNorm = 0.0; - BulkSolutionVector solBulkDiff; - LowDimSolutionVector solLowDimDiff; - int iterations = 0; - - if(verbose_) - std::cout << "Starting iterative algorithm " - << "with tolerance = " << tolerance_ - << " and max iterations = " << maxIterations_ << std::endl; - - // iterative algorithm within each time step - while(error > tolerance_) - { - if(iterations >= maxIterations_) - DUNE_THROW(Dumux::NumericalProblem, "Iterative algorithm didn't converge in " + std::to_string(maxIterations_) + " iterations!"); - - // run the bulk model - if(verbose_) std::cout << "Solving the bulk problem " << bulkProblem().name() << std::endl; - bulkTimeManager().setTime(timeManager().time(), 0); - bulkTimeManager().setEndTime(timeManager().time() + timeManager().timeStepSize()); - bulkTimeManager().setTimeStepSize(bulkTimeManager().previousTimeStepSize()); - bulkTimeManager().run(); // increases the time step index - - // run the low dimensional problem - if(verbose_) std::cout << "Solving the low-dimensional problem " << lowDimProblem().name() << std::endl; - lowDimTimeManager().setTime(timeManager().time(), 0); - lowDimTimeManager().setEndTime(timeManager().time() + timeManager().timeStepSize()); - lowDimTimeManager().setTimeStepSize(lowDimTimeManager().previousTimeStepSize()); - lowDimTimeManager().run(); // increases the time step index - - // get current solution - currentSolBulk_ = bulkProblem().model().curSol(); - currentSolLowDim_ = lowDimProblem().model().curSol(); - - // calculate discrete l2-norm of pressure - solBulkDiff = previousSolBulk_; - solBulkDiff -= currentSolBulk_; - solLowDimDiff = previousSolLowDim_; - solLowDimDiff -= currentSolLowDim_; - - pBulkNorm = solBulkDiff.infinity_norm()/currentSolBulk_.infinity_norm(); - pLowDimNorm = solLowDimDiff.infinity_norm()/currentSolLowDim_.infinity_norm(); - - // calculate the error - error = pBulkNorm + pLowDimNorm; - - // update the previous solution - previousSolBulk_ = currentSolBulk_; - previousSolLowDim_ = currentSolLowDim_; - - iterations++; - - if(verbose_) - { - std::cout << "Iteration " << iterations << " done " - << "with maximum relative shift in bulk domain = " << pBulkNorm - << " and maximum relative shift in lower-dimensional domain = " << pLowDimNorm - << " | total error = " << error << std::endl; - } - - }// end while(error > tolerance_) - - if(verbose_) - { - std::cout << "Iterative algorithm finished with " << iterations << " iterations " - << "and total error = " << error << std::endl; - } - } - - /*! - * \brief Time integration for the monolithic solver. - */ - void timeIntegrationMonolithic() - { - const int maxFails = GET_PARAM_FROM_GROUP(TypeTag, int, Implicit, MaxTimeStepDivisions); - - std::cout << std::endl; - std::cout << "Start coupled time integration starting at t = " << timeManager().time() << std::endl; - - for (int i = 0; i < maxFails; ++i) - { - if (model().update(newtonMethod(), newtonController())) - return; - - const Scalar dt = timeManager().timeStepSize(); - const Scalar nextDt = dt / 2; - timeManager().setTimeStepSize(nextDt); - bulkTimeManager().setTimeStepSize(nextDt); - lowDimTimeManager().setTimeStepSize(nextDt); - - // update failed - std::cout << "Newton solver did not converge with dt="<<dt<<" seconds. Retrying with time step of " - << nextDt << " seconds\n"; - } - - DUNE_THROW(Dune::MathError, - "Newton solver didn't converge after " - << maxFails - << " time-step divisions. dt=" - << timeManager().timeStepSize()); - } - - /*! - * \brief Called by the time manager after the time integration to - * do some post processing on the solution. - */ - void postTimeStep() - { - if (!useIterativeSolver_) - { - // call low dim problem first because it might grow and the - // coupling maps might need to be updated before the bulkproblem - lowDimProblem().postTimeStep(); - bulkProblem().postTimeStep(); - } - } - - /*! - * \brief Called by Dumux::TimeManager whenever a solution for a - * timestep has been computed and the simulation time has - * been updated. - */ - Scalar nextTimeStepSize(const Scalar dt) - { - Scalar newDt = newtonCtl_.suggestTimeStepSize(dt); - bulkTimeManager().setTimeStepSize(newDt); - lowDimTimeManager().setTimeStepSize(newDt); - - return newDt; - } - - /*! - * \brief Returns true if the current solution should be written to - * disk (i.e. as a VTK file) - */ - bool shouldWriteOutput() const - { - return (timeManager().episodeWillBeFinished() || timeManager().willBeFinished()); - } - - /*! - * \brief Returns true if the current state of the simulation - * should be written to disk - */ - bool shouldWriteRestartFile() const - { - return false; - } - - /*! - * \brief Returns the user specified maximum time step size - * - * Overload in problem for custom needs. - */ - Scalar maxTimeStepSize() const - { - return maxTimeStepSize_; - } - - /*! - * \brief Called by the time manager after the end of an episode. - */ - void episodeEnd() - { - timeManager().startNextEpisode(episodeTime_); - bulkTimeManager().startNextEpisode(episodeTime_); - lowDimTimeManager().startNextEpisode(episodeTime_); - - if (!useIterativeSolver_) - { - // set the initial time step size of a an episode to the last real time step size before the episode - Scalar nextDt = std::max(timeManager().previousTimeStepSize(), timeManager().timeStepSize()); - bulkTimeManager().setTimeStepSize(nextDt); - lowDimTimeManager().setTimeStepSize(nextDt); - } - } - - /*! - * \brief The problem name. - * - * This is used as a prefix for files generated by the simulation. - * It could be either overwritten by the problem files, or simply - * declared over the setName() function in the application file. - */ - const std::string name() const - { - return name_; - } - - /*! - * \brief Called by the time manager after everything which can be - * done about the current time step is finished and the - * model should be prepared to do the next time integration. - */ - void advanceTimeLevel() - { - model().advanceTimeLevel(); - - asImp_().bulkProblem().advanceTimeLevel(); - asImp_().lowDimProblem().advanceTimeLevel(); - - if (!useIterativeSolver_) - { - // foward current time to the subproblems for correct output - bulkTimeManager().setTime(timeManager().time() + timeManager().timeStepSize(), timeManager().timeStepIndex()+1); - lowDimTimeManager().setTime(timeManager().time() + timeManager().timeStepSize(), timeManager().timeStepIndex()+1); - } - } - - /*! - * \brief Write the relevant quantities of the current solution into - * an VTK output file. - */ - void writeOutput() - { - // write the current result to disk - if (asImp_().shouldWriteOutput() && !(timeManager().time() < 0)) - { - asImp_().bulkProblem().writeOutput(); - asImp_().lowDimProblem().writeOutput(); - } - } - - /*! - * \brief Load a previously saved state of the whole simulation - * from disk. - * - * \param tRestart The simulation time on which the program was - * written to disk. - */ - void restart(const Scalar tRestart) - { - DUNE_THROW(Dune::NotImplemented, "Restart mixeddimension simulations."); - } - - //! Returns the leafGridView of the bulk problem - const BulkGridView &bulkGridView() const - { return bulkGridView_; } - - //! Returns the leafGridView of the low dimensional problem - const LowDimGridView &lowDimGridView() const - { return lowDimGridView_; } - - //! Returns the time manager of the mixeddimension problem - const TimeManager &timeManager() const - { return timeManager_; } - - //! Returns the time manager of the mixeddimension problem - TimeManager &timeManager() - { return timeManager_; } - - //! Returns a reference to the bulk problem - BulkProblem &bulkProblem() - { return bulkProblem_; } - - //! Returns a const reference to the bulk problem - const BulkProblem &bulkProblem() const - { return bulkProblem_; } - - //! Returns a reference to the low dimensional problem - LowDimProblem &lowDimProblem() - { return lowDimProblem_; } - - //! Returns a const reference to the low dimensional problem - const LowDimProblem &lowDimProblem() const - { return lowDimProblem_; } - - //! Returns a const reference to the bulk time manager - const BulkTimeManager &bulkTimeManager() const - { return bulkTimeManager_; } - - //! Returns a reference to the bulk time manager - BulkTimeManager &bulkTimeManager() - { return bulkTimeManager_; } - - //! Returns a const reference to the low dimensional time manager - const LowDimTimeManager &lowDimTimeManager() const - { return lowDimTimeManager_; } - - //! Returns a reference to the low dimensional time manager - LowDimTimeManager &lowDimTimeManager() - { return lowDimTimeManager_; } - - //! Return reference to the coupling manager - CouplingManager &couplingManager() - { return *couplingManager_; } - - //! Return const reference to the coupling manager - const CouplingManager &couplingManager() const - { return *couplingManager_; } - - /*! - * \brief Returns numerical model used for the problem. - */ - Model &model() - { return model_; } - - /*! - * \copydoc model() - */ - const Model &model() const - { return model_; } - - /*! - * \brief Returns the newton method object - */ - NewtonMethod &newtonMethod() - { return newtonMethod_; } - - /*! - * \copydoc newtonMethod() - */ - const NewtonMethod &newtonMethod() const - { return newtonMethod_; } - - /*! - * \brief Returns the newton contoller object - */ - NewtonController &newtonController() - { return newtonCtl_; } - - /*! - * \copydoc newtonController() - */ - const NewtonController &newtonController() const - { return newtonCtl_; } - -private: - - //! Returns the implementation of the problem (i.e. static polymorphism) - Implementation &asImp_() - { return *static_cast<Implementation *>(this); } - - //! Returns the implementation of the problem (i.e. static polymorphism) - const Implementation &asImp_() const - { return *static_cast<const Implementation *>(this); } - - TimeManager &timeManager_; - - BulkGridView bulkGridView_; - LowDimGridView lowDimGridView_; - - BulkTimeManager bulkTimeManager_; - LowDimTimeManager lowDimTimeManager_; - - Scalar maxTimeStepSize_; - BulkProblem bulkProblem_; - LowDimProblem lowDimProblem_; - - BulkSolutionVector previousSolBulk_; - LowDimSolutionVector previousSolLowDim_; - - BulkSolutionVector currentSolBulk_; - LowDimSolutionVector currentSolLowDim_; - - std::shared_ptr<CouplingManager> couplingManager_; - - Model model_; - - NewtonMethod newtonMethod_; - NewtonController newtonCtl_; - - Scalar episodeTime_; - - bool useIterativeSolver_; - - // for the iterative algorithm - int maxIterations_; - Scalar tolerance_; - bool verbose_; - - std::string name_; -}; - -}//end namespace Dumux - -#endif diff --git a/dumux/mixeddimension/properties.hh b/dumux/mixeddimension/properties.hh deleted file mode 100644 index 0fb5e7fe686bea93913e5dd741c2291f14aa5034..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/properties.hh +++ /dev/null @@ -1,199 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup MixedDimension - * \brief Base properties for problems of mixed dimension - * two sub problems - */ - -#ifndef DUMUX_MIXEDDIMENSION_PROPERTIES_HH -#define DUMUX_MIXEDDIMENSION_PROPERTIES_HH - -#include <dune/common/fvector.hh> -#include <dune/common/fmatrix.hh> -#include <dune/common/indices.hh> -#include <dune/istl/bcrsmatrix.hh> -#include <dune/istl/multitypeblockvector.hh> -#include <dune/istl/multitypeblockmatrix.hh> - -#include <dumux/common/basicproperties.hh> -#include <dumux/nonlinear/newtonmethod.hh> -#include <dumux/common/timemanager.hh> - -#include <dumux/mixeddimension/subproblemlocaljacobian.hh> - -namespace Dumux -{ - -// forward declarations -template <class TypeTag> class MixedDimensionModel; -// template <class TypeTag> class BulkLocalJacobian; -// template <class TypeTag> class LowDimLocalJacobian; -template <class TypeTag> class MixedDimensionNewtonController; -template <class TypeTag> class MixedDimensionAssembler; - -namespace Properties -{ -// NumericModel provides Scalar, GridCreator, ParameterTree -NEW_TYPE_TAG(MixedDimension, INHERITS_FROM(NewtonMethod, LinearSolverTypeTag, NumericModel)); - -NEW_PROP_TAG(Model); //!< The type of the base class of the model -NEW_PROP_TAG(BulkLocalJacobian); //!< The type of the bulk local jacobian operator -NEW_PROP_TAG(LowDimLocalJacobian); //!< The type of the low dim local jacobian operator - -NEW_PROP_TAG(SolutionVector); //!< Vector containing all primary variable vector of the grid - -NEW_PROP_TAG(JacobianAssembler); //!< Assembles the global jacobian matrix -NEW_PROP_TAG(JacobianMatrix); //!< Type of the global jacobian matrix - -// high level simulation control -NEW_PROP_TAG(TimeManager); //!< Manages the simulation time - -/*! - * \brief Specify which kind of method should be used to numerically - * calculate the partial derivatives of the residual. - * - * -1 means backward differences, 0 means central differences, 1 means - * forward differences. By default we use central differences. - */ -NEW_PROP_TAG(ImplicitNumericDifferenceMethod); - -//! the maximum allowed number of timestep divisions for the -//! Newton solver -NEW_PROP_TAG(ImplicitMaxTimeStepDivisions); - -// property tags that will be set in the problem at hand -NEW_PROP_TAG(BulkProblemTypeTag); -NEW_PROP_TAG(LowDimProblemTypeTag); -NEW_PROP_TAG(Problem); -NEW_PROP_TAG(CouplingManager); -NEW_PROP_TAG(MixedDimensionUseIterativeSolver); -NEW_PROP_TAG(SubProblemBlockIndices); - -// forward declarations -NEW_PROP_TAG(NumEq); - -////////////////////////////////////////////////////////////////// -// Properties -////////////////////////////////////////////////////////////////// -//! use the plain newton method by default -SET_TYPE_PROP(MixedDimension, NewtonMethod, NewtonMethod<TypeTag>); - -//! set default values -SET_TYPE_PROP(MixedDimension, NewtonController, MixedDimensionNewtonController<TypeTag>); - -//! Set the assembler -SET_TYPE_PROP(MixedDimension, JacobianAssembler, MixedDimensionAssembler<TypeTag>); - -//! Set the BaseModel to MixedDimensionModel -SET_TYPE_PROP(MixedDimension, Model, MixedDimensionModel<TypeTag>); - -//! The local jacobian operators -SET_TYPE_PROP(MixedDimension, BulkLocalJacobian, BulkLocalJacobian<TypeTag>); -SET_TYPE_PROP(MixedDimension, LowDimLocalJacobian, LowDimLocalJacobian<TypeTag>); - -//! use forward differences to calculate the jacobian by default -SET_INT_PROP(MixedDimension, ImplicitNumericDifferenceMethod, +1); - -//! default property value for the time manager -SET_TYPE_PROP(MixedDimension, TimeManager, TimeManager<TypeTag>); - -//! default property is monolithic solver -SET_BOOL_PROP(MixedDimension, MixedDimensionUseIterativeSolver, false); - -//! default property value for the solution vector only used for monolithic solver -SET_PROP(MixedDimension, SolutionVector) -{ -private: - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); -public: - using SolutionVectorBulk = typename GET_PROP_TYPE(BulkProblemTypeTag, SolutionVector); - using SolutionVectorLowDim = typename GET_PROP_TYPE(LowDimProblemTypeTag, SolutionVector); - using type = Dune::MultiTypeBlockVector<SolutionVectorBulk, SolutionVectorLowDim>; -}; - -//! Set the type of a global jacobian matrix from the solution types -SET_PROP(MixedDimension, JacobianMatrix) -{ -private: - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - enum { - numEqBulk = GET_PROP_VALUE(BulkProblemTypeTag, NumEq), - numEqLowDim = GET_PROP_VALUE(LowDimProblemTypeTag, NumEq) - }; - -public: - // the sub-blocks - using MatrixLittleBlockBulk = Dune::FieldMatrix<Scalar, numEqBulk, numEqBulk>; - using MatrixLittleBlockBulkCoupling = Dune::FieldMatrix<Scalar, numEqBulk, numEqLowDim>; - using MatrixLittleBlockLowDim = Dune::FieldMatrix<Scalar, numEqLowDim, numEqLowDim>; - using MatrixLittleBlockLowDimCoupling = Dune::FieldMatrix<Scalar, numEqLowDim, numEqBulk>; - - // the BCRS matrices of the subproblems as big blocks - using MatrixBlockBulk = Dune::BCRSMatrix<MatrixLittleBlockBulk>; - using MatrixBlockBulkCoupling = Dune::BCRSMatrix<MatrixLittleBlockBulkCoupling>; - using MatrixBlockLowDim = Dune::BCRSMatrix<MatrixLittleBlockLowDim>; - using MatrixBlockLowDimCoupling = Dune::BCRSMatrix<MatrixLittleBlockLowDimCoupling>; - - // the row types - using RowBulk = Dune::MultiTypeBlockVector<MatrixBlockBulk, MatrixBlockBulkCoupling>; - using RowLowDim = Dune::MultiTypeBlockVector<MatrixBlockLowDimCoupling, MatrixBlockLowDim>; - - // the jacobian matrix - using type = Dune::MultiTypeBlockMatrix<RowBulk, RowLowDim>; -}; - -//! Definition of the indices of the subproblems in the global solution vector -SET_PROP(MixedDimension, SubProblemBlockIndices) -{ - using BulkIdx = Dune::index_constant<0>; - using LowDimIdx = Dune::index_constant<1>; -}; - -//! set default solver -SET_TYPE_PROP(MixedDimension, LinearSolver, GSBiCGSTABBackend<TypeTag>); - -//! set the block level to 2, suitable for e.g. the Dune::MultiTypeBlockMatrix -SET_INT_PROP(MixedDimension, LinearSolverPreconditionerBlockLevel, 2); - -//! if the deflection of the newton method is large, we do not -//! need to solve the linear approximation accurately. Assuming -//! that the initial value for the delta vector u is quite -//! close to the final value, a reduction of 6 orders of -//! magnitude in the defect should be sufficient... -SET_SCALAR_PROP(MixedDimension, LinearSolverResidualReduction, 1e-6); - -//! set the default number of maximum iterations for the linear solver -SET_INT_PROP(MixedDimension, LinearSolverMaxIterations, 250); - -//! set number of equations of the mathematical model as default -SET_INT_PROP(MixedDimension, LinearSolverBlockSize, 1); - -//! set number of maximum timestep divisions to 10 -SET_INT_PROP(MixedDimension, ImplicitMaxTimeStepDivisions, 10); - -}//end namespace Properties - -}//end namespace Dumux - -#endif diff --git a/dumux/mixeddimension/subproblemlocaljacobian.hh b/dumux/mixeddimension/subproblemlocaljacobian.hh deleted file mode 100644 index fbb64e6967623c940fb810184918f087b138ec1d..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/subproblemlocaljacobian.hh +++ /dev/null @@ -1,522 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup MixedDimension - * \brief Caculates the Jacobian of the local residual for fully-implicit models - */ -#ifndef DUMUX_SUBPROBLEM_LOCAL_JACOBIAN_HH -#define DUMUX_SUBPROBLEM_LOCAL_JACOBIAN_HH - -#include <dune/common/indices.hh> -#include <dune/istl/matrix.hh> - -#include <dumux/common/math.hh> -#include <dumux/common/valgrind.hh> - -#include <dumux/mixeddimension/properties.hh> - -namespace Dumux -{ - -namespace Properties -{ - // forward declaration of property tags - NEW_PROP_TAG(BulkProblemTypeTag); - NEW_PROP_TAG(LowDimProblemTypeTag); -} - - -template <class TypeTag, class SubProblemTypeTag> -class SubProblemLocalJacobian; - -template<class TypeTag> -using BulkLocalJacobian = SubProblemLocalJacobian<TypeTag, typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag)>; -template<class TypeTag> -using LowDimLocalJacobian = SubProblemLocalJacobian<TypeTag, typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag)>; - -/*! - * \ingroup MixedDimension - * \brief Calculates the Jacobian of the local residual for one subdomain domain - * - * The default behavior is to use numeric differentiation, i.e. - * forward or backward differences (2nd order), or central - * differences (3rd order). The method used is determined by the - * "NumericDifferenceMethod" property: - * - * - if the value of this property is smaller than 0, backward - * differences are used, i.e.: - * \f[ - \frac{\partial f(x)}{\partial x} \approx \frac{f(x) - f(x - \epsilon)}{\epsilon} - * \f] - * - * - if the value of this property is 0, central - * differences are used, i.e.: - * \f[ - \frac{\partial f(x)}{\partial x} \approx \frac{f(x + \epsilon) - f(x - \epsilon)}{2 \epsilon} - * \f] - * - * - if the value of this property is larger than 0, forward - * differences are used, i.e.: - * \f[ - \frac{\partial f(x)}{\partial x} \approx \frac{f(x + \epsilon) - f(x)}{\epsilon} - * \f] - * - * Here, \f$ f \f$ is the residual function for all equations, \f$x\f$ - * is the value of a sub-control volume's primary variable at the - * evaluation point and \f$\epsilon\f$ is a small value larger than 0. - */ -template<class TypeTag, class SubProblemTypeTag> -class SubProblemLocalJacobian : public GET_PROP_TYPE(SubProblemTypeTag, LocalJacobian) -{ - using ParentType = typename GET_PROP_TYPE(SubProblemTypeTag, LocalJacobian); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using GlobalProblem = typename GET_PROP_TYPE(TypeTag, Problem); - - // types of the sub problem - using Problem = typename GET_PROP_TYPE(SubProblemTypeTag, Problem); - using FVElementGeometry = typename GET_PROP_TYPE(SubProblemTypeTag, FVElementGeometry); - using ElementSolutionVector = typename GET_PROP_TYPE(SubProblemTypeTag, ElementSolutionVector); - using PrimaryVariables = typename GET_PROP_TYPE(SubProblemTypeTag, PrimaryVariables); - using VolumeVariables = typename GET_PROP_TYPE(SubProblemTypeTag, VolumeVariables); - using ElementVolumeVariables = typename GET_PROP_TYPE(SubProblemTypeTag, ElementVolumeVariables); - using ElementFluxVariablesCache = typename GET_PROP_TYPE(SubProblemTypeTag, ElementFluxVariablesCache); - using ElementBoundaryTypes = typename GET_PROP_TYPE(SubProblemTypeTag, ElementBoundaryTypes); - using LocalResidual = typename GET_PROP_TYPE(SubProblemTypeTag, LocalResidual); - using GridView = typename GET_PROP_TYPE(SubProblemTypeTag, GridView); - using IndexType = typename GridView::IndexSet::IndexType; - using Element = typename GridView::template Codim<0>::Entity; - using SolutionVector = typename GET_PROP_TYPE(SubProblemTypeTag, SolutionVector); - - enum { isBox = GET_PROP_VALUE(SubProblemTypeTag, ImplicitIsBox) }; - -public: - - // copying a local jacobian is not a good idea - SubProblemLocalJacobian(const SubProblemLocalJacobian &) = delete; - - SubProblemLocalJacobian() - { numericDifferenceMethod_ = GET_PARAM_FROM_GROUP(TypeTag, int, Implicit, NumericDifferenceMethod); } - - /*! - * \brief Initialize the local Jacobian object. - * - * At this point we can assume that everything has been allocated, - * although some objects may not yet be completely initialized. - * - * \param problem The problem which we want to simulate. - */ - void init(GlobalProblem &globalProblem) - { - globalProblemPtr_ = &globalProblem; - ParentType::init(problem_()); - } - - /*! - * \brief Assemble an element's local Jacobian matrix of the - * defect. - * - * \param element The DUNE Codim<0> entity which we look at. - */ - template<class JacobianMatrix, class JacobianMatrixCoupling> - void assemble(const Element &element, - JacobianMatrix& matrix, - JacobianMatrixCoupling& couplingMatrix, - SolutionVector& residual) - { - // prepare the volvars/fvGeometries in case caching is disabled - auto fvGeometry = localView(this->model_().fvGridGeometry()); - fvGeometry.bind(element); - - auto curElemVolVars = localView(this->model_().curGridVolVars()); - curElemVolVars.bind(element, fvGeometry, this->model_().curSol()); - - auto prevElemVolVars = localView(this->model_().prevGridVolVars()); - prevElemVolVars.bindElement(element, fvGeometry, this->model_().prevSol()); - - auto elemFluxVarsCache = localView(this->model_().gridFluxVarsCache()); - elemFluxVarsCache.bind(element, fvGeometry, curElemVolVars); - - // check for boundaries on the element - ElementBoundaryTypes elemBcTypes; - elemBcTypes.update(this->problem_(), element, fvGeometry); - - assemble_(element, fvGeometry, prevElemVolVars, curElemVolVars, elemFluxVarsCache, elemBcTypes, matrix, couplingMatrix, residual); - } - -protected: - - // for cell-centered models - template<class JacobianMatrix, class JacobianMatrixCoupling, class T = SubProblemTypeTag, typename std::enable_if<((!GET_PROP_VALUE(T, ImplicitIsBox))), bool>::type = 0> - void assemble_(const Element& element, - const FVElementGeometry& fvGeometry, - ElementVolumeVariables& prevElemVolVars, - ElementVolumeVariables& curElemVolVars, - ElementFluxVariablesCache& elemFluxVarsCache, - const ElementBoundaryTypes& elemBcTypes, - JacobianMatrix& matrix, - JacobianMatrixCoupling& couplingMatrix, - SolutionVector& residual) - { - const bool isGhost = (element.partitionType() == Dune::GhostEntity); - - // set the actual dof index - this->globalI_ = this->problem_().elementMapper().index(element); - - // Evaluate the undeflected element local residual - this->localResidual().eval(element, - fvGeometry, - prevElemVolVars, - curElemVolVars, - elemBcTypes, - elemFluxVarsCache); - this->residual_ = this->localResidual().residual(); - - // set the global residual - residual[this->globalI_] = this->localResidual().residual(0); - - // calculate derivatives of all dofs in stencil with respect to the dofs in the element - this->evalPartialDerivatives_(element, - fvGeometry, - prevElemVolVars, - curElemVolVars, - elemFluxVarsCache, - elemBcTypes, - matrix, - residual, - isGhost); - - // compute derivatives with respect to additional user defined DOF dependencies - const auto& additionalDofDepedencies = this->problem_().getAdditionalDofDependencies(this->globalI_); - if (!additionalDofDepedencies.empty() && !isGhost) - { - this->evalAdditionalDerivatives_(additionalDofDepedencies, - element, - fvGeometry, - curElemVolVars, - matrix, - residual); - } - - evalPartialDerivativeCoupling_(element, - fvGeometry, - curElemVolVars, - elemFluxVarsCache, - elemBcTypes, - couplingMatrix, - residual); - } - - // for box models - template<class JacobianMatrix, class JacobianMatrixCoupling, class T = SubProblemTypeTag, typename std::enable_if<((GET_PROP_VALUE(T, ImplicitIsBox))), bool>::type = 0> - void assemble_(const Element& element, - const FVElementGeometry& fvGeometry, - ElementVolumeVariables& prevElemVolVars, - ElementVolumeVariables& curElemVolVars, - ElementFluxVariablesCache& elemFluxVarsCache, - const ElementBoundaryTypes& elemBcTypes, - JacobianMatrix& matrix, - JacobianMatrixCoupling& couplingMatrix, - SolutionVector& residual) - { - constexpr auto numEq = GET_PROP_VALUE(T, NumEq); - - // the element solution - auto curElemSol = this->problem_().model().elementSolution(element, this->problem_().model().curSol()); - - // calculate the actual element residual - this->localResidual().eval(element, fvGeometry, prevElemVolVars, curElemVolVars, elemBcTypes, elemFluxVarsCache); - this->residual_ = this->localResidual().residual(); - - // residual[this->globalI_] = this->localResidual().residual(0); - - this->problem_().model().updatePVWeights(fvGeometry); - - // calculation of the derivatives - for (auto&& scv : scvs(fvGeometry)) - { - // dof index and corresponding actual pri vars - const auto dofIdx = scv.dofIndex(); - auto& curVolVars = this->getCurVolVars(curElemVolVars, scv); - VolumeVariables origVolVars(curVolVars); - - // add precalculated residual for this scv into the global container - residual[dofIdx] += this->residual_[scv.indexInElement()]; - - // calculate derivatives w.r.t to the privars at the dof at hand - for (int pvIdx = 0; pvIdx < numEq; pvIdx++) - { - this->evalPartialDerivative_(matrix, - element, - fvGeometry, - prevElemVolVars, - curElemVolVars, - curElemSol, - scv, - elemBcTypes, - elemFluxVarsCache, - pvIdx); - - // restore the original state of the scv's volume variables - curVolVars = origVolVars; - - // restore the original element solution - curElemSol[scv.indexInElement()][pvIdx] = this->problem_().model().curSol()[scv.dofIndex()][pvIdx]; - } - // TODO: what if we have an extended source stencil???? - } - //TODO: is otherElement in this method required? is otherResidual correct? - evalPartialDerivativeCouplingBox_(element, - fvGeometry, - curElemVolVars, - elemFluxVarsCache, - elemBcTypes, - couplingMatrix, - residual); - } - - /*! - * \brief Returns a reference to the problem. - */ - const GlobalProblem &globalProblem_() const - { return *globalProblemPtr_; } - - GlobalProblem &globalProblem_() - { return *globalProblemPtr_; } - - //! Return this subproblem - template<class T = TypeTag> - // static_assert(std::is_same<typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag), SubProblemTypeTag>::value, "class name: " + className<typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag)>()); - decltype(auto) problem_(typename std::enable_if<std::is_same<typename GET_PROP_TYPE(T, BulkProblemTypeTag), SubProblemTypeTag>::value, void>::type* x = nullptr) - { return globalProblem_().bulkProblem(); } - - template<class T = TypeTag> - decltype(auto) problem_(typename std::enable_if<std::is_same<typename GET_PROP_TYPE(T, LowDimProblemTypeTag), SubProblemTypeTag>::value, void>::type* x = nullptr) - { return globalProblem_().lowDimProblem(); } - - //! Return the other subproblem - template<class T = TypeTag> - decltype(auto) otherProblem_(typename std::enable_if<!std::is_same<typename GET_PROP_TYPE(T, BulkProblemTypeTag), SubProblemTypeTag>::value, void>::type* x = nullptr) - { return globalProblem_().bulkProblem(); } - - template<class T = TypeTag> - decltype(auto) otherProblem_(typename std::enable_if<!std::is_same<typename GET_PROP_TYPE(T, LowDimProblemTypeTag), SubProblemTypeTag>::value, void>::type* x = nullptr) - { return globalProblem_().lowDimProblem(); } - - // cell-centered - template<class JacobianMatrixCoupling> - void evalPartialDerivativeCoupling_(const Element& element, - const FVElementGeometry& fvGeometry, - ElementVolumeVariables& curElemVolVars, - ElementFluxVariablesCache& elemFluxVarsCache, - const ElementBoundaryTypes& elemBcTypes, - JacobianMatrixCoupling& couplingMatrix, - SolutionVector& residual) - { - const auto& couplingStencil = globalProblem_().couplingManager().couplingStencil(element); - - for (auto globalJ : couplingStencil) - { - const auto otherElement = otherProblem_().model().fvGridGeometry().element(globalJ); - const auto originalResidual = globalProblem_().couplingManager().evalCouplingResidual(element, - fvGeometry, - curElemVolVars, - elemBcTypes, - elemFluxVarsCache, - otherElement); - - auto& otherPriVars = otherProblem_().model().curSol()[globalJ]; - auto originalOtherPriVars = otherPriVars; - - // derivatives in the neighbors with repect to the current elements - PrimaryVariables partialDeriv; - for (int pvIdx = 0; pvIdx < otherPriVars.size(); pvIdx++) - { - const Scalar eps = this->numericEpsilon(otherPriVars[pvIdx]); - Scalar delta = 0; - - if (numericDifferenceMethod_ >= 0) - { - // we are not using backward differences, i.e. we need to - // calculate f(x + \epsilon) - - // deflect primary variables - otherPriVars[pvIdx] += eps; - delta += eps; - - // calculate the residual with the deflected primary variables - partialDeriv = globalProblem_().couplingManager().evalCouplingResidual(element, - fvGeometry, - curElemVolVars, - elemBcTypes, - elemFluxVarsCache, - otherElement); - } - else - { - // we are using backward differences, i.e. we don't need - // to calculate f(x + \epsilon) and we can recycle the - // (already calculated) residual f(x) - partialDeriv = originalResidual; - } - - - if (numericDifferenceMethod_ <= 0) - { - // we are not using forward differences, i.e. we - // need to calculate f(x - \epsilon) - - // deflect the primary variables - otherPriVars[pvIdx] -= 2*eps; - delta += eps; - - // calculate the residual with the deflected primary variables - partialDeriv -= globalProblem_().couplingManager().evalCouplingResidual(element, - fvGeometry, - curElemVolVars, - elemBcTypes, - elemFluxVarsCache, - otherElement); - } - else - { - // we are using forward differences, i.e. we don't need to - // calculate f(x - \epsilon) and we can recycle the - // (already calculated) residual f(x) - partialDeriv -= originalResidual; - } - - // divide difference in residuals by the magnitude of the - // deflections between the two function evaluation - partialDeriv /= delta; - - // restore the original state of the element solution vector - otherPriVars = originalOtherPriVars; - - // update the global jacobian matrix (coupling block) - this->updateGlobalJacobian_(couplingMatrix, this->globalI_, globalJ, pvIdx, partialDeriv); - } - } - } - - // box - template<class JacobianMatrixCoupling> - void evalPartialDerivativeCouplingBox_(const Element& element, - const FVElementGeometry& fvGeometry, - ElementVolumeVariables& curElemVolVars, - ElementFluxVariablesCache& elemFluxVarsCache, - const ElementBoundaryTypes& elemBcTypes, - JacobianMatrixCoupling& couplingMatrix, - SolutionVector& residual) - { - const auto& couplingStencil = globalProblem_().couplingManager().couplingStencil(element); - constexpr auto numEq = GET_PROP_VALUE(SubProblemTypeTag, NumEq); - - for (auto globalJ : couplingStencil) - { - const auto otherResidual = globalProblem_().couplingManager().evalCouplingResidual(element, - fvGeometry, - curElemVolVars, - elemBcTypes, - elemFluxVarsCache); - - auto& otherPriVars = otherProblem_().model().curSol()[globalJ]; - auto originalOtherPriVars = otherPriVars; - - // derivatives in the neighbors with repect to the current elements - ElementSolutionVector partialDeriv(fvGeometry.numScv()); - for (int pvIdx = 0; pvIdx < numEq; pvIdx++) - { - const Scalar eps = this->numericEpsilon(otherPriVars[pvIdx]); - Scalar delta = 0; - - if (numericDifferenceMethod_ >= 0) - { - // we are not using backward differences, i.e. we need to - // calculate f(x + \epsilon) - - // deflect primary variables - otherPriVars[pvIdx] += eps; - delta += eps; - - // calculate the residual with the deflected primary variables - partialDeriv = globalProblem_().couplingManager().evalCouplingResidual(element, - fvGeometry, - curElemVolVars, - elemBcTypes, - elemFluxVarsCache); - } - else - { - // we are using backward differences, i.e. we don't need - // to calculate f(x + \epsilon) and we can recycle the - // (already calculated) residual f(x) - partialDeriv = otherResidual; - } - - - if (numericDifferenceMethod_ <= 0) - { - // we are not using forward differences, i.e. we - // need to calculate f(x - \epsilon) - - // deflect the primary variables - otherPriVars[pvIdx] -= 2*eps; - delta += eps; - - // calculate the residual with the deflected primary variables - partialDeriv -= globalProblem_().couplingManager().evalCouplingResidual(element, - fvGeometry, - curElemVolVars, - elemBcTypes, - elemFluxVarsCache); - } - else - { - // we are using forward differences, i.e. we don't need to - // calculate f(x - \epsilon) and we can recycle the - // (already calculated) residual f(x) - partialDeriv -= otherResidual; - } - - // divide difference in residuals by the magnitude of the - // deflections between the two function evaluation - partialDeriv /= delta; - - // restore the original state of the element solution vector - otherPriVars = originalOtherPriVars; - - // update the global jacobian matrix (coupling block) - // this->updateGlobalJacobian_(couplingMatrix, scv.dofIndex(), globalJ, pvIdx, partialDeriv[scv.dofIndex()]); - - for (auto&& scv : scvs(fvGeometry)) - this->updateGlobalJacobian_(couplingMatrix, scv.dofIndex(), globalJ, pvIdx, partialDeriv[scv.indexInElement()]); - } - } - } - - // The problem we would like to solve - GlobalProblem *globalProblemPtr_; - // The type of the numeric difference method (forward, center, backward) - int numericDifferenceMethod_; -}; - -} // end namespace Dumux - -#endif diff --git a/dumux/mixeddimension/subproblemproperties.hh b/dumux/mixeddimension/subproblemproperties.hh deleted file mode 100644 index 9a9e7dde3727b005485f88480e3dafe31f6398fa..0000000000000000000000000000000000000000 --- a/dumux/mixeddimension/subproblemproperties.hh +++ /dev/null @@ -1,38 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup MixedDimension - * \brief Base class for subproblems of coupled problems - */ -#ifndef DUMUX_SUB_PROBLEM_PROPERTIES_HH -#define DUMUX_SUB_PROBLEM_PROPERTIES_HH - -#include <dumux/common/propertysystem.hh> - -namespace Dumux -{ -namespace Properties -{ - //! The type of the coupling manager - NEW_PROP_TAG(GlobalProblemTypeTag); - NEW_PROP_TAG(CouplingManager); -} -} -#endif diff --git a/test/mixeddimension/CMakeLists.txt b/test/mixeddimension/CMakeLists.txt deleted file mode 100644 index bd0d2f725097fe48de0a6c529f56d016bd5597a9..0000000000000000000000000000000000000000 --- a/test/mixeddimension/CMakeLists.txt +++ /dev/null @@ -1,2 +0,0 @@ -add_subdirectory("embedded") -add_subdirectory("facet") diff --git a/test/mixeddimension/embedded/1p2c_richards2c/CMakeLists.txt b/test/mixeddimension/embedded/1p2c_richards2c/CMakeLists.txt deleted file mode 100644 index 59a872ee9c6306fa85ba0603e1caa4e8b0b16976..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p2c_richards2c/CMakeLists.txt +++ /dev/null @@ -1,13 +0,0 @@ -dune_add_test( - NAME test_rosi2c - SOURCES test_rosi2c.cc - COMMAND ${CMAKE_SOURCE_DIR}/bin/testing/runtest.py - CMD_ARGS --script fuzzy - --files ${CMAKE_SOURCE_DIR}/test/references/rosi2c-root-reference.vtp - ${CMAKE_CURRENT_BINARY_DIR}/rosi2c-root-00010.vtp - ${CMAKE_SOURCE_DIR}/test/references/rosi2c-soil-reference.vtu - ${CMAKE_CURRENT_BINARY_DIR}/rosi2c-soil-00010.vtu - --command "${CMAKE_CURRENT_BINARY_DIR}/test_rosi2c -TimeManager.TEnd 86400" - ) - -dune_symlink_to_source_files(FILES "grids" "test_rosi2c.input") diff --git a/test/mixeddimension/embedded/1p2c_richards2c/grids/lupine.dgf b/test/mixeddimension/embedded/1p2c_richards2c/grids/lupine.dgf deleted file mode 100644 index a13c4d3956f94a0f7ae164f7de6ef87b8dc82e89..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p2c_richards2c/grids/lupine.dgf +++ /dev/null @@ -1,3486 +0,0 @@ -DGF -Vertex -0.000389 0.000879 0.000800 # node 0 -0.000389 0.000879 -0.000294 # node 1 -0.000778 0.001758 -0.000589 # node 2 -0.001167 0.002638 -0.000883 # node 3 -0.001555 0.003517 -0.001178 # node 4 -0.001944 0.004396 -0.001472 # node 5 -0.002333 0.005275 -0.001767 # node 6 -0.002722 0.006154 -0.002061 # node 7 -0.003009 0.006712 -0.002838 # node 8 -0.003295 0.007269 -0.003615 # node 9 -0.003582 0.007826 -0.004392 # node 10 -0.003869 0.008384 -0.005169 # node 11 -0.003835 0.008394 -0.006178 # node 12 -0.003802 0.008404 -0.007186 # node 13 -0.003768 0.008415 -0.008195 # node 14 -0.003734 0.008425 -0.009203 # node 15 -0.003701 0.008435 -0.010211 # node 16 -0.003667 0.008446 -0.011220 # node 17 -0.003634 0.008456 -0.012228 # node 18 -0.003379 0.008194 -0.013152 # node 19 -0.003125 0.007931 -0.014077 # node 20 -0.002871 0.007669 -0.015001 # node 21 -0.002617 0.007406 -0.015924 # node 22 -0.002303 0.006929 -0.016611 # node 23 -0.001990 0.006453 -0.017298 # node 24 -0.001676 0.005977 -0.017983 # node 25 -0.001362 0.005500 -0.018670 # node 26 -0.001048 0.005024 -0.019357 # node 27 -0.000652 0.004517 -0.019932 # node 28 -0.000256 0.004010 -0.020508 # node 29 --0.000140 0.003502 -0.021084 # node 30 --0.000536 0.002995 -0.021660 # node 31 --0.001022 0.003569 -0.022299 # node 32 --0.001508 0.004143 -0.022938 # node 33 --0.001994 0.004718 -0.023577 # node 34 --0.002480 0.005292 -0.024217 # node 35 --0.002966 0.005866 -0.024856 # node 36 --0.003058 0.006804 -0.025014 # node 37 --0.003149 0.007742 -0.025174 # node 38 --0.003241 0.008681 -0.025334 # node 39 --0.003333 0.009619 -0.025494 # node 40 --0.003424 0.010557 -0.025654 # node 41 --0.003516 0.011496 -0.025814 # node 42 --0.003608 0.012434 -0.025974 # node 43 --0.003699 0.013373 -0.026133 # node 44 --0.003791 0.014311 -0.026293 # node 45 --0.003883 0.015249 -0.026453 # node 46 --0.003974 0.016188 -0.026613 # node 47 --0.004066 0.017126 -0.026773 # node 48 --0.004158 0.018064 -0.026933 # node 49 --0.004739 0.018185 -0.027691 # node 50 --0.005321 0.018305 -0.028450 # node 51 --0.005903 0.018425 -0.029208 # node 52 --0.006485 0.018546 -0.029967 # node 53 --0.007204 0.018230 -0.030649 # node 54 --0.007923 0.017914 -0.031331 # node 55 --0.008641 0.017599 -0.032014 # node 56 --0.009360 0.017283 -0.032697 # node 57 --0.010079 0.016968 -0.033379 # node 58 --0.010357 0.016663 -0.034164 # node 59 --0.010634 0.016358 -0.034950 # node 60 --0.010912 0.016052 -0.035736 # node 61 --0.011189 0.015747 -0.036521 # node 62 --0.010909 0.015791 -0.037468 # node 63 --0.010629 0.015834 -0.038413 # node 64 --0.010349 0.015877 -0.039360 # node 65 --0.010069 0.015921 -0.040306 # node 66 --0.009789 0.015964 -0.041252 # node 67 --0.009508 0.016008 -0.042198 # node 68 --0.009228 0.016051 -0.043144 # node 69 --0.008849 0.016040 -0.044108 # node 70 --0.008470 0.016030 -0.045071 # node 71 --0.008091 0.016019 -0.046033 # node 72 --0.007712 0.016009 -0.046997 # node 73 --0.007333 0.015998 -0.047960 # node 74 --0.006955 0.015988 -0.048923 # node 75 --0.006377 0.015992 -0.049798 # node 76 --0.005799 0.015997 -0.050672 # node 77 --0.005222 0.016002 -0.051547 # node 78 --0.004644 0.016006 -0.052422 # node 79 --0.003947 0.015928 -0.053168 # node 80 --0.003250 0.015851 -0.053913 # node 81 --0.002553 0.015773 -0.054659 # node 82 --0.001856 0.015695 -0.055404 # node 83 --0.001121 0.015925 -0.055700 # node 84 --0.000385 0.016155 -0.055996 # node 85 -0.000350 0.016385 -0.056291 # node 86 -0.001085 0.016615 -0.056587 # node 87 -0.001363 0.017132 -0.057363 # node 88 -0.001640 0.017649 -0.058139 # node 89 -0.001918 0.018166 -0.058916 # node 90 -0.002196 0.018683 -0.059692 # node 91 -0.002474 0.019199 -0.060468 # node 92 -0.002752 0.019716 -0.061244 # node 93 -0.002838 0.019743 -0.062281 # node 94 -0.002925 0.019769 -0.063318 # node 95 -0.003012 0.019795 -0.064356 # node 96 -0.003099 0.019822 -0.065392 # node 97 -0.003186 0.019848 -0.066429 # node 98 -0.003512 0.019897 -0.067379 # node 99 -0.003838 0.019946 -0.068328 # node 100 -0.004163 0.019995 -0.069278 # node 101 -0.004489 0.020044 -0.070227 # node 102 -0.004448 0.019865 -0.071091 # node 103 -0.004407 0.019687 -0.071956 # node 104 -0.004366 0.019509 -0.072820 # node 105 -0.004326 0.019331 -0.073683 # node 106 -0.004494 0.019245 -0.074766 # node 107 -0.004663 0.019158 -0.075847 # node 108 -0.004832 0.019072 -0.076928 # node 109 -0.005000 0.018986 -0.078009 # node 110 -0.005169 0.018900 -0.079091 # node 111 --0.003467 0.018531 -0.027004 # node 112 --0.002776 0.018997 -0.027077 # node 113 --0.002086 0.019464 -0.027149 # node 114 --0.001395 0.019930 -0.027221 # node 115 --0.000548 0.020022 -0.027549 # node 116 -0.000298 0.020115 -0.027877 # node 117 -0.001145 0.020207 -0.028203 # node 118 -0.001992 0.020299 -0.028531 # node 119 --0.003277 0.018464 -0.026658 # node 120 --0.002396 0.018864 -0.026383 # node 121 --0.001516 0.019264 -0.026108 # node 122 --0.000513 0.019296 -0.026131 # node 123 -0.000489 0.019328 -0.026153 # node 124 -0.001270 0.005523 -0.019851 # node 125 -0.001492 0.006021 -0.020347 # node 126 -0.001714 0.006520 -0.020841 # node 127 -0.002488 0.006843 -0.021176 # node 128 -0.003263 0.007166 -0.021511 # node 129 -0.004038 0.007489 -0.021846 # node 130 -0.004812 0.007812 -0.022180 # node 131 -0.005738 0.008029 -0.022481 # node 132 -0.006664 0.008245 -0.022782 # node 133 -0.007589 0.008462 -0.023083 # node 134 -0.008515 0.008679 -0.023384 # node 135 -0.009441 0.008896 -0.023686 # node 136 -0.010044 0.008824 -0.024267 # node 137 -0.010647 0.008752 -0.024849 # node 138 -0.011249 0.008680 -0.025430 # node 139 -0.012147 0.008597 -0.025799 # node 140 -0.013044 0.008515 -0.026168 # node 141 -0.013941 0.008432 -0.026537 # node 142 -0.014838 0.008349 -0.026904 # node 143 -0.015435 0.007968 -0.027519 # node 144 -0.016032 0.007587 -0.028133 # node 145 -0.016742 0.007504 -0.028620 # node 146 -0.017453 0.007422 -0.029106 # node 147 -0.018164 0.007339 -0.029591 # node 148 -0.018874 0.007256 -0.030077 # node 149 -0.018708 0.007520 -0.030891 # node 150 -0.018542 0.007783 -0.031707 # node 151 -0.018376 0.008046 -0.032521 # node 152 -0.017748 0.008417 -0.032940 # node 153 -0.017120 0.008789 -0.033358 # node 154 -0.016493 0.009161 -0.033776 # node 155 -0.015865 0.009533 -0.034193 # node 156 -0.015351 0.009881 -0.034916 # node 157 -0.014836 0.010229 -0.035639 # node 158 -0.014322 0.010577 -0.036361 # node 159 -0.013961 0.010666 -0.037306 # node 160 -0.013599 0.010755 -0.038249 # node 161 -0.013238 0.010844 -0.039193 # node 162 -0.012876 0.010934 -0.040137 # node 163 -0.012866 0.010814 -0.041064 # node 164 -0.012855 0.010695 -0.041992 # node 165 -0.012844 0.010576 -0.042920 # node 166 -0.012833 0.010457 -0.043847 # node 167 -0.012823 0.010338 -0.044774 # node 168 -0.012812 0.010219 -0.045702 # node 169 -0.000021 -0.000080 -0.000946 # node 170 -0.000042 -0.000159 -0.001892 # node 171 -0.000063 -0.000239 -0.002839 # node 172 -0.000084 -0.000319 -0.003785 # node 173 -0.000105 -0.000398 -0.004731 # node 174 --0.000098 -0.000611 -0.005684 # node 175 --0.000300 -0.000824 -0.006636 # node 176 --0.000503 -0.001037 -0.007589 # node 177 --0.000412 -0.001103 -0.008357 # node 178 --0.000320 -0.001169 -0.009125 # node 179 --0.000229 -0.001234 -0.009894 # node 180 --0.000378 -0.001898 -0.010650 # node 181 --0.000526 -0.002561 -0.011407 # node 182 --0.000675 -0.003225 -0.012162 # node 183 --0.000773 -0.003424 -0.013141 # node 184 --0.000870 -0.003623 -0.014120 # node 185 --0.000968 -0.003822 -0.015100 # node 186 --0.001065 -0.004021 -0.016079 # node 187 --0.001442 -0.004609 -0.016482 # node 188 --0.001820 -0.005198 -0.016884 # node 189 --0.002197 -0.005786 -0.017288 # node 190 --0.002575 -0.006374 -0.017691 # node 191 --0.002581 -0.006757 -0.018423 # node 192 --0.002587 -0.007139 -0.019154 # node 193 --0.002594 -0.007522 -0.019887 # node 194 --0.002524 -0.008048 -0.020388 # node 195 --0.002453 -0.008574 -0.020889 # node 196 --0.002383 -0.009101 -0.021391 # node 197 --0.002416 -0.009753 -0.021877 # node 198 --0.002450 -0.010406 -0.022363 # node 199 --0.002484 -0.011058 -0.022849 # node 200 --0.002517 -0.011711 -0.023336 # node 201 --0.002323 -0.012330 -0.023630 # node 202 --0.002128 -0.012949 -0.023923 # node 203 --0.001934 -0.013569 -0.024218 # node 204 --0.001750 -0.014357 -0.024323 # node 205 --0.001566 -0.015145 -0.024429 # node 206 --0.001382 -0.015933 -0.024534 # node 207 --0.001196 -0.016741 -0.024600 # node 208 --0.001009 -0.017549 -0.024667 # node 209 --0.000824 -0.018358 -0.024732 # node 210 --0.000492 -0.019206 -0.024828 # node 211 --0.000161 -0.020055 -0.024923 # node 212 -0.000170 -0.020903 -0.025019 # node 213 -0.000629 -0.021306 -0.025352 # node 214 -0.001087 -0.021709 -0.025687 # node 215 -0.001546 -0.022112 -0.026020 # node 216 -0.002043 -0.022749 -0.026477 # node 217 -0.002541 -0.023385 -0.026932 # node 218 -0.003038 -0.024022 -0.027389 # node 219 --0.000222 -0.003884 -0.012830 # node 220 -0.000231 -0.004543 -0.013498 # node 221 -0.000684 -0.005202 -0.014164 # node 222 -0.001137 -0.005860 -0.014832 # node 223 -0.001518 -0.006542 -0.015180 # node 224 -0.001899 -0.007224 -0.015527 # node 225 -0.002280 -0.007906 -0.015873 # node 226 -0.002661 -0.008588 -0.016221 # node 227 -0.003042 -0.009270 -0.016568 # node 228 -0.003352 -0.009919 -0.017172 # node 229 -0.003661 -0.010568 -0.017778 # node 230 -0.003971 -0.011217 -0.018382 # node 231 -0.004280 -0.011866 -0.018987 # node 232 -0.004590 -0.012515 -0.019591 # node 233 -0.004900 -0.013164 -0.020197 # node 234 -0.004914 -0.013234 -0.021160 # node 235 -0.004927 -0.013303 -0.022124 # node 236 -0.004941 -0.013373 -0.023089 # node 237 -0.004955 -0.013442 -0.024053 # node 238 -0.004969 -0.013512 -0.025018 # node 239 -0.004982 -0.013581 -0.025981 # node 240 -0.004996 -0.013650 -0.026946 # node 241 -0.004950 -0.013592 -0.027931 # node 242 -0.004903 -0.013533 -0.028917 # node 243 -0.004857 -0.013475 -0.029902 # node 244 -0.004811 -0.013417 -0.030889 # node 245 -0.004764 -0.013358 -0.031874 # node 246 -0.004718 -0.013300 -0.032860 # node 247 -0.004671 -0.013241 -0.033846 # node 248 -0.004625 -0.013183 -0.034831 # node 249 -0.004579 -0.013124 -0.035817 # node 250 -0.004453 -0.013037 -0.036722 # node 251 -0.004328 -0.012950 -0.037629 # node 252 -0.004203 -0.012864 -0.038534 # node 253 -0.004077 -0.012777 -0.039440 # node 254 -0.004033 -0.012694 -0.040417 # node 255 -0.003989 -0.012612 -0.041394 # node 256 -0.003945 -0.012530 -0.042371 # node 257 -0.003901 -0.012447 -0.043348 # node 258 -0.003857 -0.012365 -0.044326 # node 259 -0.003813 -0.012282 -0.045302 # node 260 -0.003770 -0.012200 -0.046279 # node 261 -0.003572 -0.012036 -0.047248 # node 262 -0.003375 -0.011872 -0.048217 # node 263 -0.003178 -0.011708 -0.049187 # node 264 -0.002980 -0.011543 -0.050156 # node 265 -0.002783 -0.011379 -0.051124 # node 266 -0.002586 -0.011215 -0.052093 # node 267 -0.002806 -0.011119 -0.052984 # node 268 -0.003026 -0.011024 -0.053877 # node 269 -0.003247 -0.010928 -0.054768 # node 270 -0.003467 -0.010832 -0.055659 # node 271 -0.003687 -0.010736 -0.056551 # node 272 -0.003794 -0.010703 -0.057563 # node 273 -0.003900 -0.010670 -0.058577 # node 274 -0.004007 -0.010637 -0.059589 # node 275 -0.004113 -0.010604 -0.060602 # node 276 -0.004220 -0.010571 -0.061614 # node 277 -0.004326 -0.010538 -0.062628 # node 278 -0.004432 -0.010505 -0.063640 # node 279 -0.004539 -0.010472 -0.064653 # node 280 -0.004646 -0.010439 -0.065667 # node 281 -0.004752 -0.010406 -0.066679 # node 282 -0.004858 -0.010373 -0.067692 # node 283 -0.004965 -0.010340 -0.068704 # node 284 -0.005062 -0.010486 -0.069662 # node 285 -0.005160 -0.010631 -0.070621 # node 286 -0.005257 -0.010777 -0.071579 # node 287 -0.005354 -0.010923 -0.072537 # node 288 -0.005452 -0.011068 -0.073494 # node 289 -0.005549 -0.011214 -0.074452 # node 290 -0.005646 -0.011360 -0.075410 # node 291 -0.005744 -0.011506 -0.076369 # node 292 -0.005779 -0.011476 -0.077382 # node 293 -0.005814 -0.011446 -0.078396 # node 294 -0.005850 -0.011415 -0.079409 # node 295 -0.005885 -0.011385 -0.080423 # node 296 -0.005920 -0.011355 -0.081437 # node 297 -0.005956 -0.011325 -0.082450 # node 298 -0.005991 -0.011295 -0.083464 # node 299 -0.005664 -0.011174 -0.084359 # node 300 -0.005336 -0.011054 -0.085254 # node 301 -0.005009 -0.010933 -0.086150 # node 302 -0.004681 -0.010812 -0.087046 # node 303 -0.004354 -0.010691 -0.087941 # node 304 -0.004027 -0.010570 -0.088837 # node 305 -0.004443 -0.010794 -0.056901 # node 306 -0.005199 -0.010852 -0.057250 # node 307 -0.005955 -0.010910 -0.057600 # node 308 -0.006648 -0.010527 -0.057952 # node 309 -0.007341 -0.010145 -0.058303 # node 310 -0.007216 -0.009755 -0.059136 # node 311 -0.007090 -0.009364 -0.059967 # node 312 -0.006965 -0.008974 -0.060798 # node 313 -0.006620 -0.008625 -0.061526 # node 314 -0.006275 -0.008276 -0.062253 # node 315 -0.005930 -0.007926 -0.062981 # node 316 -0.005572 -0.007782 -0.063772 # node 317 -0.005214 -0.007638 -0.064563 # node 318 -0.004855 -0.007493 -0.065353 # node 319 -0.004629 -0.007295 -0.066342 # node 320 -0.004402 -0.007097 -0.067332 # node 321 -0.004176 -0.006899 -0.068321 # node 322 -0.003730 -0.010095 -0.057103 # node 323 -0.003773 -0.009453 -0.057657 # node 324 -0.003816 -0.008811 -0.058210 # node 325 -0.003859 -0.008170 -0.058763 # node 326 -0.004345 -0.007610 -0.059489 # node 327 -0.004830 -0.007050 -0.060214 # node 328 -0.005315 -0.006491 -0.060941 # node 329 -0.005363 -0.006042 -0.061890 # node 330 -0.005412 -0.005593 -0.062840 # node 331 -0.005460 -0.005144 -0.063789 # node 332 -0.005508 -0.004695 -0.064739 # node 333 -0.005556 -0.004247 -0.065688 # node 334 -0.005604 -0.003798 -0.066638 # node 335 -0.005790 -0.003398 -0.067482 # node 336 -0.005977 -0.002999 -0.068327 # node 337 -0.006164 -0.002599 -0.069172 # node 338 -0.006350 -0.002200 -0.070017 # node 339 -0.006537 -0.001800 -0.070862 # node 340 -0.007458 -0.001535 -0.070929 # node 341 -0.008379 -0.001270 -0.070994 # node 342 -0.009301 -0.001005 -0.071061 # node 343 -0.010222 -0.000740 -0.071128 # node 344 -0.011143 -0.000475 -0.071194 # node 345 -0.011189 0.000010 -0.071974 # node 346 -0.011234 0.000496 -0.072753 # node 347 -0.011279 0.000981 -0.073533 # node 348 -0.011324 0.001467 -0.074313 # node 349 -0.010689 0.001664 -0.074888 # node 350 -0.010055 0.001860 -0.075462 # node 351 -0.009420 0.002057 -0.076037 # node 352 -0.008785 0.002254 -0.076611 # node 353 -0.008150 0.002450 -0.077186 # node 354 -0.007688 0.002729 -0.077892 # node 355 -0.007226 0.003007 -0.078599 # node 356 -0.006764 0.003285 -0.079306 # node 357 -0.006302 0.003563 -0.080012 # node 358 -0.005840 0.003841 -0.080719 # node 359 -0.005405 0.003969 -0.081608 # node 360 -0.004969 0.004097 -0.082498 # node 361 -0.004533 0.004226 -0.083388 # node 362 -0.004097 0.004354 -0.084277 # node 363 -0.004128 0.004881 -0.085154 # node 364 -0.004158 0.005409 -0.086031 # node 365 -0.004189 0.005936 -0.086909 # node 366 -0.011421 -0.000752 -0.071854 # node 367 -0.011698 -0.001030 -0.072514 # node 368 -0.011975 -0.001306 -0.073176 # node 369 -0.011950 -0.001186 -0.073976 # node 370 -0.011925 -0.001065 -0.074774 # node 371 -0.011900 -0.000945 -0.075574 # node 372 -0.012626 -0.000819 -0.075752 # node 373 -0.013351 -0.000694 -0.075931 # node 374 -0.014076 -0.000569 -0.076109 # node 375 -0.014801 -0.000443 -0.076288 # node 376 -0.015502 -0.000524 -0.075856 # node 377 -0.016204 -0.000605 -0.075424 # node 378 -0.016905 -0.000686 -0.074992 # node 379 -0.017606 -0.000766 -0.074561 # node 380 -0.001803 -0.011531 -0.052388 # node 381 -0.001020 -0.011848 -0.052682 # node 382 -0.000318 -0.011912 -0.052763 # node 383 --0.000384 -0.011976 -0.052846 # node 384 --0.001086 -0.012041 -0.052927 # node 385 --0.001646 -0.011504 -0.052940 # node 386 --0.002206 -0.010968 -0.052952 # node 387 --0.002765 -0.010431 -0.052966 # node 388 --0.002710 -0.009452 -0.053134 # node 389 --0.002655 -0.008474 -0.053303 # node 390 --0.002600 -0.007495 -0.053472 # node 391 --0.002958 -0.006610 -0.053263 # node 392 --0.003316 -0.005724 -0.053054 # node 393 --0.004008 -0.005411 -0.052924 # node 394 --0.004699 -0.005098 -0.052794 # node 395 --0.005390 -0.004784 -0.052664 # node 396 --0.006082 -0.004471 -0.052536 # node 397 --0.006594 -0.003993 -0.052906 # node 398 --0.007107 -0.003514 -0.053276 # node 399 --0.007302 -0.003659 -0.054238 # node 400 --0.007497 -0.003804 -0.055200 # node 401 --0.007693 -0.003949 -0.056161 # node 402 --0.008328 -0.003673 -0.056823 # node 403 --0.008964 -0.003396 -0.057487 # node 404 --0.009599 -0.003120 -0.058149 # node 405 --0.010235 -0.002844 -0.058811 # node 406 --0.010519 -0.002113 -0.058867 # node 407 --0.010803 -0.001383 -0.058922 # node 408 --0.011087 -0.000652 -0.058978 # node 409 --0.011327 0.000265 -0.059040 # node 410 --0.011568 0.001182 -0.059102 # node 411 --0.012309 0.001537 -0.059173 # node 412 --0.013051 0.001893 -0.059244 # node 413 --0.013792 0.002249 -0.059316 # node 414 --0.014534 0.002605 -0.059386 # node 415 --0.015275 0.002960 -0.059457 # node 416 --0.015817 0.003517 -0.060102 # node 417 --0.016359 0.004073 -0.060748 # node 418 --0.016901 0.004629 -0.061393 # node 419 --0.017501 0.004917 -0.062141 # node 420 --0.018101 0.005204 -0.062889 # node 421 --0.018701 0.005491 -0.063637 # node 422 --0.019301 0.005778 -0.064386 # node 423 --0.019900 0.006066 -0.065133 # node 424 --0.020197 0.006091 -0.066167 # node 425 --0.020494 0.006117 -0.067200 # node 426 --0.020791 0.006142 -0.068234 # node 427 --0.020892 0.006117 -0.069179 # node 428 --0.020994 0.006091 -0.070124 # node 429 --0.020802 0.005980 -0.071158 # node 430 --0.020610 0.005869 -0.072190 # node 431 --0.020418 0.005758 -0.073223 # node 432 --0.020226 0.005646 -0.074256 # node 433 --0.020302 0.005689 -0.075198 # node 434 --0.020377 0.005732 -0.076140 # node 435 --0.020453 0.005775 -0.077082 # node 436 --0.020528 0.005818 -0.078024 # node 437 --0.020604 0.005861 -0.078967 # node 438 --0.020510 0.005922 -0.079902 # node 439 --0.020415 0.005983 -0.080837 # node 440 --0.020321 0.006044 -0.081771 # node 441 --0.020227 0.006105 -0.082707 # node 442 --0.020163 0.006015 -0.083604 # node 443 --0.020099 0.005926 -0.084502 # node 444 --0.020035 0.005836 -0.085400 # node 445 --0.019972 0.005746 -0.086298 # node 446 --0.019908 0.005656 -0.087197 # node 447 --0.003470 -0.007322 -0.053616 # node 448 --0.004340 -0.007148 -0.053760 # node 449 --0.005210 -0.006975 -0.053903 # node 450 --0.006081 -0.006801 -0.054048 # node 451 --0.006767 -0.006315 -0.054277 # node 452 --0.007453 -0.005829 -0.054507 # node 453 --0.008240 -0.005770 -0.054681 # node 454 --0.009028 -0.005711 -0.054857 # node 455 --0.009815 -0.005653 -0.055031 # node 456 --0.010602 -0.005594 -0.055207 # node 457 --0.011389 -0.005535 -0.055382 # node 458 --0.011501 -0.006111 -0.055974 # node 459 --0.011613 -0.006688 -0.056568 # node 460 --0.011725 -0.007264 -0.057161 # node 461 --0.011837 -0.007840 -0.057754 # node 462 --0.011667 -0.008544 -0.058456 # node 463 --0.011497 -0.009247 -0.059157 # node 464 --0.011326 -0.009951 -0.059858 # node 465 --0.011550 -0.010437 -0.060724 # node 466 --0.011773 -0.010923 -0.061591 # node 467 --0.011996 -0.011410 -0.062458 # node 468 --0.012668 -0.011571 -0.063157 # node 469 --0.013340 -0.011732 -0.063854 # node 470 --0.014012 -0.011893 -0.064553 # node 471 --0.014258 -0.012199 -0.065304 # node 472 --0.014504 -0.012505 -0.066056 # node 473 --0.014750 -0.012811 -0.066807 # node 474 --0.014298 -0.013008 -0.067712 # node 475 --0.013847 -0.013205 -0.068618 # node 476 --0.013396 -0.013402 -0.069523 # node 477 --0.012944 -0.013599 -0.070429 # node 478 --0.012493 -0.013796 -0.071334 # node 479 --0.012042 -0.013993 -0.072240 # node 480 --0.012379 -0.014372 -0.072974 # node 481 --0.012717 -0.014751 -0.073710 # node 482 --0.013055 -0.015130 -0.074444 # node 483 --0.013392 -0.015509 -0.075179 # node 484 --0.013933 -0.015911 -0.075797 # node 485 --0.014473 -0.016314 -0.076414 # node 486 --0.015014 -0.016717 -0.077032 # node 487 --0.015554 -0.017119 -0.077650 # node 488 --0.015635 -0.017415 -0.078561 # node 489 --0.015716 -0.017711 -0.079471 # node 490 --0.015798 -0.018007 -0.080381 # node 491 --0.016407 -0.018346 -0.081099 # node 492 --0.017016 -0.018684 -0.081817 # node 493 --0.017625 -0.019023 -0.082536 # node 494 --0.018233 -0.019362 -0.083253 # node 495 --0.013128 -0.016006 -0.075833 # node 496 --0.012864 -0.016503 -0.076487 # node 497 --0.012599 -0.017000 -0.077141 # node 498 --0.012335 -0.017498 -0.077796 # node 499 --0.012513 -0.018129 -0.078340 # node 500 --0.012690 -0.018761 -0.078884 # node 501 --0.012868 -0.019392 -0.079428 # node 502 --0.013046 -0.020024 -0.079972 # node 503 --0.013224 -0.020656 -0.080517 # node 504 --0.013879 -0.021295 -0.080569 # node 505 --0.014534 -0.021935 -0.080620 # node 506 --0.015189 -0.022575 -0.080672 # node 507 --0.015843 -0.023215 -0.080723 # node 508 --0.016435 -0.022933 -0.081096 # node 509 --0.017027 -0.022652 -0.081468 # node 510 --0.017618 -0.022371 -0.081839 # node 511 --0.017624 -0.022368 -0.082792 # node 512 --0.017630 -0.022365 -0.083747 # node 513 --0.017636 -0.022363 -0.084700 # node 514 --0.017642 -0.022360 -0.085653 # node 515 --0.013520 -0.020961 -0.081127 # node 516 --0.013817 -0.021267 -0.081738 # node 517 --0.014114 -0.021572 -0.082348 # node 518 --0.014850 -0.021301 -0.083008 # node 519 --0.015586 -0.021031 -0.083667 # node 520 --0.016321 -0.020760 -0.084326 # node 521 --0.017057 -0.020489 -0.084986 # node 522 --0.017709 -0.020163 -0.085250 # node 523 --0.018361 -0.019837 -0.085514 # node 524 --0.019013 -0.019511 -0.085780 # node 525 --0.019665 -0.019184 -0.086044 # node 526 --0.019525 -0.018924 -0.086848 # node 527 --0.019385 -0.018664 -0.087651 # node 528 --0.011831 -0.017522 -0.078092 # node 529 --0.011326 -0.017546 -0.078390 # node 530 --0.011173 -0.017797 -0.079112 # node 531 --0.010734 -0.018222 -0.079716 # node 532 --0.010294 -0.018646 -0.080319 # node 533 --0.010664 -0.018725 -0.080932 # node 534 --0.011033 -0.018803 -0.081547 # node 535 --0.011113 -0.018048 -0.081939 # node 536 --0.011194 -0.017293 -0.082331 # node 537 --0.011274 -0.016537 -0.082724 # node 538 -0.003070 -0.012539 -0.046652 # node 539 -0.002370 -0.012878 -0.047027 # node 540 -0.001671 -0.013216 -0.047400 # node 541 -0.001074 -0.013742 -0.047703 # node 542 -0.000477 -0.014268 -0.048007 # node 543 --0.000119 -0.014794 -0.048310 # node 544 --0.000716 -0.015320 -0.048614 # node 545 --0.001313 -0.015846 -0.048918 # node 546 --0.001964 -0.016320 -0.049229 # node 547 --0.002616 -0.016793 -0.049541 # node 548 --0.003267 -0.017267 -0.049852 # node 549 --0.003314 -0.017752 -0.050671 # node 550 --0.003361 -0.018238 -0.051490 # node 551 --0.003407 -0.018724 -0.052309 # node 552 --0.003585 -0.019334 -0.053172 # node 553 --0.003763 -0.019943 -0.054036 # node 554 --0.004572 -0.020084 -0.054036 # node 555 --0.005381 -0.020225 -0.054036 # node 556 --0.006190 -0.020366 -0.054037 # node 557 --0.006998 -0.020506 -0.054037 # node 558 --0.003762 -0.020242 -0.055028 # node 559 --0.003760 -0.020540 -0.056019 # node 560 --0.003759 -0.020839 -0.057010 # node 561 --0.003757 -0.021137 -0.058002 # node 562 --0.003756 -0.021435 -0.058993 # node 563 --0.003755 -0.021734 -0.059984 # node 564 --0.003753 -0.022032 -0.060977 # node 565 --0.003752 -0.022331 -0.061968 # node 566 --0.003751 -0.022629 -0.062959 # node 567 -0.003917 -0.011278 -0.046354 # node 568 -0.004064 -0.010356 -0.046430 # node 569 -0.004211 -0.009434 -0.046506 # node 570 -0.004958 -0.008978 -0.046536 # node 571 -0.005704 -0.008521 -0.046566 # node 572 -0.006450 -0.008065 -0.046597 # node 573 -0.007196 -0.007608 -0.046627 # node 574 -0.007942 -0.007151 -0.046657 # node 575 -0.008228 -0.006423 -0.046657 # node 576 -0.008514 -0.005694 -0.046656 # node 577 -0.008800 -0.004966 -0.046654 # node 578 -0.009086 -0.004237 -0.046654 # node 579 -0.009727 -0.003601 -0.046978 # node 580 -0.010368 -0.002965 -0.047301 # node 581 -0.011008 -0.002329 -0.047624 # node 582 -0.011649 -0.001693 -0.047948 # node 583 -0.011714 -0.001802 -0.048843 # node 584 -0.011778 -0.001911 -0.049740 # node 585 -0.011053 -0.001914 -0.049786 # node 586 -0.010327 -0.001917 -0.049831 # node 587 -0.009602 -0.001920 -0.049877 # node 588 -0.012124 -0.001333 -0.049921 # node 589 -0.012469 -0.000755 -0.050101 # node 590 -0.012814 -0.000177 -0.050282 # node 591 -0.011966 0.000170 -0.050327 # node 592 -0.011118 0.000516 -0.050372 # node 593 -0.010269 0.000863 -0.050417 # node 594 -0.009421 0.001210 -0.050462 # node 595 -0.008594 0.001474 -0.050347 # node 596 -0.007768 0.001739 -0.050231 # node 597 -0.006941 0.002003 -0.050116 # node 598 -0.006115 0.002268 -0.050001 # node 599 -0.005288 0.002532 -0.049886 # node 600 -0.004462 0.002797 -0.049770 # node 601 -0.008365 -0.003942 -0.046349 # node 602 -0.007643 -0.003648 -0.046043 # node 603 -0.006921 -0.003353 -0.045739 # node 604 -0.006200 -0.003058 -0.045433 # node 605 -0.005478 -0.002764 -0.045128 # node 606 -0.005003 -0.012686 -0.039492 # node 607 -0.005928 -0.012595 -0.039544 # node 608 -0.006854 -0.012504 -0.039598 # node 609 -0.007574 -0.012294 -0.039599 # node 610 -0.008295 -0.012084 -0.039600 # node 611 -0.009016 -0.011875 -0.039601 # node 612 -0.009639 -0.011337 -0.039767 # node 613 -0.010263 -0.010799 -0.039932 # node 614 -0.010886 -0.010261 -0.040098 # node 615 -0.011510 -0.009723 -0.040263 # node 616 -0.012153 -0.009228 -0.040622 # node 617 -0.012796 -0.008734 -0.040980 # node 618 -0.013439 -0.008240 -0.041339 # node 619 -0.014082 -0.007746 -0.041697 # node 620 -0.014737 -0.007292 -0.042341 # node 621 -0.015391 -0.006837 -0.042984 # node 622 -0.016046 -0.006383 -0.043628 # node 623 -0.016700 -0.005929 -0.044272 # node 624 -0.017446 -0.005457 -0.044624 # node 625 -0.018192 -0.004986 -0.044978 # node 626 -0.018938 -0.004515 -0.045330 # node 627 -0.019684 -0.004043 -0.045683 # node 628 -0.020383 -0.003903 -0.046129 # node 629 -0.021082 -0.003762 -0.046574 # node 630 -0.021781 -0.003621 -0.047021 # node 631 -0.022480 -0.003480 -0.047467 # node 632 -0.023301 -0.003721 -0.047429 # node 633 -0.024122 -0.003963 -0.047391 # node 634 -0.024943 -0.004204 -0.047354 # node 635 -0.025764 -0.004445 -0.047317 # node 636 -0.003806 -0.013160 -0.036014 # node 637 -0.003034 -0.013197 -0.036211 # node 638 -0.002262 -0.013233 -0.036408 # node 639 -0.001490 -0.013269 -0.036606 # node 640 -0.000610 -0.013047 -0.036886 # node 641 --0.000270 -0.012825 -0.037164 # node 642 --0.001150 -0.012603 -0.037444 # node 643 --0.002030 -0.012745 -0.037571 # node 644 --0.002910 -0.012886 -0.037697 # node 645 --0.003790 -0.013028 -0.037822 # node 646 --0.004660 -0.012919 -0.037590 # node 647 --0.005529 -0.012810 -0.037357 # node 648 --0.006399 -0.012700 -0.037123 # node 649 --0.007268 -0.012591 -0.036891 # node 650 --0.008102 -0.012468 -0.036484 # node 651 --0.008936 -0.012344 -0.036079 # node 652 --0.009769 -0.012220 -0.035672 # node 653 --0.010603 -0.012097 -0.035267 # node 654 --0.011436 -0.011973 -0.034860 # node 655 --0.012270 -0.011849 -0.034453 # node 656 --0.013104 -0.011726 -0.034048 # node 657 --0.013937 -0.011602 -0.033641 # node 658 --0.014720 -0.011424 -0.033966 # node 659 --0.015503 -0.011246 -0.034290 # node 660 --0.016286 -0.011069 -0.034616 # node 661 --0.016876 -0.011538 -0.034874 # node 662 --0.017466 -0.012007 -0.035133 # node 663 --0.018056 -0.012476 -0.035392 # node 664 --0.018425 -0.012794 -0.036277 # node 665 --0.018795 -0.013112 -0.037161 # node 666 --0.019165 -0.013430 -0.038044 # node 667 --0.019534 -0.013748 -0.038929 # node 668 --0.019520 -0.014452 -0.039692 # node 669 --0.019506 -0.015157 -0.040454 # node 670 --0.019492 -0.015861 -0.041218 # node 671 --0.019478 -0.016566 -0.041980 # node 672 -0.004850 -0.012808 -0.027209 # node 673 -0.004705 -0.011965 -0.027473 # node 674 -0.004559 -0.011123 -0.027737 # node 675 -0.005190 -0.011218 -0.028589 # node 676 -0.005822 -0.011313 -0.029440 # node 677 -0.005666 -0.010427 -0.029783 # node 678 -0.005511 -0.009540 -0.030126 # node 679 -0.005356 -0.008654 -0.030468 # node 680 -0.005200 -0.007768 -0.030810 # node 681 -0.005045 -0.006882 -0.031153 # node 682 -0.004742 -0.006228 -0.031856 # node 683 -0.004440 -0.005574 -0.032559 # node 684 -0.004137 -0.004921 -0.033261 # node 685 -0.003834 -0.004267 -0.033964 # node 686 -0.003858 -0.003611 -0.034636 # node 687 -0.003882 -0.002955 -0.035307 # node 688 -0.003906 -0.002298 -0.035979 # node 689 -0.003930 -0.001642 -0.036650 # node 690 -0.003525 -0.000785 -0.036940 # node 691 -0.003120 0.000072 -0.037229 # node 692 -0.002715 0.000930 -0.037519 # node 693 -0.002310 0.001787 -0.037809 # node 694 -0.001905 0.002644 -0.038098 # node 695 -0.001500 0.003502 -0.038388 # node 696 -0.001095 0.004359 -0.038677 # node 697 -0.000811 0.005099 -0.039031 # node 698 -0.000526 0.005840 -0.039386 # node 699 -0.000241 0.006580 -0.039740 # node 700 --0.000043 0.007320 -0.040094 # node 701 --0.000490 0.007759 -0.040760 # node 702 --0.000937 0.008198 -0.041426 # node 703 --0.001383 0.008638 -0.042091 # node 704 --0.001830 0.009077 -0.042758 # node 705 --0.002277 0.009516 -0.043423 # node 706 --0.003024 0.009919 -0.043768 # node 707 --0.003771 0.010323 -0.044113 # node 708 --0.004518 0.010727 -0.044459 # node 709 --0.005265 0.011131 -0.044803 # node 710 --0.006012 0.011534 -0.045149 # node 711 --0.006759 0.011938 -0.045494 # node 712 --0.007506 0.012342 -0.045839 # node 713 --0.007203 0.013155 -0.046361 # node 714 --0.006900 0.013968 -0.046883 # node 715 --0.006597 0.014781 -0.047407 # node 716 --0.006060 0.015181 -0.048218 # node 717 --0.005523 0.015581 -0.049029 # node 718 --0.004986 0.015981 -0.049840 # node 719 --0.004045 0.016193 -0.050141 # node 720 --0.003105 0.016406 -0.050442 # node 721 --0.002887 0.017209 -0.051026 # node 722 --0.002670 0.018012 -0.051610 # node 723 --0.002452 0.018815 -0.052193 # node 724 --0.007033 0.011715 -0.046104 # node 725 --0.006561 0.011087 -0.046370 # node 726 --0.005602 0.011114 -0.046359 # node 727 --0.004644 0.011141 -0.046347 # node 728 --0.003686 0.011168 -0.046334 # node 729 --0.003323 0.012091 -0.046211 # node 730 --0.002959 0.013014 -0.046087 # node 731 --0.002596 0.013936 -0.045962 # node 732 --0.002233 0.014859 -0.045839 # node 733 --0.001870 0.015782 -0.045714 # node 734 --0.001506 0.016704 -0.045590 # node 735 --0.001143 0.017627 -0.045467 # node 736 --0.000780 0.018550 -0.045342 # node 737 -0.000098 0.018566 -0.045660 # node 738 -0.000975 0.018582 -0.045978 # node 739 -0.001852 0.018598 -0.046296 # node 740 --0.002777 0.010074 -0.043093 # node 741 --0.003276 0.010633 -0.042764 # node 742 --0.003776 0.011191 -0.042436 # node 743 --0.004276 0.011750 -0.042107 # node 744 --0.004776 0.012308 -0.041778 # node 745 --0.005644 0.012743 -0.041583 # node 746 --0.006513 0.013177 -0.041389 # node 747 --0.007381 0.013612 -0.041196 # node 748 --0.008250 0.014047 -0.041001 # node 749 --0.009212 0.014197 -0.041101 # node 750 --0.010173 0.014347 -0.041201 # node 751 --0.011135 0.014498 -0.041301 # node 752 --0.012097 0.014648 -0.041401 # node 753 --0.013058 0.014798 -0.041500 # node 754 --0.013838 0.014636 -0.041683 # node 755 --0.014617 0.014474 -0.041867 # node 756 --0.015396 0.014311 -0.042050 # node 757 --0.016175 0.014149 -0.042233 # node 758 --0.016954 0.013986 -0.042417 # node 759 --0.017333 0.013468 -0.043054 # node 760 --0.017713 0.012950 -0.043691 # node 761 --0.018092 0.012432 -0.044329 # node 762 --0.018269 0.012042 -0.045190 # node 763 --0.018446 0.011653 -0.046052 # node 764 --0.018623 0.011263 -0.046913 # node 765 --0.018800 0.010873 -0.047774 # node 766 -0.003926 -0.001583 -0.037582 # node 767 -0.003922 -0.001524 -0.038514 # node 768 -0.003919 -0.001464 -0.039447 # node 769 -0.003033 -0.001382 -0.039631 # node 770 -0.002148 -0.001299 -0.039816 # node 771 -0.001262 -0.001216 -0.040000 # node 772 -0.000377 -0.001134 -0.040183 # node 773 --0.000508 -0.001051 -0.040368 # node 774 --0.001394 -0.000968 -0.040552 # node 775 --0.002279 -0.000886 -0.040737 # node 776 --0.003164 -0.000803 -0.040921 # node 777 --0.003650 -0.000072 -0.041429 # node 778 --0.004136 0.000660 -0.041937 # node 779 --0.004622 0.001391 -0.042444 # node 780 --0.005108 0.002123 -0.042952 # node 781 --0.005849 0.002683 -0.042761 # node 782 --0.006589 0.003243 -0.042569 # node 783 --0.007330 0.003803 -0.042377 # node 784 --0.008071 0.004363 -0.042184 # node 785 --0.008812 0.004923 -0.041993 # node 786 --0.009784 0.004762 -0.042178 # node 787 --0.010756 0.004601 -0.042362 # node 788 --0.011728 0.004440 -0.042548 # node 789 --0.012038 0.003689 -0.043013 # node 790 --0.012349 0.002938 -0.043480 # node 791 --0.012659 0.002187 -0.043947 # node 792 --0.012969 0.001436 -0.044412 # node 793 --0.013279 0.000685 -0.044879 # node 794 --0.013576 -0.000114 -0.045320 # node 795 --0.013873 -0.000914 -0.045761 # node 796 --0.014151 -0.001498 -0.046430 # node 797 --0.014429 -0.002083 -0.047099 # node 798 --0.014707 -0.002667 -0.047768 # node 799 --0.014986 -0.003251 -0.048437 # node 800 --0.015030 -0.003936 -0.048874 # node 801 --0.015073 -0.004622 -0.049311 # node 802 --0.015117 -0.005307 -0.049748 # node 803 --0.015161 -0.005992 -0.050186 # node 804 --0.015840 -0.006284 -0.050638 # node 805 --0.016519 -0.006576 -0.051091 # node 806 --0.017198 -0.006868 -0.051543 # node 807 --0.017822 -0.006431 -0.051816 # node 808 --0.018445 -0.005995 -0.052088 # node 809 --0.019068 -0.005558 -0.052360 # node 810 --0.019692 -0.005121 -0.052632 # node 811 --0.020175 -0.004765 -0.053451 # node 812 --0.020658 -0.004410 -0.054270 # node 813 --0.021140 -0.004055 -0.055089 # node 814 --0.021623 -0.003700 -0.055908 # node 815 --0.022106 -0.003345 -0.056727 # node 816 --0.022589 -0.002989 -0.057546 # node 817 --0.023072 -0.002634 -0.058366 # node 818 --0.023555 -0.002279 -0.059184 # node 819 --0.024038 -0.001923 -0.060003 # node 820 --0.024521 -0.001568 -0.060822 # node 821 --0.024512 -0.001998 -0.061643 # node 822 --0.024504 -0.002428 -0.062463 # node 823 --0.024496 -0.002858 -0.063284 # node 824 --0.024488 -0.003287 -0.064106 # node 825 --0.024432 -0.003465 -0.065046 # node 826 --0.024377 -0.003642 -0.065987 # node 827 --0.024322 -0.003820 -0.066927 # node 828 --0.024267 -0.003997 -0.067868 # node 829 --0.024212 -0.004174 -0.068808 # node 830 --0.024193 -0.004365 -0.069714 # node 831 --0.024175 -0.004555 -0.070621 # node 832 --0.024157 -0.004745 -0.071528 # node 833 --0.024138 -0.004935 -0.072433 # node 834 --0.024120 -0.005125 -0.073340 # node 835 -0.005241 -0.014382 -0.026617 # node 836 -0.005486 -0.015114 -0.026288 # node 837 -0.005731 -0.015846 -0.025958 # node 838 -0.005976 -0.016578 -0.025629 # node 839 -0.005918 -0.017101 -0.025736 # node 840 -0.005860 -0.017625 -0.025842 # node 841 -0.005908 -0.018160 -0.025999 # node 842 -0.005956 -0.018694 -0.026154 # node 843 -0.005467 -0.019456 -0.026546 # node 844 -0.004978 -0.020217 -0.026937 # node 845 -0.004148 -0.020483 -0.026947 # node 846 -0.003317 -0.020748 -0.026957 # node 847 -0.002556 -0.020891 -0.027376 # node 848 -0.001796 -0.021033 -0.027793 # node 849 -0.001087 -0.020991 -0.028186 # node 850 -0.000379 -0.020949 -0.028579 # node 851 --0.000330 -0.020907 -0.028971 # node 852 --0.001089 -0.021010 -0.029217 # node 853 --0.001847 -0.021113 -0.029462 # node 854 --0.002605 -0.021217 -0.029708 # node 855 --0.003364 -0.021320 -0.029953 # node 856 --0.003673 -0.021714 -0.030501 # node 857 --0.003982 -0.022108 -0.031048 # node 858 --0.004291 -0.022502 -0.031596 # node 859 --0.004766 -0.023347 -0.031780 # node 860 --0.005242 -0.024192 -0.031966 # node 861 --0.005717 -0.025036 -0.032150 # node 862 --0.006379 -0.025499 -0.032331 # node 863 --0.007041 -0.025962 -0.032511 # node 864 --0.007703 -0.026425 -0.032692 # node 865 --0.008420 -0.026673 -0.033180 # node 866 --0.009137 -0.026920 -0.033669 # node 867 --0.009854 -0.027168 -0.034157 # node 868 --0.009838 -0.027387 -0.035120 # node 869 --0.009821 -0.027606 -0.036083 # node 870 --0.010652 -0.027566 -0.036483 # node 871 --0.011482 -0.027527 -0.036882 # node 872 --0.012312 -0.027487 -0.037281 # node 873 --0.013001 -0.027132 -0.037122 # node 874 --0.013691 -0.026777 -0.036963 # node 875 --0.014380 -0.026422 -0.036804 # node 876 --0.014810 -0.025944 -0.037060 # node 877 --0.015241 -0.025465 -0.037316 # node 878 --0.015586 -0.024876 -0.037696 # node 879 --0.015930 -0.024286 -0.038076 # node 880 --0.016487 -0.023804 -0.037736 # node 881 --0.017044 -0.023321 -0.037394 # node 882 --0.017600 -0.022839 -0.037053 # node 883 --0.004410 -0.021868 -0.032009 # node 884 --0.004530 -0.021235 -0.032422 # node 885 --0.004649 -0.020601 -0.032834 # node 886 --0.003925 -0.020190 -0.033390 # node 887 --0.003201 -0.019780 -0.033944 # node 888 --0.002478 -0.019369 -0.034499 # node 889 --0.001754 -0.018959 -0.035054 # node 890 --0.001031 -0.018548 -0.035609 # node 891 --0.000541 -0.017857 -0.036132 # node 892 --0.000051 -0.017165 -0.036656 # node 893 -0.000439 -0.016474 -0.037179 # node 894 -0.000829 -0.016014 -0.037698 # node 895 -0.001218 -0.015554 -0.038217 # node 896 -0.001607 -0.015094 -0.038736 # node 897 -0.001647 -0.014790 -0.039659 # node 898 -0.001687 -0.014485 -0.040583 # node 899 -0.001726 -0.014180 -0.041507 # node 900 -0.001009 -0.014057 -0.042027 # node 901 -0.000291 -0.013933 -0.042546 # node 902 --0.000427 -0.013810 -0.043066 # node 903 --0.001144 -0.013686 -0.043586 # node 904 --0.001752 -0.014122 -0.043866 # node 905 --0.002360 -0.014558 -0.044147 # node 906 --0.002967 -0.014993 -0.044428 # node 907 --0.003575 -0.015429 -0.044708 # node 908 --0.004308 -0.015677 -0.045010 # node 909 --0.005041 -0.015924 -0.045312 # node 910 --0.005825 -0.016202 -0.044931 # node 911 --0.006609 -0.016479 -0.044549 # node 912 --0.006680 -0.017106 -0.044020 # node 913 --0.006750 -0.017733 -0.043491 # node 914 --0.006821 -0.018360 -0.042963 # node 915 --0.006075 -0.018676 -0.043200 # node 916 --0.005330 -0.018992 -0.043437 # node 917 --0.004584 -0.019308 -0.043673 # node 918 --0.003838 -0.019623 -0.043910 # node 919 --0.003093 -0.019939 -0.044146 # node 920 --0.002446 -0.020417 -0.044381 # node 921 --0.001800 -0.020895 -0.044616 # node 922 --0.001154 -0.021372 -0.044850 # node 923 --0.000507 -0.021850 -0.045086 # node 924 --0.000348 -0.021800 -0.045938 # node 925 --0.000189 -0.021749 -0.046791 # node 926 --0.000030 -0.021698 -0.047643 # node 927 -0.000129 -0.021648 -0.048496 # node 928 --0.000630 -0.021778 -0.049140 # node 929 --0.001389 -0.021909 -0.049784 # node 930 --0.002149 -0.022040 -0.050429 # node 931 --0.002895 -0.022173 -0.050778 # node 932 --0.003642 -0.022307 -0.051126 # node 933 --0.004388 -0.022440 -0.051473 # node 934 --0.005135 -0.022573 -0.051822 # node 935 --0.006040 -0.022544 -0.052043 # node 936 --0.006945 -0.022515 -0.052266 # node 937 --0.007851 -0.022486 -0.052487 # node 938 --0.008756 -0.022457 -0.052709 # node 939 --0.009661 -0.022428 -0.052930 # node 940 --0.010567 -0.022399 -0.053152 # node 941 -0.005278 -0.014060 -0.027723 # node 942 -0.005560 -0.014469 -0.028502 # node 943 -0.005841 -0.014879 -0.029280 # node 944 -0.006123 -0.015288 -0.030058 # node 945 -0.006557 -0.015457 -0.030743 # node 946 -0.006991 -0.015625 -0.031430 # node 947 -0.007425 -0.015794 -0.032116 # node 948 -0.007962 -0.016105 -0.032781 # node 949 -0.008499 -0.016416 -0.033447 # node 950 -0.009035 -0.016727 -0.034112 # node 951 -0.009351 -0.016898 -0.034780 # node 952 -0.009666 -0.017068 -0.035449 # node 953 -0.009981 -0.017238 -0.036118 # node 954 -0.005419 -0.013746 -0.019752 # node 955 -0.005937 -0.014327 -0.019308 # node 956 -0.006456 -0.014909 -0.018863 # node 957 -0.006975 -0.015490 -0.018419 # node 958 -0.007494 -0.016071 -0.017974 # node 959 -0.007645 -0.016713 -0.018570 # node 960 -0.007797 -0.017354 -0.019167 # node 961 -0.007948 -0.017996 -0.019762 # node 962 -0.008100 -0.018637 -0.020358 # node 963 -0.008905 -0.019016 -0.020768 # node 964 -0.009711 -0.019395 -0.021179 # node 965 -0.010516 -0.019774 -0.021589 # node 966 -0.011322 -0.020153 -0.022000 # node 967 -0.012127 -0.020532 -0.022411 # node 968 -0.012933 -0.020910 -0.022821 # node 969 -0.013710 -0.020813 -0.023377 # node 970 -0.014488 -0.020715 -0.023932 # node 971 -0.015265 -0.020618 -0.024488 # node 972 -0.016043 -0.020520 -0.025044 # node 973 -0.016821 -0.020423 -0.025600 # node 974 -0.017598 -0.020325 -0.026156 # node 975 -0.018376 -0.020228 -0.026711 # node 976 -0.019071 -0.019628 -0.026941 # node 977 -0.019766 -0.019029 -0.027171 # node 978 -0.020461 -0.018429 -0.027401 # node 979 -0.021156 -0.017830 -0.027631 # node 980 -0.021852 -0.017231 -0.027861 # node 981 -0.022547 -0.016631 -0.028091 # node 982 -0.023242 -0.016032 -0.028321 # node 983 -0.023937 -0.015432 -0.028551 # node 984 -0.023547 -0.014944 -0.029140 # node 985 -0.023157 -0.014455 -0.029729 # node 986 -0.022768 -0.013966 -0.030318 # node 987 -0.022378 -0.013478 -0.030907 # node 988 -0.021647 -0.012998 -0.031149 # node 989 -0.020917 -0.012518 -0.031391 # node 990 -0.020186 -0.012038 -0.031633 # node 991 -0.019456 -0.011558 -0.031876 # node 992 -0.019835 -0.011120 -0.032654 # node 993 -0.020214 -0.010682 -0.033434 # node 994 -0.020594 -0.010244 -0.034213 # node 995 -0.020022 -0.010011 -0.034527 # node 996 -0.019451 -0.009779 -0.034840 # node 997 -0.018880 -0.009546 -0.035153 # node 998 -0.018045 -0.009777 -0.035137 # node 999 -0.017210 -0.010009 -0.035119 # node 1000 -0.016433 -0.010057 -0.035534 # node 1001 -0.015657 -0.010105 -0.035950 # node 1002 -0.014995 -0.010158 -0.036101 # node 1003 -0.014333 -0.010211 -0.036253 # node 1004 -0.013671 -0.010263 -0.036406 # node 1005 -0.013950 -0.009822 -0.036904 # node 1006 -0.014229 -0.009380 -0.037403 # node 1007 -0.014509 -0.008939 -0.037903 # node 1008 -0.015308 -0.009014 -0.038378 # node 1009 -0.016106 -0.009089 -0.038851 # node 1010 -0.016352 -0.009569 -0.039574 # node 1011 -0.016598 -0.010050 -0.040297 # node 1012 -0.016844 -0.010530 -0.041020 # node 1013 -0.017510 -0.010074 -0.041261 # node 1014 -0.018177 -0.009617 -0.041502 # node 1015 -0.018843 -0.009160 -0.041743 # node 1016 -0.019510 -0.008703 -0.041984 # node 1017 -0.017915 -0.020699 -0.026078 # node 1018 -0.017454 -0.021169 -0.025443 # node 1019 -0.016993 -0.021640 -0.024810 # node 1020 -0.016533 -0.022111 -0.024177 # node 1021 -0.015732 -0.022480 -0.023918 # node 1022 -0.014931 -0.022849 -0.023659 # node 1023 -0.014130 -0.023218 -0.023400 # node 1024 -0.013318 -0.023049 -0.023579 # node 1025 -0.012506 -0.022879 -0.023758 # node 1026 -0.011694 -0.022709 -0.023938 # node 1027 -0.010882 -0.022539 -0.024117 # node 1028 -0.010033 -0.022842 -0.023892 # node 1029 -0.009184 -0.023144 -0.023668 # node 1030 -0.008334 -0.023446 -0.023443 # node 1031 -0.008609 -0.023936 -0.024198 # node 1032 -0.008883 -0.024425 -0.024951 # node 1033 -0.009157 -0.024914 -0.025706 # node 1034 -0.009431 -0.025403 -0.026460 # node 1035 -0.009433 -0.026253 -0.026187 # node 1036 -0.007351 -0.016309 -0.018859 # node 1037 -0.007208 -0.016548 -0.019742 # node 1038 -0.007066 -0.016786 -0.020627 # node 1039 -0.007594 -0.017359 -0.021237 # node 1040 -0.008122 -0.017933 -0.021846 # node 1041 -0.008649 -0.018506 -0.022456 # node 1042 -0.009177 -0.019080 -0.023066 # node 1043 -0.009934 -0.018929 -0.023569 # node 1044 -0.010691 -0.018778 -0.024073 # node 1045 -0.011448 -0.018628 -0.024577 # node 1046 -0.011970 -0.018807 -0.025502 # node 1047 -0.012493 -0.018986 -0.026429 # node 1048 -0.013015 -0.019166 -0.027356 # node 1049 -0.013537 -0.019345 -0.028282 # node 1050 -0.014313 -0.019664 -0.028752 # node 1051 -0.015089 -0.019983 -0.029222 # node 1052 -0.015865 -0.020301 -0.029693 # node 1053 -0.016640 -0.020620 -0.030163 # node 1054 -0.017338 -0.020601 -0.030352 # node 1055 -0.018035 -0.020582 -0.030542 # node 1056 -0.018732 -0.020562 -0.030732 # node 1057 -0.019474 -0.020420 -0.031322 # node 1058 -0.020217 -0.020277 -0.031913 # node 1059 -0.020960 -0.020135 -0.032504 # node 1060 -0.021043 -0.020208 -0.033564 # node 1061 -0.021127 -0.020282 -0.034623 # node 1062 -0.002367 -0.009682 -0.016940 # node 1063 -0.001692 -0.010094 -0.017311 # node 1064 -0.001017 -0.010506 -0.017682 # node 1065 -0.000342 -0.010918 -0.018054 # node 1066 --0.000333 -0.011330 -0.018426 # node 1067 --0.001008 -0.011742 -0.018798 # node 1068 --0.001746 -0.012079 -0.018836 # node 1069 --0.002483 -0.012416 -0.018873 # node 1070 --0.003221 -0.012753 -0.018912 # node 1071 --0.003928 -0.012940 -0.018834 # node 1072 --0.004634 -0.013127 -0.018757 # node 1073 --0.005341 -0.013314 -0.018679 # node 1074 --0.005900 -0.013778 -0.018434 # node 1075 --0.006458 -0.014241 -0.018191 # node 1076 --0.007017 -0.014705 -0.017947 # node 1077 --0.007575 -0.015168 -0.017703 # node 1078 --0.008202 -0.015432 -0.017572 # node 1079 --0.008829 -0.015696 -0.017442 # node 1080 --0.009456 -0.015960 -0.017312 # node 1081 --0.010176 -0.016028 -0.017632 # node 1082 --0.010897 -0.016097 -0.017953 # node 1083 --0.011617 -0.016166 -0.018273 # node 1084 --0.011764 -0.016262 -0.019169 # node 1085 --0.011910 -0.016359 -0.020064 # node 1086 --0.012130 -0.016846 -0.020436 # node 1087 --0.012350 -0.017332 -0.020808 # node 1088 --0.012315 -0.017922 -0.021332 # node 1089 --0.012279 -0.018513 -0.021857 # node 1090 --0.012244 -0.019103 -0.022382 # node 1091 --0.012685 -0.019466 -0.023133 # node 1092 --0.013125 -0.019829 -0.023886 # node 1093 --0.013565 -0.020193 -0.024638 # node 1094 --0.014150 -0.020564 -0.025341 # node 1095 --0.014734 -0.020935 -0.026043 # node 1096 --0.015318 -0.021306 -0.026747 # node 1097 --0.016037 -0.021607 -0.026864 # node 1098 --0.016756 -0.021907 -0.026982 # node 1099 --0.017475 -0.022207 -0.027100 # node 1100 --0.017594 -0.022746 -0.027516 # node 1101 --0.017714 -0.023285 -0.027931 # node 1102 --0.017656 -0.023509 -0.028723 # node 1103 --0.017597 -0.023734 -0.029516 # node 1104 --0.017539 -0.023958 -0.030308 # node 1105 --0.016926 -0.024402 -0.030580 # node 1106 --0.016312 -0.024847 -0.030852 # node 1107 --0.015699 -0.025291 -0.031126 # node 1108 --0.015064 -0.025670 -0.031332 # node 1109 --0.014428 -0.026049 -0.031539 # node 1110 --0.013792 -0.026428 -0.031746 # node 1111 --0.013210 -0.026917 -0.031936 # node 1112 --0.012629 -0.027406 -0.032126 # node 1113 --0.012047 -0.027895 -0.032316 # node 1114 --0.011212 -0.028335 -0.032142 # node 1115 --0.010377 -0.028775 -0.031969 # node 1116 --0.009543 -0.029216 -0.031794 # node 1117 --0.008708 -0.029656 -0.031621 # node 1118 --0.008052 -0.029005 -0.031980 # node 1119 --0.007397 -0.028354 -0.032340 # node 1120 --0.006742 -0.027703 -0.032699 # node 1121 --0.006804 -0.028226 -0.033569 # node 1122 -0.002553 -0.009857 -0.017191 # node 1123 -0.002064 -0.010445 -0.017814 # node 1124 -0.001575 -0.011032 -0.018438 # node 1125 -0.001085 -0.011619 -0.019061 # node 1126 -0.000596 -0.012207 -0.019684 # node 1127 -0.000258 -0.012984 -0.019854 # node 1128 --0.000079 -0.013761 -0.020024 # node 1129 --0.000417 -0.014537 -0.020194 # node 1130 --0.000784 -0.015181 -0.020307 # node 1131 --0.001151 -0.015825 -0.020419 # node 1132 --0.001519 -0.016469 -0.020530 # node 1133 --0.001838 -0.017191 -0.020707 # node 1134 --0.002157 -0.017913 -0.020883 # node 1135 --0.002477 -0.018635 -0.021059 # node 1136 --0.003378 -0.018981 -0.021348 # node 1137 --0.004280 -0.019328 -0.021636 # node 1138 --0.005073 -0.019693 -0.021616 # node 1139 --0.005866 -0.020059 -0.021594 # node 1140 --0.006659 -0.020425 -0.021574 # node 1141 --0.007319 -0.020371 -0.021972 # node 1142 --0.007979 -0.020318 -0.022369 # node 1143 --0.008639 -0.020264 -0.022767 # node 1144 --0.009074 -0.020816 -0.022983 # node 1145 --0.009508 -0.021368 -0.023199 # node 1146 --0.010133 -0.021292 -0.023673 # node 1147 --0.010758 -0.021215 -0.024148 # node 1148 --0.011331 -0.021218 -0.024557 # node 1149 --0.011904 -0.021220 -0.024966 # node 1150 --0.012478 -0.021222 -0.025374 # node 1151 --0.013084 -0.021208 -0.025811 # node 1152 --0.013689 -0.021193 -0.026249 # node 1153 --0.014295 -0.021179 -0.026686 # node 1154 --0.014998 -0.021075 -0.026974 # node 1155 --0.015701 -0.020972 -0.027263 # node 1156 --0.016403 -0.020868 -0.027552 # node 1157 --0.017106 -0.020764 -0.027841 # node 1158 --0.017627 -0.021000 -0.028263 # node 1159 --0.018148 -0.021235 -0.028687 # node 1160 --0.018669 -0.021470 -0.029109 # node 1161 --0.018706 -0.021497 -0.029918 # node 1162 --0.018743 -0.021523 -0.030727 # node 1163 --0.019263 -0.021055 -0.031114 # node 1164 --0.019783 -0.020587 -0.031502 # node 1165 --0.020303 -0.020119 -0.031890 # node 1166 --0.020229 -0.019513 -0.032400 # node 1167 --0.020155 -0.018907 -0.032911 # node 1168 --0.020081 -0.018301 -0.033421 # node 1169 --0.019739 -0.017583 -0.033927 # node 1170 --0.019396 -0.016865 -0.034431 # node 1171 --0.019054 -0.016147 -0.034937 # node 1172 --0.018423 -0.015389 -0.035012 # node 1173 --0.017792 -0.014631 -0.035088 # node 1174 --0.017161 -0.013873 -0.035163 # node 1175 --0.016530 -0.013116 -0.035240 # node 1176 --0.015898 -0.012358 -0.035316 # node 1177 --0.015267 -0.011600 -0.035391 # node 1178 --0.014636 -0.010842 -0.035468 # node 1179 --0.013940 -0.010658 -0.034889 # node 1180 --0.013243 -0.010474 -0.034310 # node 1181 --0.012549 -0.010310 -0.034304 # node 1182 --0.011854 -0.010146 -0.034300 # node 1183 --0.011160 -0.009982 -0.034296 # node 1184 --0.010612 -0.009570 -0.034836 # node 1185 --0.010064 -0.009158 -0.035374 # node 1186 --0.010107 -0.008672 -0.036260 # node 1187 --0.010150 -0.008186 -0.037146 # node 1188 --0.010193 -0.007700 -0.038030 # node 1189 --0.010235 -0.007213 -0.038916 # node 1190 --0.010278 -0.006727 -0.039801 # node 1191 --0.009668 -0.021231 -0.023979 # node 1192 --0.009826 -0.021094 -0.024758 # node 1193 --0.009985 -0.020957 -0.025538 # node 1194 --0.009999 -0.021786 -0.025558 # node 1195 --0.010013 -0.022614 -0.025578 # node 1196 --0.010027 -0.023443 -0.025598 # node 1197 --0.009963 -0.023577 -0.026163 # node 1198 --0.009898 -0.023710 -0.026728 # node 1199 --0.009481 -0.023532 -0.027281 # node 1200 --0.009063 -0.023354 -0.027833 # node 1201 --0.008645 -0.023176 -0.028386 # node 1202 --0.008064 -0.023218 -0.028844 # node 1203 --0.007484 -0.023260 -0.029303 # node 1204 --0.006903 -0.023302 -0.029762 # node 1205 -0.003217 -0.008875 -0.015594 # node 1206 -0.003392 -0.008479 -0.014621 # node 1207 -0.003567 -0.008084 -0.013649 # node 1208 -0.003742 -0.007689 -0.012676 # node 1209 -0.004351 -0.007349 -0.012140 # node 1210 -0.004960 -0.007010 -0.011603 # node 1211 -0.005613 -0.006444 -0.011300 # node 1212 -0.006267 -0.005878 -0.010995 # node 1213 -0.006920 -0.005312 -0.010691 # node 1214 -0.007589 -0.004771 -0.010645 # node 1215 -0.008258 -0.004231 -0.010599 # node 1216 -0.008683 -0.003898 -0.010280 # node 1217 -0.009107 -0.003565 -0.009962 # node 1218 -0.009534 -0.003157 -0.009552 # node 1219 -0.009961 -0.002748 -0.009142 # node 1220 -0.010389 -0.002339 -0.008733 # node 1221 -0.011211 -0.002270 -0.009063 # node 1222 -0.012033 -0.002200 -0.009394 # node 1223 -0.012856 -0.002130 -0.009724 # node 1224 -0.013678 -0.002060 -0.010055 # node 1225 -0.014301 -0.001512 -0.010304 # node 1226 -0.014925 -0.000964 -0.010553 # node 1227 -0.015548 -0.000417 -0.010802 # node 1228 -0.016171 0.000131 -0.011050 # node 1229 -0.016795 0.000679 -0.011299 # node 1230 -0.017418 0.001227 -0.011549 # node 1231 -0.017621 0.001645 -0.012452 # node 1232 -0.017823 0.002063 -0.013356 # node 1233 -0.018026 0.002481 -0.014259 # node 1234 -0.018229 0.002899 -0.015163 # node 1235 -0.018431 0.003317 -0.016067 # node 1236 -0.018634 0.003735 -0.016970 # node 1237 -0.019142 0.004266 -0.017602 # node 1238 -0.019651 0.004798 -0.018234 # node 1239 -0.020159 0.005330 -0.018867 # node 1240 -0.020667 0.005861 -0.019500 # node 1241 -0.021175 0.006393 -0.020132 # node 1242 -0.021195 0.006536 -0.021079 # node 1243 -0.021216 0.006680 -0.022026 # node 1244 -0.021236 0.006823 -0.022972 # node 1245 -0.021257 0.006966 -0.023919 # node 1246 -0.021089 0.007063 -0.024742 # node 1247 -0.020922 0.007160 -0.025564 # node 1248 -0.020755 0.007257 -0.026388 # node 1249 -0.020492 0.007165 -0.027402 # node 1250 -0.020229 0.007073 -0.028417 # node 1251 -0.019966 0.006981 -0.029431 # node 1252 -0.018972 0.003341 -0.017843 # node 1253 -0.019310 0.002947 -0.018716 # node 1254 -0.019648 0.002553 -0.019589 # node 1255 -0.019985 0.002159 -0.020462 # node 1256 -0.020323 0.001765 -0.021336 # node 1257 -0.020661 0.001371 -0.022208 # node 1258 -0.020999 0.000977 -0.023081 # node 1259 -0.021337 0.000583 -0.023954 # node 1260 -0.020965 0.000191 -0.024813 # node 1261 -0.020594 -0.000202 -0.025672 # node 1262 -0.020222 -0.000594 -0.026532 # node 1263 -0.003282 -0.009398 -0.015540 # node 1264 -0.003523 -0.009526 -0.014512 # node 1265 -0.003763 -0.009654 -0.013486 # node 1266 -0.003183 -0.009313 -0.012801 # node 1267 -0.002603 -0.008973 -0.012117 # node 1268 -0.002023 -0.008632 -0.011433 # node 1269 -0.001466 -0.008377 -0.010929 # node 1270 -0.000909 -0.008121 -0.010425 # node 1271 -0.000353 -0.007865 -0.009921 # node 1272 --0.000204 -0.007610 -0.009417 # node 1273 --0.000936 -0.008013 -0.009419 # node 1274 --0.001668 -0.008417 -0.009422 # node 1275 --0.002400 -0.008820 -0.009424 # node 1276 --0.003133 -0.009224 -0.009426 # node 1277 --0.004001 -0.008973 -0.009872 # node 1278 --0.004870 -0.008723 -0.010318 # node 1279 --0.005149 -0.008465 -0.010882 # node 1280 --0.005428 -0.008206 -0.011447 # node 1281 --0.005971 -0.007963 -0.011554 # node 1282 --0.006513 -0.007719 -0.011662 # node 1283 --0.006138 -0.007363 -0.012327 # node 1284 --0.005764 -0.007007 -0.012992 # node 1285 --0.005389 -0.006651 -0.013657 # node 1286 --0.005639 -0.006286 -0.014461 # node 1287 --0.005890 -0.005922 -0.015264 # node 1288 --0.006643 -0.008088 -0.010929 # node 1289 --0.006773 -0.008457 -0.010196 # node 1290 --0.006785 -0.009145 -0.010277 # node 1291 --0.006798 -0.009834 -0.010358 # node 1292 --0.007258 -0.010179 -0.010862 # node 1293 --0.007718 -0.010525 -0.011366 # node 1294 --0.008178 -0.010870 -0.011869 # node 1295 --0.008157 -0.010666 -0.012726 # node 1296 --0.008136 -0.010462 -0.013582 # node 1297 --0.008115 -0.010257 -0.014439 # node 1298 --0.008806 -0.010073 -0.014634 # node 1299 --0.009497 -0.009888 -0.014830 # node 1300 --0.010188 -0.009703 -0.015026 # node 1301 -0.003252 -0.009864 -0.016042 # node 1302 -0.003463 -0.010458 -0.015516 # node 1303 -0.003673 -0.011052 -0.014989 # node 1304 -0.003883 -0.011646 -0.014463 # node 1305 -0.003342 -0.012283 -0.014304 # node 1306 -0.002800 -0.012919 -0.014146 # node 1307 -0.002258 -0.013555 -0.013987 # node 1308 -0.001716 -0.014192 -0.013827 # node 1309 -0.001366 -0.014998 -0.014066 # node 1310 -0.001016 -0.015805 -0.014304 # node 1311 -0.000665 -0.016611 -0.014543 # node 1312 -0.000315 -0.017417 -0.014782 # node 1313 -0.000561 -0.018280 -0.014831 # node 1314 -0.000806 -0.019142 -0.014880 # node 1315 -0.001052 -0.020005 -0.014930 # node 1316 -0.001298 -0.020867 -0.014979 # node 1317 -0.001544 -0.021729 -0.015028 # node 1318 -0.001565 -0.022543 -0.015348 # node 1319 -0.001586 -0.023357 -0.015667 # node 1320 -0.001607 -0.024170 -0.015986 # node 1321 -0.001628 -0.024984 -0.016306 # node 1322 -0.001650 -0.025798 -0.016624 # node 1323 -0.001671 -0.026611 -0.016944 # node 1324 -0.001692 -0.027425 -0.017263 # node 1325 -0.002174 -0.027931 -0.017971 # node 1326 -0.002655 -0.028438 -0.018680 # node 1327 -0.003137 -0.028944 -0.019388 # node 1328 -0.003619 -0.029451 -0.020096 # node 1329 -0.003671 -0.029680 -0.020947 # node 1330 -0.003722 -0.029909 -0.021798 # node 1331 -0.003774 -0.030139 -0.022649 # node 1332 -0.003826 -0.030368 -0.023500 # node 1333 -0.002997 -0.030398 -0.023992 # node 1334 -0.002167 -0.030429 -0.024486 # node 1335 -0.001338 -0.030459 -0.024978 # node 1336 -0.000518 -0.030420 -0.025176 # node 1337 --0.000302 -0.030381 -0.025373 # node 1338 --0.001122 -0.030342 -0.025572 # node 1339 -0.002225 -0.014818 -0.013688 # node 1340 -0.002733 -0.015443 -0.013548 # node 1341 -0.003242 -0.016069 -0.013409 # node 1342 -0.003750 -0.016695 -0.013269 # node 1343 -0.004280 -0.017205 -0.013013 # node 1344 -0.004811 -0.017714 -0.012758 # node 1345 -0.005342 -0.018224 -0.012502 # node 1346 -0.005872 -0.018734 -0.012247 # node 1347 -0.006491 -0.019397 -0.012003 # node 1348 -0.007109 -0.020059 -0.011759 # node 1349 -0.007727 -0.020722 -0.011514 # node 1350 -0.008245 -0.021328 -0.011471 # node 1351 -0.008762 -0.021934 -0.011429 # node 1352 -0.009280 -0.022540 -0.011386 # node 1353 -0.009797 -0.023145 -0.011343 # node 1354 -0.010668 -0.023327 -0.011636 # node 1355 -0.011539 -0.023509 -0.011927 # node 1356 -0.012410 -0.023692 -0.012219 # node 1357 -0.013281 -0.023874 -0.012511 # node 1358 -0.014152 -0.024056 -0.012802 # node 1359 -0.014689 -0.024035 -0.013464 # node 1360 -0.015225 -0.024014 -0.014126 # node 1361 -0.015762 -0.023993 -0.014787 # node 1362 -0.016299 -0.023973 -0.015448 # node 1363 -0.017143 -0.023849 -0.016003 # node 1364 -0.017987 -0.023726 -0.016559 # node 1365 -0.018831 -0.023602 -0.017114 # node 1366 -0.019233 -0.022775 -0.017309 # node 1367 -0.019636 -0.021948 -0.017503 # node 1368 -0.020039 -0.021121 -0.017698 # node 1369 -0.020441 -0.020294 -0.017892 # node 1370 -0.020844 -0.019467 -0.018087 # node 1371 -0.021105 -0.018939 -0.018914 # node 1372 -0.021367 -0.018411 -0.019743 # node 1373 -0.021628 -0.017883 -0.020571 # node 1374 -0.021890 -0.017355 -0.021399 # node 1375 -0.000381 -0.005699 -0.015153 # node 1376 --0.000375 -0.005537 -0.015474 # node 1377 --0.001131 -0.005376 -0.015797 # node 1378 --0.001887 -0.005214 -0.016118 # node 1379 --0.002718 -0.005092 -0.016043 # node 1380 --0.003549 -0.004969 -0.015968 # node 1381 --0.004380 -0.004847 -0.015893 # node 1382 --0.005211 -0.004724 -0.015819 # node 1383 --0.006023 -0.004828 -0.015900 # node 1384 --0.006835 -0.004931 -0.015981 # node 1385 --0.007647 -0.005034 -0.016062 # node 1386 --0.008393 -0.005468 -0.016162 # node 1387 --0.009140 -0.005901 -0.016262 # node 1388 --0.009887 -0.006334 -0.016361 # node 1389 --0.010713 -0.006613 -0.016762 # node 1390 --0.011539 -0.006892 -0.017162 # node 1391 --0.012365 -0.007171 -0.017563 # node 1392 --0.013191 -0.007450 -0.017963 # node 1393 --0.013968 -0.007976 -0.018079 # node 1394 --0.014746 -0.008503 -0.018193 # node 1395 --0.015523 -0.009029 -0.018309 # node 1396 --0.016087 -0.009159 -0.018793 # node 1397 --0.016651 -0.009289 -0.019279 # node 1398 --0.017215 -0.009419 -0.019764 # node 1399 --0.017911 -0.009764 -0.020063 # node 1400 --0.018607 -0.010109 -0.020361 # node 1401 --0.019303 -0.010454 -0.020659 # node 1402 --0.019935 -0.010541 -0.021166 # node 1403 --0.020566 -0.010627 -0.021672 # node 1404 --0.021198 -0.010713 -0.022179 # node 1405 --0.021829 -0.010799 -0.022686 # node 1406 --0.022312 -0.011260 -0.023293 # node 1407 --0.022795 -0.011721 -0.023902 # node 1408 --0.023277 -0.012181 -0.024510 # node 1409 --0.023760 -0.012642 -0.025119 # node 1410 --0.017413 -0.008938 -0.019978 # node 1411 --0.017610 -0.008456 -0.020191 # node 1412 --0.017363 -0.008911 -0.020917 # node 1413 --0.017116 -0.009366 -0.021642 # node 1414 --0.016869 -0.009821 -0.022369 # node 1415 --0.016622 -0.010276 -0.023094 # node 1416 --0.016375 -0.010731 -0.023820 # node 1417 -0.000182 -0.002975 -0.012363 # node 1418 -0.001040 -0.002726 -0.012566 # node 1419 -0.001047 -0.002250 -0.013363 # node 1420 -0.001751 -0.001902 -0.013967 # node 1421 -0.001781 -0.001563 -0.014792 # node 1422 -0.001810 -0.001224 -0.015618 # node 1423 -0.002389 -0.001373 -0.016413 # node 1424 -0.002967 -0.001521 -0.017209 # node 1425 -0.002980 -0.001801 -0.018248 # node 1426 -0.002994 -0.002081 -0.019286 # node 1427 -0.003007 -0.002360 -0.020324 # node 1428 -0.003378 -0.002432 -0.020823 # node 1429 -0.003749 -0.002503 -0.021322 # node 1430 -0.003896 -0.002582 -0.022391 # node 1431 -0.004043 -0.002660 -0.023460 # node 1432 -0.003786 -0.002932 -0.024286 # node 1433 -0.003529 -0.003204 -0.025112 # node 1434 -0.003272 -0.003476 -0.025939 # node 1435 -0.003014 -0.003748 -0.026766 # node 1436 -0.002383 -0.004142 -0.027402 # node 1437 -0.001752 -0.004536 -0.028039 # node 1438 --0.001339 -0.003044 -0.012376 # node 1439 --0.002002 -0.002864 -0.012589 # node 1440 --0.002665 -0.002684 -0.012801 # node 1441 --0.003125 -0.002607 -0.013486 # node 1442 --0.003780 -0.002773 -0.014183 # node 1443 --0.004436 -0.002939 -0.014880 # node 1444 --0.002779 -0.002498 -0.014309 # node 1445 --0.002433 -0.002388 -0.015131 # node 1446 --0.003031 -0.002507 -0.015506 # node 1447 --0.003629 -0.002626 -0.015880 # node 1448 --0.004227 -0.002745 -0.016254 # node 1449 --0.004645 -0.003167 -0.016447 # node 1450 --0.005063 -0.003590 -0.016640 # node 1451 --0.004922 -0.003620 -0.017466 # node 1452 --0.004074 -0.003807 -0.017728 # node 1453 --0.003227 -0.003994 -0.017990 # node 1454 --0.002791 -0.003606 -0.017601 # node 1455 --0.002354 -0.003217 -0.017213 # node 1456 --0.001941 -0.002814 -0.017398 # node 1457 --0.001529 -0.002410 -0.017583 # node 1458 --0.001534 -0.001604 -0.017930 # node 1459 --0.001539 -0.000798 -0.018276 # node 1460 --0.001544 0.000009 -0.018622 # node 1461 --0.001549 0.000815 -0.018968 # node 1462 --0.001519 0.001685 -0.019160 # node 1463 --0.001490 0.002554 -0.019352 # node 1464 --0.001460 0.003424 -0.019543 # node 1465 --0.005896 -0.003661 -0.016892 # node 1466 --0.006729 -0.003733 -0.017144 # node 1467 --0.007562 -0.003804 -0.017397 # node 1468 --0.008267 -0.003662 -0.017704 # node 1469 --0.008972 -0.003521 -0.018012 # node 1470 --0.009677 -0.003379 -0.018321 # node 1471 --0.010540 -0.003124 -0.018326 # node 1472 --0.011402 -0.002869 -0.018331 # node 1473 --0.012264 -0.002614 -0.018337 # node 1474 --0.012988 -0.002688 -0.018716 # node 1475 --0.013712 -0.002763 -0.019093 # node 1476 --0.014436 -0.002838 -0.019471 # node 1477 --0.015160 -0.002913 -0.019850 # node 1478 --0.015884 -0.002988 -0.020228 # node 1479 --0.016731 -0.003004 -0.020474 # node 1480 --0.017579 -0.003020 -0.020721 # node 1481 --0.018427 -0.003036 -0.020968 # node 1482 --0.019275 -0.003052 -0.021214 # node 1483 --0.020040 -0.002911 -0.021481 # node 1484 --0.020804 -0.002770 -0.021747 # node 1485 --0.021569 -0.002629 -0.022013 # node 1486 --0.022334 -0.002488 -0.022279 # node 1487 --0.023099 -0.002347 -0.022546 # node 1488 --0.023296 -0.001851 -0.023416 # node 1489 --0.023493 -0.001354 -0.024287 # node 1490 --0.023691 -0.000858 -0.025157 # node 1491 --0.023888 -0.000362 -0.026028 # node 1492 --0.024085 0.000135 -0.026899 # node 1493 --0.024283 0.000631 -0.027769 # node 1494 --0.019224 -0.002129 -0.021406 # node 1495 --0.019174 -0.001206 -0.021596 # node 1496 --0.019124 -0.000282 -0.021786 # node 1497 --0.019073 0.000641 -0.021977 # node 1498 --0.019023 0.001564 -0.022167 # node 1499 --0.018972 0.002487 -0.022357 # node 1500 --0.018922 0.003411 -0.022548 # node 1501 --0.018872 0.004334 -0.022738 # node 1502 --0.018264 0.004493 -0.023446 # node 1503 --0.017657 0.004652 -0.024153 # node 1504 --0.017050 0.004810 -0.024861 # node 1505 --0.016443 0.004969 -0.025569 # node 1506 --0.015836 0.005128 -0.026277 # node 1507 --0.016531 0.004850 -0.026786 # node 1508 --0.017227 0.004573 -0.027294 # node 1509 --0.017923 0.004295 -0.027803 # node 1510 --0.018618 0.004017 -0.028313 # node 1511 --0.019256 0.003445 -0.028472 # node 1512 --0.019894 0.002874 -0.028631 # node 1513 --0.019900 0.002042 -0.028957 # node 1514 --0.019906 0.001211 -0.029282 # node 1515 --0.019913 0.000379 -0.029608 # node 1516 --0.019919 -0.000453 -0.029933 # node 1517 --0.014876 0.005166 -0.026346 # node 1518 --0.013916 0.005203 -0.026414 # node 1519 --0.012956 0.005241 -0.026483 # node 1520 --0.011995 0.005278 -0.026552 # node 1521 --0.011035 0.005316 -0.026621 # node 1522 --0.012231 -0.001950 -0.018487 # node 1523 --0.012198 -0.001287 -0.018636 # node 1524 --0.012165 -0.000623 -0.018786 # node 1525 --0.012179 0.000191 -0.018580 # node 1526 --0.012193 0.001006 -0.018374 # node 1527 --0.012207 0.001820 -0.018169 # node 1528 --0.012221 0.002634 -0.017963 # node 1529 --0.012235 0.003449 -0.017758 # node 1530 --0.012249 0.004263 -0.017552 # node 1531 --0.001043 -0.000868 -0.010137 # node 1532 --0.001857 -0.000502 -0.010380 # node 1533 --0.002672 -0.000136 -0.010624 # node 1534 --0.003486 0.000229 -0.010867 # node 1535 --0.004300 0.000595 -0.011110 # node 1536 --0.005234 0.000763 -0.011397 # node 1537 --0.006168 0.000931 -0.011682 # node 1538 --0.006404 0.000929 -0.012206 # node 1539 --0.006640 0.000928 -0.012729 # node 1540 --0.007177 0.000713 -0.013241 # node 1541 --0.007715 0.000497 -0.013753 # node 1542 --0.008252 0.000282 -0.014266 # node 1543 --0.009106 0.000113 -0.014624 # node 1544 --0.010038 0.000087 -0.014563 # node 1545 --0.010969 0.000062 -0.014501 # node 1546 --0.011901 0.000036 -0.014440 # node 1547 --0.012833 0.000010 -0.014378 # node 1548 --0.013765 -0.000015 -0.014317 # node 1549 --0.014696 -0.000041 -0.014254 # node 1550 --0.015628 -0.000066 -0.014193 # node 1551 --0.009551 -0.000481 -0.014928 # node 1552 --0.009996 -0.001075 -0.015230 # node 1553 --0.010441 -0.001669 -0.015533 # node 1554 --0.010753 -0.002349 -0.015977 # node 1555 --0.011064 -0.003028 -0.016419 # node 1556 --0.011375 -0.003708 -0.016862 # node 1557 --0.006464 0.001504 -0.012158 # node 1558 --0.006759 0.002078 -0.012633 # node 1559 --0.007345 0.002428 -0.012829 # node 1560 --0.007930 0.002779 -0.013024 # node 1561 --0.008824 0.003120 -0.013278 # node 1562 --0.009719 0.003462 -0.013530 # node 1563 --0.010319 0.003835 -0.013720 # node 1564 --0.010920 0.004209 -0.013910 # node 1565 --0.011521 0.004582 -0.014101 # node 1566 --0.012339 0.004667 -0.014013 # node 1567 --0.013157 0.004753 -0.013926 # node 1568 --0.013975 0.004838 -0.013838 # node 1569 --0.014793 0.004923 -0.013751 # node 1570 --0.015610 0.005008 -0.013663 # node 1571 --0.004663 0.000643 -0.012006 # node 1572 --0.005025 0.000691 -0.012901 # node 1573 --0.005620 0.000639 -0.013792 # node 1574 --0.006214 0.000587 -0.014683 # node 1575 --0.006852 0.000452 -0.015193 # node 1576 --0.007489 0.000318 -0.015702 # node 1577 --0.008139 0.000167 -0.016108 # node 1578 --0.008789 0.000016 -0.016512 # node 1579 --0.009727 -0.000181 -0.016530 # node 1580 --0.010664 -0.000377 -0.016548 # node 1581 --0.011602 -0.000574 -0.016566 # node 1582 --0.012540 -0.000770 -0.016583 # node 1583 --0.012868 -0.000973 -0.017007 # node 1584 --0.013196 -0.001176 -0.017430 # node 1585 --0.014023 -0.001182 -0.017609 # node 1586 --0.014851 -0.001188 -0.017788 # node 1587 --0.015736 -0.001553 -0.017710 # node 1588 --0.016621 -0.001918 -0.017633 # node 1589 --0.016429 -0.002559 -0.018051 # node 1590 --0.016238 -0.003199 -0.018469 # node 1591 --0.016046 -0.003840 -0.018886 # node 1592 --0.015855 -0.004481 -0.019303 # node 1593 --0.016501 -0.004632 -0.019540 # node 1594 --0.017147 -0.004783 -0.019777 # node 1595 --0.017793 -0.004933 -0.020013 # node 1596 --0.000981 -0.001210 -0.010313 # node 1597 --0.001734 -0.001185 -0.010731 # node 1598 --0.002486 -0.001160 -0.011150 # node 1599 --0.003238 -0.001136 -0.011569 # node 1600 --0.003595 -0.000837 -0.012513 # node 1601 --0.004123 -0.000909 -0.013119 # node 1602 --0.004651 -0.000980 -0.013724 # node 1603 --0.004660 -0.001025 -0.014293 # node 1604 --0.004668 -0.001070 -0.014861 # node 1605 --0.005121 -0.001220 -0.015192 # node 1606 --0.005574 -0.001369 -0.015522 # node 1607 --0.005662 -0.001748 -0.016144 # node 1608 --0.005751 -0.002126 -0.016766 # node 1609 --0.006224 -0.002043 -0.017253 # node 1610 --0.006697 -0.001960 -0.017741 # node 1611 --0.007275 -0.001377 -0.018290 # node 1612 --0.007853 -0.000794 -0.018838 # node 1613 --0.008431 -0.000210 -0.019386 # node 1614 --0.009008 0.000373 -0.019933 # node 1615 --0.008480 0.000359 -0.020792 # node 1616 --0.007952 0.000344 -0.021651 # node 1617 --0.007657 0.001171 -0.021944 # node 1618 --0.007361 0.001997 -0.022237 # node 1619 --0.007066 0.002823 -0.022530 # node 1620 --0.006770 0.003650 -0.022822 # node 1621 --0.006109 0.003775 -0.023381 # node 1622 --0.005448 0.003900 -0.023941 # node 1623 --0.004880 0.004364 -0.024426 # node 1624 --0.004312 0.004828 -0.024911 # node 1625 --0.003744 0.005291 -0.025397 # node 1626 --0.003312 0.005825 -0.025843 # node 1627 --0.002880 0.006358 -0.026289 # node 1628 --0.002448 0.006891 -0.026736 # node 1629 --0.002428 0.007560 -0.026694 # node 1630 --0.002409 0.008228 -0.026653 # node 1631 --0.002389 0.008897 -0.026613 # node 1632 --0.001875 0.009574 -0.026720 # node 1633 --0.001361 0.010251 -0.026828 # node 1634 --0.001333 0.011073 -0.027101 # node 1635 --0.001306 0.011895 -0.027374 # node 1636 --0.000624 0.012205 -0.027857 # node 1637 -0.000058 0.012516 -0.028338 # node 1638 -0.000740 0.012826 -0.028819 # node 1639 -0.001439 0.012757 -0.029133 # node 1640 -0.002139 0.012688 -0.029448 # node 1641 -0.002838 0.012618 -0.029762 # node 1642 --0.005720 -0.001289 -0.016634 # node 1643 --0.005690 -0.000452 -0.016502 # node 1644 --0.005659 0.000385 -0.016370 # node 1645 --0.005629 0.001222 -0.016238 # node 1646 --0.005613 0.001971 -0.015987 # node 1647 --0.005597 0.002720 -0.015734 # node 1648 --0.004619 0.002701 -0.015964 # node 1649 --0.003641 0.002682 -0.016194 # node 1650 --0.002662 0.002663 -0.016424 # node 1651 --0.003153 0.002328 -0.017304 # node 1652 --0.003643 0.001993 -0.018184 # node 1653 -0.000119 -0.000484 -0.009879 # node 1654 -0.000468 0.000266 -0.009864 # node 1655 -0.000816 0.001016 -0.009849 # node 1656 -0.001164 0.001766 -0.009835 # node 1657 -0.001513 0.002516 -0.009820 # node 1658 -0.001917 0.003092 -0.010058 # node 1659 -0.002322 0.003667 -0.010297 # node 1660 -0.002726 0.004243 -0.010535 # node 1661 -0.002646 0.005052 -0.010949 # node 1662 -0.002567 0.005861 -0.011363 # node 1663 -0.002487 0.006670 -0.011778 # node 1664 -0.002407 0.007479 -0.012191 # node 1665 -0.002327 0.008288 -0.012606 # node 1666 -0.002247 0.009097 -0.013020 # node 1667 -0.003167 0.009357 -0.013336 # node 1668 -0.004088 0.009616 -0.013652 # node 1669 -0.005008 0.009876 -0.013969 # node 1670 -0.005929 0.010135 -0.014284 # node 1671 -0.006400 0.010521 -0.014638 # node 1672 -0.006871 0.010907 -0.014990 # node 1673 -0.007342 0.011293 -0.015342 # node 1674 -0.007820 0.012070 -0.015386 # node 1675 -0.008299 0.012847 -0.015428 # node 1676 -0.008778 0.013623 -0.015470 # node 1677 -0.009256 0.014400 -0.015512 # node 1678 -0.009735 0.015177 -0.015556 # node 1679 -0.010060 0.015759 -0.015721 # node 1680 -0.010384 0.016342 -0.015887 # node 1681 -0.010709 0.016924 -0.016053 # node 1682 -0.010275 0.017291 -0.016831 # node 1683 -0.009841 0.017657 -0.017609 # node 1684 -0.009408 0.018024 -0.018387 # node 1685 -0.008974 0.018391 -0.019166 # node 1686 -0.008541 0.018757 -0.019943 # node 1687 -0.007876 0.018954 -0.020510 # node 1688 -0.007210 0.019151 -0.021078 # node 1689 -0.006545 0.019347 -0.021646 # node 1690 -0.005880 0.019544 -0.022213 # node 1691 -0.005215 0.019741 -0.022780 # node 1692 -0.004493 0.019769 -0.022832 # node 1693 -0.003771 0.019798 -0.022884 # node 1694 -0.003050 0.019826 -0.022937 # node 1695 -0.003329 0.019868 -0.022200 # node 1696 -0.003608 0.019910 -0.021464 # node 1697 -0.003887 0.019951 -0.020728 # node 1698 -0.004574 0.019895 -0.020430 # node 1699 -0.005261 0.019838 -0.020132 # node 1700 -0.005948 0.019782 -0.019833 # node 1701 -0.006083 0.019201 -0.020598 # node 1702 -0.006218 0.018620 -0.021362 # node 1703 -0.006353 0.018040 -0.022127 # node 1704 -0.005718 0.018140 -0.022967 # node 1705 -0.005082 0.018240 -0.023806 # node 1706 -0.005675 0.018062 -0.024123 # node 1707 -0.006269 0.017884 -0.024441 # node 1708 -0.000651 -0.000048 -0.005390 # node 1709 -0.001197 0.000302 -0.006049 # node 1710 -0.001743 0.000652 -0.006707 # node 1711 -0.002439 0.000471 -0.007270 # node 1712 -0.003136 0.000290 -0.007833 # node 1713 -0.003481 -0.000049 -0.008439 # node 1714 -0.003827 -0.000387 -0.009045 # node 1715 -0.004172 -0.000725 -0.009651 # node 1716 -0.004953 -0.000882 -0.009938 # node 1717 -0.005734 -0.001039 -0.010226 # node 1718 -0.006515 -0.001195 -0.010513 # node 1719 -0.007296 -0.001352 -0.010800 # node 1720 -0.007942 -0.001486 -0.011316 # node 1721 -0.008588 -0.001621 -0.011831 # node 1722 -0.009235 -0.001756 -0.012347 # node 1723 -0.009806 -0.001378 -0.012734 # node 1724 -0.010377 -0.001001 -0.013123 # node 1725 -0.010949 -0.000624 -0.013511 # node 1726 -0.011791 -0.000592 -0.013601 # node 1727 -0.012634 -0.000559 -0.013690 # node 1728 -0.013477 -0.000527 -0.013780 # node 1729 -0.014320 -0.000495 -0.013870 # node 1730 -0.015163 -0.000463 -0.013959 # node 1731 -0.004141 -0.000602 -0.010389 # node 1732 -0.004110 -0.000479 -0.011127 # node 1733 -0.004932 -0.000424 -0.011389 # node 1734 -0.005753 -0.000369 -0.011651 # node 1735 -0.006575 -0.000313 -0.011913 # node 1736 -0.006845 -0.000408 -0.012651 # node 1737 -0.007115 -0.000503 -0.013388 # node 1738 -# -SIMPLEX -parameters 4 -0 1 1 1 1.789900e-05 9.298100e-03 # simplex 0 -1 2 1 1 9.789900e-06 7.298100e-03 # simplex 1 -2 3 1 1 9.789900e-06 7.298100e-03 # simplex 2 -3 4 1 1 8.642000e-06 5.687800e-03 # simplex 3 -4 5 1 1 7.492900e-06 4.278200e-03 # simplex 4 -5 6 1 1 6.344600e-06 3.069400e-03 # simplex 5 -6 7 1 1 5.158000e-06 2.061200e-03 # simplex 6 -7 8 1 1 4.516100e-06 1.529300e-03 # simplex 7 -8 9 1 1 4.516100e-06 1.529300e-03 # simplex 8 -9 10 1 1 4.515900e-06 1.529300e-03 # simplex 9 -10 11 1 1 4.564300e-06 1.529300e-03 # simplex 10 -11 12 1 1 4.564800e-06 1.479200e-03 # simplex 11 -12 13 1 1 4.564800e-06 1.479200e-03 # simplex 12 -13 14 1 1 4.564800e-06 1.479200e-03 # simplex 13 -14 15 1 1 4.564300e-06 1.479200e-03 # simplex 14 -15 16 1 1 4.565800e-06 1.479200e-03 # simplex 15 -16 17 1 1 4.561800e-06 1.479200e-03 # simplex 16 -17 18 1 1 4.496700e-06 1.479200e-03 # simplex 17 -18 19 1 1 4.496900e-06 1.479400e-03 # simplex 18 -19 20 1 1 4.496700e-06 1.479400e-03 # simplex 19 -20 21 1 1 4.492100e-06 1.479400e-03 # simplex 20 -21 22 1 1 4.038700e-06 1.479400e-03 # simplex 21 -22 23 1 1 4.038700e-06 1.369400e-03 # simplex 22 -23 24 1 1 4.035100e-06 1.369400e-03 # simplex 23 -24 25 1 1 4.038700e-06 1.369400e-03 # simplex 24 -25 26 1 1 4.038700e-06 1.369400e-03 # simplex 25 -26 27 1 1 3.905400e-06 1.369400e-03 # simplex 26 -27 28 1 1 3.905300e-06 1.345600e-03 # simplex 27 -28 29 1 1 3.908700e-06 1.345600e-03 # simplex 28 -29 30 1 1 3.905100e-06 1.345600e-03 # simplex 29 -30 31 1 1 4.464300e-06 1.345600e-03 # simplex 30 -31 32 1 1 4.464300e-06 1.541900e-03 # simplex 31 -32 33 1 1 4.464600e-06 1.541900e-03 # simplex 32 -33 34 1 1 4.467600e-06 1.541900e-03 # simplex 33 -34 35 1 1 4.464600e-06 1.541900e-03 # simplex 34 -35 36 1 1 4.325100e-06 1.541900e-03 # simplex 35 -36 37 1 1 4.326400e-06 1.553200e-03 # simplex 36 -37 38 1 1 4.326000e-06 1.553200e-03 # simplex 37 -38 39 1 1 4.326400e-06 1.553200e-03 # simplex 38 -39 40 1 1 4.324200e-06 1.553200e-03 # simplex 39 -40 41 1 1 4.329100e-06 1.553200e-03 # simplex 40 -41 42 1 1 4.324600e-06 1.553200e-03 # simplex 41 -42 43 1 1 4.328300e-06 1.553200e-03 # simplex 42 -43 44 1 1 4.324700e-06 1.553200e-03 # simplex 43 -44 45 1 1 4.324600e-06 1.553200e-03 # simplex 44 -45 46 1 1 4.329100e-06 1.553200e-03 # simplex 45 -46 47 1 1 4.324700e-06 1.553200e-03 # simplex 46 -47 48 1 1 4.324600e-06 1.553200e-03 # simplex 47 -48 49 1 1 4.356500e-06 1.553200e-03 # simplex 48 -49 50 1 1 4.359900e-06 1.473700e-03 # simplex 49 -50 51 1 1 4.355900e-06 1.473700e-03 # simplex 50 -51 52 1 1 4.360400e-06 1.473700e-03 # simplex 51 -52 53 1 1 4.705600e-06 1.473700e-03 # simplex 52 -53 54 1 1 4.705600e-06 1.623400e-03 # simplex 53 -54 55 1 1 4.707500e-06 1.623400e-03 # simplex 54 -55 56 1 1 4.705900e-06 1.623400e-03 # simplex 55 -56 57 1 1 4.704200e-06 1.623400e-03 # simplex 56 -57 58 1 1 4.014300e-06 1.623400e-03 # simplex 57 -58 59 1 1 4.012900e-06 1.333100e-03 # simplex 58 -59 60 1 1 4.015900e-06 1.333100e-03 # simplex 59 -60 61 1 1 4.012900e-06 1.333100e-03 # simplex 60 -61 62 1 1 4.470400e-06 1.333100e-03 # simplex 61 -62 63 1 1 4.465500e-06 1.461600e-03 # simplex 62 -63 64 1 1 4.470300e-06 1.461600e-03 # simplex 63 -64 65 1 1 4.465700e-06 1.461600e-03 # simplex 64 -65 66 1 1 4.470900e-06 1.461600e-03 # simplex 65 -66 67 1 1 4.465900e-06 1.461600e-03 # simplex 66 -67 68 1 1 4.470500e-06 1.461600e-03 # simplex 67 -68 69 1 1 4.683300e-06 1.461600e-03 # simplex 68 -69 70 1 1 4.683200e-06 1.540800e-03 # simplex 69 -70 71 1 1 4.678500e-06 1.540800e-03 # simplex 70 -71 72 1 1 4.683300e-06 1.540800e-03 # simplex 71 -72 73 1 1 4.683200e-06 1.540800e-03 # simplex 72 -73 74 1 1 4.683200e-06 1.540800e-03 # simplex 73 -74 75 1 1 4.741000e-06 1.540800e-03 # simplex 74 -75 76 1 1 4.740800e-06 1.590000e-03 # simplex 75 -76 77 1 1 4.740800e-06 1.590000e-03 # simplex 76 -77 78 1 1 4.745200e-06 1.590000e-03 # simplex 77 -78 79 1 1 4.630900e-06 1.590000e-03 # simplex 78 -79 80 1 1 4.630900e-06 1.581000e-03 # simplex 79 -80 81 1 1 4.631300e-06 1.581000e-03 # simplex 80 -81 82 1 1 4.631300e-06 1.581000e-03 # simplex 81 -82 83 1 1 3.732200e-06 1.581000e-03 # simplex 82 -83 84 1 1 3.732300e-06 1.327100e-03 # simplex 83 -84 85 1 1 3.732300e-06 1.327100e-03 # simplex 84 -85 86 1 1 3.732400e-06 1.327100e-03 # simplex 85 -86 87 1 1 4.403900e-06 1.327100e-03 # simplex 86 -87 88 1 1 4.400000e-06 1.485900e-03 # simplex 87 -88 89 1 1 4.403900e-06 1.485900e-03 # simplex 88 -89 90 1 1 4.403900e-06 1.485900e-03 # simplex 89 -90 91 1 1 4.397500e-06 1.485900e-03 # simplex 90 -91 92 1 1 4.403900e-06 1.485900e-03 # simplex 91 -92 93 1 1 4.707800e-06 1.485900e-03 # simplex 92 -93 94 1 1 4.707700e-06 1.527000e-03 # simplex 93 -94 95 1 1 4.712700e-06 1.527000e-03 # simplex 94 -95 96 1 1 4.707800e-06 1.527000e-03 # simplex 95 -96 97 1 1 4.707700e-06 1.527000e-03 # simplex 96 -97 98 1 1 4.548500e-06 1.527000e-03 # simplex 97 -98 99 1 1 4.543900e-06 1.491600e-03 # simplex 98 -99 100 1 1 4.548700e-06 1.491600e-03 # simplex 99 -100 101 1 1 4.543800e-06 1.491600e-03 # simplex 100 -101 102 1 1 3.997900e-06 1.491600e-03 # simplex 101 -102 103 1 1 3.997000e-06 1.301200e-03 # simplex 102 -103 104 1 1 3.997000e-06 1.301200e-03 # simplex 103 -104 105 1 1 3.992000e-06 1.301200e-03 # simplex 104 -105 106 1 1 4.970200e-06 1.301200e-03 # simplex 105 -106 107 1 1 4.965600e-06 1.614800e-03 # simplex 106 -107 108 1 1 4.965200e-06 1.614800e-03 # simplex 107 -108 109 1 1 4.965200e-06 1.614800e-03 # simplex 108 -109 110 1 1 4.970300e-06 1.614800e-03 # simplex 109 -110 111 1 1 4.485400e-06 1.614800e-03 # simplex 110 -49 112 2 2 3.629400e-06 1.246800e-03 # simplex 111 -112 113 2 2 3.302300e-06 1.031000e-03 # simplex 112 -113 114 2 2 2.970900e-06 8.356700e-04 # simplex 113 -114 115 2 2 2.882500e-06 6.608800e-04 # simplex 114 -115 116 2 2 2.655700e-06 6.071800e-04 # simplex 115 -116 117 2 2 2.573600e-06 5.709500e-04 # simplex 116 -117 118 2 2 2.494600e-06 5.358300e-04 # simplex 117 -118 119 2 2 2.384200e-06 5.018300e-04 # simplex 118 -49 120 2 3 4.353400e-06 1.484300e-03 # simplex 119 -120 121 2 3 3.945200e-06 1.218500e-03 # simplex 120 -121 122 2 3 3.526800e-06 9.788500e-04 # simplex 121 -122 123 2 3 3.229700e-06 8.269600e-04 # simplex 122 -123 124 2 3 3.055300e-06 7.401000e-04 # simplex 123 -27 125 2 4 3.198500e-06 1.047000e-03 # simplex 124 -125 126 2 4 2.892100e-06 8.579400e-04 # simplex 125 -126 127 2 4 3.174900e-06 6.877400e-04 # simplex 126 -127 128 2 4 2.988200e-06 7.756100e-04 # simplex 127 -128 129 2 4 3.007200e-06 7.862600e-04 # simplex 128 -129 130 2 4 3.027800e-06 7.969800e-04 # simplex 129 -130 131 2 4 3.365200e-06 8.077800e-04 # simplex 130 -131 132 2 4 3.436800e-06 9.338900e-04 # simplex 131 -132 133 2 4 3.555300e-06 9.995700e-04 # simplex 132 -133 134 2 4 3.674400e-06 1.067500e-03 # simplex 133 -134 135 2 4 3.792800e-06 1.137600e-03 # simplex 134 -135 136 2 4 3.297000e-06 1.210000e-03 # simplex 135 -136 137 2 4 3.210800e-06 9.253800e-04 # simplex 136 -137 138 2 4 2.913000e-06 7.644900e-04 # simplex 137 -138 139 2 4 3.040800e-06 6.189800e-04 # simplex 138 -139 140 2 4 2.830700e-06 6.460800e-04 # simplex 139 -140 141 2 4 2.768200e-06 6.178700e-04 # simplex 140 -141 142 2 4 2.704600e-06 5.903000e-04 # simplex 141 -142 143 2 4 2.546400e-06 5.633500e-04 # simplex 142 -143 144 2 4 2.457400e-06 4.908900e-04 # simplex 143 -144 145 2 4 2.156500e-06 4.445800e-04 # simplex 144 -145 146 2 4 2.088700e-06 3.890400e-04 # simplex 145 -146 147 2 4 2.062600e-06 3.794000e-04 # simplex 146 -147 148 2 4 2.034700e-06 3.698700e-04 # simplex 147 -148 149 2 4 2.026500e-06 3.604700e-04 # simplex 148 -149 150 2 4 2.018900e-06 3.391900e-04 # simplex 149 -150 151 2 4 2.022500e-06 3.412400e-04 # simplex 150 -151 152 2 4 1.958200e-06 3.433000e-04 # simplex 151 -152 153 2 4 1.964800e-06 3.565500e-04 # simplex 152 -153 154 2 4 1.972700e-06 3.601000e-04 # simplex 153 -154 155 2 4 1.984100e-06 3.636600e-04 # simplex 154 -155 156 2 4 2.257800e-06 3.672400e-04 # simplex 155 -156 157 2 4 2.327900e-06 4.262700e-04 # simplex 156 -157 158 2 4 2.445700e-06 4.718700e-04 # simplex 157 -158 159 2 4 2.735900e-06 5.197800e-04 # simplex 158 -159 160 2 4 2.787600e-06 5.573800e-04 # simplex 159 -160 161 2 4 2.768600e-06 5.490900e-04 # simplex 160 -161 162 2 4 2.746200e-06 5.408700e-04 # simplex 161 -162 163 2 4 2.513500e-06 5.327100e-04 # simplex 162 -163 164 2 4 2.469900e-06 4.678300e-04 # simplex 163 -164 165 2 4 2.402100e-06 4.424700e-04 # simplex 164 -165 166 2 4 2.331400e-06 4.178100e-04 # simplex 165 -166 167 2 4 2.266300e-06 3.938600e-04 # simplex 166 -167 168 2 4 2.198400e-06 3.706200e-04 # simplex 167 -168 169 2 4 1.920800e-06 3.480800e-04 # simplex 168 -1 170 1 6 1.164300e-05 1.019700e-02 # simplex 169 -170 171 1 6 1.134200e-05 9.676100e-03 # simplex 170 -171 172 1 6 1.104100e-05 9.168800e-03 # simplex 171 -172 173 1 6 1.074000e-05 8.675300e-03 # simplex 172 -173 174 1 6 1.095600e-05 8.195400e-03 # simplex 173 -174 175 1 6 1.079400e-05 8.456800e-03 # simplex 174 -175 176 1 6 1.082700e-05 8.506600e-03 # simplex 175 -176 177 1 6 8.459500e-06 8.556600e-03 # simplex 176 -177 178 1 6 8.444300e-06 6.591800e-03 # simplex 177 -178 179 1 6 8.391100e-06 6.507100e-03 # simplex 178 -179 180 1 6 1.091700e-05 6.422900e-03 # simplex 179 -180 181 1 6 1.069100e-05 8.415300e-03 # simplex 180 -181 182 1 6 1.024600e-05 7.741300e-03 # simplex 181 -182 183 1 6 9.685700e-06 7.095500e-03 # simplex 182 -183 184 2 5 8.982700e-06 5.408100e-03 # simplex 183 -184 185 2 5 7.378700e-06 3.646200e-03 # simplex 184 -185 186 2 5 5.759100e-06 2.231600e-03 # simplex 185 -186 187 2 5 3.335000e-06 1.164300e-03 # simplex 186 -187 188 2 5 2.533400e-06 6.180900e-04 # simplex 187 -188 189 2 5 2.417500e-06 5.620000e-04 # simplex 188 -189 190 2 5 2.299500e-06 5.085800e-04 # simplex 189 -190 191 2 5 2.233600e-06 4.578200e-04 # simplex 190 -191 192 2 5 2.262300e-06 4.549200e-04 # simplex 191 -192 193 2 5 2.445900e-06 5.304800e-04 # simplex 192 -193 194 2 5 2.322000e-06 6.118500e-04 # simplex 193 -194 195 2 5 2.298800e-06 5.475700e-04 # simplex 194 -195 196 2 5 2.088600e-06 4.511600e-04 # simplex 195 -196 197 2 5 2.089200e-06 3.640900e-04 # simplex 196 -197 198 2 5 1.921900e-06 3.480500e-04 # simplex 197 -198 199 2 5 1.825500e-06 3.148800e-04 # simplex 198 -199 200 2 5 1.734700e-06 2.833700e-04 # simplex 199 -200 201 2 5 1.434400e-06 2.535200e-04 # simplex 200 -201 202 2 5 1.418800e-06 2.214300e-04 # simplex 201 -202 203 2 5 1.474800e-06 2.383300e-04 # simplex 202 -203 204 2 5 1.747800e-06 2.558500e-04 # simplex 203 -204 205 2 5 1.826500e-06 3.247200e-04 # simplex 204 -205 206 2 5 1.922600e-06 3.597500e-04 # simplex 205 -206 207 2 5 2.057300e-06 3.965700e-04 # simplex 206 -207 208 2 5 2.056600e-06 4.043600e-04 # simplex 207 -208 209 2 5 1.959100e-06 3.661600e-04 # simplex 208 -209 210 2 5 2.044100e-06 3.298500e-04 # simplex 209 -210 211 2 5 2.017200e-06 3.528100e-04 # simplex 210 -211 212 2 5 2.067600e-06 3.714200e-04 # simplex 211 -212 213 2 5 1.610600e-06 3.905000e-04 # simplex 212 -213 214 2 5 1.656100e-06 3.064600e-04 # simplex 213 -214 215 2 5 1.703100e-06 3.245900e-04 # simplex 214 -215 216 2 5 2.338000e-06 3.432400e-04 # simplex 215 -216 217 2 5 2.319800e-06 4.513800e-04 # simplex 216 -217 218 2 5 2.228200e-06 4.153300e-04 # simplex 217 -218 219 2 5 2.082600e-06 3.807900e-04 # simplex 218 -183 220 1 6 9.732800e-06 6.942200e-03 # simplex 219 -220 221 1 6 9.573800e-06 6.727200e-03 # simplex 220 -221 222 1 6 9.428800e-06 6.515600e-03 # simplex 221 -222 223 1 6 7.614200e-06 6.307300e-03 # simplex 222 -223 224 1 6 7.793300e-06 5.519600e-03 # simplex 223 -224 225 1 6 8.222500e-06 6.144000e-03 # simplex 224 -225 226 1 6 8.656100e-06 6.801900e-03 # simplex 225 -226 227 1 6 9.081500e-06 7.493200e-03 # simplex 226 -227 228 1 6 1.045300e-05 8.218000e-03 # simplex 227 -228 229 1 6 1.073100e-05 9.345400e-03 # simplex 228 -229 230 1 6 1.088000e-05 9.619200e-03 # simplex 229 -230 231 1 6 1.103600e-05 9.897000e-03 # simplex 230 -231 232 1 6 1.119200e-05 1.017900e-02 # simplex 231 -232 233 1 6 1.135600e-05 1.046400e-02 # simplex 232 -233 234 1 6 1.182900e-05 1.075400e-02 # simplex 233 -234 235 1 6 1.176500e-05 1.021100e-02 # simplex 234 -235 236 1 6 1.140800e-05 9.597900e-03 # simplex 235 -236 237 1 6 1.104800e-05 9.004000e-03 # simplex 236 -237 238 1 6 1.069100e-05 8.429000e-03 # simplex 237 -238 239 1 6 1.031900e-05 7.873000e-03 # simplex 238 -239 240 1 6 9.972600e-06 7.336000e-03 # simplex 239 -240 241 1 6 9.826100e-06 6.818000e-03 # simplex 240 -241 242 1 6 9.627300e-06 6.720900e-03 # simplex 241 -242 243 1 6 9.638300e-06 6.737000e-03 # simplex 242 -243 244 1 6 9.660600e-06 6.753200e-03 # simplex 243 -244 245 1 6 9.661900e-06 6.769400e-03 # simplex 244 -245 246 1 6 9.672900e-06 6.785600e-03 # simplex 245 -246 247 1 6 9.685000e-06 6.801800e-03 # simplex 246 -247 248 1 6 9.696000e-06 6.818000e-03 # simplex 247 -248 249 1 6 9.708100e-06 6.834300e-03 # simplex 248 -249 250 1 6 9.030500e-06 6.850600e-03 # simplex 249 -250 251 1 6 9.158000e-06 6.536400e-03 # simplex 250 -251 252 1 6 9.352300e-06 6.834100e-03 # simplex 251 -252 253 1 6 9.559000e-06 7.138400e-03 # simplex 252 -253 254 1 6 1.043300e-05 7.449300e-03 # simplex 253 -254 255 1 6 1.043300e-05 7.923500e-03 # simplex 254 -255 256 1 6 1.017700e-05 7.556100e-03 # simplex 255 -256 257 1 6 9.932900e-06 7.197300e-03 # simplex 256 -257 258 1 6 9.698400e-06 6.847300e-03 # simplex 257 -258 259 1 6 9.443900e-06 6.506100e-03 # simplex 258 -259 260 1 6 9.198500e-06 6.173500e-03 # simplex 259 -260 261 1 6 9.147300e-06 5.849700e-03 # simplex 260 -261 262 1 6 8.891800e-06 5.682400e-03 # simplex 261 -262 263 1 6 8.639000e-06 5.352400e-03 # simplex 262 -263 264 1 6 8.368900e-06 5.032200e-03 # simplex 263 -264 265 1 6 8.105200e-06 4.721900e-03 # simplex 264 -265 266 1 6 7.843300e-06 4.421400e-03 # simplex 265 -266 267 1 6 6.980900e-06 4.130900e-03 # simplex 266 -267 268 1 6 6.913800e-06 3.730400e-03 # simplex 267 -268 269 1 6 7.010200e-06 3.843100e-03 # simplex 268 -269 270 1 6 7.113600e-06 3.957500e-03 # simplex 269 -270 271 1 6 7.225700e-06 4.073600e-03 # simplex 270 -271 272 1 6 8.077500e-06 4.191300e-03 # simplex 271 -272 273 1 6 8.084800e-06 4.594600e-03 # simplex 272 -273 274 1 6 7.959200e-06 4.462600e-03 # simplex 273 -274 275 1 6 7.850900e-06 4.332500e-03 # simplex 274 -275 276 1 6 7.725600e-06 4.204400e-03 # simplex 275 -276 277 1 6 7.617000e-06 4.078200e-03 # simplex 276 -277 278 1 6 7.491900e-06 3.954000e-03 # simplex 277 -278 279 1 6 7.383100e-06 3.831600e-03 # simplex 278 -279 280 1 6 7.266100e-06 3.711200e-03 # simplex 279 -280 281 1 6 7.141400e-06 3.592700e-03 # simplex 280 -281 282 1 6 7.032200e-06 3.476100e-03 # simplex 281 -282 283 1 6 6.907800e-06 3.361400e-03 # simplex 282 -283 284 1 6 6.493400e-06 3.248700e-03 # simplex 283 -284 285 1 6 6.387800e-06 3.006100e-03 # simplex 284 -285 286 1 6 6.269800e-06 2.901500e-03 # simplex 285 -286 287 1 6 6.157800e-06 2.798900e-03 # simplex 286 -287 288 1 6 6.044900e-06 2.698000e-03 # simplex 287 -288 289 1 6 5.933900e-06 2.599100e-03 # simplex 288 -289 290 1 6 5.821900e-06 2.501900e-03 # simplex 289 -290 291 1 6 5.716400e-06 2.406600e-03 # simplex 290 -291 292 1 6 5.831900e-06 2.313200e-03 # simplex 291 -292 293 1 6 5.690300e-06 2.285500e-03 # simplex 292 -293 294 1 6 5.521300e-06 2.151700e-03 # simplex 293 -294 295 1 6 5.357900e-06 2.021900e-03 # simplex 294 -295 296 1 6 5.182900e-06 1.896200e-03 # simplex 295 -296 297 1 6 5.013800e-06 1.774400e-03 # simplex 296 -297 298 1 6 4.850000e-06 1.656800e-03 # simplex 297 -298 299 1 6 4.425400e-06 1.543100e-03 # simplex 298 -299 300 1 6 4.347700e-06 1.430200e-03 # simplex 299 -300 301 1 6 4.348400e-06 1.430200e-03 # simplex 300 -301 302 1 6 4.348200e-06 1.430200e-03 # simplex 301 -302 303 1 6 4.348200e-06 1.430200e-03 # simplex 302 -303 304 1 6 4.348200e-06 1.430200e-03 # simplex 303 -304 305 1 6 3.972800e-06 1.430200e-03 # simplex 304 -272 306 2 7 6.336300e-06 3.593400e-03 # simplex 305 -306 307 2 7 5.351700e-06 2.563200e-03 # simplex 306 -307 308 2 7 4.530700e-06 1.707000e-03 # simplex 307 -308 309 2 7 3.743800e-06 1.261500e-03 # simplex 308 -309 310 2 7 3.614200e-06 1.024300e-03 # simplex 309 -310 311 2 7 3.538600e-06 9.875000e-04 # simplex 310 -311 312 2 7 3.802300e-06 1.140300e-03 # simplex 311 -312 313 2 7 3.851900e-06 1.304000e-03 # simplex 312 -313 314 2 7 3.978300e-06 1.337900e-03 # simplex 313 -314 315 2 7 3.992600e-06 1.347400e-03 # simplex 314 -315 316 2 7 4.018100e-06 1.356900e-03 # simplex 315 -316 317 2 7 3.865600e-06 1.236000e-03 # simplex 316 -317 318 2 7 3.519800e-06 1.027100e-03 # simplex 317 -318 319 2 7 3.735700e-06 8.375400e-04 # simplex 318 -319 320 2 7 3.323100e-06 7.684700e-04 # simplex 319 -320 321 2 7 2.892400e-06 5.836400e-04 # simplex 320 -321 322 2 7 2.240700e-06 4.242400e-04 # simplex 321 -272 323 2 8 6.430500e-06 3.512800e-03 # simplex 322 -323 324 2 8 5.331500e-06 2.418600e-03 # simplex 323 -324 325 2 8 4.234300e-06 1.528700e-03 # simplex 324 -325 326 2 8 3.833500e-06 8.428700e-04 # simplex 325 -326 327 2 8 3.118700e-06 7.108800e-04 # simplex 326 -327 328 2 8 3.213600e-06 7.537900e-04 # simplex 327 -328 329 2 8 3.348500e-06 7.979500e-04 # simplex 328 -329 330 2 8 3.384300e-06 7.962300e-04 # simplex 329 -330 331 2 8 3.353500e-06 7.832300e-04 # simplex 330 -331 332 2 8 3.328900e-06 7.703300e-04 # simplex 331 -332 333 2 8 3.298000e-06 7.575300e-04 # simplex 332 -333 334 2 8 3.273400e-06 7.448500e-04 # simplex 333 -334 335 2 8 2.939600e-06 7.322700e-04 # simplex 334 -335 336 2 8 2.892500e-06 6.448100e-04 # simplex 335 -336 337 2 8 2.825900e-06 6.141800e-04 # simplex 336 -337 338 2 8 2.753400e-06 5.842900e-04 # simplex 337 -338 339 2 8 2.686700e-06 5.551400e-04 # simplex 338 -339 340 2 8 2.637100e-06 5.267500e-04 # simplex 339 -340 341 2 8 2.617100e-06 5.670000e-04 # simplex 340 -341 342 2 8 2.648100e-06 5.804500e-04 # simplex 341 -342 343 2 8 2.678700e-06 5.940600e-04 # simplex 342 -343 344 2 8 2.709100e-06 6.078200e-04 # simplex 343 -344 345 2 8 2.623800e-06 6.217500e-04 # simplex 344 -345 346 2 8 2.700600e-06 5.870900e-04 # simplex 345 -346 347 2 8 2.831500e-06 6.440800e-04 # simplex 346 -347 348 2 8 2.959800e-06 7.037100e-04 # simplex 347 -348 349 2 8 2.949300e-06 7.659800e-04 # simplex 348 -349 350 2 8 3.019800e-06 7.928400e-04 # simplex 349 -350 351 2 8 3.048600e-06 8.061600e-04 # simplex 350 -351 352 2 8 3.072400e-06 8.196000e-04 # simplex 351 -352 353 2 8 3.097800e-06 8.331400e-04 # simplex 352 -353 354 2 8 3.159900e-06 8.468000e-04 # simplex 353 -354 355 2 8 3.069700e-06 7.900200e-04 # simplex 354 -355 356 2 8 2.857500e-06 6.845800e-04 # simplex 355 -356 357 2 8 2.645300e-06 5.866900e-04 # simplex 356 -357 358 2 8 2.432700e-06 4.963500e-04 # simplex 357 -358 359 2 8 2.493900e-06 4.135700e-04 # simplex 358 -359 360 2 8 2.374900e-06 4.138100e-04 # simplex 359 -360 361 2 8 2.375300e-06 4.140100e-04 # simplex 360 -361 362 2 8 2.373800e-06 4.142100e-04 # simplex 361 -362 363 2 8 2.437000e-06 4.144100e-04 # simplex 362 -363 364 2 8 2.255500e-06 3.666100e-04 # simplex 363 -364 365 2 8 1.890200e-06 2.571900e-04 # simplex 364 -365 366 2 8 1.411800e-06 1.671700e-04 # simplex 365 -345 367 2 9 2.166400e-06 4.512400e-04 # simplex 366 -367 368 2 9 2.098400e-06 4.222800e-04 # simplex 367 -368 369 2 9 2.135700e-06 3.942700e-04 # simplex 368 -369 370 2 9 2.119400e-06 3.994400e-04 # simplex 369 -370 371 2 9 2.170700e-06 4.178600e-04 # simplex 370 -371 372 2 9 2.077800e-06 4.366900e-04 # simplex 371 -372 373 2 9 2.053400e-06 4.405700e-04 # simplex 372 -373 374 2 9 1.961500e-06 4.022900e-04 # simplex 373 -374 375 2 9 1.870900e-06 3.657600e-04 # simplex 374 -375 376 2 9 1.944900e-06 3.309700e-04 # simplex 375 -376 377 2 9 1.872100e-06 3.279600e-04 # simplex 376 -377 378 2 9 1.825300e-06 3.119800e-04 # simplex 377 -378 379 2 9 1.777900e-06 2.964100e-04 # simplex 378 -379 380 2 9 1.687500e-06 2.812300e-04 # simplex 379 -267 381 2 10 6.067900e-06 2.777100e-03 # simplex 380 -381 382 2 10 2.990600e-06 1.091800e-03 # simplex 381 -382 383 2 10 1.959800e-06 4.297500e-04 # simplex 382 -383 384 2 10 2.050800e-06 4.707100e-04 # simplex 383 -384 385 2 10 2.341900e-06 5.135300e-04 # simplex 384 -385 386 2 10 2.301400e-06 5.431000e-04 # simplex 385 -386 387 2 10 2.123900e-06 4.617300e-04 # simplex 386 -387 388 2 10 2.492700e-06 3.869700e-04 # simplex 387 -388 389 2 10 2.552100e-06 5.189700e-04 # simplex 388 -389 390 2 10 2.900500e-06 6.699600e-04 # simplex 389 -390 391 2 10 3.194600e-06 8.402200e-04 # simplex 390 -391 392 2 10 3.117800e-06 7.835500e-04 # simplex 391 -392 393 2 10 2.053600e-06 5.488900e-04 # simplex 392 -393 394 2 10 1.813800e-06 3.390400e-04 # simplex 393 -394 395 2 10 1.748800e-06 3.151000e-04 # simplex 394 -395 396 2 10 1.683000e-06 2.920400e-04 # simplex 395 -396 397 2 10 1.666200e-06 2.698600e-04 # simplex 396 -397 398 2 10 1.918000e-06 3.571800e-04 # simplex 397 -398 399 2 10 3.078300e-06 5.853700e-04 # simplex 398 -399 400 2 10 3.348300e-06 8.143600e-04 # simplex 399 -400 401 2 10 3.272300e-06 7.795300e-04 # simplex 400 -401 402 2 10 3.093900e-06 7.454500e-04 # simplex 401 -402 403 2 10 3.040900e-06 7.309200e-04 # simplex 402 -403 404 2 10 2.997700e-06 7.114900e-04 # simplex 403 -404 405 2 10 2.957500e-06 6.923200e-04 # simplex 404 -405 406 2 10 2.391000e-06 6.734200e-04 # simplex 405 -406 407 2 10 2.355700e-06 5.616600e-04 # simplex 406 -407 408 2 10 2.318000e-06 5.439300e-04 # simplex 407 -408 409 2 10 2.756300e-06 5.264900e-04 # simplex 408 -409 410 2 10 2.716600e-06 6.178300e-04 # simplex 409 -410 411 2 10 2.328600e-06 6.018100e-04 # simplex 410 -411 412 2 10 2.282600e-06 5.013000e-04 # simplex 411 -412 413 2 10 2.213700e-06 4.724700e-04 # simplex 412 -413 414 2 10 2.149100e-06 4.444900e-04 # simplex 413 -414 415 2 10 2.080600e-06 4.173700e-04 # simplex 414 -415 416 2 10 2.465300e-06 3.911100e-04 # simplex 415 -416 417 2 10 2.404100e-06 4.373300e-04 # simplex 416 -417 418 2 10 2.363000e-06 4.225600e-04 # simplex 417 -418 419 2 10 2.301100e-06 4.080500e-04 # simplex 418 -419 420 2 10 2.338800e-06 4.110900e-04 # simplex 419 -420 421 2 10 2.453800e-06 4.525100e-04 # simplex 420 -421 422 2 10 2.570900e-06 4.959200e-04 # simplex 421 -422 423 2 10 2.682300e-06 5.413200e-04 # simplex 422 -423 424 2 10 3.007500e-06 5.887100e-04 # simplex 423 -424 425 2 10 3.096900e-06 6.446200e-04 # simplex 424 -425 426 2 10 3.155900e-06 6.681200e-04 # simplex 425 -426 427 2 10 2.835000e-06 6.920400e-04 # simplex 426 -427 428 2 10 2.995800e-06 6.749700e-04 # simplex 427 -428 429 2 10 3.614700e-06 7.961600e-04 # simplex 428 -429 430 2 10 3.651700e-06 9.090100e-04 # simplex 429 -430 431 2 10 3.455900e-06 8.125600e-04 # simplex 430 -431 432 2 10 3.253200e-06 7.215200e-04 # simplex 431 -432 433 2 10 2.737100e-06 6.358900e-04 # simplex 432 -433 434 2 10 2.688800e-06 5.476900e-04 # simplex 433 -434 435 2 10 2.773100e-06 5.825000e-04 # simplex 434 -435 436 2 10 2.857100e-06 6.183700e-04 # simplex 435 -436 437 2 10 2.941400e-06 6.553200e-04 # simplex 436 -437 438 2 10 3.012600e-06 6.933400e-04 # simplex 437 -438 439 2 10 3.094500e-06 7.299300e-04 # simplex 438 -439 440 2 10 3.180300e-06 7.711800e-04 # simplex 439 -440 441 2 10 3.270400e-06 8.135600e-04 # simplex 440 -441 442 2 10 3.222400e-06 8.570800e-04 # simplex 441 -442 443 2 10 3.072200e-06 7.441700e-04 # simplex 442 -443 444 2 10 2.664900e-06 5.602200e-04 # simplex 443 -444 445 2 10 2.257400e-06 4.023800e-04 # simplex 444 -445 446 2 10 1.852600e-06 2.706500e-04 # simplex 445 -446 447 2 10 1.301300e-06 1.650500e-04 # simplex 446 -391 448 2 11 3.051900e-06 8.220700e-04 # simplex 447 -448 449 2 11 2.975500e-06 7.818300e-04 # simplex 448 -449 450 2 11 2.900900e-06 7.426000e-04 # simplex 449 -450 451 2 11 2.738400e-06 7.043700e-04 # simplex 450 -451 452 2 11 2.861200e-06 7.397500e-04 # simplex 451 -452 453 2 11 2.936500e-06 9.064700e-04 # simplex 452 -453 454 2 11 3.086500e-06 9.332300e-04 # simplex 453 -454 455 2 11 3.112300e-06 9.494500e-04 # simplex 454 -455 456 2 11 3.140700e-06 9.658100e-04 # simplex 455 -456 457 2 11 3.166300e-06 9.823100e-04 # simplex 456 -457 458 2 11 3.293100e-06 9.989400e-04 # simplex 457 -458 459 2 11 3.369500e-06 1.028300e-03 # simplex 458 -459 460 2 11 3.486000e-06 1.100600e-03 # simplex 459 -460 461 2 11 3.602800e-06 1.175400e-03 # simplex 460 -461 462 2 11 4.490300e-06 1.252700e-03 # simplex 461 -462 463 2 11 4.558800e-06 1.564000e-03 # simplex 462 -463 464 2 11 4.559600e-06 1.564000e-03 # simplex 463 -464 465 2 11 4.608100e-06 1.564000e-03 # simplex 464 -465 466 2 11 4.606900e-06 1.540700e-03 # simplex 465 -466 467 2 11 4.609000e-06 1.540700e-03 # simplex 466 -467 468 2 11 4.446200e-06 1.540700e-03 # simplex 467 -468 469 2 11 4.442600e-06 1.521100e-03 # simplex 468 -469 470 2 11 4.446200e-06 1.521100e-03 # simplex 469 -470 471 2 11 3.834200e-06 1.521100e-03 # simplex 470 -471 472 2 11 3.834200e-06 1.273200e-03 # simplex 471 -472 473 2 11 3.834200e-06 1.273200e-03 # simplex 472 -473 474 2 11 4.664500e-06 1.273200e-03 # simplex 473 -474 475 2 11 4.662500e-06 1.550900e-03 # simplex 474 -475 476 2 11 4.662500e-06 1.550900e-03 # simplex 475 -476 477 2 11 4.664500e-06 1.550900e-03 # simplex 476 -477 478 2 11 4.662500e-06 1.550900e-03 # simplex 477 -478 479 2 11 4.662500e-06 1.550900e-03 # simplex 478 -479 480 2 11 4.037700e-06 1.550900e-03 # simplex 479 -480 481 2 11 4.043600e-06 1.357400e-03 # simplex 480 -481 482 2 11 4.039500e-06 1.357400e-03 # simplex 481 -482 483 2 11 4.037700e-06 1.357400e-03 # simplex 482 -483 484 2 11 4.136200e-06 1.357400e-03 # simplex 483 -484 485 2 11 4.082400e-06 1.386300e-03 # simplex 484 -485 486 2 11 3.976900e-06 1.313900e-03 # simplex 485 -486 487 2 11 3.864400e-06 1.243400e-03 # simplex 486 -487 488 2 11 3.952500e-06 1.174900e-03 # simplex 487 -488 489 2 11 3.834000e-06 1.109100e-03 # simplex 488 -489 490 2 11 3.719300e-06 1.043500e-03 # simplex 489 -490 491 2 11 3.754700e-06 9.800200e-04 # simplex 490 -491 492 2 11 3.603400e-06 9.809700e-04 # simplex 491 -492 493 2 11 3.425600e-06 8.845200e-04 # simplex 492 -493 494 2 11 3.239100e-06 7.930600e-04 # simplex 493 -494 495 2 11 2.905800e-06 7.065900e-04 # simplex 494 -484 496 2 12 3.766400e-06 1.232500e-03 # simplex 495 -496 497 2 12 3.485800e-06 1.052900e-03 # simplex 496 -497 498 2 12 3.201200e-06 8.875500e-04 # simplex 497 -498 499 2 12 2.876600e-06 7.362900e-04 # simplex 498 -499 500 2 12 2.678300e-06 6.424500e-04 # simplex 499 -500 501 2 12 2.566000e-06 5.914400e-04 # simplex 500 -501 502 2 12 2.461800e-06 5.425400e-04 # simplex 501 -502 503 2 12 2.353300e-06 4.957500e-04 # simplex 502 -503 504 2 12 2.412100e-06 4.510800e-04 # simplex 503 -504 505 2 12 2.300400e-06 4.587800e-04 # simplex 504 -505 506 2 12 2.190800e-06 4.160900e-04 # simplex 505 -506 507 2 12 2.079400e-06 3.754900e-04 # simplex 506 -507 508 2 12 1.620600e-06 3.369700e-04 # simplex 507 -508 509 2 12 1.516900e-06 2.369900e-04 # simplex 508 -509 510 2 12 1.397600e-06 2.018900e-04 # simplex 509 -510 511 2 12 1.623200e-06 1.696000e-04 # simplex 510 -511 512 2 12 1.471500e-06 1.623300e-04 # simplex 511 -512 513 2 12 1.311400e-06 1.292500e-04 # simplex 512 -513 514 2 12 1.153000e-06 9.993900e-05 # simplex 513 -514 515 2 12 8.951900e-07 7.439900e-05 # simplex 514 -504 516 2 13 1.931200e-06 3.714800e-04 # simplex 515 -516 517 2 13 1.963600e-06 3.854200e-04 # simplex 516 -517 518 2 13 2.755200e-06 3.996200e-04 # simplex 517 -518 519 2 13 2.824600e-06 5.952300e-04 # simplex 518 -519 520 2 13 2.917800e-06 6.357100e-04 # simplex 519 -520 521 2 13 3.016400e-06 6.775300e-04 # simplex 520 -521 522 2 13 2.353400e-06 7.206700e-04 # simplex 521 -522 523 2 13 2.335400e-06 5.532600e-04 # simplex 522 -523 524 2 13 2.227500e-06 5.028200e-04 # simplex 523 -524 525 2 13 2.118600e-06 4.548000e-04 # simplex 524 -525 526 2 13 2.216800e-06 4.091900e-04 # simplex 525 -526 527 2 13 1.793300e-06 2.681000e-04 # simplex 526 -527 528 2 13 9.071800e-07 8.535900e-05 # simplex 527 -499 529 2 14 1.823900e-06 4.380600e-04 # simplex 528 -529 530 2 14 2.268300e-06 3.836200e-04 # simplex 529 -530 531 2 14 2.281400e-06 3.995600e-04 # simplex 530 -531 532 2 14 2.051500e-06 3.707600e-04 # simplex 531 -532 533 2 14 1.563500e-06 3.058500e-04 # simplex 532 -533 534 2 14 1.449900e-06 2.152800e-04 # simplex 533 -534 535 2 14 1.637400e-06 1.954200e-04 # simplex 534 -535 536 2 14 1.522500e-06 2.114800e-04 # simplex 535 -536 537 2 14 1.374700e-06 1.719200e-04 # simplex 536 -537 538 2 14 1.198400e-06 1.364500e-04 # simplex 537 -261 539 2 15 7.368900e-06 4.371600e-03 # simplex 538 -539 540 2 15 5.606200e-06 2.544100e-03 # simplex 539 -540 541 2 15 3.803100e-06 1.211300e-03 # simplex 540 -541 542 2 15 2.653100e-06 6.488700e-04 # simplex 541 -542 543 2 15 2.427200e-06 5.431200e-04 # simplex 542 -543 544 2 15 2.202200e-06 4.467700e-04 # simplex 543 -544 545 2 15 1.975300e-06 3.598400e-04 # simplex 544 -545 546 2 15 1.775000e-06 2.823000e-04 # simplex 545 -546 547 2 15 1.911600e-06 3.307200e-04 # simplex 546 -547 548 2 15 2.401100e-06 5.205600e-04 # simplex 547 -548 549 2 15 3.188500e-06 7.534600e-04 # simplex 548 -549 550 2 15 3.220000e-06 7.973300e-04 # simplex 549 -550 551 2 15 2.750500e-06 5.821800e-04 # simplex 550 -551 552 2 15 2.564800e-06 4.008600e-04 # simplex 551 -552 553 2 15 2.446000e-06 4.160800e-04 # simplex 552 -553 554 2 15 2.109100e-06 5.265400e-04 # simplex 553 -554 555 2 15 2.108000e-06 4.298500e-04 # simplex 554 -555 556 2 15 1.869800e-06 3.381700e-04 # simplex 555 -556 557 2 15 1.630800e-06 2.574900e-04 # simplex 556 -557 558 2 15 1.392500e-06 1.878000e-04 # simplex 557 -554 559 2 16 2.749500e-06 5.283800e-04 # simplex 558 -559 560 2 16 2.641900e-06 4.875400e-04 # simplex 559 -560 561 2 16 2.535300e-06 4.483400e-04 # simplex 560 -561 562 2 16 2.424300e-06 4.107900e-04 # simplex 561 -562 563 2 16 2.316600e-06 3.748700e-04 # simplex 562 -563 564 2 16 2.209700e-06 3.406000e-04 # simplex 563 -564 565 2 16 2.099600e-06 3.079700e-04 # simplex 564 -565 566 2 16 1.990700e-06 2.769900e-04 # simplex 565 -566 567 2 16 1.711200e-06 2.476400e-04 # simplex 566 -261 568 2 17 7.900000e-06 4.720800e-03 # simplex 567 -568 569 2 17 5.797500e-06 2.556800e-03 # simplex 568 -569 570 2 17 3.456000e-06 1.056500e-03 # simplex 569 -570 571 2 17 2.329000e-06 4.932200e-04 # simplex 570 -571 572 2 17 2.329600e-06 4.933000e-04 # simplex 571 -572 573 2 17 2.329400e-06 4.933800e-04 # simplex 572 -573 574 2 17 2.329600e-06 4.934700e-04 # simplex 573 -574 575 2 17 2.083900e-06 4.935500e-04 # simplex 574 -575 576 2 17 2.078600e-06 4.392300e-04 # simplex 575 -576 577 2 17 2.067800e-06 4.346500e-04 # simplex 576 -577 578 2 17 2.056900e-06 4.301100e-04 # simplex 577 -578 579 2 17 2.506300e-06 4.255900e-04 # simplex 578 -579 580 2 17 2.480200e-06 5.047400e-04 # simplex 579 -580 581 2 17 2.438600e-06 4.885600e-04 # simplex 580 -581 582 2 17 2.400300e-06 4.726500e-04 # simplex 581 -582 583 2 17 2.225700e-06 4.570000e-04 # simplex 582 -583 584 2 17 2.135000e-06 3.610100e-04 # simplex 583 -584 585 2 17 1.591900e-06 3.118400e-04 # simplex 584 -585 586 2 17 1.490500e-06 2.426800e-04 # simplex 585 -586 587 2 17 1.403600e-06 2.156800e-04 # simplex 586 -587 588 2 17 1.318300e-06 1.902700e-04 # simplex 587 -585 589 2 18 1.458800e-06 2.416700e-04 # simplex 588 -589 590 2 18 1.441100e-06 2.355900e-04 # simplex 589 -590 591 2 18 1.871800e-06 2.295900e-04 # simplex 590 -591 592 2 18 1.914300e-06 3.179500e-04 # simplex 591 -592 593 2 18 2.024600e-06 3.549600e-04 # simplex 592 -593 594 2 18 2.131700e-06 3.940000e-04 # simplex 593 -594 595 2 18 2.137600e-06 4.350800e-04 # simplex 594 -595 596 2 18 2.155500e-06 4.215800e-04 # simplex 595 -596 597 2 18 2.088800e-06 3.959100e-04 # simplex 596 -597 598 2 18 2.021800e-06 3.710400e-04 # simplex 597 -598 599 2 18 1.955500e-06 3.469800e-04 # simplex 598 -599 600 2 18 1.888900e-06 3.237200e-04 # simplex 599 -600 601 2 18 1.819100e-06 3.012800e-04 # simplex 600 -579 602 2 19 2.126400e-06 4.240400e-04 # simplex 601 -602 603 2 19 2.011400e-06 3.797800e-04 # simplex 602 -603 604 2 19 1.898200e-06 3.379700e-04 # simplex 603 -604 605 2 19 1.784300e-06 2.985900e-04 # simplex 604 -605 606 2 19 1.648800e-06 2.616500e-04 # simplex 605 -254 607 2 20 9.616000e-06 6.649400e-03 # simplex 606 -607 608 2 20 6.984500e-06 3.527100e-03 # simplex 607 -608 609 2 20 3.507200e-06 1.394900e-03 # simplex 608 -609 610 2 20 2.240800e-06 5.321900e-04 # simplex 609 -610 611 2 20 2.245000e-06 5.345400e-04 # simplex 610 -611 612 2 20 2.518600e-06 5.369000e-04 # simplex 611 -612 613 2 20 2.544000e-06 6.105700e-04 # simplex 612 -613 614 2 20 2.585800e-06 6.317300e-04 # simplex 613 -614 615 2 20 2.632900e-06 6.532600e-04 # simplex 614 -615 616 2 20 2.823200e-06 6.751400e-04 # simplex 615 -616 617 2 20 2.819900e-06 7.028400e-04 # simplex 616 -617 618 2 20 2.771000e-06 6.780200e-04 # simplex 617 -618 619 2 20 2.719300e-06 6.536400e-04 # simplex 618 -619 620 2 20 3.087000e-06 6.297100e-04 # simplex 619 -620 621 2 20 3.061600e-06 7.011600e-04 # simplex 620 -621 622 2 20 3.078900e-06 7.082700e-04 # simplex 621 -622 623 2 20 3.094700e-06 7.154200e-04 # simplex 622 -623 624 2 20 2.884500e-06 7.226000e-04 # simplex 623 -624 625 2 20 2.860000e-06 6.753900e-04 # simplex 624 -625 626 2 20 2.792500e-06 6.444600e-04 # simplex 625 -626 627 2 20 2.727400e-06 6.142600e-04 # simplex 626 -627 628 2 20 2.354000e-06 5.847800e-04 # simplex 627 -628 629 2 20 2.252800e-06 4.671900e-04 # simplex 628 -629 630 2 20 2.108200e-06 4.085600e-04 # simplex 629 -630 631 2 20 1.960500e-06 3.538500e-04 # simplex 630 -631 632 2 20 1.848300e-06 3.030700e-04 # simplex 631 -632 633 2 20 1.757000e-06 2.867100e-04 # simplex 632 -633 634 2 20 1.725000e-06 2.764100e-04 # simplex 633 -634 635 2 20 1.693200e-06 2.663000e-04 # simplex 634 -635 636 2 20 1.661100e-06 2.563800e-04 # simplex 635 -250 637 2 21 7.573300e-06 5.172300e-03 # simplex 636 -637 638 2 21 6.235100e-06 3.510700e-03 # simplex 637 -638 639 2 21 4.898500e-06 2.171000e-03 # simplex 638 -639 640 2 21 4.238600e-06 1.153300e-03 # simplex 639 -640 641 2 21 3.115000e-06 8.047200e-04 # simplex 640 -641 642 2 21 2.781000e-06 6.411400e-04 # simplex 641 -642 643 2 21 2.318800e-06 4.961600e-04 # simplex 642 -643 644 2 21 2.102900e-06 3.902600e-04 # simplex 643 -644 645 2 21 1.997600e-06 3.519600e-04 # simplex 644 -645 646 2 21 1.904900e-06 3.156400e-04 # simplex 645 -646 647 2 21 1.924100e-06 3.227000e-04 # simplex 646 -647 648 2 21 2.067800e-06 3.725200e-04 # simplex 647 -648 649 2 21 2.209900e-06 4.259200e-04 # simplex 648 -649 650 2 21 2.428600e-06 4.828900e-04 # simplex 649 -650 651 2 21 2.519300e-06 5.303000e-04 # simplex 650 -651 652 2 21 2.557300e-06 5.459500e-04 # simplex 651 -652 653 2 21 2.592900e-06 5.618200e-04 # simplex 652 -653 654 2 21 2.629600e-06 5.779200e-04 # simplex 653 -654 655 2 21 2.669000e-06 5.942500e-04 # simplex 654 -655 656 2 21 2.704100e-06 6.108000e-04 # simplex 655 -656 657 2 21 2.740300e-06 6.275900e-04 # simplex 656 -657 658 2 21 2.571700e-06 6.446000e-04 # simplex 657 -658 659 2 21 2.552000e-06 5.903100e-04 # simplex 658 -659 660 2 21 2.478500e-06 5.565200e-04 # simplex 659 -660 661 2 21 2.211900e-06 5.237300e-04 # simplex 660 -661 662 2 21 2.198200e-06 4.775900e-04 # simplex 661 -662 663 2 21 2.239200e-06 4.955700e-04 # simplex 662 -663 664 2 21 2.889100e-06 5.138900e-04 # simplex 663 -664 665 2 21 2.965400e-06 6.399800e-04 # simplex 664 -665 666 2 21 3.060300e-06 6.829600e-04 # simplex 665 -666 667 2 21 3.160100e-06 7.273400e-04 # simplex 666 -667 668 2 21 3.350900e-06 7.731200e-04 # simplex 667 -668 669 2 21 3.315300e-06 7.976700e-04 # simplex 668 -669 670 2 21 3.143200e-06 7.168200e-04 # simplex 669 -670 671 2 21 2.970200e-06 6.402900e-04 # simplex 670 -671 672 2 21 2.650600e-06 5.680800e-04 # simplex 671 -241 673 2 22 8.315000e-06 5.568200e-03 # simplex 672 -673 674 2 22 6.676700e-06 3.606600e-03 # simplex 673 -674 675 2 22 6.013600e-06 2.071000e-03 # simplex 674 -675 676 2 22 4.797200e-06 1.614000e-03 # simplex 675 -676 677 2 22 4.312800e-06 1.592800e-03 # simplex 676 -677 678 2 22 4.268600e-06 1.487000e-03 # simplex 677 -678 679 2 22 4.205400e-06 1.444200e-03 # simplex 678 -679 680 2 22 4.143300e-06 1.402100e-03 # simplex 679 -680 681 2 22 4.083400e-06 1.360500e-03 # simplex 680 -681 682 2 22 4.200800e-06 1.319600e-03 # simplex 681 -682 683 2 22 4.073700e-06 1.247800e-03 # simplex 682 -683 684 2 22 3.870900e-06 1.128500e-03 # simplex 683 -684 685 2 22 3.674100e-06 1.015100e-03 # simplex 684 -685 686 2 22 3.240000e-06 9.077300e-04 # simplex 685 -686 687 2 22 3.122100e-06 7.851800e-04 # simplex 686 -687 688 2 22 3.077800e-06 7.618500e-04 # simplex 687 -688 689 2 22 3.028700e-06 7.388800e-04 # simplex 688 -689 690 2 22 3.148800e-06 7.162600e-04 # simplex 689 -690 691 2 22 3.042500e-06 7.369800e-04 # simplex 690 -691 692 2 22 2.880300e-06 6.600400e-04 # simplex 691 -692 693 2 22 2.716900e-06 5.873400e-04 # simplex 692 -693 694 2 22 2.552900e-06 5.188800e-04 # simplex 693 -694 695 2 22 2.390500e-06 4.546600e-04 # simplex 694 -695 696 2 22 2.226400e-06 3.946900e-04 # simplex 695 -696 697 2 22 1.808300e-06 3.389600e-04 # simplex 696 -697 698 2 22 1.846300e-06 3.069900e-04 # simplex 697 -698 699 2 22 2.062900e-06 3.832100e-04 # simplex 698 -699 700 2 22 2.279900e-06 4.678800e-04 # simplex 699 -700 701 2 22 2.626600e-06 5.610100e-04 # simplex 700 -701 702 2 22 2.720500e-06 6.111000e-04 # simplex 701 -702 703 2 22 2.686200e-06 5.957800e-04 # simplex 702 -703 704 2 22 2.654200e-06 5.806500e-04 # simplex 703 -704 705 2 22 2.617500e-06 5.657200e-04 # simplex 704 -705 706 2 22 2.590100e-06 5.509900e-04 # simplex 705 -706 707 2 22 2.565500e-06 5.635100e-04 # simplex 706 -707 708 2 22 2.548900e-06 5.561200e-04 # simplex 707 -708 709 2 22 2.531100e-06 5.487700e-04 # simplex 708 -709 710 2 22 2.514200e-06 5.414700e-04 # simplex 709 -710 711 2 22 2.498200e-06 5.342300e-04 # simplex 710 -711 712 2 22 2.480500e-06 5.270300e-04 # simplex 711 -712 713 2 22 2.722100e-06 5.198800e-04 # simplex 712 -713 714 2 22 2.763400e-06 5.847100e-04 # simplex 713 -714 715 2 22 2.865400e-06 6.279700e-04 # simplex 714 -715 716 2 22 3.078400e-06 6.727800e-04 # simplex 715 -716 717 2 22 3.278700e-06 7.650200e-04 # simplex 716 -717 718 2 22 3.569600e-06 9.067100e-04 # simplex 717 -718 719 2 22 3.708100e-06 1.060400e-03 # simplex 718 -719 720 2 22 3.622900e-06 1.020800e-03 # simplex 719 -720 721 2 22 3.176400e-06 7.763800e-04 # simplex 720 -721 722 2 22 2.824300e-06 6.037900e-04 # simplex 721 -722 723 2 22 2.592800e-06 5.095400e-04 # simplex 722 -723 724 2 22 2.288400e-06 4.232800e-04 # simplex 723 -713 725 2 23 2.326100e-06 5.127200e-04 # simplex 724 -725 726 2 23 2.921000e-06 6.056300e-04 # simplex 725 -726 727 2 23 3.059900e-06 7.771300e-04 # simplex 726 -727 728 2 23 3.110300e-06 8.030900e-04 # simplex 727 -728 729 2 23 3.296200e-06 8.294700e-04 # simplex 728 -729 730 2 23 3.257300e-06 8.428200e-04 # simplex 729 -730 731 2 23 3.121700e-06 7.755800e-04 # simplex 730 -731 732 2 23 2.991600e-06 7.111300e-04 # simplex 731 -732 733 2 23 2.859400e-06 6.494700e-04 # simplex 732 -733 734 2 23 2.724000e-06 5.906100e-04 # simplex 733 -734 735 2 23 2.593700e-06 5.345500e-04 # simplex 734 -735 736 2 23 2.461400e-06 4.812800e-04 # simplex 735 -736 737 2 23 2.174000e-06 4.308100e-04 # simplex 736 -737 738 2 23 2.032500e-06 3.482200e-04 # simplex 737 -738 739 2 23 1.872600e-06 2.955900e-04 # simplex 738 -739 740 2 23 1.693600e-06 2.472700e-04 # simplex 739 -706 741 2 24 2.406100e-06 5.526700e-04 # simplex 740 -741 742 2 24 2.612300e-06 6.525100e-04 # simplex 741 -742 743 2 24 2.823000e-06 7.606400e-04 # simplex 742 -743 744 2 24 3.028900e-06 8.770600e-04 # simplex 743 -744 745 2 24 3.919600e-06 1.001800e-03 # simplex 744 -745 746 2 24 3.963400e-06 1.257300e-03 # simplex 745 -746 747 2 24 3.810200e-06 1.161500e-03 # simplex 746 -747 748 2 24 3.656600e-06 1.069500e-03 # simplex 747 -748 749 2 24 3.459500e-06 9.812600e-04 # simplex 748 -749 750 2 24 3.487700e-06 9.880900e-04 # simplex 749 -750 751 2 24 3.699500e-06 1.109900e-03 # simplex 750 -751 752 2 24 3.907900e-06 1.238900e-03 # simplex 751 -752 753 2 24 4.112300e-06 1.374900e-03 # simplex 752 -753 754 2 24 3.613100e-06 1.518000e-03 # simplex 753 -754 755 2 24 3.693900e-06 1.323800e-03 # simplex 754 -755 756 2 24 3.694800e-06 1.323800e-03 # simplex 755 -756 757 2 24 3.693900e-06 1.323800e-03 # simplex 756 -757 758 2 24 3.694800e-06 1.323800e-03 # simplex 757 -758 759 2 24 4.093400e-06 1.323800e-03 # simplex 758 -759 760 2 24 4.091700e-06 1.402200e-03 # simplex 759 -760 761 2 24 4.093300e-06 1.402200e-03 # simplex 760 -761 762 2 24 4.350800e-06 1.402200e-03 # simplex 761 -762 763 2 24 4.248500e-06 1.371700e-03 # simplex 762 -763 764 2 24 4.028800e-06 1.235000e-03 # simplex 763 -764 765 2 24 3.811800e-06 1.105600e-03 # simplex 764 -765 766 2 24 3.310300e-06 9.833000e-04 # simplex 765 -690 767 2 25 2.926900e-06 6.570700e-04 # simplex 766 -767 768 2 25 2.893900e-06 6.423700e-04 # simplex 767 -768 769 2 25 2.781600e-06 6.278300e-04 # simplex 768 -769 770 2 25 2.734000e-06 6.524500e-04 # simplex 769 -770 771 2 25 2.671700e-06 6.228600e-04 # simplex 770 -771 772 2 25 2.608100e-06 5.939600e-04 # simplex 771 -772 773 2 25 2.546100e-06 5.657500e-04 # simplex 772 -773 774 2 25 2.483400e-06 5.382200e-04 # simplex 773 -774 775 2 25 2.420500e-06 5.113800e-04 # simplex 774 -775 776 2 25 2.358000e-06 4.852200e-04 # simplex 775 -776 777 2 25 2.563800e-06 4.597500e-04 # simplex 776 -777 778 2 25 2.511700e-06 4.830000e-04 # simplex 777 -778 779 2 25 2.477800e-06 4.700700e-04 # simplex 778 -779 780 2 25 2.443900e-06 4.573200e-04 # simplex 779 -780 781 2 25 2.252700e-06 4.447400e-04 # simplex 780 -781 782 2 25 2.342200e-06 4.582500e-04 # simplex 781 -782 783 2 25 2.549700e-06 5.428700e-04 # simplex 782 -783 784 2 25 2.756600e-06 6.346600e-04 # simplex 783 -784 785 2 25 2.963100e-06 7.336200e-04 # simplex 784 -785 786 2 25 3.352700e-06 8.397500e-04 # simplex 785 -786 787 2 25 3.428100e-06 9.297200e-04 # simplex 786 -787 788 2 25 3.363700e-06 8.951900e-04 # simplex 787 -788 789 2 25 3.081600e-06 8.613200e-04 # simplex 788 -789 790 2 25 3.048700e-06 7.700400e-04 # simplex 789 -790 791 2 25 3.036400e-06 7.644300e-04 # simplex 790 -791 792 2 25 3.023600e-06 7.588300e-04 # simplex 791 -792 793 2 25 3.014100e-06 7.532600e-04 # simplex 792 -793 794 2 25 3.078000e-06 7.477100e-04 # simplex 793 -794 795 2 25 3.020800e-06 7.407100e-04 # simplex 794 -795 796 2 25 2.827300e-06 6.907200e-04 # simplex 795 -796 797 2 25 2.788700e-06 6.315500e-04 # simplex 796 -797 798 2 25 2.812700e-06 6.424400e-04 # simplex 797 -798 799 2 25 2.837400e-06 6.534300e-04 # simplex 798 -799 800 2 25 2.502900e-06 6.645100e-04 # simplex 799 -800 801 2 25 2.513800e-06 6.010500e-04 # simplex 800 -801 802 2 25 2.519000e-06 6.034700e-04 # simplex 801 -802 803 2 25 2.526000e-06 6.059000e-04 # simplex 802 -803 804 2 25 2.693400e-06 6.083300e-04 # simplex 803 -804 805 2 25 2.694900e-06 6.488300e-04 # simplex 804 -805 806 2 25 2.687200e-06 6.460000e-04 # simplex 805 -806 807 2 25 2.503100e-06 6.431800e-04 # simplex 806 -807 808 2 25 2.549600e-06 6.330500e-04 # simplex 807 -808 809 2 25 2.651000e-06 6.845000e-04 # simplex 808 -809 810 2 25 2.755300e-06 7.379700e-04 # simplex 809 -810 811 2 25 3.584700e-06 7.934400e-04 # simplex 810 -811 812 2 25 3.630000e-06 9.672100e-04 # simplex 811 -812 813 2 25 3.594000e-06 9.489100e-04 # simplex 812 -813 814 2 25 3.561100e-06 9.308000e-04 # simplex 813 -814 815 2 25 3.526700e-06 9.128500e-04 # simplex 814 -815 816 2 25 3.492200e-06 8.950800e-04 # simplex 815 -816 817 2 25 3.460600e-06 8.774900e-04 # simplex 816 -817 818 2 25 3.423200e-06 8.600700e-04 # simplex 817 -818 819 2 25 3.388700e-06 8.428200e-04 # simplex 818 -819 820 2 25 3.354100e-06 8.257500e-04 # simplex 819 -820 821 2 25 3.031500e-06 8.088500e-04 # simplex 820 -821 822 2 25 3.051800e-06 7.389700e-04 # simplex 821 -822 823 2 25 3.133600e-06 7.773600e-04 # simplex 822 -823 824 2 25 3.212000e-06 8.167300e-04 # simplex 823 -824 825 2 25 3.401800e-06 8.570600e-04 # simplex 824 -825 826 2 25 3.365800e-06 8.483700e-04 # simplex 825 -826 827 2 25 3.199100e-06 7.681900e-04 # simplex 826 -827 828 2 25 3.039700e-06 6.919900e-04 # simplex 827 -828 829 2 25 2.873400e-06 6.197700e-04 # simplex 828 -829 830 2 25 2.621200e-06 5.515300e-04 # simplex 829 -830 831 2 25 2.535600e-06 4.993000e-04 # simplex 830 -831 832 2 25 2.524300e-06 4.948600e-04 # simplex 831 -832 833 2 25 2.510100e-06 4.904300e-04 # simplex 832 -833 834 2 25 2.501700e-06 4.860200e-04 # simplex 833 -834 835 2 25 2.251900e-06 4.816300e-04 # simplex 834 -241 836 2 26 7.856600e-06 5.436100e-03 # simplex 835 -836 837 2 26 6.733400e-06 3.991200e-03 # simplex 836 -837 838 2 26 5.603300e-06 2.769500e-03 # simplex 837 -838 839 2 26 2.864600e-06 1.771000e-03 # simplex 838 -839 840 2 26 2.433300e-06 8.725200e-04 # simplex 839 -840 841 2 26 2.531400e-06 8.725200e-04 # simplex 840 -841 842 2 26 2.474000e-06 8.642900e-04 # simplex 841 -842 843 2 26 4.173700e-06 7.882900e-04 # simplex 842 -843 844 2 26 3.680100e-06 1.061600e-03 # simplex 843 -844 845 2 26 2.505400e-06 6.296800e-04 # simplex 844 -845 846 2 26 1.976400e-06 3.559300e-04 # simplex 845 -846 847 2 26 1.722000e-06 2.656400e-04 # simplex 846 -847 848 2 26 1.886300e-06 3.129600e-04 # simplex 847 -848 849 2 26 2.279200e-06 5.350700e-04 # simplex 848 -849 850 2 26 2.389600e-06 5.447000e-04 # simplex 849 -850 851 2 26 2.090100e-06 4.174500e-04 # simplex 850 -851 852 2 26 1.775700e-06 3.071300e-04 # simplex 851 -852 853 2 26 1.644600e-06 2.654000e-04 # simplex 852 -853 854 2 26 1.685900e-06 2.788500e-04 # simplex 853 -854 855 2 26 1.727000e-06 2.926200e-04 # simplex 854 -855 856 2 26 1.632500e-06 3.067300e-04 # simplex 855 -856 857 2 26 1.746600e-06 3.096300e-04 # simplex 856 -857 858 2 26 1.937400e-06 3.800100e-04 # simplex 857 -858 859 2 26 2.827400e-06 4.576100e-04 # simplex 858 -859 860 2 26 2.970400e-06 7.085600e-04 # simplex 859 -860 861 2 26 3.010400e-06 7.294000e-04 # simplex 860 -861 862 2 26 2.564100e-06 7.505400e-04 # simplex 861 -862 863 2 26 2.543100e-06 6.189200e-04 # simplex 862 -863 864 2 26 2.467100e-06 5.820100e-04 # simplex 863 -864 865 2 26 2.603100e-06 5.462300e-04 # simplex 864 -865 866 2 26 2.721500e-06 6.330200e-04 # simplex 865 -866 867 2 26 3.030000e-06 7.850200e-04 # simplex 866 -867 868 2 26 3.658500e-06 9.533800e-04 # simplex 867 -868 869 2 26 3.931200e-06 1.125200e-03 # simplex 868 -869 870 2 26 3.873200e-06 1.251900e-03 # simplex 869 -870 871 2 26 3.693600e-06 1.145300e-03 # simplex 870 -871 872 2 26 3.099200e-06 8.069800e-04 # simplex 871 -872 873 2 26 2.149800e-06 5.278800e-04 # simplex 872 -873 874 2 26 1.823000e-06 3.321000e-04 # simplex 873 -874 875 2 26 1.695700e-06 2.879700e-04 # simplex 874 -875 876 2 26 1.373200e-06 2.469900e-04 # simplex 875 -876 877 2 26 1.469800e-06 2.430900e-04 # simplex 876 -877 878 2 26 1.980100e-06 3.469900e-04 # simplex 877 -878 879 2 26 2.075900e-06 4.284600e-04 # simplex 878 -879 880 2 26 2.034400e-06 3.819000e-04 # simplex 879 -880 881 2 26 2.025200e-06 3.945700e-04 # simplex 880 -881 882 2 26 2.119600e-06 4.335600e-04 # simplex 881 -882 883 2 26 2.181700e-06 4.743900e-04 # simplex 882 -859 884 2 27 2.262600e-06 5.176700e-04 # simplex 883 -884 885 2 27 2.216100e-06 4.963000e-04 # simplex 884 -885 886 2 27 2.834800e-06 4.753900e-04 # simplex 885 -886 887 2 27 2.833000e-06 6.201500e-04 # simplex 886 -887 888 2 27 2.897900e-06 6.484300e-04 # simplex 887 -888 889 2 27 2.962600e-06 6.773400e-04 # simplex 888 -889 890 2 27 3.025700e-06 7.068800e-04 # simplex 889 -890 891 2 27 3.076600e-06 7.370500e-04 # simplex 890 -891 892 2 27 3.198700e-06 7.947600e-04 # simplex 891 -892 893 2 27 3.370500e-06 8.836500e-04 # simplex 892 -893 894 2 27 2.830800e-06 9.772500e-04 # simplex 893 -894 895 2 27 2.869600e-06 7.896400e-04 # simplex 894 -895 896 2 27 2.809700e-06 7.570700e-04 # simplex 895 -896 897 2 27 3.364400e-06 7.251800e-04 # simplex 896 -897 898 2 27 3.298500e-06 8.082200e-04 # simplex 897 -898 899 2 27 3.227400e-06 7.754400e-04 # simplex 898 -899 900 2 27 2.905300e-06 7.433400e-04 # simplex 899 -900 901 2 27 2.885300e-06 7.170000e-04 # simplex 900 -901 902 2 27 2.912900e-06 7.299400e-04 # simplex 901 -902 903 2 27 2.939200e-06 7.429900e-04 # simplex 902 -903 904 2 27 2.646100e-06 7.561600e-04 # simplex 903 -904 905 2 27 2.681300e-06 7.071800e-04 # simplex 904 -905 906 2 27 2.723500e-06 7.307300e-04 # simplex 905 -906 907 2 27 2.768600e-06 7.546600e-04 # simplex 906 -907 908 2 27 2.926800e-06 7.789900e-04 # simplex 907 -908 909 2 27 2.999100e-06 8.507200e-04 # simplex 908 -909 910 2 27 3.413300e-06 9.082900e-04 # simplex 909 -910 911 2 27 3.546200e-06 1.074800e-03 # simplex 910 -911 912 2 27 3.329500e-06 1.170100e-03 # simplex 911 -912 913 2 27 3.433200e-06 1.093100e-03 # simplex 912 -913 914 2 27 3.501300e-06 1.138800e-03 # simplex 913 -914 915 2 27 3.664000e-06 1.185500e-03 # simplex 914 -915 916 2 27 3.591600e-06 1.204800e-03 # simplex 915 -916 917 2 27 3.366100e-06 1.058000e-03 # simplex 916 -917 918 2 27 3.138300e-06 9.207800e-04 # simplex 917 -918 919 2 27 2.912700e-06 7.930700e-04 # simplex 918 -919 920 2 27 2.668900e-06 6.749000e-04 # simplex 919 -920 921 2 27 2.535700e-06 6.064800e-04 # simplex 920 -921 922 2 27 2.501300e-06 5.907800e-04 # simplex 921 -922 923 2 27 2.470800e-06 5.752900e-04 # simplex 922 -923 924 2 27 2.527000e-06 5.600100e-04 # simplex 923 -924 925 2 27 2.588500e-06 5.533800e-04 # simplex 924 -925 926 2 27 2.733100e-06 6.184300e-04 # simplex 925 -926 927 2 27 2.880700e-06 6.871000e-04 # simplex 926 -927 928 2 27 3.502400e-06 7.593900e-04 # simplex 927 -928 929 2 27 3.589500e-06 9.800400e-04 # simplex 928 -929 930 2 27 3.596400e-06 9.837600e-04 # simplex 929 -930 931 2 27 2.994300e-06 9.875000e-04 # simplex 930 -931 932 2 27 2.971700e-06 8.282100e-04 # simplex 931 -932 933 2 27 2.922100e-06 8.010800e-04 # simplex 932 -933 934 2 27 2.874600e-06 7.744100e-04 # simplex 933 -934 935 2 27 3.156200e-06 7.481800e-04 # simplex 934 -935 936 2 27 3.041700e-06 7.845100e-04 # simplex 935 -936 937 2 27 2.862300e-06 6.949700e-04 # simplex 936 -937 938 2 27 2.684100e-06 6.108700e-04 # simplex 937 -938 939 2 27 2.504500e-06 5.321800e-04 # simplex 938 -939 940 2 27 2.327500e-06 4.589300e-04 # simplex 939 -940 941 2 27 2.135600e-06 3.910900e-04 # simplex 940 -241 942 2 28 8.602900e-06 5.357900e-03 # simplex 941 -942 943 2 28 6.857900e-06 3.415100e-03 # simplex 942 -943 944 2 28 5.115100e-06 1.909800e-03 # simplex 943 -944 945 2 28 3.032100e-06 8.420300e-04 # simplex 944 -945 946 2 28 2.161400e-06 4.175900e-04 # simplex 945 -946 947 2 28 2.205200e-06 4.354800e-04 # simplex 946 -947 948 2 28 2.470800e-06 4.537500e-04 # simplex 947 -948 949 2 28 2.433000e-06 4.905500e-04 # simplex 948 -949 950 2 28 2.306200e-06 4.407700e-04 # simplex 949 -950 951 2 28 1.816000e-06 3.936600e-04 # simplex 950 -951 952 2 28 1.722600e-06 2.871700e-04 # simplex 951 -952 953 2 28 1.638100e-06 2.596800e-04 # simplex 952 -953 954 2 28 1.434100e-06 2.335600e-04 # simplex 953 -234 955 2 29 1.076000e-05 9.302700e-03 # simplex 954 -955 956 2 29 9.313800e-06 6.961800e-03 # simplex 955 -956 957 2 29 7.852800e-06 4.960200e-03 # simplex 956 -957 958 2 29 6.398200e-06 3.297900e-03 # simplex 957 -958 959 2 29 4.899300e-06 1.974900e-03 # simplex 958 -959 960 2 29 4.020600e-06 1.383800e-03 # simplex 959 -960 961 2 29 4.020500e-06 1.383800e-03 # simplex 960 -961 962 2 29 4.017200e-06 1.383800e-03 # simplex 961 -962 963 2 29 4.433500e-06 1.383800e-03 # simplex 962 -963 964 2 29 4.435900e-06 1.569600e-03 # simplex 963 -964 965 2 29 4.432300e-06 1.569600e-03 # simplex 964 -965 966 2 29 4.437700e-06 1.569600e-03 # simplex 965 -966 967 2 29 4.434000e-06 1.569600e-03 # simplex 966 -967 968 2 29 4.433900e-06 1.569600e-03 # simplex 967 -968 969 2 29 4.343300e-06 1.569600e-03 # simplex 968 -969 970 2 29 4.344100e-06 1.511800e-03 # simplex 969 -970 971 2 29 4.333400e-06 1.507200e-03 # simplex 970 -971 972 2 29 4.333800e-06 1.502600e-03 # simplex 971 -972 973 2 29 4.323900e-06 1.498000e-03 # simplex 972 -973 974 2 29 4.314100e-06 1.493400e-03 # simplex 973 -974 975 2 29 4.310700e-06 1.488900e-03 # simplex 974 -975 976 2 29 4.239800e-06 1.484300e-03 # simplex 975 -976 977 2 29 4.236500e-06 1.502100e-03 # simplex 976 -977 978 2 29 4.245000e-06 1.506100e-03 # simplex 977 -978 979 2 29 4.247900e-06 1.510100e-03 # simplex 978 -979 980 2 29 4.256900e-06 1.514200e-03 # simplex 979 -980 981 2 29 4.262100e-06 1.518200e-03 # simplex 980 -981 982 2 29 4.264900e-06 1.522300e-03 # simplex 981 -982 983 2 29 4.273500e-06 1.526300e-03 # simplex 982 -983 984 2 29 3.881200e-06 1.530400e-03 # simplex 983 -984 985 2 29 3.811100e-06 1.282100e-03 # simplex 984 -985 986 2 29 3.653800e-06 1.179700e-03 # simplex 985 -986 987 2 29 3.498200e-06 1.081600e-03 # simplex 986 -987 988 2 29 3.533500e-06 9.877900e-04 # simplex 987 -988 989 2 29 3.530000e-06 1.085700e-03 # simplex 988 -989 990 2 29 3.697100e-06 1.188900e-03 # simplex 989 -990 991 2 29 3.857800e-06 1.296700e-03 # simplex 990 -991 992 2 29 4.305600e-06 1.409200e-03 # simplex 991 -992 993 2 29 4.237500e-06 1.373200e-03 # simplex 992 -993 994 2 29 3.904700e-06 1.167300e-03 # simplex 993 -994 995 2 29 2.549100e-06 9.781000e-04 # simplex 994 -995 996 2 29 2.355300e-06 6.249500e-04 # simplex 995 -996 997 2 29 2.214600e-06 5.523000e-04 # simplex 996 -997 998 2 29 2.598000e-06 4.841300e-04 # simplex 997 -998 999 2 29 2.488600e-06 5.684600e-04 # simplex 998 -999 1000 2 29 2.496700e-06 5.519000e-04 # simplex 999 -1000 1001 2 29 2.566100e-06 5.815200e-04 # simplex 1000 -1001 1002 2 29 2.119800e-06 6.647600e-04 # simplex 1001 -1002 1003 2 29 2.152800e-06 5.383400e-04 # simplex 1002 -1003 1004 2 29 2.081500e-06 5.033900e-04 # simplex 1003 -1004 1005 2 29 2.130700e-06 4.696300e-04 # simplex 1004 -1005 1006 2 29 2.100000e-06 4.636500e-04 # simplex 1005 -1006 1007 2 29 2.117400e-06 4.698000e-04 # simplex 1006 -1007 1008 2 29 2.746700e-06 4.759900e-04 # simplex 1007 -1008 1009 2 29 2.645700e-06 5.835900e-04 # simplex 1008 -1009 1010 2 29 2.356000e-06 4.922400e-04 # simplex 1009 -1010 1011 2 29 2.265200e-06 4.243400e-04 # simplex 1010 -1011 1012 2 29 2.301800e-06 4.376900e-04 # simplex 1011 -1012 1013 2 29 2.182000e-06 4.512400e-04 # simplex 1012 -1013 1014 2 29 2.124800e-06 4.217700e-04 # simplex 1013 -1014 1015 2 29 1.964700e-06 3.615200e-04 # simplex 1014 -1015 1016 2 29 1.808800e-06 3.059100e-04 # simplex 1015 -1016 1017 2 29 1.637600e-06 2.549400e-04 # simplex 1016 -976 1018 2 30 3.922800e-06 1.270800e-03 # simplex 1017 -1018 1019 2 30 3.561900e-06 1.048500e-03 # simplex 1018 -1019 1020 2 30 3.200500e-06 8.475700e-04 # simplex 1019 -1020 1021 2 30 2.858200e-06 6.680100e-04 # simplex 1020 -1021 1022 2 30 2.629300e-06 5.937800e-04 # simplex 1021 -1022 1023 2 30 2.546300e-06 5.568900e-04 # simplex 1022 -1023 1024 2 30 2.274000e-06 5.211800e-04 # simplex 1023 -1024 1025 2 30 2.210300e-06 4.561200e-04 # simplex 1024 -1025 1026 2 30 2.159200e-06 4.350700e-04 # simplex 1025 -1026 1027 2 30 2.107100e-06 4.145300e-04 # simplex 1026 -1027 1028 2 30 2.250000e-06 3.944800e-04 # simplex 1027 -1028 1029 2 30 2.176000e-06 4.033200e-04 # simplex 1028 -1029 1030 2 30 2.084400e-06 3.700900e-04 # simplex 1029 -1030 1031 2 30 2.017600e-06 3.382800e-04 # simplex 1030 -1031 1032 2 30 1.900500e-06 2.869200e-04 # simplex 1031 -1032 1033 2 30 1.765900e-06 2.472700e-04 # simplex 1032 -1033 1034 2 30 1.629600e-06 2.105700e-04 # simplex 1033 -1034 1035 2 30 1.418400e-06 1.768200e-04 # simplex 1034 -1035 1036 2 30 1.416000e-06 1.802500e-04 # simplex 1035 -959 1037 2 31 4.189800e-06 1.372200e-03 # simplex 1036 -1037 1038 2 31 4.193400e-06 1.372200e-03 # simplex 1037 -1038 1039 2 31 4.476400e-06 1.372200e-03 # simplex 1038 -1039 1040 2 31 4.475700e-06 1.552700e-03 # simplex 1039 -1040 1041 2 31 4.476400e-06 1.552700e-03 # simplex 1040 -1041 1042 2 31 4.479000e-06 1.552700e-03 # simplex 1041 -1042 1043 2 31 4.168500e-06 1.552700e-03 # simplex 1042 -1043 1044 2 31 4.170900e-06 1.457500e-03 # simplex 1043 -1044 1045 2 31 4.168200e-06 1.457500e-03 # simplex 1044 -1045 1046 2 31 4.874900e-06 1.457500e-03 # simplex 1045 -1046 1047 2 31 4.881100e-06 1.628700e-03 # simplex 1046 -1047 1048 2 31 4.879700e-06 1.628700e-03 # simplex 1047 -1048 1049 2 31 4.878900e-06 1.628700e-03 # simplex 1048 -1049 1050 2 31 4.350300e-06 1.628700e-03 # simplex 1049 -1050 1051 2 31 4.350500e-06 1.530100e-03 # simplex 1050 -1051 1052 2 31 4.351500e-06 1.530100e-03 # simplex 1051 -1052 1053 2 31 4.346900e-06 1.530100e-03 # simplex 1052 -1053 1054 2 31 3.272400e-06 1.530100e-03 # simplex 1053 -1054 1055 2 31 3.269300e-06 1.169300e-03 # simplex 1054 -1055 1056 2 31 3.269400e-06 1.169300e-03 # simplex 1055 -1056 1057 2 31 4.336400e-06 1.169300e-03 # simplex 1056 -1057 1058 2 31 4.343600e-06 1.505600e-03 # simplex 1057 -1058 1059 2 31 4.342900e-06 1.505600e-03 # simplex 1058 -1059 1060 2 31 4.821300e-06 1.505600e-03 # simplex 1059 -1060 1061 2 31 4.817000e-06 1.563500e-03 # simplex 1060 -1061 1062 2 31 4.343100e-06 1.563500e-03 # simplex 1061 -228 1063 2 32 9.590500e-06 7.714100e-03 # simplex 1062 -1063 1064 2 32 8.307100e-06 5.789300e-03 # simplex 1063 -1064 1065 2 32 7.026500e-06 4.140700e-03 # simplex 1064 -1065 1066 2 32 5.738200e-06 2.768400e-03 # simplex 1065 -1066 1067 2 32 4.456100e-06 1.672300e-03 # simplex 1066 -1067 1068 2 32 2.945400e-06 8.525300e-04 # simplex 1067 -1068 1069 2 32 2.243100e-06 4.929900e-04 # simplex 1068 -1069 1070 2 32 2.186900e-06 4.685400e-04 # simplex 1069 -1070 1071 2 32 1.929700e-06 4.447200e-04 # simplex 1070 -1071 1072 2 32 1.895200e-06 3.882800e-04 # simplex 1071 -1072 1073 2 32 1.877500e-06 3.810400e-04 # simplex 1072 -1073 1074 2 32 1.937400e-06 3.738800e-04 # simplex 1073 -1074 1075 2 32 1.986100e-06 4.063600e-04 # simplex 1074 -1075 1076 2 32 2.107900e-06 4.565100e-04 # simplex 1075 -1076 1077 2 32 2.224200e-06 5.095800e-04 # simplex 1076 -1077 1078 2 32 2.122100e-06 5.655700e-04 # simplex 1077 -1078 1079 2 32 2.100400e-06 5.041500e-04 # simplex 1078 -1079 1080 2 32 1.948100e-06 4.336100e-04 # simplex 1079 -1080 1081 2 32 2.050900e-06 3.683900e-04 # simplex 1080 -1081 1082 2 32 2.028700e-06 4.061700e-04 # simplex 1081 -1082 1083 2 32 2.152000e-06 4.586000e-04 # simplex 1082 -1083 1084 2 32 2.629400e-06 5.142100e-04 # simplex 1083 -1084 1085 2 32 2.587500e-06 5.270000e-04 # simplex 1084 -1085 1086 2 32 1.678500e-06 4.363200e-04 # simplex 1085 -1086 1087 2 32 1.646000e-06 3.206800e-04 # simplex 1086 -1087 1088 2 32 2.125000e-06 3.621600e-04 # simplex 1087 -1088 1089 2 32 2.218700e-06 4.737200e-04 # simplex 1088 -1089 1090 2 32 2.279200e-06 4.999900e-04 # simplex 1089 -1090 1091 2 32 2.791800e-06 5.269700e-04 # simplex 1090 -1091 1092 2 32 2.718400e-06 5.835200e-04 # simplex 1091 -1092 1093 2 32 2.493400e-06 4.905800e-04 # simplex 1092 -1093 1094 2 32 2.369900e-06 4.056900e-04 # simplex 1093 -1094 1095 2 32 2.180500e-06 3.649800e-04 # simplex 1094 -1095 1096 2 32 2.048600e-06 3.216800e-04 # simplex 1095 -1096 1097 2 32 1.530200e-06 2.811200e-04 # simplex 1096 -1097 1098 2 32 1.444400e-06 2.102500e-04 # simplex 1097 -1098 1099 2 32 1.381400e-06 1.923100e-04 # simplex 1098 -1099 1100 2 32 1.156100e-06 1.751800e-04 # simplex 1099 -1100 1101 2 32 1.149900e-06 1.468800e-04 # simplex 1100 -1101 1102 2 32 1.423600e-06 1.578600e-04 # simplex 1101 -1102 1103 2 32 1.587900e-06 2.201200e-04 # simplex 1102 -1103 1104 2 32 1.857600e-06 3.012600e-04 # simplex 1103 -1104 1105 2 32 2.073700e-06 3.951300e-04 # simplex 1104 -1105 1106 2 32 2.147000e-06 4.495600e-04 # simplex 1105 -1106 1107 2 32 2.029600e-06 4.026400e-04 # simplex 1106 -1107 1108 2 32 1.826700e-06 3.583100e-04 # simplex 1107 -1108 1109 2 32 1.798900e-06 3.326200e-04 # simplex 1108 -1109 1110 2 32 1.850300e-06 3.519100e-04 # simplex 1109 -1110 1111 2 32 1.938600e-06 3.717500e-04 # simplex 1110 -1111 1112 2 32 1.967700e-06 3.915300e-04 # simplex 1111 -1112 1113 2 32 1.979300e-06 3.954500e-04 # simplex 1112 -1113 1114 2 32 2.436200e-06 3.993800e-04 # simplex 1113 -1114 1115 2 32 2.473900e-06 5.059800e-04 # simplex 1114 -1115 1116 2 32 2.537700e-06 5.321400e-04 # simplex 1115 -1116 1117 2 32 2.600000e-06 5.589600e-04 # simplex 1116 -1117 1118 2 32 2.750200e-06 5.864400e-04 # simplex 1117 -1118 1119 2 32 2.595000e-06 5.326000e-04 # simplex 1118 -1119 1120 2 32 2.205700e-06 3.853400e-04 # simplex 1119 -1120 1121 2 32 1.865200e-06 2.619200e-04 # simplex 1120 -1121 1122 2 32 1.329300e-06 1.493900e-04 # simplex 1121 -228 1123 2 33 1.077300e-05 8.565400e-03 # simplex 1122 -1123 1124 2 33 9.394100e-06 6.518600e-03 # simplex 1123 -1124 1125 2 33 8.017100e-06 4.751300e-03 # simplex 1124 -1125 1126 2 33 6.644800e-06 3.263500e-03 # simplex 1125 -1126 1127 2 33 4.613200e-06 2.055100e-03 # simplex 1126 -1127 1128 2 33 3.909400e-06 1.402100e-03 # simplex 1127 -1128 1129 2 33 3.905300e-06 1.402100e-03 # simplex 1128 -1129 1130 2 33 3.391700e-06 1.402100e-03 # simplex 1129 -1130 1131 2 33 3.391800e-06 1.218100e-03 # simplex 1130 -1131 1132 2 33 3.390900e-06 1.218100e-03 # simplex 1131 -1132 1133 2 33 3.659700e-06 1.218100e-03 # simplex 1132 -1133 1134 2 33 3.637100e-06 1.295300e-03 # simplex 1133 -1134 1135 2 33 3.590000e-06 1.262700e-03 # simplex 1134 -1135 1136 2 33 4.416100e-06 1.230500e-03 # simplex 1135 -1136 1137 2 33 4.054400e-06 1.274600e-03 # simplex 1136 -1137 1138 2 33 2.888300e-06 8.622700e-04 # simplex 1137 -1138 1139 2 33 2.593800e-06 6.125900e-04 # simplex 1138 -1139 1140 2 33 2.661200e-06 6.446600e-04 # simplex 1139 -1140 1141 2 33 2.411300e-06 6.775500e-04 # simplex 1140 -1141 1142 2 33 2.514300e-06 6.346600e-04 # simplex 1141 -1142 1143 2 33 2.663400e-06 7.110400e-04 # simplex 1142 -1143 1144 2 33 2.675700e-06 7.917700e-04 # simplex 1143 -1144 1145 2 33 2.711400e-06 7.893700e-04 # simplex 1144 -1145 1146 2 33 2.840200e-06 7.534900e-04 # simplex 1145 -1146 1147 2 33 2.692700e-06 7.032700e-04 # simplex 1146 -1147 1148 2 33 2.187900e-06 5.825500e-04 # simplex 1147 -1148 1149 2 33 2.179900e-06 5.180300e-04 # simplex 1148 -1149 1150 2 33 2.382400e-06 6.172300e-04 # simplex 1149 -1150 1151 2 33 2.737500e-06 7.251300e-04 # simplex 1150 -1151 1152 2 33 2.800300e-06 8.077500e-04 # simplex 1151 -1152 1153 2 33 2.726800e-06 7.655800e-04 # simplex 1152 -1153 1154 2 33 2.723900e-06 7.245500e-04 # simplex 1153 -1154 1155 2 33 2.606900e-06 6.941200e-04 # simplex 1154 -1155 1156 2 33 2.443400e-06 6.110800e-04 # simplex 1155 -1156 1157 2 33 2.285400e-06 5.333300e-04 # simplex 1156 -1157 1158 2 33 1.968800e-06 4.608600e-04 # simplex 1157 -1158 1159 2 33 1.840000e-06 3.654000e-04 # simplex 1158 -1159 1160 2 33 1.729500e-06 3.234800e-04 # simplex 1159 -1160 1161 2 33 1.848000e-06 2.841100e-04 # simplex 1160 -1161 1162 2 33 1.860300e-06 3.056600e-04 # simplex 1161 -1162 1163 2 33 1.982600e-06 3.561500e-04 # simplex 1162 -1163 1164 2 33 2.061600e-06 4.132400e-04 # simplex 1163 -1164 1165 2 33 2.077100e-06 4.194300e-04 # simplex 1164 -1165 1166 2 33 2.081000e-06 4.256600e-04 # simplex 1165 -1166 1167 2 33 2.096900e-06 4.217200e-04 # simplex 1166 -1167 1168 2 33 2.107700e-06 4.268700e-04 # simplex 1167 -1168 1169 2 33 2.512100e-06 4.320400e-04 # simplex 1168 -1169 1170 2 33 2.487800e-06 5.082700e-04 # simplex 1169 -1170 1171 2 33 2.425600e-06 4.829800e-04 # simplex 1170 -1171 1172 2 33 2.480300e-06 4.583300e-04 # simplex 1171 -1172 1173 2 33 2.415900e-06 4.692800e-04 # simplex 1172 -1173 1174 2 33 2.353300e-06 4.452600e-04 # simplex 1173 -1174 1175 2 33 2.289100e-06 4.218700e-04 # simplex 1174 -1175 1176 2 33 2.229500e-06 3.991100e-04 # simplex 1175 -1176 1177 2 33 2.165400e-06 3.769800e-04 # simplex 1176 -1177 1178 2 33 2.102900e-06 3.554800e-04 # simplex 1177 -1178 1179 2 33 1.905300e-06 3.346200e-04 # simplex 1178 -1179 1180 2 33 1.788100e-06 2.645800e-04 # simplex 1179 -1180 1181 2 33 1.239900e-06 2.138400e-04 # simplex 1180 -1181 1182 2 33 1.178400e-06 1.546400e-04 # simplex 1181 -1182 1183 2 33 1.191400e-06 1.585100e-04 # simplex 1182 -1183 1184 2 33 1.476000e-06 1.624300e-04 # simplex 1183 -1184 1185 2 33 1.532300e-06 2.063900e-04 # simplex 1184 -1185 1186 2 33 1.888700e-06 2.331700e-04 # simplex 1185 -1186 1187 2 33 1.906700e-06 2.643600e-04 # simplex 1186 -1187 1188 2 33 1.829800e-06 2.439400e-04 # simplex 1187 -1188 1189 2 33 1.756400e-06 2.243400e-04 # simplex 1188 -1189 1190 2 33 1.681300e-06 2.055500e-04 # simplex 1189 -1190 1191 2 33 1.484100e-06 1.875900e-04 # simplex 1190 -1146 1192 2 34 2.725700e-06 6.613300e-04 # simplex 1191 -1192 1193 2 34 2.414100e-06 5.175500e-04 # simplex 1192 -1193 1194 2 34 2.155100e-06 3.914000e-04 # simplex 1193 -1194 1195 2 34 2.030000e-06 3.961600e-04 # simplex 1194 -1195 1196 2 34 2.124000e-06 4.326800e-04 # simplex 1195 -1196 1197 2 34 1.562200e-06 4.708100e-04 # simplex 1196 -1197 1198 2 34 1.455200e-06 2.568400e-04 # simplex 1197 -1198 1199 2 34 1.404700e-06 1.593700e-04 # simplex 1198 -1199 1200 2 34 1.173500e-06 1.443300e-04 # simplex 1199 -1200 1201 2 34 1.123700e-06 1.323500e-04 # simplex 1200 -1201 1202 2 34 1.113600e-06 1.209000e-04 # simplex 1201 -1202 1203 2 34 1.019200e-06 1.073600e-04 # simplex 1202 -1203 1204 2 34 8.805600e-07 8.016500e-05 # simplex 1203 -1204 1205 2 34 7.142900e-07 5.694000e-05 # simplex 1204 -228 1206 2 35 1.157400e-05 8.455600e-03 # simplex 1205 -1206 1207 2 35 9.538600e-06 5.761700e-03 # simplex 1206 -1207 1208 2 35 7.522400e-06 3.584500e-03 # simplex 1207 -1208 1209 2 35 4.537200e-06 1.924000e-03 # simplex 1208 -1209 1210 2 35 3.522100e-06 1.081000e-03 # simplex 1209 -1210 1211 2 35 3.608600e-06 1.046200e-03 # simplex 1210 -1211 1212 2 35 3.517500e-06 1.062100e-03 # simplex 1211 -1212 1213 2 35 3.389100e-06 9.864000e-04 # simplex 1212 -1213 1214 2 35 3.065000e-06 9.134700e-04 # simplex 1213 -1214 1215 2 35 2.868900e-06 7.581100e-04 # simplex 1214 -1215 1216 2 35 1.882500e-06 6.168400e-04 # simplex 1215 -1216 1217 2 35 1.746800e-06 3.778300e-04 # simplex 1216 -1217 1218 2 35 1.935700e-06 3.520700e-04 # simplex 1217 -1218 1219 2 35 1.926100e-06 3.975700e-04 # simplex 1218 -1219 1220 2 35 1.977800e-06 4.188900e-04 # simplex 1219 -1220 1221 2 35 2.506100e-06 4.407600e-04 # simplex 1220 -1221 1222 2 35 2.538800e-06 5.697200e-04 # simplex 1221 -1222 1223 2 35 2.544100e-06 5.709600e-04 # simplex 1222 -1223 1224 2 35 2.544200e-06 5.722000e-04 # simplex 1223 -1224 1225 2 35 2.482600e-06 5.734400e-04 # simplex 1224 -1225 1226 2 35 2.428000e-06 5.363300e-04 # simplex 1225 -1226 1227 2 35 2.308500e-06 4.856700e-04 # simplex 1226 -1227 1228 2 35 2.191000e-06 4.375300e-04 # simplex 1227 -1228 1229 2 35 2.075100e-06 3.919000e-04 # simplex 1228 -1229 1230 2 35 1.956800e-06 3.487800e-04 # simplex 1229 -1230 1231 2 35 2.156500e-06 3.081700e-04 # simplex 1230 -1231 1232 2 35 2.301100e-06 3.817900e-04 # simplex 1231 -1232 1233 2 35 2.720600e-06 5.330700e-04 # simplex 1232 -1233 1234 2 35 3.142900e-06 7.096100e-04 # simplex 1233 -1234 1235 2 35 3.558100e-06 9.114000e-04 # simplex 1234 -1235 1236 2 35 3.977900e-06 1.138400e-03 # simplex 1235 -1236 1237 2 35 4.197600e-06 1.390700e-03 # simplex 1236 -1237 1238 2 35 4.263000e-06 1.426000e-03 # simplex 1237 -1238 1239 2 35 3.999200e-06 1.256300e-03 # simplex 1238 -1239 1240 2 35 3.740400e-06 1.097400e-03 # simplex 1239 -1240 1241 2 35 3.475900e-06 9.491800e-04 # simplex 1240 -1241 1242 2 35 3.174300e-06 8.117300e-04 # simplex 1241 -1242 1243 2 35 3.171800e-06 7.530300e-04 # simplex 1242 -1243 1244 2 35 3.424200e-06 8.776400e-04 # simplex 1243 -1244 1245 2 35 3.676900e-06 1.011800e-03 # simplex 1244 -1245 1246 2 35 3.470500e-06 1.155500e-03 # simplex 1245 -1246 1247 2 35 3.461600e-06 1.020300e-03 # simplex 1246 -1247 1248 2 35 3.232500e-06 8.874300e-04 # simplex 1247 -1248 1249 2 35 3.730600e-06 7.638600e-04 # simplex 1248 -1249 1250 2 35 3.461700e-06 8.216600e-04 # simplex 1249 -1250 1251 2 35 3.221000e-06 7.114100e-04 # simplex 1250 -1251 1252 2 35 2.704300e-06 6.091000e-04 # simplex 1251 -1237 1253 2 36 4.528800e-06 1.491300e-03 # simplex 1252 -1253 1254 2 36 4.405300e-06 1.408300e-03 # simplex 1253 -1254 1255 2 36 4.276000e-06 1.327700e-03 # simplex 1254 -1255 1256 2 36 4.149400e-06 1.249500e-03 # simplex 1255 -1256 1257 2 36 4.017600e-06 1.173600e-03 # simplex 1256 -1257 1258 2 36 3.893500e-06 1.100100e-03 # simplex 1257 -1258 1259 2 36 3.765600e-06 1.029000e-03 # simplex 1258 -1259 1260 2 36 3.633800e-06 9.603100e-04 # simplex 1259 -1260 1261 2 36 3.575800e-06 9.325300e-04 # simplex 1260 -1261 1262 2 36 3.596500e-06 9.409300e-04 # simplex 1261 -1262 1263 2 36 3.354600e-06 9.493700e-04 # simplex 1262 -228 1264 2 37 1.157300e-05 8.005500e-03 # simplex 1263 -1264 1265 2 37 8.989500e-06 4.852400e-03 # simplex 1264 -1265 1266 2 37 5.797500e-06 2.488800e-03 # simplex 1265 -1266 1267 2 37 4.114800e-06 1.325600e-03 # simplex 1266 -1267 1268 2 37 3.625900e-06 1.031200e-03 # simplex 1267 -1268 1269 2 37 2.598600e-06 7.738400e-04 # simplex 1268 -1269 1270 2 37 2.396300e-06 5.534600e-04 # simplex 1269 -1270 1271 2 37 2.412900e-06 5.613700e-04 # simplex 1270 -1271 1272 2 37 2.430100e-06 5.693200e-04 # simplex 1271 -1272 1273 2 37 2.579200e-06 5.773400e-04 # simplex 1272 -1273 1274 2 37 2.504500e-06 5.964400e-04 # simplex 1273 -1274 1275 2 37 2.333300e-06 5.176900e-04 # simplex 1274 -1275 1276 2 37 2.162100e-06 4.445200e-04 # simplex 1275 -1276 1277 2 37 2.400100e-06 3.769200e-04 # simplex 1276 -1277 1278 2 37 2.472700e-06 4.730300e-04 # simplex 1277 -1278 1279 2 37 1.905800e-06 6.154000e-04 # simplex 1278 -1279 1280 2 37 2.004700e-06 4.383700e-04 # simplex 1279 -1280 1281 2 37 1.755400e-06 4.257600e-04 # simplex 1280 -1281 1282 2 37 1.778300e-06 4.146200e-04 # simplex 1281 -1282 1283 2 37 2.574600e-06 4.481200e-04 # simplex 1282 -1283 1284 2 37 2.595200e-06 5.965900e-04 # simplex 1283 -1284 1285 2 37 2.531900e-06 5.690800e-04 # simplex 1284 -1285 1286 2 37 2.694300e-06 5.422300e-04 # simplex 1285 -1286 1287 2 37 2.416400e-06 4.653500e-04 # simplex 1286 -1287 1288 2 37 1.760700e-06 2.895700e-04 # simplex 1287 -1283 1289 2 38 2.511500e-06 5.569200e-04 # simplex 1288 -1289 1290 2 38 1.965400e-06 4.896600e-04 # simplex 1289 -1290 1291 2 38 1.874000e-06 4.023900e-04 # simplex 1290 -1291 1292 2 38 2.011300e-06 3.812900e-04 # simplex 1291 -1292 1293 2 38 1.892300e-06 3.560200e-04 # simplex 1292 -1293 1294 2 38 1.700500e-06 2.881200e-04 # simplex 1293 -1294 1295 2 38 1.741200e-06 2.274000e-04 # simplex 1294 -1295 1296 2 38 1.635200e-06 2.187900e-04 # simplex 1295 -1296 1297 2 38 1.647500e-06 2.219500e-04 # simplex 1296 -1297 1298 2 38 1.396300e-06 2.251400e-04 # simplex 1297 -1298 1299 2 38 1.370300e-06 2.000500e-04 # simplex 1298 -1299 1300 2 38 1.306000e-06 1.819900e-04 # simplex 1299 -1300 1301 2 38 1.235100e-06 1.647800e-04 # simplex 1300 -228 1302 2 39 9.097000e-06 6.901700e-03 # simplex 1301 -1302 1303 2 39 7.621100e-06 4.847100e-03 # simplex 1302 -1303 1304 2 39 6.138700e-06 3.155500e-03 # simplex 1303 -1304 1305 2 39 4.837100e-06 1.827000e-03 # simplex 1304 -1305 1306 2 39 3.751500e-06 1.310800e-03 # simplex 1305 -1306 1307 2 39 3.552600e-06 1.175500e-03 # simplex 1306 -1307 1308 2 39 3.357200e-06 1.047500e-03 # simplex 1307 -1308 1309 2 39 3.378000e-06 9.268300e-04 # simplex 1308 -1309 1310 2 39 3.240000e-06 9.096400e-04 # simplex 1309 -1310 1311 2 39 3.173400e-06 8.743100e-04 # simplex 1310 -1311 1312 2 39 3.109900e-06 8.396800e-04 # simplex 1311 -1312 1313 2 39 3.006000e-06 8.057500e-04 # simplex 1312 -1313 1314 2 39 3.001700e-06 7.987700e-04 # simplex 1313 -1314 1315 2 39 3.065800e-06 8.313000e-04 # simplex 1314 -1315 1316 2 39 3.122800e-06 8.644800e-04 # simplex 1315 -1316 1317 2 39 3.183200e-06 8.983100e-04 # simplex 1316 -1317 1318 2 39 3.161400e-06 9.327900e-04 # simplex 1317 -1318 1319 2 39 3.244800e-06 9.452400e-04 # simplex 1318 -1319 1320 2 39 3.350800e-06 1.010200e-03 # simplex 1319 -1320 1321 2 39 3.465500e-06 1.077200e-03 # simplex 1320 -1321 1322 2 39 3.573500e-06 1.146500e-03 # simplex 1321 -1322 1323 2 39 3.680900e-06 1.217900e-03 # simplex 1322 -1323 1324 2 39 3.792800e-06 1.291400e-03 # simplex 1323 -1324 1325 2 39 4.438000e-06 1.367100e-03 # simplex 1324 -1325 1326 2 39 4.406800e-06 1.472500e-03 # simplex 1325 -1326 1327 2 39 4.199000e-06 1.340600e-03 # simplex 1326 -1327 1328 2 39 3.999500e-06 1.214900e-03 # simplex 1327 -1328 1329 2 39 3.369700e-06 1.095400e-03 # simplex 1328 -1329 1330 2 39 3.209700e-06 8.419900e-04 # simplex 1329 -1330 1331 2 39 3.070200e-06 7.699700e-04 # simplex 1330 -1331 1332 2 39 2.928900e-06 7.011700e-04 # simplex 1331 -1332 1333 2 39 3.047100e-06 6.355800e-04 # simplex 1332 -1333 1334 2 39 3.051800e-06 7.478000e-04 # simplex 1333 -1334 1335 2 39 3.210200e-06 8.283500e-04 # simplex 1334 -1335 1336 2 39 2.950000e-06 9.130100e-04 # simplex 1335 -1336 1337 2 39 2.995400e-06 8.410800e-04 # simplex 1336 -1337 1338 2 39 2.948900e-06 8.147400e-04 # simplex 1337 -1338 1339 2 39 2.885800e-06 7.888200e-04 # simplex 1338 -1309 1340 2 40 3.033200e-06 8.918400e-04 # simplex 1339 -1340 1341 2 40 3.226900e-06 1.007900e-03 # simplex 1340 -1341 1342 2 40 3.419000e-06 1.131100e-03 # simplex 1341 -1342 1343 2 40 3.436900e-06 1.261300e-03 # simplex 1342 -1343 1344 2 40 3.521400e-06 1.255500e-03 # simplex 1343 -1344 1345 2 40 3.524400e-06 1.255500e-03 # simplex 1344 -1345 1346 2 40 3.524400e-06 1.255500e-03 # simplex 1345 -1346 1347 2 40 4.246400e-06 1.255500e-03 # simplex 1346 -1347 1348 2 40 4.244200e-06 1.518800e-03 # simplex 1347 -1348 1349 2 40 4.247400e-06 1.518800e-03 # simplex 1348 -1349 1350 2 40 3.610700e-06 1.518800e-03 # simplex 1349 -1350 1351 2 40 3.560400e-06 1.262900e-03 # simplex 1350 -1351 1352 2 40 3.459200e-06 1.191700e-03 # simplex 1351 -1352 1353 2 40 3.353600e-06 1.122600e-03 # simplex 1352 -1353 1354 2 40 3.819800e-06 1.055600e-03 # simplex 1353 -1354 1355 2 40 3.664200e-06 1.129800e-03 # simplex 1354 -1355 1356 2 40 3.474200e-06 1.014500e-03 # simplex 1355 -1356 1357 2 40 3.281400e-06 9.054900e-04 # simplex 1356 -1357 1358 2 40 3.088200e-06 8.026300e-04 # simplex 1357 -1358 1359 2 40 2.638300e-06 7.059700e-04 # simplex 1358 -1359 1360 2 40 2.635800e-06 6.106600e-04 # simplex 1359 -1360 1361 2 40 2.815300e-06 6.956200e-04 # simplex 1360 -1361 1362 2 40 2.992800e-06 7.861000e-04 # simplex 1361 -1362 1363 2 40 3.788200e-06 8.821200e-04 # simplex 1362 -1363 1364 2 40 3.860600e-06 1.131800e-03 # simplex 1363 -1364 1365 2 40 3.801100e-06 1.096800e-03 # simplex 1364 -1365 1366 2 40 3.453800e-06 1.062500e-03 # simplex 1365 -1366 1367 2 40 3.377600e-06 9.612500e-04 # simplex 1366 -1367 1368 2 40 3.276700e-06 9.046600e-04 # simplex 1367 -1368 1369 2 40 3.174200e-06 8.497800e-04 # simplex 1368 -1369 1370 2 40 3.074800e-06 7.966300e-04 # simplex 1369 -1370 1371 2 40 3.213000e-06 7.451900e-04 # simplex 1370 -1371 1372 2 40 3.033400e-06 6.715500e-04 # simplex 1371 -1372 1373 2 40 2.768000e-06 5.605300e-04 # simplex 1372 -1373 1374 2 40 2.506800e-06 4.595500e-04 # simplex 1373 -1374 1375 2 40 2.098300e-06 3.685900e-04 # simplex 1374 -223 1376 2 41 7.053100e-06 4.375500e-03 # simplex 1375 -1376 1377 2 41 5.885400e-06 3.046800e-03 # simplex 1376 -1377 1378 2 41 4.712100e-06 1.958500e-03 # simplex 1377 -1378 1379 2 41 3.568000e-06 1.110800e-03 # simplex 1378 -1379 1380 2 41 2.847700e-06 7.642800e-04 # simplex 1379 -1380 1381 2 41 2.777600e-06 7.271700e-04 # simplex 1380 -1381 1382 2 41 2.707400e-06 6.909800e-04 # simplex 1381 -1382 1383 2 41 2.571700e-06 6.557200e-04 # simplex 1382 -1383 1384 2 41 2.568700e-06 6.378100e-04 # simplex 1383 -1384 1385 2 41 2.631200e-06 6.692100e-04 # simplex 1384 -1385 1386 2 41 2.846500e-06 7.013700e-04 # simplex 1385 -1386 1387 2 41 2.827700e-06 7.309000e-04 # simplex 1386 -1387 1388 2 41 2.722400e-06 6.777000e-04 # simplex 1387 -1388 1389 2 41 2.891400e-06 6.265100e-04 # simplex 1388 -1389 1390 2 41 2.822600e-06 6.500100e-04 # simplex 1389 -1390 1391 2 41 2.807100e-06 6.422900e-04 # simplex 1390 -1391 1392 2 41 2.788900e-06 6.346200e-04 # simplex 1391 -1392 1393 2 41 2.732500e-06 6.269900e-04 # simplex 1392 -1393 1394 2 41 2.721700e-06 6.220600e-04 # simplex 1393 -1394 1395 2 41 2.711600e-06 6.182300e-04 # simplex 1394 -1395 1396 2 41 2.158000e-06 6.144200e-04 # simplex 1395 -1396 1397 2 41 2.124800e-06 4.562300e-04 # simplex 1396 -1397 1398 2 41 2.060400e-06 4.290000e-04 # simplex 1397 -1398 1399 2 41 2.199200e-06 4.026100e-04 # simplex 1398 -1399 1400 2 41 2.185600e-06 4.515800e-04 # simplex 1399 -1400 1401 2 41 2.233300e-06 4.713600e-04 # simplex 1400 -1401 1402 2 41 2.233400e-06 4.915600e-04 # simplex 1401 -1402 1403 2 41 2.261400e-06 4.814700e-04 # simplex 1402 -1403 1404 2 41 2.278200e-06 4.877100e-04 # simplex 1403 -1404 1405 2 41 2.290600e-06 4.939900e-04 # simplex 1404 -1405 1406 2 41 2.557600e-06 5.003200e-04 # simplex 1405 -1406 1407 2 41 2.496400e-06 5.239400e-04 # simplex 1406 -1407 1408 2 41 2.346800e-06 4.648800e-04 # simplex 1407 -1408 1409 2 41 2.206600e-06 4.093600e-04 # simplex 1408 -1409 1410 2 41 1.969300e-06 3.573700e-04 # simplex 1409 -1399 1411 2 42 1.354400e-06 2.531900e-04 # simplex 1410 -1411 1412 2 42 1.774700e-06 1.732100e-04 # simplex 1411 -1412 1413 2 42 1.535600e-06 1.968900e-04 # simplex 1412 -1413 1414 2 42 1.453100e-06 1.759400e-04 # simplex 1413 -1414 1415 2 42 1.367800e-06 1.561800e-04 # simplex 1414 -1415 1416 2 42 1.283700e-06 1.375900e-04 # simplex 1415 -1416 1417 2 42 1.122000e-06 1.201800e-04 # simplex 1416 -183 1418 2 43 8.154300e-06 4.900300e-03 # simplex 1417 -1418 1419 2 43 5.800800e-06 2.430300e-03 # simplex 1418 -1419 1420 2 43 4.237100e-06 1.242400e-03 # simplex 1419 -1420 1421 2 43 3.923400e-06 1.449600e-03 # simplex 1420 -1421 1422 2 43 4.113800e-06 1.377100e-03 # simplex 1421 -1422 1423 2 43 4.320700e-06 1.224000e-03 # simplex 1422 -1423 1424 2 43 3.985600e-06 1.185900e-03 # simplex 1423 -1424 1425 2 43 3.859700e-06 9.506600e-04 # simplex 1424 -1425 1426 2 43 3.667200e-06 9.035700e-04 # simplex 1425 -1426 1427 2 43 3.762800e-06 9.493700e-04 # simplex 1426 -1427 1428 2 43 2.241800e-06 9.963000e-04 # simplex 1427 -1428 1429 2 43 2.274800e-06 6.170500e-04 # simplex 1428 -1429 1430 2 43 3.953600e-06 6.237800e-04 # simplex 1429 -1430 1431 2 43 4.138200e-06 1.134200e-03 # simplex 1430 -1431 1432 2 43 3.750000e-06 1.326600e-03 # simplex 1431 -1432 1433 2 43 3.850500e-06 1.192800e-03 # simplex 1432 -1433 1434 2 43 3.769000e-06 1.142800e-03 # simplex 1433 -1434 1435 2 43 3.687600e-06 1.094000e-03 # simplex 1434 -1435 1436 2 43 3.892000e-06 1.046200e-03 # simplex 1435 -1436 1437 2 43 3.525300e-06 9.575900e-04 # simplex 1436 -1437 1438 2 43 2.709300e-06 6.162700e-04 # simplex 1437 -183 1439 2 44 6.584000e-06 4.210000e-03 # simplex 1438 -1439 1440 2 44 5.333600e-06 2.769700e-03 # simplex 1439 -1440 1441 2 44 4.703500e-06 1.631100e-03 # simplex 1440 -1441 1442 2 44 4.010000e-06 1.012900e-03 # simplex 1441 -1442 1443 2 44 3.459100e-06 9.316200e-04 # simplex 1442 -1443 1444 2 44 3.260000e-06 9.167400e-04 # simplex 1443 -1442 1445 2 45 3.417900e-06 9.436000e-04 # simplex 1444 -1445 1446 2 45 3.028300e-06 1.168200e-03 # simplex 1445 -1446 1447 2 45 2.987700e-06 9.513100e-04 # simplex 1446 -1447 1448 2 45 2.566000e-06 7.019500e-04 # simplex 1447 -1448 1449 2 45 1.871100e-06 4.904900e-04 # simplex 1448 -1449 1450 2 45 1.768500e-06 3.928100e-04 # simplex 1449 -1450 1451 2 45 2.616400e-06 4.777000e-04 # simplex 1450 -1451 1452 2 45 2.602200e-06 4.843300e-04 # simplex 1451 -1452 1453 2 45 2.074700e-06 3.746300e-04 # simplex 1452 -1453 1454 2 45 1.461700e-06 3.101200e-04 # simplex 1453 -1454 1455 2 45 1.379600e-06 2.097000e-04 # simplex 1454 -1455 1456 2 45 1.179300e-06 2.051800e-04 # simplex 1455 -1456 1457 2 45 1.231300e-06 1.968400e-04 # simplex 1456 -1457 1458 2 45 1.945800e-06 2.346300e-04 # simplex 1457 -1458 1459 2 45 1.972500e-06 3.477900e-04 # simplex 1458 -1459 1460 2 45 1.869400e-06 3.120600e-04 # simplex 1459 -1460 1461 2 45 1.764400e-06 2.782500e-04 # simplex 1460 -1461 1462 2 45 1.686800e-06 2.463900e-04 # simplex 1461 -1462 1463 2 45 1.610800e-06 2.306300e-04 # simplex 1462 -1463 1464 2 45 1.564800e-06 2.177400e-04 # simplex 1463 -1464 1465 2 45 1.512500e-06 2.052100e-04 # simplex 1464 -1451 1466 2 46 2.774500e-06 6.953800e-04 # simplex 1465 -1466 1467 2 46 2.630100e-06 6.248000e-04 # simplex 1466 -1467 1468 2 46 2.226100e-06 5.580000e-04 # simplex 1467 -1468 1469 2 46 2.165600e-06 4.701000e-04 # simplex 1468 -1469 1470 2 46 2.177200e-06 4.746600e-04 # simplex 1469 -1470 1471 2 46 2.515300e-06 4.792400e-04 # simplex 1470 -1471 1472 2 46 2.519800e-06 5.623500e-04 # simplex 1471 -1472 1473 2 46 2.521700e-06 5.631800e-04 # simplex 1472 -1473 1474 2 46 2.303500e-06 5.640100e-04 # simplex 1473 -1474 1475 2 46 2.323000e-06 5.129700e-04 # simplex 1474 -1475 1476 2 46 2.362900e-06 5.307800e-04 # simplex 1475 -1476 1477 2 46 2.404500e-06 5.488900e-04 # simplex 1476 -1477 1478 2 46 2.442900e-06 5.673000e-04 # simplex 1477 -1478 1479 2 46 2.671400e-06 5.860200e-04 # simplex 1478 -1479 1480 2 46 2.720900e-06 6.618300e-04 # simplex 1479 -1480 1481 2 46 2.770900e-06 6.863800e-04 # simplex 1480 -1481 1482 2 46 2.821000e-06 7.113900e-04 # simplex 1481 -1482 1483 2 46 2.672900e-06 7.368300e-04 # simplex 1482 -1483 1484 2 46 2.644600e-06 6.715200e-04 # simplex 1483 -1484 1485 2 46 2.553000e-06 6.238400e-04 # simplex 1484 -1485 1486 2 46 2.456200e-06 5.779200e-04 # simplex 1485 -1486 1487 2 46 2.361500e-06 5.337500e-04 # simplex 1486 -1487 1488 2 46 2.812400e-06 4.913400e-04 # simplex 1487 -1488 1489 2 46 2.705500e-06 5.290200e-04 # simplex 1488 -1489 1490 2 46 2.604200e-06 4.908300e-04 # simplex 1489 -1490 1491 2 46 2.506500e-06 4.540800e-04 # simplex 1490 -1491 1492 2 46 2.407100e-06 4.187500e-04 # simplex 1491 -1492 1493 2 46 2.305900e-06 3.848600e-04 # simplex 1492 -1493 1494 2 46 2.049300e-06 3.523900e-04 # simplex 1493 -1483 1495 2 47 3.067500e-06 7.902900e-04 # simplex 1494 -1495 1496 2 47 3.013400e-06 7.625900e-04 # simplex 1495 -1496 1497 2 47 2.960000e-06 7.353800e-04 # simplex 1496 -1497 1498 2 47 2.905000e-06 7.086600e-04 # simplex 1497 -1498 1499 2 47 2.850600e-06 6.824400e-04 # simplex 1498 -1499 1500 2 47 2.797100e-06 6.567100e-04 # simplex 1499 -1500 1501 2 47 2.742000e-06 6.314800e-04 # simplex 1500 -1501 1502 2 47 2.695200e-06 6.067400e-04 # simplex 1501 -1502 1503 2 47 2.714800e-06 5.861100e-04 # simplex 1502 -1503 1504 2 47 2.811600e-06 6.286100e-04 # simplex 1503 -1504 1505 2 47 2.908300e-06 6.726000e-04 # simplex 1504 -1505 1506 2 47 3.005000e-06 7.180700e-04 # simplex 1505 -1506 1507 2 47 2.968100e-06 7.650300e-04 # simplex 1506 -1507 1508 2 47 2.867500e-06 6.982200e-04 # simplex 1507 -1508 1509 2 47 2.558100e-06 5.558300e-04 # simplex 1508 -1509 1510 2 47 2.248400e-06 4.296800e-04 # simplex 1509 -1510 1511 2 47 1.865000e-06 3.197700e-04 # simplex 1510 -1511 1512 2 47 1.731300e-06 2.729000e-04 # simplex 1511 -1512 1513 2 47 1.812700e-06 2.845900e-04 # simplex 1512 -1513 1514 2 47 1.813800e-06 2.894300e-04 # simplex 1513 -1514 1515 2 47 1.778300e-06 2.782200e-04 # simplex 1514 -1515 1516 2 47 1.742800e-06 2.672300e-04 # simplex 1515 -1516 1517 2 47 1.685800e-06 2.564600e-04 # simplex 1516 -1507 1518 2 48 3.069600e-06 7.768800e-04 # simplex 1517 -1518 1519 2 48 2.786800e-06 6.404000e-04 # simplex 1518 -1519 1520 2 48 2.506600e-06 5.171100e-04 # simplex 1519 -1520 1521 2 48 2.221100e-06 4.070000e-04 # simplex 1520 -1521 1522 2 48 1.937400e-06 3.100700e-04 # simplex 1521 -1474 1523 2 49 1.864900e-06 4.044800e-04 # simplex 1522 -1523 1524 2 49 1.770300e-06 3.642000e-04 # simplex 1523 -1524 1525 2 49 2.066300e-06 3.260300e-04 # simplex 1524 -1525 1526 2 49 1.936800e-06 3.530900e-04 # simplex 1525 -1526 1527 2 49 1.795300e-06 3.034500e-04 # simplex 1526 -1527 1528 2 49 1.654000e-06 2.575700e-04 # simplex 1527 -1528 1529 2 49 1.512600e-06 2.154500e-04 # simplex 1528 -1529 1530 2 49 1.371500e-06 1.770900e-04 # simplex 1529 -1530 1531 2 49 1.222900e-06 1.424900e-04 # simplex 1530 -180 1532 2 50 9.520700e-06 7.339100e-03 # simplex 1531 -1532 1533 2 50 8.210000e-06 5.460000e-03 # simplex 1532 -1533 1534 2 50 6.898700e-06 3.858900e-03 # simplex 1533 -1534 1535 2 50 5.588500e-06 2.535600e-03 # simplex 1534 -1535 1536 2 50 4.580800e-06 1.490100e-03 # simplex 1535 -1536 1537 2 50 3.725700e-06 1.105900e-03 # simplex 1536 -1537 1538 2 50 2.104600e-06 1.051200e-03 # simplex 1537 -1538 1539 2 50 2.139600e-06 5.802000e-04 # simplex 1538 -1539 1540 2 50 3.038700e-06 6.453300e-04 # simplex 1539 -1540 1541 2 50 3.053900e-06 9.184800e-04 # simplex 1540 -1541 1542 2 50 2.935700e-06 8.486600e-04 # simplex 1541 -1542 1543 2 50 3.430300e-06 7.816100e-04 # simplex 1542 -1543 1544 2 50 3.449100e-06 1.004800e-03 # simplex 1543 -1544 1545 2 50 3.510500e-06 1.050800e-03 # simplex 1544 -1545 1546 2 50 3.422700e-06 9.969300e-04 # simplex 1545 -1546 1547 2 50 3.331800e-06 9.445200e-04 # simplex 1546 -1547 1548 2 50 3.240300e-06 8.935200e-04 # simplex 1547 -1548 1549 2 50 3.146000e-06 8.439400e-04 # simplex 1548 -1549 1550 2 50 3.058000e-06 7.957800e-04 # simplex 1549 -1550 1551 2 50 2.964900e-06 7.490200e-04 # simplex 1550 -1544 1552 2 51 2.895000e-06 8.162400e-04 # simplex 1551 -1552 1553 2 51 2.559100e-06 6.376300e-04 # simplex 1552 -1553 1554 2 51 2.410300e-06 4.810700e-04 # simplex 1553 -1554 1555 2 51 2.161600e-06 4.174200e-04 # simplex 1554 -1555 1556 2 51 2.049300e-06 3.747500e-04 # simplex 1555 -1556 1557 2 51 1.887100e-06 3.343800e-04 # simplex 1556 -1538 1558 2 52 2.675300e-06 6.777400e-04 # simplex 1557 -1558 1559 2 52 1.930400e-06 4.505300e-04 # simplex 1558 -1559 1560 2 52 1.634600e-06 2.970400e-04 # simplex 1559 -1560 1561 2 52 2.100900e-06 2.521800e-04 # simplex 1560 -1561 1562 2 52 1.971300e-06 3.105000e-04 # simplex 1561 -1562 1563 2 52 1.402300e-06 2.871500e-04 # simplex 1562 -1563 1564 2 52 1.367200e-06 2.017200e-04 # simplex 1563 -1564 1565 2 52 1.352200e-06 1.971400e-04 # simplex 1564 -1565 1566 2 52 1.508300e-06 1.926100e-04 # simplex 1565 -1566 1567 2 52 1.571400e-06 2.372100e-04 # simplex 1566 -1567 1568 2 52 1.713800e-06 2.821000e-04 # simplex 1567 -1568 1569 2 52 1.855900e-06 3.308900e-04 # simplex 1568 -1569 1570 2 52 1.996200e-06 3.835600e-04 # simplex 1569 -1570 1571 2 52 2.138300e-06 4.401200e-04 # simplex 1570 -1536 1572 2 53 3.714100e-06 1.038100e-03 # simplex 1571 -1572 1573 2 53 4.188700e-06 1.073700e-03 # simplex 1572 -1573 1574 2 53 4.026900e-06 1.118400e-03 # simplex 1573 -1574 1575 2 53 2.790400e-06 9.032800e-04 # simplex 1574 -1575 1576 2 53 2.667000e-06 6.598400e-04 # simplex 1575 -1576 1577 2 53 2.598600e-06 7.008000e-04 # simplex 1576 -1577 1578 2 53 2.656600e-06 7.010600e-04 # simplex 1577 -1578 1579 2 53 3.314300e-06 7.244300e-04 # simplex 1578 -1579 1580 2 53 3.221700e-06 8.617100e-04 # simplex 1579 -1580 1581 2 53 2.982500e-06 7.372400e-04 # simplex 1580 -1581 1582 2 53 2.740400e-06 6.224700e-04 # simplex 1581 -1582 1583 2 53 1.492700e-06 5.174200e-04 # simplex 1582 -1583 1584 2 53 1.477100e-06 2.862500e-04 # simplex 1583 -1584 1585 2 53 2.346600e-06 3.309800e-04 # simplex 1584 -1585 1586 2 53 2.336700e-06 5.098200e-04 # simplex 1585 -1586 1587 2 53 2.438300e-06 4.318200e-04 # simplex 1586 -1587 1588 2 53 2.248800e-06 4.185600e-04 # simplex 1587 -1588 1589 2 53 1.710700e-06 3.593100e-04 # simplex 1588 -1589 1590 2 53 1.640400e-06 2.643000e-04 # simplex 1589 -1590 1591 2 53 1.637100e-06 2.634800e-04 # simplex 1590 -1591 1592 2 53 1.635300e-06 2.626600e-04 # simplex 1591 -1592 1593 2 53 1.458700e-06 2.618300e-04 # simplex 1592 -1593 1594 2 53 1.413200e-06 2.230800e-04 # simplex 1593 -1594 1595 2 53 1.323100e-06 1.955700e-04 # simplex 1594 -1595 1596 2 53 1.219800e-06 1.698600e-04 # simplex 1595 -180 1597 2 54 8.914200e-06 6.453800e-03 # simplex 1596 -1597 1598 2 54 7.285000e-06 4.315300e-03 # simplex 1597 -1598 1599 2 54 5.655100e-06 2.607200e-03 # simplex 1598 -1599 1600 2 54 4.918900e-06 1.329500e-03 # simplex 1599 -1600 1601 2 54 3.290000e-06 1.257100e-03 # simplex 1600 -1601 1602 2 54 3.648300e-06 1.241000e-03 # simplex 1601 -1602 1603 2 54 2.581900e-06 1.241000e-03 # simplex 1602 -1603 1604 2 54 2.576900e-06 8.365400e-04 # simplex 1603 -1604 1605 2 54 2.625500e-06 8.365400e-04 # simplex 1604 -1605 1606 2 54 2.623200e-06 9.150700e-04 # simplex 1605 -1606 1607 2 54 3.319100e-06 9.150700e-04 # simplex 1606 -1607 1608 2 54 3.314700e-06 1.109600e-03 # simplex 1607 -1608 1609 2 54 3.097500e-06 1.109600e-03 # simplex 1608 -1609 1610 2 54 2.916900e-06 9.202600e-04 # simplex 1609 -1610 1611 2 54 3.582900e-06 6.677800e-04 # simplex 1610 -1611 1612 2 54 3.277900e-06 8.405500e-04 # simplex 1611 -1612 1613 2 54 3.371100e-06 8.889600e-04 # simplex 1612 -1613 1614 2 54 3.464000e-06 9.387200e-04 # simplex 1613 -1614 1615 2 54 3.634300e-06 9.898400e-04 # simplex 1614 -1615 1616 2 54 3.750800e-06 1.030300e-03 # simplex 1615 -1616 1617 2 54 3.567300e-06 1.106800e-03 # simplex 1616 -1617 1618 2 54 3.507900e-06 1.046800e-03 # simplex 1617 -1618 1619 2 54 3.262000e-06 9.045800e-04 # simplex 1618 -1619 1620 2 54 3.013400e-06 7.727100e-04 # simplex 1619 -1620 1621 2 54 2.615500e-06 6.512200e-04 # simplex 1620 -1621 1622 2 54 2.525800e-06 5.566800e-04 # simplex 1621 -1622 1623 2 54 2.592200e-06 5.813800e-04 # simplex 1622 -1623 1624 2 54 2.573900e-06 5.815700e-04 # simplex 1623 -1624 1625 2 54 2.477100e-06 5.387100e-04 # simplex 1624 -1625 1626 2 54 2.216600e-06 4.974900e-04 # simplex 1625 -1626 1627 2 54 2.153500e-06 4.382400e-04 # simplex 1626 -1627 1628 2 54 2.123400e-06 4.254000e-04 # simplex 1627 -1628 1629 2 54 1.711500e-06 4.127500e-04 # simplex 1628 -1629 1630 2 54 1.683300e-06 3.363000e-04 # simplex 1629 -1630 1631 2 54 1.652400e-06 3.242000e-04 # simplex 1630 -1631 1632 2 54 2.073600e-06 3.123200e-04 # simplex 1631 -1632 1633 2 54 2.219900e-06 4.552500e-04 # simplex 1632 -1633 1634 2 54 2.568200e-06 5.956800e-04 # simplex 1633 -1634 1635 2 54 2.647100e-06 6.369300e-04 # simplex 1634 -1635 1636 2 54 2.561200e-06 5.642400e-04 # simplex 1635 -1636 1637 2 54 2.559600e-06 5.684900e-04 # simplex 1636 -1637 1638 2 54 2.717100e-06 6.410800e-04 # simplex 1637 -1638 1639 2 54 2.487100e-06 7.180400e-04 # simplex 1638 -1639 1640 2 54 2.487600e-06 6.285300e-04 # simplex 1639 -1640 1641 2 54 2.350600e-06 5.612300e-04 # simplex 1640 -1641 1642 2 54 2.178100e-06 4.977500e-04 # simplex 1641 -1609 1643 2 55 3.683300e-06 1.264500e-03 # simplex 1642 -1643 1644 2 55 3.358200e-06 1.051200e-03 # simplex 1643 -1644 1645 2 55 3.032900e-06 8.576200e-04 # simplex 1644 -1645 1646 2 55 2.522200e-06 6.837200e-04 # simplex 1645 -1646 1647 2 55 2.337700e-06 5.447200e-04 # simplex 1646 -1647 1648 2 55 2.900200e-06 5.185900e-04 # simplex 1647 -1648 1649 2 55 2.793600e-06 6.146900e-04 # simplex 1648 -1649 1650 2 55 2.650800e-06 5.535500e-04 # simplex 1649 -1650 1651 2 55 2.650100e-06 4.956300e-04 # simplex 1650 -1651 1652 2 55 2.340700e-06 3.822000e-04 # simplex 1651 -1652 1653 2 55 1.734500e-06 2.419200e-04 # simplex 1652 -180 1654 2 56 8.569700e-06 6.696400e-03 # simplex 1653 -1654 1655 2 56 7.520100e-06 5.158300e-03 # simplex 1654 -1655 1656 2 56 6.470000e-06 3.820800e-03 # simplex 1655 -1656 1657 2 56 5.421200e-06 2.684100e-03 # simplex 1656 -1657 1658 2 56 3.925700e-06 1.748100e-03 # simplex 1657 -1658 1659 2 56 3.360600e-06 1.197900e-03 # simplex 1658 -1659 1660 2 56 3.360600e-06 1.197900e-03 # simplex 1659 -1660 1661 2 56 4.127000e-06 1.197900e-03 # simplex 1660 -1661 1662 2 56 4.127300e-06 1.456400e-03 # simplex 1661 -1662 1663 2 56 4.128000e-06 1.456400e-03 # simplex 1662 -1663 1664 2 56 4.125700e-06 1.456400e-03 # simplex 1663 -1664 1665 2 56 4.128000e-06 1.456400e-03 # simplex 1664 -1665 1666 2 56 4.128000e-06 1.456400e-03 # simplex 1665 -1666 1667 2 56 4.556400e-06 1.456400e-03 # simplex 1666 -1667 1668 2 56 4.557600e-06 1.625100e-03 # simplex 1667 -1668 1669 2 56 4.557700e-06 1.625100e-03 # simplex 1668 -1669 1670 2 56 4.555900e-06 1.625100e-03 # simplex 1669 -1670 1671 2 56 3.184700e-06 1.625100e-03 # simplex 1670 -1671 1672 2 56 3.181900e-06 1.118200e-03 # simplex 1671 -1672 1673 2 56 3.182200e-06 1.118200e-03 # simplex 1672 -1673 1674 2 56 4.133200e-06 1.118200e-03 # simplex 1673 -1674 1675 2 56 4.132800e-06 1.487200e-03 # simplex 1674 -1675 1676 2 56 4.129200e-06 1.487200e-03 # simplex 1675 -1676 1677 2 56 4.133000e-06 1.487200e-03 # simplex 1676 -1677 1678 2 56 4.133200e-06 1.487200e-03 # simplex 1677 -1678 1679 2 56 3.107200e-06 1.487200e-03 # simplex 1678 -1679 1680 2 56 3.108900e-06 1.112700e-03 # simplex 1679 -1680 1681 2 56 3.108400e-06 1.112700e-03 # simplex 1680 -1681 1682 2 56 4.357900e-06 1.112700e-03 # simplex 1681 -1682 1683 2 56 4.355200e-06 1.468100e-03 # simplex 1682 -1683 1684 2 56 4.356900e-06 1.468100e-03 # simplex 1683 -1684 1685 2 56 4.361200e-06 1.468100e-03 # simplex 1684 -1685 1686 2 56 4.355200e-06 1.468100e-03 # simplex 1685 -1686 1687 2 56 4.052700e-06 1.468100e-03 # simplex 1686 -1687 1688 2 56 3.935400e-06 1.318000e-03 # simplex 1687 -1688 1689 2 56 3.683600e-06 1.155200e-03 # simplex 1688 -1689 1690 2 56 3.433100e-06 1.003100e-03 # simplex 1689 -1690 1691 2 56 3.179700e-06 8.617500e-04 # simplex 1690 -1691 1692 2 56 2.367200e-06 7.311400e-04 # simplex 1691 -1692 1693 2 56 2.216500e-06 5.392100e-04 # simplex 1692 -1693 1694 2 56 2.121600e-06 4.940900e-04 # simplex 1693 -1694 1695 2 56 2.208100e-06 4.509500e-04 # simplex 1694 -1695 1696 2 56 2.105300e-06 4.090000e-04 # simplex 1695 -1696 1697 2 56 2.011700e-06 3.724600e-04 # simplex 1696 -1697 1698 2 56 1.823500e-06 3.376300e-04 # simplex 1697 -1698 1699 2 56 1.792900e-06 3.354600e-04 # simplex 1698 -1699 1700 2 56 1.825300e-06 3.473200e-04 # simplex 1699 -1700 1701 2 56 2.395600e-06 3.593900e-04 # simplex 1700 -1701 1702 2 56 2.357900e-06 4.283200e-04 # simplex 1701 -1702 1703 2 56 2.239500e-06 3.868800e-04 # simplex 1702 -1703 1704 2 56 2.317800e-06 3.475400e-04 # simplex 1703 -1704 1705 2 56 2.185000e-06 3.372300e-04 # simplex 1704 -1705 1706 2 56 1.350500e-06 2.971600e-04 # simplex 1705 -1706 1707 2 56 1.218700e-06 1.661400e-04 # simplex 1706 -1707 1708 2 56 1.018700e-06 1.209000e-04 # simplex 1707 -174 1709 2 57 9.716600e-06 6.376400e-03 # simplex 1708 -1709 1710 2 57 7.079600e-06 3.402600e-03 # simplex 1709 -1710 1711 2 57 4.389600e-06 1.362900e-03 # simplex 1710 -1711 1712 2 57 2.752000e-06 6.352600e-04 # simplex 1711 -1712 1713 2 57 2.260900e-06 5.957000e-04 # simplex 1712 -1713 1714 2 57 2.243700e-06 4.857800e-04 # simplex 1713 -1714 1715 2 57 2.283100e-06 5.029500e-04 # simplex 1714 -1715 1716 2 57 2.536600e-06 5.204200e-04 # simplex 1715 -1716 1717 2 57 2.648000e-06 6.509300e-04 # simplex 1716 -1717 1718 2 57 2.823700e-06 7.403600e-04 # simplex 1717 -1718 1719 2 57 3.000300e-06 8.355400e-04 # simplex 1718 -1719 1720 2 57 3.141500e-06 9.364900e-04 # simplex 1719 -1720 1721 2 57 3.180900e-06 9.256100e-04 # simplex 1720 -1721 1722 2 57 3.087900e-06 8.722700e-04 # simplex 1721 -1722 1723 2 57 2.813100e-06 8.205100e-04 # simplex 1722 -1723 1724 2 57 2.711100e-06 7.248600e-04 # simplex 1723 -1724 1725 2 57 2.590700e-06 6.616900e-04 # simplex 1724 -1725 1726 2 57 2.658400e-06 6.014000e-04 # simplex 1725 -1726 1727 2 57 2.510300e-06 5.898200e-04 # simplex 1726 -1727 1728 2 57 2.337900e-06 5.115200e-04 # simplex 1727 -1728 1729 2 57 2.165300e-06 4.388000e-04 # simplex 1728 -1729 1730 2 57 1.992400e-06 3.716500e-04 # simplex 1729 -1730 1731 2 57 1.817700e-06 3.100700e-04 # simplex 1730 -1716 1732 2 58 2.178800e-06 4.542400e-04 # simplex 1731 -1732 1733 2 58 2.315300e-06 3.849500e-04 # simplex 1732 -1733 1734 2 58 2.181400e-06 4.342000e-04 # simplex 1733 -1734 1735 2 58 2.119500e-06 4.099300e-04 # simplex 1734 -1735 1736 2 58 1.883500e-06 3.863700e-04 # simplex 1735 -1736 1737 2 58 1.625400e-06 2.406400e-04 # simplex 1736 -1737 1738 2 58 1.039600e-06 1.187300e-04 # simplex 1737 -# -BOUNDARYDOMAIN -default 1 -# diff --git a/test/mixeddimension/embedded/1p2c_richards2c/richardstestproblem.hh b/test/mixeddimension/embedded/1p2c_richards2c/richardstestproblem.hh deleted file mode 100644 index f07997fef820ed7b3f21ec538d325b4fb62c1384..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p2c_richards2c/richardstestproblem.hh +++ /dev/null @@ -1,385 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief A sub problem for the richards problem - */ -#ifndef DUMUX_RICHARDS_TEST_PROBLEM_HH -#define DUMUX_RICHARDS_TEST_PROBLEM_HH - -#include <cmath> - -#include <dumux/implicit/cellcentered/tpfa/properties.hh> -#include <dumux/porousmediumflow/implicit/problem.hh> -#include <dumux/porousmediumflow/richardsnc/model.hh> -#include <dumux/material/components/simpleh2o.hh> -#include <dumux/material/components/constant.hh> -#include <dumux/material/fluidsystems/liquidphase2c.hh> - -//! get the properties needed for subproblems -#include <dumux/mixeddimension/subproblemproperties.hh> - -#include "richardstestspatialparams.hh" - -namespace Dumux -{ -template <class TypeTag> -class RichardsTestProblem; - -namespace Properties -{ -NEW_TYPE_TAG(RichardsTestProblem, INHERITS_FROM(RichardsNC, RichardsTestSpatialParams)); -NEW_TYPE_TAG(RichardsTestBoxProblem, INHERITS_FROM(BoxModel, RichardsTestProblem)); -NEW_TYPE_TAG(RichardsTestCCProblem, INHERITS_FROM(CCTpfaModel, RichardsTestProblem)); - -// Set the grid type -//SET_TYPE_PROP(RichardsTestProblem, Grid, Dune::YaspGrid<3, Dune::EquidistantOffsetCoordinates<double, 3> >); -SET_TYPE_PROP(RichardsTestProblem, Grid, Dune::UGGrid<3>); - -SET_BOOL_PROP(RichardsTestProblem, EnableFVGridGeometryCache, true); -SET_BOOL_PROP(RichardsTestProblem, EnableGridVolumeVariablesCache, true); -SET_BOOL_PROP(RichardsTestProblem, EnableGridFluxVariablesCache, true); -SET_BOOL_PROP(RichardsTestProblem, SolutionDependentAdvection, false); -SET_BOOL_PROP(RichardsTestProblem, SolutionDependentMolecularDiffusion, false); -SET_BOOL_PROP(RichardsTestProblem, SolutionDependentHeatConduction, false); - -// Set the problem property -SET_TYPE_PROP(RichardsTestProblem, Problem, RichardsTestProblem<TypeTag>); - -// Set the fluid system -SET_PROP(RichardsTestProblem, FluidSystem) -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using type = FluidSystems::LiquidPhaseTwoC<Scalar, SimpleH2O<Scalar>, Constant<TypeTag,Scalar>>; -}; - -// Set the spatial parameters -SET_TYPE_PROP(RichardsTestProblem, SpatialParams, RichardsTestSpatialParams<TypeTag>); - -// Enable gravity -SET_BOOL_PROP(RichardsTestProblem, ProblemEnableGravity, true); - -// Enable velocity output -SET_BOOL_PROP(RichardsTestProblem, VtkAddVelocity, true); - -// Set the grid parameter group -SET_STRING_PROP(RichardsTestProblem, GridParameterGroup, "SoilGrid"); - -// Use mole fractions -SET_BOOL_PROP(RichardsTestProblem, UseMoles, true); -} - -/*! - * \ingroup OnePBoxModel - * \ingroup ImplicitTestProblems - * \brief Test problem for the one-phase model: - * water is flowing from bottom to top through and around a low permeable lens. - * - * The domain is box shaped. All sides are closed (Neumann 0 boundary) - * except the top and bottom boundaries (Dirichlet), where water is - * flowing from bottom to top. - * - * In the middle of the domain, a lens with low permeability (\f$K=10e-12\f$) - * compared to the surrounding material (\f$ K=10e-10\f$) is defined. - * - * To run the simulation execute the following line in shell: - * <tt>./test_box1p -parameterFile test_box1p.input</tt> or - * <tt>./test_cc1p -parameterFile test_cc1p.input</tt> - * - * The same parameter file can be also used for 3d simulation but you need to change line - * <tt>using type = Dune::SGrid<2, 2>;</tt> to - * <tt>using type = Dune::SGrid<3, 3>;</tt> in the problem file - * and use <tt>1p_3d.dgf</tt> in the parameter file. - */ -template <class TypeTag> -class RichardsTestProblem : public ImplicitPorousMediaProblem<TypeTag> -{ - using ParentType = ImplicitPorousMediaProblem<TypeTag>; - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); - using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); - using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using PointSource = typename GET_PROP_TYPE(TypeTag, PointSource); - using MaterialLaw = typename GET_PROP_TYPE(TypeTag, MaterialLaw); - using Indices = typename GET_PROP_TYPE(TypeTag, Indices); - - enum { - // Grid and world dimension - dim = GridView::dimension, - dimWorld = GridView::dimensionworld - }; - enum { conti0EqIdx = Indices::conti0EqIdx, - transportEqIdx = Indices::conti0EqIdx + 1 }; - enum { pressureIdx = Indices::pressureIdx }; - enum { wPhaseIdx = Indices::wPhaseIdx }; - enum { transportCompIdx = Indices::compMainIdx + 1 }; - - using Element = typename GridView::template Codim<0>::Entity; - using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; - - using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); - using CouplingManager = typename GET_PROP_TYPE(GlobalProblemTypeTag, CouplingManager); - -public: - RichardsTestProblem(TimeManager &timeManager, const GridView &gridView) - : ParentType(timeManager, gridView) - { - name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name) + "-soil"; - contaminantMoleFraction_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, Problem, ContaminantMoleFraction); - - // for initial conditions - const Scalar sw = 0.3; // start with 30% saturation on top - pcTop_ = MaterialLaw::pc(this->spatialParams().materialLawParamsAtPos(this->bBoxMax()), sw); - } - - /*! - * \name Problem parameters - */ - // \{ - - /*! - * \brief The problem name. - * - * This is used as a prefix for files generated by the simulation. - */ - const std::string& name() const - { - return name_; - } - - /*! - * \brief Return the temperature within the domain. - * - * This problem assumes a temperature of 10 degrees Celsius. - */ - Scalar temperature() const - { return 273.15 + 10; } // 10C - /* - * \brief Returns the reference pressure [Pa] of the non-wetting - * fluid phase within a finite volume - * - * This problem assumes a constant reference pressure of 1 bar. - */ - Scalar nonWettingReferencePressure() const - { return 1.0e5; } - - /*! - * \brief Applies a vector of point sources. The point sources - * are possibly solution dependent. - * - * \param pointSources A vector of PointSource s that contain - source values for all phases and space positions. - * - * For this method, the \a values method of the point source - * has to return the absolute mass rate in kg/s. Positive values mean - * that mass is created, negative ones mean that it vanishes. - */ - void addPointSources(std::vector<PointSource>& pointSources) const - { pointSources = this->couplingManager().bulkPointSources(); } - - /*! - * \brief Evaluate the point sources (added by addPointSources) - * for all phases within a given sub-control-volume. - * - * This is the method for the case where the point source is - * solution dependent and requires some quantities that - * are specific to the fully-implicit method. - * - * \param pointSource A single point source - * \param element The finite element - * \param fvGeometry The finite-volume geometry - * \param elemVolVars All volume variables for the element - * \param scv The sub-control volume within the element - * - * For this method, the \a values() method of the point sources returns - * the absolute rate mass generated or annihilate in kg/s. Positive values mean - * that mass is created, negative ones mean that it vanishes. - */ - void pointSource(PointSource& source, - const Element &element, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const SubControlVolume &scv) const - { - // compute source at every integration point - const auto& bulkVolVars = this->couplingManager().bulkVolVars(source.id()); - const auto& lowDimVolVars = this->couplingManager().lowDimVolVars(source.id()); - - const auto& spatialParams = this->couplingManager().lowDimProblem().spatialParams(); - const unsigned int lowDimElementIdx = this->couplingManager().pointSourceData(source.id()).lowDimElementIdx(); - const Scalar Kr = spatialParams.Kr(lowDimElementIdx); - const Scalar rootRadius = spatialParams.radius(lowDimElementIdx); - - // sink defined as radial flow Jr * density [m^2 s-1]* [kg m-3] - PrimaryVariables sourceValues(0.0); - sourceValues[conti0EqIdx] = 2* M_PI *rootRadius * Kr *(lowDimVolVars.pressure(wPhaseIdx) - bulkVolVars.pressure(wPhaseIdx)) - *bulkVolVars.molarDensity(wPhaseIdx); - - //! advective transport over root wall - // compute correct upwind concentration - if (sourceValues[conti0EqIdx] > 0) - sourceValues[transportEqIdx] = sourceValues[conti0EqIdx] - * lowDimVolVars.moleFraction(wPhaseIdx, transportCompIdx); - else - sourceValues[transportEqIdx] = sourceValues[conti0EqIdx] - * bulkVolVars.moleFraction(wPhaseIdx, transportCompIdx); - - //! diffusive transport over root wall - sourceValues[transportEqIdx] += 2* M_PI *rootRadius * 1.0e-8 - *(lowDimVolVars.moleFraction(wPhaseIdx, transportCompIdx) - bulkVolVars.moleFraction(wPhaseIdx, transportCompIdx)) - *0.5*(bulkVolVars.molarDensity(wPhaseIdx) + lowDimVolVars.molarDensity(wPhaseIdx)); - - sourceValues *= source.quadratureWeight()*source.integrationElement(); - source = sourceValues; - } - - //! Called after every time step - //! Output the total global exchange term - void postTimeStep() - { - ParentType::postTimeStep(); - - PrimaryVariables source(0.0); - - if (!(this->timeManager().time() < 0.0)) - { - for (const auto& element : elements(this->gridView())) - { - auto fvGeometry = localView(this->model().fvGridGeometry()); - fvGeometry.bindElement(element); - - auto elemVolVars = localView(this->model().curGridVolVars()); - elemVolVars.bindElement(element, fvGeometry, this->model().curSol()); - - for (auto&& scv : scvs(fvGeometry)) - { - const auto& volVars = elemVolVars[scv]; - auto pointSources = this->scvPointSources(element, fvGeometry, elemVolVars, scv); - // conversion to kg/s - pointSources *= scv.volume()*volVars.extrusionFactor() - * volVars.density(wPhaseIdx) / volVars.molarDensity(wPhaseIdx); - source += pointSources; - } - } - } - - std::cout << "Global integrated source (soil): " << source[conti0EqIdx] << " (kg/s) / " - << source[conti0EqIdx]*3600*24*1000 << " (g/day)" << '\n'; - } - - // \} - /*! - * \name Boundary conditions - */ - // \{ - - /*! - * \brief Specifies which kind of boundary condition should be - * used for which equation on a given boundary control volume. - * - * \param globalPos The position of the center of the finite volume - */ - BoundaryTypes boundaryTypesAtPos(const GlobalPosition &globalPos) const - { - BoundaryTypes bcTypes; - bcTypes.setAllNeumann(); - return bcTypes; - } - - /*! - * \brief Evaluate the boundary conditions for a dirichlet - * control volume. - * - * \param globalPos The center of the finite volume which ought to be set. - * - * For this method, the \a values parameter stores primary variables. - */ - PrimaryVariables dirichletAtPos(const GlobalPosition &globalPos) const - { return initialAtPos(globalPos); } - - // \} - - /*! - * \name Volume terms - */ - // \{ - - /*! - * \brief Evaluate the initial values for a control volume. - * - * For this method, the \a values parameter stores primary - * variables. - * - * \param globalPos The position for which the boundary type is set - */ - PrimaryVariables initialAtPos(const GlobalPosition &globalPos) const - { - const auto xTracer = [&,this]() - { - auto contaminationPos = this->bBoxMax()-this->bBoxMin(); - contaminationPos[0] *= 0.25; - contaminationPos[1] *= 0.55; - contaminationPos[2] *= 0.25; - contaminationPos += this->bBoxMin(); - - static const Scalar extend = 0.15*(this->bBoxMax()[0]-this->bBoxMin()[0]); - if ((globalPos - contaminationPos).infinity_norm() < extend + eps_) - return contaminantMoleFraction_; - else - return 0.0; - }(); - - PrimaryVariables values(0.0); - //! hydrostatic pressure profile - values[pressureIdx] = (nonWettingReferencePressure() - pcTop_) - -9.81*1000*(globalPos[dimWorld-1] - this->bBoxMax()[dimWorld-1]); - values[transportCompIdx] = xTracer; - return values; - - } - - bool shouldWriteRestartFile() const - { - return false; - } - - //! Set the coupling manager - void setCouplingManager(std::shared_ptr<CouplingManager> cm) - { couplingManager_ = cm; } - - //! Get the coupling manager - const CouplingManager& couplingManager() const - { return *couplingManager_; } - -private: - std::string name_; - std::shared_ptr<CouplingManager> couplingManager_; - Scalar contaminantMoleFraction_; - Scalar pcTop_; - static constexpr Scalar eps_ = 1e-7; -}; - -} //end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p2c_richards2c/richardstestspatialparams.hh b/test/mixeddimension/embedded/1p2c_richards2c/richardstestspatialparams.hh deleted file mode 100644 index 47cdb6972b14cadff4a2c76a6cb6c6c924dcd04b..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p2c_richards2c/richardstestspatialparams.hh +++ /dev/null @@ -1,138 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief spatial parameters for the RichardsTestProblem - */ -#ifndef DUMUX_RICHARDS_TEST_SPATIAL_PARAMETERS_HH -#define DUMUX_RICHARDS_TEST_SPATIAL_PARAMETERS_HH - -#include <dumux/material/spatialparams/fv.hh> -#include <dumux/material/fluidmatrixinteractions/2p/vangenuchten.hh> -#include <dumux/material/fluidmatrixinteractions/2p/efftoabslaw.hh> - -namespace Dumux -{ -template<class TypeTag> -class RichardsTestSpatialParams; - -namespace Properties -{ -// The spatial parameters TypeTag -NEW_TYPE_TAG(RichardsTestSpatialParams); - -// Set the spatial parameters -SET_TYPE_PROP(RichardsTestSpatialParams, SpatialParams, RichardsTestSpatialParams<TypeTag>); - -// Set the material law -SET_PROP(RichardsTestSpatialParams, MaterialLaw) -{ -private: - // define the material law which is parameterized by effective - // saturations - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); -public: - // define the material law parameterized by absolute saturations - using type = EffToAbsLaw<VanGenuchten<Scalar>>; -}; -} // end namespace Properties - -/*! - * \ingroup RichardsModel - * \ingroup ImplicitTestProblems - * \brief The spatial parameters for the RichardsTestProblem - */ -template<class TypeTag> -class RichardsTestSpatialParams : public FVSpatialParams<TypeTag> -{ - using ParentType = FVSpatialParams<TypeTag>; - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - - enum { - dim=GridView::dimension, - dimWorld=GridView::dimensionworld - }; - - using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; - using MaterialLaw = typename GET_PROP_TYPE(TypeTag, MaterialLaw); - using MaterialLawParams = typename MaterialLaw::Params; - -public: - // export permeability type - using PermeabilityType = Scalar; - - /*! - * \brief Constructor - * - * \param gridView The DUNE GridView representing the spatial - * domain of the problem. - */ - RichardsTestSpatialParams(const Problem& problem, const GridView& gridView) - : ParentType(problem, gridView) - { - // residual saturations - materialParams_.setSwr(0.05); - materialParams_.setSnr(0.0); - - // parameters for the Van Genuchten law - // alpha and n - materialParams_.setVgAlpha(2.956e-4); - materialParams_.setVgn(1.5); - - permeability_ = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.Permeability); - } - - /*! - * \brief Returns the intrinsic permeability tensor [m^2] at a given location - * - * \param globalPos The global position where we evaluate - */ - PermeabilityType permeabilityAtPos(const GlobalPosition& globalPos) const - { return permeability_; } - - /*! - * \brief Returns the porosity [] at a given location - * - * \param globalPos The global position where we evaluate - */ - Scalar porosityAtPos(const GlobalPosition& globalPos) const - { return 0.4; } - - /*! - * \brief Returns the parameters for the material law at a given location - * - * This method is not actually required by the Richards model, but provided - * for the convenience of the RichardsLensProblem - * - * \param globalPos A global coordinate vector - */ - const MaterialLawParams& materialLawParamsAtPos(const GlobalPosition &globalPos) const - { return materialParams_; } - -private: - MaterialLawParams materialParams_; - Scalar permeability_; -}; - -} // end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p2c_richards2c/rootsystemtestproblem.hh b/test/mixeddimension/embedded/1p2c_richards2c/rootsystemtestproblem.hh deleted file mode 100644 index 34c2a914a9f01d6d296c937faeb0d9444bb505a9..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p2c_richards2c/rootsystemtestproblem.hh +++ /dev/null @@ -1,407 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief A sub problem for the rootsystem - */ -#ifndef DUMUX_ROOTSYSTEM_TEST_PROBLEM_HH -#define DUMUX_ROOTSYSTEM_TEST_PROBLEM_HH - -#include <cmath> - -#include <dune/grid/common/scsgmapper.hh> - -#include <dumux/implicit/cellcentered/tpfa/properties.hh> -#include <dumux/porousmediumflow/implicit/problem.hh> -#include <dumux/porousmediumflow/1p2c/implicit/model.hh> -#include <dumux/material/components/simpleh2o.hh> -#include <dumux/material/components/constant.hh> -#include <dumux/material/fluidsystems/liquidphase2c.hh> - -//! get the properties needed for subproblems -#include <dumux/mixeddimension/subproblemproperties.hh> - -#include "rootsystemtestspatialparams.hh" - -namespace Dumux -{ -template <class TypeTag> -class RootsystemTestProblem; - -namespace Properties -{ -NEW_TYPE_TAG(RootsystemTestProblem, INHERITS_FROM(OnePTwoC)); -NEW_TYPE_TAG(RootsystemTestBoxProblem, INHERITS_FROM(BoxModel, RootsystemTestProblem)); -NEW_TYPE_TAG(RootsystemTestCCProblem, INHERITS_FROM(CCTpfaModel, RootsystemTestProblem)); - -SET_PROP(RootsystemTestProblem, FluidSystem) -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using type = FluidSystems::LiquidPhaseTwoC<Scalar, SimpleH2O<Scalar>, Constant<TypeTag,Scalar>>; -}; - -// Set the grid type -SET_TYPE_PROP(RootsystemTestProblem, Grid, Dune::FoamGrid<1, 3>); - -SET_BOOL_PROP(RootsystemTestProblem, EnableFVGridGeometryCache, true); -SET_BOOL_PROP(RootsystemTestProblem, EnableGridVolumeVariablesCache, true); -SET_BOOL_PROP(RootsystemTestProblem, EnableGridFluxVariablesCache, true); -SET_BOOL_PROP(RootsystemTestProblem, SolutionDependentAdvection, false); -SET_BOOL_PROP(RootsystemTestProblem, SolutionDependentMolecularDiffusion, false); -SET_BOOL_PROP(RootsystemTestProblem, SolutionDependentHeatConduction, false); - -// Set the problem property -SET_TYPE_PROP(RootsystemTestProblem, Problem, RootsystemTestProblem<TypeTag>); - -// Set the spatial parameters -SET_TYPE_PROP(RootsystemTestProblem, SpatialParams, RootsystemTestSpatialParams<TypeTag>); - -// Enable gravity -SET_BOOL_PROP(RootsystemTestProblem, ProblemEnableGravity, true); - -// Enable velocity output -SET_BOOL_PROP(RootsystemTestProblem, VtkAddVelocity, true); - -// Use mole fractions -SET_BOOL_PROP(RootsystemTestProblem, UseMoles, true); -} - -/*! - * \ingroup OneDRootSystem - * \ingroup ImplicitTestProblems - * \brief TODO - */ -template <class TypeTag> -class RootsystemTestProblem : public ImplicitPorousMediaProblem<TypeTag> -{ - using ParentType = ImplicitPorousMediaProblem<TypeTag>; - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); - using PointSource = typename GET_PROP_TYPE(TypeTag, PointSource); - using VtkOutputModule = typename GET_PROP_TYPE(TypeTag, VtkOutputModule); - using Indices = typename GET_PROP_TYPE(TypeTag, Indices); - // copy some indices for convenience - enum { - // Grid and world dimension - dim = GridView::dimension, - dimworld = GridView::dimensionworld - }; - enum { - // indices of the primary variables - conti0EqIdx = Indices::conti0EqIdx, - transportEqIdx = Indices::transportEqIdx, - pressureIdx = Indices::pressureIdx, - massOrMoleFracIdx = Indices::massOrMoleFracIdx, - transportCompIdx = Indices::transportCompIdx - }; - - static const int wPhaseIdx = GET_PROP_VALUE(TypeTag, PhaseIdx); - - using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); - using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); - using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); - using Element = typename GridView::template Codim<0>::Entity; - using GlobalPosition = Dune::FieldVector<Scalar, dimworld>; - - using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); - using CouplingManager = typename GET_PROP_TYPE(GlobalProblemTypeTag, CouplingManager); - -public: - RootsystemTestProblem(TimeManager &timeManager, const GridView &gridView) - : ParentType(timeManager, gridView) - { - name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name) + "-root"; - } - /*! - * \name Problem parameters - */ - // \{ - - /*! - * \brief Return how much the domain is extruded at a given sub-control volume. - * - * The extrusion factor here makes extrudes the 1d line to a circular tube with - * cross-section area pi*r^2. - */ - Scalar extrusionFactor(const Element &element, - const SubControlVolume &scv, - const ElementSolutionVector& elemSol) const - { - const auto eIdx = this->gridView().indexSet().index(element); - const auto radius = this->spatialParams().radius(eIdx); - return M_PI*radius*radius; - } - - /*! - * \brief The problem name. - * - * This is used as a prefix for files generated by the simulation. - */ - const std::string& name() const - { - return name_; - } - - /*! - * \brief Return the temperature within the domain. - * - * This problem assumes a temperature of 10 degrees Celsius. - */ - Scalar temperature() const - { return 273.15 + 10; } // 10C - - - // \} - /*! - * \name Boundary conditions - */ - // \{ - - BoundaryTypes boundaryTypesAtPos (const GlobalPosition &globalPos ) const - { - BoundaryTypes bcTypes; - bcTypes.setAllNeumann(); - return bcTypes; - } - - - /*! - * \brief Specifies which kind of boundary condition should be - * used for which equation on a given boundary control volume. - * - * \param values The boundary types for the conservation equations - * \param globalPos The position of the center of the finite volume - */ - - /*! - * \brief Evaluate the boundary conditions for a dirichlet - * control volume. - * - * \param values The dirichlet values for the primary variables - * \param globalPos The center of the finite volume which ought to be set. - * - * For this method, the \a values parameter stores primary variables. - */ - PrimaryVariables dirichletAtPos(const GlobalPosition& globalPos) const - { - PrimaryVariables values(0.0); - if (globalPos[2] + eps_ > this->bBoxMax()[2] ) - { - values[pressureIdx] = GET_RUNTIME_PARAM(TypeTag, Scalar, BoundaryConditions.CriticalCollarPressure); - values[massOrMoleFracIdx] = 0.0; - } - - return values; - } - - /*! - * \brief Evaluate the boundary conditions for a neumann - * boundary segment. - * - * For this method, the \a priVars parameter stores the mass flux - * in normal direction of each component. Negative values mean - * influx. - */ - PrimaryVariables neumann(const Element& element, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolvars, - const SubControlVolumeFace& scvf) const - { - PrimaryVariables values(0.0); - if (scvf.center()[2] + eps_ > this->bBoxMax()[2]) - { - const auto& volVars = elemVolvars[scvf.insideScvIdx()]; - // conversion of transpiration rate from kg/s to mol/s - static const Scalar tr = GET_RUNTIME_PARAM(TypeTag, Scalar, BoundaryConditions.TranspirationRate); - const Scalar value = tr * volVars.molarDensity(wPhaseIdx)/volVars.density(wPhaseIdx); - values[conti0EqIdx] = value / volVars.extrusionFactor() / scvf.area(); - // use upwind mole fraction to get outflow condition for the tracer - values[transportEqIdx] = values[conti0EqIdx] - * volVars.moleFraction(wPhaseIdx, transportCompIdx); - } - return values; - - } - - // \} - - /*! - * \name Volume terms - */ - // \{ - - /*! - * \brief Evaluate the initial value for a control volume. - * - * For this method, the \a priVars parameter stores primary - * variables. - */ - PrimaryVariables initialAtPos(const GlobalPosition& globalPos) const - { - PrimaryVariables values(0.0); - values[pressureIdx] = GET_RUNTIME_PARAM(TypeTag, - Scalar, - BoundaryConditions.InitialRootPressure); - return values; - } - - /*! - * \brief Applies a vector of point sources. The point sources - * are possibly solution dependent. - * - * \param pointSources A vector of PointSource s that contain - source values for all phases and space positions. - * - * For this method, the \a values method of the point source - * has to return the absolute mass rate in kg/s. Positive values mean - * that mass is created, negative ones mean that it vanishes. - */ - void addPointSources(std::vector<PointSource>& pointSources) const - { pointSources = this->couplingManager().lowDimPointSources(); } - - /*! - * \brief Evaluate the point sources (added by addPointSources) - * for all phases within a given sub-control-volume. - * - * This is the method for the case where the point source is - * solution dependent and requires some quantities that - * are specific to the fully-implicit method. - * - * \param pointSource A single point source - * \param element The finite element - * \param fvGeometry The finite-volume geometry - * \param elemVolVars All volume variables for the element - * \param scv The sub-control volume within the element - * - * For this method, the \a values() method of the point sources returns - * the absolute rate mass generated or annihilate in kg/s. Positive values mean - * that mass is created, negative ones mean that it vanishes. - */ - void pointSource(PointSource& source, - const Element &element, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const SubControlVolume &scv) const - { - // compute source at every integration point - const auto& bulkVolVars = this->couplingManager().bulkVolVars(source.id()); - const auto& lowDimVolVars = elemVolVars[scv]; - - const unsigned int lowDimElementIdx = this->couplingManager().pointSourceData(source.id()).lowDimElementIdx(); - const Scalar Kr = this->spatialParams().Kr(lowDimElementIdx); - const Scalar rootRadius = this->spatialParams().radius(lowDimElementIdx); - - // sink defined as radial flow Jr * density [m^2 s-1]* [kg m-3] - PrimaryVariables sourceValues(0.0); - sourceValues[conti0EqIdx] = 2* M_PI *rootRadius * Kr *(bulkVolVars.pressure(wPhaseIdx) - lowDimVolVars.pressure(wPhaseIdx)) - *bulkVolVars.molarDensity(wPhaseIdx); - - //! advective transport over root wall - // compute correct upwind concentration - if (sourceValues[conti0EqIdx] < 0) - sourceValues[transportEqIdx] = sourceValues[conti0EqIdx] - * lowDimVolVars.moleFraction(wPhaseIdx, transportCompIdx); - else - sourceValues[transportEqIdx] = sourceValues[conti0EqIdx] - * bulkVolVars.moleFraction(wPhaseIdx, transportCompIdx); - - //! diffusive transport over root wall - sourceValues[transportEqIdx] += 2* M_PI *rootRadius * 1.0e-8 - *(bulkVolVars.moleFraction(wPhaseIdx, transportCompIdx) - lowDimVolVars.moleFraction(wPhaseIdx, transportCompIdx)) - *0.5*(bulkVolVars.molarDensity(wPhaseIdx) + lowDimVolVars.molarDensity(wPhaseIdx)); - - sourceValues *= source.quadratureWeight()*source.integrationElement(); - source = sourceValues; - } - - //! Called after every time step - //! Output the total global exchange term - void postTimeStep() - { - ParentType::postTimeStep(); - - PrimaryVariables source(0.0); - - if (!(this->timeManager().time() < 0.0)) - { - for (const auto& element : elements(this->gridView())) - { - auto fvGeometry = localView(this->model().fvGridGeometry()); - fvGeometry.bindElement(element); - - auto elemVolVars = localView(this->model().curGridVolVars()); - elemVolVars.bindElement(element, fvGeometry, this->model().curSol()); - - for (auto&& scv : scvs(fvGeometry)) - { - const auto& volVars = elemVolVars[scv]; - auto pointSources = this->scvPointSources(element, fvGeometry, elemVolVars, scv); - // conversion to kg/s - pointSources *= scv.volume()*volVars.extrusionFactor() - * volVars.density(wPhaseIdx) / volVars.molarDensity(wPhaseIdx); - source += pointSources; - } - } - } - - std::cout << "Global integrated source (root): " << source[conti0EqIdx] << " (kg/s) / " - << source[conti0EqIdx]*3600*24*1000 << " (g/day)" << '\n'; - } - - bool shouldWriteRestartFile() const - { - return false; - } - - /*! - * \brief Adds additional VTK output data to the VTKWriter. Function is called by the output module on every write. - */ - void addVtkOutputFields(VtkOutputModule& outputModule) const - { - auto& r = outputModule.createScalarField("radius", 0); - for (const auto& element : elements(this->gridView())) - { - auto dofIndex = this->elementMapper().index(element); - r[dofIndex] = this->spatialParams().radius(dofIndex); - } - } - - //! Set the coupling manager - void setCouplingManager(std::shared_ptr<CouplingManager> cm) - { couplingManager_ = cm; } - - //! Get the coupling manager - const CouplingManager& couplingManager() const - { return *couplingManager_; } - -private: - std::string name_; - const Scalar eps_ = 1e-9; - std::shared_ptr<CouplingManager> couplingManager_; -}; - -} //end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p2c_richards2c/rootsystemtestspatialparams.hh b/test/mixeddimension/embedded/1p2c_richards2c/rootsystemtestspatialparams.hh deleted file mode 100644 index a74c09783b5d813aaa7cc9d7897f5ac2a3118665..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p2c_richards2c/rootsystemtestspatialparams.hh +++ /dev/null @@ -1,210 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief The spatial parameters class for the root system test problem - */ -#ifndef DUMUX_ROOTSYSTEM_TEST_SPATIALPARAMS_HH -#define DUMUX_ROOTSYSTEM_TEST_SPATIALPARAMS_HH - -#include <dumux/material/spatialparams/fv1p.hh> -#include <dumux/material/components/simpleh2o.hh> - -namespace Dumux -{ - -/*! - * \ingroup OnePModel - * \ingroup ImplicitTestProblems - * - * \brief Definition of the spatial parameters for the root system test problem - */ -template<class TypeTag> -class RootsystemTestSpatialParams: public FVSpatialParamsOneP<TypeTag> -{ - using ParentType = FVSpatialParamsOneP<TypeTag>; - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using GridCreator = typename GET_PROP_TYPE(TypeTag, GridCreator); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem); - using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); - using Indices = typename GET_PROP_TYPE(TypeTag, Indices); - enum { - // Grid and world dimension - dim = GridView::dimension, - dimworld = GridView::dimensionworld - }; - using GlobalPosition = Dune::FieldVector<Scalar, dimworld>; - - struct RootParams - { - Scalar radius; - Scalar surface; - Scalar axialPerm; - Scalar radialPerm; - int order; - int branchId; - Scalar mass; - }; - -public: - // export permeability type - using PermeabilityType = Scalar; - - RootsystemTestSpatialParams(const Problem& problem, const GridView& gridView) - : ParentType(problem, gridView), gridView_(gridView) - { - Kx_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, Kx); - Kr_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, Kr); - - rootParams_.resize(problem.gridView().size(0)); - for (const auto& element : elements(problem.gridView())) - { - auto eIdx = problem.gridView().indexSet().index(element); - auto level0element = element; - for(auto levelIdx = element.level(); levelIdx != 0; levelIdx--) - level0element = level0element.father(); - Scalar rootLength = element.geometry().volume(); - Scalar rootSurface = GridCreator::parameters(level0element)[2]/(1 << element.level()); - - rootParams_[eIdx].radius = rootSurface / rootLength / 2.0 / M_PI; - rootParams_[eIdx].order = GridCreator::parameters(level0element)[0]; - // root branch -> count from 0!! - rootParams_[eIdx].branchId = GridCreator::parameters(level0element)[1] -1; - rootParams_[eIdx].surface = rootSurface; - rootParams_[eIdx].mass = GridCreator::parameters(level0element)[3]; - - if ((int)rootParams_[eIdx].order == 1) - { - rootParams_[eIdx].axialPerm = Kx_; //Kx - rootParams_[eIdx].radialPerm = Kr_; //Kr - } - else if ((int)rootParams_[eIdx].order == 2) - { - rootParams_[eIdx].axialPerm = Kx_; //Kx - rootParams_[eIdx].radialPerm = Kr_; //Kr - } - else //order >= 3 - { - rootParams_[eIdx].axialPerm = Kx_; //Kx - rootParams_[eIdx].radialPerm = Kr_; //Kr - } - } - } - - /*! - * \brief Return the intrinsic permeability for the current sub-control volume in [m^2]. - * - * \param ipGlobal The integration point - * \note Kx has units [m^4/(Pa*s)] so we have to divide by the cross-section area - * and multiply with a characteristic viscosity - */ - PermeabilityType permeability(const Element& element, - const SubControlVolume& scv, - const ElementSolutionVector& elemSol) const - { - const Scalar r = rootParams(element).radius; - return Kx_ / (M_PI*r*r) * SimpleH2O<Scalar>::liquidViscosity(285.15, elemSol[0][Indices::pressureIdx]); - } - - /*! - * \brief Return the radius of the circular pipe for the current sub-control volume in [m]. - * - * \param the index of the element - */ - Scalar radius(unsigned int eIdxGlobal) const - { - return rootParams_[eIdxGlobal].radius; - } - - Scalar rootSurface(unsigned int eIdxGlobal) const - { - return rootParams_[eIdxGlobal].surface; - } - - Scalar Kr(unsigned int eIdxGlobal) const - { - return rootParams_[eIdxGlobal].radialPerm; - } - - Scalar rootOrder(unsigned int eIdxGlobal) const - { - return rootParams_[eIdxGlobal].order; - } - - Scalar rootBranch(unsigned int eIdxGlobal) const - { - return rootParams_[eIdxGlobal].branchId; - } - - Scalar rootMass(unsigned int eIdxGlobal) const - { - return rootParams_[eIdxGlobal].mass; - } - - RootParams& rootParams(const Element &element) - { - auto eIdx = gridView_.indexSet().index(element); - return rootParams_[eIdx]; - } - const RootParams& rootParams(const Element &element) const - { - auto eIdx = gridView_.indexSet().index(element); - return rootParams_[eIdx]; - } - - /*! - * \brief Returns the porosity \f$[-]\f$ - * - * \param element The element - * \param scv The sub control volume - * \param elemSol The element solution vector - * \return the porosity - */ - Scalar porosity(const Element& element, - const SubControlVolume& scv, - const ElementSolutionVector& elemSol) const - { return 0.4; } - - /*! - * \brief Returns the dispersivity at a given location - * - * \param element The element - * \param scv The sub control volume - * \param elemSol The element solution vector - * \return the dispersivity - */ - Scalar dispersivity(const Element& element, - const SubControlVolume scv, - const ElementSolutionVector& elemSol) const - { return 0.0; } - -private: - std::vector<RootParams> rootParams_; - Scalar Kx_, Kr_; - GridView gridView_; -}; - -} // end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p2c_richards2c/rositestproblem.hh b/test/mixeddimension/embedded/1p2c_richards2c/rositestproblem.hh deleted file mode 100644 index 9af7478dbf81fa0a164ac75aebc92c697cc37d45..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p2c_richards2c/rositestproblem.hh +++ /dev/null @@ -1,227 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief A test problem the rootsystem coupled with richards in the bulk - */ -#ifndef DUMUX_ROSI_TEST_PROBLEM_HH -#define DUMUX_ROSI_TEST_PROBLEM_HH - -#include "rootsystemtestproblem.hh" -#include "richardstestproblem.hh" - -#include <dumux/mixeddimension/problem.hh> -#include <dumux/mixeddimension/embedded/cellcentered/bboxtreecouplingmanager.hh> -#include <dumux/mixeddimension/embedded/cellcentered/bboxtreecouplingmanagersimple.hh> -#include <dumux/mixeddimension/integrationpointsource.hh> - -#include "schursolver.hh" - -namespace Dumux -{ -template <class TypeTag> -class RosiTestProblem; - -namespace Properties -{ -NEW_TYPE_TAG(RosiTestProblem, INHERITS_FROM(MixedDimension)); - -// Set the problem property -SET_TYPE_PROP(RosiTestProblem, Problem, Dumux::RosiTestProblem<TypeTag>); - -// Set the coupling manager -//SET_TYPE_PROP(RosiTestProblem, CouplingManager, Dumux::CCBBoxTreeEmbeddedCouplingManager<TypeTag>); -SET_TYPE_PROP(RosiTestProblem, CouplingManager, Dumux::CCBBoxTreeEmbeddedCouplingManagerSimple<TypeTag>); - -// Set the two sub-problems of the global problem -SET_TYPE_PROP(RosiTestProblem, LowDimProblemTypeTag, TTAG(RootsystemTestCCProblem)); -SET_TYPE_PROP(RosiTestProblem, BulkProblemTypeTag, TTAG(RichardsTestCCProblem)); - -// publish this problem in the sub problems -SET_TYPE_PROP(RootsystemTestCCProblem, GlobalProblemTypeTag, TTAG(RosiTestProblem)); -SET_TYPE_PROP(RichardsTestCCProblem, GlobalProblemTypeTag, TTAG(RosiTestProblem)); - -// The subproblems inherit the parameter tree from this problem -SET_PROP(RootsystemTestCCProblem, ParameterTree) : GET_PROP(TTAG(RosiTestProblem), ParameterTree) {}; -SET_PROP(RichardsTestCCProblem, ParameterTree) : GET_PROP(TTAG(RosiTestProblem), ParameterTree) {}; - -// Set the point source type of the subproblems to an integration point source -SET_TYPE_PROP(RootsystemTestCCProblem, PointSource, Dumux::IntegrationPointSource<TTAG(RootsystemTestCCProblem), unsigned int>); -SET_TYPE_PROP(RootsystemTestCCProblem, PointSourceHelper, Dumux::IntegrationPointSourceHelper<TTAG(RootsystemTestCCProblem)>); -SET_TYPE_PROP(RichardsTestCCProblem, PointSource, Dumux::IntegrationPointSource<TTAG(RichardsTestCCProblem), unsigned int>); -SET_TYPE_PROP(RichardsTestCCProblem, PointSourceHelper, Dumux::IntegrationPointSourceHelper<TTAG(RichardsTestCCProblem)>); - -SET_TYPE_PROP(RosiTestProblem, LinearSolver, BlockILU0BiCGSTABSolver<TypeTag>); - -}//end namespace properties - -template <class TypeTag> -class RosiTestProblem : public MixedDimensionProblem<TypeTag> -{ - using ParentType = MixedDimensionProblem<TypeTag>; - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - - // obtain the type tags of the sub problems - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - // obtain types from the sub problem type tags - using BulkProblem = typename GET_PROP_TYPE(BulkProblemTypeTag, Problem); - using LowDimProblem = typename GET_PROP_TYPE(LowDimProblemTypeTag, Problem); - - using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); - using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); - - using BulkIndices = typename GET_PROP_TYPE(BulkProblemTypeTag, Indices); - using LowDimIndices = typename GET_PROP_TYPE(LowDimProblemTypeTag, Indices); - - using LowDimFluidSystem = typename GET_PROP_TYPE(LowDimProblemTypeTag, FluidSystem); - - enum { - // indices of the primary variables - wPhaseIdx = BulkIndices::wPhaseIdx, - transportCompIdx = BulkIndices::compMainIdx + 1, - transportEqIdx = BulkIndices::conti0EqIdx + 1 - }; - -public: - RosiTestProblem(TimeManager &timeManager, const BulkGridView &bulkGridView, const LowDimGridView &lowDimgridView) - : ParentType(timeManager, bulkGridView, lowDimgridView) - { - accumulatedBoundaryFlux_ = 0.0; - } - - void preTimeStep() - { - ParentType::preTimeStep(); - std::cout << '\n' << "\033[1m" << "Simulation time in hours: " << this->timeManager().time()/3600 << "\033[0m" << '\n'; - } - - void init() - { - ParentType::init(); - - // compute the mass in the entire domain to make sure the tracer is conserved - Scalar bulkmass = 0.0; - Scalar lowdimmass = 0.0; - - // low dim elements - for (const auto& element : elements(this->lowDimProblem().gridView())) - { - auto fvGeometry = localView(this->lowDimProblem().model().fvGridGeometry()); - fvGeometry.bindElement(element); - - auto elemVolVars = localView(this->lowDimProblem().model().curGridVolVars()); - elemVolVars.bindElement(element, fvGeometry, this->lowDimProblem().model().curSol()); - - for (auto&& scv : scvs(fvGeometry)) - { - const auto& volVars = elemVolVars[scv]; - lowdimmass += volVars.massFraction(wPhaseIdx, transportCompIdx)*volVars.density(wPhaseIdx) - *scv.volume() * volVars.porosity() * volVars.saturation(wPhaseIdx) * volVars.extrusionFactor(); - } - } - - // bulk elements - for (const auto& element : elements(this->bulkProblem().gridView())) - { - auto fvGeometry = localView(this->bulkProblem().model().fvGridGeometry()); - fvGeometry.bindElement(element); - - auto elemVolVars = localView(this->bulkProblem().model().curGridVolVars()); - elemVolVars.bindElement(element, fvGeometry, this->bulkProblem().model().curSol()); - - for (auto&& scv : scvs(fvGeometry)) - { - const auto& volVars = elemVolVars[scv]; - bulkmass += volVars.massFraction(wPhaseIdx, transportCompIdx)*volVars.density(wPhaseIdx) - * scv.volume() * volVars.porosity() * volVars.saturation(wPhaseIdx) * volVars.extrusionFactor(); - } - } - - std::cout << "\033[1;33m" << "The domain initially contains " << (lowdimmass + bulkmass)*1e9 << " µg tracer" - << " (root: " << lowdimmass*1e9 << ", soil: " << bulkmass*1e9 << ")\033[0m" << '\n'; - } - - void postTimeStep() - { - ParentType::postTimeStep(); - - // compute the mass in the entire domain to make sure the tracer is conserved - Scalar bulkmass = 0.0; - Scalar lowdimmass = 0.0; - - // low dim elements - for (const auto& element : elements(this->lowDimProblem().gridView())) - { - auto fvGeometry = localView(this->lowDimProblem().model().fvGridGeometry()); - fvGeometry.bindElement(element); - - auto elemVolVars = localView(this->lowDimProblem().model().curGridVolVars()); - elemVolVars.bindElement(element, fvGeometry, this->lowDimProblem().model().curSol()); - - for (auto&& scv : scvs(fvGeometry)) - { - const auto& volVars = elemVolVars[scv]; - lowdimmass += volVars.massFraction(wPhaseIdx, transportCompIdx)*volVars.density(wPhaseIdx) - *scv.volume() * volVars.porosity() * volVars.saturation(wPhaseIdx) * volVars.extrusionFactor(); - } - - for (auto&& scvf : scvfs(fvGeometry)) - if (scvf.boundary()) - accumulatedBoundaryFlux_ += this->lowDimProblem().neumann(element, fvGeometry, elemVolVars, scvf)[transportEqIdx] - * scvf.area() * elemVolVars[scvf.insideScvIdx()].extrusionFactor() - * LowDimFluidSystem::molarMass(transportCompIdx) - * this->timeManager().timeStepSize(); - - } - - // bulk elements - for (const auto& element : elements(this->bulkProblem().gridView())) - { - auto fvGeometry = localView(this->bulkProblem().model().fvGridGeometry()); - fvGeometry.bindElement(element); - - auto elemVolVars = localView(this->bulkProblem().model().curGridVolVars()); - elemVolVars.bindElement(element, fvGeometry, this->bulkProblem().model().curSol()); - - for (auto&& scv : scvs(fvGeometry)) - { - const auto& volVars = elemVolVars[scv]; - bulkmass += volVars.massFraction(wPhaseIdx, transportCompIdx)*volVars.density(wPhaseIdx) - * scv.volume() * volVars.porosity() * volVars.saturation(wPhaseIdx) * volVars.extrusionFactor(); - } - } - - std::cout << "\033[1;33m" << "The domain contains " << (lowdimmass + bulkmass)*1e9 << " µg tracer" - << " (root: " << lowdimmass*1e9 << ", soil: " << bulkmass*1e9 << ")\033[0m" << '\n'; - - std::cout << "\033[1;33m" << accumulatedBoundaryFlux_*1e9 << " µg left domain over the root collar -> " - << ((lowdimmass + bulkmass) + accumulatedBoundaryFlux_)*1e9 << " µg balanced.\033[0m" << '\n'; - } - -private: - Scalar accumulatedBoundaryFlux_; -}; - -} // end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p2c_richards2c/schursolver.hh b/test/mixeddimension/embedded/1p2c_richards2c/schursolver.hh deleted file mode 100644 index 5bf3d797e253ac69f07fa5cfa53932393fd0dc35..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p2c_richards2c/schursolver.hh +++ /dev/null @@ -1,375 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \brief Schur complement solver for the embedded problem, the idea is to solve - * only linear systems of the size of the much smaller embedded domain by - * forming a Schur complement preconditioner. If the embedded system is much - * smaller it might be feasible to just use a direct solver. - */ -#ifndef DUMUX_EMBEDDED_SCHUR_COMPLEMENT_SOLVER_BACKEND_HH -#define DUMUX_EMBEDDED_SCHUR_COMPLEMENT_SOLVER_BACKEND_HH - -#include <dune/istl/preconditioners.hh> -#include <dune/istl/solvers.hh> -#include <dune/istl/superlu.hh> -#include <dune/istl/umfpack.hh> - -#include <dumux/common/parameters.hh> -#include <dumux/common/basicproperties.hh> - -#include <dune/istl/paamg/amg.hh> -#include <dune/istl/paamg/pinfo.hh> -#include <dumux/linear/amgproperties.hh> - -namespace Dumux { - -/*! - \brief Schur complement linear operator - this applies the Schur complement to a vector and can be used in an inverse operator -*/ -template<class AType, class BType, class CType, class DType, class InvOpDType, class X, class Y> -class SchurComplement : public Dune::LinearOperator<X,Y> -{ -public: - // export types - // using matrix_type = DType; - using domain_type = X; - using range_type = Y; - using field_type = typename X::field_type; - - //! constructor: just store a reference to a matrix - explicit SchurComplement (const AType& A, const BType& B, - const CType& C, const DType& D, - const std::shared_ptr<InvOpDType>& invD) - : A_(A), B_(B), C_(C), D_(D), invD_(invD) {} - - //! apply operator to x: \f$ y = A(x) \f$ - virtual void apply (const X& x, Y& y) const - { - // apply C, note x and aTmp1 have different size (Cx) - X aTmp1(D_.N()); - aTmp1 = 0.0; - C_.mv(x, aTmp1); - - // apply D^-1 (D^-1Cx) - auto aTmp2 = aTmp1; - Dune::InverseOperatorResult result; - invD_->apply(aTmp2, aTmp1, result); - - // apply B (BD^-1Cx) - B_.mv(aTmp2, y); - - y *= -1.0; - - // add Ax (Ax - BD^-1Cx) -> the full Schur complement of S_D := D/M - A_.umv(x, y); - } - - //! apply operator to x, scale and add: \f$ y = y + \alpha A(x) \f$ - virtual void applyscaleadd (field_type alpha, const X& x, Y& y) const - { - auto tmp = y; - this->apply(x, tmp); - y.axpy(alpha, tmp); - } - - //! Category of the preconditioner (see SolverCategory::Category) - virtual Dune::SolverCategory::Category category() const - { - return Dune::SolverCategory::sequential; - } - - private: - const AType& A_; - const BType& B_; - const CType& C_; - const DType& D_; - std::shared_ptr<InvOpDType> invD_; -}; - -/*! \brief The schur complement preconditioner - - \tparam M The matrix type to operate on - \tparam X Type of the update - \tparam Y Type of the defect - \tparam l The block level to invert. Default is 1 -*/ -template<class TypeTag, class AType, class BType, class CType, class DType, class InvOpDType, class X, class Y> -class SchurComplementPreconditioner : public Dune::Preconditioner<X, Y> -{ -public: - //! \brief The matrix type the preconditioner is for. - // using matrix_type = M; - //! \brief The domain type of the preconditioner. - using domain_type = X; - //! \brief The range type of the preconditioner. - using range_type = Y; - //! \brief The field type of the preconditioner. - using field_type = typename X::field_type; - - using BulkVector = typename GET_PROP(TypeTag, SolutionVector)::SolutionVectorBulk; - using EmbeddedVector = typename GET_PROP(TypeTag, SolutionVector)::SolutionVectorLowDim; - - /*! \brief Approximates the Schur complement - */ - SchurComplementPreconditioner (const AType& A, const BType& B, - const CType& C, const DType& D, - const std::shared_ptr<InvOpDType>& invD) - : A_(A), B_(B), C_(C), D_(D), invD_(invD) {} - - - virtual void pre (X& x, Y& b) - { - DUNE_UNUSED_PARAMETER(x); - DUNE_UNUSED_PARAMETER(b); - } - - /*! - \brief Apply the preconditioner. - - \copydoc Preconditioner::apply(X&,const Y&) - */ - virtual void apply (X& x, const Y& b) - { - using namespace Dune::Indices; - const BulkVector& f = b[_0]; - const EmbeddedVector& g = b[_1]; - - static const int verbosity = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, int, LinearSolver, PreconditionerVerbosity); - static const int schurMaxIter = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, int, LinearSolver, SchurIterations); - static const double schurReduction = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, double, LinearSolver, SchurResidualReduction); - - Dune::Richardson<BulkVector, BulkVector> identity(1.0); - SchurComplement<AType, BType, CType, DType, InvOpDType, BulkVector, BulkVector> schurOp(A_, B_, C_, D_, invD_); - Dune::BiCGSTABSolver<BulkVector> invOpS(schurOp, identity, schurReduction, schurMaxIter, verbosity); - - // apply S^-1 to solve the bulk block - BulkVector fTmp(f); - Dune::InverseOperatorResult res; - invOpS.apply(x[_0], fTmp, res); - - // prepare rhs for application of D^-1 (g - Ca) - EmbeddedVector gTmp(g); - C_.mmv(x[_0], gTmp); - - // then solve for embedded block b using the action of D^-1 - // use direct solver - invD_->apply(x[_1], gTmp, res); - } - - virtual void post (X& x) - { DUNE_UNUSED_PARAMETER(x); } - - //! Category of the preconditioner (see SolverCategory::Category) - virtual Dune::SolverCategory::Category category() const - { return Dune::SolverCategory::sequential; } - -private: - const AType& A_; - const BType& B_; - const CType& C_; - const DType& D_; - std::shared_ptr<InvOpDType> invD_; -}; - -template <class TypeTag> -class SchurComplementSolver -{ - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - -public: - SchurComplementSolver() = default; - SchurComplementSolver(const Problem& problem) {} - - // expects a system as a multi-type matrix - // | A B | - // | C D | - - // Solve saddle-point problem using a Schur complement based preconditioner - template<class Matrix, class Vector> - bool solve(const Matrix& M, Vector& x, const Vector& b) - { - int verbosity = GET_PARAM_FROM_GROUP(TypeTag, int, LinearSolver, Verbosity); - static const double reduction = GET_PARAM_FROM_GROUP(TypeTag, double, LinearSolver, ResidualReduction); - static const double maxIter = GET_PARAM_FROM_GROUP(TypeTag, double, LinearSolver, MaxIterations); - static const int restartGMRes = GET_PARAM_FROM_GROUP(TypeTag, double, LinearSolver, GMResRestart); - - using AType = typename GET_PROP(TypeTag, JacobianMatrix)::MatrixBlockBulk; - using BType = typename GET_PROP(TypeTag, JacobianMatrix)::MatrixBlockBulkCoupling; - using CType = typename GET_PROP(TypeTag, JacobianMatrix)::MatrixBlockLowDimCoupling; - using DType = typename GET_PROP(TypeTag, JacobianMatrix)::MatrixBlockLowDim; - - using namespace Dune::Indices; - const AType& A = M[_0][_0]; - const BType& B = M[_0][_1]; - const CType& C = M[_1][_0]; - const DType& D = M[_1][_1]; - - // Solver to compute applications of D^-1 used in the preconditioner - // We construct it here so e.g. LU decomposition is only done once - using InnerSolver = Dune::UMFPack<DType>; - auto invD = std::make_shared<InnerSolver>(D, false); - - SchurComplementPreconditioner<TypeTag, AType, BType, CType, DType, InnerSolver, Vector, Vector> preconditioner(A, B, C, D, invD); - - Dune::MatrixAdapter<Matrix, Vector, Vector> op(M); - Dune::RestartedfGMResSolver<Vector> solver(op, preconditioner, reduction, restartGMRes, maxIter, verbosity); - auto bTmp(b); - solver.apply(x, bTmp, result_); - - return true; - } - - const Dune::InverseOperatorResult& result() const - { - return result_; - } - -private: - Dune::InverseOperatorResult result_; -}; - - -template<class FirstBlock, class FirstX, class FirstY, - class SecondBlock, class SecondX, class SecondY, - class X, class Y> -class BlockILU0Preconditioner : public Dune::Preconditioner<X, Y> -{ -public: - //! \brief The matrix type the preconditioner is for. - // using matrix_type = typename std::remove_const<M>::type; - //! \brief The domain type of the preconditioner. - using domain_type = X; - //! \brief The range type of the preconditioner. - using range_type = Y; - //! \brief The field type of the preconditioner. - using field_type = typename X::field_type; - - /*! \brief Constructor. - - Constructor gets all parameters to operate the prec. - \param A The matrix to operate on. - \param w The relaxation factor. - */ - BlockILU0Preconditioner (const FirstBlock& A, const SecondBlock& B) - : firstILU_(A, 1.0), secondILU_(B, 1.0) // does ILU decomposition - {} - - /*! - \brief Prepare the preconditioner. - - \copydoc Preconditioner::pre(X&,Y&) - */ - virtual void pre (X& x, Y& b) - { - DUNE_UNUSED_PARAMETER(x); - DUNE_UNUSED_PARAMETER(b); - } - - /*! - \brief Apply the preconditoner. - - \copydoc Preconditioner::apply(X&,const Y&) - */ - virtual void apply (X& v, const Y& d) - { - using namespace Dune::Indices; - firstILU_.apply(v[_0], d[_0]); - secondILU_.apply(v[_1], d[_1]); - } - - /*! - \brief Clean up. - - \copydoc Preconditioner::post(X&) - */ - virtual void post (X& x) - { - DUNE_UNUSED_PARAMETER(x); - } - - //! Category of the preconditioner (see SolverCategory::Category) - virtual Dune::SolverCategory::Category category() const - { - return Dune::SolverCategory::sequential; - } - - private: - Dune::SeqILU0<FirstBlock, FirstX, FirstY> firstILU_; - Dune::SeqILU0<SecondBlock, SecondX, SecondY> secondILU_; -}; - -template <class TypeTag> -class BlockILU0BiCGSTABSolver -{ - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - -public: - BlockILU0BiCGSTABSolver() = default; - BlockILU0BiCGSTABSolver(const Problem& problem) {} - - // expects a system as a multi-type matrix - // | A B | - // | C D | - - // Solve saddle-point problem using a Schur complement based preconditioner - template<class Matrix, class Vector> - bool solve(const Matrix& M, Vector& x, const Vector& b) - { - int verbosity = GET_PARAM_FROM_GROUP(TypeTag, int, LinearSolver, Verbosity); - static const double reduction = GET_PARAM_FROM_GROUP(TypeTag, double, LinearSolver, ResidualReduction); - static const double maxIter = GET_PARAM_FROM_GROUP(TypeTag, double, LinearSolver, MaxIterations); - - using AType = typename GET_PROP(TypeTag, JacobianMatrix)::MatrixBlockBulk; - using DType = typename GET_PROP(TypeTag, JacobianMatrix)::MatrixBlockLowDim; - - using BulkVector = typename GET_PROP(TypeTag, SolutionVector)::SolutionVectorBulk; - using EmbeddedVector = typename GET_PROP(TypeTag, SolutionVector)::SolutionVectorLowDim; - - using namespace Dune::Indices; - const AType& A = M[_0][_0]; - const DType& D = M[_1][_1]; - - // Solver to compute applications of D^-1 used in the preconditioner - // We construct it here so e.g. LU decomposition is only done once - using InnerSolver = Dune::UMFPack<DType>; - auto invD = std::make_shared<InnerSolver>(D, false); - - BlockILU0Preconditioner<AType, BulkVector, BulkVector, DType, EmbeddedVector, EmbeddedVector, Vector, Vector> preconditioner(A, D); - Dune::MatrixAdapter<Matrix, Vector, Vector> op(M); - Dune::BiCGSTABSolver<Vector> solver(op, preconditioner, reduction, maxIter, verbosity); - auto bTmp(b); - solver.apply(x, bTmp, result_); - - return result_.converged; - } - - const Dune::InverseOperatorResult& result() const - { - return result_; - } - -private: - Dune::InverseOperatorResult result_; -}; - -} // end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p2c_richards2c/start.hh b/test/mixeddimension/embedded/1p2c_richards2c/start.hh deleted file mode 100644 index 4678f103dae2237fe8385ea5b5cdf116e194a727..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p2c_richards2c/start.hh +++ /dev/null @@ -1,264 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * \ingroup EmbeddedCoupling - * \brief Provides a starting algorithm (a default main function) for multidimension problems - */ -#ifndef DUMUX_START_EMBEDDED_MIXEDDIMENSION_HH -#define DUMUX_START_EMBEDDED_MIXEDDIMENSION_HH - -#include <ctime> -#include <iostream> - -#include <dune/common/parallel/mpihelper.hh> -#include <dune/grid/io/file/dgfparser/dgfexception.hh> - -#include <dumux/common/properties.hh> -#include <dumux/common/parameters.hh> -#include <dumux/common/dumuxmessage.hh> -#include <dumux/common/defaultusagemessage.hh> -#include <dumux/common/boundingboxtree.hh> -#include <dumux/mixeddimension/glue/glue.hh> - -namespace Dumux -{ -// forward declaration of property tags -namespace Properties -{ -NEW_PROP_TAG(LowDimProblemTypeTag); -NEW_PROP_TAG(BulkProblemTypeTag); -} - -template <class TypeTag> -int start_(int argc, - char **argv, - void (*usage)(const char *, const std::string &)) -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using ParameterTree = typename GET_PROP(TypeTag, ParameterTree); - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - using BulkGridCreator = typename GET_PROP_TYPE(BulkProblemTypeTag, GridCreator); - using LowDimGridCreator= typename GET_PROP_TYPE(LowDimProblemTypeTag, GridCreator); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - - // initialize MPI, finalize is done automatically on exit - const auto& mpiHelper = Dune::MPIHelper::instance(argc, argv); - - // print dumux start message - if (mpiHelper.rank() == 0) - DumuxMessage::print(/*firstCall=*/true); - - //////////////////////////////////////////////////////////// - // parse the command line arguments and input file - //////////////////////////////////////////////////////////// - - // if the user just wanted to see the help / usage message show usage and stop program - if(!ParameterParser::parseCommandLineArguments(argc, argv, ParameterTree::tree(), usage)) - { - usage(argv[0], defaultUsageMessage(argv[0])); - return 0; - } - - // parse the input file into the parameter tree - // check first if the user provided an input file through the command line, if not use the default - const auto parameterFileName = ParameterTree::tree().hasKey("ParameterFile") ? GET_RUNTIME_PARAM(TypeTag, std::string, ParameterFile) : ""; - ParameterParser::parseInputFile(argc, argv, ParameterTree::tree(), parameterFileName, usage); - - //////////////////////////////////////////////////////////// - // check for some user debugging parameters - //////////////////////////////////////////////////////////// - - bool printProps = false; // per default don't print all properties - if (ParameterTree::tree().hasKey("PrintProperties") || ParameterTree::tree().hasKey("TimeManager.PrintProperties")) - printProps = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, bool, TimeManager, PrintProperties); - - if (printProps && mpiHelper.rank() == 0) - Properties::print<TypeTag>(); - - bool printParams = true; // per default print all properties - if (ParameterTree::tree().hasKey("PrintParameters") || ParameterTree::tree().hasKey("TimeManager.PrintParameters")) - printParams = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, bool, TimeManager, PrintParameters); - - ////////////////////////////////////////////////////////////////////// - // try to create a grid (from the given grid file or the input file) - ///////////////////////////////////////////////////////////////////// - - try { BulkGridCreator::makeGrid(); } - catch (...) { - std::string usageMessage = "\n\t -> Creation of the bulk grid failed! <- \n\n"; - usageMessage += defaultUsageMessage(argv[0]); - usage(argv[0], usageMessage); - throw; - } - BulkGridCreator::loadBalance(); - - try { LowDimGridCreator::makeGrid(); } - catch (...) { - std::string usageMessage = "\n\t -> Creation of the low dim grid failed! <- \n\n"; - usageMessage += defaultUsageMessage(argv[0]); - usage(argv[0], usageMessage); - throw; - } - LowDimGridCreator::loadBalance(); - - const auto& bulkGridView = BulkGridCreator::grid().leafGridView(); - const auto& lowDimGridView = LowDimGridCreator::grid().leafGridView(); - - ////////////////////////////////////////////////////////////////////// - // run the simulation - ///////////////////////////////////////////////////////////////////// - - // read the initial time step and the end time (mandatory parameters) - auto tEnd = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, TEnd); - auto dt = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, DtInitial); - - // check if we are about to restart a previously interrupted simulation - bool restart = false; - Scalar restartTime = 0; - if (ParameterTree::tree().hasKey("Restart") || ParameterTree::tree().hasKey("TimeManager.Restart")) - { - restart = true; - restartTime = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, TimeManager, Restart); - } - - // instantiate and run the concrete problem - TimeManager timeManager; - Problem problem(timeManager, bulkGridView, lowDimGridView); - - //locally refine levels deep around the embedded grid - int levels = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, int, SoilGrid, LocalRefinement); - for (int i = 0; i < levels; ++i) - { - CCMultiDimensionGlue<TypeTag> glue(problem.bulkProblem(), problem.lowDimProblem()); - glue.build(); - - // refine all 3D cells intersected - for (const auto& is : intersections(glue)) - { - for (unsigned int outsideIdx = 0; outsideIdx < is.neighbor(0); ++outsideIdx) - { - const auto cutElement = is.outside(outsideIdx); - - // mark the cut element and all it's neighbors - BulkGridCreator::grid().mark(1, cutElement); - for (const auto& intersection : intersections(bulkGridView, cutElement)) - if (intersection.neighbor()) - BulkGridCreator::grid().mark(1, intersection.outside()); - } - - } - - // refine all 3D cells that are where the contamination is - for (const auto& element : elements(bulkGridView)) - { - const auto globalPos = element.geometry().center(); - auto contaminationPos = problem.bulkProblem().bBoxMax()-problem.bulkProblem().bBoxMin(); - contaminationPos[0] *= 0.25; - contaminationPos[1] *= 0.55; - contaminationPos[2] *= 0.25; - contaminationPos += problem.bulkProblem().bBoxMin(); - - static const Scalar extend = 0.15*(problem.bulkProblem().bBoxMax()[0]-problem.bulkProblem().bBoxMin()[0]); - if ((globalPos - contaminationPos).infinity_norm() < extend + 1e-7) - BulkGridCreator::grid().mark(1, element); - } - - BulkGridCreator::grid().preAdapt(); - BulkGridCreator::grid().adapt(); - BulkGridCreator::grid().postAdapt(); - - // make sure there is only one level difference - for (const auto& element : elements(bulkGridView)) - { - for (const auto& intersection : intersections(bulkGridView, element)) - { - if (intersection.neighbor()) - if (intersection.outside().level()-1 > element.level()) - BulkGridCreator::grid().mark(1, element); - } - } - - BulkGridCreator::grid().preAdapt(); - BulkGridCreator::grid().adapt(); - BulkGridCreator::grid().postAdapt(); - - // update the bounding box tree - problem.bulkProblem().boundingBoxTree().build(bulkGridView); - } - BulkGridCreator::loadBalance(); - - timeManager.init(problem, restartTime, dt, tEnd, restart); - timeManager.run(); - - // print dumux end message and maybe the parameters for debugging - if (mpiHelper.rank() == 0) - { - DumuxMessage::print(/*firstCall=*/false); - - if (printParams) - Parameters::print<TypeTag>(); - } - - return 0; -} - -/*! - * \ingroup Start - * - * \brief Provides a main function with error handling - * - * \tparam TypeTag The type tag of the problem which needs to be solved - * - * \param argc The number of command line arguments of the program - * \param argv The contents of the command line arguments of the program - * \param usage Callback function for printing the usage message - */ -template <class TypeTag> -int start(int argc, - char **argv, - void (*usage)(const char *, const std::string &)) -{ - try { - return start_<TypeTag>(argc, argv, usage); - } - catch (ParameterException &e) { - Parameters::print<TypeTag>(); - std::cerr << std::endl << e << ". Abort!" << std::endl; - return 1; - } - catch (Dune::DGFException & e) { - std::cerr << "DGF exception thrown (" << e << - "). Most likely, the DGF file name is wrong " - "or the DGF file is corrupted, " - "e.g. missing hash at end of file or wrong number (dimensions) of entries." - << std::endl; - return 2; - } - catch (Dune::Exception &e) { - std::cerr << "Dune reported error: " << e << std::endl; - return 3; - } -} - -} // end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p2c_richards2c/test_rosi2c.cc b/test/mixeddimension/embedded/1p2c_richards2c/test_rosi2c.cc deleted file mode 100644 index f8671fc4cdbcac5f9b31e797f5bfc413009de6f3..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p2c_richards2c/test_rosi2c.cc +++ /dev/null @@ -1,45 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief test for the rootsystem coupled model - */ -#include "config.h" -#include "rositestproblem.hh" -#include "start.hh" - -/*! - * \brief Provides an interface for customizing error messages associated with - * reading in parameters. - * - * \param progName The name of the program, that was tried to be started. - * \param errorMsg The error message that was issued by the start function. - * Comprises the thing that went wrong and a general help message. - */ -void usage(const char *progName, const std::string &errorMsg) -{ - // TODO -} - -int main(int argc, char** argv) -{ - using ProblemTypeTag = TTAG(RosiTestProblem); - return Dumux::start<ProblemTypeTag>(argc, argv, usage); -} diff --git a/test/mixeddimension/embedded/1p2c_richards2c/test_rosi2c.input b/test/mixeddimension/embedded/1p2c_richards2c/test_rosi2c.input deleted file mode 100644 index a2016460e23ac89ef95148009a1a8e87cdde9618..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p2c_richards2c/test_rosi2c.input +++ /dev/null @@ -1,42 +0,0 @@ -[MixedDimension] -UseIterativeSolver = false - -[TimeManager] -DtInitial = 8640 # [s] -TEnd = 864000 # [s] -EpisodeTime = 8640 # [s] - -[Grid] -File = ./grids/lupine.dgf -Refinement = 1 - -[SoilGrid] -LowerLeft = -0.05 -0.05 -0.1 -UpperRight = 0.05 0.05 0 -Cells = 10 10 10 -ClosureType = None -Refinement = 0 -LocalRefinement = 0 - -[Problem] -Name = rosi2c -ContaminantMoleFraction = 3e-7 -MolarMass = 20e-3 # in kg/mol, molar mass heavy water D2O - -[Component] -LiquidDiffusionCoefficient = 2.3e-9 -Name = D2O - -[SpatialParams] -Permeability = 2.57e-12 # [m^2] -### root parameters ### -Kx = 5.0968e-17 -Kr = 2.04e-13 - -[BoundaryConditions] -InitialRootPressure = -1.2e6 # [Pa] -TranspirationRate = 2.15e-8 # [kg / s] -CriticalCollarPressure = -1.5e6 # [Pa] - -[Vtk] -AddVelocity = false diff --git a/test/mixeddimension/embedded/1p_1p/1d3dtestproblem.hh b/test/mixeddimension/embedded/1p_1p/1d3dtestproblem.hh deleted file mode 100644 index d876be4bd8951be8dbf0318996297d279d05ae43..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_1p/1d3dtestproblem.hh +++ /dev/null @@ -1,256 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief A test problem for the 1d3d coupled problem: - * a one-dimensional network is embedded in a three-dimensional matrix - * Comparison with anaytical solutiom (see D'Angelo 2007 PhD thesis) - */ -#ifndef DUMUX_1D3D_TEST_PROBLEM_HH -#define DUMUX_1D3D_TEST_PROBLEM_HH - -#include "bloodflowproblem.hh" -#include "tissueproblem.hh" - -#include <dumux/mixeddimension/problem.hh> -#include <dumux/mixeddimension/embedded/cellcentered/bboxtreecouplingmanager.hh> -//#include <dumux/mixeddimension/embedded/cellcentered/bboxtreecouplingmanagersimple.hh> -#include <dumux/mixeddimension/integrationpointsource.hh> - -namespace Dumux -{ -template <class TypeTag> -class TestOneDThreeDProblem; - -namespace Properties -{ -NEW_TYPE_TAG(TestOneDThreeDProblem, INHERITS_FROM(MixedDimension)); -NEW_TYPE_TAG(TestOneDThreeDCCProblem, INHERITS_FROM(TestOneDThreeDProblem)); - -// Set the problem property -SET_TYPE_PROP(TestOneDThreeDProblem, Problem, Dumux::TestOneDThreeDProblem<TypeTag>); - -// Set the coupling manager -//SET_TYPE_PROP(TestOneDThreeDCCProblem, CouplingManager, Dumux::CCBBoxTreeEmbeddedCouplingManagerSimple<TypeTag>); -SET_TYPE_PROP(TestOneDThreeDCCProblem, CouplingManager, Dumux::CCBBoxTreeEmbeddedCouplingManager<TypeTag>); -//////////////////////////////////////////////////////////////////////////// -// Set the two sub-problems of the global problem -SET_TYPE_PROP(TestOneDThreeDCCProblem, LowDimProblemTypeTag, TTAG(BloodFlowCCProblem)); -SET_TYPE_PROP(TestOneDThreeDCCProblem, BulkProblemTypeTag, TTAG(TissueCCProblem)); -//////////////////////////////////////////////////////////////////////////// - -// publish this problem in the sub problems -SET_TYPE_PROP(BloodFlowCCProblem, GlobalProblemTypeTag, TTAG(TestOneDThreeDCCProblem)); -SET_TYPE_PROP(TissueCCProblem, GlobalProblemTypeTag, TTAG(TestOneDThreeDCCProblem)); - -// The subproblems inherit the parameter tree from this problem -SET_PROP(BloodFlowCCProblem, ParameterTree) : GET_PROP(TTAG(TestOneDThreeDCCProblem), ParameterTree) {}; -SET_PROP(TissueCCProblem, ParameterTree) : GET_PROP(TTAG(TestOneDThreeDCCProblem), ParameterTree) {}; - -// Set the point source type of the subproblems to an id'ed point source -SET_TYPE_PROP(BloodFlowCCProblem, PointSource, Dumux::IntegrationPointSource<TTAG(BloodFlowCCProblem), unsigned int>); -SET_TYPE_PROP(BloodFlowCCProblem, PointSourceHelper, Dumux::IntegrationPointSourceHelper<TTAG(BloodFlowCCProblem)>); -SET_TYPE_PROP(TissueCCProblem, PointSource, Dumux::IntegrationPointSource<TTAG(TissueCCProblem), unsigned int>); -SET_TYPE_PROP(TissueCCProblem, PointSourceHelper, Dumux::IntegrationPointSourceHelper<TTAG(TissueCCProblem)>); - -SET_TYPE_PROP(TestOneDThreeDProblem, LinearSolver, ILU0BiCGSTABBackend<TypeTag>); - -}//end namespace properties - -template <class TypeTag> -class TestOneDThreeDProblem : public MixedDimensionProblem<TypeTag> -{ - using ParentType = MixedDimensionProblem<TypeTag>; - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - - // obtain the type tags of the sub problems - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - // obtain types from the sub problem type tags - using BulkProblem = typename GET_PROP_TYPE(BulkProblemTypeTag, Problem); - using LowDimProblem = typename GET_PROP_TYPE(LowDimProblemTypeTag, Problem); - - using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); - using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); - - enum { bulkIsBox = GET_PROP_VALUE(BulkProblemTypeTag, ImplicitIsBox) }; - enum { lowDimIsBox = GET_PROP_VALUE(LowDimProblemTypeTag, ImplicitIsBox) }; - -public: - TestOneDThreeDProblem(TimeManager &timeManager, const BulkGridView &bulkGridView, const LowDimGridView &lowDimgridView) - : ParentType(timeManager, bulkGridView, lowDimgridView) - { - order_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, int, Problem, NormIntegrationOrder); - excludeInnerBulk_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, bool, Problem, NormExcludeInnerBulk); - } - - /*! - * \brief Called by Dumux::TimeManager in order to do a time - * integration on the model. Iterative algorithm for one time step. - */ - void timeIntegration() - { - ParentType::timeIntegration(); - - // compute the L2-norm with respect to the analytical solution - // discrete l2-norm for finite volumes - auto norm1D = this->calculateNorm(this->lowDimProblem(), this->lowDimGridView(), order_, lowDimIsBox); - auto norm3D = this->calculateNorm(this->bulkProblem(), this->bulkGridView(), order_, bulkIsBox); - // normalize the norm - norm1D.first /= this->calculateNormExactSolution(this->lowDimProblem(), this->lowDimGridView(), order_, lowDimIsBox); - norm3D.first /= this->calculateNormExactSolution(this->bulkProblem(), this->bulkGridView(), order_, bulkIsBox); - - // ouput result to terminal - std::cout << "hmax_3d: " << norm3D.second << " " - << "hmax_1d: " << norm1D.second << " " - << "L2_3d: " << norm3D.first << " " - << "L2_1d: " << norm1D.first << std::endl; - - // ... and file. - file_.open(this->name() + ".log", std::ios::app); - file_ << norm3D.second << " " << norm1D.second << " " << norm3D.first << " " << norm1D.first << "\n"; - file_.close(); - } - - //! Calculate the L2-Norm of the solution and hmax of the grid - template<class SubProblem, class GridView> - std::pair<Scalar, Scalar> calculateNorm(const SubProblem &sp, const GridView &gv, int order, bool isBox) - { - typename Dune::PQkLocalFiniteElementCache<Scalar, Scalar, GridView::dimension, 1> feCache; - - // calculate the L2-Norm and hmax - const auto& solution = sp.model().curSol(); - Scalar LTwoNorm = 0.0; - Scalar hMax = 0.0; - - // iterate over all elements - for (const auto& element : elements(gv)) - { - const unsigned int eIdx = gv.indexSet().index(element); - const auto geometry = element.geometry(); - const auto center = geometry.center(); - if (int(GridView::dimension) == 3 && excludeInnerBulk_ && - std::sqrt(center[0]*center[0] + center[1]*center[1]) < GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, Radius) + 0.01) - continue; - hMax = std::max(geometryDiameter(geometry), hMax); - - using Quad = Dune::QuadratureRule<Scalar, GridView::dimension>; - const Quad &quad = Dune::QuadratureRules<Scalar, GridView::dimension>::rule(geometry.type(), order); - for(auto&& qp : quad) - { - const auto globalPos = geometry.global(qp.position()); - const Scalar pe = sp.exactSolution(globalPos); - Scalar p(0.0); - if(!isBox) - p = solution[eIdx][0]; - else - { - // do interpolation with ansatz functions - std::vector<Dune::FieldVector<Scalar,1> > shapeValues; - const auto& localFiniteElement = feCache.get(geometry.type()); - localFiniteElement.localBasis().evaluateFunction(qp.position(), shapeValues); - for (int vIdx = 0; vIdx < shapeValues.size(); ++vIdx) - p += shapeValues[vIdx]*solution[sp.model().dofMapper().subIndex(element, vIdx, GridView::dimension)][0]; - } - - LTwoNorm += (p - pe)*(p - pe)*qp.weight()*geometry.integrationElement(qp.position()); - } - } - return std::make_pair(std::sqrt(LTwoNorm), hMax); - } - - template<class SubProblem, class GridView> - Scalar calculateNormExactSolution(const SubProblem &sp, const GridView &gv, int order, bool isBox) - { - // calculate the L2-Norm - Scalar LTwoNorm = 0.0; - - // iterate over all elements - for (const auto& element : elements(gv)) - { - const auto geometry = element.geometry(); - const auto center = geometry.center(); - if (int(GridView::dimension) == 3 && excludeInnerBulk_ && - std::sqrt(center[0]*center[0] + center[1]*center[1]) < GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, Radius)) - continue; - using Quad = Dune::QuadratureRule<Scalar, GridView::dimension>; - const Quad &quad = Dune::QuadratureRules<Scalar, GridView::dimension>::rule(geometry.type(), order); - for(auto&& qp : quad) - { - const auto globalPos = geometry.global(qp.position()); - const Scalar pe = sp.exactSolution(globalPos); - LTwoNorm += pe*pe*qp.weight()*geometry.integrationElement(qp.position()); - } - } - return std::sqrt(LTwoNorm); - } - - template<class Geometry> - Scalar geometryDiameter(const Geometry& geometry) - { - auto type = geometry.type(); - if(type.isLine()) - { - return (geometry.corner(0)-geometry.corner(1)).two_norm(); - } - else if(type.isHexahedron()) - { - return (geometry.corner(0)-geometry.corner(1)).two_norm(); - } - else if(type.isTetrahedron()) - { - const auto p0 = geometry.corner(0); - const auto p1 = geometry.corner(1); - const auto p2 = geometry.corner(2); - const auto p3 = geometry.corner(3); - - // Compute side length - const auto a = (p1-p2).two_norm(); - const auto b = (p0-p2).two_norm(); - const auto c = (p0-p1).two_norm(); - const auto aa = (p0-p3).two_norm(); - const auto bb = (p1-p3).two_norm(); - const auto cc = (p2-p3).two_norm(); - - // compute some helper variables - const auto la = a*aa; - const auto lb = b*bb; - const auto lc = c*cc; - const auto s = 0.5*(la+lb+lc); - const auto area = std::sqrt(s*(s-la)*(s-lb)*(s-lc)); - return area/(3.0*geometry.volume()); - } - else - { - DUNE_THROW(Dune::NotImplemented, "Diameter for geometry " << type << "."); - } - } - -private: - std::ofstream file_; - int order_; - bool excludeInnerBulk_; -}; - -} //end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p_1p/CMakeLists.txt b/test/mixeddimension/embedded/1p_1p/CMakeLists.txt deleted file mode 100644 index 6ed85ea447d857f68f89d2c5c24a29dab3f8e8de..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_1p/CMakeLists.txt +++ /dev/null @@ -1,3 +0,0 @@ -dune_add_test(SOURCES test_1p_1p.cc) -dune_symlink_to_source_files(FILES "grids" "test_1p_1p.input") -set(CMAKE_BUILD_TYPE Release) diff --git a/test/mixeddimension/embedded/1p_1p/bloodflowproblem.hh b/test/mixeddimension/embedded/1p_1p/bloodflowproblem.hh deleted file mode 100644 index 9595fed1176a9c7bf57b7bb3c0fd78b39869450e..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_1p/bloodflowproblem.hh +++ /dev/null @@ -1,356 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief A test problem for the one-phase blood flow model: - * Blood is flowing through a 1d network grid. - */ -#ifndef DUMUX_BLOOD_FLOW_PROBLEM_HH -#define DUMUX_BLOOD_FLOW_PROBLEM_HH - -#include <dumux/implicit/cellcentered/tpfa/properties.hh> -#include <dumux/porousmediumflow/1p/model.hh> -#include <dumux/porousmediumflow/implicit/problem.hh> -#include <dumux/material/components/constant.hh> -#include <dumux/material/fluidsystems/liquidphase.hh> -#include <dumux/material/fluidsystems/1p.hh> -#include <dumux/linear/seqsolverbackend.hh> -#include <dumux/mixeddimension/subproblemproperties.hh> -#include "bloodflowspatialparams.hh" - -namespace Dumux -{ -template <class TypeTag> -class BloodFlowProblem; - -namespace Properties -{ -NEW_TYPE_TAG(BloodFlowProblem, INHERITS_FROM(OneP)); -NEW_TYPE_TAG(BloodFlowCCProblem, INHERITS_FROM(CCTpfaModel, BloodFlowProblem)); - -// Set the grid type -SET_TYPE_PROP(BloodFlowProblem, Grid, Dune::FoamGrid<1, 3>); - -// Set the grid parameter group -SET_STRING_PROP(BloodFlowProblem, GridParameterGroup, "VesselGrid"); - -// Set the problem property -SET_TYPE_PROP(BloodFlowProblem, Problem, BloodFlowProblem<TypeTag>); - -// the fluid system -SET_PROP(BloodFlowProblem, FluidSystem) -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using type = FluidSystems::OneP<Scalar, FluidSystems::LiquidPhase<Scalar, Components::Constant<1, Scalar> > >; -}; - -// Set the spatial parameters -SET_TYPE_PROP(BloodFlowProblem, SpatialParams, BloodFlowSpatialParams<TypeTag>); - -// evaluate analytical permeability field at scvf center -SET_BOOL_PROP(BloodFlowProblem, EvaluatePermeabilityAtScvfIP, true); - -// disable gravity -SET_BOOL_PROP(BloodFlowProblem, ProblemEnableGravity, false); - -} - -/*! - * \ingroup OneDStokes - * \ingroup ImplicitTestProblems - * \brief Exact solution 1D-3D - */ -template <class TypeTag> -class BloodFlowProblem : public ImplicitPorousMediaProblem<TypeTag> -{ - using ParentType = ImplicitPorousMediaProblem<TypeTag>; - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); - using PointSource = typename GET_PROP_TYPE(TypeTag, PointSource); - using Indices = typename GET_PROP_TYPE(TypeTag, Indices); - // copy some indices for convenience - enum { - // Grid and world dimension - dim = GridView::dimension, - dimworld = GridView::dimensionworld - }; - enum { - // indices of the primary variables - conti0EqIdx = Indices::conti0EqIdx, - pressureIdx = Indices::pressureIdx - }; - enum { isBox = GET_PROP_VALUE(TypeTag, ImplicitIsBox) }; - enum { dofCodim = isBox ? dim : 0 }; - - using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); - using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); - using VtkOutputModule = typename GET_PROP_TYPE(TypeTag, VtkOutputModule); - using Element = typename GridView::template Codim<0>::Entity; - using GlobalPosition = Dune::FieldVector<Scalar, dimworld>; - - using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); - using CouplingManager = typename GET_PROP_TYPE(GlobalProblemTypeTag, CouplingManager); - -public: - BloodFlowProblem(TimeManager &timeManager, const GridView &gridView) - : ParentType(timeManager, gridView) - { - //read parameters from input file - name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name) + "_1d"; - p_in_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryConditions1D, PressureInput); - delta_p_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, BoundaryConditions1D, DeltaPressure); - } - - /*! - * \brief Called by the TimeManager in order to - * initialize the problem. - */ - void init() - { - ParentType::init(); - exactPressure_.resize(this->model().numDofs()); - for (const auto& element : elements(this->gridView())) - { - auto fvGeometry = localView(this->model().fvGridGeometry()); - fvGeometry.bindElement(element); - - for (auto&& scv : scvs(fvGeometry)) - exactPressure_[scv.dofIndex()] = exactSolution(scv.dofPosition()); - } - } - - /*! - * \brief Return how much the domain is extruded at a given sub-control volume. - * - * The extrusion factor here makes extrudes the 1d line to a circular tube with - * cross-section area pi*r^2. - */ - Scalar extrusionFactor(const Element &element, - const SubControlVolume &scv, - const ElementSolutionVector& elemSol) const - { - const auto eIdx = this->elementMapper().index(element); - const auto radius = this->spatialParams().radius(eIdx); - return M_PI*radius*radius; - } - - /*! - * \brief Returns true if a restart file should be written to disk. - */ - bool shouldWriteRestartFile() const - { return false; } - - /*! - * \name Problem parameters - */ - // \{ - - /*! - * \brief The problem name. - * - * This is used as a prefix for files generated by the simulation. - */ - const std::string& name() const - { return name_; } - - /*! - * \brief Return the temperature within the domain in [K]. - * - */ - Scalar temperature() const - { return 273.15 + 37.0; } // Body temperature - - // \} - /*! - * \name Boundary conditions - */ - // \{ - - /*! - * \brief Specifies which kind of boundary condition should be - * used for which equation on a given boundary segment. - * - * \param globalPos The global position - */ - BoundaryTypes boundaryTypesAtPos(const GlobalPosition &globalPos) const - { - BoundaryTypes values; - values.setAllDirichlet(); - return values; - } - - /*! - * \brief Evaluate the boundary conditions for a dirichlet - * control volume. - * - * \param globalPos The global position - * - * For this method, the \a values parameter stores primary variables. - */ - PrimaryVariables dirichletAtPos(const GlobalPosition& globalPos) const - { - PrimaryVariables values; - if(globalPos[2] > 0.5) - values[pressureIdx] = p_in_; - else - values[pressureIdx] = p_in_-delta_p_; - return values; - } - - - // \} - - /*! - * \name Volume terms - */ - // \{ - - /*! - * \brief Applies a vector of point sources. The point sources - * are possibly solution dependent. - * - * \param pointSources A vector of PointSource s that contain - source values for all phases and space positions. - * - * For this method, the \a values method of the point source - * has to return the absolute mass rate in kg/s. Positive values mean - * that mass is created, negative ones mean that it vanishes. - */ - void addPointSources(std::vector<PointSource>& pointSources) const - { pointSources = this->couplingManager().lowDimPointSources(); } - - /*! - * \brief Evaluate the point sources (added by addPointSources) - * for all phases within a given sub-control-volume. - * - * This is the method for the case where the point source is - * solution dependent and requires some quantities that - * are specific to the fully-implicit method. - * - * \param pointSource A single point source - * \param element The finite element - * \param fvGeometry The finite-volume geometry - * \param elemVolVars All volume variables for the element - * \param scv The sub-control volume within the element - * - * For this method, the \a values() method of the point sources returns - * the absolute rate mass generated or annihilate in kg/s. Positive values mean - * that mass is created, negative ones mean that it vanishes. - */ - void pointSource(PointSource& source, - const Element &element, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const SubControlVolume &scv) const - { - // compute source at every integration point - const auto& bulkVolVars = this->couplingManager().bulkVolVars(source.id()); - const Scalar pressure1D = this->couplingManager().lowDimPriVars(source.id())[pressureIdx]; - - // calculate the source - const Scalar radius = this->couplingManager().radius(source.id()); - const Scalar beta = 2*M_PI/(2*M_PI + std::log(radius)); - const Scalar sourceValue = beta*(bulkVolVars.pressure() - pressure1D)*bulkVolVars.density(); - - source = sourceValue*source.quadratureWeight()*source.integrationElement(); - } - - /*! - * \brief Evaluate the initial value for a control volume. - * - * For this method, the \a priVars parameter stores primary - * variables. - */ - PrimaryVariables initialAtPos(const GlobalPosition &globalPos) const - { return PrimaryVariables(0.0); } - - // \} - - //! The exact pressure solution - Scalar exactSolution(const GlobalPosition &globalPos) const - { return 1 + globalPos[2]; } - - //! Called after every time step - //! Output the total global exchange term - void postTimeStep() - { - ParentType::postTimeStep(); - - PrimaryVariables source(0.0); - - if (!(this->timeManager().time() < 0.0)) - { - for (const auto& element : elements(this->gridView())) - { - auto fvGeometry = localView(this->model().fvGridGeometry()); - fvGeometry.bindElement(element); - - auto elemVolVars = localView(this->model().curGridVolVars()); - elemVolVars.bindElement(element, fvGeometry, this->model().curSol()); - - for (auto&& scv : scvs(fvGeometry)) - { - auto pointSources = this->scvPointSources(element, fvGeometry, elemVolVars, scv); - pointSources *= scv.volume()*elemVolVars[scv].extrusionFactor(); - source += pointSources; - } - } - } - - std::cout << "Global integrated source (1D): " << source << '\n'; - } - - /*! - * \brief Adds additional VTK output data to the VTKWriter. Function is called by the output module on every write. - */ - void addVtkOutputFields(VtkOutputModule& outputModule) const - { - auto& p = outputModule.createScalarField("exact pressure", dofCodim); - p = exactPressure_; - } - - //! Set the coupling manager - void setCouplingManager(std::shared_ptr<CouplingManager> cm) - { couplingManager_ = cm; } - - //! Get the coupling manager - const CouplingManager& couplingManager() const - { return *couplingManager_; } - -private: - std::vector<Scalar> exactPressure_; - - static constexpr Scalar eps_ = 1.5e-7; - std::string name_; - - Scalar p_in_; - Scalar delta_p_; - - std::shared_ptr<CouplingManager> couplingManager_; -}; - -} //end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p_1p/bloodflowspatialparams.hh b/test/mixeddimension/embedded/1p_1p/bloodflowspatialparams.hh deleted file mode 100644 index a0671748f05a6199789ba1f92ad03cfa694f255a..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_1p/bloodflowspatialparams.hh +++ /dev/null @@ -1,98 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief The spatial parameters class blood flow problem - */ -#ifndef DUMUX_BlOOD_FLOW_SPATIALPARAMS_HH -#define DUMUX_BlOOD_FLOW_SPATIALPARAMS_HH - -#include <dumux/material/spatialparams/fv1p.hh> - -namespace Dumux -{ - -/*! - * \ingroup OnePModel - * \ingroup ImplicitTestProblems - * - * \brief Definition of the spatial parameters for the blood flow problem - */ -template<class TypeTag> -class BloodFlowSpatialParams: public FVSpatialParamsOneP<TypeTag> -{ - using ParentType = FVSpatialParamsOneP<TypeTag>; - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); - enum { - // Grid and world dimension - dim = GridView::dimension, - dimworld = GridView::dimensionworld - }; - using GlobalPosition = Dune::FieldVector<Scalar, dimworld>; - -public: - // export permeability type - using PermeabilityType = Scalar; - - BloodFlowSpatialParams(const Problem& problem, const GridView& gridView) - : ParentType(problem, gridView) {} - - /*! - * \brief Return the intrinsic permeability for the current sub-control volume in [m^2]. - * - * \param ipGlobal The integration point - */ - Scalar permeabilityAtPos(const GlobalPosition& ipGlobal) const - { - return (1 + ipGlobal[2] + 0.5*ipGlobal[2]*ipGlobal[2])/(M_PI*radius(0)*radius(0)); - } - - /*! - * \brief Return the radius of the circular pipe for the current sub-control volume in [m]. - * - * \param the index of the element - */ - Scalar radius(unsigned int eIdxGlobal) const - { - return GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, Radius); - } - - /*! - * \brief Returns the porosity \f$[-]\f$ - * - * \param element The element - * \param scv The sub control volume - * \param elemSol The element solution vector - * \return the porosity - */ - Scalar porosity(const Element& element, - const SubControlVolume& scv, - const ElementSolutionVector& elemSol) const - { return 1.0; } -}; - -} // end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p_1p/convergencetest.py b/test/mixeddimension/embedded/1p_1p/convergencetest.py deleted file mode 100755 index 2efe0fdc7b06ff0caab865703d80b1f265b3032b..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_1p/convergencetest.py +++ /dev/null @@ -1,53 +0,0 @@ -#!/usr/bin/env python - -from math import * -import subprocess -import sys - -if len(sys.argv) != 2: - sys.err.write('Please provide a single argument <testname> to the script') - -testname = str(sys.argv[1]) - -subprocess.call(['rm', testname + '.log']) -print("Removed old log file ({})!".format(testname + '.log')) -for i in [10, 20, 30, 40, 50, 60]: - subprocess.call(['./' + testname, '-ParameterFile', 'test_1p1dstokes.input', - '-TissueGrid.Cells', 3*(str(i)+" "), - '-VesselGrid.Cells', str(i), - '-Problem.Name', testname]) - -logfile = open(testname + '.log', "r+") - -bulkError = [] -bulkHmax = [] -lowDimError = [] -lowDimHmax = [] -for line in logfile: - line = line.strip("\n") - line = line.split() - bulkHmax.append(float(line[0])) - lowDimHmax.append(float(line[1])) - bulkError.append(float(line[2])) - lowDimError.append(float(line[3])) - -logfile.truncate(0) -for name, hmax, error in (("3D", bulkHmax, bulkError), ("1D", lowDimHmax, lowDimError)): - logfile.write("[" + name + "]\thmax\t\terror\t\trate\n") - logfile.write("-"*50 + "\n") - for i in range(len(error)-1): - if isnan(error[i]) or isinf(error[i]): - continue - if not (error[i] < 1e-12 or error[i] < 1e-12): - rate = (log(error[i])-log(error[i+1]))/(log(hmax[i])-log(hmax[i+1])) - message = "{}\t{:0.4e}\t{:0.4e}\t{:0.4e}\n".format(i, hmax[i], error[i], rate) - logfile.write(message) - else: - logfile.write("error: exact solution!?") - i = len(error)-1 - message = "{}\t{:0.4e}\t{:0.4e}\n\n\n".format(i, hmax[i], error[i]) - logfile.write(message) - -logfile.close() -print("\nComputed the following convergence rates:\n") -subprocess.call(['cat', testname + '.log']) diff --git a/test/mixeddimension/embedded/1p_1p/grids/cylinder.geo b/test/mixeddimension/embedded/1p_1p/grids/cylinder.geo deleted file mode 100644 index 67b329574236d6a788bcfcd0f20462b4248f6eda..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_1p/grids/cylinder.geo +++ /dev/null @@ -1,41 +0,0 @@ -size = 0.1; -Point(1) = {0, 0, 0, size}; -Point(2) = {1, 0, 0, size}; -Point(3) = {0, 1, 0, size}; -Point(4) = {0, -1, 0, size}; -Point(5) = {-1, 0, 0, size}; -Point(6) = {-1, 0, 1, size}; -Point(7) = {0, 0, 1, size}; -Point(8) = {0, 1, 1, size}; -Point(13) = {1, 0, 1, size}; -Point(18) = {0, -1, 1, size}; - -Circle(1) = {3, 1, 2}; -Circle(2) = {2, 1, 4}; -Circle(3) = {4, 1, 5}; -Circle(4) = {5, 1, 3}; -Circle(8) = {6, 7, 8}; -Circle(9) = {8, 7, 13}; -Circle(10) = {13, 7, 18}; -Circle(11) = {18, 7, 6}; - -Line(13) = {5, 6}; -Line(14) = {3, 8}; -Line(18) = {2, 13}; -Line(22) = {4, 18}; - -Line Loop(6) = {4, 1, 2, 3}; -Ruled Surface(6) = {6}; -Line Loop(15) = {4, 14, -8, -13}; -Ruled Surface(15) = {15}; -Line Loop(19) = {1, 18, -9, -14}; -Ruled Surface(19) = {19}; -Line Loop(23) = {2, 22, -10, -18}; -Ruled Surface(23) = {23}; -Line Loop(27) = {3, 13, -11, -22}; -Ruled Surface(27) = {27}; -Line Loop(28) = {8, 9, 10, 11}; -Ruled Surface(28) = {28}; -Surface Loop(1) = {6, 28, 15, 19, 23, 27}; - -Volume(1) = {1}; diff --git a/test/mixeddimension/embedded/1p_1p/grids/cylinder.msh b/test/mixeddimension/embedded/1p_1p/grids/cylinder.msh deleted file mode 100644 index ec41116a09117430f50fb8e5aaaee505935ddc2a..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_1p/grids/cylinder.msh +++ /dev/null @@ -1,18890 +0,0 @@ -$MeshFormat -2.2 0 8 -$EndMeshFormat -$Nodes -2839 -1 0 0 0 -2 1 0 0 -3 0 1 0 -4 0 -1 0 -5 -1 0 0 -6 -1 0 1 -7 0 0 1 -8 0 1 1 -9 1 0 1 -10 0 -1 1 -11 0.09801714032917982 0.9951847266722343 0 -12 0.1950903220155996 0.9807852804033356 0 -13 0.2902846772537184 0.9569403357324345 0 -14 0.3826834323641164 0.9238795325116899 0 -15 0.4713967368248421 0.8819212643489727 0 -16 0.5555702330183399 0.8314696123033888 0 -17 0.6343932841623059 0.7730104533638363 0 -18 0.7071067811852056 0.7071067811878894 0 -19 0.7730104533617078 0.6343932841648996 0 -20 0.8314696123017838 0.5555702330207417 0 -21 0.8819212643478248 0.4713967368269896 0 -22 0.9238795325109631 0.382683432365871 0 -23 0.9569403357320482 0.290284677254992 0 -24 0.9807852804031679 0.1950903220164424 0 -25 0.9951847266721896 0.09801714032963502 0 -26 0.9951847266722343 -0.09801714032917982 0 -27 0.9807852804033356 -0.1950903220155996 0 -28 0.9569403357324345 -0.2902846772537184 0 -29 0.9238795325116899 -0.3826834323641164 0 -30 0.8819212643489727 -0.4713967368248421 0 -31 0.8314696123033888 -0.5555702330183399 0 -32 0.7730104533638363 -0.6343932841623059 0 -33 0.7071067811878894 -0.7071067811852056 0 -34 0.6343932841648996 -0.7730104533617078 0 -35 0.5555702330207417 -0.8314696123017838 0 -36 0.4713967368269896 -0.8819212643478248 0 -37 0.382683432365871 -0.9238795325109631 0 -38 0.290284677254992 -0.9569403357320482 0 -39 0.1950903220164424 -0.9807852804031679 0 -40 0.09801714032963502 -0.9951847266721896 0 -41 -0.09801714032917982 -0.9951847266722343 0 -42 -0.1950903220155996 -0.9807852804033356 0 -43 -0.2902846772537184 -0.9569403357324345 0 -44 -0.3826834323641164 -0.9238795325116899 0 -45 -0.4713967368248421 -0.8819212643489727 0 -46 -0.5555702330183399 -0.8314696123033888 0 -47 -0.6343932841623059 -0.7730104533638363 0 -48 -0.7071067811852056 -0.7071067811878894 0 -49 -0.7730104533617078 -0.6343932841648996 0 -50 -0.8314696123017838 -0.5555702330207417 0 -51 -0.8819212643478248 -0.4713967368269896 0 -52 -0.9238795325109631 -0.382683432365871 0 -53 -0.9569403357320482 -0.290284677254992 0 -54 -0.9807852804031679 -0.1950903220164424 0 -55 -0.9951847266721896 -0.09801714032963502 0 -56 -0.9951847266722343 0.09801714032917982 0 -57 -0.9807852804033356 0.1950903220155996 0 -58 -0.9569403357324345 0.2902846772537184 0 -59 -0.9238795325116899 0.3826834323641164 0 -60 -0.8819212643489727 0.4713967368248421 0 -61 -0.8314696123033888 0.5555702330183399 0 -62 -0.7730104533638363 0.6343932841623059 0 -63 -0.7071067811878894 0.7071067811852056 0 -64 -0.6343932841648996 0.7730104533617078 0 -65 -0.5555702330207417 0.8314696123017838 0 -66 -0.4713967368269896 0.8819212643478248 0 -67 -0.382683432365871 0.9238795325109631 0 -68 -0.290284677254992 0.9569403357320482 0 -69 -0.1950903220164424 0.9807852804031679 0 -70 -0.09801714032963502 0.9951847266721896 0 -71 -0.9951847266722343 0.09801714032917982 1 -72 -0.9807852804033356 0.1950903220155996 1 -73 -0.9569403357324345 0.2902846772537184 1 -74 -0.9238795325116899 0.3826834323641164 1 -75 -0.8819212643489727 0.4713967368248421 1 -76 -0.8314696123033888 0.5555702330183399 1 -77 -0.7730104533638363 0.6343932841623059 1 -78 -0.7071067811878894 0.7071067811852056 1 -79 -0.6343932841648996 0.7730104533617078 1 -80 -0.5555702330207417 0.8314696123017838 1 -81 -0.4713967368269896 0.8819212643478248 1 -82 -0.382683432365871 0.9238795325109631 1 -83 -0.290284677254992 0.9569403357320482 1 -84 -0.1950903220164424 0.9807852804031679 1 -85 -0.09801714032963502 0.9951847266721896 1 -86 0.09801714032917982 0.9951847266722343 1 -87 0.1950903220155996 0.9807852804033356 1 -88 0.2902846772537184 0.9569403357324345 1 -89 0.3826834323641164 0.9238795325116899 1 -90 0.4713967368248421 0.8819212643489727 1 -91 0.5555702330183399 0.8314696123033888 1 -92 0.6343932841623059 0.7730104533638363 1 -93 0.7071067811852056 0.7071067811878894 1 -94 0.7730104533617078 0.6343932841648996 1 -95 0.8314696123017838 0.5555702330207417 1 -96 0.8819212643478248 0.4713967368269896 1 -97 0.9238795325109631 0.382683432365871 1 -98 0.9569403357320482 0.290284677254992 1 -99 0.9807852804031679 0.1950903220164424 1 -100 0.9951847266721896 0.09801714032963502 1 -101 0.9951847266722343 -0.09801714032917982 1 -102 0.9807852804033356 -0.1950903220155996 1 -103 0.9569403357324345 -0.2902846772537184 1 -104 0.9238795325116899 -0.3826834323641164 1 -105 0.8819212643489727 -0.4713967368248421 1 -106 0.8314696123033888 -0.5555702330183399 1 -107 0.7730104533638363 -0.6343932841623059 1 -108 0.7071067811878894 -0.7071067811852056 1 -109 0.6343932841648996 -0.7730104533617078 1 -110 0.5555702330207417 -0.8314696123017838 1 -111 0.4713967368269896 -0.8819212643478248 1 -112 0.382683432365871 -0.9238795325109631 1 -113 0.290284677254992 -0.9569403357320482 1 -114 0.1950903220164424 -0.9807852804031679 1 -115 0.09801714032963502 -0.9951847266721896 1 -116 -0.09801714032917982 -0.9951847266722343 1 -117 -0.1950903220155996 -0.9807852804033356 1 -118 -0.2902846772537184 -0.9569403357324345 1 -119 -0.3826834323641164 -0.9238795325116899 1 -120 -0.4713967368248421 -0.8819212643489727 1 -121 -0.5555702330183399 -0.8314696123033888 1 -122 -0.6343932841623059 -0.7730104533638363 1 -123 -0.7071067811852056 -0.7071067811878894 1 -124 -0.7730104533617078 -0.6343932841648996 1 -125 -0.8314696123017838 -0.5555702330207417 1 -126 -0.8819212643478248 -0.4713967368269896 1 -127 -0.9238795325109631 -0.382683432365871 1 -128 -0.9569403357320482 -0.290284677254992 1 -129 -0.9807852804031679 -0.1950903220164424 1 -130 -0.9951847266721896 -0.09801714032963502 1 -131 -1 0 0.09999999999981467 -132 -1 0 0.1999999999995579 -133 -1 0 0.2999999999992664 -134 -1 0 0.3999999999989749 -135 -1 0 0.4999999999986943 -136 -1 0 0.5999999999989468 -137 -1 0 0.69999999999921 -138 -1 0 0.7999999999994734 -139 -1 0 0.8999999999997368 -140 0 1 0.09999999999981467 -141 0 1 0.1999999999995579 -142 0 1 0.2999999999992664 -143 0 1 0.3999999999989749 -144 0 1 0.4999999999986943 -145 0 1 0.5999999999989468 -146 0 1 0.69999999999921 -147 0 1 0.7999999999994734 -148 0 1 0.8999999999997368 -149 1 0 0.09999999999981467 -150 1 0 0.1999999999995579 -151 1 0 0.2999999999992664 -152 1 0 0.3999999999989749 -153 1 0 0.4999999999986943 -154 1 0 0.5999999999989468 -155 1 0 0.69999999999921 -156 1 0 0.7999999999994734 -157 1 0 0.8999999999997368 -158 0 -1 0.09999999999981467 -159 0 -1 0.1999999999995579 -160 0 -1 0.2999999999992664 -161 0 -1 0.3999999999989749 -162 0 -1 0.4999999999986943 -163 0 -1 0.5999999999989468 -164 0 -1 0.69999999999921 -165 0 -1 0.7999999999994734 -166 0 -1 0.8999999999997368 -167 -0.01489013110217191 0.1128433212965915 0 -168 -0.3726643429720469 0.4166466881802571 0 -169 0.2061182405504317 -0.1891162876052249 0 -170 -0.6598737186498631 -0.3996717128888204 0 -171 0.7378927286481207 0.3192420261839005 0 -172 0.01466142831193779 0.8272237684785292 0 -173 0.3370754052642337 -0.7985861994645976 0 -174 -0.9438549346419947 0.06528568960172068 0 -175 0.4481270302873285 0.4799239039177654 0 -176 -0.1015593056650897 -0.5615796140429242 0 -177 -0.5186878134191732 0.05916530219787033 0 -178 0.2812224505085883 -0.570695607754275 0 -179 0.505635729351801 -0.304481706896756 0 -180 0.5848608128902552 -0.09149928215758324 0 -181 -0.4632942574942971 -0.6396960663140423 0 -182 0.09093690424967679 0.4664248753414081 0 -183 0.3851774666564889 0.1782357420389189 0 -184 -0.6864465194284128 0.2879992377262781 0 -185 -0.829728721554193 0.4110876883961008 0 -186 0.5770162976253339 -0.5777543299184758 0 -187 0.3549966728398525 0.7320687778028323 0 -188 -0.2253362591362957 0.1401772970090848 0 -189 -0.8567447594889784 0.3142987707236813 0 -190 -0.1650313402202314 0.7057854899848173 0 -191 0.6965562164092898 0.5900334576675489 0 -192 -0.7188995641138137 -0.5469424391032756 0 -193 0.7873306395356622 -0.2146421250874112 0 -194 -0.7629264515370427 -0.1411589126952345 0 -195 0.7808778258171468 0.4870936042857612 0 -196 0.941996094958654 0.1410646020886507 0 -197 0.5164876560026652 -0.7786392345462142 0 -198 -0.05693705601237799 0.9275805071406972 0 -199 -0.4120866933600256 -0.4428579800533167 0 -200 -0.07880089378248009 -0.1962345195639227 0 -201 0.009707976051640671 -0.377985848275476 0 -202 0.2347580215044217 0.6182624948248754 0 -203 -0.1548740126727162 -0.01178461404483697 0 -204 0.2335012830489741 0.3052734333866139 0 -205 0.1715663146040294 0.1391071331580046 0 -206 0.2921596338728165 0.00712308539140849 0 -207 -0.2072012665731706 -0.3962499157726271 0 -208 -0.1115976678179918 0.2749646942775872 0 -209 -0.1695675931440572 0.4301846075144063 0 -210 -0.2854440235767216 -0.5930104702438146 0 -211 0.3807016502441228 -0.2746908090237499 0 -212 0.2198326236156283 -0.4008989023385866 0 -213 -0.5449020105391725 0.3230319188225924 0 -214 -0.5354693707669813 -0.3343077709132236 0 -215 0.1576449351081017 -0.7250929944385807 0 -216 -0.5713538978404682 -0.1653664283567751 0 -217 -0.4016455857604303 0.595880943735448 0 -218 -0.5582973104720437 0.5041810352506704 0 -219 0.2916633943109935 0.4751790276322141 0 -220 0.08926695141977206 -0.5608758927388681 0 -221 -0.0006976483081858609 -0.7056161424877193 0 -222 -0.4682933916821866 0.2719128130436115 0 -223 -0.6230304938197511 -0.4972019003056534 0 -224 0.05391789747270492 0.2508467300109738 0 -225 0.397529800351628 -0.6908871796223928 0 -226 0.4675821005683946 -0.6088880120915954 0 -227 0.4016121314414871 -0.4408917281306228 0 -228 0.05804112983470416 0.710551179026458 0 -229 -0.464673860942899 -0.03317627958983491 0 -230 0.636272502817646 0.1652686090969194 0 -231 0.5462092387155335 0.7361266815345756 0 -232 -0.2578612453108214 0.5711660198956415 0 -233 -0.3320972090189139 -0.7607243590584523 0 -234 0.4181662018848349 0.5771170907005744 0 -235 0.06879497100348433 -0.02190635644754027 0 -236 -0.09149845583727209 0.6226551862057104 0 -237 0.5059173883983249 -0.01692101301520688 0 -238 -0.1771534081527436 -0.7256058856518911 0 -239 0.5882118862343536 0.2682982982646882 0 -240 0.5659459211274125 -0.4730851303163546 0 -241 -0.6340818797510406 -0.03728002139819003 0 -242 -0.7321942292516518 0.4403268526817276 0 -243 -0.6988544283335589 0.0336554151661721 0 -244 0.1475721856064399 -0.9088812130692627 0 -245 0.5675274922466056 0.3753794074536541 0 -246 0.7057393670739563 0.4799628898320247 0 -247 -0.279210583611184 0.7469701459815805 0 -248 0.4289875031922974 0.3754294336907495 0 -249 0.5476846697730372 -0.2000958105047829 0 -250 0.6578602798042273 -0.240583897164695 0 -251 0.6723305775878805 -0.5052362849299884 0 -252 -0.6249173623216496 -0.6047286288578477 0 -253 -0.8469068112317624 0.1268528539286444 0 -254 -0.09922755125161745 0.8141985023289735 0 -255 -0.6248112406384179 0.1767049427652994 0 -256 -0.2851979659264997 0.2805015802677577 0 -257 0.894184524085083 0.2093289267781813 0 -258 -0.08532932413697283 0.180597156034421 0 -259 -0.05050990896769389 0.7147360573457365 0 -260 -0.898276342342217 -0.2233793481762484 0 -261 -0.2141304837094128 0.8282740014729689 0 -262 0.6878197731274286 0.06760246011238819 0 -263 0.2973997525880571 0.8674467273755989 0 -264 0.7445808447251113 -0.0255975979707363 0 -265 0.6373507889658276 -0.3959843131778853 0 -266 -0.8537259679161119 -0.3163890777418479 0 -267 0.6994317518810673 -0.1233212969462886 0 -268 -0.9440438192477203 -0.03628999848494067 0 -269 0.1345760192328008 0.9291038050906089 0 -270 -0.7088466587304186 -0.4547684762504491 0 -271 0.4300114298105243 -0.805792282622309 0 -272 -0.6282864266425573 -0.6918790728695118 0 -273 0.6905680756513926 -0.6119239369674063 0 -274 0.7246498230917701 -0.3323149353483554 0 -275 -0.9208701520226563 0.1498838859863945 0 -276 0.8250621395557075 -0.386121115212759 0 -277 0.7997732073363528 0.4024865457396409 0 -278 0.5508580984589524 -0.6865701796401495 0 -279 -0.8919067785018355 0.2199105907043973 0 -280 0.8586521267164036 0.1446070764948364 0 -281 0.750437930672717 0.5494393484365377 0 -282 0.9019187386052981 -0.2980229949968392 0 -283 -0.489517165870531 -0.7996353702649328 0 -284 0.8119942787150082 0.06335500116269849 0 -285 0.6321999494912832 -0.6733593701202086 0 -286 -0.8000247472708988 -0.465371417545498 0 -287 0.7826361537006341 -0.4898140255867427 0 -288 -0.2052315233354475 -0.08335160778038875 0 -289 -0.1919565641908406 -0.180520242911961 0 -290 -0.3873880221019035 -0.3511115757959653 0 -291 0.03812166187730062 -0.2035692371431176 0 -292 0.07821324383204481 -0.3014520515347556 0 -293 -0.471965607205798 -0.2949088639215298 0 -294 -0.2780588369049468 -0.3132434743303074 0 -295 -0.04446417448473222 0.3458594592405368 0 -296 -0.158506687037424 -0.2885001489673101 0 -297 0.1988962497868186 0.4637600099526067 0 -298 -0.08197016647682964 0.4368687964577961 0 -299 0.2764896627682549 0.1586516714450626 0 -300 0.1643634425737215 0.5487756437385726 0 -301 0.0009887711868924731 -0.1050285163357862 0 -302 -0.4759956827763721 -0.1977472795328587 0 -303 0.1785501348271464 -0.01151913447748107 0 -304 0.2357949522040577 -0.0882352995721746 0 -305 0.2914128383908219 -0.2402081887258993 0 -306 0.1590683629904295 0.3730262912511938 0 -307 0.193499151418948 -0.2980207750184558 0 -308 -0.09904634410703614 -0.3834985923528689 0 -309 -0.05209290583226375 -0.472367545964878 0 -310 0.3069239889230257 0.2420193591372739 0 -311 0.0558571720051072 0.3416291235146447 0 -312 -0.04729596799041022 -0.0207649684194578 0 -313 0.1189921121260211 -0.3881508820474189 0 -314 0.0689521747575573 0.5845753642124772 0 -315 0.1502816874245865 -0.4796551606873013 0 -316 -0.311189712656628 -0.4167890745557961 0 -317 0.05121882973439718 -0.4741003585644007 0 -318 0.3998128391511796 0.0182258862173772 0 -319 0.3002655675268715 -0.3335321536089929 0 -320 -0.467167832121429 0.3676149390870807 0 -321 -0.2518479984663866 -0.4966179215435935 0 -322 -0.01954666967472093 0.5282357028341735 0 -323 -0.4420561546722742 -0.5424421013009838 0 -324 0.1347613524866945 0.279758732233144 0 -325 -0.3010146528029155 0.499437425778674 0 -326 -0.3932905172194274 -0.704044398463908 0 -327 -0.1207152632938502 -0.1029832573546522 0 -328 0.3404414354353801 0.09002305329016072 0 -329 -0.4085924305662 0.3248696891044284 0 -330 -0.2675136738763451 0.4239230814511841 0 -331 0.3381677355288537 0.3390803995739855 0 -332 -0.03135430994741292 -0.2897556827047398 0 -333 -0.4684423854644831 0.4594855265543136 0 -334 -0.1416780663454387 -0.650497561298596 0 -335 -0.2329290029658952 0.3521166654026555 0 -336 0.2919601509669086 0.7762980475443713 0 -337 -0.3480645188170259 -0.5188775491211935 0 -338 0.1250774351939876 -0.1236670587836791 0 -339 -0.00499978046996577 -0.5599141029934792 0 -340 0.1281930689261892 0.0574485428802127 0 -341 -0.3738510854357225 -0.6160332211708907 0 -342 -0.2261993587752863 -0.6659094991655576 0 -343 -0.0496067415353007 -0.6431181395487076 0 -344 -0.5123231645397268 -0.4759560327440612 0 -345 0.3167058115570347 -0.4220048574037433 0 -346 -0.310371007683696 -0.6849236363680253 0 -347 0.3000969971962698 0.6841467695748745 0 -348 -0.1267423485632745 0.5301746414195229 0 -349 -0.5364806003916698 -0.5741320194152774 0 -350 0.4874619606552645 0.2213744939628277 0 -351 -0.173963059451156 0.2053413073906938 0 -352 -0.1517608384385666 -0.4816284625262366 0 -353 0.3300821826779072 0.6029785234219056 0 -354 0.1852972921635817 -0.5657488879083675 0 -355 0.3728962509741941 -0.5876793227319536 0 -356 -0.3900629087296096 0.5173545158421649 0 -357 -0.193442868509227 -0.5767656057713316 0 -358 0.3419878803943121 -0.5045479849208596 0 -359 0.03964345499374758 -0.6396249766172708 0 -360 0.2188727675700079 -0.6521456305981037 0 -361 0.2318729165784665 0.07358915109128716 0 -362 0.1021058297805448 -0.814680227389906 0 -363 0.249783898267344 -0.4917879358005596 0 -364 0.5034847299315688 -0.1006765021689996 0 -365 0.4662153121881227 0.1058958014249786 0 -366 0.07332618353488179 0.1191250094298667 0 -367 0.460832517356312 -0.237611745794315 0 -368 -0.479917895250232 -0.3811384675540024 0 -369 0.3077305949006116 -0.6735820307749127 0 -370 0.266775987343034 0.403661554251556 0 -371 -0.5078335253404545 -0.1085800469582984 0 -372 -0.201367012049343 0.2788333939787389 0 -373 0.2050343904188623 0.2198272789697197 0 -374 0.1306865074554725 -0.6461565721650109 0 -375 0.3859819990685978 -0.3606134897483774 0 -376 0.4993852676761485 0.3201165285218569 0 -377 0.4860319990196429 0.6531882455250706 0 -378 0.07706904501651238 -0.7228835044980104 0 -379 -0.4361160652578225 0.04427302365264754 0 -380 0.1450409776183777 0.6547036267625423 0 -381 -0.4868410836903728 0.5500612947763699 0 -382 -0.5757305643044726 -0.4081614681944651 0 -383 0.263771840481441 0.5400011675433607 0 -384 0.4110702747610515 0.2760245058272874 0 -385 -0.08803530681824034 0.07379012053319717 0 -386 -0.4817254415443842 0.6266685936133359 0 -387 0.323803517293315 -0.06254169478854399 0 -388 -0.5552389700183259 -0.7512480913213753 0 -389 0.382048199532339 -0.1942653002526116 0 -390 -0.1876783180126735 0.0704523036687483 0 -391 -0.4751778848396058 -0.7282117404797854 0 -392 -0.5499092797379446 -0.2564971695667416 0 -393 0.219851725292466 0.7165641113995326 0 -394 -0.01025709985129425 0.6335980648316029 0 -395 -0.5453399082494779 0.2213350026921679 0 -396 -0.2649712173238684 -0.007308662875572608 0 -397 -0.5556443425464735 -0.02299227648522159 0 -398 0.1095381188945286 0.1971049003022462 0 -399 -0.638458426110373 0.4672835956079769 0 -400 -0.346884240687709 0.6741829574741396 0 -401 -0.09139052853106094 -0.7452180316153449 0 -402 -0.2205225217227749 0.5164229450015527 0 -403 0.3552725826516125 0.5235330398028322 0 -404 -0.2535384179919559 -0.7702946536489805 0 -405 -0.3280145767961103 0.5828514106412327 0 -406 -0.5506017429376822 0.4143813270771181 0 -407 0.4585138244858044 -0.3783286933767109 0 -408 -0.3693922365705392 -0.03136873166693083 0 -409 -0.01787720021117375 0.2616733019160574 0 -410 -0.6162889521955293 0.06522506122651073 0 -411 0.2442281401814541 -0.7536003118590476 0 -412 0.4063464948286463 -0.09511288722220682 0 -413 0.3901978806057825 0.6694096544824485 0 -414 0.4655769107405767 -0.1620170550868065 0 -415 -0.3280581788905707 0.1414339049630858 0 -416 -0.5097433078936839 0.6902413533710781 0 -417 -0.2736531800614983 0.08149532696235445 0 -418 -0.5486503786802042 -0.6671297970631638 0 -419 -0.3299192792955695 0.3372239032621044 0 -420 -0.4558525340747375 0.1434082738701169 0 -421 -0.0001430320703094401 -0.8129307203378724 0 -422 0.1228448074692967 0.8568592734177389 0 -423 -0.6608430807282704 -0.1338581937882606 0 -424 -0.6375480220568117 -0.2366628276984261 0 -425 0.5252567395192239 0.5584306995877726 0 -426 -0.3857985885402326 0.8033442782404672 0 -427 0.4388826257800226 -0.3115651688221367 0 -428 -0.6410647453330565 0.3627267508193242 0 -429 -0.7496157125109288 -0.03779600491662746 0 -430 0.4269685719437261 -0.5221002644877679 0 -431 -0.5551566462594364 0.6177550872289869 0 -432 -0.4117895370221333 -0.7915426373067653 0 -433 0.6993827794551659 0.3994123302359561 0 -434 0.2556963237258529 -0.8888515505178286 0 -435 -0.3188905297627745 -0.8498142328635798 0 -436 0.6387558277118134 0.3503633375331786 0 -437 -0.6242853787726539 0.264883304686998 0 -438 -0.9264803859942226 -0.1287176948808177 0 -439 -0.1877837819603203 0.6000750655148042 0 -440 -0.2646582448657857 0.6448779789481707 0 -441 -0.152133249118561 0.9218986987885697 0 -442 -0.1644059540140628 -0.8126788887116688 0 -443 -0.2711782104860975 0.2113417508539306 0 -444 0.5863255770833402 0.06362010327612649 0 -445 0.1870563659681501 -0.8070574425014467 0 -446 -0.6922911209611479 -0.6385590572185768 0 -447 -0.1374030353756332 0.3565393869093728 0 -448 0.5901521891586549 -0.3086326577494312 0 -449 0.6182140273665455 -0.1662228358156973 0 -450 0.4693924724692355 -0.7139409480108876 0 -451 -0.5652415637379284 0.7295687888279005 0 -452 0.01981020554516885 0.1873099581572978 0 -453 0.5532382149086871 0.4597941468025001 0 -454 0.6333860539061867 0.4305455832304169 0 -455 -0.5884961619158667 -0.09257475964691164 0 -456 0.0200651639619524 0.05348660976204545 0 -457 0.481483175664595 -0.4581084009819107 0 -458 0.3556071521463915 0.4337661665395246 0 -459 0.3765635464195665 0.806863937736678 0 -460 -0.4350596127731527 0.7006073571185951 0 -461 0.5388532869391327 -0.3864492419276446 0 -462 -0.3649205668318742 0.2450053511570122 0 -463 0.6837444684437251 0.2524094462075003 0 -464 0.8572897592671798 0.3041049149239807 0 -465 0.455707508460543 0.7636911176744583 0 -466 0.6473853101215116 -0.0218761336499213 0 -467 0.6204393937082382 0.5302857844852089 0 -468 0.604706038717405 0.6532892821972947 0 -469 -0.3556647096111131 0.06208013088590247 0 -470 -0.2979660072832331 0.8722343282071957 0 -471 0.500999773378926 0.4058512661205096 0 -472 0.5047965351549493 -0.5290773716437192 0 -473 -0.6096015435690453 -0.3297708307052061 0 -474 -0.724363526056054 0.1324843044201993 0 -475 -0.1522800036552821 0.1342498878106648 0 -476 -0.2269619617449617 -0.8957097598845233 0 -477 0.7309898872604753 -0.4247363063277748 0 -478 -0.08710116339252107 -0.8332390086263972 0 -479 0.7525943858244931 -0.5604841538449994 0 -480 -0.2316541976717628 0.9192866843212151 0 -481 -0.7540127198378932 0.3400982776729103 0 -482 -0.04731981910284444 -0.9327380075711851 0 -483 0.6557530129991036 -0.3187264965268145 0 -484 0.0001724796024830111 0.4250189149856317 0 -485 0.1413853047947234 0.7593007597512331 0 -486 -0.7832727442151514 0.2334160887003146 0 -487 0.04843641505981688 0.9374508256956847 0 -488 -0.1368167665626629 -0.924135977114844 0 -489 -0.801393656822481 -0.2301204258059725 0 -490 0.3083867834800733 -0.1452090690529445 0 -491 0.1284393129705075 -0.2236424115536497 0 -492 -0.690009345595062 0.2170391717094603 0 -493 -0.4904967966076433 0.7788346059905684 0 -494 -0.3901940629776298 -0.1392267927930228 0 -495 0.9462307892661517 -0.03288038834450059 0 -496 -0.8612168712247568 0.01819684031637953 0 -497 -0.6347132090670289 0.5654415930449135 0 -498 -0.3757873431037344 -0.2612038230449293 0 -499 -0.5535867630526328 0.1334018274115283 0 -500 -0.7672059278342828 -0.3931896284192145 0 -501 0.2082911918450492 0.9074837107568923 0 -502 0.05022538082042499 -0.9358689564886321 0 -503 0.9192572979358884 -0.1002735754856719 0 -504 -0.7263884933172041 -0.3018752795664544 0 -505 0.794050110332126 0.238168529175106 0 -506 -0.847811282671954 -0.1544913865654889 0 -507 -0.850062300520715 -0.08167029746152871 0 -508 0.2144229239062995 0.8149211727830377 0 -509 0.5569168313794729 0.1643219243286201 0 -510 -0.6949443798658144 0.621123751819485 0 -511 0.740766936601075 0.1568172074017683 0 -512 -0.7203549260756636 -0.2090981075711651 0 -513 -0.2771441373982809 -0.1157961998050268 0 -514 -0.7306148554436583 0.5424321794980251 0 -515 -0.6333629286139567 0.6717401575427867 0 -516 0.8701786782657281 -0.02130556674529047 0 -517 -0.8496514132994603 -0.4065165681033898 0 -518 0.08431947107947543 0.7916518812483164 0 -519 -0.2896115579251017 -0.2111783262434401 0 -520 0.5820949408808411 -0.01668536424104822 0 -521 0.8128969600568244 -0.2934493570940539 0 -522 0.8881783120440532 -0.1696376523132233 0 -523 -0.2298578852206504 -0.2486981283679218 0 -524 0.8257959247814073 -0.1093782778331251 0 -525 -0.8047351142615391 0.4850492181537549 0 -526 0.8745470843692873 -0.2362850874305321 0 -527 0.9384132243254537 0.05632504728984392 0 -528 -0.7803546236343779 0.05476080911931544 0 -529 -0.9392659739630638 0.3431900787540593 0.4853045053070748 -530 -0.7910440875347089 0.6117591450696751 0.5065994974499256 -531 -0.5719988138472379 0.8202544464721621 0.4814977173341509 -532 -0.3321631563691106 0.9432219450113053 0.4827257257651405 -533 -0.976257028239513 0.2166153614427063 0.6475891870252556 -534 -0.9773715327029041 0.21152987274136 0.1550133699861822 -535 -0.9773717333880407 0.2115289454756884 0.8452207110393758 -536 -0.2082237520349928 0.9780812180429956 0.155013369986183 -537 -0.2082223536721352 0.9780815157394789 0.8452207110393767 -538 -0.9170851706846403 0.3986913464201653 0.730188848666249 -539 -0.9169713407336365 0.3989530802903483 0.2704348625956347 -540 -0.3995333704461671 0.9167186514410657 0.7255415625883596 -541 -0.3960002552968459 0.9182504003837041 0.2704348625956443 -542 -0.7743312367591608 0.6327804799288838 0.7186242239054739 -543 -0.7742471635225728 0.6328833461051492 0.2659954095509822 -544 -0.6205150753906394 0.7841945174591245 0.7203380202464894 -545 -0.6236087483806969 0.7817366109778026 0.279346475678474 -546 -0.8200308012207234 0.572319390768213 0.7849661320661909 -547 -0.8197181222872534 0.5727671429070101 0.211724675585628 -548 -0.6938330116902549 0.720135925981221 0.7203701015797966 -549 -0.7087300825895233 0.7054797445941645 0.2713835936847093 -550 -0.5532506283839055 0.8330148511238042 0.2365021314533479 -551 -0.563859583586875 0.8258706738934587 0.7660887336121032 -552 -0.9521096464035445 0.3057568007834298 0.2801068001767859 -553 -0.9590526003515908 0.2832280172561533 0.7104110858525614 -554 -0.3040417217066984 0.95265871720235 0.2798106581209703 -555 -0.302646566865025 0.9531028567603886 0.730951968278685 -556 -0.9783322618841703 0.2070410233663932 0.5102464682932181 -557 -0.9468003853882371 0.3218214259938049 0.1051037793552513 -558 -0.9471415746401231 0.3208158936029014 0.8952277138523819 -559 -0.2484412514299149 0.968646965920989 0.4507211129046973 -560 -0.9632467987882811 0.2686179529073379 0.4583994794810094 -561 -0.3200400970450523 0.9474039984522935 0.8956647033164949 -562 -0.3201027425132446 0.9473828340409697 0.1045226755995171 -563 -0.09599045523053115 0.9953822544654065 0.1518565625972821 -564 -0.9917010042378518 0.1285656182407896 0.193268491832901 -565 -0.09591032412551498 0.9953899787149452 0.8484107219212023 -566 -0.9954278585644667 0.09551637762059594 0.8387307346163252 -567 -0.4799930755812677 0.8772722766587552 0.5200271789959322 -568 -0.1225768780414963 0.9924590213049603 0.3344928251825433 -569 -0.99785299821021 0.06549346503961016 0.3686037582349758 -570 -0.1134139469512339 0.9935478230246108 0.6850853379155327 -571 -0.9829507090551584 0.1838692567232527 0.7403139815082466 -572 -0.9760418753891588 0.2175827600863954 0.2494023512510187 -573 -0.190335338890567 0.9817191343604409 0.7613409421317954 -574 -0.1930648274956744 0.981186002949525 0.2449781568693677 -575 -0.147211115719889 0.9891050942182561 0.07136282521062355 -576 -0.1471976091077919 0.9891071043486392 0.9287207357133048 -577 -0.9901589340385734 0.1399474377886074 0.08763524409677081 -578 -0.989368251606483 0.1454319865543031 0.9274236977940166 -579 -0.9714494031355834 0.2372468274761939 0.9286929813193815 -580 -0.2347678235345355 0.9720514744769729 0.928692981319382 -581 -0.9714494031355836 0.2372468274761939 0.07130701868036859 -582 -0.2347678235345355 0.9720514744769729 0.07130701868036907 -583 -0.4127048754811398 0.9108648010292728 0.8287512276305901 -584 -0.412815605756743 0.9108146219970852 0.1715531066908904 -585 -0.9103476658722549 0.4138443273030781 0.8288225979501729 -586 -0.9102136670476255 0.414138962571399 0.1714606702132057 -587 -0.8608623997098688 0.5088378216738276 0.8552803917457172 -588 -0.860783214044285 0.5089717658373505 0.1453605815360826 -589 -0.5285226454485201 0.8489192030152799 0.8515789592584662 -590 -0.5119929795555076 0.8589896325834634 0.1498838347523728 -591 -0.8034567472531505 0.5953631289334155 0.9054190855904765 -592 -0.8033643991244999 0.5954877347345882 0.0947383726413541 -593 -0.6241718901836503 0.7812870480844855 0.6468292058396435 -594 -0.6022867880200611 0.7982797911612682 0.3888613754502612 -595 -0.6203732305115662 0.784306735190157 0.8782290054956053 -596 -0.7767775795542315 0.6297750327711233 0.6227108425139345 -597 -0.7825327843815513 0.6226093810472636 0.3901404025448285 -598 -0.8410837335028298 0.5409049391870451 0.5835939469904714 -599 -0.4467875343044753 0.8946400947812072 0.3550393821918137 -600 -0.4577522859129598 0.8890797741156077 0.6236300628665049 -601 -0.8982453655404812 0.4394943267950649 0.3455811173650706 -602 -0.8881607685216673 0.459532859825063 0.6444441107963509 -603 -0.9354999055644357 0.3533269402252418 0.3838063280620518 -604 -0.343766908597223 0.9390550103979579 0.3762575963868008 -605 -0.9315110824488644 0.3637129407581547 0.6500608739098623 -606 -0.1594267077119825 0.9872097674091955 0.5015720744903065 -607 -0.9902279080786904 0.139458560375835 0.520404853765381 -608 -0.9406431617634041 0.3393971747492104 0.2058962262494543 -609 -0.9407980328883836 0.3389676405106363 0.794300559631808 -610 -0.337994715850797 0.9411480075189762 0.2043807860672182 -611 -0.3378019589015478 0.9412172100861083 0.7960865110542177 -612 -0.9713692711195613 0.2375747021983868 0.3443106388821362 -613 -0.2366674226153946 0.9715907219979956 0.3507670320593466 -614 -0.4794601168929118 0.8775636708006064 0.2537092784272525 -615 -0.4892241231716311 0.8721581033889146 0.7493404207156225 -616 -0.2335891576040041 0.9723353873277737 0.6601723214871175 -617 -0.9880775455805693 0.1539570197148497 0.4160350555416725 -618 -0.1680495575669629 0.9857785482559194 0.4137323719488888 -619 -0.8709174817609662 0.4914292827692883 0.2617419401432236 -620 -0.8775678210357059 0.4794525205717909 0.7517433084229413 -621 -0.9616557147811302 0.274259523496986 0.2020887668327065 -622 -0.9638125933169048 0.2665807287928786 0.7999914937630218 -623 -0.2692199368894629 0.9630787224216064 0.1989553769690583 -624 -0.2689728786855852 0.9631477511428811 0.801701458053507 -625 -0.9923710297079829 0.1232872231673583 0.3024388953859542 -626 -0.6592289674337952 0.7519422640709673 0.08855713328539629 -627 -0.6638546340676276 0.7478616348141789 0.9361130185885662 -628 -0.08256773356514305 0.9965854551286184 0.2462655089296034 -629 -0.08009532145498227 0.9967872087266285 0.7587593124244638 -630 -0.5816556859568672 0.8134351006651028 0.07963255512519031 -631 -0.5873720385379984 0.8093170505702424 0.9327662573137641 -632 -0.2709036564203072 0.9626064662872925 0.5550280167600687 -633 -0.8370470625428161 0.5471308939261637 0.4227677696172704 -634 -0.8928519438111826 0.4503503152353654 0.451532616094026 -635 -0.4030236676702685 0.9151895559377878 0.4581328622645257 -636 -0.8780377543489088 0.4785913726112548 0.5560411503580756 -637 -0.5452052368522714 0.838302600323331 0.6765540585427813 -638 -0.5355530888787133 0.8445015624570917 0.3268783278459751 -639 -0.6407169877641398 0.7677771431805241 0.8032725700360669 -640 -0.9905458034711798 0.1371824012970861 0.6327129258777549 -641 -0.8264468756654157 0.5630147082473714 0.319564657021652 -642 -0.8980665702352384 0.4398595632993736 0.08090774732524031 -643 -0.8981820869621584 0.4396236329638134 0.9193131124339943 -644 -0.4367659793335928 0.8995751660071366 0.08136404926766995 -645 -0.4369499654229247 0.8994858129603296 0.9187925777178435 -646 -0.9182965549395954 0.3958932143723487 0.5642856417400383 -647 -0.3901820204806273 0.9207377427333233 0.5455350337682113 -648 -0.9980764147957163 0.0619957275022175 0.2279130430791431 -649 -0.5082777045975883 0.8611932274518922 0.4217394740137765 -650 -0.7338743475880671 0.6792852434376802 0.09279949762658779 -651 -0.7304062529379254 0.6830129615674796 0.9196958588270968 -652 -0.9975970715691886 0.06928262983301939 0.5613627352683926 -653 -0.06783673488491912 0.9976964354953632 0.5468889514127163 -654 -0.9979903262038186 0.06336646434507676 0.1431361298346825 -655 -0.5553740206445431 0.8316006837377629 0.5854546527251471 -656 -0.9581766432947076 0.2861774279087822 0.5764151123665553 -657 -0.6799067216544399 0.7332986089234808 0.8703264754542905 -658 -0.5166865487080223 0.8561746377837832 0.05951018826482166 -659 -0.5170140758981195 0.8559768953209038 0.9406275588580146 -660 -0.1446360123998852 0.9894849285952061 0.6008706330982989 -661 -0.7002047403784886 0.7139420995791559 0.6313158256035638 -662 -0.7309960010581641 0.6823817453866806 0.3445208680272688 -663 -0.9973272103516628 0.07306459807711095 0.455597259885667 -664 -0.07119254902843161 0.9974625912598599 0.4311088151075504 -665 -0.7378153617373853 0.6750025866501037 0.8209420210564629 -666 -0.7580184601732105 0.6522330979309737 0.18913565398189 -667 -0.06834012583269218 0.9976620806671825 0.9354262915268488 -668 -0.06835891337518497 0.9976607935376453 0.06464387756154406 -669 -0.997907163028794 0.06466292582171237 0.9336104384398454 -670 -0.9981765704843149 0.06036169427850549 0.06615427478625358 -671 -0.9967540036162204 0.08050749204288717 0.728536502347487 -672 -0.6545605735833732 0.7560095604621714 0.4631460067468154 -673 -0.715975097433559 0.6981258195017612 0.5381112769416089 -674 -0.7264076351120679 0.6872641032753659 0.4335380466697727 -675 -0.6712125326907644 0.7412649566510272 0.3587102283081879 -676 -0.8664292457048364 0.4992998720081436 0.3603898399304167 -677 -0.3436601016845758 0.9390941031175453 0.6401431609581579 -678 -0.6028903872205806 0.7978240288415852 0.1681898142258756 -679 -0.8569646300728165 0.5153752252525928 0.0642013403005354 -680 -0.8570237264818297 0.515276947133479 0.9360025179540374 -681 -0.6389928972891724 0.7692126345907152 0.5577257808651549 -682 -0.06529201612343202 0.9978661997635441 0.6265689844849409 -683 -0.8323524102678153 0.5542467547233438 0.6843470941158939 -684 -0.6831295865724666 0.7302971778319639 0.1815686947471554 -685 -0.9983467643023074 0.05747815417280498 0.6445224326983582 -686 -0.9802781326930307 0.1976228290554131 0.577473709465633 -687 -0.8525628048494924 0.5226247829821757 0.5045741076085684 -688 -0.7375385805460219 0.6753049993937252 0.6732552484006923 -689 0.3381053423938106 0.9411082708406957 0.48686309530787 -690 0.5578774126813952 0.8299233653897884 0.5006686618978221 -691 0.8288849281008572 0.5594191415810121 0.500207042435953 -692 0.7731686146977866 0.6342005150157998 0.5000460094301914 -693 0.7038051791569101 0.7103930389523183 0.5090545604503189 -694 0.9434124383040732 0.3316217291631589 0.4824350679296279 -695 0.214550755462004 0.9767128407729078 0.6468308443228235 -696 0.21152987274136 0.9773715327029041 0.1550133699861822 -697 0.2115289454756884 0.9773717333880407 0.8452207110393758 -698 0.9780812180429956 0.2082237520349928 0.155013369986183 -699 0.9780815157394789 0.2082223536721352 0.8452207110393767 -700 0.3987141415220682 0.9170752604613865 0.730188848666249 -701 0.3989758725627935 0.9169614240047165 0.2704348625956347 -702 0.9156662291153456 0.4019394940257591 0.7266515428182212 -703 0.9151803365955496 0.4030446023814936 0.2773766258591942 -704 0.6422894623907452 0.7664621624723605 0.7437915935065398 -705 0.6422895492414902 0.7664620896920886 0.2562224700968316 -706 0.5765912652789796 0.817032748917683 0.7894097116192326 -707 0.576607552772475 0.8170212543659667 0.2106882331486446 -708 0.7051857567767542 0.709022600795769 0.7911003150658646 -709 0.7051857326013364 0.7090226248403619 0.2089026989132541 -710 0.3057838391552551 0.9521009629821162 0.2801229499435473 -711 0.2832586916997101 0.9590435410222879 0.7103914861025569 -712 0.9526593770533667 0.3040396541773649 0.2798106581209703 -713 0.9528630939798993 0.303400600083543 0.7217747973061267 -714 0.2041034648630271 0.9789493222996313 0.5094787801197229 -715 0.3218296432111831 0.9467975922817733 0.1051037793552513 -716 0.3208241117795892 0.9471387909387079 0.8952277138523819 -717 0.9686554801791342 0.2484080528463825 0.450623328048122 -718 0.264392651299446 0.9644151211687059 0.4580271780099038 -719 0.9474052240010381 0.3200364690711713 0.8956647033164949 -720 0.9473840598296077 0.3200991146204094 0.1045226755995171 -721 0.9953822587169444 0.09599041114378976 0.1518565625972821 -722 0.1285658529987508 0.9917009738034464 0.1932685639300739 -723 0.9953899829629337 0.09591028003843169 0.8484107219212023 -724 0.09551805258918585 0.9954276978412691 0.8387297321767953 -725 0.8825695805397716 0.4701818111176268 0.5010284637957932 -726 0.9924586226138771 0.1225801060505563 0.3344952694480511 -727 0.06549422878991448 0.997852948081637 0.3686042196568833 -728 0.9935527948484828 0.1133703834727953 0.6851014280042834 -729 0.1836501852447154 0.9829916629654505 0.7402212808152396 -730 0.2175917427264787 0.976039872903384 0.2494077945875833 -731 0.9817185258431241 0.1903384774983847 0.7613382933461124 -732 0.9811855411131207 0.193067174606541 0.2449803018370584 -733 0.4703682308669898 0.8824702416461747 0.5010284637957796 -734 0.9891050953049507 0.1472111084184361 0.07136282521062358 -735 0.9891071054352339 0.1471976018063241 0.9287207357133048 -736 0.1399474712733105 0.9901589293058999 0.08763525439636698 -737 0.1454319985037227 0.9893682498499805 0.9274236977940166 -738 0.2372468274761939 0.9714494031355834 0.9286929813193815 -739 0.9720514744769729 0.2347678235345355 0.928692981319382 -740 0.2372468274761939 0.9714494031355836 0.07130701868036859 -741 0.9720514744769729 0.2347678235345355 0.07130701868036907 -742 0.9107150276292214 0.4130352750677674 0.8284643483065787 -743 0.9106648084316474 0.4131459871330603 0.1718399860149018 -744 0.4141389257000954 0.9102136838237331 0.8285146806861833 -745 0.414433517906914 0.9100795895059397 0.1717685874771955 -746 0.5121826756995009 0.858876537526378 0.8635028892787803 -747 0.5122415817462456 0.8588414067393959 0.1366292421419629 -748 0.863382047225182 0.5045507313732223 0.8701189833055687 -749 0.863330258699225 0.5046393409300638 0.1300844628116332 -750 0.6079342330637956 0.7939873854597028 0.8673114275268556 -751 0.6079461041528296 0.7939782959536092 0.1327275432764892 -752 0.7518436864041959 0.6593413920073191 0.6397587303385693 -753 0.7595008632666285 0.6505062941257724 0.3589430136488505 -754 0.7559695442353253 0.6546067889875834 0.8504068554959977 -755 0.7559593471439295 0.6546185648648563 0.1496364099835539 -756 0.6878900256483247 0.7258149300018202 0.8641667207247912 -757 0.6878906583670203 0.7258143303430895 0.1358468490393105 -758 0.7088605072100402 0.7053486948438514 0.3863042485762619 -759 0.628498149982987 0.7778110795482172 0.6369819110393535 -760 0.6357868174084842 0.7718647049901886 0.367703034344145 -761 0.8988853619558075 0.4381838724343663 0.389712874777665 -762 0.9014677528795971 0.4328462666099934 0.6155205300844736 -763 0.4542944621247975 0.8908515822979384 0.3747600196518778 -764 0.4535157552401815 0.8912482593244869 0.6319675611756562 -765 0.348823531782111 0.9371884248511901 0.3830801192165508 -766 0.9392650317621979 0.3431926574225581 0.3753723003803118 -767 0.3630728032082929 0.9317607737882467 0.6474484254462448 -768 0.9407688723551328 0.3390485640843384 0.6462536070988469 -769 0.9871720353390406 0.1596601786438167 0.5016783465833288 -770 0.1382003190968983 0.9904042971441085 0.5200694441078569 -771 0.3394091991259667 0.94063882311367 0.2058962262494543 -772 0.3389796668671718 0.9407936997294472 0.794300559631808 -773 0.9411500637078871 0.3379889903275545 0.2043807860672182 -774 0.9412192651023721 0.3377962329573119 0.7960865110542177 -775 0.2360927673670301 0.9717305208734452 0.344131537198179 -776 0.9715865991953082 0.2366843473153553 0.350779602567673 -777 0.8711474380695429 0.4910215281888076 0.2320050762715046 -778 0.8713902801358597 0.4905904398627717 0.7691427659277738 -779 0.9746161867744557 0.2238823094333697 0.6679523812751348 -780 0.4958309159444523 0.8684190824674948 0.2617330872502885 -781 0.4949659372144667 0.8689123782047328 0.7390555056582565 -782 0.1531265427889614 0.9882065886713671 0.4159542361942153 -783 0.985770948837291 0.1680941296667648 0.4137371267499861 -784 0.2742627788670027 0.9616547863595073 0.2020887668327065 -785 0.2665839751672952 0.9638116953969809 0.799991493763022 -786 0.9630791835323875 0.2692182873554287 0.1989553769690583 -787 0.9631482118305077 0.2689712290333209 0.8017014580535069 -788 0.1229533128716197 0.9924124560150852 0.3024026382457511 -789 0.7364213903365932 0.6765231229268659 0.06873818537969169 -790 0.7364224481514815 0.6765219714529446 0.9312704312360501 -791 0.9965853626461465 0.08256884981304313 0.2462664267762432 -792 0.9967870828273435 0.08009688825762504 0.7587580912893692 -793 0.8077149146747965 0.5895732495728468 0.08025923815508461 -794 0.80772799670595 0.589555326782307 0.9197964338833367 -795 0.7610005977031652 0.6487511774905886 0.2499458384173447 -796 0.7609977955730836 0.6487544644416001 0.7501534395836589 -797 0.6697506479845857 0.7425860687652492 0.4500525850211241 -798 0.6928610895577502 0.7210710856613565 0.594625192253311 -799 0.745271562315587 0.6667610504548718 0.5640344451007628 -800 0.7416378109756854 0.6708005346831452 0.4377342247379005 -801 0.6308114572680596 0.7759361477462865 0.5293712500969264 -802 0.6096825654166106 0.7926456771010743 0.4511841109784971 -803 0.7979249960194321 0.6027567508766611 0.5766877330314233 -804 0.7978672972136939 0.6028331245352357 0.4236635609489023 -805 0.9651748411129382 0.2616056690567208 0.5563653459193444 -806 0.6452498418516237 0.7639716235505443 0.8111559536886566 -807 0.6452553175777475 0.7639669987228771 0.188877558894906 -808 0.404076108578049 0.9147253677888357 0.4607559303594634 -809 0.5488394688405127 0.8359277704699515 0.4081250235324678 -810 0.9152447706418716 0.4028982623600005 0.4566198579151338 -811 0.571360312478101 0.8206993318657736 0.3083908920664721 -812 0.5697678248005942 0.8218057105070513 0.6896042134173657 -813 0.8219431007112379 0.5695696087338191 0.3122918242932954 -814 0.5466568250595858 0.8373567433392852 0.5946703801427451 -815 0.8211673056272303 0.5706875293616593 0.6881524363061742 -816 0.1362033612785504 0.9906808993699356 0.632395075189614 -817 0.6986365656171925 0.7154767286101025 0.6927351969645495 -818 0.6916770744583267 0.7222069126426098 0.3094264056775545 -819 0.4347116758777763 0.9005696857298358 0.07943761641792425 -820 0.4344928990469912 0.9006752581689703 0.9206881695858703 -821 0.9004833121806654 0.4348905661015633 0.07956007053366478 -822 0.9005002323121296 0.4348555295794234 0.9205460758603929 -823 0.3845387214456464 0.9231088623282453 0.5549532633728871 -824 0.9263676444988843 0.3766204816862578 0.5445483494034266 -825 0.8541660678773146 0.5200003158527952 0.4050524416214326 -826 0.06192861001241663 0.9980805815473666 0.2279058060705371 -827 0.06877962922699229 0.9976318772991356 0.5612154380101058 -828 0.9976980878343419 0.06781242903552351 0.5468989232494289 -829 0.8546579018219774 0.5191915550673522 0.5965983418290685 -830 0.0633553240804339 0.9979910334820965 0.1431349373993763 -831 0.6610759710154466 0.7503189725350039 0.0666573911291488 -832 0.6610741169732972 0.750320606053156 0.9333530190466863 -833 0.2825977874114191 0.9592384951356834 0.5748019905614467 -834 0.8576536770996944 0.5142277415283748 0.0573902217991977 -835 0.8576629850772776 0.5142122169185926 0.9426648276412184 -836 0.5121632231684254 0.8588881375556012 0.05573972552785768 -837 0.582050614846911 0.8131525574923397 0.06529231701257641 -838 0.5799032712327417 0.8146853355827421 0.9335085115917 -839 0.5116863082843304 0.8591723470377484 0.94353991409127 -840 0.9894268335915154 0.1450328961617584 0.6010663410969236 -841 0.07292722615963204 0.9973372647628591 0.4555825714750588 -842 0.9974623650720889 0.07119571802289322 0.4311090871027557 -843 0.9976620813734524 0.06834011552222477 0.9354262915268488 -844 0.9976607942441091 0.06835890306473064 0.06464387756154406 -845 0.06466294269528391 0.997907161935411 0.9336104384398454 -846 0.06035947256158727 0.9981767048334113 0.06615403835911161 -847 0.08020212936273061 0.9967786205801584 0.7284319375784661 -848 0.5183131521147537 0.8551909005274017 0.3382522556252766 -849 0.5169404207780519 0.8560213790354834 0.6638244150985059 -850 0.8166336690143664 0.5771563485158373 0.1936052800509082 -851 0.8167230442147786 0.5770298684197769 0.8066831678712415 -852 0.9978618503450922 0.06535845489199768 0.6266133384697585 -853 0.0571189705257036 0.9983673788771763 0.6444084901552684 -854 0.1954444258996562 0.9807147783044537 0.5767152268602928 -855 0.8742523119958985 0.4854718271638698 0.3232877685646184 -856 0.8749521618662024 0.4842093704645323 0.6792131233931421 -857 0.9392659739630638 -0.3431900787540593 0.4853045053070748 -858 0.7910440875347089 -0.6117591450696751 0.5065994974499256 -859 0.5719988138472379 -0.8202544464721621 0.4814977173341509 -860 0.3321631563691106 -0.9432219450113053 0.4827257257651405 -861 0.976257028239513 -0.2166153614427063 0.6475891870252556 -862 0.9773715327029041 -0.21152987274136 0.1550133699861822 -863 0.9773717333880407 -0.2115289454756884 0.8452207110393758 -864 0.2082237520349928 -0.9780812180429956 0.155013369986183 -865 0.2082223536721352 -0.9780815157394789 0.8452207110393767 -866 0.9170851706846403 -0.3986913464201653 0.730188848666249 -867 0.9169713407336365 -0.3989530802903483 0.2704348625956347 -868 0.3995333704461671 -0.9167186514410657 0.7255415625883596 -869 0.3960002552968459 -0.9182504003837041 0.2704348625956443 -870 0.7743312367591608 -0.6327804799288838 0.7186242239054739 -871 0.7742471635225728 -0.6328833461051492 0.2659954095509822 -872 0.6205150753906394 -0.7841945174591245 0.7203380202464894 -873 0.6236087483806969 -0.7817366109778026 0.279346475678474 -874 0.8200308012207234 -0.572319390768213 0.7849661320661909 -875 0.8197181222872534 -0.5727671429070101 0.211724675585628 -876 0.6938330116902549 -0.720135925981221 0.7203701015797966 -877 0.7087300825895233 -0.7054797445941645 0.2713835936847093 -878 0.563859583586875 -0.8258706738934587 0.7660887336121032 -879 0.5532506283839055 -0.8330148511238042 0.2365021314533479 -880 0.9521096464035445 -0.3057568007834298 0.2801068001767859 -881 0.9590526003515908 -0.2832280172561533 0.7104110858525614 -882 0.3040417217066984 -0.95265871720235 0.2798106581209703 -883 0.302646566865025 -0.9531028567603886 0.730951968278685 -884 0.9783322618841703 -0.2070410233663932 0.5102464682932181 -885 0.9468003853882371 -0.3218214259938049 0.1051037793552513 -886 0.9471415746401231 -0.3208158936029014 0.8952277138523819 -887 0.2484412514299149 -0.968646965920989 0.4507211129046973 -888 0.9632467987882811 -0.2686179529073379 0.4583994794810094 -889 0.3200400970450523 -0.9474039984522935 0.8956647033164949 -890 0.3201027425132446 -0.9473828340409697 0.1045226755995171 -891 0.09599045523053115 -0.9953822544654065 0.1518565625972821 -892 0.9917010042378518 -0.1285656182407896 0.193268491832901 -893 0.09591032412551498 -0.9953899787149452 0.8484107219212023 -894 0.9954278585644667 -0.09551637762059594 0.8387307346163252 -895 0.4799930755812677 -0.8772722766587552 0.5200271789959322 -896 0.1225768780414963 -0.9924590213049603 0.3344928251825433 -897 0.99785299821021 -0.06549346503961016 0.3686037582349758 -898 0.1134139469512339 -0.9935478230246108 0.6850853379155327 -899 0.9829507090551584 -0.1838692567232527 0.7403139815082466 -900 0.9760418753891588 -0.2175827600863954 0.2494023512510187 -901 0.190335338890567 -0.9817191343604409 0.7613409421317954 -902 0.1930648274956744 -0.981186002949525 0.2449781568693677 -903 0.147211115719889 -0.9891050942182561 0.07136282521062355 -904 0.1471976091077919 -0.9891071043486392 0.9287207357133048 -905 0.9901589340385734 -0.1399474377886074 0.08763524409677081 -906 0.989368251606483 -0.1454319865543031 0.9274236977940166 -907 0.9714494031355834 -0.2372468274761939 0.9286929813193815 -908 0.2347678235345355 -0.9720514744769729 0.928692981319382 -909 0.9714494031355836 -0.2372468274761939 0.07130701868036859 -910 0.2347678235345355 -0.9720514744769729 0.07130701868036907 -911 0.4127048754811398 -0.9108648010292728 0.8287512276305901 -912 0.412815605756743 -0.9108146219970852 0.1715531066908904 -913 0.9103476658722549 -0.4138443273030781 0.8288225979501729 -914 0.9102136670476255 -0.414138962571399 0.1714606702132057 -915 0.8608623997098688 -0.5088378216738276 0.8552803917457172 -916 0.860783214044285 -0.5089717658373505 0.1453605815360826 -917 0.5285226454485201 -0.8489192030152799 0.8515789592584662 -918 0.5119929795555076 -0.8589896325834634 0.1498838347523728 -919 0.8034567472531505 -0.5953631289334155 0.9054190855904765 -920 0.8033643991244999 -0.5954877347345882 0.0947383726413541 -921 0.6241718901836503 -0.7812870480844855 0.6468292058396435 -922 0.6022867880200611 -0.7982797911612682 0.3888613754502612 -923 0.6203732305115662 -0.784306735190157 0.8782290054956053 -924 0.7767775795542315 -0.6297750327711233 0.6227108425139345 -925 0.7825327843815513 -0.6226093810472636 0.3901404025448285 -926 0.8410837335028298 -0.5409049391870451 0.5835939469904714 -927 0.4467875343044753 -0.8946400947812072 0.3550393821918137 -928 0.4577522859129598 -0.8890797741156077 0.6236300628665049 -929 0.8982453655404812 -0.4394943267950649 0.3455811173650706 -930 0.8881607685216673 -0.459532859825063 0.6444441107963509 -931 0.9354999055644357 -0.3533269402252418 0.3838063280620518 -932 0.343766908597223 -0.9390550103979579 0.3762575963868008 -933 0.9315110824488644 -0.3637129407581547 0.6500608739098623 -934 0.1594267077119825 -0.9872097674091955 0.5015720744903065 -935 0.9902279080786904 -0.139458560375835 0.520404853765381 -936 0.9406431617634041 -0.3393971747492104 0.2058962262494543 -937 0.9407980328883836 -0.3389676405106363 0.794300559631808 -938 0.337994715850797 -0.9411480075189762 0.2043807860672182 -939 0.3378019589015478 -0.9412172100861083 0.7960865110542177 -940 0.9713692711195613 -0.2375747021983868 0.3443106388821362 -941 0.2366674226153946 -0.9715907219979956 0.3507670320593466 -942 0.4794601168929118 -0.8775636708006064 0.2537092784272525 -943 0.4892241231716311 -0.8721581033889146 0.7493404207156225 -944 0.2335891576040041 -0.9723353873277737 0.6601723214871175 -945 0.9880775455805693 -0.1539570197148497 0.4160350555416725 -946 0.1680495575669629 -0.9857785482559194 0.4137323719488888 -947 0.8709174817609662 -0.4914292827692883 0.2617419401432236 -948 0.8775678210357059 -0.4794525205717909 0.7517433084229413 -949 0.9616557147811302 -0.274259523496986 0.2020887668327065 -950 0.9638125933169048 -0.2665807287928786 0.7999914937630218 -951 0.2692199368894629 -0.9630787224216064 0.1989553769690583 -952 0.2689728786855852 -0.9631477511428811 0.801701458053507 -953 0.9923710297079829 -0.1232872231673583 0.3024388953859542 -954 0.6592289674337952 -0.7519422640709673 0.08855713328539629 -955 0.6638546340676276 -0.7478616348141789 0.9361130185885662 -956 0.08256773356514305 -0.9965854551286184 0.2462655089296034 -957 0.08009532145498227 -0.9967872087266285 0.7587593124244638 -958 0.5816556859568672 -0.8134351006651028 0.07963255512519031 -959 0.5873720385379984 -0.8093170505702424 0.9327662573137641 -960 0.2709036564203072 -0.9626064662872925 0.5550280167600687 -961 0.8370470625428161 -0.5471308939261637 0.4227677696172704 -962 0.8928519438111826 -0.4503503152353654 0.451532616094026 -963 0.4030236676702685 -0.9151895559377878 0.4581328622645257 -964 0.8780377543489088 -0.4785913726112548 0.5560411503580756 -965 0.5452052368522714 -0.838302600323331 0.6765540585427813 -966 0.5355530888787133 -0.8445015624570917 0.3268783278459751 -967 0.6407169877641398 -0.7677771431805241 0.8032725700360669 -968 0.9905458034711798 -0.1371824012970861 0.6327129258777549 -969 0.8264468756654157 -0.5630147082473714 0.319564657021652 -970 0.8980665702352384 -0.4398595632993736 0.08090774732524031 -971 0.8981820869621584 -0.4396236329638134 0.9193131124339943 -972 0.4367659793335928 -0.8995751660071366 0.08136404926766995 -973 0.4369499654229247 -0.8994858129603296 0.9187925777178435 -974 0.9182965549395954 -0.3958932143723487 0.5642856417400383 -975 0.3901820204806273 -0.9207377427333233 0.5455350337682113 -976 0.9980764147957163 -0.0619957275022175 0.2279130430791431 -977 0.5082777045975883 -0.8611932274518922 0.4217394740137765 -978 0.7338743475880671 -0.6792852434376802 0.09279949762658779 -979 0.7304062529379254 -0.6830129615674796 0.9196958588270968 -980 0.9975970715691886 -0.06928262983301939 0.5613627352683926 -981 0.06783673488491912 -0.9976964354953632 0.5468889514127163 -982 0.9979903262038186 -0.06336646434507676 0.1431361298346825 -983 0.5553740206445431 -0.8316006837377629 0.5854546527251471 -984 0.9581766432947076 -0.2861774279087822 0.5764151123665553 -985 0.6799067216544399 -0.7332986089234808 0.8703264754542905 -986 0.5166865487080223 -0.8561746377837832 0.05951018826482166 -987 0.5170140758981195 -0.8559768953209038 0.9406275588580146 -988 0.1446360123998852 -0.9894849285952061 0.6008706330982989 -989 0.7002047403784886 -0.7139420995791559 0.6313158256035638 -990 0.7309960010581641 -0.6823817453866806 0.3445208680272688 -991 0.9973272103516628 -0.07306459807711095 0.455597259885667 -992 0.07119254902843161 -0.9974625912598599 0.4311088151075504 -993 0.7378153617373853 -0.6750025866501037 0.8209420210564629 -994 0.7580184601732105 -0.6522330979309737 0.18913565398189 -995 0.06834012583269218 -0.9976620806671825 0.9354262915268488 -996 0.06835891337518497 -0.9976607935376453 0.06464387756154406 -997 0.997907163028794 -0.06466292582171237 0.9336104384398454 -998 0.9981765704843149 -0.06036169427850549 0.06615427478625358 -999 0.9967540036162204 -0.08050749204288717 0.728536502347487 -1000 0.6545605735833732 -0.7560095604621714 0.4631460067468154 -1001 0.715975097433559 -0.6981258195017612 0.5381112769416089 -1002 0.7264076351120679 -0.6872641032753659 0.4335380466697727 -1003 0.6712125326907644 -0.7412649566510272 0.3587102283081879 -1004 0.8664292457048364 -0.4992998720081436 0.3603898399304167 -1005 0.3436601016845758 -0.9390941031175453 0.6401431609581579 -1006 0.6028903872205806 -0.7978240288415852 0.1681898142258756 -1007 0.8569646300728165 -0.5153752252525928 0.0642013403005354 -1008 0.8570237264818297 -0.515276947133479 0.9360025179540374 -1009 0.6389928972891724 -0.7692126345907152 0.5577257808651549 -1010 0.06529201612343202 -0.9978661997635441 0.6265689844849409 -1011 0.8323524102678153 -0.5542467547233438 0.6843470941158939 -1012 0.6831295865724666 -0.7302971778319639 0.1815686947471554 -1013 0.9983467643023074 -0.05747815417280498 0.6445224326983582 -1014 0.9802781326930307 -0.1976228290554131 0.577473709465633 -1015 0.8525628048494924 -0.5226247829821757 0.5045741076085684 -1016 0.7375385805460219 -0.6753049993937252 0.6732552484006923 -1017 -0.3431900787540593 -0.9392659739630638 0.4853045053070748 -1018 -0.6117591450696751 -0.7910440875347089 0.5065994974499256 -1019 -0.8202544464721621 -0.5719988138472379 0.4814977173341509 -1020 -0.9432219450113053 -0.3321631563691106 0.4827257257651405 -1021 -0.2166153614427063 -0.976257028239513 0.6475891870252556 -1022 -0.21152987274136 -0.9773715327029041 0.1550133699861822 -1023 -0.2115289454756884 -0.9773717333880407 0.8452207110393758 -1024 -0.9780812180429956 -0.2082237520349928 0.155013369986183 -1025 -0.9780815157394789 -0.2082223536721352 0.8452207110393767 -1026 -0.3986913464201653 -0.9170851706846403 0.730188848666249 -1027 -0.3989530802903483 -0.9169713407336365 0.2704348625956347 -1028 -0.9167186514410657 -0.3995333704461671 0.7255415625883596 -1029 -0.9182504003837041 -0.3960002552968459 0.2704348625956443 -1030 -0.6327804799288838 -0.7743312367591608 0.7186242239054739 -1031 -0.6328833461051492 -0.7742471635225728 0.2659954095509822 -1032 -0.7841945174591245 -0.6205150753906394 0.7203380202464894 -1033 -0.7817366109778026 -0.6236087483806969 0.279346475678474 -1034 -0.572319390768213 -0.8200308012207234 0.7849661320661909 -1035 -0.5727671429070101 -0.8197181222872534 0.211724675585628 -1036 -0.720135925981221 -0.6938330116902549 0.7203701015797966 -1037 -0.7054797445941645 -0.7087300825895233 0.2713835936847093 -1038 -0.8330148511238042 -0.5532506283839055 0.2365021314533479 -1039 -0.8258706738934587 -0.563859583586875 0.7660887336121032 -1040 -0.3057568007834298 -0.9521096464035445 0.2801068001767859 -1041 -0.2832280172561533 -0.9590526003515908 0.7104110858525614 -1042 -0.95265871720235 -0.3040417217066984 0.2798106581209703 -1043 -0.9531028567603886 -0.302646566865025 0.730951968278685 -1044 -0.2070410233663932 -0.9783322618841703 0.5102464682932181 -1045 -0.3218214259938049 -0.9468003853882371 0.1051037793552513 -1046 -0.3208158936029014 -0.9471415746401231 0.8952277138523819 -1047 -0.968646965920989 -0.2484412514299149 0.4507211129046973 -1048 -0.2686179529073379 -0.9632467987882811 0.4583994794810094 -1049 -0.9474039984522935 -0.3200400970450523 0.8956647033164949 -1050 -0.9473828340409697 -0.3201027425132446 0.1045226755995171 -1051 -0.9953822544654065 -0.09599045523053115 0.1518565625972821 -1052 -0.1285656182407896 -0.9917010042378518 0.193268491832901 -1053 -0.9953899787149452 -0.09591032412551498 0.8484107219212023 -1054 -0.09551637762059594 -0.9954278585644667 0.8387307346163252 -1055 -0.8772722766587552 -0.4799930755812677 0.5200271789959322 -1056 -0.9924590213049603 -0.1225768780414963 0.3344928251825433 -1057 -0.06549346503961016 -0.99785299821021 0.3686037582349758 -1058 -0.9935478230246108 -0.1134139469512339 0.6850853379155327 -1059 -0.1838692567232527 -0.9829507090551584 0.7403139815082466 -1060 -0.2175827600863954 -0.9760418753891588 0.2494023512510187 -1061 -0.9817191343604409 -0.190335338890567 0.7613409421317954 -1062 -0.981186002949525 -0.1930648274956744 0.2449781568693677 -1063 -0.9891050942182561 -0.147211115719889 0.07136282521062355 -1064 -0.9891071043486392 -0.1471976091077919 0.9287207357133048 -1065 -0.1399474377886074 -0.9901589340385734 0.08763524409677081 -1066 -0.1454319865543031 -0.989368251606483 0.9274236977940166 -1067 -0.2372468274761939 -0.9714494031355834 0.9286929813193815 -1068 -0.9720514744769729 -0.2347678235345355 0.928692981319382 -1069 -0.2372468274761939 -0.9714494031355836 0.07130701868036859 -1070 -0.9720514744769729 -0.2347678235345355 0.07130701868036907 -1071 -0.9108648010292728 -0.4127048754811398 0.8287512276305901 -1072 -0.9108146219970852 -0.412815605756743 0.1715531066908904 -1073 -0.4138443273030781 -0.9103476658722549 0.8288225979501729 -1074 -0.414138962571399 -0.9102136670476255 0.1714606702132057 -1075 -0.5088378216738276 -0.8608623997098688 0.8552803917457172 -1076 -0.5089717658373505 -0.860783214044285 0.1453605815360826 -1077 -0.8489192030152799 -0.5285226454485201 0.8515789592584662 -1078 -0.8589896325834634 -0.5119929795555076 0.1498838347523728 -1079 -0.5953631289334155 -0.8034567472531505 0.9054190855904765 -1080 -0.5954877347345882 -0.8033643991244999 0.0947383726413541 -1081 -0.7812870480844855 -0.6241718901836503 0.6468292058396435 -1082 -0.7982797911612682 -0.6022867880200611 0.3888613754502612 -1083 -0.784306735190157 -0.6203732305115662 0.8782290054956053 -1084 -0.6297750327711233 -0.7767775795542315 0.6227108425139345 -1085 -0.6226093810472636 -0.7825327843815513 0.3901404025448285 -1086 -0.5409049391870451 -0.8410837335028298 0.5835939469904714 -1087 -0.8946400947812072 -0.4467875343044753 0.3550393821918137 -1088 -0.8890797741156077 -0.4577522859129598 0.6236300628665049 -1089 -0.4394943267950649 -0.8982453655404812 0.3455811173650706 -1090 -0.459532859825063 -0.8881607685216673 0.6444441107963509 -1091 -0.3533269402252418 -0.9354999055644357 0.3838063280620518 -1092 -0.9390550103979579 -0.343766908597223 0.3762575963868008 -1093 -0.3637129407581547 -0.9315110824488644 0.6500608739098623 -1094 -0.9872097674091955 -0.1594267077119825 0.5015720744903065 -1095 -0.139458560375835 -0.9902279080786904 0.520404853765381 -1096 -0.3393971747492104 -0.9406431617634041 0.2058962262494543 -1097 -0.3389676405106363 -0.9407980328883836 0.794300559631808 -1098 -0.9411480075189762 -0.337994715850797 0.2043807860672182 -1099 -0.9412172100861083 -0.3378019589015478 0.7960865110542177 -1100 -0.2375747021983868 -0.9713692711195613 0.3443106388821362 -1101 -0.9715907219979956 -0.2366674226153946 0.3507670320593466 -1102 -0.8775636708006064 -0.4794601168929118 0.2537092784272525 -1103 -0.8721581033889146 -0.4892241231716311 0.7493404207156225 -1104 -0.9723353873277737 -0.2335891576040041 0.6601723214871175 -1105 -0.1539570197148497 -0.9880775455805693 0.4160350555416725 -1106 -0.9857785482559194 -0.1680495575669629 0.4137323719488888 -1107 -0.4914292827692883 -0.8709174817609662 0.2617419401432236 -1108 -0.4794525205717909 -0.8775678210357059 0.7517433084229413 -1109 -0.274259523496986 -0.9616557147811302 0.2020887668327065 -1110 -0.2665807287928786 -0.9638125933169048 0.7999914937630218 -1111 -0.9630787224216064 -0.2692199368894629 0.1989553769690583 -1112 -0.9631477511428811 -0.2689728786855852 0.801701458053507 -1113 -0.1232872231673583 -0.9923710297079829 0.3024388953859542 -1114 -0.7519422640709673 -0.6592289674337952 0.08855713328539629 -1115 -0.7478616348141789 -0.6638546340676276 0.9361130185885662 -1116 -0.9965854551286184 -0.08256773356514305 0.2462655089296034 -1117 -0.9967872087266285 -0.08009532145498227 0.7587593124244638 -1118 -0.8134351006651028 -0.5816556859568672 0.07963255512519031 -1119 -0.8093170505702424 -0.5873720385379984 0.9327662573137641 -1120 -0.9626064662872925 -0.2709036564203072 0.5550280167600687 -1121 -0.5471308939261637 -0.8370470625428161 0.4227677696172704 -1122 -0.4503503152353654 -0.8928519438111826 0.451532616094026 -1123 -0.9151895559377878 -0.4030236676702685 0.4581328622645257 -1124 -0.4785913726112548 -0.8780377543489088 0.5560411503580756 -1125 -0.838302600323331 -0.5452052368522714 0.6765540585427813 -1126 -0.8445015624570917 -0.5355530888787133 0.3268783278459751 -1127 -0.7677771431805241 -0.6407169877641398 0.8032725700360669 -1128 -0.1371824012970861 -0.9905458034711798 0.6327129258777549 -1129 -0.5630147082473714 -0.8264468756654157 0.319564657021652 -1130 -0.4398595632993736 -0.8980665702352384 0.08090774732524031 -1131 -0.4396236329638134 -0.8981820869621584 0.9193131124339943 -1132 -0.8995751660071366 -0.4367659793335928 0.08136404926766995 -1133 -0.8994858129603296 -0.4369499654229247 0.9187925777178435 -1134 -0.3958932143723487 -0.9182965549395954 0.5642856417400383 -1135 -0.9207377427333233 -0.3901820204806273 0.5455350337682113 -1136 -0.0619957275022175 -0.9980764147957163 0.2279130430791431 -1137 -0.8611932274518922 -0.5082777045975883 0.4217394740137765 -1138 -0.6792852434376802 -0.7338743475880671 0.09279949762658779 -1139 -0.6830129615674796 -0.7304062529379254 0.9196958588270968 -1140 -0.06928262983301939 -0.9975970715691886 0.5613627352683926 -1141 -0.9976964354953632 -0.06783673488491912 0.5468889514127163 -1142 -0.06336646434507676 -0.9979903262038186 0.1431361298346825 -1143 -0.8316006837377629 -0.5553740206445431 0.5854546527251471 -1144 -0.2861774279087822 -0.9581766432947076 0.5764151123665553 -1145 -0.7332986089234808 -0.6799067216544399 0.8703264754542905 -1146 -0.8561746377837832 -0.5166865487080223 0.05951018826482166 -1147 -0.8559768953209038 -0.5170140758981195 0.9406275588580146 -1148 -0.9894849285952061 -0.1446360123998852 0.6008706330982989 -1149 -0.7139420995791559 -0.7002047403784886 0.6313158256035638 -1150 -0.6823817453866806 -0.7309960010581641 0.3445208680272688 -1151 -0.07306459807711095 -0.9973272103516628 0.455597259885667 -1152 -0.9974625912598599 -0.07119254902843161 0.4311088151075504 -1153 -0.6750025866501037 -0.7378153617373853 0.8209420210564629 -1154 -0.6522330979309737 -0.7580184601732105 0.18913565398189 -1155 -0.9976620806671825 -0.06834012583269218 0.9354262915268488 -1156 -0.9976607935376453 -0.06835891337518497 0.06464387756154406 -1157 -0.06466292582171237 -0.997907163028794 0.9336104384398454 -1158 -0.06036169427850549 -0.9981765704843149 0.06615427478625358 -1159 -0.08050749204288717 -0.9967540036162204 0.728536502347487 -1160 -0.7560095604621714 -0.6545605735833732 0.4631460067468154 -1161 -0.6981258195017612 -0.715975097433559 0.5381112769416089 -1162 -0.6872641032753659 -0.7264076351120679 0.4335380466697727 -1163 -0.7412649566510272 -0.6712125326907644 0.3587102283081879 -1164 -0.4992998720081436 -0.8664292457048364 0.3603898399304167 -1165 -0.9390941031175453 -0.3436601016845758 0.6401431609581579 -1166 -0.7978240288415852 -0.6028903872205806 0.1681898142258756 -1167 -0.5153752252525928 -0.8569646300728165 0.0642013403005354 -1168 -0.515276947133479 -0.8570237264818297 0.9360025179540374 -1169 -0.7692126345907152 -0.6389928972891724 0.5577257808651549 -1170 -0.9978661997635441 -0.06529201612343202 0.6265689844849409 -1171 -0.5542467547233438 -0.8323524102678153 0.6843470941158939 -1172 -0.7302971778319639 -0.6831295865724666 0.1815686947471554 -1173 -0.05747815417280498 -0.9983467643023074 0.6445224326983582 -1174 -0.1976228290554131 -0.9802781326930307 0.577473709465633 -1175 -0.5226247829821757 -0.8525628048494924 0.5045741076085684 -1176 -0.6753049993937252 -0.7375385805460219 0.6732552484006923 -1177 0.2897393311351879 0.07794379604700158 1 -1178 -0.08384762777884533 0.1029886532790118 1 -1179 -0.1868618493752617 -0.1697088149075699 1 -1180 -0.3776896737680859 -0.6345383402844322 1 -1181 -0.6855847602544329 -0.5402588614974924 1 -1182 -0.7251054130289099 -0.1282865082520786 1 -1183 0.7428512514317812 0.3874304260244591 1 -1184 -0.6561970558251797 0.3113427097602823 1 -1185 -0.4579004718465931 0.5774211047401429 1 -1186 0.03710089829920105 -0.5139659211104587 1 -1187 0.3982042818340527 -0.5620618205069675 1 -1188 -0.07015072609332348 0.4324483737751407 1 -1189 -0.1642668193499533 -0.680985234222624 1 -1190 0.5381935055408629 0.575935351360501 0.9999999999999998 -1191 0.302844898437953 0.4853636979979016 1 -1192 -0.3870524063999865 0.1536406679776654 1 -1193 0.5290757727936075 0.2875696435572835 1 -1194 0.6172635449615472 0.008523403073678604 1 -1195 0.5868486091732812 -0.192719618002612 1 -1196 -0.4968691152746735 -0.4560775863354037 1 -1197 -0.5156546559655826 -0.202537679800142 1 -1198 -0.2118120223383398 0.8961321817628053 0.9999999999999998 -1199 -0.6354686672731695 0.02085098977047031 1 -1200 -0.7271620789297262 0.5375461616458593 1 -1201 0.7144236417541402 0.6052845283650242 1 -1202 -0.5877009795807298 -0.6706229383561548 1 -1203 0.9012954200594055 0.1579899308036823 1 -1204 0.7835971073404365 -0.1389579662997908 1 -1205 -0.8903960356561698 -0.2802350557305419 1 -1206 -0.6699522790610153 -0.3373685246003992 0.9999999999999998 -1207 -0.7903776319630841 0.4625386637351386 1 -1208 -0.5486218084842825 -0.7502746557815863 1 -1209 0.1403380267529757 -0.1421586656854136 1 -1210 0.7988411761436804 0.4612314396471645 1 -1211 0.8930783280602245 -0.2766666411797676 1 -1212 0.2457072906861 -0.3951928296007075 1 -1213 0.3388143371273323 -0.1595460037569817 1 -1214 0.1098433660505816 0.2596576136565499 1 -1215 -0.1541635214137582 0.673924607512236 0.9999999999999998 -1216 -0.282125784303324 0.5161272698207664 1 -1217 -0.4199275623793364 0.3710827118547174 0.9999999999999998 -1218 0.08249990666715543 0.08182904727205895 1 -1219 0.2821360672299542 0.311064745098424 1 -1220 0.1196722830985447 -0.7705720555181 1 -1221 0.4652421224051141 -0.3399814851821571 1 -1222 -0.09122426231872535 -0.337111468793524 1 -1223 0.02195911386464319 0.6368804143367492 1 -1224 0.3105060326434622 -0.8632557435491723 1 -1225 0.2250816214210191 -0.6142762534206043 1 -1226 0.07615504953458829 -0.3006291037816297 1 -1227 -0.2453486379365794 0.3056912420423805 1 -1228 -0.2858417332118752 -0.01986971418896494 1 -1229 0.4689185337476446 -0.03810069354321177 1 -1230 -0.4400849631740479 -0.04214328356705449 1 -1231 -0.3249826736511917 0.719515267308632 0.9999999999999998 -1232 0.1377581307416433 0.462247708693028 1 -1233 -0.5605309399850325 0.06526447865590657 1 -1234 0.1997432178431347 0.64080914595172 1 -1235 -0.5689299548284804 0.2583476726922759 1 -1236 -0.3667012846014245 -0.3245972273005387 1 -1237 0.5199863078182339 0.04517299155988724 1 -1238 0.461120646449517 0.4114225426169505 1 -1239 0.4586534271317928 0.2229317590466199 1 -1240 -0.3345014255880162 -0.1765559411365862 1 -1241 0.3285410620669998 0.6513327343506894 1 -1242 -0.1414030460391212 -0.4800475532438272 1 -1243 -0.2621101598910728 -0.3223378473339158 1 -1244 0.6752206395617439 0.2127645466824821 1 -1245 -0.07338012151484075 0.2022177440491255 1 -1246 0.6405014791262231 0.442627436186767 1 -1247 -0.2170507143118224 0.1240131335004222 1 -1248 -0.6148045003852537 -0.08395851737442062 1 -1249 0.24255820862573 0.8224895687694701 1 -1250 -0.3235738241790452 -0.862957772908878 1 -1251 0.6170659652700686 0.1128373066619179 1 -1252 -0.4755431102153302 0.7819578469865797 1 -1253 -0.1082153240590707 0.00391918990745016 1 -1254 -0.484855615470777 -0.3662275957768236 1 -1255 -0.1769447713438851 -0.5677032149004312 1 -1256 -0.06965919152208136 -0.7690877482787777 1 -1257 -0.6212198110357178 0.5590264097909334 0.9999999999999996 -1258 -0.03223278583278621 -0.1808566225696097 1 -1259 0.6104363692842232 -0.08748311138230858 1 -1260 0.7099832888995116 -0.05234034366779375 1 -1261 -0.5666300583569353 -0.2897501642032262 1 -1262 -0.407334012781258 -0.8341015350385896 1 -1263 0.8190084090227093 0.2957971557576304 1 -1264 0.7260163732660905 0.5094716074731855 1 -1265 0.5644652580487282 0.7441132630720504 1 -1266 -0.4305940379326485 -0.5462892179184861 1 -1267 -0.3075534950041687 -0.5322266727195423 1 -1268 -0.404225787723734 -0.4353362678197478 1 -1269 0.7375823634558023 0.1209551695033318 1 -1270 -0.2629399692222569 -0.768293094783319 1 -1271 -0.8221852927314433 -0.3941129697927344 1 -1272 0.6782173654264352 -0.165752945592774 1 -1273 -0.2098770146392914 -0.8945044624463515 1 -1274 -0.704419997856483 -0.2400195018817135 1 -1275 0.6351670938812566 0.3195795082868028 1 -1276 0.6338895210384274 0.5496522571583957 1 -1277 -0.6201034653477484 -0.1912058887269904 1 -1278 -0.5750282162443874 -0.3959847189247601 1 -1279 0.7681325376637608 -0.2456807735640208 1 -1280 -0.7182015191654888 0.4181342432029016 1 -1281 -0.7688070982144932 -0.3127033038543355 1 -1282 -0.4821350327708168 -0.679568484097359 1 -1283 -0.7838384999768635 -0.03301137092827572 1 -1284 0.7921478869289384 0.03324684365194161 1 -1285 -0.7310352974199794 -0.3989268711648745 1 -1286 -0.9364094631988048 0.1206615329306272 0.9999999999999996 -1287 -0.5837377553492353 -0.5008722891293291 1 -1288 -0.6996360226301102 -0.02830626441578882 1 -1289 -0.6548114842992234 0.6522253941759271 1 -1290 0.8507591056727636 0.3732318446144911 1 -1291 0.7644032612152132 -0.5451765710572032 1 -1292 -0.5166454208427602 -0.5750577717229809 1 -1293 -0.6596342913134017 -0.4473752865516082 1 -1294 0.3169021764471723 0.8585867598171324 1 -1295 -0.7691604616153226 -0.4851790803747096 1 -1296 0.1672884818060241 -0.251375627271068 1 -1297 0.1954843407249223 0.1748987168222638 1 -1298 0.3785172222944508 -0.6690319645647382 1 -1299 -0.1188870894884175 0.5605742511636167 1 -1300 0.08388103732213939 -0.6734407695917304 1 -1301 0.1409528296701937 -0.4588520743904128 1 -1302 0.3371340753769553 -0.4757053704756283 1 -1303 0.02382873724393619 0.3430274052803972 1 -1304 0.2812552106311015 -0.2740690957705252 1 -1305 0.3286519171212273 -0.0386944757210344 1 -1306 0.2837341302554344 0.2087007472111435 1 -1307 0.4912104695447582 -0.6993004570916344 1 -1308 -0.1864394136454839 0.482377305938041 1 -1309 0.2341561990124306 -0.5160814675504103 1 -1310 -0.02017224663535766 0.5472123314886239 1 -1311 -0.01581198911111908 0.724808931790039 1 -1312 0.1805648838067565 0.06571621799379929 1 -1313 0.3643808482891061 -0.3613181010411468 1 -1314 0.2407268774318451 -0.1864760587950334 1 -1315 0.4446537839890055 -0.4505403239500324 1 -1316 0.05687573149989808 -0.4047654231383883 1 -1317 0.4022361939928636 -0.2613929206768327 1 -1318 -0.4032582009070645 0.2681898085210601 1 -1319 -0.1678167486058268 0.3705648746830997 1 -1320 0.5458938820334904 -0.4861448607661641 1 -1321 0.005061261764652936 0.1370518894791942 1 -1322 0.04589619399172706 0.4510496437307415 1 -1323 -0.09828910880181183 0.7580938297798721 1 -1324 -0.2614456778703278 0.4107235755675123 1 -1325 0.2070590441784775 0.3836564668400582 1 -1326 -0.1859083844054351 0.7893855597746479 1 -1327 -0.4402628373985661 0.4732652653828584 1 -1328 -0.3896208910236426 0.64902770674268 1 -1329 -0.07264310393822274 0.3086832326887924 1 -1330 -0.3058994523754138 0.6213267695937259 1 -1331 0.13742733549762 -0.5795403380755969 1 -1332 0.07516858629885204 0.5482464902311093 1 -1333 0.120118317598501 0.3648936634927235 1 -1334 0.1498502592995082 -0.3546699388268387 1 -1335 -0.4165467373717386 0.04577414876098618 1 -1336 -0.3161722497114678 0.2371489081253449 1 -1337 0.4064315926580289 0.02862285067378889 1 -1338 0.454043234652407 -0.1860270014262071 1 -1339 0.3082516507568707 -0.5970328724503663 1 -1340 -0.3531080193750911 0.4434544641331968 1 -1341 -0.3334771964398274 0.05666144452878905 1 -1342 0.3804909244459719 0.1553879405513502 1 -1343 -0.1549411873289434 0.2622264005089452 1 -1344 -0.4643690881194533 0.6837980166882356 1 -1345 -0.2149424194377239 0.5935680243821336 1 -1346 -0.2289205139897001 0.2060842156019647 1 -1347 -0.372254849454193 0.5487533569626941 1 -1348 0.2665642959148265 -0.6882996565167228 1 -1349 0.09704099533564151 0.1555804140908409 1 -1350 0.4721632260799813 0.7821807992834833 1 -1351 0.01500602965081807 0.2350186801942024 1 -1352 -0.04709472592971037 -0.431149731957735 1 -1353 0.3646365471567796 0.2562161715266956 1 -1354 -0.4775499809493421 0.2089498665234371 1 -1355 -0.4826808193711798 0.107171078571877 1 -1356 -0.1367565119727853 -0.2465475913831901 1 -1357 0.219705380708883 -0.7939756064398715 1 -1358 0.1741880528554439 -0.68370111678044 1 -1359 -0.2639570152518794 0.8016305911706761 1 -1360 -0.5492768104608923 0.5015231546541296 1 -1361 0.2841573755711653 0.4078358956460787 1 -1362 -0.2888496262826039 0.1384648416345654 1 -1363 -0.4900931113036227 0.3066440754051976 1 -1364 -0.5764870991130485 0.3352470531688554 1 -1365 -0.2371742926469025 -0.09595580732289435 1 -1366 0.08496956162472277 -0.2174017510071562 1 -1367 0.5628046274289193 -0.6008527299011868 1 -1368 -0.5649974091796021 0.1624713784566736 1 -1369 -0.5198091270833947 0.3983581575747551 1 -1370 -0.06086724746033154 0.6613923220320002 0.9999999999999999 -1371 0.2645972460202924 0.5565708854344379 1 -1372 0.2381737088852517 -0.08898704803098301 1 -1373 0.1654619266985638 0.5569655326899126 1 -1374 -0.3339105929942835 0.3403405214056002 1 -1375 -0.2414151790302403 0.7042403310275425 0.9999999999999998 -1376 0.5236363325054458 -0.3957323891803582 1 -1377 0.2001718999604586 0.2846353921693596 1 -1378 -0.2973537287270382 -0.2497305945850173 1 -1379 0.1346020442325961 -0.01195199770336261 1 -1380 0.0533752900601189 -0.06945837436083732 1 -1381 -0.0339018885494541 -0.9355188825904608 1 -1382 0.218710189712175 -0.9067403055351748 1 -1383 0.4920179670022333 0.1331909570851415 1 -1384 -0.2075560019448862 -0.3988192925514371 1 -1385 -0.3878655808964822 -0.1091239464544706 1 -1386 0.3698105745245859 0.4401249237072208 1 -1387 0.01485167081678732 -0.2363254532006812 1 -1388 0.5245890723736372 -0.2722172014891703 1 -1389 0.4492691061472249 0.310645211289362 1 -1390 0.603520269179519 -0.6975687385325237 1 -1391 -0.06168037400390453 -0.2461027596535805 1 -1392 0.1114047498665568 0.6326724054365875 1 -1393 0.03608912874801523 -0.159321579326335 1 -1394 -0.4774532850798383 -0.782904803335564 1 -1395 0.5626003870671774 -0.340646582270633 1 -1396 -0.4690530332319679 -0.1242262632900833 1 -1397 -0.312194007889803 -0.1004963253001233 1 -1398 -0.9222335095548163 0.1974113058283598 1 -1399 -0.2522791207951212 0.0542548700526142 1 -1400 -0.4030963138487751 0.743954200548912 1 -1401 -0.1691607464166971 0.06566043580772857 1 -1402 0.1193460939319357 -0.9499352453402704 1 -1403 -0.1538324155783985 0.1577867722421939 1 -1404 -0.2171271198769763 -0.2493674977489563 1 -1405 0.4026013267157277 0.8394914425016136 1 -1406 0.1503067246066855 0.6996162570874258 1 -1407 -0.5460228607739707 -0.1312177430277169 1 -1408 0.2409284996873737 0.9072223934569358 1 -1409 0.005661507366884866 0.02042799413484428 1 -1410 -0.5239619876185739 -0.06305110756054305 1 -1411 0.2237178801649813 0.4799932248016413 1 -1412 -0.5000825455132965 0.0175303156327149 1 -1413 0.4136295321030357 -0.08808116651059752 1 -1414 -0.6568796916635082 0.4809164288838965 1 -1415 0.6226506947183573 -0.4217881961711301 1 -1416 -0.2975228485856651 -0.4166182548813794 1 -1417 -0.08702053301887624 -0.6236759969406293 1 -1418 0.3672107946325331 0.3537064886174076 1 -1419 -0.4247840468868734 -0.189631409609065 1 -1420 0.5130950282881888 -0.09964503783656026 1 -1421 -0.5720638123631638 -0.01063363570216563 1 -1422 -0.4548362322806574 -0.2708151432727706 1 -1423 -0.2977083739020105 0.8851139292215636 1 -1424 -0.5556760386833099 0.7271666005781979 0.9999999999999998 -1425 -0.3632427306968263 -0.02825281686578007 1 -1426 -0.2031153266954588 -0.01789148767040871 1 -1427 0.2404545597202565 0.7225506513469681 1 -1428 0.06259778230631446 0.7561031659657698 1 -1429 -0.4154245460646798 0.8312208130512116 1 -1430 -0.5523446397879744 0.6194761042735737 1 -1431 -0.3485062501944445 0.8238276167462517 1 -1432 0.4626583028483838 0.5129888404091927 1 -1433 -0.1469700882254162 -0.09424166898111733 1 -1434 -0.1683185424939579 -0.3261583556390828 1 -1435 -0.2645560887465901 -0.1739453204802458 1 -1436 0.6747521949736207 -0.6218342179362119 1 -1437 -0.6205715956630742 0.4075292462118147 1 -1438 -0.3762799031558483 -0.2425951741032604 0.9999999999999998 -1439 -0.1313082417458413 -0.3953633459711371 1 -1440 0.5508195279160139 -0.0303167745486399 1 -1441 0.5707907370774351 0.2177387875914229 1 -1442 0.2348914284161124 0.000810270545667291 1 -1443 -0.6556466636262697 0.1164447275998658 1 -1444 0.5488622412837595 0.3797914630148991 1 -1445 -0.09903111014880184 -0.1730941636383408 1 -1446 -0.45092559183586 -0.614827869506994 1 -1447 -0.8879760872878617 0.3024143509600128 1 -1448 0.3580121941624591 0.54512833636333 1 -1449 -0.008696867479190379 -0.3269221880167234 1 -1450 0.6184028234214376 0.6602226578426881 1 -1451 0.4382510340574169 0.6169634532606038 1 -1452 0.6462392254665531 -0.5262798203822959 1 -1453 0.02815411186573752 -0.7305665403968723 1 -1454 0.5492611626992877 0.4800872944328648 1 -1455 -0.2325330667229669 -0.4797091325699736 1 -1456 0.1578506074212944 0.7879376492642725 1 -1457 -0.04171736994433251 -0.09345910847504396 1 -1458 0.6789449829688424 -0.2472656711504801 1 -1459 0.8118140157497508 -0.3603054921251926 1 -1460 -0.8195508810477371 0.2486091381283811 1 -1461 0.629531227992938 -0.3121794568006635 1 -1462 0.2113090107686239 -0.319370994260365 1 -1463 -0.616963375720216 -0.5859684005353663 1 -1464 0.7443859852773173 -0.4513871403505811 1 -1465 0.6996033030969461 -0.376179666856836 1 -1466 -0.7542473451401366 -0.5715109612897482 1 -1467 0.51249892416245 0.6856571258169819 1 -1468 -0.7244212108470494 0.2143263503440802 1 -1469 0.01280131869345816 -0.6220069425344454 1 -1470 0.3511130215621625 0.7721776760014751 1 -1471 0.4624843194036344 -0.612412255398776 1 -1472 -0.3809471762282604 -0.7500086989415082 1 -1473 0.4358922146983504 -0.8138293260753886 1 -1474 0.1371748275373223 -0.8658088596776375 1 -1475 0.4838415568862029 -0.5437004995095347 1 -1476 -0.8187064335658744 0.3766999013648455 1 -1477 -0.7486017683818011 0.3192131869745889 1 -1478 -0.6822611688035686 -0.6433859986600988 1 -1479 0.4215616146121645 0.7042882666300073 1 -1480 -0.002643538877739299 0.962897237672404 1 -1481 0.713335751873068 -0.3107053401424084 1 -1482 -0.2695571722803648 -0.6449498108693597 1 -1483 -0.06378191232584748 -0.6900728545102359 1 -1484 0.8808803952935624 -0.1817164928460623 1 -1485 0.9319262184192126 -0.1092364066217543 1 -1486 -0.1616166624489407 -0.8022910306398039 1 -1487 -0.7760881100559551 0.09867380118735108 1 -1488 0.0796353513669978 0.8881827680804089 1 -1489 -0.06983451008702352 -0.5460190599985321 1 -1490 -0.139798571399375 0.9385113740376905 1 -1491 -0.1201919428480979 0.8544918313022043 1 -1492 -0.9534467231936609 -0.02680334131782712 1 -1493 -0.8200661569510446 -0.1976842463915288 1 -1494 0.8066711810146894 0.2079343221437162 1 -1495 0.1694979088358587 0.9148117961382987 0.9999999999999998 -1496 -0.07911451000517439 0.9306450805454027 1 -1497 -0.3239668772039842 -0.696695726677667 1 -1498 0.550548657687973 -0.7612420741252157 1 -1499 -0.0343006262048253 0.8310137101255415 1 -1500 -0.641562779938361 -0.2649432725960296 1 -1501 0.9643997686992148 0.001806132474239205 1 -1502 -0.9168810631441754 -0.2115661737094375 1 -1503 0.731096244703401 0.2830117313784486 1 -1504 -0.8590498436837828 0.144699298946951 1 -1505 0.8913965958830555 0.3136293969391959 1 -1506 0.06802678154243572 -0.950226917123985 1 -1507 0.864460689126844 -0.0311852262407035 1 -1508 -0.1310705240542894 -0.9406080685833257 1 -1509 -0.7092748416253511 0.03317442791744341 1 -1510 0.4007131213395561 -0.7381851271345401 1 -1511 0.336247066790694 -0.7650876958557478 1 -1512 0.6912308379501809 0.04191735055348339 1 -1513 -0.9663667576267356 0.04223423629661429 1 -1514 0.9556302559079273 0.1034777970560016 1 -1515 -0.8935388521365365 -0.09233037823453862 1 -1516 0.01971094461541648 -0.847703385895251 1 -1517 -0.6357787202496983 0.2130337210736508 1 -1518 -0.7976849700903755 0.1817860122865861 1 -1519 -0.09951235088801881 -0.8676479992679118 1 -1520 0.8068574654874888 -0.06516561265809309 1 -1521 0.8596955490010718 -0.1071134738663725 1 -1522 -0.8914599274203824 0.0364317607117798 1 -1523 -0.8099435282043598 -0.1130116877100516 1 -1524 0.8967666622946819 0.2421844460630574 1 -1525 0.8916348678382225 0.06337007545270483 1 -1526 0.8307412926206452 0.1169060740987489 1 -1527 -0.2589559423442405 0.1014011376387137 0.5008275501990492 -1528 0.4260253875760067 -0.2675148989354469 0.4949763661652533 -1529 -0.1705755425031569 -0.3718642904006512 0.5203358390841492 -1530 0.2353773201402325 0.4283683136154832 0.5006023868675681 -1531 -0.5806281543198079 -0.1291361781280228 0.4053791149571385 -1532 -0.1875376048635322 0.5305509208659949 0.4380856702015229 -1533 0.1436401383132612 0.02983683735221962 0.4163431802764236 -1534 0.08719601315237588 -0.6145804871114879 0.3777941016866144 -1535 0.5537254701234143 0.1417095809938009 0.4752856848849247 -1536 -0.5402282201700361 0.2999893049641546 0.6342279365074988 -1537 -0.3807545332711346 -0.1583280142720361 0.6704589199710429 -1538 0.1174496543455132 -0.2257175394813525 0.652599659839441 -1539 -0.4601017844752675 -0.4825993925857559 0.6465560865363646 -1540 -0.4226913196091631 0.3285565460807247 0.328481047691513 -1541 0.01337237294514992 0.2269533930291818 0.6604064414751063 -1542 0.05143652755276452 0.675759261505764 0.6040471848939094 -1543 -0.4538470686680693 -0.4206198161015839 0.3245479443048969 -1544 -0.06946798516690324 -0.6659817172840372 0.6675432027140461 -1545 -0.05140886468516185 0.2654018100020156 0.3191337722903125 -1546 0.4680108866211538 -0.5018477711945851 0.302622171090444 -1547 -0.6830356291220697 0.0170818561082567 0.6696045510859933 -1548 0.2752674564400409 -0.5336895095204137 0.6568224277042116 -1549 -0.6469860743215284 -0.2687665813040876 0.7092483824224135 -1550 0.08332268535097488 -0.2826957349725049 0.3293899778455987 -1551 0.4988352713847868 0.4602127453120683 0.3176843164322835 -1552 -0.1866185979810028 -0.1302998670308438 0.3066881023555902 -1553 -0.381282833100056 0.5683273091130125 0.6847852776402438 -1554 0.6791441961391212 -0.07253126903419937 0.6795231062384602 -1555 0.3726858485634674 0.5973162884347125 0.705789415113972 -1556 0.2511842451543379 0.04258306582710784 0.6998466818828 -1557 -0.2258006558766422 -0.6448642201954504 0.3191809225903157 -1558 0.2008321860952088 0.6633990281468599 0.3028032062856338 -1559 0.6314960483048577 -0.1154888824496868 0.3107030760373702 -1560 -0.1102322072606163 -0.04623230781405174 0.7089500053457785 -1561 -0.2617516734569045 0.2991934581965778 0.7115310829252965 -1562 -0.6756771078749055 0.1640815046191071 0.3926593672477749 -1563 -0.4172588941854733 0.05548593852492328 0.2770563866131241 -1564 0.3116717255590914 0.2359602710150045 0.2930321499032784 -1565 0.4241088360120989 0.2992497088192009 0.6987107360877789 -1566 0.5519635394469948 -0.4546788710221602 0.6744888605889192 -1567 -0.4040808275019367 0.6017327508021159 0.2782979644816344 -1568 -0.4106345382460115 0.09237991156999711 0.7054898762382981 -1569 0.3447587959500348 -0.1092208981863725 0.2768261271133902 -1570 -0.1810745175962372 -0.2803592118401619 0.7555680026617477 -1571 0.5627876481746205 0.4797768065311441 0.5703312583585344 -1572 0.1191243697774754 0.4570729942861314 0.7363196363774794 -1573 -0.5251327598370729 0.5056507549817203 0.4824467312492489 -1574 -0.1286790327474148 0.5198572171143837 0.7026970683736751 -1575 -0.6398288960081671 -0.3967540971577673 0.4925587275713551 -1576 -0.3158615333060192 -0.6732193285864307 0.7433157493396968 -1577 -0.2023506521595368 -0.3873094034248116 0.2612679282314508 -1578 -0.0687376517845559 0.7215374361819805 0.2763498550938385 -1579 0.01824255490609927 -0.440363717266947 0.7497954872440789 -1580 0.6891088950928312 0.2064351297487015 0.713039378832369 -1581 0.4045817335767466 0.6382285109235861 0.4629328370519065 -1582 0.6816131427403038 0.2655360308309181 0.2707927959500338 -1583 -0.6757003751594159 -0.3125451459208037 0.2522505307556644 -1584 -0.3544898127451639 -0.2360470724149217 0.4437195439540642 -1585 0.1410376695733489 0.4205281204504905 0.266211275439605 -1586 -0.03083125561902936 -0.1204645128691049 0.4922179010327469 -1587 -0.4287597350648392 -0.626311753171657 0.4524736893744096 -1588 -0.2198434914216949 0.4114801586978838 0.2336452804190642 -1589 0.352138780294117 -0.2986374204326763 0.7449824206894993 -1590 -0.02320538643891737 0.03713524447086428 0.2390967852865058 -1591 0.2305569247087205 -0.4627813678204056 0.2449914497399334 -1592 -0.6547970724688391 0.3932924335749481 0.3124997021946133 -1593 0.6622337132567835 -0.3550159850145451 0.2470131835770819 -1594 0.3946910823296325 -0.3169546846548853 0.2134005676586351 -1595 -0.2648913604611006 0.3256789632015641 0.488420416235517 -1596 -0.766306974939312 0.01532147170983561 0.232735949220602 -1597 0.0004482854381711032 0.4033874809199434 0.5037864798213936 -1598 -0.4791850553277257 0.0520016021376572 0.4941704203760687 -1599 0.6876680956227184 -0.2740715556386676 0.5119063505015955 -1600 0.2726162072820609 -0.7061198762048421 0.2427853175806301 -1601 0.08922049132882226 -0.4240143345152219 0.522108945358141 -1602 -0.2381148644052758 0.1822929268538933 0.2219689275742563 -1603 -0.03489456912630613 -0.7602295547384225 0.2321780626169265 -1604 -0.190055574408782 0.729987863325568 0.5857734242773267 -1605 -0.4307664996986479 -0.1746236024177282 0.2297595729768034 -1606 -0.4319191858598856 -0.6240779729770056 0.2248960506424261 -1607 -0.7299146963872406 0.2320188904839818 0.7620827942489179 -1608 0.2727197893259683 0.1964487986842025 0.5223234883300363 -1609 -0.5456216021846346 -0.0936944880617824 0.7897867378700048 -1610 0.7602564222107944 0.01527642800310954 0.4688273503413224 -1611 -0.04349054378566442 0.1198258182109307 0.4801804719701262 -1612 0.4523614981428704 -0.07535601769517453 0.762101856462896 -1613 0.3800482340337037 -0.02769984424784958 0.5044757956565701 -1614 -0.08510946491029409 -0.7656525256751778 0.4586210740272213 -1615 0.3700216317523182 -0.6603338878519337 0.4660258229555145 -1616 -0.2497281969936825 -0.4745781425176533 0.6924067246061426 -1617 -0.7759354027796367 -0.02753228168269914 0.4658721502388175 -1618 -0.593597720659979 0.5093639575186479 0.6919815392364225 -1619 0.4970345771946372 0.08151034851000515 0.2432114169773462 -1620 -0.2210703269572001 0.1104862718013563 0.7915190339829767 -1621 0.7054469243192961 0.3145812322674481 0.495123012643376 -1622 0.2010659946870489 0.7416634754570237 0.7706870508139104 -1623 -0.4542736011264856 -0.3219034470776267 0.7903918873621232 -1624 0.1567762090683479 -0.7327768430814247 0.7541576101985272 -1625 -0.2313157756649291 -0.1000630652750272 0.5395873159050592 -1626 0.5695934960444959 0.5341040479718946 0.7848607997192849 -1627 -0.06768551643339803 0.7150988443953437 0.7856674573001077 -1628 0.6816571178300938 -0.2868369036372647 0.7705522239202488 -1629 0.4167336438379647 0.6538249533767083 0.2269590473416049 -1630 -0.3626304303617218 0.6474980674175507 0.4849898485697547 -1631 -0.05360304158787333 -0.5419917361572266 0.2136311153152262 -1632 -0.6145498839641679 -0.462499139238593 0.7921600920511679 -1633 -0.2761092009709606 -0.07468097774397484 0.8109852491713162 -1634 0.1188158982336489 0.1937938308847273 0.2128472581500006 -1635 0.2183547790767074 -0.1720397547161504 0.4640536959456131 -1636 -0.005330086893333214 -0.2057385181695093 0.8059613895401644 -1637 -0.2835535837222516 0.7317644963580441 0.7878325170777516 -1638 0.2071337666091234 0.2517624357257014 0.775682358235934 -1639 -0.4333832390711411 0.3932574238522109 0.790537281786916 -1640 -0.2293225636455908 -0.6167702775467009 0.5323639583282638 -1641 0.4291779744659044 0.3376585274916576 0.4799818520080394 -1642 0.3020379097817625 0.4445420687342184 0.8075801638550748 -1643 0.7688980632143222 0.05526280314887054 0.2431657619555672 -1644 -0.5597161367712218 0.2057526448825882 0.2150914223696431 -1645 -0.488961961943559 -0.2977221716797162 0.5774937204163904 -1646 -0.7816515980134675 -0.1265553466799168 0.7903511618404185 -1647 0.2994858228329721 -0.4451425431809571 0.4549920774894509 -1648 0.2266390200905402 0.7556225883735477 0.5038299712202728 -1649 0.3303057271740225 0.4647721484928029 0.2010561754329001 -1650 0.009582813567835614 0.5924197894640157 0.4186721605617141 -1651 0.05714713569837214 0.06102757064435255 0.7884295426888065 -1652 -0.7766155642268409 0.1713843688970682 0.5714369855991579 -1653 -0.7047485659070423 0.3630796360980311 0.5163183478445648 -1654 0.4457606368227131 -0.6308074050186382 0.7732185815932774 -1655 -0.2294862134218622 0.6017737974236366 0.1907866263109543 -1656 -0.3481677436040566 -0.4502801476719888 0.4879213779965706 -1657 0.1374753580534533 -0.09677366277510138 0.2496318675510712 -1658 -0.6087936084826955 -0.5088939702818638 0.2107434874342705 -1659 -0.03998074302873958 0.5194483132999294 0.2275911681255203 -1660 -0.7198563384043042 -0.21305472546913 0.5276744835651811 -1661 -0.5026835456322463 -0.6297698251047834 0.8056464701193697 -1662 0.03596612493956298 0.7956733926269637 0.4374840947831541 -1663 -0.5331968545515241 0.2081435732354459 0.8097489253398171 -1664 0.1250096019883979 -0.7687143888939496 0.5355710715554819 -1665 0.4888042169273879 0.2895868543105636 0.2031783051930317 -1666 -0.5555721528132005 -0.1165747459018584 0.5973708167613281 -1667 0.6182491665174048 -0.4792823675237493 0.4642435482671396 -1668 -0.5048588724963391 0.4515433094269067 0.1954265108443692 -1669 0.07056401079108149 0.01097373440364856 0.598340878617692 -1670 -0.5834436649250119 -0.05241381462269533 0.1945437571972099 -1671 -0.4010641739345974 0.2127281578604783 0.5465108800821227 -1672 0.1720449698641732 -0.3221608192654578 0.8108529442669438 -1673 -0.09165857505871219 -0.5258026483004975 0.4141784775371777 -1674 0.09737632495338681 0.7959636576555584 0.1977806089945729 -1675 0.1280958139937026 0.2794630923624374 0.4093791825543732 -1676 0.271514811228705 0.06201672310582214 0.1979840362944283 -1677 -0.7603449043222508 0.244301808520086 0.2206812128752121 -1678 0.1661269854651449 -0.1048167480879268 0.802950296991369 -1679 -0.08182701182079787 0.3448025602198144 0.7984558590153326 -1680 -0.2685991239613601 0.7505546500293951 0.3307451884320752 -1681 -0.302096708702542 -0.7562153281562015 0.1866907582076309 -1682 -0.1782063879563374 0.05231791499391089 0.3406836633955877 -1683 -0.1516623162870995 0.2214481180249445 0.5848266911162344 -1684 -0.3235340022610285 -0.03292807203833541 0.4014844016557412 -1685 0.6939233370705795 0.404673606396999 0.6994417127237379 -1686 -0.4899942053532235 -0.3367277168034402 0.1719345679406837 -1687 0.4572943943111029 -0.6690032294359837 0.1900086618457621 -1688 -0.2142305976404983 -0.7852161999360561 0.6242593814813298 -1689 -0.383737867488972 0.3972273977067129 0.6117358644043633 -1690 0.6599499513377362 0.4515160499760618 0.198013389209425 -1691 -0.06188755831947756 -0.2555161861588499 0.61557561841536 -1692 0.5074862955343781 0.1081305478803053 0.6769897344590908 -1693 0.2082344050130905 0.5728465407080663 0.6178955385500926 -1694 0.1223190953255313 -0.6062599255580166 0.1850280464598402 -1695 -0.03147561592681211 -0.1891690785763942 0.194502032811733 -1696 0.8006742496147707 0.04108176705758548 0.796789046335544 -1697 -0.2662338642110071 -0.009751294844192892 0.1873574152189428 -1698 -0.3134597657396519 -0.3199437715449241 0.620498773541549 -1699 -0.3585037938057019 -0.46412152367399 0.174407060616465 -1700 -0.5843036167992253 0.5696022519271557 0.3168852181725199 -1701 -0.3362039508244464 0.1817032758162619 0.3664077157693337 -1702 -0.357361919873882 0.4680807744042367 0.4243759524994118 -1703 0.5789501638129865 -0.07106008397612242 0.5023063289692703 -1704 -0.5447896080993275 0.2757868369704695 0.4534129673285625 -1705 -0.1235248945910543 -0.5538322305383238 0.81488801420488 -1706 -0.2585888735573415 0.4521891349374837 0.8181702839218711 -1707 -0.157933423090554 -0.7653584566729932 0.8092206087169511 -1708 -0.3858226116910095 -0.4896525626071203 0.8132284251429015 -1709 -0.09063093811355534 -0.2645850447954304 0.3916391354430453 -1710 -0.4610362944921692 -0.6663204537029145 0.629665972379491 -1711 -0.5798986685045233 -0.5643718539202384 0.5349811137768995 -1712 0.2946244229539283 -0.1406506604828218 0.6427223818970162 -1713 0.5751249431725731 0.5873157629465194 0.4237058295718075 -1714 0.5412922309891489 -0.2136737467618647 0.6488575664132837 -1715 -0.7847304445884203 -0.1814430004993352 0.3466340719942225 -1716 0.4998543000258899 -0.1634703608007155 0.1850498610548541 -1717 -0.2645780562350042 0.023348826369604 0.651956202206692 -1718 0.2759879859474652 0.7731625368086883 0.1801851170560789 -1719 -0.3346928779397363 -0.2226696225766985 0.8441054105325125 -1720 -0.2635683777126927 -0.2360436708653244 0.179113697815526 -1721 -0.03088484388925635 -0.8280174301157478 0.6131355729312347 -1722 0.2120215662628065 -0.262864550944664 0.1880375902455657 -1723 -0.800687836993329 -0.1776282045165636 0.1697300538772253 -1724 0.8050900413010056 -0.1392414235696276 0.5609494772538349 -1725 -0.5214639813600935 0.6471153890092247 0.1640165117203445 -1726 -0.0346565928027231 0.8282096980111014 0.5946324896835172 -1727 -0.3600747688400361 0.2096293573108863 0.8231760187722746 -1728 -0.0612707829417953 -0.4980075850623925 0.5953757329153355 -1729 0.7860012520423756 -0.1794944003829563 0.2017698108522246 -1730 -0.6161996584310776 0.3741484550819196 0.8173225388329095 -1731 0.5138721461426536 -0.3475026495318633 0.8212711234935685 -1732 0.06479385560301998 -0.3982473580077916 0.1808705042658334 -1733 0.002953263749912609 0.3540274796351641 0.1728757569974154 -1734 -0.6026313243013465 0.144854025095788 0.5788379811480537 -1735 -0.8087525156040805 0.06283549659563537 0.8074343580139683 -1736 -0.3475089597893744 0.3091920565074288 0.171748094566833 -1737 0.38945017481019 -0.4892520586080409 0.1576619134587404 -1738 0.5247242481170749 -0.2677996305693626 0.3371712064558376 -1739 -0.1794013024304742 0.2108832889321999 0.4071213143591461 -1740 0.5115014063265356 0.6469524484964491 0.6054138478923431 -1741 0.09509183100971029 -0.5801550468274914 0.6539673786130227 -1742 -0.6230807947425946 0.05872615265928433 0.829141116675179 -1743 0.3868936993748097 0.493978349586999 0.5632779356433291 -1744 0.2401690664851714 -0.357894425359968 0.6079437697091533 -1745 -0.8230732724178249 -0.07931624863543339 0.6266381085085286 -1746 -0.3020595891603098 -0.7626736951645612 0.4419181549421772 -1747 0.3360666883982419 0.5010404902851608 0.3743164966688662 -1748 0.324481093967146 -0.725935619006927 0.6479115684961714 -1749 0.5727415103041537 0.3160179707424741 0.8167341550143956 -1750 -0.1457329449501101 0.391885721576966 0.5910913324606768 -1751 0.5133966000819925 -0.6255926081335229 0.5916893816839194 -1752 0.6877186154173641 0.4522095096517577 0.3776749955626148 -1753 0.3124133952385488 0.07463246666870829 0.3727876279091192 -1754 0.1271314481816756 -0.7986198844372681 0.3315597037438246 -1755 0.1797379671827016 -0.5111702917799034 0.8187259438648817 -1756 -0.5137397012939076 -0.2856909561760932 0.4094422804409499 -1757 0.79668098134383 0.1842470798492523 0.3951322415207564 -1758 -0.4338978873279508 0.6515732136698763 0.8301291054233174 -1759 0.1561515234611272 0.3257920349253637 0.6222941646798446 -1760 0.1963242141803096 0.5795559694387474 0.8311849629339441 -1761 0.6076638742440151 -0.5215928466469846 0.1774153176704323 -1762 -0.4200318368722008 -0.0004024549460563132 0.8417764349238583 -1763 -0.7137589888259581 -0.4220594722657054 0.6513243097680457 -1764 0.6140827968321658 0.03945109840820257 0.8151008098517643 -1765 0.5789172625887943 0.5984089266103609 0.2510312938188058 -1766 -0.5192463904151925 0.6423338281134909 0.5979335832730115 -1767 -0.07524588397542591 0.1846706538634821 0.1704830826041691 -1768 0.2798138497922539 -0.2987943704553804 0.3513289581992673 -1769 0.4741364507809542 0.6773728879689566 0.8271291902074291 -1770 -0.571639945563135 0.03366915261351502 0.3500894544650696 -1771 0.8302457144753025 0.02150420560545006 0.6271984978092501 -1772 -0.1486412667370204 -0.1581042251834023 0.8483223959749728 -1773 -0.4122135036147163 -0.1031439314167696 0.5196887595411841 -1774 -0.06555514598074151 0.175581850690024 0.8294424200974082 -1775 -0.5589785740242068 -0.6107059716327323 0.3406129766132961 -1776 0.3279009894641834 0.7585199850181192 0.6487044814130369 -1777 -0.1370167372328479 0.02332464802711059 0.5608646508198587 -1778 0.1217233053151956 0.5710296270325389 0.1720039282563118 -1779 -0.1525355354168692 0.3800314926992214 0.3807730975421261 -1780 0.3679699932400757 0.1509673582939277 0.8079285519084872 -1781 0.806386728970652 -0.1476196472283468 0.797047556034903 -1782 -0.08559690917742993 0.5910500874106382 0.5569233923098893 -1783 -0.2636904170008557 0.5085191009165406 0.5839737063900505 -1784 0.05883551590378742 -0.2611992589500655 0.5002315291067212 -1785 0.575467877595947 0.3104601642108862 0.6119563322627156 -1786 -0.1405353174198741 0.812168683872339 0.4367113303867074 -1787 -0.7738299747870927 -0.2974613239839956 0.8259825343872197 -1788 -0.002242526922659329 0.5539589023784115 0.8231245880194205 -1789 -0.2179669845575453 -0.5622535755749039 0.1691052118530735 -1790 0.5379989534260448 -0.630336511817939 0.4077172872239652 -1791 0.1086069004858522 0.163030211850888 0.5374334202683736 -1792 0.4851573320150915 0.4450302545099519 0.1566884761543443 -1793 0.7989556546867123 -0.1383772804983302 0.3788260141967923 -1794 0.0548686064066877 0.827236064680549 0.7413933667493832 -1795 -0.3055177720446238 -0.4981229053173356 0.3330882535568133 -1796 0.1769587810515039 0.5806820633090871 0.4502372957038098 -1797 0.00788436454070836 -0.8234906999929246 0.7860215215908308 -1798 -0.09333842181712693 -0.3785738128740549 0.8458320987938355 -1799 -0.7326826399406376 0.3906063156287732 0.6872539056381207 -1800 0.6015703881463021 -0.02884688990223785 0.1680247055269669 -1801 0.2405359918876195 0.3251285330890784 0.167960069164899 -1802 0.04764131473372508 0.1407954968201949 0.3481412317006259 -1803 0.6582835203954377 -0.460958956796208 0.8241276271522142 -1804 -0.1003236606953986 0.1117195714679601 0.6879436981675313 -1805 0.359619199790977 -0.471595084913712 0.8086575156030822 -1806 0.05023143849897006 -0.4485421773352093 0.3570527679386166 -1807 -0.2271703504721426 -0.1505387656065419 0.6855745594722706 -1808 0.604791386523739 -0.1376106272891562 0.829419853602414 -1809 -0.3492194303285366 0.735314356559836 0.1698917820734844 -1810 0.7727940898592759 0.3049320081337835 0.8312799230815422 -1811 0.5725275904472352 0.3235572032388059 0.3884899348046464 -1812 0.4050750784823718 -0.4123944334903992 0.5901227636397952 -1813 -0.3482188580021762 0.4912575546189707 0.1717735591716711 -1814 0.1877928103938133 -0.5651493116531431 0.5091014581403361 -1815 -0.8309053164834572 0.09916345270842244 0.3661849051762534 -1816 0.2822330812622726 0.6094540843005447 0.1525343799729009 -1817 0.7187983492192621 -0.4001126954791847 0.6361169196718438 -1818 -0.2848324357203811 0.170529448607215 0.6313915699834518 -1819 -0.1849339743942146 -0.8121508127203738 0.3012375577739506 -1820 -0.2530325700440716 -0.400567397260887 0.8359187581116083 -1821 -0.1842345235238287 0.6054903173979984 0.8356501950781112 -1822 0.331915053891085 0.7634359821674879 0.3634064355224099 -1823 -0.5870687317058056 -0.2171529097092512 0.1464344801629032 -1824 -0.03053627006035877 -0.05613615487754769 0.8428409865875413 -1825 -0.3714799447726297 0.7366760718104371 0.6359557287868771 -1826 0.8039558449256728 0.1885996886821917 0.5726568361932507 -1827 -0.001445338825292797 -0.6337516402441237 0.5182528246749377 -1828 -0.5913247154698418 0.5944268792304028 0.838824300231077 -1829 -0.158204445660851 -0.7056021339752511 0.1536254533396434 -1830 0.04621414647486398 0.5161890192232463 0.6071342638453148 -1831 -0.6666581503985438 0.5035548404410138 0.1831282639766969 -1832 0.7435206435721979 -0.3852709447414152 0.3944882476029096 -1833 -0.0003998136292509211 0.4157143167071906 0.3436487650855608 -1834 -0.2135555971820222 0.2536324707384078 0.8524692623856582 -1835 -0.02810483534071526 -0.09835988443417776 0.330324679312081 -1836 -0.6279170535133959 0.0003280039747361151 0.5172274605396272 -1837 0.04005790518620359 -0.6174220263241886 0.8164104503971387 -1838 -0.4904513069467261 0.1657849585208185 0.3582319928258968 -1839 0.6616285756778354 0.07968846613322079 0.5969599349060676 -1840 -0.5768134633521648 -0.2384100448584009 0.8492825097624882 -1841 -0.7759516906407193 0.2979950667312992 0.3789506805582122 -1842 -0.806167993482036 -0.2392052159207246 0.6701372062062089 -1843 0.2638566743057945 -0.5833734203600671 0.3589981281964149 -1844 0.03341272347385661 -0.103097434363811 0.6964767133705024 -1845 -0.5183169493533077 0.6627224849093477 0.4349772174219652 -1846 -0.7656896649774887 -0.3434474696647679 0.392440366464793 -1847 0.1382510874307913 -0.7750790824987686 0.1624466801716171 -1848 -0.338389120067394 -0.3102780682840136 0.3013272440397201 -1849 0.8062023796483279 0.2056313452111498 0.1684561831511206 -1850 0.1165831524928068 0.04200525729415146 0.1596812354777682 -1851 0.4794815756866081 -0.04244585721961595 0.363186174756348 -1852 0.2196848041589182 -0.03150295060897854 0.5471664863652738 -1853 -0.4951334467428219 -0.4314283859619339 0.5101622648741549 -1854 0.2727724366482091 0.4337882142679872 0.6533491096537772 -1855 0.4783717801223517 0.7103051669154334 0.3526814219435931 -1856 -0.05968538438900177 0.2688241816102016 0.4763212471427867 -1857 0.07865273427543014 0.334620576033205 0.8416187944294141 -1858 0.4523237635254805 0.4575050559900113 0.7056787643635957 -1859 0.383614011996285 0.1733843183455504 0.1619844488672081 -1860 0.1528945964714104 0.8350167496336558 0.617769279175496 -1861 -0.3810453692341917 0.1521144517884436 0.1524725976178496 -1862 0.6367287015019442 0.05142655140704931 0.353963583226904 -1863 -0.675141396012364 -0.4938544061992682 0.3623801675630198 -1864 -0.3952708659698883 -0.7493662382857582 0.314573034557271 -1865 -0.00641772514232208 0.3797716891452446 0.6559702875964847 -1866 -0.4056058717496475 0.2608297054581378 0.6891088424098605 -1867 0.4511688696447874 0.2165642681834125 0.3739682299040198 -1868 -0.6805860272897432 0.5011631703370654 0.4324390846262091 -1869 -0.8466565270229671 0.06802380606178164 0.659508411096542 -1870 -0.5933442776108568 -0.6070374410110589 0.6827553414956054 -1871 -0.2748102527338946 0.3122227085600739 0.3298961001810516 -1872 0.3194209298214664 -0.7445901189862209 0.8244239534389373 -1873 0.2636109147598613 -0.7923202599736067 0.4362643328049295 -1874 -0.4104605918150604 0.3405032743413422 0.4744690190540853 -1875 0.497731678469152 -0.3918062262979392 0.1406749679960977 -1876 -0.5463228586924249 -0.3726200922846346 0.6889810645833149 -1877 0.6401470520902447 0.1368079710937282 0.1676449109544919 -1878 -0.5333102617735804 0.02637233237386779 0.6443866053997293 -1879 -0.1578853667264603 0.3082204050873464 0.1419614660580731 -1880 0.25627663475198 0.3672855549819526 0.3579218521225834 -1881 0.1700024468948066 0.8203364090456934 0.3441347102959313 -1882 -0.4341674543757161 -0.1300941436592158 0.3739877585526686 -1883 -0.3414550328214129 -0.5738035645444385 0.6243810967486659 -1884 -0.186513629274071 0.8144563022143906 0.1961518479863084 -1885 0.3336122019766977 0.2990217375759618 0.8534359276531993 -1886 -0.1181839931301286 -0.4042913210285911 0.7007949174089227 -1887 -0.5112703785083013 -0.2125421650725316 0.7105599843622197 -1888 -0.209001450474068 -0.2340451500234244 0.4774581323235618 -1889 0.8035758444736105 -0.2642566889231577 0.665137625415563 -1890 0.7169724804278209 0.4612359109139338 0.5491900517089714 -1891 -0.2757317080286829 0.5334357128757602 0.3164130711580824 -1892 0.4301138382390157 0.1985943530314085 0.5653657007665609 -1893 -0.1627577742021715 -0.001195750585257546 0.8622654563107478 -1894 0.4072648948638856 -0.7389216246603439 0.3283280205737901 -1895 0.2695858495689847 -0.5836342324276668 0.1516850538496391 -1896 -0.08587138519130103 -0.3389137726465978 0.1569444475996139 -1897 -0.6227885814444443 0.3452701714359619 0.1605569445272338 -1898 0.450434327607055 -0.5053648295996997 0.4644239969554326 -1899 -0.481421048340379 0.4648077925348399 0.3419521979175524 -1900 -0.1436454549948708 -0.04974846789106671 0.4366303736092227 -1901 -0.6883829836102946 -0.1322751384571004 0.6642966055710632 -1902 0.4153395568188203 -0.02791484241195973 0.1550702208969312 -1903 -0.1228020732084685 -0.0657178136667692 0.1822383356872605 -1904 -0.7284153656647405 -0.4235676597195699 0.1533768305375023 -1905 0.009269036339737781 0.6767846712810349 0.1487439585768934 -1906 0.423285827766928 0.5334492600172978 0.8351113226458562 -1907 0.6279503677636153 -0.5794260579909577 0.7279858797976312 -1908 0.3212007199821644 0.6684042613201846 0.8314238027711682 -1909 -0.4567399169128528 -0.16357636225273 0.8685311235584965 -1910 -0.07468177598850173 -0.6623720965978936 0.3445527322581249 -1911 0.5502443257222018 -0.3574562910487877 0.5455581455995123 -1912 -0.1523434405181532 0.8317190298195828 0.7082218540222007 -1913 -0.4298653743364559 -0.7309311751360307 0.133260320587677 -1914 -0.3086163759964929 -0.7944991924058475 0.8429797780370928 -1915 -0.4169706165896858 -0.03881233781539868 0.1504118452791452 -1916 -0.1208909348010609 0.6641297567151327 0.431453207533195 -1917 0.3894506179714239 0.3627694841090023 0.2917703589870371 -1918 0.3403096352977707 -0.1902416860682809 0.1471294841026333 -1919 0.4155294887764775 -0.372280200554244 0.3788324417354608 -1920 0.1943908291432948 0.1554617382001011 0.3343384728747047 -1921 -0.2406767524912235 0.6198909836858413 0.6971289203422656 -1922 0.204415702209442 0.1036610063050462 0.8434114307145313 -1923 0.1056042955190601 0.6018316461020546 0.7183356151760701 -1924 0.07435331390637703 0.6882420111834119 0.8444759389603153 -1925 -0.2549382868201227 -0.3783570936681964 0.4006959435890271 -1926 0.3233022635445528 -0.1576015873871742 0.8323405552906988 -1927 -0.1182994002500232 -0.849898711260532 0.1456914141872615 -1928 -0.357858125110728 0.01954613810997256 0.5506977046702169 -1929 -0.01511855704814912 -0.8532446143249087 0.3531900697639659 -1930 -0.5632762667403025 -0.6407979028855134 0.1494138890025552 -1931 0.6469315171048758 -0.5505720079786326 0.3269710015597609 -1932 0.09401207291875552 -0.1096474274749635 0.4133186831979591 -1933 0.7036063568755009 0.4699219939710699 0.8459200425305979 -1934 -0.2934731114084406 0.789790300788349 0.4820083765378938 -1935 0.03946014249263127 -0.3284741798551196 0.8644617041473633 -1936 0.4563504561876592 0.7346767936990294 0.7001763116719822 -1937 -0.7674548657012984 0.3553242103919801 0.8496144541008477 -1938 0.1356742045159678 0.140238045859411 0.6852200292755464 -1939 0.290429605096002 -0.3846400814489358 0.1380151093066113 -1940 -0.6507254956518073 -0.1636738432018194 0.2743510468864088 -1941 0.190811623188796 -0.3264262730376234 0.4693904305055324 -1942 0.6271254997605362 0.5989427029091482 0.5498764503875908 -1943 0.04502422238161667 -0.3506135963648737 0.6390954924758461 -1944 0.5077242953934304 -0.5072211571852391 0.8486610141192255 -1945 -0.03777458054809463 -0.3856459630839103 0.4574501879993149 -1946 0.8615839434959125 -0.03963956050052901 0.1852905941856055 -1947 -0.004403295663172879 -0.6561483201905337 0.1366540319560461 -1948 -0.4222245888486003 0.7408499474985654 0.3427712102634076 -1949 -0.6770237054379267 0.256256462200578 0.6307326259371607 -1950 -0.1394944136138131 0.5838850968065782 0.311692054138594 -1951 -0.2036914455284332 -0.6111799071307513 0.6751536208178557 -1952 0.6455839757028253 -0.1714511538782559 0.1479812868098924 -1953 0.4793442358729343 0.4874669874599891 0.4556826719475595 -1954 -0.3855780608594809 0.5153046523095202 0.8573513032203289 -1955 -0.03858390135697611 0.8561292636656469 0.2174591218443439 -1956 -0.4003600977475648 0.5231314450472277 0.5480748914947993 -1957 0.7815401134035289 0.3327831735073176 0.3642664999514215 -1958 0.1129826443257993 0.4525861622723021 0.4264320904699229 -1959 -0.3318456998022986 -0.7119802001657813 0.5762490051895788 -1960 -0.8545132267245719 -0.04755777290983507 0.338240457888105 -1961 0.7817887846351753 -0.3271615412923058 0.1497502420223775 -1962 0.09723650301649225 -0.1227523534334505 0.5555858448603935 -1963 -0.3660044343479124 -0.03383993761119039 0.7194958021375333 -1964 -0.5393918258985927 -0.2530595435986563 0.2744412727653065 -1965 -0.5159481199549143 0.07587615678718534 0.1505432019049701 -1966 0.3619321028599701 -0.1523603070208578 0.4207684972690086 -1967 -0.6712642511727395 0.1125655990280512 0.1491803782642384 -1968 -0.6240821087097976 0.1480343602383573 0.7189847823342462 -1969 -0.1540781954895405 0.07195775785137856 0.2043850547210984 -1970 0.007756341929499533 -0.0007317486991873616 0.4307291717870319 -1971 0.148471009875292 -0.4459983482725692 0.6817612562477511 -1972 -0.8624265574827907 0.07162893585749137 0.5186593331352873 -1973 -0.6964640569134519 0.4983596865309592 0.5823276483872792 -1974 0.5233733450119625 0.1672328172090549 0.8213864266180282 -1975 -0.7700628176684935 -0.349548182664521 0.5380510988969706 -1976 -0.6684038460302634 -0.07459254258892489 0.865209817429003 -1977 0.6226887569658188 0.3176970825916136 0.1443841252303541 -1978 -0.3318425490227083 -0.6337698401565606 0.1303006303859131 -1979 -0.4818251315158599 -0.5245014474373024 0.1357980335586472 -1980 0.2534540727594724 -0.05876400101501192 0.3789346697116525 -1981 -0.6541235907462966 -0.2531454839637083 0.4058056769199412 -1982 -0.1499482935980512 0.493632594461422 0.1377101246096814 -1983 0.2447165720457164 -0.07590326124960307 0.1482596096239063 -1984 -0.8329077338406882 0.1970260003520843 0.8592708661354946 -1985 0.0521451482774053 0.6369899431482834 0.2844046699467159 -1986 0.3095941028312735 0.1984158527612064 0.6726460547016013 -1987 -0.1053745315208202 -0.1774316746491195 0.7260511924578481 -1988 -0.1129110823529134 -0.1273212101665311 0.6001190340702387 -1989 -0.3212797913267582 -0.1013123079382443 0.2787012923900717 -1990 -0.8407309942512162 0.1280781056964347 0.1554967625398166 -1991 0.6454540808273547 0.5307950340608535 0.6690405156400144 -1992 -0.2857728797031585 0.03682617525362827 0.8761254971011312 -1993 0.7705053237288289 0.353846468087825 0.1581958014908569 -1994 -0.6269398065768421 -0.5870094471040093 0.8586576997831979 -1995 -0.1493883193483952 0.8182425327899607 0.8574972178579308 -1996 0.3816844596778744 0.3511401810028325 0.134132762010775 -1997 0.1021305835144664 -0.1820819017446901 0.1370485937360733 -1998 0.3299489826315722 0.3158882656869445 0.5864189748282934 -1999 0.6749641871789686 -0.2532530354217665 0.3601165341265737 -2000 0.4844849432713875 -0.03222832368722415 0.6176933160016455 -2001 0.1130719532265823 -0.2161484422951669 0.8686161567104039 -2002 0.01688249666331677 -0.06262851011003087 0.140656174200846 -2003 -0.6888338491996532 -0.04973444765955637 0.3535212188464415 -2004 -0.06078101861232882 -0.3731849320303456 0.2974727898666168 -2005 0.2381854841023914 0.1862299824883865 0.1347973478505014 -2006 -0.2169339704737894 -0.4930174115032767 0.4698600404624669 -2007 -0.1764686937026834 -0.2774317316934663 0.8827156901407857 -2008 0.4503038107896717 0.3895368939398637 0.8543470914581099 -2009 -0.8153689383985999 0.2782169484879964 0.6576373813955125 -2010 -0.5180451789410545 0.4339830042190708 0.6020182969900041 -2011 -0.1353049620719254 0.2421111304854398 0.7213911868126018 -2012 0.1738423958385219 0.44504300238071 0.8652382753153527 -2013 -0.3267663647819106 0.3390410415268076 0.8612438619911481 -2014 0.3268118562047991 0.6367596219995979 0.5794402963846924 -2015 -0.1959032762556433 -0.2562764642148988 0.6091266059239153 -2016 0.3245671343253437 0.0008227223510846593 0.8339114226918899 -2017 0.1699922890187227 0.7006951433005434 0.1282444979885358 -2018 0.4681548870006831 -0.2037328513698946 0.8426401386680222 -2019 -0.3139450585067586 -0.2002504462819368 0.5643568727734561 -2020 -0.4842503498049162 0.3243201543607412 0.1346688136399451 -2021 -0.2694241065154273 -0.5808822056188708 0.8582924895342889 -2022 -0.3747687766595331 -0.3995170086370441 0.7120794638768855 -2023 0.3638545515162389 -0.5865550587113519 0.2573938458692649 -2024 -0.02994398788792463 0.6158810436835728 0.6977766144061381 -2025 -0.5896254975076983 -0.3831143739463101 0.3399469973783634 -2026 -0.6553916055145144 0.1861145905565911 0.8672727607869558 -2027 0.2324666925986604 0.5272288444961796 0.2817573197542323 -2028 0.5234533766816716 0.6956442338327765 0.4818390239230312 -2029 -0.143108586245516 -0.2575682454831338 0.2591869482606644 -2030 0.202147887329574 0.4587049595779576 0.1413751693307268 -2031 -0.08245317675621568 0.1393045167178021 0.3572486292131586 -2032 -0.3682278968164989 0.0809603981577732 0.4380199719467451 -2033 0.5087140640619597 -0.02205638164481489 0.8722754105889063 -2034 0.7924578924016293 0.3310915914814553 0.615097352164342 -2035 0.02815135999219359 -0.861249229023637 0.488266326155156 -2036 -0.1211834908658382 0.4789833240186051 0.8378165973358933 -2037 0.3743591801744934 0.06975800195243348 0.6184895279382057 -2038 -0.2923489700470596 0.08667444134765857 0.2902749190465349 -2039 -0.6240164460985792 -0.2936448147172723 0.5784404905147176 -2040 -0.4289595768860093 -0.5525167045998479 0.3393790830145899 -2041 0.3284691262998812 0.8006642841284161 0.7832152399603012 -2042 -0.4517852707982987 0.2913503370526007 0.8737318726521681 -2043 -0.3390870145429675 -0.7985733630302621 0.6858265923484183 -2044 0.07792179024728964 0.188652146811116 0.858150342976233 -2045 0.4359789366756412 0.7525354218077123 0.5677536106845249 -2046 -0.7664309729408989 0.3944453903292283 0.2114998193594446 -2047 -0.5025123625823872 0.1757556783697116 0.6595909652974712 -2048 0.5605007860104498 -0.213348268790139 0.4692176289232913 -2049 0.02547515626218691 -0.8654102879607724 0.1530665330779941 -2050 -0.2320645277416178 0.4286705880866093 0.6880075025614245 -2051 0.71103308316657 0.1505976893632107 0.8530088479359534 -2052 0.07254739272985253 0.3036583899558979 0.2783049830612591 -2053 -0.7030099614339448 0.4927747923854261 0.8557274977516028 -2054 -0.8037921897671507 -0.3144791401830997 0.1968934136770429 -2055 0.8510626110999524 0.1447269019691394 0.7051069639910444 -2056 -0.7394487133086149 -0.4340441877693673 0.8597410423871857 -2057 0.5706702215828964 -0.6389539755521569 0.8483653811338041 -2058 -0.166466884876485 -0.5193644603884924 0.294925471131503 -2059 -0.5563314366416854 0.2972311155484197 0.3179156611508201 -2060 -0.8437713288196667 -0.1558043665946613 0.477171207579683 -2061 0.5693477694122527 -0.4065578562343366 0.3473326521144449 -2062 -0.3558309402667079 -0.3305608834554186 0.1342985513869139 -2063 -0.5071160786364058 -0.1921420909313377 0.501446101772024 -2064 -0.1981453591112653 -0.8393062738294885 0.4961079696749867 -2065 0.05714617420556981 0.2871164033826997 0.5401061538361155 -2066 0.407585456326406 0.5546926980459161 0.1339591827284597 -2067 -0.3373155936556095 0.4206093086326822 0.2909733991270204 -2068 0.5288454460251998 0.6726297682960756 0.1370778629464023 -2069 -0.5359543756392847 0.6721476480756932 0.7348560644741483 -2070 0.109582435080705 -0.8444023487053159 0.6648125982672333 -2071 -0.412305554623039 0.2142648263478042 0.2641421440127042 -2072 -0.03086858532825973 -0.3195875386158392 0.7477447191122346 -2073 0.8044360297039428 -0.295259036308079 0.2931257091938654 -2074 0.4426463936142723 0.5798626404862972 0.3468733865907183 -2075 -0.531752250770211 -0.4959040106959274 0.4005490619799961 -2076 0.215072692818648 -0.6476431261444666 0.8578943533502577 -2077 -0.4502575498169812 0.1253358155362689 0.8724046672968395 -2078 0.1594017372901529 -0.06814645861295532 0.6624015645543456 -2079 0.1791906203975193 0.703653199814367 0.6418321946996326 -2080 0.1707426408921319 0.03202920843108373 0.2835444251689719 -2081 0.8103502284106343 -0.2884360016704725 0.8457066659819364 -2082 -0.3037754403009207 -0.2449895359393976 0.7227812272517971 -2083 -0.4045618973188356 -0.3534839205219086 0.4234147908898253 -2084 0.03370643984283835 0.2377318496189745 0.1266110309831601 -2085 0.187477677482894 -0.4277894830400209 0.3732457411947996 -2086 0.6246570725778954 -0.3026020538078947 0.12944204208133 -2087 0.1422929777200452 0.8452344597810622 0.8621083526490309 -2088 -0.09581800271979862 0.3756704348650541 0.2615728127648748 -2089 0.6580102170889137 0.2119348249072855 0.4090759701756979 -2090 -0.2497776202802752 0.1004021247381746 0.1243075312393833 -2091 -0.5276279984374959 -0.01813580438970374 0.8897279362260793 -2092 -0.5986646229964204 -0.4023663467805549 0.1312116322188547 -2093 -0.04998243531167414 0.7147355450632643 0.5299638193617967 -2094 -0.01611740590383849 -0.4898887672873047 0.874455225128929 -2095 -0.4288698521298968 -0.7487335459696072 0.7835260162055498 -2096 0.4300412239152108 -0.5332695696788065 0.6667239147861811 -2097 0.4593610085697046 -0.2774091436706051 0.1164473313687073 -2098 -0.446094843380665 -0.004245758888901247 0.3852586196064489 -2099 0.5634350482328946 0.6588912766589122 0.7286210719197235 -2100 0.1093524335962942 0.6924244260953061 0.4835007226944565 -2101 0.3113151794181378 -0.8098133271240759 0.1492343551242979 -2102 0.2261547616118871 -0.2143694257270507 0.7399450068395375 -2103 -0.2695011798837563 -0.1492203953662797 0.4026954363923163 -2104 -0.52046819007892 0.4754830254977376 0.8646264019482364 -2105 0.4767358544441169 -0.334801081827565 0.6848973993766887 -2106 0.4039878646404673 0.7522247350622018 0.128985784642686 -2107 0.7284089487744495 -0.4581888072645059 0.1379528829805284 -2108 -0.3012589334976219 -0.5997730886411534 0.4204638190196012 -2109 0.8617966038789814 0.05154076000074044 0.3626027265360391 -2110 0.4184364894202214 0.1019661860802095 0.4625477133632412 -2111 0.4249707496715782 -0.1584038660477894 0.5871206330256833 -2112 -0.3143870087252855 0.2881098982817215 0.597806579385178 -2113 0.1904591451034299 -0.1953803137487679 0.3307083035107737 -2114 -0.590437848454927 -0.4844182346809008 0.6377645435900637 -2115 0.8749123148238568 -0.04478980193878082 0.4988354464982971 -2116 -0.302006289395057 0.211558699748169 0.4779830889316083 -2117 -0.5530381799961132 -0.3699877899608249 0.8691780001893157 -2118 0.326014923668712 0.2712169152248007 0.4229027385370693 -2119 -0.7075999267503031 -0.50840929885149 0.5418166958216977 -2120 0.0449852893873208 0.8707059098043478 0.3240968452739816 -2121 0.2998220070820717 -0.2454268602671927 0.5505405629559654 -2122 -0.5713290975760634 0.4004285480721118 0.4156788526751678 -2123 0.1720780333727027 -0.4957863845908874 0.1301976564814535 -2124 -0.130005213064852 0.6933699854453785 0.1532813467799198 -2125 0.6491116981490382 -0.5655791039887097 0.5814032293432129 -2126 -0.4278420612182201 -0.5336815755608638 0.5368112300258705 -2127 0.4940549362350651 -0.5610104503562485 0.1262625751447525 -2128 -0.8632263904823065 -0.03258412993320441 0.1359300033844008 -2129 0.817359317282351 -0.2685592368443043 0.4437286830271966 -2130 -0.231143498934721 -0.4292992281458771 0.1324074038811776 -2131 -0.02066779420125272 0.871439116762076 0.8499999999996051 -2132 -0.3777182983292913 0.7852011072999616 0.8718178819436684 -2133 0.3011944427976132 -0.3533675701585708 0.8694816491296433 -2134 0.3572205794700266 -0.4304800124034842 0.2734337790643249 -2135 0.8673958278775882 0.1350824430758515 0.8711602138943128 -2136 0.4663316877890993 0.3940448595226275 0.592085064548579 -2137 0.1404903222984472 -0.8448549667739323 0.8519068284621614 -2138 -0.4281054228584459 -0.7561797242782903 0.4915515253396683 -2139 -0.433793309169308 0.5703248562650641 0.4007157948739776 -2140 -0.1090446786688798 -0.8614404783318387 0.7223870142249312 -2141 -0.6598250830097732 0.234999957279331 0.5021756455246768 -2142 -0.4767228756634362 -0.08063595209186565 0.6868453284547131 -2143 -0.005094497581354419 0.1142870001487638 0.6022805409196011 -2144 0.6446198276377881 0.5727286404950058 0.1306747939987768 -2145 0.2902690785172535 0.6251009134597456 0.3946522666868959 -2146 -0.03937657111813746 -0.7201721939854757 0.8663568680968272 -2147 -0.4726073325593608 -0.06066455103441372 0.27261715086736 -2148 -0.3485981627200821 -0.1173667628696722 0.8910311826860182 -2149 0.5585536321932957 0.2001222511482689 0.2854493449900224 -2150 -0.06552023583333047 0.4872720529002833 0.4300474499438339 -2151 -0.4030908729717043 -0.3947281058127801 0.5825853976342223 -2152 0.6804186525250848 -0.2050497613511079 0.6337366208624945 -2153 0.5159528185478226 0.1781693547799776 0.129350738863068 -2154 -0.2597978663432111 0.6365349432530092 0.4001420343485349 -2155 0.5855119548801235 -0.6444008373211545 0.2421758263137414 -2156 0.03865251251326511 -0.5271898091398926 0.1202821872881676 -2157 -0.2288913240121414 -0.1203480447201896 0.1248960038762526 -2158 0.1986461629978537 -0.668798629920818 0.6081804647064244 -2159 0.003100212235885563 0.09268042891230249 0.1259204092094739 -2160 0.6965096234737141 -0.1403125820880333 0.4734345699260439 -2161 0.1446204120610582 0.8607261559285454 0.4837414622538871 -2162 0.4382935524849751 -0.7451465805670994 0.561004440108812 -2163 0.5784462069780928 0.3682393460436278 0.2629425606446049 -2164 -0.168717008880517 0.2736773688308151 0.2739605406923505 -2165 0.8754001081847939 -0.09151966634231169 0.6780388129930293 -2166 -0.2301814076080373 -0.2613333283312384 0.3536558841395496 -2167 -0.5119994435653263 0.04757516745716822 0.7680478058306511 -2168 -0.1517022806520584 0.07610367848856762 0.4547096944427634 -2169 -0.8195564891933078 0.2906185727695579 0.5223718146680493 -2170 -0.5144703615632579 -0.7138788891709172 0.2730183870821554 -2171 0.635576245219496 0.6036773972000575 0.8778523654792363 -2172 0.02746696505773132 -0.7331814366836649 0.3940453552013738 -2173 -0.7113668655479333 -0.07190679329222817 0.1335562639235685 -2174 0.2616007020749181 0.5375632658865633 0.7290682199201327 -2175 -0.7200725993565874 0.08799673153141857 0.4887345631313922 -2176 0.397861427587146 -0.2275098156516904 0.3144995843976999 -2177 0.7133411803209897 -0.05159969981505366 0.8585219301465822 -2178 -0.5131939601196465 -0.5097371429420083 0.8735660740694992 -2179 -0.8729528003021098 -0.03372038410573563 0.7415880824103332 -2180 -0.6187338568032139 0.6038335396449142 0.5097927732560312 -2181 -0.4176772583368683 -0.2863338223728813 0.6778208325298672 -2182 -0.1354292810457839 -0.7026243217193664 0.5611410673575306 -2183 0.1589700585151907 0.4562335338220426 0.5993665183788323 -2184 0.8474916763452298 -0.06823392732662401 0.8829261447681226 -2185 -0.2597373148840892 0.2496619195761607 0.1139627706363393 -2186 0.8687081746729429 0.09164468733043842 0.5014760961511827 -2187 -0.2658779482459565 -0.427057820612197 0.5784470957490582 -2188 0.05968148309574124 -0.7151322106441117 0.6468566374953603 -2189 0.02696670555560149 -0.649371343131795 0.2633823340260381 -2190 0.1201373661510256 0.3351693606141496 0.1186545784856358 -2191 -0.5555330342626372 -0.6758021520003612 0.4603342036701946 -2192 -0.4540038180092959 0.7390275182057859 0.5276474331628709 -2193 -0.5678494371046306 0.1361280990209974 0.4558787611814688 -2194 -0.3094558019141869 0.6306867773119552 0.8684944250898533 -2195 -0.6478463642713282 -0.1644725353508851 0.7779601935734238 -2196 -0.3418424094899757 0.6129679110103989 0.1259274513382152 -2197 -0.8425480989053364 0.175489570599074 0.7318343723324974 -2198 -0.6108023588398432 0.2765972371433255 0.7367462685669015 -2199 -0.0705877061089495 0.05400192007510454 0.7961190223067058 -2200 -0.2582350196477303 0.3790449128729736 0.1193059551240202 -2201 -0.1706698390301715 0.1132498856446494 0.8950860414847661 -2202 -0.7591507881448514 -0.42337839102773 0.2843846420165516 -2203 0.6438126960021688 0.2078133375394828 0.5535791465680885 -2204 0.6168288236555156 0.4076720055539471 0.4768854602621236 -2205 0.5739697891217915 0.4360889036879847 0.8759765275922213 -2206 -0.4884295273597861 0.5512444467548523 0.7607880847850065 -2207 -0.4542928816252397 0.5453812578394018 0.1240177515399751 -2208 0.261624890239488 -0.40119606724469 0.7442159026075457 -2209 0.7331837238761277 -0.0630136608353149 0.1344798783598035 -2210 -0.2266294319378325 0.6196540164821029 0.5256194846575831 -2211 0.03180174676749169 0.4758692011020362 0.1214094619437233 -2212 -0.04508048130781325 0.8830523630817037 0.480781885161649 -2213 0.2916613304903793 0.5464997579652749 0.4957111352822977 -2214 -0.3203502223202499 -0.07384788842334793 0.6133182873591528 -2215 -0.5380784997946538 0.3929104142623951 0.7198110331437398 -2216 -0.312228301964958 -0.3349511100522805 0.5000315575817653 -2217 0.1888326072221622 0.8524176940674439 0.1228826878392107 -2218 -0.1691177060001753 -0.6713293876680581 0.4320767870410506 -2219 0.1272138086452964 -0.5283284570303273 0.2890461440558724 -2220 -0.3505778254515487 0.4523296977406454 0.7185033767290285 -2221 0.1956946211952566 -0.6754047070053554 0.4310614104724295 -2222 -0.1446697533872223 -0.2247203389117624 0.1176825865635955 -2223 -0.4942937098735983 -0.4573155170753133 0.7629010370908696 -2224 0.3416713788838051 -0.5465299964980086 0.5373652498709482 -2225 -0.7088442868479409 -0.2564314538015007 0.1210172847151226 -2226 -0.04367934952078386 -0.5478622694442657 0.7133683225577869 -2227 0.02852260619191879 -0.5211699853933912 0.4619289503990009 -2228 -0.3128156353188873 -0.5902798806338294 0.2467061616839179 -2229 -0.3621605845813457 -0.6759180858065998 0.8736043641992075 -2230 -0.4228491020508428 0.2306411497258943 0.4311770120814226 -2231 0.2128088682387878 0.09565874999758578 0.5844455953955177 -2232 -0.4201947135982907 -0.5752013897437992 0.7248894431845913 -2233 0.7670461092082307 -0.3964413405813574 0.7664247226701217 -2234 0.2955637069830203 0.3371794459178669 0.7360275629860141 -2235 -0.08306337875262423 0.726640688726247 0.6579836431430559 -2236 -0.8614927143241016 0.186204377540418 0.4575613541717961 -2237 0.372564188050625 0.01900342901468431 0.2700874841987623 -2238 -0.707072371745466 -0.09080107515764435 0.548262696060391 -2239 0.07599492185653708 0.5164261827226531 0.3214080737210531 -2240 -0.06176992243677895 -0.3746645490543384 0.5802921801192368 -2241 0.4518089925317835 -0.7327838687244022 0.8694213303231109 -2242 0.1918970411025933 0.268069179114617 0.2811200514679383 -2243 -0.3873675532231218 -0.1288565776315491 0.7823834800770124 -2244 -0.1834296369906647 -0.5173505803729128 0.5971435019083324 -2245 -0.2084055373590287 0.0008102796845953705 0.752282577917964 -2246 -0.6479151866699771 0.6017136732343189 0.6300404720474444 -2247 -0.05991368491463218 -0.2710246483466783 0.8859288662076903 -2248 0.7400845699771194 -0.4492994231341511 0.5127387006658841 -2249 -0.5245679716761251 -0.06211804064878583 0.4917199057722887 -2250 -0.7397056113704532 0.1264893625038761 0.6806403356675745 -2251 0.3009917913270679 -0.8205713287124525 0.3092661019932553 -2252 -0.4308275358661132 0.1055219969709007 0.5888931269828666 -2253 0.3411886035031085 0.8128593268228195 0.5062763367268764 -2254 0.3079914897618015 -0.623414953184965 0.7576055398802707 -2255 -0.6918149932917412 -0.5311888534625948 0.7156976190808847 -2256 -0.7042730630509243 0.520923756062347 0.3062494358950403 -2257 -0.01106574404122819 0.02586616790915422 0.6911727279321092 -2258 -0.1930393676269077 0.4210243056095462 0.4853758761081264 -2259 0.1518628223552008 -0.85984320316181 0.4455305749828634 -2260 -0.5110010840649366 0.6688223578451187 0.2883260198669096 -2261 0.6093389486430764 -0.3281682461954512 0.6653268224844119 -2262 -0.4377405391314869 -0.2338962561215107 0.1166026313064532 -2263 0.30932925509431 0.5347222638269348 0.8889597075861344 -2264 -0.8529599691625255 -0.04715270728329735 0.8768067807143582 -2265 0.5705275225677714 0.4154091636185963 0.7348201590830821 -2266 0.206356229831661 0.3043119838017404 0.5070062594364583 -2267 0.692311548412869 0.5434689116933111 0.2846347469397439 -2268 -0.1112287696760226 -0.5971837912218924 0.1178218659070199 -2269 -0.1069738191185493 -0.467056791591184 0.121432986183224 -2270 0.05951738160900624 -0.01110519293653066 0.3182576973045928 -2271 0.03715439039233374 0.2032376041808521 0.4499537686765792 -2272 -0.6312156768940697 0.3831515523833683 0.6150693504122872 -2273 -0.6596639282751064 -0.3462807864717022 0.8072270286028785 -2274 -0.1401301289632564 -0.8758094357823268 0.5952974755384872 -2275 -0.2422225931277653 -0.1379849442281665 0.8998652036123262 -2276 -0.008260795301274007 0.4892064382683021 0.716364486364228 -2277 0.06799285948129917 0.8783982649409768 0.1094732129755622 -2278 -0.04489473912737343 -0.882213755989069 0.8853657120315455 -2279 0.5139293429248954 -0.7108036365664978 0.6928797598986596 -2280 0.7395687384930028 -0.4615800649837196 0.281768159596529 -2281 -0.2859541316739108 0.8254181785194916 0.6907814451207113 -2282 -0.7673327022223874 0.01942308866883461 0.5791528110381128 -2283 -0.1519423874496985 0.8680516287908963 0.5539514931784805 -2284 -0.003160735828721187 0.4328678114697446 0.8778472233740576 -2285 0.07876706367311694 -0.2731895598073755 0.7549454615414823 -2286 -0.668928534461666 0.09234975826996279 0.2807294479214926 -2287 0.2445389588061809 -0.8287261160441902 0.7008083784181578 -2288 0.6878763055834252 0.5664017689938763 0.4535001407517111 -2289 -0.3606430399161139 -0.3438416372315969 0.874106787287547 -2290 -0.03634985566169268 -0.0383042948971047 0.5786281650343603 -2291 -0.2628680178891547 -0.3596398007741763 0.7207584167493158 -2292 0.1748083921099408 -0.6447246389686296 0.2926940211097027 -2293 0.1741781246900539 -0.3514373833453682 0.271811731776891 -2294 -0.2724534235454008 0.8444844234944096 0.840340185755751 -2295 -0.1934667943394935 0.1164392511861519 0.591991332602917 -2296 -0.2413847231845873 -0.007483565428977712 0.475157124499027 -2297 -0.6501937163149081 0.2314089449086799 0.1174106113993713 -2298 0.02871906184896342 -0.2885991580420501 0.1200399895727922 -2299 0.7076003968700006 -0.2088792479082664 0.8755662780818965 -2300 -0.0924891428306187 -0.2227926980289624 0.5041817149592234 -2301 0.1034835483877327 -0.7187886754876687 0.8759122139825558 -2302 0.2384567947738816 -0.2394414964015217 0.8831091117757721 -2303 -0.7196243451042592 -0.1942427711482292 0.8806219913646722 -2304 0.5351650499329617 0.2669854041137404 0.4978022881200124 -2305 0.04609212571953434 0.707739102236248 0.7211572895879458 -2306 -0.06708076649580778 0.3037929851162793 0.5888991846335887 -2307 0.8273927108044181 0.2756320917676425 0.4805977988675463 -2308 -0.06173606284472631 0.4755196217829663 0.5759606114053337 -2309 0.0103597557457385 -0.1981888847582778 0.4077772097049084 -2310 0.07881446054181648 0.3148822701007892 0.7189382941379564 -2311 -0.2457734447204658 0.1231549282552542 0.3928551226260663 -2312 -0.1365054661452632 -0.4131700800579434 0.3873765169496516 -2313 -0.5172857299370747 0.2198732152534002 0.5526711743043649 -2314 -0.6529509565799958 0.3081978964937696 0.4024891505487019 -2315 -0.4334706069114553 -0.2424867563426233 0.3307516450705096 -2316 0.7669527278168213 0.4283723966071037 0.2776031195887856 -2317 0.3425050496559507 -0.6869874995454376 0.1382418908549793 -2318 -0.2435937050385879 -0.1806801165553812 0.7925936997363811 -2319 0.5335477827580272 -0.2977232175298803 0.2156118775128731 -2320 0.4279197115967669 -0.1954553257682189 0.7135861056391007 -2321 -0.7632898234817707 0.424886709946585 0.3720072474276619 -2322 0.4553911077758795 0.2622707893550857 0.8768335282161137 -2323 0.1072500876528361 0.1507694958584511 0.1060305222655844 -2324 -0.1784951738045083 0.3727212418215693 0.8744058047094799 -2325 0.2118672776366412 0.3245743167064246 0.87983450483639 -2326 -0.04768583356384522 -0.1530616949176209 0.8938136988610232 -2327 0.598743310049287 -0.6328343824126836 0.1160238864329421 -2328 -0.2607565495322178 0.5290858255970026 0.1071400737032346 -2329 0.2673551423661406 0.6579740718612938 0.7122299127253394 -2330 -0.801512684126794 0.3118041303649108 0.1175785224512145 -2331 0.7437031163808722 -0.0242193730011715 0.3446559654053969 -2332 0.3499907189222872 0.5623141554664739 0.2705052489118191 -2333 -0.1643166816322504 0.1694310739211527 0.1051357566563701 -2334 0.1929091362847992 0.1345376266472419 0.4542977303462201 -2335 -0.1124204594881851 -0.5819558550809335 0.5210516534636667 -2336 -0.5084199959277955 -0.4444603151855853 0.220723194055439 -2337 -0.2789954484863568 0.1522361197310045 0.8826779855850262 -2338 0.8376687423874736 0.08067672834991416 0.1306632168666219 -2339 -0.8500214176095467 -0.2018657388989338 0.8726825278466326 -2340 -0.3213052287034535 0.05927932068564287 0.7693916333919271 -2341 0.4769660769165362 0.539117235549701 0.2303064781193769 -2342 -0.567111067935721 0.2973474428569919 0.8900935853414061 -2343 -0.2630041018526245 0.4163414206366461 0.3803127202711374 -2344 -0.8569820592322305 0.1788519235699778 0.270780100381906 -2345 -0.1265852605636568 0.8325838489058752 0.3095546325130685 -2346 -0.2313091870926866 -0.8372881113148269 0.7371624260604447 -2347 0.5259214717337009 0.5436647930374019 0.6653395865401021 -2348 -0.2661206666099213 0.3925590208190598 0.5831770919026749 -2349 -0.6642360217921183 -0.5719910950865912 0.115899720895081 -2350 -0.8789604088266498 0.05779302487135037 0.2602176143940107 -2351 0.5391675421182213 0.2413473284557956 0.7158312877061487 -2352 0.3892959914022961 0.1388802662588759 0.2989853186986579 -2353 0.1671512167657742 -0.3581344598906235 0.1149439166516288 -2354 0.3513189261162471 0.4285458444201547 0.4689529960618487 -2355 -0.3513967094937555 -0.1450577646384512 0.1370638653018941 -2356 -0.5974540373835732 -0.05977969933486485 0.6906087649328974 -2357 -0.1325482964523836 -0.6287691039728343 0.2436318915036923 -2358 0.1917952515617314 0.6916597395920823 0.8835954421830493 -2359 -0.6330529246143992 0.6075491585915298 0.1193269840081813 -2360 0.06756066988117065 0.7824901657520568 0.5522235731033001 -2361 0.698612506932061 0.04980005306949521 0.717470787539328 -2362 -0.009187454992049676 -0.551415565099331 0.3273578635910566 -2363 0.7232866784927818 0.1353541724390264 0.4863130257853776 -2364 -0.06595677112407859 0.02555828683161531 0.3457751356063658 -2365 0.7956166108275354 -0.333200945626086 0.5548065902094644 -2366 0.1729706741704808 -0.6757872936345291 0.1053058864963726 -2367 -0.7178850837771031 0.512551654040256 0.7285247996640138 -2368 -0.6969513956752189 -0.1366488526729163 0.4369874837445226 -2369 -0.1450926482975545 -0.1632937243396614 0.4104519280590921 -2370 0.4518296353846791 0.05390498012484093 0.7822314163031161 -2371 -0.1767444690998057 0.7157690161410489 0.733573179916196 -2372 0.1145569125389477 0.5927352460418428 0.5493706476292187 -2373 0.3015911955659955 0.07085109470261591 0.498380343503586 -2374 0.584799329962529 -0.2558640549791161 0.8839594110236579 -2375 0.2440983225815901 0.8321692492361912 0.6998417977271842 -2376 0.008676699413781221 0.1922692337419056 0.251057676302273 -2377 0.09986632115107058 0.7199684469891652 0.3630731185764738 -2378 0.4258639543914774 0.7535638312336956 0.4491979144744877 -2379 0.4102887080235374 0.7773757603123107 0.8830553182740463 -2380 -0.6570752876172866 0.2301293649843746 0.2887693992858603 -2381 0.06281449872851401 -0.111305402757612 0.8898672934999707 -2382 0.2497886723203865 -0.804518886331922 0.5690536392090707 -2383 0.3667674744820123 -0.5888428398174127 0.8727292987286249 -2384 -0.6491716578288269 -0.5983654501161236 0.427526243809884 -2385 0.7142563548047179 -0.05405475680806619 0.56148258012593 -2386 -0.4692126262650984 -0.1906598236834432 0.6079369715097067 -2387 -0.165350744629738 -0.4658533171618945 0.8839049523859497 -2388 -0.00203611325756612 -0.1581685604507499 0.601828464627138 -2389 0.363338797295406 -0.5093137697696232 0.3695637020961671 -2390 -0.879368004387524 0.1674245137700446 0.6176118543257719 -2391 -0.5253093697390868 0.1016727486907353 0.2653953239242386 -2392 0.5643590977351451 -0.02945493179778654 0.7185066966101138 -2393 -0.4030534023455305 0.7468482229607525 0.7560330915264203 -2394 -0.05350969781595893 -0.8791981019093912 0.2424317890295014 -2395 -0.5003235123498349 -0.1293684761226814 0.1380242626850928 -2396 -0.2823962769271831 0.192206656460126 0.7425656966328283 -2397 -0.05400756433641702 0.5728012059977002 0.1135092055117841 -2398 -0.1569194240605987 0.3096239321369948 0.5152914790719021 -2399 -0.4265671458098727 0.4263212471274 0.1077230073009017 -2400 -0.4667335898631721 0.7499228336359395 0.2059480009659982 -2401 0.0168043627276571 0.3147937073877183 0.4004989607929321 -2402 0.1362475547994517 -0.3122904480659182 0.5739390142152587 -2403 0.8378694913814254 0.2444287930780201 0.2879931114609292 -2404 0.5268538545457165 0.5519675654331718 0.1220457476485982 -2405 -0.3541752684817162 -0.8095210253914451 0.1005367323805687 -2406 -0.3059303272676707 -0.8291036367684971 0.2858689232245946 -2407 -0.0956344849167523 0.02624763777272202 0.1099892011747551 -2408 -0.8355304288189297 0.2849969981868482 0.7786997175527066 -2409 0.5117954485097618 0.04971787738166206 0.1191445498307176 -2410 -0.8886560771590784 -0.04428306610507191 0.5030357868732783 -2411 0.1641351805311174 -0.3266035949303079 0.6929428052026156 -2412 -0.4019108761728868 -0.376206691813639 0.2330153016286595 -2413 -0.19253856698177 -0.05873531275601131 0.6345540196672956 -2414 -0.7986767759779391 -0.3559955447908391 0.7170917276033694 -2415 -0.3040084074753846 0.554828675608496 0.7756343917376525 -2416 -0.08841285328222195 -0.8842467546987015 0.4886654150639232 -2417 -0.4214742872825706 0.3786380255460943 0.2252825993625888 -2418 0.07323863756976388 -0.3541254550338565 0.4265429516097272 -2419 -0.8857883421615029 0.09425025165115597 0.8942104162820096 -2420 0.12819380706919 -0.4157863220830732 0.8825046044279785 -2421 0.3921512699707084 -0.7862573287597224 0.4475674983668408 -2422 -0.8864723922235244 -0.1726793098687508 0.1012380834523817 -2423 0.4950005518426009 -0.1516580621437496 0.30781427782274 -2424 -0.243075719294489 -0.8567832708911585 0.1415670500428222 -2425 0.05274733996351354 0.884210616931756 0.6423761537645065 -2426 0.7081573077296356 0.1477606077299298 0.3112158416495013 -2427 -0.4452376642109293 0.3108914809167726 0.5764310012484809 -2428 0.5363824956927603 -0.5048027974342516 0.5584307234879031 -2429 0.353206615773795 -0.03573375198971941 0.6896887579106838 -2430 -0.1493219112810019 0.4684994082723853 0.3058920056320914 -2431 0.5067414500914375 0.08280340869937342 0.3712738821688081 -2432 0.4983317632081675 0.5871953798631295 0.5086358837808352 -2433 -0.2935538764577099 0.6455145231532105 0.2809084813828673 -2434 -0.7273353879495315 -0.02002580878198109 0.7753594436821177 -2435 -0.7235391937661055 0.02820105734613464 0.88297879965541 -2436 0.3825114231718587 0.7916464634311919 0.2490553155892782 -2437 -0.1811792491691644 0.1575944289684879 0.3118208342135301 -2438 -0.4893648739236516 0.2008429353134445 0.1108472750580403 -2439 0.6383741463351682 0.04324911171065739 0.4791634957667847 -2440 -0.4503358008766135 -0.02730383339533118 0.5923059509347892 -2441 0.09873909204297887 0.5357428498191477 0.8838105503805405 -2442 -0.5619067762803357 -0.136714929497455 0.8905324465384478 -2443 -0.01837079936018123 0.7035081070241614 0.3835564548408916 -2444 0.4711248322776101 -0.6250476826474877 0.3043215287869512 -2445 0.5897433175557163 0.4241212148437575 0.1084340557758703 -2446 -0.08740700537004643 0.3974161361500688 0.110910604675168 -2447 0.2216517578164336 0.4760164947001516 0.387335777729524 -2448 -0.4528098536314328 -0.419479892280014 0.1034904843971675 -2449 0.05147574463424176 -0.1758573597089193 0.2818534032154556 -2450 -0.1818523648389097 0.6846702278222152 0.2628642813572108 -2451 0.795137646385784 0.3919691114818719 0.4692244713423687 -2452 -0.5143594292978227 0.3698122328540038 0.5087550127193036 -2453 -0.02378845587051304 0.2785799129580526 0.8881610573358315 -2454 -0.1190983291590649 0.403342398136655 0.7043591444077335 -2455 -0.002775935685714513 0.0912922196556962 0.8886578650363737 -2456 -0.1098670533661756 0.8738973901360845 0.1126839544040316 -2457 -0.01872745901214463 0.7915210253315603 0.1148507242076042 -2458 -0.3068583310911465 -0.8320022908886323 0.5558800822071444 -2459 -0.3176019352912839 0.6328680502470627 0.6044803571556786 -2460 0.1996209859809512 -0.1775165547069238 0.5813834226631769 -2461 0.8767218441707958 -0.1603435450373664 0.4672695155537324 -2462 0.6757061787376165 -0.573941814190135 0.8814334124148904 -2463 -0.4875183359680914 0.2986360902817211 0.7582835204172437 -2464 -0.03503736920007293 -0.7698373914386625 0.1123330312666939 -2465 0.3239910735242452 -0.3257625998987519 0.4618755447357054 -2466 0.470886053371064 -0.1270324973939585 0.4756308818135214 -2467 -0.2091331631349347 0.7150639398226148 0.882939014365508 -2468 0.3990299430482901 -0.3997337702822519 0.09914230070784046 -2469 -0.5012188830680787 0.7335156457494176 0.8908085243590651 -2470 0.003848836637312544 -0.216537633662662 0.6959571879569335 -2471 0.1131339565504012 0.3859002936317977 0.5204185849363737 -2472 -0.5888828069896608 0.4488495386717333 0.1090059415425738 -2473 -0.6182660230345787 0.4421785141287889 0.5146362055742719 -2474 -0.2045629512271269 -0.6554492666580279 0.788036609193652 -2475 -0.07369557385925962 0.6364066549149463 0.8801437939171468 -2476 0.1911863115688246 0.2125257812440618 0.6080718297096164 -2477 0.8709048824008795 -0.1437495302845862 0.1195144415317429 -2478 -0.7559330325688134 -0.104108997553393 0.2564912382521813 -2479 0.04853344471661854 -0.4670617003498217 0.6236155582441149 -2480 0.2074549457663429 -0.4481085470601496 0.533855350391638 -2481 -0.5026286269380249 0.5592997903583453 0.2362335032334361 -2482 -0.2599670017132745 -0.01627930629665848 0.3129232932507764 -2483 0.4739010821014409 -0.384807313737397 0.2740106320951823 -2484 -0.04804731393886176 0.7637606242255439 0.892373515514349 -2485 0.2873892026654858 0.7684493056188395 0.8947196027460499 -2486 0.602760514925576 -0.3261898845380847 0.4367597523105626 -2487 0.5084618433985454 0.031533128957732 0.5129687128647857 -2488 -0.8588203985831578 -0.2289370480114645 0.2630802379819829 -2489 0.2968228566192395 -0.4913974444873186 0.09903750671263219 -2490 0.5031158898010433 -0.05260613820143356 0.2365579889137608 -2491 -0.8360669562832218 -0.2768045825616382 0.4661177155800343 -2492 0.2964091490060959 -0.7009294093468018 0.3623566726560092 -2493 0.1296209587705252 -0.003375223467947483 0.872232017301816 -2494 0.1889881507659373 -0.8663738013578975 0.1039594558966887 -2495 0.2111068529131338 -0.854830058110275 0.2276312599948431 -2496 -0.4874281790048631 0.5392023813852088 0.6440456301570453 -2497 -0.04555507823656343 0.8885726552611327 0.7129149470975077 -2498 0.7419952613625633 0.4925290912602127 0.1165335476906518 -2499 0.6783636692149424 -0.3375476393846231 0.8838839216746504 -2500 -0.7089992172148539 0.1221354935867291 0.7900450228341437 -2501 0.5377967611247878 0.7100137323814657 0.2496423803562592 -2502 0.3029480416455027 0.6788133186042661 0.245721224466241 -2503 -0.8782523081640018 -0.1112641676947825 0.2367804314054446 -2504 0.06393872488865035 0.09499034438053879 0.4604847267735397 -2505 -0.6172927195811451 -0.1645512636263438 0.5140214823709259 -2506 0.03973754380982453 0.5104738033013606 0.4928730782999851 -2507 -0.5613050686058438 0.1289968699402654 0.8922713433383548 -2508 0.2147299506440449 0.8569453331627017 0.2394964206150056 -2509 -0.5697293392797402 -0.3906132163732456 0.5817916286969457 -2510 0.3996759559028488 -0.2742151440180576 0.6132878982951655 -2511 0.1834329879367775 -0.6098979520660582 0.7395999174902119 -2512 0.2543166337323283 0.2094003572360646 0.8807876800425103 -2513 0.5200739115614024 0.5828771878317536 0.8794385204502011 -2514 0.4132016332162179 -0.7818911324564904 0.2128760980827269 -2515 0.1904768425396144 0.3722099199832721 0.7747487630979676 -2516 -0.5616276625945364 -0.3084654180516521 0.09928056456642367 -2517 0.2892190805005238 -0.2147118853972362 0.2658532505645884 -2518 -0.4254230269705039 -0.7769822271743112 0.6079404865495407 -2519 -0.03004934973551317 -0.2599616644644586 0.291073801737881 -2520 -0.003007918405555896 0.1447896474729849 0.73853857261023 -2521 -0.006348030483308995 0.2559658825345344 0.7707664329257755 -2522 -0.8669537149986938 -0.1474931120090087 0.7119801948636928 -2523 0.882034528640579 -0.06491639713515401 0.3191452186667358 -2524 -0.3355728541825816 0.2917556603669511 0.4155789458479573 -2525 0.3089270972551666 0.5133032877852798 0.1031662127190415 -2526 -0.1350834257185179 0.6228709002712287 0.6544763974803552 -2527 -0.1772612045493558 0.1657625738449891 0.5008014423832123 -2528 0.07018456905330597 0.09865689055634161 0.2467448365072835 -2529 0.8291350990739219 0.2699307733243039 0.7216009346769817 -2530 -0.3023983196602176 0.8272831562813943 0.2390634322611931 -2531 0.4187906168829776 -0.3948201840526644 0.8896378107866053 -2532 0.575908122455379 0.477424397939877 0.3982378798416173 -2533 -0.2469262469680668 0.6958523014740117 0.1117522019013327 -2534 0.5642808990330335 -0.25200584459265 0.7630866585772939 -2535 -0.5089170328815675 -0.5499041421731367 0.2601674754265469 -2536 -0.2455171633272462 0.8555782262973937 0.390064471335517 -2537 0.007699149380494194 -0.7513592907748177 0.531177985980344 -2538 -0.161329406405158 0.5094496066661864 0.5430628400466672 -2539 0.5087895337153292 0.3464891642073728 0.1086108905307392 -2540 -0.1954024557718877 -0.3634261145269481 0.6339685439325832 -2541 -0.3611021609781164 -0.6431656597728355 0.3345507978864249 -2542 0.5122047492329667 -0.7299480156565565 0.2732436355406324 -2543 -0.2521706656494656 -0.8597987800718969 0.3898145054302403 -2544 -0.7225997069689258 -0.3095035944462682 0.6339320584819538 -2545 0.6332229040224423 -0.237892732098394 0.2479466577674689 -2546 -0.291383578972558 0.540126427916544 0.4798079974297886 -2547 0.4290463710221349 0.4059858949731578 0.3891521132986357 -2548 -0.3208855129477575 -0.5526964820642521 0.5181736873818297 -2549 -0.391085789262177 -0.2718917761379797 0.5390981035287921 -2550 -0.1833653901057402 -0.09872011734577109 0.770101097473574 -2551 -0.4770091512402195 -0.2726330381694806 0.8893528125992531 -2552 -0.3079214537526105 -0.5570934965130572 0.7507926767166527 -2553 0.7230367440601743 -0.4998453196098889 0.7114952541348297 -2554 -0.6053798938047379 -0.1157112879095977 0.1066975445060101 -2555 0.2542938055554272 0.8468148389558936 0.4279732961647983 -2556 -0.2548121797456158 -0.7073133557502298 0.09895427142396829 -2557 0.6697578449041509 0.3558955344423672 0.885212147971733 -2558 0.4616283895483467 -0.434240230050553 0.7535844981314372 -2559 -0.4400233109991064 -0.6233999919192589 0.1073738715572165 -2560 -0.784332062151444 0.436950699525711 0.09982623544229853 -2561 0.0647973811570315 -0.8788987653955854 0.2664274434623258 -2562 0.6017505638686036 -0.6549587986273882 0.5105698499190133 -2563 -0.4366787849908607 -0.5919164037330112 0.889801595651352 -2564 -0.723919441842907 -0.5158006246033562 0.2236742820393364 -2565 -0.6550280610590411 -0.6008017075410099 0.2708231333618534 -2566 0.3096039720847623 -0.1228849012541036 0.5248362932809629 -2567 0.6995431797971856 0.2288366283252796 0.1172022242139224 -2568 0.09769037102288426 -0.2711335493697446 0.2134372795952932 -2569 -0.6182224198868103 0.6422310294407805 0.2307673007388992 -2570 -0.738487631969637 -0.443685725051534 0.4482350855488578 -2571 0.3488660028615877 -0.2943147714982924 0.1058689747729894 -2572 -0.209652096316633 0.3068137972731548 0.6170920471604068 -2573 -0.4417534343667359 0.1833500437556298 0.7563373420671073 -2574 -0.06747346652334006 0.2660486999160939 0.09889790146966962 -2575 -0.3299314252854185 -0.2019454894343535 0.325495477534203 -2576 0.4674453312277652 -0.7564195924191854 0.1106258173068412 -2577 0.223937448304072 0.6452046366045268 0.5314185364857735 -2578 -0.425886090328969 -0.4742718632513516 0.4152795385652336 -2579 -0.4038496012189864 0.4120969109533091 0.8969718158781158 -2580 -0.413655947921548 0.4936258253045973 0.2601975109423696 -2581 -0.4236284995174571 -0.7828023367774503 0.89571028094813 -2582 -0.5191217201886807 -0.7114016520536517 0.8911110651591082 -2583 0.09309850932900822 -0.02838090575816707 0.4966628544298603 -2584 -0.489532532086967 -0.7402321567384103 0.3858708884396322 -2585 0.5921704073774945 0.6678169576811358 0.3425165980632546 -2586 -0.6625650708845405 -0.2846736415869186 0.8959011435727003 -2587 -0.78187821684589 0.4183994959531993 0.5847721000407595 -2588 0.7254306884172818 -0.5041120611329445 0.4061240328569324 -2589 0.8759352613708804 -0.2081717563642994 0.6063775766696515 -2590 0.2438858533707597 -0.05491348082296049 0.2641331914404029 -2591 0.4082566343940906 -0.7724323545733796 0.7347137125648763 -2592 0.6947873039857629 -0.1673738814728995 0.7536218567553555 -2593 -0.1369517376751909 -0.03419698923155866 0.2866842092156138 -2594 -0.5726160298004894 -0.6771512162658998 0.5812416454472507 -2595 -0.7232524833476753 0.05819507227948622 0.3769932933364464 -2596 0.6837981720102936 0.5631209997017397 0.7760329674290461 -2597 0.2511199428469903 0.4013662326634814 0.2504749721750842 -2598 0.3129504488876063 0.5401172640482085 0.6312352774831755 -2599 -0.2005847223363157 0.1457617639280374 0.6936435067783194 -2600 -0.5911552807949726 -0.2099476766374637 0.6380790119445637 -2601 -0.3019635103594555 -0.5290831430141028 0.1020749423188019 -2602 -0.05298472088125201 0.1961310337499131 0.5538402208911405 -2603 -0.5271318183677934 -0.7135540010610876 0.7205482459938517 -2604 -0.5808254041688178 -0.071511511205712 0.3069551962144179 -2605 0.1323764867779196 -0.06468461257421573 0.1052034996118172 -2606 -0.757206125152561 0.03682763656852686 0.1156974484905201 -2607 0.2873200646806097 -0.3433855020725156 0.2454528145635986 -2608 0.474741316406178 0.5919103463341304 0.7535190658790611 -2609 -0.271379887284065 -0.299570463571827 0.8077324773091624 -2610 -0.506087755124234 0.7358344380149723 0.1003460606739997 -2611 0.4863819147505054 0.3078530284784853 0.315606699558305 -2612 0.6107135693530491 -0.4203186846637483 0.1139705660606372 -2613 -0.2425269448086131 -0.6677224510151704 0.2130186183669994 -2614 0.2159424917716579 0.02627157356574542 0.1037228713592421 -2615 0.6147817731196773 0.2215321177440378 0.8845073138141573 -2616 0.5808079342827133 -0.1043244441341208 0.6179179662761088 -2617 -0.5572847926091142 -0.2945673664584039 0.7607807138222233 -2618 -0.5748797505143709 0.4644199408491273 0.281198930411634 -2619 -0.1663359434270382 -0.7153980256170649 0.6996961901295675 -2620 -0.05032210954775818 -0.6059380359757964 0.890124077422078 -2621 -0.2617381683874551 -0.4784335424759031 0.2308586955635772 -2622 -0.579304985576731 -0.3610776396674364 0.2312552398430962 -2623 0.1207871033333984 -0.2190756436367004 0.4160501792447626 -2624 -0.2229280332680169 -0.3041435229215698 0.0983976379149529 -2625 -0.001574460490601066 -0.7095721141418593 0.7544551897391668 -2626 -0.8224696847700474 -0.2615755758774378 0.102799342317159 -2627 -0.1461988127123881 -0.5105403407414539 0.7003007356898977 -2628 0.8714709067845736 0.1296394036919866 0.2460890147559627 -2629 -0.4057995180886253 -0.2313946245966914 0.766895372710205 -2630 -0.457302197296062 0.4317671362800658 0.441601933763106 -2631 0.5643643359090262 0.6918763977921992 0.8974947645493992 -2632 -0.2451512552986652 0.3053120686702104 0.2050032346494221 -2633 0.3660521968366084 -0.02823071951550601 0.3882787246849254 -2634 0.6750170986765336 0.3643344779636927 0.5938155517347027 -2635 0.2711526209055622 0.7280258920243978 0.08814329418311569 -2636 0.3924511465244184 -0.6330202320298146 0.6070850754203231 -2637 0.8658638203928881 -0.1907233714432234 0.2923105397222592 -2638 0.05144298102831747 0.8927894464762809 0.5326909531147999 -2639 0.4391136243117207 0.2583441263236453 0.1073629919119828 -2640 -0.2438770236705515 -0.7032529486956579 0.8945559861363259 -2641 0.4551173852065793 -0.1131695838091858 0.09802637369869205 -2642 -0.4012764373475455 -0.8053799114947462 0.2151298056541475 -2643 0.1994017548560858 0.6915605177827135 0.4133916199934797 -2644 0.7758991588111851 -0.1519862233734701 0.6723406932814285 -2645 0.08077499733770205 0.7536793173743566 0.1004301182673219 -2646 -0.5578658674846135 -0.323075314521216 0.4995548904293887 -2647 0.3245706545382808 0.2558558552111191 0.1111951824655994 -2648 -0.3563088054250421 -0.4708383535787716 0.6374716434980116 -2649 0.2626529141856742 0.829128731585233 0.5873562905557884 -2650 0.5064107328691939 -0.4034896041579354 0.4466218772638458 -2651 -0.3392363803663895 0.132622273246289 0.5545329982415291 -2652 -0.3443519187116847 0.4133589764974957 0.5144472002515382 -2653 0.03411173219002796 0.4372472863440373 0.2399875029932002 -2654 -0.3551031885147138 0.326660627595146 0.7579573658798437 -2655 -0.2525416921561439 0.5364002674060291 0.8930210177317617 -2656 -0.1153289648754076 -0.4662823224759736 0.5042964764777043 -2657 -0.2030220031293484 0.004006105402380739 0.09799513574600545 -2658 -0.2817545139917917 0.8258803121231675 0.1153835019539469 -2659 0.4199526023828158 0.587774625532263 0.6079903992515914 -2660 -0.5085512690698959 -0.3922992259452955 0.411742724460651 -2661 -0.438715185638609 0.6476251646994405 0.09590491489781729 -2662 -0.3472028516994275 0.04707419253986515 0.1356069711559634 -2663 -0.4868821086410061 0.7398528541035844 0.653375322540017 -2664 0.1551780629119699 0.003282214815383953 0.7564590334623713 -2665 0.5397428380028427 0.1990379331263948 0.6066096644246246 -2666 0.242059746163027 0.8670567714858912 0.8990904401732163 -2667 0.4180773219326407 -0.1009221180577344 0.8803530259368274 -2668 0.269307734480321 -0.4698179025328256 0.8918292565408499 -2669 0.3567360255603695 0.06747808526500322 0.1154546903914205 -2670 0.8895149414726439 -0.03348086984380472 0.7790329002360117 -2671 0.3800160740105075 0.2805668516261653 0.2188603827359538 -2672 -0.6260267442400194 0.6417660086209518 0.3974913010447338 -2673 0.1346654760437819 -0.5186963791215512 0.4188234037515086 -2674 0.395859169801976 0.4509204103043477 0.0977916245570512 -2675 -0.3163974503892316 -0.09949426787326979 0.4805183639245167 -2676 -0.06732984938078414 0.2831514876435958 0.2138882566929688 -2677 0.6360397375937603 0.6373459922125055 0.6509452359839447 -2678 -0.466149285480804 0.1552954175238831 0.4887689731407261 -2679 0.3879403129091484 -0.5896116506446959 0.1100505122012602 -2680 0.03289853351017819 -0.4807571255053748 0.25084935499793 -2681 -0.1916399299516419 -0.5696138126881899 0.3934493912855079 -2682 -0.04128784540925555 0.5398064087219996 0.3360576784621332 -2683 0.08719601315237585 -0.6145804871114879 0.08822924147259928 -2684 0.7689185286278424 0.4691737955067349 0.6476871753157515 -2685 0.7184002436389274 0.05717960909467794 0.1178838443889103 -2686 -0.7489255161757468 0.1344264078083676 0.8912988513299557 -2687 -0.05643140163716723 0.9024690955105321 0.3680123634384479 -2688 -0.09663112594287801 0.3824834931056824 0.4696348349023493 -2689 0.5712121540804317 -0.4225163363316933 0.2244009667076065 -2690 0.8004977275089136 0.3822323221999981 0.7459473192437053 -2691 0.2329644090112173 -0.1824890661227578 0.1103298539624747 -2692 0.888002814352288 0.1729781467725739 0.1024249776829458 -2693 0.01314630745688111 0.6163428805938391 0.5232583481660241 -2694 -0.762601581707566 0.2024499426666165 0.112313983702205 -2695 0.4970430305518053 -0.7303881313211116 0.4582060260446065 -2696 -0.213262676897057 -0.8606157053233429 0.8823108250411829 -2697 -0.5778553217386651 0.5259529228660395 0.5792140176582888 -2698 -0.3108702874898938 0.2299402215248105 0.2782818643210345 -2699 0.2511903099790659 0.1609426822520741 0.2407011040120151 -2700 0.1132135061898425 -0.6550521542504291 0.5112605031211084 -2701 0.2255921947553513 0.2291522900216613 0.4093911116842354 -2702 0.6056686042137897 0.471173960068243 0.2921120249538366 -2703 0.0862659078465732 -0.1664070970206582 0.7655371029288686 -2704 0.06570370704115491 -0.06291126836442482 0.7923775081994078 -2705 0.03375465535935168 0.7661527217139852 0.2851679462638912 -2706 -0.3647813601355001 0.6504243836999961 0.36917273853153 -2707 -0.1637698466053739 0.03426317338119761 0.6663861291782547 -2708 0.3598550981535448 -0.4428967583137738 0.6944673783133026 -2709 -0.1269530283720805 -0.8802456643423494 0.3776185637867593 -2710 -0.5002272491683735 -0.5711667199828008 0.6044836791728113 -2711 0.336569448763303 0.398552995582438 0.9025578171220868 -2712 0.01289814877936179 0.3915589569846867 0.7645746598674891 -2713 -0.5098349356779105 -0.7584050777674369 0.08552999955340179 -2714 0.3259504558393205 0.8227408239774477 0.09603226802366287 -2715 0.275134078709776 -0.8524759641953824 0.8419872570267221 -2716 -0.7366977846397879 -0.2239381943976016 0.7535950322636369 -2717 0.3235799890772134 0.7053313424741134 0.4939284545061087 -2718 0.677019497906002 0.3099457186663286 0.7651287048637493 -2719 -0.2354725581861989 -0.7364173626275784 0.5268074671444285 -2720 0.5703512899331553 -0.4193709886639656 0.8949305415798446 -2721 -0.436539255382153 -0.07404403984061328 0.906145319983828 -2722 0.8552620982782887 0.2490459649454856 0.8914741565304435 -2723 -0.596718890325823 0.3109209291248416 0.5438338332484054 -2724 -0.6758573541989417 0.2952463346133908 0.8677629936243426 -2725 -0.6591399771315507 0.6117624329118451 0.7456220881491686 -2726 -0.3520101372331587 -0.4043780007276736 0.3472653224057731 -2727 -0.1189322850543659 0.5940489533096465 0.2026239083315117 -2728 -0.7526732740877145 0.1898561732694159 0.4664618275919712 -2729 0.3760381683884613 0.3914174449231309 0.6578051267997592 -2730 -0.4493054666813369 -0.4099509643614628 0.8588540480616206 -2731 0.6505720138676674 -0.05183643608039683 0.4109950789798921 -2732 0.09829840606935503 0.8970681726540619 0.2344745287434672 -2733 -0.8753923265625 -0.1814579785904429 0.5904155960730999 -2734 0.1208730699810087 -0.8836180328689923 0.5554902197691722 -2735 -0.5374108848419712 -0.1480819408260176 0.2403141269571556 -2736 0.359291187840201 0.7076900465885975 0.7383565120547232 -2737 -0.1302981480587542 0.2125452523678631 0.9074437454001074 -2738 0.2713358983889495 -0.6989448569041355 0.519386211742023 -2739 -0.2707010010566251 -0.06200191656382333 0.704630479587389 -2740 0.09329715773588455 -0.5274349329785376 0.8972346003123833 -2741 -0.06944770046791612 -0.1304193245816994 0.1011386673316015 -2742 0.780501096271072 -0.05281428486677338 0.7320223430605619 -2743 -0.4551687980208692 0.3510887234049764 0.6722130286870545 -2744 0.2910374803442637 0.4055584536279282 0.1065273032633818 -2745 -0.7499614750618664 0.1674292411108543 0.3068815939144517 -2746 -0.1974418940369631 0.3650316758385445 0.7682491045898806 -2747 -0.09465689103362129 -0.2491232162283457 0.7948321804359284 -2748 -0.1101377726291212 -0.4476594943302786 0.2310283604324495 -2749 -0.3360393278131123 0.6512033048820108 0.737907452843138 -2750 0.09666731980259777 0.3720650458885345 0.3573932704762078 -2751 -0.1170273722894151 -0.0805534606246163 0.904614389616281 -2752 -0.6314493885952007 0.01018710391329276 0.1074581898139493 -2753 -0.2142999492316697 0.7131797028817271 0.4666845924544723 -2754 0.6029612443129184 0.1313871964402023 0.7421339185885835 -2755 -0.2247298623239496 -0.5002476574042893 0.7970985048794021 -2756 -0.4838929512217104 0.2910548453100723 0.237694267009467 -2757 -0.4207634318914664 -0.4913933909188922 0.2544175580962655 -2758 0.5575754497189873 -0.1195256871302004 0.3995385414359571 -2759 -0.4715302076764349 0.5974586219738349 0.5098347544785781 -2760 -0.08078210666619394 -0.4623580677785397 0.7816107399142964 -2761 -0.8347376009227776 0.3150460213396254 0.2783572953620059 -2762 0.3986787133964944 0.4684204518826837 0.2825658792773656 -2763 -0.1696839949676694 -0.3713874975817907 0.9122568581291347 -2764 -0.09168267741480797 -0.7724654322067276 0.3475844069825731 -2765 0.2528630910153704 -0.07740471613460324 0.73073294465983 -2766 -0.7692559356576966 0.4529976383412773 0.4796364366343713 -2767 -0.2573152750350499 -0.2330107018864605 0.9131069860070462 -2768 -0.2952135095221115 -0.7227715826003267 0.2879822158139811 -2769 -0.6688247369294467 -0.6007728954488241 0.5970382311145018 -2770 -0.243927859125309 -0.04190881250008165 0.9150244750767835 -2771 0.5503556164472635 -0.5193853460492698 0.3807400289116654 -2772 0.3782750943110922 0.6684918349039901 0.3298828083520987 -2773 0.1874712826062991 0.7514219307277605 0.2399392703626354 -2774 -0.1721266855090343 -0.3198183380564648 0.4288652450831087 -2775 0.7834841570873495 -0.4003053130235198 0.8877450047013137 -2776 0.1914712552681572 0.6007416584143546 0.09637049910266662 -2777 -0.9060680703379456 -0.0173606373763654 0.6433894158103659 -2778 0.6298823514726354 -0.4375438832545945 0.5717941592435022 -2779 -0.1743568638998892 -0.1683409248902435 0.2056710090447126 -2780 0.4022955382948182 0.6253393369554284 0.8947480752918366 -2781 0.086142609978511 -0.5317440909199276 0.7568605048802571 -2782 -0.4567624705470465 0.4616986879502336 0.7119559164933371 -2783 0.4208729547618593 0.1818714967783909 0.7073824202919149 -2784 0.7609336359710546 0.1105250771162853 0.6437686888452088 -2785 -0.6287274254799198 -0.4841134696106401 0.9000175633806914 -2786 -0.4027378585896876 0.7995193313456087 0.4418776448655482 -2787 0.3477642344230998 0.4759346382000128 0.7164476781617185 -2788 0.3685573553516663 -0.2553667984818948 0.8850492109734684 -2789 -0.7421854204898259 -0.2232844341155629 0.2526812285961456 -2790 -0.6912082578375865 0.09035325940902665 0.5945808587675997 -2791 -0.5224257059248865 -0.02548984442540156 0.1058518913299535 -2792 -0.4876412221508531 -0.3401339571603062 0.2731502106225239 -2793 0.6932359580617647 -0.0333970626563528 0.2399442662545579 -2794 0.2846065651182142 -0.2682246219006252 0.6599355443818093 -2795 -0.005352757179196281 -0.4269410375701688 0.09906141895868803 -2796 0.003944034522816595 0.04017580376388349 0.5252831424572694 -2797 -0.4245296739304524 -0.2767210976433927 0.2231246068635061 -2798 -0.2471291110575329 0.2266370248597099 0.5590245740608913 -2799 -0.09414102262281829 -0.1804362106790681 0.3191737138165838 -2800 -0.007854117766265253 -0.5899876788200353 0.6193881340623264 -2801 0.3855049081453676 0.3883864566345009 0.767671343989018 -2802 -0.162342282456459 0.7366293102724563 0.3587075751221185 -2803 0.6928838453856316 -0.5654317936046607 0.1123397827950603 -2804 -0.8574363820090095 -0.2471646317609797 0.769966168978098 -2805 -0.2967424661467359 -0.3787585662497117 0.2102605278071486 -2806 -0.1407532101590606 -0.1249848057491311 0.5034249552323244 -2807 -0.07897942929178468 0.1235359517237296 0.2545207795112631 -2808 -0.2121393431959094 0.3047849527517457 0.406749706212715 -2809 -0.1144759336638732 0.2861263819132565 0.3942107134631006 -2810 -0.2628370492713896 -0.6964350513533664 0.6548344152468893 -2811 -0.0944948333818672 0.5875202933299704 0.7790616367985608 -2812 -0.5923623791511552 0.6818713112844196 0.8968133187913846 -2813 -0.2325235394750925 0.03236338240474376 0.5619798860008405 -2814 -0.1810503883827107 -0.776742010499108 0.4090591539135189 -2815 0.09111999169808251 0.6381896527074973 0.09120953806387988 -2816 0.6625652672911277 0.3546193240360329 0.3329251491633921 -2817 -0.62225264315803 -0.4985905383955416 0.4600418634518151 -2818 -0.8041433008326441 -0.1079708716439496 0.09094470897325618 -2819 -0.1645851301619969 0.5952318516651226 0.10507248608382 -2820 -0.3472795195568447 0.07316236216439009 0.6326048913930064 -2821 0.5536913972332854 -0.2210481014728385 0.1080303460741374 -2822 0.7428438172533491 0.05101893237773437 0.8986758332440437 -2823 -0.583243494484373 0.2134127966735014 0.3768798327528745 -2824 -0.3104491155103756 -0.05068781028035571 0.09310031690363779 -2825 0.02201325749799555 -0.220831389452721 0.903778214386423 -2826 0.5618896323403307 -0.1137154385070451 0.1123696933009117 -2827 -0.5024065362775453 0.3795930695280547 0.2885501261841266 -2828 -0.3860553914860895 -0.6282445028390896 0.5471746798272327 -2829 0.3309325598072628 0.1624290583274472 0.435835521292628 -2830 -0.9009853543488063 0.05962833902407472 0.1044975561001578 -2831 -0.3838900033737878 0.1711799297946658 0.6489523436632283 -2832 0.2416004794829591 -0.5694041074716236 0.254629630415913 -2833 -0.09461699034348303 -0.6529214456387157 0.7746450051945836 -2834 0.5419616828572633 -0.139555986614364 0.7348672354010028 -2835 0.5459504158901097 0.08336987814944558 0.8955499643340876 -2836 0.4585493874620855 -0.2114935187608128 0.4054490234364467 -2837 0.1063101111640002 0.6064938689654608 0.3727289359191031 -2838 0.1531048749679534 -0.04973378848432432 0.3477780718957869 -2839 0.08950791688861059 -0.5396929673732229 0.5517151698033739 -$EndNodes -$Elements -16042 -1 15 2 0 1 1 -2 15 2 0 2 2 -3 15 2 0 3 3 -4 15 2 0 4 4 -5 15 2 0 5 5 -6 15 2 0 6 6 -7 15 2 0 7 7 -8 15 2 0 8 8 -9 15 2 0 13 9 -10 15 2 0 18 10 -11 1 2 0 1 3 11 -12 1 2 0 1 11 12 -13 1 2 0 1 12 13 -14 1 2 0 1 13 14 -15 1 2 0 1 14 15 -16 1 2 0 1 15 16 -17 1 2 0 1 16 17 -18 1 2 0 1 17 18 -19 1 2 0 1 18 19 -20 1 2 0 1 19 20 -21 1 2 0 1 20 21 -22 1 2 0 1 21 22 -23 1 2 0 1 22 23 -24 1 2 0 1 23 24 -25 1 2 0 1 24 25 -26 1 2 0 1 25 2 -27 1 2 0 2 2 26 -28 1 2 0 2 26 27 -29 1 2 0 2 27 28 -30 1 2 0 2 28 29 -31 1 2 0 2 29 30 -32 1 2 0 2 30 31 -33 1 2 0 2 31 32 -34 1 2 0 2 32 33 -35 1 2 0 2 33 34 -36 1 2 0 2 34 35 -37 1 2 0 2 35 36 -38 1 2 0 2 36 37 -39 1 2 0 2 37 38 -40 1 2 0 2 38 39 -41 1 2 0 2 39 40 -42 1 2 0 2 40 4 -43 1 2 0 3 4 41 -44 1 2 0 3 41 42 -45 1 2 0 3 42 43 -46 1 2 0 3 43 44 -47 1 2 0 3 44 45 -48 1 2 0 3 45 46 -49 1 2 0 3 46 47 -50 1 2 0 3 47 48 -51 1 2 0 3 48 49 -52 1 2 0 3 49 50 -53 1 2 0 3 50 51 -54 1 2 0 3 51 52 -55 1 2 0 3 52 53 -56 1 2 0 3 53 54 -57 1 2 0 3 54 55 -58 1 2 0 3 55 5 -59 1 2 0 4 5 56 -60 1 2 0 4 56 57 -61 1 2 0 4 57 58 -62 1 2 0 4 58 59 -63 1 2 0 4 59 60 -64 1 2 0 4 60 61 -65 1 2 0 4 61 62 -66 1 2 0 4 62 63 -67 1 2 0 4 63 64 -68 1 2 0 4 64 65 -69 1 2 0 4 65 66 -70 1 2 0 4 66 67 -71 1 2 0 4 67 68 -72 1 2 0 4 68 69 -73 1 2 0 4 69 70 -74 1 2 0 4 70 3 -75 1 2 0 8 6 71 -76 1 2 0 8 71 72 -77 1 2 0 8 72 73 -78 1 2 0 8 73 74 -79 1 2 0 8 74 75 -80 1 2 0 8 75 76 -81 1 2 0 8 76 77 -82 1 2 0 8 77 78 -83 1 2 0 8 78 79 -84 1 2 0 8 79 80 -85 1 2 0 8 80 81 -86 1 2 0 8 81 82 -87 1 2 0 8 82 83 -88 1 2 0 8 83 84 -89 1 2 0 8 84 85 -90 1 2 0 8 85 8 -91 1 2 0 9 8 86 -92 1 2 0 9 86 87 -93 1 2 0 9 87 88 -94 1 2 0 9 88 89 -95 1 2 0 9 89 90 -96 1 2 0 9 90 91 -97 1 2 0 9 91 92 -98 1 2 0 9 92 93 -99 1 2 0 9 93 94 -100 1 2 0 9 94 95 -101 1 2 0 9 95 96 -102 1 2 0 9 96 97 -103 1 2 0 9 97 98 -104 1 2 0 9 98 99 -105 1 2 0 9 99 100 -106 1 2 0 9 100 9 -107 1 2 0 10 9 101 -108 1 2 0 10 101 102 -109 1 2 0 10 102 103 -110 1 2 0 10 103 104 -111 1 2 0 10 104 105 -112 1 2 0 10 105 106 -113 1 2 0 10 106 107 -114 1 2 0 10 107 108 -115 1 2 0 10 108 109 -116 1 2 0 10 109 110 -117 1 2 0 10 110 111 -118 1 2 0 10 111 112 -119 1 2 0 10 112 113 -120 1 2 0 10 113 114 -121 1 2 0 10 114 115 -122 1 2 0 10 115 10 -123 1 2 0 11 10 116 -124 1 2 0 11 116 117 -125 1 2 0 11 117 118 -126 1 2 0 11 118 119 -127 1 2 0 11 119 120 -128 1 2 0 11 120 121 -129 1 2 0 11 121 122 -130 1 2 0 11 122 123 -131 1 2 0 11 123 124 -132 1 2 0 11 124 125 -133 1 2 0 11 125 126 -134 1 2 0 11 126 127 -135 1 2 0 11 127 128 -136 1 2 0 11 128 129 -137 1 2 0 11 129 130 -138 1 2 0 11 130 6 -139 1 2 0 13 5 131 -140 1 2 0 13 131 132 -141 1 2 0 13 132 133 -142 1 2 0 13 133 134 -143 1 2 0 13 134 135 -144 1 2 0 13 135 136 -145 1 2 0 13 136 137 -146 1 2 0 13 137 138 -147 1 2 0 13 138 139 -148 1 2 0 13 139 6 -149 1 2 0 14 3 140 -150 1 2 0 14 140 141 -151 1 2 0 14 141 142 -152 1 2 0 14 142 143 -153 1 2 0 14 143 144 -154 1 2 0 14 144 145 -155 1 2 0 14 145 146 -156 1 2 0 14 146 147 -157 1 2 0 14 147 148 -158 1 2 0 14 148 8 -159 1 2 0 18 2 149 -160 1 2 0 18 149 150 -161 1 2 0 18 150 151 -162 1 2 0 18 151 152 -163 1 2 0 18 152 153 -164 1 2 0 18 153 154 -165 1 2 0 18 154 155 -166 1 2 0 18 155 156 -167 1 2 0 18 156 157 -168 1 2 0 18 157 9 -169 1 2 0 22 4 158 -170 1 2 0 22 158 159 -171 1 2 0 22 159 160 -172 1 2 0 22 160 161 -173 1 2 0 22 161 162 -174 1 2 0 22 162 163 -175 1 2 0 22 163 164 -176 1 2 0 22 164 165 -177 1 2 0 22 165 166 -178 1 2 0 22 166 10 -179 2 2 0 6 527 25 2 -180 2 2 0 6 26 495 2 -181 2 2 0 6 495 527 2 -182 2 2 0 6 3 11 487 -183 2 2 0 6 198 70 3 -184 2 2 0 6 487 198 3 -185 2 2 0 6 502 40 4 -186 2 2 0 6 41 482 4 -187 2 2 0 6 482 502 4 -188 2 2 0 6 5 268 55 -189 2 2 0 6 174 5 56 -190 2 2 0 6 268 5 174 -191 2 2 0 6 12 269 11 -192 2 2 0 6 487 11 269 -193 2 2 0 6 501 12 13 -194 2 2 0 6 12 501 269 -195 2 2 0 6 14 263 13 -196 2 2 0 6 501 13 263 -197 2 2 0 6 459 14 15 -198 2 2 0 6 263 14 459 -199 2 2 0 6 465 15 16 -200 2 2 0 6 459 15 465 -201 2 2 0 6 16 17 231 -202 2 2 0 6 231 465 16 -203 2 2 0 6 18 468 17 -204 2 2 0 6 468 231 17 -205 2 2 0 6 19 191 18 -206 2 2 0 6 468 18 191 -207 2 2 0 6 20 281 19 -208 2 2 0 6 281 191 19 -209 2 2 0 6 21 195 20 -210 2 2 0 6 195 281 20 -211 2 2 0 6 22 277 21 -212 2 2 0 6 21 277 195 -213 2 2 0 6 23 464 22 -214 2 2 0 6 464 277 22 -215 2 2 0 6 23 24 257 -216 2 2 0 6 257 464 23 -217 2 2 0 6 25 196 24 -218 2 2 0 6 24 196 257 -219 2 2 0 6 25 527 196 -220 2 2 0 6 26 27 503 -221 2 2 0 6 495 26 503 -222 2 2 0 6 28 526 27 -223 2 2 0 6 526 522 27 -224 2 2 0 6 27 522 503 -225 2 2 0 6 29 282 28 -226 2 2 0 6 28 282 526 -227 2 2 0 6 276 29 30 -228 2 2 0 6 276 282 29 -229 2 2 0 6 31 287 30 -230 2 2 0 6 30 287 276 -231 2 2 0 6 32 479 31 -232 2 2 0 6 479 287 31 -233 2 2 0 6 273 32 33 -234 2 2 0 6 479 32 273 -235 2 2 0 6 34 285 33 -236 2 2 0 6 33 285 273 -237 2 2 0 6 35 197 34 -238 2 2 0 6 197 278 34 -239 2 2 0 6 285 34 278 -240 2 2 0 6 36 197 35 -241 2 2 0 6 271 36 37 -242 2 2 0 6 271 197 36 -243 2 2 0 6 38 434 37 -244 2 2 0 6 37 173 271 -245 2 2 0 6 173 37 434 -246 2 2 0 6 434 38 39 -247 2 2 0 6 40 244 39 -248 2 2 0 6 434 39 244 -249 2 2 0 6 502 244 40 -250 2 2 0 6 41 42 488 -251 2 2 0 6 488 482 41 -252 2 2 0 6 476 42 43 -253 2 2 0 6 488 42 476 -254 2 2 0 6 44 435 43 -255 2 2 0 6 435 476 43 -256 2 2 0 6 432 44 45 -257 2 2 0 6 435 44 432 -258 2 2 0 6 46 283 45 -259 2 2 0 6 432 45 283 -260 2 2 0 6 47 388 46 -261 2 2 0 6 388 283 46 -262 2 2 0 6 48 272 47 -263 2 2 0 6 47 272 388 -264 2 2 0 6 49 446 48 -265 2 2 0 6 446 272 48 -266 2 2 0 6 50 192 49 -267 2 2 0 6 446 49 192 -268 2 2 0 6 286 50 51 -269 2 2 0 6 50 286 192 -270 2 2 0 6 51 52 517 -271 2 2 0 6 286 51 517 -272 2 2 0 6 266 52 53 -273 2 2 0 6 517 52 266 -274 2 2 0 6 54 260 53 -275 2 2 0 6 53 260 266 -276 2 2 0 6 438 54 55 -277 2 2 0 6 54 438 260 -278 2 2 0 6 438 55 268 -279 2 2 0 6 275 56 57 -280 2 2 0 6 174 56 275 -281 2 2 0 6 58 279 57 -282 2 2 0 6 279 275 57 -283 2 2 0 6 189 58 59 -284 2 2 0 6 58 189 279 -285 2 2 0 6 185 59 60 -286 2 2 0 6 185 189 59 -287 2 2 0 6 525 60 61 -288 2 2 0 6 185 60 525 -289 2 2 0 6 514 61 62 -290 2 2 0 6 525 61 514 -291 2 2 0 6 63 510 62 -292 2 2 0 6 62 510 514 -293 2 2 0 6 64 515 63 -294 2 2 0 6 515 510 63 -295 2 2 0 6 451 64 65 -296 2 2 0 6 64 451 515 -297 2 2 0 6 66 493 65 -298 2 2 0 6 493 451 65 -299 2 2 0 6 67 426 66 -300 2 2 0 6 493 66 426 -301 2 2 0 6 67 68 470 -302 2 2 0 6 426 67 470 -303 2 2 0 6 69 480 68 -304 2 2 0 6 480 470 68 -305 2 2 0 6 69 70 441 -306 2 2 0 6 69 441 480 -307 2 2 0 6 70 198 441 -308 2 2 0 6 231 377 465 -309 2 2 0 6 465 377 413 -310 2 2 0 6 231 468 377 -311 2 2 0 6 413 377 234 -312 2 2 0 6 425 234 377 -313 2 2 0 6 425 377 468 -314 2 2 0 6 346 404 233 -315 2 2 0 6 346 233 326 -316 2 2 0 6 233 404 435 -317 2 2 0 6 233 432 326 -318 2 2 0 6 432 233 435 -319 2 2 0 6 413 187 465 -320 2 2 0 6 459 465 187 -321 2 2 0 6 299 328 361 -322 2 2 0 6 361 328 206 -323 2 2 0 6 361 340 205 -324 2 2 0 6 303 340 361 -325 2 2 0 6 361 205 299 -326 2 2 0 6 361 206 303 -327 2 2 0 6 193 522 526 -328 2 2 0 6 193 526 521 -329 2 2 0 6 526 282 521 -330 2 2 0 6 185 481 189 -331 2 2 0 6 279 189 486 -332 2 2 0 6 486 189 481 -333 2 2 0 6 239 376 245 -334 2 2 0 6 376 239 350 -335 2 2 0 6 239 463 230 -336 2 2 0 6 230 509 239 -337 2 2 0 6 245 436 239 -338 2 2 0 6 509 350 239 -339 2 2 0 6 463 239 436 -340 2 2 0 6 345 212 319 -341 2 2 0 6 363 212 345 -342 2 2 0 6 212 315 313 -343 2 2 0 6 313 307 212 -344 2 2 0 6 307 319 212 -345 2 2 0 6 212 363 315 -346 2 2 0 6 168 356 325 -347 2 2 0 6 356 168 333 -348 2 2 0 6 405 356 217 -349 2 2 0 6 356 381 217 -350 2 2 0 6 325 356 405 -351 2 2 0 6 356 333 381 -352 2 2 0 6 196 280 257 -353 2 2 0 6 280 505 257 -354 2 2 0 6 505 464 257 -355 2 2 0 6 334 342 357 -356 2 2 0 6 357 176 334 -357 2 2 0 6 357 342 210 -358 2 2 0 6 357 210 321 -359 2 2 0 6 321 352 357 -360 2 2 0 6 357 352 176 -361 2 2 0 6 228 518 485 -362 2 2 0 6 518 228 172 -363 2 2 0 6 518 422 485 -364 2 2 0 6 422 518 172 -365 2 2 0 6 218 406 399 -366 2 2 0 6 399 406 428 -367 2 2 0 6 497 218 399 -368 2 2 0 6 514 497 399 -369 2 2 0 6 242 514 399 -370 2 2 0 6 428 242 399 -371 2 2 0 6 333 168 320 -372 2 2 0 6 168 329 320 -373 2 2 0 6 330 168 325 -374 2 2 0 6 419 168 330 -375 2 2 0 6 168 419 329 -376 2 2 0 6 234 403 353 -377 2 2 0 6 383 353 403 -378 2 2 0 6 353 347 413 -379 2 2 0 6 353 202 347 -380 2 2 0 6 353 413 234 -381 2 2 0 6 383 202 353 -382 2 2 0 6 173 411 369 -383 2 2 0 6 173 434 411 -384 2 2 0 6 173 369 225 -385 2 2 0 6 271 173 225 -386 2 2 0 6 236 439 190 -387 2 2 0 6 259 236 190 -388 2 2 0 6 247 261 190 -389 2 2 0 6 190 440 247 -390 2 2 0 6 190 261 254 -391 2 2 0 6 259 190 254 -392 2 2 0 6 190 439 440 -393 2 2 0 6 214 473 392 -394 2 2 0 6 214 392 293 -395 2 2 0 6 473 214 382 -396 2 2 0 6 368 382 214 -397 2 2 0 6 293 368 214 -398 2 2 0 6 191 281 246 -399 2 2 0 6 246 467 191 -400 2 2 0 6 467 468 191 -401 2 2 0 6 317 201 313 -402 2 2 0 6 201 317 309 -403 2 2 0 6 313 315 317 -404 2 2 0 6 317 315 220 -405 2 2 0 6 339 317 220 -406 2 2 0 6 309 317 339 -407 2 2 0 6 308 332 201 -408 2 2 0 6 332 292 201 -409 2 2 0 6 313 201 292 -410 2 2 0 6 201 309 308 -411 2 2 0 6 376 384 248 -412 2 2 0 6 248 471 376 -413 2 2 0 6 376 350 384 -414 2 2 0 6 471 245 376 -415 2 2 0 6 405 217 400 -416 2 2 0 6 217 460 400 -417 2 2 0 6 386 217 381 -418 2 2 0 6 460 217 386 -419 2 2 0 6 211 389 367 -420 2 2 0 6 305 389 211 -421 2 2 0 6 367 389 414 -422 2 2 0 6 412 389 490 -423 2 2 0 6 305 490 389 -424 2 2 0 6 414 389 412 -425 2 2 0 6 384 331 248 -426 2 2 0 6 458 248 331 -427 2 2 0 6 248 458 175 -428 2 2 0 6 471 248 175 -429 2 2 0 6 445 244 362 -430 2 2 0 6 445 434 244 -431 2 2 0 6 362 244 502 -432 2 2 0 6 360 411 215 -433 2 2 0 6 360 369 411 -434 2 2 0 6 445 215 411 -435 2 2 0 6 411 434 445 -436 2 2 0 6 391 388 418 -437 2 2 0 6 391 283 388 -438 2 2 0 6 272 418 388 -439 2 2 0 6 394 228 314 -440 2 2 0 6 228 394 259 -441 2 2 0 6 394 322 236 -442 2 2 0 6 394 236 259 -443 2 2 0 6 314 322 394 -444 2 2 0 6 520 444 466 -445 2 2 0 6 444 262 466 -446 2 2 0 6 180 520 466 -447 2 2 0 6 264 466 262 -448 2 2 0 6 180 466 267 -449 2 2 0 6 466 264 267 -450 2 2 0 6 174 275 253 -451 2 2 0 6 279 253 275 -452 2 2 0 6 484 322 182 -453 2 2 0 6 484 182 311 -454 2 2 0 6 182 322 314 -455 2 2 0 6 182 314 300 -456 2 2 0 6 311 182 306 -457 2 2 0 6 306 182 297 -458 2 2 0 6 182 300 297 -459 2 2 0 6 200 332 296 -460 2 2 0 6 332 200 291 -461 2 2 0 6 308 296 332 -462 2 2 0 6 291 292 332 -463 2 2 0 6 262 444 230 -464 2 2 0 6 444 509 230 -465 2 2 0 6 444 520 237 -466 2 2 0 6 365 444 237 -467 2 2 0 6 509 444 365 -468 2 2 0 6 310 331 384 -469 2 2 0 6 331 370 458 -470 2 2 0 6 204 370 331 -471 2 2 0 6 204 331 310 -472 2 2 0 6 416 451 493 -473 2 2 0 6 451 416 431 -474 2 2 0 6 515 451 431 -475 2 2 0 6 188 443 351 -476 2 2 0 6 372 351 443 -477 2 2 0 6 415 443 188 -478 2 2 0 6 415 462 443 -479 2 2 0 6 372 443 256 -480 2 2 0 6 256 443 462 -481 2 2 0 6 457 227 407 -482 2 2 0 6 227 457 430 -483 2 2 0 6 407 227 375 -484 2 2 0 6 345 375 227 -485 2 2 0 6 227 358 345 -486 2 2 0 6 430 358 227 -487 2 2 0 6 213 406 320 -488 2 2 0 6 333 320 406 -489 2 2 0 6 213 320 222 -490 2 2 0 6 329 222 320 -491 2 2 0 6 428 406 213 -492 2 2 0 6 333 406 218 -493 2 2 0 6 355 226 225 -494 2 2 0 6 430 226 355 -495 2 2 0 6 225 369 355 -496 2 2 0 6 178 358 355 -497 2 2 0 6 355 358 430 -498 2 2 0 6 369 178 355 -499 2 2 0 6 472 457 240 -500 2 2 0 6 430 457 472 -501 2 2 0 6 226 472 186 -502 2 2 0 6 472 226 430 -503 2 2 0 6 472 240 186 -504 2 2 0 6 183 384 350 -505 2 2 0 6 384 183 310 -506 2 2 0 6 232 402 325 -507 2 2 0 6 405 232 325 -508 2 2 0 6 330 325 402 -509 2 2 0 6 511 262 230 -510 2 2 0 6 511 230 463 -511 2 2 0 6 458 219 403 -512 2 2 0 6 175 458 403 -513 2 2 0 6 403 234 175 -514 2 2 0 6 383 403 219 -515 2 2 0 6 475 188 351 -516 2 2 0 6 258 475 351 -517 2 2 0 6 372 208 351 -518 2 2 0 6 351 208 258 -519 2 2 0 6 475 390 188 -520 2 2 0 6 385 390 475 -521 2 2 0 6 417 188 390 -522 2 2 0 6 390 396 417 -523 2 2 0 6 203 390 385 -524 2 2 0 6 203 396 390 -525 2 2 0 6 338 235 303 -526 2 2 0 6 338 301 235 -527 2 2 0 6 338 304 169 -528 2 2 0 6 491 338 169 -529 2 2 0 6 303 304 338 -530 2 2 0 6 291 301 338 -531 2 2 0 6 291 338 491 -532 2 2 0 6 243 410 241 -533 2 2 0 6 241 410 397 -534 2 2 0 6 241 429 243 -535 2 2 0 6 397 455 241 -536 2 2 0 6 241 455 423 -537 2 2 0 6 241 423 429 -538 2 2 0 6 457 407 461 -539 2 2 0 6 457 461 240 -540 2 2 0 6 255 499 410 -541 2 2 0 6 499 177 410 -542 2 2 0 6 243 474 410 -543 2 2 0 6 474 255 410 -544 2 2 0 6 410 177 397 -545 2 2 0 6 171 277 464 -546 2 2 0 6 171 464 505 -547 2 2 0 6 171 433 277 -548 2 2 0 6 171 463 436 -549 2 2 0 6 505 463 171 -550 2 2 0 6 171 436 433 -551 2 2 0 6 405 400 440 -552 2 2 0 6 247 440 400 -553 2 2 0 6 247 400 426 -554 2 2 0 6 460 426 400 -555 2 2 0 6 193 274 250 -556 2 2 0 6 250 267 193 -557 2 2 0 6 193 524 522 -558 2 2 0 6 524 193 267 -559 2 2 0 6 521 274 193 -560 2 2 0 6 222 395 213 -561 2 2 0 6 437 213 395 -562 2 2 0 6 213 437 428 -563 2 2 0 6 456 385 167 -564 2 2 0 6 167 385 258 -565 2 2 0 6 366 456 167 -566 2 2 0 6 167 452 366 -567 2 2 0 6 258 452 167 -568 2 2 0 6 519 523 294 -569 2 2 0 6 523 519 289 -570 2 2 0 6 523 296 294 -571 2 2 0 6 296 523 289 -572 2 2 0 6 407 375 427 -573 2 2 0 6 179 461 407 -574 2 2 0 6 407 427 179 -575 2 2 0 6 441 198 254 -576 2 2 0 6 261 441 254 -577 2 2 0 6 480 441 261 -578 2 2 0 6 345 319 375 -579 2 2 0 6 345 358 363 -580 2 2 0 6 336 347 393 -581 2 2 0 6 187 347 336 -582 2 2 0 6 393 508 336 -583 2 2 0 6 263 459 336 -584 2 2 0 6 508 263 336 -585 2 2 0 6 459 187 336 -586 2 2 0 6 318 328 365 -587 2 2 0 6 206 328 318 -588 2 2 0 6 387 318 412 -589 2 2 0 6 387 206 318 -590 2 2 0 6 237 412 318 -591 2 2 0 6 365 237 318 -592 2 2 0 6 485 380 228 -593 2 2 0 6 380 314 228 -594 2 2 0 6 259 172 228 -595 2 2 0 6 497 431 218 -596 2 2 0 6 510 497 514 -597 2 2 0 6 497 510 515 -598 2 2 0 6 497 515 431 -599 2 2 0 6 477 274 276 -600 2 2 0 6 287 477 276 -601 2 2 0 6 274 477 265 -602 2 2 0 6 265 477 251 -603 2 2 0 6 477 287 251 -604 2 2 0 6 498 519 294 -605 2 2 0 6 494 519 498 -606 2 2 0 6 289 519 513 -607 2 2 0 6 494 513 519 -608 2 2 0 6 392 473 424 -609 2 2 0 6 302 392 216 -610 2 2 0 6 424 216 392 -611 2 2 0 6 302 293 392 -612 2 2 0 6 483 250 274 -613 2 2 0 6 249 449 250 -614 2 2 0 6 250 448 249 -615 2 2 0 6 250 483 448 -616 2 2 0 6 449 267 250 -617 2 2 0 6 458 370 219 -618 2 2 0 6 292 307 313 -619 2 2 0 6 437 492 184 -620 2 2 0 6 184 492 486 -621 2 2 0 6 474 492 255 -622 2 2 0 6 492 474 486 -623 2 2 0 6 437 255 492 -624 2 2 0 6 499 395 420 -625 2 2 0 6 177 499 420 -626 2 2 0 6 395 499 255 -627 2 2 0 6 374 360 215 -628 2 2 0 6 354 360 374 -629 2 2 0 6 178 360 354 -630 2 2 0 6 369 360 178 -631 2 2 0 6 393 347 202 -632 2 2 0 6 187 413 347 -633 2 2 0 6 245 471 453 -634 2 2 0 6 471 175 453 -635 2 2 0 6 475 258 385 -636 2 2 0 6 247 470 261 -637 2 2 0 6 470 247 426 -638 2 2 0 6 470 480 261 -639 2 2 0 6 498 293 302 -640 2 2 0 6 494 498 302 -641 2 2 0 6 290 498 294 -642 2 2 0 6 498 290 293 -643 2 2 0 6 238 342 334 -644 2 2 0 6 401 238 334 -645 2 2 0 6 238 404 342 -646 2 2 0 6 401 442 238 -647 2 2 0 6 442 404 238 -648 2 2 0 6 322 348 236 -649 2 2 0 6 439 236 348 -650 2 2 0 6 209 402 348 -651 2 2 0 6 348 402 439 -652 2 2 0 6 322 298 348 -653 2 2 0 6 209 348 298 -654 2 2 0 6 500 517 266 -655 2 2 0 6 517 500 286 -656 2 2 0 6 274 521 276 -657 2 2 0 6 521 282 276 -658 2 2 0 6 382 223 170 -659 2 2 0 6 270 170 223 -660 2 2 0 6 192 270 223 -661 2 2 0 6 252 192 223 -662 2 2 0 6 344 349 223 -663 2 2 0 6 223 382 344 -664 2 2 0 6 223 349 252 -665 2 2 0 6 378 362 421 -666 2 2 0 6 378 421 221 -667 2 2 0 6 378 374 215 -668 2 2 0 6 378 215 362 -669 2 2 0 6 359 374 378 -670 2 2 0 6 378 221 359 -671 2 2 0 6 235 456 340 -672 2 2 0 6 235 340 303 -673 2 2 0 6 456 235 312 -674 2 2 0 6 312 235 301 -675 2 2 0 6 170 473 382 -676 2 2 0 6 170 504 473 -677 2 2 0 6 270 500 170 -678 2 2 0 6 504 170 500 -679 2 2 0 6 211 375 319 -680 2 2 0 6 211 427 375 -681 2 2 0 6 427 211 367 -682 2 2 0 6 211 319 305 -683 2 2 0 6 421 478 401 -684 2 2 0 6 401 221 421 -685 2 2 0 6 421 482 478 -686 2 2 0 6 502 421 362 -687 2 2 0 6 421 502 482 -688 2 2 0 6 409 311 224 -689 2 2 0 6 224 452 409 -690 2 2 0 6 398 224 324 -691 2 2 0 6 398 452 224 -692 2 2 0 6 311 324 224 -693 2 2 0 6 439 402 232 -694 2 2 0 6 405 440 232 -695 2 2 0 6 232 440 439 -696 2 2 0 6 512 489 194 -697 2 2 0 6 423 512 194 -698 2 2 0 6 504 489 512 -699 2 2 0 6 504 512 424 -700 2 2 0 6 512 423 424 -701 2 2 0 6 391 418 181 -702 2 2 0 6 391 181 326 -703 2 2 0 6 391 326 432 -704 2 2 0 6 391 432 283 -705 2 2 0 6 215 445 362 -706 2 2 0 6 506 260 438 -707 2 2 0 6 260 489 266 -708 2 2 0 6 489 260 506 -709 2 2 0 6 334 343 401 -710 2 2 0 6 176 343 334 -711 2 2 0 6 218 381 333 -712 2 2 0 6 298 322 484 -713 2 2 0 6 295 484 311 -714 2 2 0 6 484 295 298 -715 2 2 0 6 450 225 226 -716 2 2 0 6 278 450 226 -717 2 2 0 6 278 226 186 -718 2 2 0 6 496 268 174 -719 2 2 0 6 268 507 438 -720 2 2 0 6 268 496 507 -721 2 2 0 6 254 198 172 -722 2 2 0 6 487 172 198 -723 2 2 0 6 330 335 419 -724 2 2 0 6 209 335 330 -725 2 2 0 6 419 335 256 -726 2 2 0 6 372 335 447 -727 2 2 0 6 209 447 335 -728 2 2 0 6 372 256 335 -729 2 2 0 6 481 428 184 -730 2 2 0 6 184 486 481 -731 2 2 0 6 437 184 428 -732 2 2 0 6 281 195 246 -733 2 2 0 6 195 433 246 -734 2 2 0 6 195 277 433 -735 2 2 0 6 330 402 209 -736 2 2 0 6 528 474 243 -737 2 2 0 6 474 528 253 -738 2 2 0 6 429 528 243 -739 2 2 0 6 528 496 253 -740 2 2 0 6 429 496 528 -741 2 2 0 6 196 527 280 -742 2 2 0 6 527 284 280 -743 2 2 0 6 505 280 511 -744 2 2 0 6 280 284 511 -745 2 2 0 6 485 508 393 -746 2 2 0 6 380 485 393 -747 2 2 0 6 485 422 508 -748 2 2 0 6 454 436 245 -749 2 2 0 6 454 245 453 -750 2 2 0 6 408 229 379 -751 2 2 0 6 229 408 494 -752 2 2 0 6 397 229 371 -753 2 2 0 6 229 397 177 -754 2 2 0 6 494 371 229 -755 2 2 0 6 379 229 177 -756 2 2 0 6 525 242 185 -757 2 2 0 6 242 525 514 -758 2 2 0 6 401 343 221 -759 2 2 0 6 343 339 359 -760 2 2 0 6 343 176 339 -761 2 2 0 6 343 359 221 -762 2 2 0 6 386 416 460 -763 2 2 0 6 431 416 386 -764 2 2 0 6 386 381 431 -765 2 2 0 6 393 202 380 -766 2 2 0 6 503 524 516 -767 2 2 0 6 524 264 516 -768 2 2 0 6 284 527 516 -769 2 2 0 6 495 516 527 -770 2 2 0 6 516 495 503 -771 2 2 0 6 516 264 284 -772 2 2 0 6 346 210 342 -773 2 2 0 6 346 342 404 -774 2 2 0 6 414 249 367 -775 2 2 0 6 367 249 179 -776 2 2 0 6 179 427 367 -777 2 2 0 6 409 208 295 -778 2 2 0 6 208 409 258 -779 2 2 0 6 295 311 409 -780 2 2 0 6 452 258 409 -781 2 2 0 6 341 337 210 -782 2 2 0 6 323 337 341 -783 2 2 0 6 337 321 210 -784 2 2 0 6 199 337 323 -785 2 2 0 6 316 321 337 -786 2 2 0 6 337 199 316 -787 2 2 0 6 374 220 354 -788 2 2 0 6 220 374 359 -789 2 2 0 6 354 220 315 -790 2 2 0 6 220 359 339 -791 2 2 0 6 503 522 524 -792 2 2 0 6 264 524 267 -793 2 2 0 6 252 446 192 -794 2 2 0 6 270 192 286 -795 2 2 0 6 496 174 253 -796 2 2 0 6 188 417 415 -797 2 2 0 6 415 417 469 -798 2 2 0 6 469 417 396 -799 2 2 0 6 346 341 210 -800 2 2 0 6 326 341 346 -801 2 2 0 6 341 181 323 -802 2 2 0 6 181 341 326 -803 2 2 0 6 234 425 175 -804 2 2 0 6 478 442 401 -805 2 2 0 6 265 483 274 -806 2 2 0 6 218 431 381 -807 2 2 0 6 324 373 398 -808 2 2 0 6 398 373 205 -809 2 2 0 6 398 205 366 -810 2 2 0 6 398 366 452 -811 2 2 0 6 271 225 450 -812 2 2 0 6 169 490 305 -813 2 2 0 6 490 169 304 -814 2 2 0 6 307 169 305 -815 2 2 0 6 491 169 307 -816 2 2 0 6 365 328 183 -817 2 2 0 6 183 328 299 -818 2 2 0 6 365 183 350 -819 2 2 0 6 310 183 299 -820 2 2 0 6 307 305 319 -821 2 2 0 6 204 373 324 -822 2 2 0 6 310 373 204 -823 2 2 0 6 205 373 299 -824 2 2 0 6 310 299 373 -825 2 2 0 6 462 329 419 -826 2 2 0 6 462 222 329 -827 2 2 0 6 253 486 474 -828 2 2 0 6 387 412 490 -829 2 2 0 6 490 304 387 -830 2 2 0 6 354 315 363 -831 2 2 0 6 300 314 380 -832 2 2 0 6 481 185 242 -833 2 2 0 6 428 481 242 -834 2 2 0 6 454 467 246 -835 2 2 0 6 454 246 433 -836 2 2 0 6 350 509 365 -837 2 2 0 6 240 461 265 -838 2 2 0 6 251 240 265 -839 2 2 0 6 251 186 240 -840 2 2 0 6 469 420 415 -841 2 2 0 6 415 420 462 -842 2 2 0 6 387 304 206 -843 2 2 0 6 408 469 396 -844 2 2 0 6 408 379 469 -845 2 2 0 6 513 408 396 -846 2 2 0 6 494 408 513 -847 2 2 0 6 204 324 306 -848 2 2 0 6 306 370 204 -849 2 2 0 6 207 352 321 -850 2 2 0 6 352 309 176 -851 2 2 0 6 308 309 352 -852 2 2 0 6 352 207 308 -853 2 2 0 6 442 476 404 -854 2 2 0 6 476 435 404 -855 2 2 0 6 442 488 476 -856 2 2 0 6 450 278 197 -857 2 2 0 6 186 285 278 -858 2 2 0 6 424 473 504 -859 2 2 0 6 425 468 467 -860 2 2 0 6 454 453 467 -861 2 2 0 6 425 467 453 -862 2 2 0 6 181 418 349 -863 2 2 0 6 418 252 349 -864 2 2 0 6 252 418 272 -865 2 2 0 6 487 422 172 -866 2 2 0 6 501 508 422 -867 2 2 0 6 422 269 501 -868 2 2 0 6 422 487 269 -869 2 2 0 6 344 323 349 -870 2 2 0 6 344 199 323 -871 2 2 0 6 181 349 323 -872 2 2 0 6 412 237 364 -873 2 2 0 6 414 412 364 -874 2 2 0 6 368 344 382 -875 2 2 0 6 368 199 344 -876 2 2 0 6 279 486 253 -877 2 2 0 6 462 419 256 -878 2 2 0 6 354 363 178 -879 2 2 0 6 200 327 301 -880 2 2 0 6 289 327 200 -881 2 2 0 6 200 301 291 -882 2 2 0 6 200 296 289 -883 2 2 0 6 366 340 456 -884 2 2 0 6 366 205 340 -885 2 2 0 6 339 176 309 -886 2 2 0 6 493 460 416 -887 2 2 0 6 271 450 197 -888 2 2 0 6 216 371 302 -889 2 2 0 6 216 455 371 -890 2 2 0 6 455 216 423 -891 2 2 0 6 216 424 423 -892 2 2 0 6 311 306 324 -893 2 2 0 6 520 180 237 -894 2 2 0 6 180 364 237 -895 2 2 0 6 488 442 478 -896 2 2 0 6 478 482 488 -897 2 2 0 6 420 469 379 -898 2 2 0 6 501 263 508 -899 2 2 0 6 222 462 420 -900 2 2 0 6 395 222 420 -901 2 2 0 6 177 420 379 -902 2 2 0 6 312 327 203 -903 2 2 0 6 312 301 327 -904 2 2 0 6 203 327 288 -905 2 2 0 6 289 288 327 -906 2 2 0 6 397 371 455 -907 2 2 0 6 449 249 180 -908 2 2 0 6 249 414 364 -909 2 2 0 6 448 179 249 -910 2 2 0 6 364 180 249 -911 2 2 0 6 172 259 254 -912 2 2 0 6 372 447 208 -913 2 2 0 6 208 447 295 -914 2 2 0 6 298 447 209 -915 2 2 0 6 298 295 447 -916 2 2 0 6 483 265 448 -917 2 2 0 6 219 370 297 -918 2 2 0 6 383 219 297 -919 2 2 0 6 363 358 178 -920 2 2 0 6 383 300 202 -921 2 2 0 6 380 202 300 -922 2 2 0 6 506 438 507 -923 2 2 0 6 207 321 316 -924 2 2 0 6 429 507 496 -925 2 2 0 6 285 186 273 -926 2 2 0 6 273 186 251 -927 2 2 0 6 251 479 273 -928 2 2 0 6 203 385 312 -929 2 2 0 6 312 385 456 -930 2 2 0 6 306 297 370 -931 2 2 0 6 194 506 507 -932 2 2 0 6 194 507 429 -933 2 2 0 6 506 194 489 -934 2 2 0 6 429 423 194 -935 2 2 0 6 396 203 288 -936 2 2 0 6 489 504 266 -937 2 2 0 6 500 266 504 -938 2 2 0 6 511 284 262 -939 2 2 0 6 264 262 284 -940 2 2 0 6 255 437 395 -941 2 2 0 6 494 302 371 -942 2 2 0 6 267 449 180 -943 2 2 0 6 505 511 463 -944 2 2 0 6 297 300 383 -945 2 2 0 6 290 294 316 -946 2 2 0 6 316 294 207 -947 2 2 0 6 316 199 290 -948 2 2 0 6 252 272 446 -949 2 2 0 6 288 513 396 -950 2 2 0 6 289 513 288 -951 2 2 0 6 448 265 461 -952 2 2 0 6 448 461 179 -953 2 2 0 6 426 460 493 -954 2 2 0 6 293 290 368 -955 2 2 0 6 199 368 290 -956 2 2 0 6 308 207 296 -957 2 2 0 6 292 491 307 -958 2 2 0 6 206 304 303 -959 2 2 0 6 433 436 454 -960 2 2 0 6 294 296 207 -961 2 2 0 6 491 292 291 -962 2 2 0 6 270 286 500 -963 2 2 0 6 251 287 479 -964 2 2 0 6 425 453 175 -965 2 2 0 15 3 668 70 -966 2 2 0 15 3 140 668 -967 2 2 0 15 5 56 670 -968 2 2 0 15 5 670 131 -969 2 2 0 15 6 669 71 -970 2 2 0 15 6 139 669 -971 2 2 0 15 8 85 667 -972 2 2 0 15 8 667 148 -973 2 2 0 15 57 577 56 -974 2 2 0 15 577 670 56 -975 2 2 0 15 57 58 581 -976 2 2 0 15 577 57 581 -977 2 2 0 15 59 557 58 -978 2 2 0 15 557 581 58 -979 2 2 0 15 59 60 642 -980 2 2 0 15 557 59 642 -981 2 2 0 15 61 679 60 -982 2 2 0 15 642 60 679 -983 2 2 0 15 62 592 61 -984 2 2 0 15 592 679 61 -985 2 2 0 15 63 650 62 -986 2 2 0 15 592 62 650 -987 2 2 0 15 64 626 63 -988 2 2 0 15 63 626 650 -989 2 2 0 15 64 65 630 -990 2 2 0 15 64 630 626 -991 2 2 0 15 65 66 658 -992 2 2 0 15 65 658 630 -993 2 2 0 15 67 644 66 -994 2 2 0 15 644 658 66 -995 2 2 0 15 67 68 562 -996 2 2 0 15 562 644 67 -997 2 2 0 15 69 582 68 -998 2 2 0 15 562 68 582 -999 2 2 0 15 69 70 575 -1000 2 2 0 15 575 582 69 -1001 2 2 0 15 575 70 668 -1002 2 2 0 15 72 71 578 -1003 2 2 0 15 578 71 669 -1004 2 2 0 15 72 579 73 -1005 2 2 0 15 578 579 72 -1006 2 2 0 15 74 73 558 -1007 2 2 0 15 558 73 579 -1008 2 2 0 15 74 643 75 -1009 2 2 0 15 558 643 74 -1010 2 2 0 15 76 75 680 -1011 2 2 0 15 643 680 75 -1012 2 2 0 15 77 76 591 -1013 2 2 0 15 591 76 680 -1014 2 2 0 15 78 77 651 -1015 2 2 0 15 591 651 77 -1016 2 2 0 15 79 78 627 -1017 2 2 0 15 78 651 627 -1018 2 2 0 15 79 631 80 -1019 2 2 0 15 79 627 631 -1020 2 2 0 15 80 659 81 -1021 2 2 0 15 80 631 659 -1022 2 2 0 15 82 81 645 -1023 2 2 0 15 645 81 659 -1024 2 2 0 15 82 561 83 -1025 2 2 0 15 561 82 645 -1026 2 2 0 15 84 83 580 -1027 2 2 0 15 561 580 83 -1028 2 2 0 15 84 576 85 -1029 2 2 0 15 576 84 580 -1030 2 2 0 15 576 667 85 -1031 2 2 0 15 132 131 654 -1032 2 2 0 15 131 670 654 -1033 2 2 0 15 133 132 648 -1034 2 2 0 15 132 654 648 -1035 2 2 0 15 133 569 134 -1036 2 2 0 15 133 648 625 -1037 2 2 0 15 569 133 625 -1038 2 2 0 15 135 134 663 -1039 2 2 0 15 569 663 134 -1040 2 2 0 15 135 652 136 -1041 2 2 0 15 135 663 652 -1042 2 2 0 15 136 685 137 -1043 2 2 0 15 136 652 685 -1044 2 2 0 15 137 671 138 -1045 2 2 0 15 671 137 685 -1046 2 2 0 15 138 566 139 -1047 2 2 0 15 566 138 671 -1048 2 2 0 15 139 566 669 -1049 2 2 0 15 141 563 140 -1050 2 2 0 15 140 563 668 -1051 2 2 0 15 142 628 141 -1052 2 2 0 15 563 141 628 -1053 2 2 0 15 142 143 568 -1054 2 2 0 15 142 568 628 -1055 2 2 0 15 144 664 143 -1056 2 2 0 15 568 143 664 -1057 2 2 0 15 144 145 653 -1058 2 2 0 15 144 653 664 -1059 2 2 0 15 146 682 145 -1060 2 2 0 15 145 682 653 -1061 2 2 0 15 146 147 629 -1062 2 2 0 15 146 629 570 -1063 2 2 0 15 146 570 682 -1064 2 2 0 15 147 148 565 -1065 2 2 0 15 565 629 147 -1066 2 2 0 15 148 667 565 -1067 2 2 0 15 604 554 613 -1068 2 2 0 15 604 613 559 -1069 2 2 0 15 613 568 618 -1070 2 2 0 15 618 559 613 -1071 2 2 0 15 554 574 613 -1072 2 2 0 15 613 574 568 -1073 2 2 0 15 541 599 614 -1074 2 2 0 15 584 541 614 -1075 2 2 0 15 550 590 614 -1076 2 2 0 15 614 590 584 -1077 2 2 0 15 599 638 614 -1078 2 2 0 15 614 638 550 -1079 2 2 0 15 558 579 535 -1080 2 2 0 15 558 585 643 -1081 2 2 0 15 535 622 558 -1082 2 2 0 15 609 558 622 -1083 2 2 0 15 585 558 609 -1084 2 2 0 15 681 661 673 -1085 2 2 0 15 681 673 672 -1086 2 2 0 15 530 673 596 -1087 2 2 0 15 530 674 673 -1088 2 2 0 15 661 596 673 -1089 2 2 0 15 672 673 674 -1090 2 2 0 15 553 571 533 -1091 2 2 0 15 533 571 640 -1092 2 2 0 15 566 571 535 -1093 2 2 0 15 566 671 571 -1094 2 2 0 15 571 622 535 -1095 2 2 0 15 640 571 671 -1096 2 2 0 15 571 553 622 -1097 2 2 0 15 607 617 556 -1098 2 2 0 15 556 686 607 -1099 2 2 0 15 663 617 607 -1100 2 2 0 15 663 607 652 -1101 2 2 0 15 640 652 607 -1102 2 2 0 15 686 640 607 -1103 2 2 0 15 560 556 617 -1104 2 2 0 15 560 656 556 -1105 2 2 0 15 617 612 560 -1106 2 2 0 15 560 603 529 -1107 2 2 0 15 603 560 612 -1108 2 2 0 15 560 529 656 -1109 2 2 0 15 532 632 647 -1110 2 2 0 15 559 632 532 -1111 2 2 0 15 616 632 660 -1112 2 2 0 15 632 606 660 -1113 2 2 0 15 616 677 632 -1114 2 2 0 15 647 632 677 -1115 2 2 0 15 559 606 632 -1116 2 2 0 15 573 629 565 -1117 2 2 0 15 573 570 629 -1118 2 2 0 15 565 537 573 -1119 2 2 0 15 573 537 624 -1120 2 2 0 15 573 624 555 -1121 2 2 0 15 555 616 573 -1122 2 2 0 15 616 570 573 -1123 2 2 0 15 604 532 635 -1124 2 2 0 15 559 532 604 -1125 2 2 0 15 554 604 541 -1126 2 2 0 15 599 541 604 -1127 2 2 0 15 604 635 599 -1128 2 2 0 15 683 596 542 -1129 2 2 0 15 546 683 542 -1130 2 2 0 15 620 602 683 -1131 2 2 0 15 620 683 546 -1132 2 2 0 15 596 683 598 -1133 2 2 0 15 598 683 602 -1134 2 2 0 15 551 637 615 -1135 2 2 0 15 544 637 551 -1136 2 2 0 15 600 615 637 -1137 2 2 0 15 600 637 655 -1138 2 2 0 15 637 593 655 -1139 2 2 0 15 544 593 637 -1140 2 2 0 15 670 577 654 -1141 2 2 0 15 564 577 534 -1142 2 2 0 15 577 564 654 -1143 2 2 0 15 577 581 534 -1144 2 2 0 15 631 627 595 -1145 2 2 0 15 627 651 657 -1146 2 2 0 15 627 657 595 -1147 2 2 0 15 562 582 536 -1148 2 2 0 15 536 623 562 -1149 2 2 0 15 562 584 644 -1150 2 2 0 15 584 562 610 -1151 2 2 0 15 610 562 623 -1152 2 2 0 15 661 681 593 -1153 2 2 0 15 531 681 672 -1154 2 2 0 15 655 681 531 -1155 2 2 0 15 655 593 681 -1156 2 2 0 15 532 647 635 -1157 2 2 0 15 656 686 556 -1158 2 2 0 15 588 586 642 -1159 2 2 0 15 642 679 588 -1160 2 2 0 15 547 619 588 -1161 2 2 0 15 592 547 588 -1162 2 2 0 15 619 586 588 -1163 2 2 0 15 592 588 679 -1164 2 2 0 15 669 566 578 -1165 2 2 0 15 591 680 587 -1166 2 2 0 15 643 587 680 -1167 2 2 0 15 591 587 546 -1168 2 2 0 15 587 643 585 -1169 2 2 0 15 546 587 620 -1170 2 2 0 15 620 587 585 -1171 2 2 0 15 554 541 610 -1172 2 2 0 15 584 610 541 -1173 2 2 0 15 530 687 633 -1174 2 2 0 15 633 597 530 -1175 2 2 0 15 633 687 634 -1176 2 2 0 15 633 676 641 -1177 2 2 0 15 634 676 633 -1178 2 2 0 15 597 633 641 -1179 2 2 0 15 533 656 553 -1180 2 2 0 15 656 533 686 -1181 2 2 0 15 640 686 533 -1182 2 2 0 15 566 535 578 -1183 2 2 0 15 578 535 579 -1184 2 2 0 15 530 598 687 -1185 2 2 0 15 598 530 596 -1186 2 2 0 15 530 597 674 -1187 2 2 0 15 608 552 621 -1188 2 2 0 15 608 621 557 -1189 2 2 0 15 586 539 608 -1190 2 2 0 15 586 608 557 -1191 2 2 0 15 552 608 539 -1192 2 2 0 15 665 591 546 -1193 2 2 0 15 591 665 651 -1194 2 2 0 15 568 664 618 -1195 2 2 0 15 606 618 664 -1196 2 2 0 15 559 618 606 -1197 2 2 0 15 612 617 625 -1198 2 2 0 15 625 617 569 -1199 2 2 0 15 569 617 663 -1200 2 2 0 15 549 675 662 -1201 2 2 0 15 662 675 674 -1202 2 2 0 15 672 675 594 -1203 2 2 0 15 675 672 674 -1204 2 2 0 15 549 545 675 -1205 2 2 0 15 675 545 594 -1206 2 2 0 15 551 615 589 -1207 2 2 0 15 589 595 551 -1208 2 2 0 15 595 639 551 -1209 2 2 0 15 551 639 544 -1210 2 2 0 15 671 685 640 -1211 2 2 0 15 685 652 640 -1212 2 2 0 15 615 583 589 -1213 2 2 0 15 645 659 589 -1214 2 2 0 15 589 583 645 -1215 2 2 0 15 659 631 589 -1216 2 2 0 15 589 631 595 -1217 2 2 0 15 565 576 537 -1218 2 2 0 15 667 576 565 -1219 2 2 0 15 537 561 624 -1220 2 2 0 15 561 537 580 -1221 2 2 0 15 561 645 583 -1222 2 2 0 15 611 624 561 -1223 2 2 0 15 583 611 561 -1224 2 2 0 15 636 687 598 -1225 2 2 0 15 687 636 634 -1226 2 2 0 15 646 636 602 -1227 2 2 0 15 602 636 598 -1228 2 2 0 15 634 636 646 -1229 2 2 0 15 540 615 600 -1230 2 2 0 15 583 615 540 -1231 2 2 0 15 542 548 665 -1232 2 2 0 15 548 542 688 -1233 2 2 0 15 596 688 542 -1234 2 2 0 15 542 665 546 -1235 2 2 0 15 575 536 582 -1236 2 2 0 15 563 574 536 -1237 2 2 0 15 563 536 575 -1238 2 2 0 15 574 623 536 -1239 2 2 0 15 572 621 552 -1240 2 2 0 15 572 534 621 -1241 2 2 0 15 534 557 621 -1242 2 2 0 15 538 602 620 -1243 2 2 0 15 585 538 620 -1244 2 2 0 15 564 572 625 -1245 2 2 0 15 564 625 648 -1246 2 2 0 15 564 534 572 -1247 2 2 0 15 654 564 648 -1248 2 2 0 15 603 634 529 -1249 2 2 0 15 552 539 603 -1250 2 2 0 15 601 603 539 -1251 2 2 0 15 603 612 552 -1252 2 2 0 15 603 601 634 -1253 2 2 0 15 658 590 630 -1254 2 2 0 15 644 590 658 -1255 2 2 0 15 668 563 575 -1256 2 2 0 15 612 625 572 -1257 2 2 0 15 660 682 570 -1258 2 2 0 15 682 660 653 -1259 2 2 0 15 616 660 570 -1260 2 2 0 15 660 606 653 -1261 2 2 0 15 634 646 529 -1262 2 2 0 15 529 646 656 -1263 2 2 0 15 574 554 623 -1264 2 2 0 15 610 623 554 -1265 2 2 0 15 576 580 537 -1266 2 2 0 15 639 665 548 -1267 2 2 0 15 544 639 548 -1268 2 2 0 15 548 688 661 -1269 2 2 0 15 593 548 661 -1270 2 2 0 15 548 593 544 -1271 2 2 0 15 557 642 586 -1272 2 2 0 15 657 665 639 -1273 2 2 0 15 639 595 657 -1274 2 2 0 15 567 647 600 -1275 2 2 0 15 600 655 567 -1276 2 2 0 15 647 677 600 -1277 2 2 0 15 540 600 677 -1278 2 2 0 15 647 567 635 -1279 2 2 0 15 567 649 635 -1280 2 2 0 15 567 531 649 -1281 2 2 0 15 567 655 531 -1282 2 2 0 15 611 555 624 -1283 2 2 0 15 555 611 540 -1284 2 2 0 15 583 540 611 -1285 2 2 0 15 547 543 641 -1286 2 2 0 15 619 547 641 -1287 2 2 0 15 543 547 666 -1288 2 2 0 15 666 547 592 -1289 2 2 0 15 543 549 662 -1290 2 2 0 15 597 543 662 -1291 2 2 0 15 662 674 597 -1292 2 2 0 15 586 619 539 -1293 2 2 0 15 596 661 688 -1294 2 2 0 15 619 641 676 -1295 2 2 0 15 619 676 601 -1296 2 2 0 15 601 676 634 -1297 2 2 0 15 602 538 605 -1298 2 2 0 15 605 646 602 -1299 2 2 0 15 641 543 597 -1300 2 2 0 15 664 653 606 -1301 2 2 0 15 574 563 628 -1302 2 2 0 15 574 628 568 -1303 2 2 0 15 590 550 678 -1304 2 2 0 15 590 678 630 -1305 2 2 0 15 590 644 584 -1306 2 2 0 15 552 612 572 -1307 2 2 0 15 585 609 538 -1308 2 2 0 15 553 538 609 -1309 2 2 0 15 553 605 538 -1310 2 2 0 15 677 616 555 -1311 2 2 0 15 555 540 677 -1312 2 2 0 15 539 619 601 -1313 2 2 0 15 649 599 635 -1314 2 2 0 15 599 649 638 -1315 2 2 0 15 550 545 678 -1316 2 2 0 15 545 550 638 -1317 2 2 0 15 678 626 630 -1318 2 2 0 15 684 626 678 -1319 2 2 0 15 626 684 650 -1320 2 2 0 15 646 605 656 -1321 2 2 0 15 531 672 594 -1322 2 2 0 15 609 622 553 -1323 2 2 0 15 543 666 549 -1324 2 2 0 15 666 684 549 -1325 2 2 0 15 545 549 684 -1326 2 2 0 15 678 545 684 -1327 2 2 0 15 650 684 666 -1328 2 2 0 15 649 531 594 -1329 2 2 0 15 605 553 656 -1330 2 2 0 15 638 649 594 -1331 2 2 0 15 545 638 594 -1332 2 2 0 15 651 665 657 -1333 2 2 0 15 557 534 581 -1334 2 2 0 15 592 650 666 -1335 2 2 0 19 2 844 25 -1336 2 2 0 19 2 149 844 -1337 2 2 0 19 3 11 846 -1338 2 2 0 19 3 846 140 -1339 2 2 0 19 8 845 86 -1340 2 2 0 19 8 148 845 -1341 2 2 0 19 9 100 843 -1342 2 2 0 19 9 843 157 -1343 2 2 0 19 12 736 11 -1344 2 2 0 19 736 846 11 -1345 2 2 0 19 12 13 740 -1346 2 2 0 19 736 12 740 -1347 2 2 0 19 14 715 13 -1348 2 2 0 19 715 740 13 -1349 2 2 0 19 14 15 819 -1350 2 2 0 19 715 14 819 -1351 2 2 0 19 16 836 15 -1352 2 2 0 19 819 15 836 -1353 2 2 0 19 17 837 16 -1354 2 2 0 19 16 837 836 -1355 2 2 0 19 18 831 17 -1356 2 2 0 19 17 831 837 -1357 2 2 0 19 19 789 18 -1358 2 2 0 19 18 789 831 -1359 2 2 0 19 19 20 793 -1360 2 2 0 19 19 793 789 -1361 2 2 0 19 20 21 834 -1362 2 2 0 19 20 834 793 -1363 2 2 0 19 22 821 21 -1364 2 2 0 19 821 834 21 -1365 2 2 0 19 22 23 720 -1366 2 2 0 19 720 821 22 -1367 2 2 0 19 24 741 23 -1368 2 2 0 19 720 23 741 -1369 2 2 0 19 24 25 734 -1370 2 2 0 19 734 741 24 -1371 2 2 0 19 734 25 844 -1372 2 2 0 19 87 86 737 -1373 2 2 0 19 737 86 845 -1374 2 2 0 19 87 738 88 -1375 2 2 0 19 737 738 87 -1376 2 2 0 19 89 88 716 -1377 2 2 0 19 716 88 738 -1378 2 2 0 19 89 820 90 -1379 2 2 0 19 716 820 89 -1380 2 2 0 19 91 90 839 -1381 2 2 0 19 820 839 90 -1382 2 2 0 19 92 91 838 -1383 2 2 0 19 91 839 838 -1384 2 2 0 19 93 92 832 -1385 2 2 0 19 92 838 832 -1386 2 2 0 19 94 93 790 -1387 2 2 0 19 93 832 790 -1388 2 2 0 19 94 794 95 -1389 2 2 0 19 94 790 794 -1390 2 2 0 19 95 835 96 -1391 2 2 0 19 95 794 835 -1392 2 2 0 19 97 96 822 -1393 2 2 0 19 822 96 835 -1394 2 2 0 19 97 719 98 -1395 2 2 0 19 719 97 822 -1396 2 2 0 19 99 98 739 -1397 2 2 0 19 719 739 98 -1398 2 2 0 19 99 735 100 -1399 2 2 0 19 735 99 739 -1400 2 2 0 19 735 843 100 -1401 2 2 0 19 141 140 830 -1402 2 2 0 19 140 846 830 -1403 2 2 0 19 142 141 826 -1404 2 2 0 19 141 830 826 -1405 2 2 0 19 142 727 143 -1406 2 2 0 19 142 826 788 -1407 2 2 0 19 727 142 788 -1408 2 2 0 19 144 143 841 -1409 2 2 0 19 727 841 143 -1410 2 2 0 19 144 827 145 -1411 2 2 0 19 144 841 827 -1412 2 2 0 19 145 853 146 -1413 2 2 0 19 145 827 853 -1414 2 2 0 19 146 847 147 -1415 2 2 0 19 847 146 853 -1416 2 2 0 19 147 724 148 -1417 2 2 0 19 724 147 847 -1418 2 2 0 19 148 724 845 -1419 2 2 0 19 150 721 149 -1420 2 2 0 19 149 721 844 -1421 2 2 0 19 151 791 150 -1422 2 2 0 19 721 150 791 -1423 2 2 0 19 151 152 726 -1424 2 2 0 19 151 726 791 -1425 2 2 0 19 153 842 152 -1426 2 2 0 19 726 152 842 -1427 2 2 0 19 153 154 828 -1428 2 2 0 19 153 828 842 -1429 2 2 0 19 155 852 154 -1430 2 2 0 19 154 852 828 -1431 2 2 0 19 155 156 792 -1432 2 2 0 19 155 728 852 -1433 2 2 0 19 155 792 728 -1434 2 2 0 19 156 157 723 -1435 2 2 0 19 723 792 156 -1436 2 2 0 19 157 843 723 -1437 2 2 0 19 694 824 810 -1438 2 2 0 19 766 694 810 -1439 2 2 0 19 824 725 810 -1440 2 2 0 19 766 810 761 -1441 2 2 0 19 725 761 810 -1442 2 2 0 19 846 736 830 -1443 2 2 0 19 830 722 826 -1444 2 2 0 19 736 722 830 -1445 2 2 0 19 765 718 775 -1446 2 2 0 19 782 775 718 -1447 2 2 0 19 718 765 689 -1448 2 2 0 19 718 833 714 -1449 2 2 0 19 718 689 833 -1450 2 2 0 19 718 714 782 -1451 2 2 0 19 837 831 751 -1452 2 2 0 19 837 747 836 -1453 2 2 0 19 747 837 751 -1454 2 2 0 19 697 785 716 -1455 2 2 0 19 716 738 697 -1456 2 2 0 19 724 729 697 -1457 2 2 0 19 724 697 737 -1458 2 2 0 19 729 785 697 -1459 2 2 0 19 737 697 738 -1460 2 2 0 19 762 768 702 -1461 2 2 0 19 713 702 768 -1462 2 2 0 19 713 774 702 -1463 2 2 0 19 742 702 774 -1464 2 2 0 19 702 856 762 -1465 2 2 0 19 702 778 856 -1466 2 2 0 19 742 778 702 -1467 2 2 0 19 823 767 833 -1468 2 2 0 19 767 823 764 -1469 2 2 0 19 767 711 833 -1470 2 2 0 19 711 767 700 -1471 2 2 0 19 764 700 767 -1472 2 2 0 19 707 705 811 -1473 2 2 0 19 707 811 780 -1474 2 2 0 19 811 705 760 -1475 2 2 0 19 848 811 809 -1476 2 2 0 19 760 809 811 -1477 2 2 0 19 780 811 848 -1478 2 2 0 19 707 807 705 -1479 2 2 0 19 707 780 747 -1480 2 2 0 19 751 707 747 -1481 2 2 0 19 707 751 807 -1482 2 2 0 19 804 813 825 -1483 2 2 0 19 825 813 855 -1484 2 2 0 19 813 804 753 -1485 2 2 0 19 795 813 753 -1486 2 2 0 19 795 850 813 -1487 2 2 0 19 777 855 813 -1488 2 2 0 19 850 777 813 -1489 2 2 0 19 851 815 778 -1490 2 2 0 19 796 815 851 -1491 2 2 0 19 803 829 815 -1492 2 2 0 19 815 752 803 -1493 2 2 0 19 829 856 815 -1494 2 2 0 19 778 815 856 -1495 2 2 0 19 796 752 815 -1496 2 2 0 19 694 805 824 -1497 2 2 0 19 717 805 694 -1498 2 2 0 19 717 694 766 -1499 2 2 0 19 709 818 705 -1500 2 2 0 19 760 705 818 -1501 2 2 0 19 709 705 807 -1502 2 2 0 19 816 827 770 -1503 2 2 0 19 854 816 770 -1504 2 2 0 19 841 782 770 -1505 2 2 0 19 770 782 714 -1506 2 2 0 19 841 770 827 -1507 2 2 0 19 714 854 770 -1508 2 2 0 19 843 735 723 -1509 2 2 0 19 842 828 769 -1510 2 2 0 19 840 769 828 -1511 2 2 0 19 852 840 828 -1512 2 2 0 19 772 716 785 -1513 2 2 0 19 744 716 772 -1514 2 2 0 19 716 744 820 -1515 2 2 0 19 690 809 802 -1516 2 2 0 19 690 733 809 -1517 2 2 0 19 690 802 801 -1518 2 2 0 19 690 801 814 -1519 2 2 0 19 690 814 733 -1520 2 2 0 19 831 789 757 -1521 2 2 0 19 751 831 757 -1522 2 2 0 19 824 805 768 -1523 2 2 0 19 779 768 805 -1524 2 2 0 19 768 762 824 -1525 2 2 0 19 768 779 713 -1526 2 2 0 19 754 851 794 -1527 2 2 0 19 754 796 851 -1528 2 2 0 19 851 778 748 -1529 2 2 0 19 748 794 851 -1530 2 2 0 19 803 752 799 -1531 2 2 0 19 692 803 799 -1532 2 2 0 19 693 799 798 -1533 2 2 0 19 693 692 799 -1534 2 2 0 19 752 798 799 -1535 2 2 0 19 760 802 809 -1536 2 2 0 19 809 763 848 -1537 2 2 0 19 763 809 733 -1538 2 2 0 19 754 756 708 -1539 2 2 0 19 756 754 790 -1540 2 2 0 19 754 708 796 -1541 2 2 0 19 794 790 754 -1542 2 2 0 19 805 769 840 -1543 2 2 0 19 779 805 840 -1544 2 2 0 19 717 769 805 -1545 2 2 0 19 769 783 842 -1546 2 2 0 19 726 842 783 -1547 2 2 0 19 717 783 769 -1548 2 2 0 19 776 726 783 -1549 2 2 0 19 783 717 776 -1550 2 2 0 19 774 787 719 -1551 2 2 0 19 742 774 719 -1552 2 2 0 19 774 713 787 -1553 2 2 0 19 712 703 773 -1554 2 2 0 19 773 786 712 -1555 2 2 0 19 766 712 776 -1556 2 2 0 19 712 732 776 -1557 2 2 0 19 712 766 703 -1558 2 2 0 19 732 712 786 -1559 2 2 0 19 819 836 747 -1560 2 2 0 19 706 812 704 -1561 2 2 0 19 706 781 812 -1562 2 2 0 19 706 704 806 -1563 2 2 0 19 706 806 750 -1564 2 2 0 19 706 746 781 -1565 2 2 0 19 750 746 706 -1566 2 2 0 19 708 756 806 -1567 2 2 0 19 832 756 790 -1568 2 2 0 19 750 756 832 -1569 2 2 0 19 750 806 756 -1570 2 2 0 19 772 785 711 -1571 2 2 0 19 711 700 772 -1572 2 2 0 19 744 772 700 -1573 2 2 0 19 689 823 833 -1574 2 2 0 19 689 808 823 -1575 2 2 0 19 823 808 733 -1576 2 2 0 19 733 764 823 -1577 2 2 0 19 725 824 762 -1578 2 2 0 19 829 762 856 -1579 2 2 0 19 762 829 725 -1580 2 2 0 19 747 745 819 -1581 2 2 0 19 715 819 745 -1582 2 2 0 19 711 729 695 -1583 2 2 0 19 695 833 711 -1584 2 2 0 19 729 711 785 -1585 2 2 0 19 775 782 788 -1586 2 2 0 19 775 788 730 -1587 2 2 0 19 788 782 727 -1588 2 2 0 19 722 788 826 -1589 2 2 0 19 722 730 788 -1590 2 2 0 19 801 802 797 -1591 2 2 0 19 802 760 797 -1592 2 2 0 19 771 710 784 -1593 2 2 0 19 771 784 715 -1594 2 2 0 19 710 771 701 -1595 2 2 0 19 745 701 771 -1596 2 2 0 19 745 771 715 -1597 2 2 0 19 708 704 817 -1598 2 2 0 19 796 708 817 -1599 2 2 0 19 708 806 704 -1600 2 2 0 19 721 732 698 -1601 2 2 0 19 721 698 734 -1602 2 2 0 19 720 741 698 -1603 2 2 0 19 698 786 720 -1604 2 2 0 19 732 786 698 -1605 2 2 0 19 734 698 741 -1606 2 2 0 19 724 847 729 -1607 2 2 0 19 845 724 737 -1608 2 2 0 19 801 798 759 -1609 2 2 0 19 759 814 801 -1610 2 2 0 19 801 797 693 -1611 2 2 0 19 801 693 798 -1612 2 2 0 19 765 775 710 -1613 2 2 0 19 710 775 730 -1614 2 2 0 19 844 721 734 -1615 2 2 0 19 838 750 832 -1616 2 2 0 19 730 696 784 -1617 2 2 0 19 696 715 784 -1618 2 2 0 19 730 784 710 -1619 2 2 0 19 722 696 730 -1620 2 2 0 19 722 736 696 -1621 2 2 0 19 736 740 696 -1622 2 2 0 19 715 696 740 -1623 2 2 0 19 853 827 816 -1624 2 2 0 19 847 853 816 -1625 2 2 0 19 691 804 825 -1626 2 2 0 19 825 855 761 -1627 2 2 0 19 761 725 825 -1628 2 2 0 19 691 825 725 -1629 2 2 0 19 835 794 748 -1630 2 2 0 19 822 835 748 -1631 2 2 0 19 780 848 763 -1632 2 2 0 19 710 701 765 -1633 2 2 0 19 765 808 689 -1634 2 2 0 19 765 763 808 -1635 2 2 0 19 763 765 701 -1636 2 2 0 19 804 800 753 -1637 2 2 0 19 692 800 804 -1638 2 2 0 19 691 692 804 -1639 2 2 0 19 834 749 793 -1640 2 2 0 19 793 755 789 -1641 2 2 0 19 749 850 793 -1642 2 2 0 19 755 793 850 -1643 2 2 0 19 723 699 731 -1644 2 2 0 19 723 735 699 -1645 2 2 0 19 731 792 723 -1646 2 2 0 19 795 753 818 -1647 2 2 0 19 795 818 709 -1648 2 2 0 19 818 753 758 -1649 2 2 0 19 760 818 758 -1650 2 2 0 19 695 729 816 -1651 2 2 0 19 816 854 695 -1652 2 2 0 19 816 729 847 -1653 2 2 0 19 699 719 787 -1654 2 2 0 19 719 699 739 -1655 2 2 0 19 719 822 742 -1656 2 2 0 19 833 695 854 -1657 2 2 0 19 759 817 704 -1658 2 2 0 19 759 798 817 -1659 2 2 0 19 817 798 752 -1660 2 2 0 19 796 817 752 -1661 2 2 0 19 812 759 704 -1662 2 2 0 19 759 812 814 -1663 2 2 0 19 840 852 728 -1664 2 2 0 19 779 840 728 -1665 2 2 0 19 691 829 803 -1666 2 2 0 19 691 803 692 -1667 2 2 0 19 743 720 773 -1668 2 2 0 19 773 720 786 -1669 2 2 0 19 743 773 703 -1670 2 2 0 19 701 780 763 -1671 2 2 0 19 745 780 701 -1672 2 2 0 19 780 745 747 -1673 2 2 0 19 781 849 812 -1674 2 2 0 19 812 849 814 -1675 2 2 0 19 776 732 726 -1676 2 2 0 19 732 791 726 -1677 2 2 0 19 833 854 714 -1678 2 2 0 19 727 782 841 -1679 2 2 0 19 713 779 731 -1680 2 2 0 19 779 728 731 -1681 2 2 0 19 781 764 849 -1682 2 2 0 19 814 849 764 -1683 2 2 0 19 755 795 709 -1684 2 2 0 19 755 850 795 -1685 2 2 0 19 766 776 717 -1686 2 2 0 19 703 761 855 -1687 2 2 0 19 703 855 777 -1688 2 2 0 19 761 703 766 -1689 2 2 0 19 731 787 713 -1690 2 2 0 19 732 721 791 -1691 2 2 0 19 821 749 834 -1692 2 2 0 19 720 743 821 -1693 2 2 0 19 749 821 743 -1694 2 2 0 19 743 703 777 -1695 2 2 0 19 777 749 743 -1696 2 2 0 19 850 749 777 -1697 2 2 0 19 757 789 755 -1698 2 2 0 19 839 746 838 -1699 2 2 0 19 820 746 839 -1700 2 2 0 19 693 797 800 -1701 2 2 0 19 800 797 758 -1702 2 2 0 19 758 797 760 -1703 2 2 0 19 746 750 838 -1704 2 2 0 19 733 808 763 -1705 2 2 0 19 693 800 692 -1706 2 2 0 19 731 699 787 -1707 2 2 0 19 735 739 699 -1708 2 2 0 19 691 725 829 -1709 2 2 0 19 744 700 781 -1710 2 2 0 19 700 764 781 -1711 2 2 0 19 753 800 758 -1712 2 2 0 19 778 742 748 -1713 2 2 0 19 781 746 744 -1714 2 2 0 19 731 728 792 -1715 2 2 0 19 748 742 822 -1716 2 2 0 19 746 820 744 -1717 2 2 0 19 751 757 807 -1718 2 2 0 19 764 733 814 -1719 2 2 0 19 755 709 757 -1720 2 2 0 19 709 807 757 -1721 2 2 0 23 2 26 998 -1722 2 2 0 23 2 998 149 -1723 2 2 0 23 4 996 40 -1724 2 2 0 23 4 158 996 -1725 2 2 0 23 9 997 101 -1726 2 2 0 23 9 157 997 -1727 2 2 0 23 10 115 995 -1728 2 2 0 23 10 995 166 -1729 2 2 0 23 27 905 26 -1730 2 2 0 23 905 998 26 -1731 2 2 0 23 27 28 909 -1732 2 2 0 23 905 27 909 -1733 2 2 0 23 29 885 28 -1734 2 2 0 23 885 909 28 -1735 2 2 0 23 29 30 970 -1736 2 2 0 23 885 29 970 -1737 2 2 0 23 31 1007 30 -1738 2 2 0 23 970 30 1007 -1739 2 2 0 23 32 920 31 -1740 2 2 0 23 920 1007 31 -1741 2 2 0 23 33 978 32 -1742 2 2 0 23 920 32 978 -1743 2 2 0 23 34 954 33 -1744 2 2 0 23 33 954 978 -1745 2 2 0 23 34 35 958 -1746 2 2 0 23 34 958 954 -1747 2 2 0 23 35 36 986 -1748 2 2 0 23 35 986 958 -1749 2 2 0 23 37 972 36 -1750 2 2 0 23 972 986 36 -1751 2 2 0 23 37 38 890 -1752 2 2 0 23 890 972 37 -1753 2 2 0 23 39 910 38 -1754 2 2 0 23 890 38 910 -1755 2 2 0 23 39 40 903 -1756 2 2 0 23 903 910 39 -1757 2 2 0 23 903 40 996 -1758 2 2 0 23 102 101 906 -1759 2 2 0 23 906 101 997 -1760 2 2 0 23 102 907 103 -1761 2 2 0 23 906 907 102 -1762 2 2 0 23 104 103 886 -1763 2 2 0 23 886 103 907 -1764 2 2 0 23 104 971 105 -1765 2 2 0 23 886 971 104 -1766 2 2 0 23 106 105 1008 -1767 2 2 0 23 971 1008 105 -1768 2 2 0 23 107 106 919 -1769 2 2 0 23 919 106 1008 -1770 2 2 0 23 108 107 979 -1771 2 2 0 23 919 979 107 -1772 2 2 0 23 109 108 955 -1773 2 2 0 23 108 979 955 -1774 2 2 0 23 109 959 110 -1775 2 2 0 23 109 955 959 -1776 2 2 0 23 110 987 111 -1777 2 2 0 23 110 959 987 -1778 2 2 0 23 112 111 973 -1779 2 2 0 23 973 111 987 -1780 2 2 0 23 112 889 113 -1781 2 2 0 23 889 112 973 -1782 2 2 0 23 114 113 908 -1783 2 2 0 23 889 908 113 -1784 2 2 0 23 114 904 115 -1785 2 2 0 23 904 114 908 -1786 2 2 0 23 904 995 115 -1787 2 2 0 23 150 149 982 -1788 2 2 0 23 149 998 982 -1789 2 2 0 23 151 150 976 -1790 2 2 0 23 150 982 976 -1791 2 2 0 23 151 897 152 -1792 2 2 0 23 897 151 953 -1793 2 2 0 23 151 976 953 -1794 2 2 0 23 153 152 991 -1795 2 2 0 23 897 991 152 -1796 2 2 0 23 153 980 154 -1797 2 2 0 23 153 991 980 -1798 2 2 0 23 154 1013 155 -1799 2 2 0 23 154 980 1013 -1800 2 2 0 23 155 999 156 -1801 2 2 0 23 999 155 1013 -1802 2 2 0 23 156 894 157 -1803 2 2 0 23 894 156 999 -1804 2 2 0 23 157 894 997 -1805 2 2 0 23 159 891 158 -1806 2 2 0 23 158 891 996 -1807 2 2 0 23 160 956 159 -1808 2 2 0 23 891 159 956 -1809 2 2 0 23 160 161 896 -1810 2 2 0 23 160 896 956 -1811 2 2 0 23 162 992 161 -1812 2 2 0 23 896 161 992 -1813 2 2 0 23 162 163 981 -1814 2 2 0 23 162 981 992 -1815 2 2 0 23 164 1010 163 -1816 2 2 0 23 163 1010 981 -1817 2 2 0 23 164 165 957 -1818 2 2 0 23 164 898 1010 -1819 2 2 0 23 164 957 898 -1820 2 2 0 23 165 166 893 -1821 2 2 0 23 893 957 165 -1822 2 2 0 23 166 995 893 -1823 2 2 0 23 1003 1000 1002 -1824 2 2 0 23 990 1003 1002 -1825 2 2 0 23 877 873 1003 -1826 2 2 0 23 1003 873 922 -1827 2 2 0 23 1000 1003 922 -1828 2 2 0 23 877 1003 990 -1829 2 2 0 23 989 924 1001 -1830 2 2 0 23 924 989 1016 -1831 2 2 0 23 921 876 989 -1832 2 2 0 23 989 1009 921 -1833 2 2 0 23 876 1016 989 -1834 2 2 0 23 1009 989 1001 -1835 2 2 0 23 868 943 928 -1836 2 2 0 23 911 943 868 -1837 2 2 0 23 878 943 917 -1838 2 2 0 23 878 965 943 -1839 2 2 0 23 943 911 917 -1840 2 2 0 23 928 943 965 -1841 2 2 0 23 924 1011 926 -1842 2 2 0 23 926 858 924 -1843 2 2 0 23 926 1011 930 -1844 2 2 0 23 930 964 926 -1845 2 2 0 23 858 926 1015 -1846 2 2 0 23 964 1015 926 -1847 2 2 0 23 881 933 866 -1848 2 2 0 23 930 866 933 -1849 2 2 0 23 881 866 937 -1850 2 2 0 23 866 930 948 -1851 2 2 0 23 913 937 866 -1852 2 2 0 23 913 866 948 -1853 2 2 0 23 893 904 865 -1854 2 2 0 23 893 865 901 -1855 2 2 0 23 901 865 952 -1856 2 2 0 23 865 889 952 -1857 2 2 0 23 904 908 865 -1858 2 2 0 23 889 865 908 -1859 2 2 0 23 973 987 917 -1860 2 2 0 23 917 911 973 -1861 2 2 0 23 889 973 911 -1862 2 2 0 23 895 977 963 -1863 2 2 0 23 977 927 963 -1864 2 2 0 23 895 859 977 -1865 2 2 0 23 927 977 966 -1866 2 2 0 23 977 859 922 -1867 2 2 0 23 966 977 922 -1868 2 2 0 23 972 918 986 -1869 2 2 0 23 918 972 912 -1870 2 2 0 23 986 918 958 -1871 2 2 0 23 879 918 942 -1872 2 2 0 23 942 918 912 -1873 2 2 0 23 918 879 1006 -1874 2 2 0 23 918 1006 958 -1875 2 2 0 23 894 863 906 -1876 2 2 0 23 997 894 906 -1877 2 2 0 23 894 899 863 -1878 2 2 0 23 894 999 899 -1879 2 2 0 23 955 985 923 -1880 2 2 0 23 959 955 923 -1881 2 2 0 23 967 923 985 -1882 2 2 0 23 917 923 878 -1883 2 2 0 23 923 967 878 -1884 2 2 0 23 917 959 923 -1885 2 2 0 23 900 949 880 -1886 2 2 0 23 880 940 900 -1887 2 2 0 23 892 862 900 -1888 2 2 0 23 900 862 949 -1889 2 2 0 23 892 900 953 -1890 2 2 0 23 940 953 900 -1891 2 2 0 23 969 871 925 -1892 2 2 0 23 875 871 969 -1893 2 2 0 23 961 1004 969 -1894 2 2 0 23 925 961 969 -1895 2 2 0 23 947 969 1004 -1896 2 2 0 23 947 875 969 -1897 2 2 0 23 883 868 1005 -1898 2 2 0 23 883 939 868 -1899 2 2 0 23 1005 944 883 -1900 2 2 0 23 883 944 901 -1901 2 2 0 23 939 883 952 -1902 2 2 0 23 901 952 883 -1903 2 2 0 23 871 875 994 -1904 2 2 0 23 871 994 877 -1905 2 2 0 23 925 871 990 -1906 2 2 0 23 871 877 990 -1907 2 2 0 23 988 1010 898 -1908 2 2 0 23 1010 988 981 -1909 2 2 0 23 938 951 882 -1910 2 2 0 23 938 890 951 -1911 2 2 0 23 882 869 938 -1912 2 2 0 23 912 890 938 -1913 2 2 0 23 912 938 869 -1914 2 2 0 23 890 912 972 -1915 2 2 0 23 920 916 1007 -1916 2 2 0 23 970 1007 916 -1917 2 2 0 23 868 928 1005 -1918 2 2 0 23 911 868 939 -1919 2 2 0 23 902 956 896 -1920 2 2 0 23 941 902 896 -1921 2 2 0 23 941 896 946 -1922 2 2 0 23 896 992 946 -1923 2 2 0 23 867 947 929 -1924 2 2 0 23 929 931 867 -1925 2 2 0 23 880 936 867 -1926 2 2 0 23 880 867 931 -1927 2 2 0 23 914 947 867 -1928 2 2 0 23 914 867 936 -1929 2 2 0 23 955 979 985 -1930 2 2 0 23 887 960 860 -1931 2 2 0 23 887 934 960 -1932 2 2 0 23 944 960 988 -1933 2 2 0 23 944 1005 960 -1934 2 2 0 23 860 960 975 -1935 2 2 0 23 960 934 988 -1936 2 2 0 23 975 960 1005 -1937 2 2 0 23 933 881 984 -1938 2 2 0 23 974 933 984 -1939 2 2 0 23 933 974 930 -1940 2 2 0 23 985 993 967 -1941 2 2 0 23 979 993 985 -1942 2 2 0 23 870 876 993 -1943 2 2 0 23 967 993 876 -1944 2 2 0 23 870 993 874 -1945 2 2 0 23 993 919 874 -1946 2 2 0 23 919 993 979 -1947 2 2 0 23 995 904 893 -1948 2 2 0 23 901 957 893 -1949 2 2 0 23 902 882 951 -1950 2 2 0 23 902 951 864 -1951 2 2 0 23 864 951 890 -1952 2 2 0 23 887 860 932 -1953 2 2 0 23 932 941 887 -1954 2 2 0 23 946 887 941 -1955 2 2 0 23 887 946 934 -1956 2 2 0 23 872 965 878 -1957 2 2 0 23 878 967 872 -1958 2 2 0 23 886 913 971 -1959 2 2 0 23 863 950 886 -1960 2 2 0 23 886 907 863 -1961 2 2 0 23 937 886 950 -1962 2 2 0 23 913 886 937 -1963 2 2 0 23 994 875 920 -1964 2 2 0 23 920 978 994 -1965 2 2 0 23 920 875 916 -1966 2 2 0 23 975 895 963 -1967 2 2 0 23 932 860 963 -1968 2 2 0 23 932 963 927 -1969 2 2 0 23 860 975 963 -1970 2 2 0 23 861 984 881 -1971 2 2 0 23 881 899 861 -1972 2 2 0 23 899 881 950 -1973 2 2 0 23 937 950 881 -1974 2 2 0 23 916 914 970 -1975 2 2 0 23 885 970 914 -1976 2 2 0 23 971 915 1008 -1977 2 2 0 23 915 971 913 -1978 2 2 0 23 919 1008 915 -1979 2 2 0 23 948 915 913 -1980 2 2 0 23 874 915 948 -1981 2 2 0 23 919 915 874 -1982 2 2 0 23 1011 924 870 -1983 2 2 0 23 924 1016 870 -1984 2 2 0 23 858 1001 924 -1985 2 2 0 23 996 891 903 -1986 2 2 0 23 876 921 872 -1987 2 2 0 23 872 921 965 -1988 2 2 0 23 965 921 983 -1989 2 2 0 23 983 921 1009 -1990 2 2 0 23 991 935 980 -1991 2 2 0 23 991 945 935 -1992 2 2 0 23 968 980 935 -1993 2 2 0 23 884 1014 935 -1994 2 2 0 23 935 945 884 -1995 2 2 0 23 1014 968 935 -1996 2 2 0 23 895 975 928 -1997 2 2 0 23 928 983 895 -1998 2 2 0 23 895 983 859 -1999 2 2 0 23 888 984 884 -2000 2 2 0 23 984 1014 884 -2001 2 2 0 23 888 857 984 -2002 2 2 0 23 857 974 984 -2003 2 2 0 23 984 861 1014 -2004 2 2 0 23 897 945 991 -2005 2 2 0 23 953 945 897 -2006 2 2 0 23 987 959 917 -2007 2 2 0 23 1013 980 968 -2008 2 2 0 23 927 869 932 -2009 2 2 0 23 882 932 869 -2010 2 2 0 23 932 882 941 -2011 2 2 0 23 876 870 1016 -2012 2 2 0 23 872 967 876 -2013 2 2 0 23 994 1012 877 -2014 2 2 0 23 978 1012 994 -2015 2 2 0 23 944 988 898 -2016 2 2 0 23 944 898 901 -2017 2 2 0 23 888 884 945 -2018 2 2 0 23 888 931 857 -2019 2 2 0 23 931 888 940 -2020 2 2 0 23 945 940 888 -2021 2 2 0 23 882 902 941 -2022 2 2 0 23 902 891 956 -2023 2 2 0 23 891 902 864 -2024 2 2 0 23 929 1004 962 -2025 2 2 0 23 931 929 962 -2026 2 2 0 23 947 1004 929 -2027 2 2 0 23 906 863 907 -2028 2 2 0 23 962 974 857 -2029 2 2 0 23 931 962 857 -2030 2 2 0 23 962 1004 961 -2031 2 2 0 23 961 1015 962 -2032 2 2 0 23 962 964 974 -2033 2 2 0 23 1015 964 962 -2034 2 2 0 23 874 1011 870 -2035 2 2 0 23 948 930 1011 -2036 2 2 0 23 948 1011 874 -2037 2 2 0 23 892 905 862 -2038 2 2 0 23 905 909 862 -2039 2 2 0 23 905 892 982 -2040 2 2 0 23 998 905 982 -2041 2 2 0 23 1000 1001 1002 -2042 2 2 0 23 858 1002 1001 -2043 2 2 0 23 858 925 1002 -2044 2 2 0 23 990 1002 925 -2045 2 2 0 23 1006 873 1012 -2046 2 2 0 23 873 877 1012 -2047 2 2 0 23 879 873 1006 -2048 2 2 0 23 873 879 966 -2049 2 2 0 23 873 966 922 -2050 2 2 0 23 869 927 942 -2051 2 2 0 23 927 966 942 -2052 2 2 0 23 988 934 981 -2053 2 2 0 23 928 965 983 -2054 2 2 0 23 936 880 949 -2055 2 2 0 23 931 940 880 -2056 2 2 0 23 899 950 863 -2057 2 2 0 23 885 862 909 -2058 2 2 0 23 862 885 949 -2059 2 2 0 23 975 1005 928 -2060 2 2 0 23 1012 954 1006 -2061 2 2 0 23 954 1012 978 -2062 2 2 0 23 939 952 889 -2063 2 2 0 23 892 953 976 -2064 2 2 0 23 982 892 976 -2065 2 2 0 23 961 925 858 -2066 2 2 0 23 858 1015 961 -2067 2 2 0 23 940 945 953 -2068 2 2 0 23 968 899 999 -2069 2 2 0 23 999 1013 968 -2070 2 2 0 23 891 864 903 -2071 2 2 0 23 1009 1001 1000 -2072 2 2 0 23 859 1009 1000 -2073 2 2 0 23 859 1000 922 -2074 2 2 0 23 942 966 879 -2075 2 2 0 23 912 869 942 -2076 2 2 0 23 890 910 864 -2077 2 2 0 23 901 898 957 -2078 2 2 0 23 903 864 910 -2079 2 2 0 23 1006 954 958 -2080 2 2 0 23 875 947 916 -2081 2 2 0 23 947 914 916 -2082 2 2 0 23 861 899 968 -2083 2 2 0 23 968 1014 861 -2084 2 2 0 23 983 1009 859 -2085 2 2 0 23 974 964 930 -2086 2 2 0 23 936 949 885 -2087 2 2 0 23 914 936 885 -2088 2 2 0 23 911 939 889 -2089 2 2 0 23 992 981 934 -2090 2 2 0 23 934 946 992 -2091 2 2 0 27 4 41 1158 -2092 2 2 0 27 4 1158 158 -2093 2 2 0 27 5 1156 55 -2094 2 2 0 27 5 131 1156 -2095 2 2 0 27 6 130 1155 -2096 2 2 0 27 6 1155 139 -2097 2 2 0 27 10 1157 116 -2098 2 2 0 27 10 166 1157 -2099 2 2 0 27 42 1065 41 -2100 2 2 0 27 1065 1158 41 -2101 2 2 0 27 42 43 1069 -2102 2 2 0 27 1065 42 1069 -2103 2 2 0 27 44 1045 43 -2104 2 2 0 27 1045 1069 43 -2105 2 2 0 27 44 45 1130 -2106 2 2 0 27 1045 44 1130 -2107 2 2 0 27 46 1167 45 -2108 2 2 0 27 1130 45 1167 -2109 2 2 0 27 47 1080 46 -2110 2 2 0 27 1080 1167 46 -2111 2 2 0 27 48 1138 47 -2112 2 2 0 27 1080 47 1138 -2113 2 2 0 27 49 1114 48 -2114 2 2 0 27 48 1114 1138 -2115 2 2 0 27 49 50 1118 -2116 2 2 0 27 49 1118 1114 -2117 2 2 0 27 50 51 1146 -2118 2 2 0 27 50 1146 1118 -2119 2 2 0 27 52 1132 51 -2120 2 2 0 27 1132 1146 51 -2121 2 2 0 27 52 53 1050 -2122 2 2 0 27 1050 1132 52 -2123 2 2 0 27 54 1070 53 -2124 2 2 0 27 1050 53 1070 -2125 2 2 0 27 54 55 1063 -2126 2 2 0 27 1063 1070 54 -2127 2 2 0 27 1063 55 1156 -2128 2 2 0 27 117 116 1066 -2129 2 2 0 27 1066 116 1157 -2130 2 2 0 27 117 1067 118 -2131 2 2 0 27 1066 1067 117 -2132 2 2 0 27 119 118 1046 -2133 2 2 0 27 1046 118 1067 -2134 2 2 0 27 119 1131 120 -2135 2 2 0 27 1046 1131 119 -2136 2 2 0 27 121 120 1168 -2137 2 2 0 27 1131 1168 120 -2138 2 2 0 27 122 121 1079 -2139 2 2 0 27 1079 121 1168 -2140 2 2 0 27 123 122 1139 -2141 2 2 0 27 1079 1139 122 -2142 2 2 0 27 124 123 1115 -2143 2 2 0 27 123 1139 1115 -2144 2 2 0 27 124 1119 125 -2145 2 2 0 27 124 1115 1119 -2146 2 2 0 27 125 1147 126 -2147 2 2 0 27 125 1119 1147 -2148 2 2 0 27 127 126 1133 -2149 2 2 0 27 1133 126 1147 -2150 2 2 0 27 127 1049 128 -2151 2 2 0 27 1049 127 1133 -2152 2 2 0 27 129 128 1068 -2153 2 2 0 27 1049 1068 128 -2154 2 2 0 27 129 1064 130 -2155 2 2 0 27 1064 129 1068 -2156 2 2 0 27 1064 1155 130 -2157 2 2 0 27 132 1051 131 -2158 2 2 0 27 131 1051 1156 -2159 2 2 0 27 133 1116 132 -2160 2 2 0 27 1051 132 1116 -2161 2 2 0 27 133 134 1056 -2162 2 2 0 27 133 1056 1116 -2163 2 2 0 27 135 1152 134 -2164 2 2 0 27 1056 134 1152 -2165 2 2 0 27 135 136 1141 -2166 2 2 0 27 135 1141 1152 -2167 2 2 0 27 137 1170 136 -2168 2 2 0 27 136 1170 1141 -2169 2 2 0 27 137 138 1117 -2170 2 2 0 27 137 1058 1170 -2171 2 2 0 27 137 1117 1058 -2172 2 2 0 27 138 139 1053 -2173 2 2 0 27 1053 1117 138 -2174 2 2 0 27 139 1155 1053 -2175 2 2 0 27 159 158 1142 -2176 2 2 0 27 158 1158 1142 -2177 2 2 0 27 160 159 1136 -2178 2 2 0 27 159 1142 1136 -2179 2 2 0 27 160 1057 161 -2180 2 2 0 27 1057 160 1113 -2181 2 2 0 27 160 1136 1113 -2182 2 2 0 27 162 161 1151 -2183 2 2 0 27 1057 1151 161 -2184 2 2 0 27 162 1140 163 -2185 2 2 0 27 162 1151 1140 -2186 2 2 0 27 163 1173 164 -2187 2 2 0 27 163 1140 1173 -2188 2 2 0 27 164 1159 165 -2189 2 2 0 27 1159 164 1173 -2190 2 2 0 27 165 1054 166 -2191 2 2 0 27 1054 165 1159 -2192 2 2 0 27 166 1054 1157 -2193 2 2 0 27 1054 1159 1059 -2194 2 2 0 27 1157 1054 1066 -2195 2 2 0 27 1054 1023 1066 -2196 2 2 0 27 1054 1059 1023 -2197 2 2 0 27 1096 1109 1045 -2198 2 2 0 27 1022 1045 1109 -2199 2 2 0 27 1074 1096 1045 -2200 2 2 0 27 1045 1022 1069 -2201 2 2 0 27 1045 1130 1074 -2202 2 2 0 27 1149 1084 1161 -2203 2 2 0 27 1084 1149 1176 -2204 2 2 0 27 1169 1149 1161 -2205 2 2 0 27 1081 1036 1149 -2206 2 2 0 27 1036 1176 1149 -2207 2 2 0 27 1149 1169 1081 -2208 2 2 0 27 1063 1024 1070 -2209 2 2 0 27 1050 1070 1024 -2210 2 2 0 27 1060 1109 1040 -2211 2 2 0 27 1060 1022 1109 -2212 2 2 0 27 1040 1100 1060 -2213 2 2 0 27 1052 1060 1113 -2214 2 2 0 27 1100 1113 1060 -2215 2 2 0 27 1052 1022 1060 -2216 2 2 0 27 1096 1040 1109 -2217 2 2 0 27 1034 1075 1108 -2218 2 2 0 27 1108 1171 1034 -2219 2 2 0 27 1108 1075 1073 -2220 2 2 0 27 1108 1090 1171 -2221 2 2 0 27 1026 1090 1108 -2222 2 2 0 27 1073 1026 1108 -2223 2 2 0 27 1074 1107 1027 -2224 2 2 0 27 1027 1107 1089 -2225 2 2 0 27 1107 1129 1164 -2226 2 2 0 27 1107 1164 1089 -2227 2 2 0 27 1035 1107 1076 -2228 2 2 0 27 1107 1035 1129 -2229 2 2 0 27 1107 1074 1076 -2230 2 2 0 27 1093 1041 1144 -2231 2 2 0 27 1041 1093 1026 -2232 2 2 0 27 1134 1093 1144 -2233 2 2 0 27 1093 1134 1090 -2234 2 2 0 27 1090 1026 1093 -2235 2 2 0 27 1172 1114 1166 -2236 2 2 0 27 1114 1172 1138 -2237 2 2 0 27 1166 1114 1118 -2238 2 2 0 27 1021 1144 1041 -2239 2 2 0 27 1041 1059 1021 -2240 2 2 0 27 1128 1174 1021 -2241 2 2 0 27 1021 1059 1128 -2242 2 2 0 27 1144 1021 1174 -2243 2 2 0 27 1148 1094 1141 -2244 2 2 0 27 1152 1141 1094 -2245 2 2 0 27 1120 1094 1148 -2246 2 2 0 27 1094 1106 1152 -2247 2 2 0 27 1047 1106 1094 -2248 2 2 0 27 1047 1094 1120 -2249 2 2 0 27 1101 1056 1106 -2250 2 2 0 27 1101 1062 1056 -2251 2 2 0 27 1056 1152 1106 -2252 2 2 0 27 1062 1116 1056 -2253 2 2 0 27 1102 1126 1038 -2254 2 2 0 27 1087 1126 1102 -2255 2 2 0 27 1033 1038 1126 -2256 2 2 0 27 1087 1137 1126 -2257 2 2 0 27 1126 1137 1082 -2258 2 2 0 27 1033 1126 1082 -2259 2 2 0 27 1043 1028 1165 -2260 2 2 0 27 1028 1088 1165 -2261 2 2 0 27 1165 1104 1043 -2262 2 2 0 27 1104 1165 1120 -2263 2 2 0 27 1135 1165 1088 -2264 2 2 0 27 1135 1120 1165 -2265 2 2 0 27 1079 1075 1034 -2266 2 2 0 27 1034 1171 1030 -2267 2 2 0 27 1153 1079 1034 -2268 2 2 0 27 1030 1153 1034 -2269 2 2 0 27 1072 1029 1102 -2270 2 2 0 27 1102 1078 1072 -2271 2 2 0 27 1038 1078 1102 -2272 2 2 0 27 1029 1087 1102 -2273 2 2 0 27 1040 1096 1027 -2274 2 2 0 27 1074 1027 1096 -2275 2 2 0 27 1040 1027 1091 -2276 2 2 0 27 1089 1091 1027 -2277 2 2 0 27 1122 1164 1121 -2278 2 2 0 27 1089 1164 1122 -2279 2 2 0 27 1121 1164 1129 -2280 2 2 0 27 1138 1172 1154 -2281 2 2 0 27 1154 1172 1037 -2282 2 2 0 27 1166 1033 1172 -2283 2 2 0 27 1033 1037 1172 -2284 2 2 0 27 1128 1059 1159 -2285 2 2 0 27 1159 1173 1128 -2286 2 2 0 27 1079 1168 1075 -2287 2 2 0 27 1131 1075 1168 -2288 2 2 0 27 1075 1131 1073 -2289 2 2 0 27 1039 1103 1077 -2290 2 2 0 27 1103 1071 1077 -2291 2 2 0 27 1071 1103 1028 -2292 2 2 0 27 1028 1103 1088 -2293 2 2 0 27 1039 1125 1103 -2294 2 2 0 27 1088 1103 1125 -2295 2 2 0 27 1048 1144 1044 -2296 2 2 0 27 1048 1017 1144 -2297 2 2 0 27 1091 1048 1100 -2298 2 2 0 27 1105 1100 1048 -2299 2 2 0 27 1048 1091 1017 -2300 2 2 0 27 1048 1044 1105 -2301 2 2 0 27 1084 1171 1086 -2302 2 2 0 27 1171 1084 1030 -2303 2 2 0 27 1086 1171 1090 -2304 2 2 0 27 1086 1018 1084 -2305 2 2 0 27 1018 1161 1084 -2306 2 2 0 27 1084 1176 1030 -2307 2 2 0 27 1055 1019 1137 -2308 2 2 0 27 1055 1143 1019 -2309 2 2 0 27 1055 1137 1123 -2310 2 2 0 27 1135 1055 1123 -2311 2 2 0 27 1088 1143 1055 -2312 2 2 0 27 1055 1135 1088 -2313 2 2 0 27 1053 1064 1025 -2314 2 2 0 27 1064 1068 1025 -2315 2 2 0 27 1025 1049 1112 -2316 2 2 0 27 1061 1025 1112 -2317 2 2 0 27 1053 1025 1061 -2318 2 2 0 27 1049 1025 1068 -2319 2 2 0 27 1106 1047 1101 -2320 2 2 0 27 1092 1101 1047 -2321 2 2 0 27 1042 1062 1101 -2322 2 2 0 27 1092 1042 1101 -2323 2 2 0 27 1050 1072 1132 -2324 2 2 0 27 1078 1132 1072 -2325 2 2 0 27 1132 1078 1146 -2326 2 2 0 27 1091 1100 1040 -2327 2 2 0 27 1113 1105 1057 -2328 2 2 0 27 1057 1105 1151 -2329 2 2 0 27 1170 1148 1141 -2330 2 2 0 27 1059 1041 1110 -2331 2 2 0 27 1097 1110 1041 -2332 2 2 0 27 1041 1026 1097 -2333 2 2 0 27 1147 1119 1077 -2334 2 2 0 27 1077 1119 1083 -2335 2 2 0 27 1119 1115 1083 -2336 2 2 0 27 1079 1153 1139 -2337 2 2 0 27 1031 1035 1154 -2338 2 2 0 27 1154 1035 1080 -2339 2 2 0 27 1035 1031 1129 -2340 2 2 0 27 1080 1035 1076 -2341 2 2 0 27 1071 1028 1099 -2342 2 2 0 27 1043 1099 1028 -2343 2 2 0 27 1099 1043 1112 -2344 2 2 0 27 1099 1112 1049 -2345 2 2 0 27 1071 1099 1049 -2346 2 2 0 27 1155 1064 1053 -2347 2 2 0 27 1104 1148 1058 -2348 2 2 0 27 1104 1120 1148 -2349 2 2 0 27 1148 1170 1058 -2350 2 2 0 27 1077 1083 1039 -2351 2 2 0 27 1077 1071 1133 -2352 2 2 0 27 1133 1147 1077 -2353 2 2 0 27 1031 1154 1037 -2354 2 2 0 27 1080 1138 1154 -2355 2 2 0 27 1039 1127 1032 -2356 2 2 0 27 1083 1127 1039 -2357 2 2 0 27 1032 1125 1039 -2358 2 2 0 27 1052 1113 1136 -2359 2 2 0 27 1100 1105 1113 -2360 2 2 0 27 1098 1050 1111 -2361 2 2 0 27 1098 1111 1042 -2362 2 2 0 27 1062 1111 1024 -2363 2 2 0 27 1062 1042 1111 -2364 2 2 0 27 1024 1111 1050 -2365 2 2 0 27 1090 1124 1086 -2366 2 2 0 27 1124 1175 1086 -2367 2 2 0 27 1018 1086 1175 -2368 2 2 0 27 1129 1031 1085 -2369 2 2 0 27 1031 1037 1150 -2370 2 2 0 27 1085 1031 1150 -2371 2 2 0 27 1174 1128 1095 -2372 2 2 0 27 1128 1140 1095 -2373 2 2 0 27 1044 1174 1095 -2374 2 2 0 27 1151 1095 1140 -2375 2 2 0 27 1095 1105 1044 -2376 2 2 0 27 1151 1105 1095 -2377 2 2 0 27 1061 1112 1043 -2378 2 2 0 27 1072 1098 1029 -2379 2 2 0 27 1072 1050 1098 -2380 2 2 0 27 1038 1033 1166 -2381 2 2 0 27 1078 1038 1166 -2382 2 2 0 27 1078 1166 1118 -2383 2 2 0 27 1127 1153 1036 -2384 2 2 0 27 1032 1127 1036 -2385 2 2 0 27 1145 1153 1127 -2386 2 2 0 27 1127 1083 1145 -2387 2 2 0 27 1049 1133 1071 -2388 2 2 0 27 1160 1161 1162 -2389 2 2 0 27 1018 1162 1161 -2390 2 2 0 27 1169 1161 1160 -2391 2 2 0 27 1173 1140 1128 -2392 2 2 0 27 1163 1160 1162 -2393 2 2 0 27 1150 1162 1085 -2394 2 2 0 27 1018 1085 1162 -2395 2 2 0 27 1150 1163 1162 -2396 2 2 0 27 1043 1104 1061 -2397 2 2 0 27 1062 1051 1116 -2398 2 2 0 27 1156 1051 1063 -2399 2 2 0 27 1051 1024 1063 -2400 2 2 0 27 1051 1062 1024 -2401 2 2 0 27 1144 1174 1044 -2402 2 2 0 27 1019 1169 1160 -2403 2 2 0 27 1019 1160 1082 -2404 2 2 0 27 1137 1019 1082 -2405 2 2 0 27 1143 1169 1019 -2406 2 2 0 27 1061 1117 1053 -2407 2 2 0 27 1142 1052 1136 -2408 2 2 0 27 1115 1139 1145 -2409 2 2 0 27 1115 1145 1083 -2410 2 2 0 27 1065 1069 1022 -2411 2 2 0 27 1158 1065 1142 -2412 2 2 0 27 1065 1052 1142 -2413 2 2 0 27 1052 1065 1022 -2414 2 2 0 27 1139 1153 1145 -2415 2 2 0 27 1066 1023 1067 -2416 2 2 0 27 1046 1067 1023 -2417 2 2 0 27 1146 1078 1118 -2418 2 2 0 27 1017 1134 1144 -2419 2 2 0 27 1076 1074 1130 -2420 2 2 0 27 1046 1073 1131 -2421 2 2 0 27 1023 1110 1046 -2422 2 2 0 27 1097 1046 1110 -2423 2 2 0 27 1073 1046 1097 -2424 2 2 0 27 1091 1122 1017 -2425 2 2 0 27 1091 1089 1122 -2426 2 2 0 27 1121 1175 1122 -2427 2 2 0 27 1175 1124 1122 -2428 2 2 0 27 1122 1124 1134 -2429 2 2 0 27 1122 1134 1017 -2430 2 2 0 27 1030 1036 1153 -2431 2 2 0 27 1036 1030 1176 -2432 2 2 0 27 1036 1081 1032 -2433 2 2 0 27 1137 1087 1123 -2434 2 2 0 27 1092 1020 1123 -2435 2 2 0 27 1092 1123 1087 -2436 2 2 0 27 1020 1135 1123 -2437 2 2 0 27 1042 1029 1098 -2438 2 2 0 27 1160 1163 1082 -2439 2 2 0 27 1059 1110 1023 -2440 2 2 0 27 1134 1124 1090 -2441 2 2 0 27 1047 1020 1092 -2442 2 2 0 27 1047 1120 1020 -2443 2 2 0 27 1042 1092 1029 -2444 2 2 0 27 1087 1029 1092 -2445 2 2 0 27 1104 1058 1061 -2446 2 2 0 27 1085 1121 1129 -2447 2 2 0 27 1018 1175 1121 -2448 2 2 0 27 1121 1085 1018 -2449 2 2 0 27 1073 1097 1026 -2450 2 2 0 27 1080 1076 1167 -2451 2 2 0 27 1130 1167 1076 -2452 2 2 0 27 1143 1081 1169 -2453 2 2 0 27 1125 1081 1143 -2454 2 2 0 27 1032 1081 1125 -2455 2 2 0 27 1037 1033 1163 -2456 2 2 0 27 1163 1033 1082 -2457 2 2 0 27 1037 1163 1150 -2458 2 2 0 27 1088 1125 1143 -2459 2 2 0 27 1061 1058 1117 -2460 2 2 0 27 1020 1120 1135 -2461 2 2 0 28 71 1513 6 -2462 2 2 0 28 6 1492 130 -2463 2 2 0 28 1513 1492 6 -2464 2 2 0 28 8 1480 85 -2465 2 2 0 28 86 1480 8 -2466 2 2 0 28 9 1501 100 -2467 2 2 0 28 9 101 1501 -2468 2 2 0 28 115 10 1506 -2469 2 2 0 28 116 1381 10 -2470 2 2 0 28 1506 10 1381 -2471 2 2 0 28 71 72 1286 -2472 2 2 0 28 1513 71 1286 -2473 2 2 0 28 1398 72 73 -2474 2 2 0 28 1286 72 1398 -2475 2 2 0 28 74 1447 73 -2476 2 2 0 28 1398 73 1447 -2477 2 2 0 28 74 75 1476 -2478 2 2 0 28 1476 1447 74 -2479 2 2 0 28 76 1207 75 -2480 2 2 0 28 1207 1476 75 -2481 2 2 0 28 77 1200 76 -2482 2 2 0 28 1200 1207 76 -2483 2 2 0 28 77 78 1289 -2484 2 2 0 28 77 1289 1200 -2485 2 2 0 28 79 1289 78 -2486 2 2 0 28 80 1424 79 -2487 2 2 0 28 79 1424 1289 -2488 2 2 0 28 80 81 1252 -2489 2 2 0 28 80 1252 1424 -2490 2 2 0 28 81 82 1429 -2491 2 2 0 28 81 1429 1252 -2492 2 2 0 28 83 1423 82 -2493 2 2 0 28 82 1423 1431 -2494 2 2 0 28 82 1431 1429 -2495 2 2 0 28 84 1198 83 -2496 2 2 0 28 83 1198 1423 -2497 2 2 0 28 85 1490 84 -2498 2 2 0 28 1490 1198 84 -2499 2 2 0 28 1490 85 1496 -2500 2 2 0 28 85 1480 1496 -2501 2 2 0 28 1495 86 87 -2502 2 2 0 28 86 1495 1488 -2503 2 2 0 28 1480 86 1488 -2504 2 2 0 28 88 1408 87 -2505 2 2 0 28 1408 1495 87 -2506 2 2 0 28 88 89 1294 -2507 2 2 0 28 1294 1408 88 -2508 2 2 0 28 90 1405 89 -2509 2 2 0 28 1294 89 1405 -2510 2 2 0 28 91 1350 90 -2511 2 2 0 28 1350 1405 90 -2512 2 2 0 28 92 1265 91 -2513 2 2 0 28 1265 1350 91 -2514 2 2 0 28 93 1450 92 -2515 2 2 0 28 1450 1265 92 -2516 2 2 0 28 93 94 1201 -2517 2 2 0 28 93 1201 1450 -2518 2 2 0 28 95 1201 94 -2519 2 2 0 28 96 1210 95 -2520 2 2 0 28 1264 1201 95 -2521 2 2 0 28 1264 95 1210 -2522 2 2 0 28 97 1290 96 -2523 2 2 0 28 1290 1210 96 -2524 2 2 0 28 98 1505 97 -2525 2 2 0 28 1505 1290 97 -2526 2 2 0 28 99 1524 98 -2527 2 2 0 28 1524 1505 98 -2528 2 2 0 28 1514 99 100 -2529 2 2 0 28 99 1203 1524 -2530 2 2 0 28 1514 1203 99 -2531 2 2 0 28 1501 1514 100 -2532 2 2 0 28 1485 101 102 -2533 2 2 0 28 1501 101 1485 -2534 2 2 0 28 103 1211 102 -2535 2 2 0 28 1484 1485 102 -2536 2 2 0 28 102 1211 1484 -2537 2 2 0 28 104 1211 103 -2538 2 2 0 28 105 1459 104 -2539 2 2 0 28 1211 104 1459 -2540 2 2 0 28 105 106 1464 -2541 2 2 0 28 1459 105 1464 -2542 2 2 0 28 106 107 1291 -2543 2 2 0 28 106 1291 1464 -2544 2 2 0 28 107 108 1436 -2545 2 2 0 28 107 1436 1291 -2546 2 2 0 28 108 109 1390 -2547 2 2 0 28 1390 1436 108 -2548 2 2 0 28 110 1498 109 -2549 2 2 0 28 1498 1390 109 -2550 2 2 0 28 110 111 1473 -2551 2 2 0 28 1473 1498 110 -2552 2 2 0 28 1473 111 112 -2553 2 2 0 28 112 113 1224 -2554 2 2 0 28 1473 112 1224 -2555 2 2 0 28 113 114 1382 -2556 2 2 0 28 1382 1224 113 -2557 2 2 0 28 114 115 1402 -2558 2 2 0 28 114 1402 1382 -2559 2 2 0 28 1506 1402 115 -2560 2 2 0 28 117 1508 116 -2561 2 2 0 28 1508 1381 116 -2562 2 2 0 28 117 118 1273 -2563 2 2 0 28 1273 1508 117 -2564 2 2 0 28 118 119 1250 -2565 2 2 0 28 1250 1273 118 -2566 2 2 0 28 120 1262 119 -2567 2 2 0 28 1262 1250 119 -2568 2 2 0 28 1394 120 121 -2569 2 2 0 28 120 1394 1262 -2570 2 2 0 28 121 122 1208 -2571 2 2 0 28 121 1208 1394 -2572 2 2 0 28 122 123 1202 -2573 2 2 0 28 1208 122 1202 -2574 2 2 0 28 124 1478 123 -2575 2 2 0 28 123 1478 1202 -2576 2 2 0 28 125 1466 124 -2577 2 2 0 28 124 1466 1478 -2578 2 2 0 28 125 126 1295 -2579 2 2 0 28 125 1295 1466 -2580 2 2 0 28 126 127 1271 -2581 2 2 0 28 1271 1295 126 -2582 2 2 0 28 127 128 1205 -2583 2 2 0 28 1271 127 1205 -2584 2 2 0 28 129 1502 128 -2585 2 2 0 28 1502 1205 128 -2586 2 2 0 28 130 1515 129 -2587 2 2 0 28 1515 1502 129 -2588 2 2 0 28 130 1492 1515 -2589 2 2 0 28 1400 1252 1429 -2590 2 2 0 28 1344 1424 1252 -2591 2 2 0 28 1252 1400 1344 -2592 2 2 0 28 1375 1359 1326 -2593 2 2 0 28 1326 1359 1198 -2594 2 2 0 28 1323 1215 1326 -2595 2 2 0 28 1326 1491 1323 -2596 2 2 0 28 1326 1215 1375 -2597 2 2 0 28 1198 1491 1326 -2598 2 2 0 28 1258 1457 1393 -2599 2 2 0 28 1258 1393 1387 -2600 2 2 0 28 1387 1391 1258 -2601 2 2 0 28 1258 1391 1445 -2602 2 2 0 28 1457 1258 1445 -2603 2 2 0 28 1284 1507 1520 -2604 2 2 0 28 1521 1520 1507 -2605 2 2 0 28 1284 1525 1507 -2606 2 2 0 28 1485 1521 1507 -2607 2 2 0 28 1501 1507 1525 -2608 2 2 0 28 1507 1501 1485 -2609 2 2 0 28 1357 1348 1511 -2610 2 2 0 28 1357 1511 1224 -2611 2 2 0 28 1348 1298 1511 -2612 2 2 0 28 1511 1298 1510 -2613 2 2 0 28 1511 1510 1473 -2614 2 2 0 28 1473 1224 1511 -2615 2 2 0 28 1398 1447 1460 -2616 2 2 0 28 1460 1447 1476 -2617 2 2 0 28 1283 1522 1487 -2618 2 2 0 28 1283 1515 1522 -2619 2 2 0 28 1504 1522 1286 -2620 2 2 0 28 1522 1513 1286 -2621 2 2 0 28 1504 1487 1522 -2622 2 2 0 28 1522 1515 1492 -2623 2 2 0 28 1492 1513 1522 -2624 2 2 0 28 1371 1191 1411 -2625 2 2 0 28 1191 1361 1411 -2626 2 2 0 28 1371 1448 1191 -2627 2 2 0 28 1386 1191 1448 -2628 2 2 0 28 1361 1191 1386 -2629 2 2 0 28 1460 1468 1518 -2630 2 2 0 28 1460 1518 1504 -2631 2 2 0 28 1487 1518 1468 -2632 2 2 0 28 1487 1504 1518 -2633 2 2 0 28 1428 1499 1488 -2634 2 2 0 28 1311 1499 1428 -2635 2 2 0 28 1311 1323 1499 -2636 2 2 0 28 1491 1499 1323 -2637 2 2 0 28 1499 1480 1488 -2638 2 2 0 28 1480 1499 1496 -2639 2 2 0 28 1499 1491 1496 -2640 2 2 0 28 1406 1428 1456 -2641 2 2 0 28 1456 1427 1406 -2642 2 2 0 28 1428 1406 1392 -2643 2 2 0 28 1392 1406 1234 -2644 2 2 0 28 1406 1427 1234 -2645 2 2 0 28 1431 1423 1359 -2646 2 2 0 28 1359 1423 1198 -2647 2 2 0 28 1457 1380 1393 -2648 2 2 0 28 1393 1366 1387 -2649 2 2 0 28 1366 1393 1209 -2650 2 2 0 28 1380 1209 1393 -2651 2 2 0 28 1414 1257 1360 -2652 2 2 0 28 1257 1414 1200 -2653 2 2 0 28 1437 1414 1360 -2654 2 2 0 28 1280 1200 1414 -2655 2 2 0 28 1437 1280 1414 -2656 2 2 0 28 1449 1391 1387 -2657 2 2 0 28 1222 1391 1449 -2658 2 2 0 28 1356 1391 1222 -2659 2 2 0 28 1445 1391 1356 -2660 2 2 0 28 1331 1469 1186 -2661 2 2 0 28 1301 1331 1186 -2662 2 2 0 28 1358 1300 1331 -2663 2 2 0 28 1225 1358 1331 -2664 2 2 0 28 1331 1300 1469 -2665 2 2 0 28 1331 1301 1309 -2666 2 2 0 28 1225 1331 1309 -2667 2 2 0 28 1430 1360 1257 -2668 2 2 0 28 1289 1430 1257 -2669 2 2 0 28 1257 1200 1289 -2670 2 2 0 28 1203 1494 1524 -2671 2 2 0 28 1203 1525 1526 -2672 2 2 0 28 1525 1203 1514 -2673 2 2 0 28 1203 1526 1494 -2674 2 2 0 28 1415 1461 1465 -2675 2 2 0 28 1415 1465 1464 -2676 2 2 0 28 1461 1481 1465 -2677 2 2 0 28 1459 1464 1465 -2678 2 2 0 28 1459 1465 1481 -2679 2 2 0 28 1403 1401 1247 -2680 2 2 0 28 1247 1346 1403 -2681 2 2 0 28 1399 1247 1401 -2682 2 2 0 28 1247 1399 1362 -2683 2 2 0 28 1247 1362 1346 -2684 2 2 0 28 1229 1420 1413 -2685 2 2 0 28 1420 1338 1413 -2686 2 2 0 28 1259 1195 1420 -2687 2 2 0 28 1440 1259 1420 -2688 2 2 0 28 1338 1420 1195 -2689 2 2 0 28 1229 1440 1420 -2690 2 2 0 28 1291 1452 1464 -2691 2 2 0 28 1291 1436 1452 -2692 2 2 0 28 1352 1316 1186 -2693 2 2 0 28 1352 1186 1489 -2694 2 2 0 28 1469 1489 1186 -2695 2 2 0 28 1301 1186 1316 -2696 2 2 0 28 1277 1261 1500 -2697 2 2 0 28 1277 1500 1274 -2698 2 2 0 28 1206 1500 1261 -2699 2 2 0 28 1206 1274 1500 -2700 2 2 0 28 1335 1355 1192 -2701 2 2 0 28 1354 1192 1355 -2702 2 2 0 28 1335 1192 1341 -2703 2 2 0 28 1318 1192 1354 -2704 2 2 0 28 1318 1336 1192 -2705 2 2 0 28 1341 1192 1362 -2706 2 2 0 28 1336 1362 1192 -2707 2 2 0 28 1246 1264 1183 -2708 2 2 0 28 1183 1275 1246 -2709 2 2 0 28 1210 1183 1264 -2710 2 2 0 28 1183 1290 1263 -2711 2 2 0 28 1183 1263 1503 -2712 2 2 0 28 1210 1290 1183 -2713 2 2 0 28 1183 1503 1275 -2714 2 2 0 28 1456 1428 1488 -2715 2 2 0 28 1249 1427 1456 -2716 2 2 0 28 1495 1249 1456 -2717 2 2 0 28 1456 1488 1495 -2718 2 2 0 28 1277 1248 1407 -2719 2 2 0 28 1277 1407 1197 -2720 2 2 0 28 1261 1277 1197 -2721 2 2 0 28 1182 1277 1274 -2722 2 2 0 28 1248 1277 1182 -2723 2 2 0 28 1181 1287 1463 -2724 2 2 0 28 1292 1463 1287 -2725 2 2 0 28 1181 1293 1287 -2726 2 2 0 28 1293 1278 1287 -2727 2 2 0 28 1287 1196 1292 -2728 2 2 0 28 1278 1196 1287 -2729 2 2 0 28 1284 1520 1260 -2730 2 2 0 28 1204 1260 1520 -2731 2 2 0 28 1204 1520 1521 -2732 2 2 0 28 1451 1467 1190 -2733 2 2 0 28 1432 1451 1190 -2734 2 2 0 28 1450 1190 1467 -2735 2 2 0 28 1276 1190 1450 -2736 2 2 0 28 1276 1454 1190 -2737 2 2 0 28 1432 1190 1454 -2738 2 2 0 28 1266 1267 1180 -2739 2 2 0 28 1180 1446 1266 -2740 2 2 0 28 1266 1292 1196 -2741 2 2 0 28 1292 1266 1446 -2742 2 2 0 28 1266 1196 1268 -2743 2 2 0 28 1268 1267 1266 -2744 2 2 0 28 1245 1329 1351 -2745 2 2 0 28 1351 1329 1303 -2746 2 2 0 28 1321 1245 1351 -2747 2 2 0 28 1303 1214 1351 -2748 2 2 0 28 1351 1349 1321 -2749 2 2 0 28 1214 1349 1351 -2750 2 2 0 28 1288 1283 1509 -2751 2 2 0 28 1283 1288 1182 -2752 2 2 0 28 1288 1509 1199 -2753 2 2 0 28 1248 1182 1288 -2754 2 2 0 28 1248 1288 1199 -2755 2 2 0 28 1439 1384 1434 -2756 2 2 0 28 1222 1439 1434 -2757 2 2 0 28 1242 1439 1352 -2758 2 2 0 28 1352 1439 1222 -2759 2 2 0 28 1384 1439 1242 -2760 2 2 0 28 1299 1215 1370 -2761 2 2 0 28 1370 1310 1299 -2762 2 2 0 28 1215 1323 1370 -2763 2 2 0 28 1370 1323 1311 -2764 2 2 0 28 1311 1223 1370 -2765 2 2 0 28 1223 1310 1370 -2766 2 2 0 28 1378 1404 1243 -2767 2 2 0 28 1435 1404 1378 -2768 2 2 0 28 1236 1378 1243 -2769 2 2 0 28 1378 1240 1435 -2770 2 2 0 28 1378 1438 1240 -2771 2 2 0 28 1378 1236 1438 -2772 2 2 0 28 1181 1466 1295 -2773 2 2 0 28 1478 1466 1181 -2774 2 2 0 28 1299 1188 1308 -2775 2 2 0 28 1299 1310 1188 -2776 2 2 0 28 1345 1299 1308 -2777 2 2 0 28 1299 1345 1215 -2778 2 2 0 28 1461 1415 1395 -2779 2 2 0 28 1415 1376 1395 -2780 2 2 0 28 1415 1464 1452 -2781 2 2 0 28 1415 1320 1376 -2782 2 2 0 28 1320 1415 1452 -2783 2 2 0 28 1413 1305 1337 -2784 2 2 0 28 1305 1413 1213 -2785 2 2 0 28 1229 1413 1337 -2786 2 2 0 28 1338 1213 1413 -2787 2 2 0 28 1359 1231 1431 -2788 2 2 0 28 1231 1359 1375 -2789 2 2 0 28 1358 1348 1357 -2790 2 2 0 28 1220 1358 1357 -2791 2 2 0 28 1357 1224 1382 -2792 2 2 0 28 1382 1474 1357 -2793 2 2 0 28 1220 1357 1474 -2794 2 2 0 28 1269 1284 1512 -2795 2 2 0 28 1284 1269 1526 -2796 2 2 0 28 1269 1251 1244 -2797 2 2 0 28 1269 1244 1494 -2798 2 2 0 28 1251 1269 1512 -2799 2 2 0 28 1494 1526 1269 -2800 2 2 0 28 1256 1453 1516 -2801 2 2 0 28 1256 1483 1453 -2802 2 2 0 28 1453 1469 1300 -2803 2 2 0 28 1300 1220 1453 -2804 2 2 0 28 1220 1516 1453 -2805 2 2 0 28 1469 1453 1483 -2806 2 2 0 28 1467 1451 1479 -2807 2 2 0 28 1432 1448 1451 -2808 2 2 0 28 1448 1241 1451 -2809 2 2 0 28 1241 1479 1451 -2810 2 2 0 28 1263 1505 1524 -2811 2 2 0 28 1524 1494 1263 -2812 2 2 0 28 1431 1400 1429 -2813 2 2 0 28 1400 1431 1231 -2814 2 2 0 28 1379 1380 1409 -2815 2 2 0 28 1379 1209 1380 -2816 2 2 0 28 1372 1209 1379 -2817 2 2 0 28 1372 1379 1442 -2818 2 2 0 28 1409 1218 1379 -2819 2 2 0 28 1312 1379 1218 -2820 2 2 0 28 1442 1379 1312 -2821 2 2 0 28 1369 1360 1327 -2822 2 2 0 28 1327 1360 1185 -2823 2 2 0 28 1185 1360 1430 -2824 2 2 0 28 1437 1360 1369 -2825 2 2 0 28 1260 1512 1284 -2826 2 2 0 28 1284 1526 1525 -2827 2 2 0 28 1509 1283 1487 -2828 2 2 0 28 1283 1182 1523 -2829 2 2 0 28 1283 1523 1515 -2830 2 2 0 28 1348 1358 1225 -2831 2 2 0 28 1300 1358 1220 -2832 2 2 0 28 1276 1264 1246 -2833 2 2 0 28 1276 1246 1454 -2834 2 2 0 28 1246 1275 1444 -2835 2 2 0 28 1246 1444 1454 -2836 2 2 0 28 1380 1457 1409 -2837 2 2 0 28 1409 1457 1253 -2838 2 2 0 28 1457 1433 1253 -2839 2 2 0 28 1445 1433 1457 -2840 2 2 0 28 1382 1402 1474 -2841 2 2 0 28 1506 1474 1402 -2842 2 2 0 28 1292 1202 1463 -2843 2 2 0 28 1478 1463 1202 -2844 2 2 0 28 1202 1292 1282 -2845 2 2 0 28 1202 1282 1208 -2846 2 2 0 28 1178 1401 1403 -2847 2 2 0 28 1178 1403 1245 -2848 2 2 0 28 1343 1245 1403 -2849 2 2 0 28 1403 1346 1343 -2850 2 2 0 28 1463 1478 1181 -2851 2 2 0 28 1262 1394 1472 -2852 2 2 0 28 1262 1472 1250 -2853 2 2 0 28 1377 1306 1297 -2854 2 2 0 28 1297 1306 1177 -2855 2 2 0 28 1297 1214 1377 -2856 2 2 0 28 1297 1177 1312 -2857 2 2 0 28 1297 1349 1214 -2858 2 2 0 28 1349 1297 1312 -2859 2 2 0 28 1181 1295 1293 -2860 2 2 0 28 1408 1294 1249 -2861 2 2 0 28 1408 1249 1495 -2862 2 2 0 28 1271 1285 1295 -2863 2 2 0 28 1271 1205 1281 -2864 2 2 0 28 1285 1271 1281 -2865 2 2 0 28 1282 1180 1472 -2866 2 2 0 28 1472 1180 1497 -2867 2 2 0 28 1270 1250 1472 -2868 2 2 0 28 1472 1497 1270 -2869 2 2 0 28 1472 1394 1282 -2870 2 2 0 28 1411 1373 1371 -2871 2 2 0 28 1411 1361 1325 -2872 2 2 0 28 1325 1232 1411 -2873 2 2 0 28 1232 1373 1411 -2874 2 2 0 28 1367 1307 1471 -2875 2 2 0 28 1475 1367 1471 -2876 2 2 0 28 1298 1187 1471 -2877 2 2 0 28 1298 1471 1307 -2878 2 2 0 28 1187 1475 1471 -2879 2 2 0 28 1201 1264 1276 -2880 2 2 0 28 1436 1390 1367 -2881 2 2 0 28 1390 1307 1367 -2882 2 2 0 28 1390 1498 1307 -2883 2 2 0 28 1272 1259 1260 -2884 2 2 0 28 1204 1272 1260 -2885 2 2 0 28 1259 1194 1260 -2886 2 2 0 28 1260 1194 1512 -2887 2 2 0 28 1296 1226 1366 -2888 2 2 0 28 1296 1366 1209 -2889 2 2 0 28 1366 1226 1387 -2890 2 2 0 28 1279 1458 1272 -2891 2 2 0 28 1272 1204 1279 -2892 2 2 0 28 1259 1272 1195 -2893 2 2 0 28 1195 1272 1458 -2894 2 2 0 28 1319 1188 1329 -2895 2 2 0 28 1303 1329 1188 -2896 2 2 0 28 1343 1319 1329 -2897 2 2 0 28 1245 1343 1329 -2898 2 2 0 28 1348 1339 1298 -2899 2 2 0 28 1225 1339 1348 -2900 2 2 0 28 1459 1481 1279 -2901 2 2 0 28 1211 1459 1279 -2902 2 2 0 28 1279 1481 1458 -2903 2 2 0 28 1279 1204 1484 -2904 2 2 0 28 1279 1484 1211 -2905 2 2 0 28 1449 1316 1352 -2906 2 2 0 28 1352 1222 1449 -2907 2 2 0 28 1387 1226 1449 -2908 2 2 0 28 1226 1316 1449 -2909 2 2 0 28 1425 1397 1385 -2910 2 2 0 28 1228 1397 1425 -2911 2 2 0 28 1385 1397 1240 -2912 2 2 0 28 1240 1397 1435 -2913 2 2 0 28 1435 1397 1365 -2914 2 2 0 28 1365 1397 1228 -2915 2 2 0 28 1388 1461 1395 -2916 2 2 0 28 1388 1395 1221 -2917 2 2 0 28 1376 1221 1395 -2918 2 2 0 28 1426 1399 1401 -2919 2 2 0 28 1399 1426 1228 -2920 2 2 0 28 1253 1426 1401 -2921 2 2 0 28 1253 1433 1426 -2922 2 2 0 28 1365 1228 1426 -2923 2 2 0 28 1433 1365 1426 -2924 2 2 0 28 1516 1519 1256 -2925 2 2 0 28 1486 1256 1519 -2926 2 2 0 28 1256 1486 1189 -2927 2 2 0 28 1256 1189 1483 -2928 2 2 0 28 1305 1213 1372 -2929 2 2 0 28 1305 1372 1442 -2930 2 2 0 28 1314 1372 1213 -2931 2 2 0 28 1372 1314 1209 -2932 2 2 0 28 1430 1424 1344 -2933 2 2 0 28 1424 1430 1289 -2934 2 2 0 28 1184 1517 1468 -2935 2 2 0 28 1443 1468 1517 -2936 2 2 0 28 1184 1235 1517 -2937 2 2 0 28 1443 1517 1368 -2938 2 2 0 28 1235 1368 1517 -2939 2 2 0 28 1295 1285 1293 -2940 2 2 0 28 1285 1206 1293 -2941 2 2 0 28 1278 1293 1206 -2942 2 2 0 28 1350 1265 1467 -2943 2 2 0 28 1350 1467 1479 -2944 2 2 0 28 1265 1450 1467 -2945 2 2 0 28 1290 1505 1263 -2946 2 2 0 28 1503 1263 1494 -2947 2 2 0 28 1519 1508 1273 -2948 2 2 0 28 1486 1519 1273 -2949 2 2 0 28 1486 1273 1270 -2950 2 2 0 28 1250 1270 1273 -2951 2 2 0 28 1180 1267 1482 -2952 2 2 0 28 1482 1497 1180 -2953 2 2 0 28 1189 1270 1482 -2954 2 2 0 28 1482 1270 1497 -2955 2 2 0 28 1189 1482 1255 -2956 2 2 0 28 1255 1482 1267 -2957 2 2 0 28 1286 1398 1504 -2958 2 2 0 28 1327 1217 1369 -2959 2 2 0 28 1327 1185 1347 -2960 2 2 0 28 1327 1340 1217 -2961 2 2 0 28 1347 1340 1327 -2962 2 2 0 28 1194 1259 1440 -2963 2 2 0 28 1410 1396 1407 -2964 2 2 0 28 1396 1197 1407 -2965 2 2 0 28 1419 1396 1385 -2966 2 2 0 28 1197 1396 1419 -2967 2 2 0 28 1396 1410 1230 -2968 2 2 0 28 1385 1396 1230 -2969 2 2 0 28 1180 1282 1446 -2970 2 2 0 28 1392 1373 1332 -2971 2 2 0 28 1332 1223 1392 -2972 2 2 0 28 1332 1373 1232 -2973 2 2 0 28 1232 1322 1332 -2974 2 2 0 28 1332 1322 1310 -2975 2 2 0 28 1310 1223 1332 -2976 2 2 0 28 1193 1239 1389 -2977 2 2 0 28 1389 1444 1193 -2978 2 2 0 28 1275 1441 1193 -2979 2 2 0 28 1193 1444 1275 -2980 2 2 0 28 1193 1441 1239 -2981 2 2 0 28 1452 1367 1320 -2982 2 2 0 28 1436 1367 1452 -2983 2 2 0 28 1367 1475 1320 -2984 2 2 0 28 1344 1185 1430 -2985 2 2 0 28 1405 1350 1470 -2986 2 2 0 28 1350 1479 1470 -2987 2 2 0 28 1298 1339 1187 -2988 2 2 0 28 1307 1510 1298 -2989 2 2 0 28 1477 1468 1460 -2990 2 2 0 28 1398 1460 1504 -2991 2 2 0 28 1460 1476 1477 -2992 2 2 0 28 1443 1487 1468 -2993 2 2 0 28 1184 1468 1477 -2994 2 2 0 28 1437 1369 1364 -2995 2 2 0 28 1369 1363 1364 -2996 2 2 0 28 1363 1369 1217 -2997 2 2 0 28 1261 1422 1254 -2998 2 2 0 28 1261 1197 1422 -2999 2 2 0 28 1438 1422 1419 -3000 2 2 0 28 1422 1197 1419 -3001 2 2 0 28 1254 1422 1236 -3002 2 2 0 28 1422 1438 1236 -3003 2 2 0 28 1276 1450 1201 -3004 2 2 0 28 1399 1341 1362 -3005 2 2 0 28 1341 1399 1228 -3006 2 2 0 28 1508 1519 1381 -3007 2 2 0 28 1516 1381 1519 -3008 2 2 0 28 1371 1241 1448 -3009 2 2 0 28 1371 1373 1234 -3010 2 2 0 28 1241 1371 1234 -3011 2 2 0 28 1270 1189 1486 -3012 2 2 0 28 1251 1512 1194 -3013 2 2 0 28 1237 1251 1194 -3014 2 2 0 28 1194 1440 1237 -3015 2 2 0 28 1294 1405 1470 -3016 2 2 0 28 1198 1490 1491 -3017 2 2 0 28 1491 1490 1496 -3018 2 2 0 28 1248 1410 1407 -3019 2 2 0 28 1392 1223 1428 -3020 2 2 0 28 1311 1428 1223 -3021 2 2 0 28 1425 1335 1341 -3022 2 2 0 28 1335 1425 1230 -3023 2 2 0 28 1385 1230 1425 -3024 2 2 0 28 1228 1425 1341 -3025 2 2 0 28 1292 1446 1282 -3026 2 2 0 28 1461 1388 1195 -3027 2 2 0 28 1195 1458 1461 -3028 2 2 0 28 1481 1461 1458 -3029 2 2 0 28 1443 1509 1487 -3030 2 2 0 28 1443 1199 1509 -3031 2 2 0 28 1178 1253 1401 -3032 2 2 0 28 1409 1253 1178 -3033 2 2 0 28 1206 1261 1278 -3034 2 2 0 28 1278 1261 1254 -3035 2 2 0 28 1238 1389 1418 -3036 2 2 0 28 1418 1389 1353 -3037 2 2 0 28 1353 1389 1239 -3038 2 2 0 28 1389 1238 1444 -3039 2 2 0 28 1356 1404 1179 -3040 2 2 0 28 1179 1404 1435 -3041 2 2 0 28 1356 1179 1445 -3042 2 2 0 28 1365 1179 1435 -3043 2 2 0 28 1365 1433 1179 -3044 2 2 0 28 1179 1433 1445 -3045 2 2 0 28 1493 1205 1502 -3046 2 2 0 28 1281 1205 1493 -3047 2 2 0 28 1182 1274 1493 -3048 2 2 0 28 1274 1206 1281 -3049 2 2 0 28 1281 1493 1274 -3050 2 2 0 28 1377 1333 1325 -3051 2 2 0 28 1214 1333 1377 -3052 2 2 0 28 1325 1333 1232 -3053 2 2 0 28 1333 1303 1322 -3054 2 2 0 28 1303 1333 1214 -3055 2 2 0 28 1232 1333 1322 -3056 2 2 0 28 1308 1188 1319 -3057 2 2 0 28 1303 1188 1322 -3058 2 2 0 28 1310 1322 1188 -3059 2 2 0 28 1328 1185 1344 -3060 2 2 0 28 1400 1328 1344 -3061 2 2 0 28 1243 1404 1434 -3062 2 2 0 28 1434 1404 1356 -3063 2 2 0 28 1384 1243 1434 -3064 2 2 0 28 1356 1222 1434 -3065 2 2 0 28 1275 1244 1441 -3066 2 2 0 28 1244 1275 1503 -3067 2 2 0 28 1251 1441 1244 -3068 2 2 0 28 1244 1503 1494 -3069 2 2 0 28 1219 1306 1377 -3070 2 2 0 28 1353 1342 1306 -3071 2 2 0 28 1306 1342 1177 -3072 2 2 0 28 1306 1219 1353 -3073 2 2 0 28 1448 1432 1386 -3074 2 2 0 28 1249 1294 1470 -3075 2 2 0 28 1386 1432 1238 -3076 2 2 0 28 1418 1361 1386 -3077 2 2 0 28 1238 1418 1386 -3078 2 2 0 28 1493 1523 1182 -3079 2 2 0 28 1493 1515 1523 -3080 2 2 0 28 1385 1240 1419 -3081 2 2 0 28 1240 1438 1419 -3082 2 2 0 28 1412 1355 1335 -3083 2 2 0 28 1233 1355 1412 -3084 2 2 0 28 1368 1354 1355 -3085 2 2 0 28 1233 1368 1355 -3086 2 2 0 28 1334 1296 1462 -3087 2 2 0 28 1334 1462 1212 -3088 2 2 0 28 1304 1462 1296 -3089 2 2 0 28 1304 1212 1462 -3090 2 2 0 28 1506 1381 1516 -3091 2 2 0 28 1474 1516 1220 -3092 2 2 0 28 1474 1506 1516 -3093 2 2 0 28 1493 1502 1515 -3094 2 2 0 28 1317 1388 1221 -3095 2 2 0 28 1388 1317 1338 -3096 2 2 0 28 1195 1388 1338 -3097 2 2 0 28 1282 1394 1208 -3098 2 2 0 28 1227 1324 1319 -3099 2 2 0 28 1324 1308 1319 -3100 2 2 0 28 1319 1343 1227 -3101 2 2 0 28 1454 1238 1432 -3102 2 2 0 28 1454 1444 1238 -3103 2 2 0 28 1375 1345 1330 -3104 2 2 0 28 1330 1345 1216 -3105 2 2 0 28 1328 1231 1330 -3106 2 2 0 28 1347 1328 1330 -3107 2 2 0 28 1330 1231 1375 -3108 2 2 0 28 1216 1347 1330 -3109 2 2 0 28 1196 1254 1268 -3110 2 2 0 28 1268 1254 1236 -3111 2 2 0 28 1416 1267 1268 -3112 2 2 0 28 1268 1236 1416 -3113 2 2 0 28 1328 1347 1185 -3114 2 2 0 28 1317 1313 1304 -3115 2 2 0 28 1304 1213 1317 -3116 2 2 0 28 1221 1313 1317 -3117 2 2 0 28 1317 1213 1338 -3118 2 2 0 28 1206 1285 1281 -3119 2 2 0 28 1189 1255 1417 -3120 2 2 0 28 1255 1489 1417 -3121 2 2 0 28 1267 1455 1255 -3122 2 2 0 28 1242 1255 1455 -3123 2 2 0 28 1255 1242 1489 -3124 2 2 0 28 1296 1334 1226 -3125 2 2 0 28 1334 1301 1316 -3126 2 2 0 28 1301 1334 1212 -3127 2 2 0 28 1226 1334 1316 -3128 2 2 0 28 1410 1412 1230 -3129 2 2 0 28 1421 1412 1410 -3130 2 2 0 28 1410 1248 1421 -3131 2 2 0 28 1469 1483 1417 -3132 2 2 0 28 1469 1417 1489 -3133 2 2 0 28 1189 1417 1483 -3134 2 2 0 28 1335 1230 1412 -3135 2 2 0 28 1325 1219 1377 -3136 2 2 0 28 1352 1489 1242 -3137 2 2 0 28 1234 1373 1392 -3138 2 2 0 28 1314 1304 1296 -3139 2 2 0 28 1296 1209 1314 -3140 2 2 0 28 1325 1361 1219 -3141 2 2 0 28 1302 1315 1187 -3142 2 2 0 28 1302 1187 1339 -3143 2 2 0 28 1315 1475 1187 -3144 2 2 0 28 1233 1412 1421 -3145 2 2 0 28 1305 1177 1337 -3146 2 2 0 28 1305 1442 1177 -3147 2 2 0 28 1251 1237 1383 -3148 2 2 0 28 1383 1441 1251 -3149 2 2 0 28 1239 1383 1342 -3150 2 2 0 28 1383 1337 1342 -3151 2 2 0 28 1383 1239 1441 -3152 2 2 0 28 1337 1383 1237 -3153 2 2 0 28 1215 1345 1375 -3154 2 2 0 28 1216 1345 1308 -3155 2 2 0 28 1363 1318 1354 -3156 2 2 0 28 1374 1336 1318 -3157 2 2 0 28 1318 1217 1374 -3158 2 2 0 28 1318 1363 1217 -3159 2 2 0 28 1321 1409 1178 -3160 2 2 0 28 1178 1245 1321 -3161 2 2 0 28 1328 1400 1231 -3162 2 2 0 28 1301 1212 1309 -3163 2 2 0 28 1307 1473 1510 -3164 2 2 0 28 1473 1307 1498 -3165 2 2 0 28 1254 1196 1278 -3166 2 2 0 28 1204 1521 1484 -3167 2 2 0 28 1485 1484 1521 -3168 2 2 0 28 1199 1421 1248 -3169 2 2 0 28 1233 1199 1443 -3170 2 2 0 28 1199 1233 1421 -3171 2 2 0 28 1361 1418 1219 -3172 2 2 0 28 1353 1219 1418 -3173 2 2 0 28 1416 1243 1384 -3174 2 2 0 28 1384 1455 1416 -3175 2 2 0 28 1384 1242 1455 -3176 2 2 0 28 1354 1368 1235 -3177 2 2 0 28 1235 1363 1354 -3178 2 2 0 28 1470 1427 1249 -3179 2 2 0 28 1470 1241 1427 -3180 2 2 0 28 1241 1470 1479 -3181 2 2 0 28 1280 1184 1477 -3182 2 2 0 28 1280 1437 1184 -3183 2 2 0 28 1207 1200 1280 -3184 2 2 0 28 1280 1477 1476 -3185 2 2 0 28 1207 1280 1476 -3186 2 2 0 28 1374 1340 1324 -3187 2 2 0 28 1324 1340 1216 -3188 2 2 0 28 1324 1227 1374 -3189 2 2 0 28 1308 1324 1216 -3190 2 2 0 28 1243 1416 1236 -3191 2 2 0 28 1184 1364 1235 -3192 2 2 0 28 1364 1184 1437 -3193 2 2 0 28 1343 1346 1227 -3194 2 2 0 28 1321 1218 1409 -3195 2 2 0 28 1376 1320 1315 -3196 2 2 0 28 1315 1221 1376 -3197 2 2 0 28 1213 1304 1314 -3198 2 2 0 28 1304 1313 1212 -3199 2 2 0 28 1368 1233 1443 -3200 2 2 0 28 1267 1416 1455 -3201 2 2 0 28 1363 1235 1364 -3202 2 2 0 28 1501 1525 1514 -3203 2 2 0 28 1315 1302 1313 -3204 2 2 0 28 1302 1212 1313 -3205 2 2 0 28 1339 1309 1302 -3206 2 2 0 28 1302 1309 1212 -3207 2 2 0 28 1315 1320 1475 -3208 2 2 0 28 1362 1336 1346 -3209 2 2 0 28 1239 1342 1353 -3210 2 2 0 28 1337 1177 1342 -3211 2 2 0 28 1234 1427 1241 -3212 2 2 0 28 1229 1337 1237 -3213 2 2 0 28 1229 1237 1440 -3214 2 2 0 28 1217 1340 1374 -3215 2 2 0 28 1216 1340 1347 -3216 2 2 0 28 1221 1315 1313 -3217 2 2 0 28 1227 1336 1374 -3218 2 2 0 28 1336 1227 1346 -3219 2 2 0 28 1225 1309 1339 -3220 2 2 0 28 1312 1177 1442 -3221 2 2 0 28 1321 1349 1218 -3222 2 2 0 28 1218 1349 1312 -3223 4 2 0 1 1846 2054 1029 2488 -3224 4 2 0 1 581 279 2330 2694 -3225 4 2 0 1 621 1990 1677 2344 -3226 4 2 0 1 324 2005 2190 2323 -3227 4 2 0 1 1556 1938 1638 1986 -3228 4 2 0 1 1677 1990 621 2330 -3229 4 2 0 1 1667 2562 1931 2588 -3230 4 2 0 1 1641 1953 2136 2204 -3231 4 2 0 1 1737 2127 1875 2689 -3232 4 2 0 1 1566 1907 1944 2096 -3233 4 2 0 1 1662 841 2212 2638 -3234 4 2 0 1 1334 1296 1462 1672 -3235 4 2 0 1 1902 1918 387 2641 -3236 4 2 0 1 1132 500 517 2626 -3237 4 2 0 1 1777 1900 2168 2796 -3238 4 2 0 1 1337 2370 1780 2835 -3239 4 2 0 1 2076 2137 1357 2301 -3240 4 2 0 1 1419 1438 1719 2148 -3241 4 2 0 1 581 2330 1990 2694 -3242 4 2 0 1 1523 2264 1976 2303 -3243 4 2 0 1 1713 1942 797 2028 -3244 4 2 0 1 1357 2137 2076 2715 -3245 4 2 0 1 1691 1886 1570 2540 -3246 4 2 0 1 1546 2127 1737 2689 -3247 4 2 0 1 841 2120 1662 2212 -3248 4 2 0 1 1811 1953 1641 2204 -3249 4 2 0 1 1551 1917 1792 2163 -3250 4 2 0 1 1675 1920 1802 2242 -3251 4 2 0 1 1563 1701 1838 2032 -3252 4 2 0 1 324 373 2005 2323 -3253 4 2 0 1 1672 1935 1334 2001 -3254 4 2 0 1 1675 1802 2052 2242 -3255 4 2 0 1 1570 1886 1691 2072 -3256 4 2 0 1 1802 1634 2052 2242 -3257 4 2 0 1 1615 2023 2389 2444 -3258 4 2 0 1 1419 1240 1438 2148 -3259 4 2 0 1 1471 2057 2241 2383 -3260 4 2 0 1 1824 1844 1636 1987 -3261 4 2 0 1 1549 1763 1876 2273 -3262 4 2 0 1 1715 1960 1106 2060 -3263 4 2 0 1 1802 1920 1634 2242 -3264 4 2 0 1 1636 1987 1772 2326 -3265 4 2 0 1 1731 1803 1566 2261 -3266 4 2 0 1 1638 1556 1922 1938 -3267 4 2 0 1 1540 1704 1874 2630 -3268 4 2 0 1 1747 1953 1581 2213 -3269 4 2 0 1 1563 1989 1684 2098 -3270 4 2 0 1 1665 1859 2149 2352 -3271 4 2 0 1 1419 1719 1438 1909 -3272 4 2 0 1 1641 1953 1811 2547 -3273 4 2 0 1 1773 1928 1684 2098 -3274 4 2 0 1 2474 2620 2146 2833 -3275 4 2 0 1 1194 1259 2033 2177 -3276 4 2 0 1 1615 2023 2444 2492 -3277 4 2 0 1 250 1961 1952 2086 -3278 4 2 0 1 1182 1523 1976 2303 -3279 4 2 0 1 1792 1917 1665 2163 -3280 4 2 0 1 1852 1980 1932 2583 -3281 4 2 0 1 2044 2310 1938 2521 -3282 4 2 0 1 1827 1910 1673 2362 -3283 4 2 0 1 1029 2054 1846 2202 -3284 4 2 0 1 1654 1944 1907 2096 -3285 4 2 0 1 1944 2057 1471 2383 -3286 4 2 0 1 1661 1994 1870 2603 -3287 4 2 0 1 1628 1803 1731 2261 -3288 4 2 0 1 1002 1931 2562 2588 -3289 4 2 0 1 1763 2255 2056 2414 -3290 4 2 0 1 1530 1958 1880 2266 -3291 4 2 0 1 1810 1933 748 2690 -3292 4 2 0 1 1525 2135 157 2184 -3293 4 2 0 1 1880 1958 1675 2266 -3294 4 2 0 1 1770 1836 2193 2595 -3295 4 2 0 1 1615 2389 2023 2492 -3296 4 2 0 1 1579 2285 1672 2411 -3297 4 2 0 1 581 1990 279 2694 -3298 4 2 0 1 1970 2168 1900 2796 -3299 4 2 0 1 387 1918 1902 1983 -3300 4 2 0 1 1662 2120 841 2161 -3301 4 2 0 1 1185 1828 1758 2104 -3302 4 2 0 1 1570 1798 1820 1886 -3303 4 2 0 1 604 1680 1948 2530 -3304 4 2 0 1 1571 1713 1942 2288 -3305 4 2 0 1 1662 2161 841 2638 -3306 4 2 0 1 1533 2231 2504 2583 -3307 4 2 0 1 1721 1797 164 2070 -3308 4 2 0 1 1553 2663 2069 2749 -3309 4 2 0 1 1674 1985 1905 2017 -3310 4 2 0 1 1730 1618 2053 2104 -3311 4 2 0 1 1555 2014 1936 2659 -3312 4 2 0 1 933 1889 930 2233 -3313 4 2 0 1 1780 1885 1353 2322 -3314 4 2 0 1 822 1183 1210 1933 -3315 4 2 0 1 1555 1936 2014 2736 -3316 4 2 0 1 1647 2085 1768 2134 -3317 4 2 0 1 1556 1638 1922 1986 -3318 4 2 0 1 1979 2092 223 2349 -3319 4 2 0 1 1655 1813 1588 1891 -3320 4 2 0 1 1132 2054 1904 2626 -3321 4 2 0 1 1440 1194 1259 2033 -3322 4 2 0 1 1416 1820 1708 2289 -3323 4 2 0 1 1843 2023 2389 2492 -3324 4 2 0 1 709 1765 807 2068 -3325 4 2 0 1 1506 2137 995 2278 -3326 4 2 0 1 1985 2017 1674 2773 -3327 4 2 0 1 1357 2076 1872 2715 -3328 4 2 0 1 949 1961 1729 2477 -3329 4 2 0 1 950 1781 1889 2081 -3330 4 2 0 1 1547 1869 1745 2434 -3331 4 2 0 1 1744 1812 1548 2480 -3332 4 2 0 1 1812 1898 1647 1919 -3333 4 2 0 1 164 1797 1721 2140 -3334 4 2 0 1 2175 2193 1836 2595 -3335 4 2 0 1 1665 2149 1859 2153 -3336 4 2 0 1 1534 1910 1827 2362 -3337 4 2 0 1 1743 1581 1953 2213 -3338 4 2 0 1 1827 1673 2227 2362 -3339 4 2 0 1 1713 1765 1551 2074 -3340 4 2 0 1 604 1948 599 2530 -3341 4 2 0 1 1812 1919 1647 2465 -3342 4 2 0 1 1808 2033 1259 2177 -3343 4 2 0 1 1372 1442 2016 2493 -3344 4 2 0 1 748 1810 822 1933 -3345 4 2 0 1 1540 2122 1704 2630 -3346 4 2 0 1 1637 2281 1921 2749 -3347 4 2 0 1 1531 1964 1882 2315 -3348 4 2 0 1 1726 1794 2360 2425 -3349 4 2 0 1 1684 1563 2032 2038 -3350 4 2 0 1 1579 1971 1672 2420 -3351 4 2 0 1 1541 2011 1865 2306 -3352 4 2 0 1 1691 1570 2015 2540 -3353 4 2 0 1 1729 1952 193 1961 -3354 4 2 0 1 1539 2223 1870 2232 -3355 4 2 0 1 1658 2202 2025 2622 -3356 4 2 0 1 989 1907 1751 2279 -3357 4 2 0 1 1825 1934 647 2281 -3358 4 2 0 1 157 1525 843 2135 -3359 4 2 0 1 457 1737 2127 2468 -3360 4 2 0 1 413 1816 2066 2106 -3361 4 2 0 1 2135 2529 1810 2722 -3362 4 2 0 1 1531 1756 1964 2315 -3363 4 2 0 1 1938 2044 1638 2310 -3364 4 2 0 1 1547 1968 1742 2167 -3365 4 2 0 1 1619 1862 1800 1877 -3366 4 2 0 1 1575 1981 1660 2039 -3367 4 2 0 1 1579 1935 1672 2285 -3368 4 2 0 1 822 1210 748 1933 -3369 4 2 0 1 1615 2389 1898 2444 -3370 4 2 0 1 1759 1998 2234 2476 -3371 4 2 0 1 1538 1691 1784 1943 -3372 4 2 0 1 2474 2620 1705 2640 -3373 4 2 0 1 1684 2296 2103 2482 -3374 4 2 0 1 1603 1829 1819 2357 -3375 4 2 0 1 1763 2056 1632 2273 -3376 4 2 0 1 1010 163 164 1721 -3377 4 2 0 1 1713 1551 1765 2532 -3378 4 2 0 1 1538 1784 1691 2388 -3379 4 2 0 1 1669 2504 2231 2583 -3380 4 2 0 1 1540 2067 1702 2524 -3381 4 2 0 1 1185 1758 1954 2104 -3382 4 2 0 1 1588 1655 1891 2430 -3383 4 2 0 1 1563 1989 1697 2482 -3384 4 2 0 1 1547 1878 1968 2167 -3385 4 2 0 1 2359 2472 2207 2481 -3386 4 2 0 1 1127 2056 1994 2255 -3387 4 2 0 1 2146 2278 1797 2301 -3388 4 2 0 1 1573 1700 1899 2122 -3389 4 2 0 1 1800 1877 1862 2793 -3390 4 2 0 1 1550 1732 1806 2004 -3391 4 2 0 1 1635 1932 1852 1980 -3392 4 2 0 1 1226 1334 1935 2001 -3393 4 2 0 1 1792 2404 2341 2702 -3394 4 2 0 1 1296 1462 1672 2302 -3395 4 2 0 1 1675 1958 1880 2750 -3396 4 2 0 1 1817 2261 1566 2553 -3397 4 2 0 1 980 2165 1724 2589 -3398 4 2 0 1 1560 1844 1824 1987 -3399 4 2 0 1 1632 2056 1763 2255 -3400 4 2 0 1 1372 1926 1678 2016 -3401 4 2 0 1 1369 2042 2104 2579 -3402 4 2 0 1 1812 1898 1919 2650 -3403 4 2 0 1 1632 1876 1763 2273 -3404 4 2 0 1 1609 1976 1742 2356 -3405 4 2 0 1 907 1484 863 2081 -3406 4 2 0 1 1533 1932 1980 2583 -3407 4 2 0 1 2103 2296 1900 2482 -3408 4 2 0 1 1240 1719 1438 2148 -3409 4 2 0 1 1563 1684 1989 2482 -3410 4 2 0 1 1571 1713 2288 2532 -3411 4 2 0 1 1547 2167 1742 2356 -3412 4 2 0 1 930 1889 1817 2233 -3413 4 2 0 1 1745 1842 1660 1901 -3414 4 2 0 1 742 1810 748 2690 -3415 4 2 0 1 534 1990 581 2330 -3416 4 2 0 1 1142 1158 1927 2049 -3417 4 2 0 1 841 2120 727 2161 -3418 4 2 0 1 2025 2075 1658 2535 -3419 4 2 0 1 935 980 1724 2589 -3420 4 2 0 1 1563 1915 1697 1989 -3421 4 2 0 1 1533 1980 1852 2583 -3422 4 2 0 1 1579 1672 1971 2411 -3423 4 2 0 1 1615 1751 1790 1898 -3424 4 2 0 1 604 1948 1680 2786 -3425 4 2 0 1 1353 1885 1780 2512 -3426 4 2 0 1 1369 2104 2042 2342 -3427 4 2 0 1 1531 1836 1770 2003 -3428 4 2 0 1 1192 2042 1727 2077 -3429 4 2 0 1 1762 2148 1425 2721 -3430 4 2 0 1 2051 2135 1810 2722 -3431 4 2 0 1 1183 822 1810 1933 -3432 4 2 0 1 2127 2155 1546 2444 -3433 4 2 0 1 1539 1876 2022 2151 -3434 4 2 0 1 1783 2220 2050 2415 -3435 4 2 0 1 1324 1706 2013 2579 -3436 4 2 0 1 933 1817 930 1889 -3437 4 2 0 1 1762 1992 1425 2148 -3438 4 2 0 1 1587 2138 1864 2541 -3439 4 2 0 1 1573 1868 1700 2122 -3440 4 2 0 1 1921 2281 1637 2371 -3441 4 2 0 1 1658 2092 1979 2349 -3442 4 2 0 1 2002 2270 1835 2449 -3443 4 2 0 1 324 2005 373 2190 -3444 4 2 0 1 2146 2620 2474 2640 -3445 4 2 0 1 1588 1982 1655 2430 -3446 4 2 0 1 1672 2133 1462 2420 -3447 4 2 0 1 1775 2170 2040 2541 -3448 4 2 0 1 1693 2183 1796 2213 -3449 4 2 0 1 1992 2077 1341 2337 -3450 4 2 0 1 1791 2231 1669 2504 -3451 4 2 0 1 709 807 757 2068 -3452 4 2 0 1 1615 1898 1790 2444 -3453 4 2 0 1 1531 1882 1964 2735 -3454 4 2 0 1 1790 1931 1667 2562 -3455 4 2 0 1 1372 2016 1678 2493 -3456 4 2 0 1 1411 1373 1760 2012 -3457 4 2 0 1 1324 1340 1706 2579 -3458 4 2 0 1 1455 2021 1820 2387 -3459 4 2 0 1 1776 2014 1936 2736 -3460 4 2 0 1 1572 1759 1865 2183 -3461 4 2 0 1 1823 2173 1940 2554 -3462 4 2 0 1 1571 2136 1953 2204 -3463 4 2 0 1 1900 1777 2290 2796 -3464 4 2 0 1 1641 2204 2136 2304 -3465 4 2 0 1 2044 1938 2520 2521 -3466 4 2 0 1 1726 1794 2305 2360 -3467 4 2 0 1 1778 2017 1985 2773 -3468 4 2 0 1 2014 2045 1936 2659 -3469 4 2 0 1 1928 2032 1684 2098 -3470 4 2 0 1 1598 1928 1773 2098 -3471 4 2 0 1 1953 2213 1747 2354 -3472 4 2 0 1 1534 1827 2227 2362 -3473 4 2 0 1 1003 1790 990 1931 -3474 4 2 0 1 1777 1611 2295 2602 -3475 4 2 0 1 157 2184 2135 2670 -3476 4 2 0 1 1889 2165 899 2589 -3477 4 2 0 1 1537 1807 2243 2318 -3478 4 2 0 1 1815 1617 1972 2410 -3479 4 2 0 1 797 1942 1713 2288 -3480 4 2 0 1 1194 2033 1764 2177 -3481 4 2 0 1 1958 2183 1796 2372 -3482 4 2 0 1 2051 1810 2135 2529 -3483 4 2 0 1 2022 2609 2082 2629 -3484 4 2 0 1 1337 1780 1342 2835 -3485 4 2 0 1 1533 2231 2334 2504 -3486 4 2 0 1 1828 2053 1618 2104 -3487 4 2 0 1 1122 1746 1089 1864 -3488 4 2 0 1 2067 2343 1702 2524 -3489 4 2 0 1 491 1997 2353 2691 -3490 4 2 0 1 2165 2589 1889 2644 -3491 4 2 0 1 1257 651 1828 2053 -3492 4 2 0 1 1781 2081 1204 2299 -3493 4 2 0 1 413 347 1816 2635 -3494 4 2 0 1 1531 1770 1836 2249 -3495 4 2 0 1 858 2562 2125 2588 -3496 4 2 0 1 457 2127 1875 2468 -3497 4 2 0 1 1745 1901 1660 2238 -3498 4 2 0 1 1553 2459 1956 2759 -3499 4 2 0 1 1546 1737 1875 2689 -3500 4 2 0 1 2042 2104 1639 2342 -3501 4 2 0 1 1772 1987 1824 2326 -3502 4 2 0 1 499 1967 1965 2438 -3503 4 2 0 1 1575 1975 1660 1981 -3504 4 2 0 1 1539 2114 1870 2223 -3505 4 2 0 1 1574 1706 1821 2415 -3506 4 2 0 1 885 1961 949 2477 -3507 4 2 0 1 1777 2295 2143 2602 -3508 4 2 0 1 2077 2337 1992 2340 -3509 4 2 0 1 1588 1813 1655 2328 -3510 4 2 0 1 1775 2541 2040 2584 -3511 4 2 0 1 1783 2050 1921 2415 -3512 4 2 0 1 1563 1989 2098 2147 -3513 4 2 0 1 1983 2517 1657 2691 -3514 4 2 0 1 1416 1267 1708 1820 -3515 4 2 0 1 413 347 353 1816 -3516 4 2 0 1 499 2297 1967 2438 -3517 4 2 0 1 903 244 996 2494 -3518 4 2 0 1 1541 1865 2011 2521 -3519 4 2 0 1 1812 2224 1548 2480 -3520 4 2 0 1 620 1937 1799 2367 -3521 4 2 0 1 1803 1566 2261 2553 -3522 4 2 0 1 1797 2278 2137 2301 -3523 4 2 0 1 1654 1907 1751 2096 -3524 4 2 0 1 1604 2281 1921 2371 -3525 4 2 0 1 693 1942 797 2288 -3526 4 2 0 1 1547 1878 2167 2356 -3527 4 2 0 1 1834 2013 1727 2337 -3528 4 2 0 1 413 1816 2106 2635 -3529 4 2 0 1 1546 2127 1761 2155 -3530 4 2 0 1 1570 1691 1987 2747 -3531 4 2 0 1 1690 2404 1792 2702 -3532 4 2 0 1 1119 2056 1181 2785 -3533 4 2 0 1 2125 2562 1667 2588 -3534 4 2 0 1 1784 1945 2240 2300 -3535 4 2 0 1 1852 1932 1635 2583 -3536 4 2 0 1 2022 1623 2609 2629 -3537 4 2 0 1 1919 2465 1812 2650 -3538 4 2 0 1 1571 2288 2204 2532 -3539 4 2 0 1 1340 1706 2579 2655 -3540 4 2 0 1 1563 1697 2038 2482 -3541 4 2 0 1 1553 1956 1766 2759 -3542 4 2 0 1 2000 2487 1839 2616 -3543 4 2 0 1 1565 1986 1885 2234 -3544 4 2 0 1 1636 1824 1987 2326 -3545 4 2 0 1 1132 1904 500 2626 -3546 4 2 0 1 708 806 2099 2171 -3547 4 2 0 1 1336 1727 2013 2337 -3548 4 2 0 1 2183 2372 1958 2506 -3549 4 2 0 1 457 1737 430 2127 -3550 4 2 0 1 1743 2213 1953 2354 -3551 4 2 0 1 1661 1870 1632 2223 -3552 4 2 0 1 204 373 2005 2190 -3553 4 2 0 1 1173 164 163 1721 -3554 4 2 0 1 1780 1337 2016 2370 -3555 4 2 0 1 1530 1796 2183 2213 -3556 4 2 0 1 1721 1544 2140 2625 -3557 4 2 0 1 1548 1971 2480 2839 -3558 4 2 0 1 1823 2225 2173 2554 -3559 4 2 0 1 1010 1721 164 2070 -3560 4 2 0 1 1541 1938 2310 2521 -3561 4 2 0 1 1354 1663 2042 2077 -3562 4 2 0 1 1722 1657 2517 2691 -3563 4 2 0 1 1754 1847 1603 2189 -3564 4 2 0 1 2005 1634 2190 2323 -3565 4 2 0 1 1703 1839 2487 2616 -3566 4 2 0 1 1843 2389 1615 2492 -3567 4 2 0 1 1807 2243 2318 2739 -3568 4 2 0 1 710 2508 1822 2555 -3569 4 2 0 1 604 599 1948 2786 -3570 4 2 0 1 1607 1799 1730 2198 -3571 4 2 0 1 1541 1804 1683 2602 -3572 4 2 0 1 1542 2305 2079 2360 -3573 4 2 0 1 2051 2135 2055 2529 -3574 4 2 0 1 1665 2352 1867 2671 -3575 4 2 0 1 1673 2312 2362 2748 -3576 4 2 0 1 1728 2244 1544 2627 -3577 4 2 0 1 1537 2243 1807 2739 -3578 4 2 0 1 1438 1909 1719 2551 -3579 4 2 0 1 1743 1998 1854 2354 -3580 4 2 0 1 1820 2763 2007 2767 -3581 4 2 0 1 1756 1584 1882 2063 -3582 4 2 0 1 980 2115 1724 2165 -3583 4 2 0 1 1060 1927 1819 2394 -3584 4 2 0 1 1570 2072 1691 2747 -3585 4 2 0 1 2025 2336 2075 2535 -3586 4 2 0 1 2056 2273 1763 2414 -3587 4 2 0 1 1658 2025 1863 2075 -3588 4 2 0 1 1103 2056 2255 2414 -3589 4 2 0 1 1869 2179 1745 2434 -3590 4 2 0 1 1531 1882 1756 2315 -3591 4 2 0 1 691 1890 2288 2451 -3592 4 2 0 1 413 1816 353 2066 -3593 4 2 0 1 1660 1975 1575 2039 -3594 4 2 0 1 1735 1869 671 2197 -3595 4 2 0 1 1734 1836 1598 1878 -3596 4 2 0 1 1553 2220 1783 2415 -3597 4 2 0 1 1411 1760 1373 2263 -3598 4 2 0 1 223 270 1904 2092 -3599 4 2 0 1 1549 2039 1876 2544 -3600 4 2 0 1 1746 1864 1122 2138 -3601 4 2 0 1 1817 1889 933 2365 -3602 4 2 0 1 1267 1708 1820 2021 -3603 4 2 0 1 1994 2056 1632 2255 -3604 4 2 0 1 1013 154 980 2165 -3605 4 2 0 1 1563 2032 1838 2098 -3606 4 2 0 1 1657 2270 2002 2449 -3607 4 2 0 1 1940 2173 1823 2225 -3608 4 2 0 1 1618 1730 1799 2215 -3609 4 2 0 1 1559 1729 1793 1999 -3610 4 2 0 1 1335 1992 1762 2077 -3611 4 2 0 1 803 1942 1890 1991 -3612 4 2 0 1 1934 2281 1604 2283 -3613 4 2 0 1 935 1724 980 2115 -3614 4 2 0 1 1699 1978 1606 2559 -3615 4 2 0 1 1544 1721 2140 2619 -3616 4 2 0 1 1673 2312 2004 2362 -3617 4 2 0 1 604 1680 2530 2536 -3618 4 2 0 1 1101 1715 1106 2060 -3619 4 2 0 1 1555 1908 2174 2263 -3620 4 2 0 1 1721 2182 1688 2619 -3621 4 2 0 1 1587 2075 1711 2126 -3622 4 2 0 1 1555 2174 1906 2263 -3623 4 2 0 1 1419 1719 1909 2148 -3624 4 2 0 1 1658 1904 2202 2622 -3625 4 2 0 1 1803 2261 1817 2553 -3626 4 2 0 1 1530 1796 1958 2183 -3627 4 2 0 1 1354 2042 1663 2342 -3628 4 2 0 1 1336 2013 1834 2337 -3629 4 2 0 1 1540 1871 1736 2067 -3630 4 2 0 1 1334 1672 1462 2420 -3631 4 2 0 1 1599 1911 1714 2048 -3632 4 2 0 1 1889 1781 2165 2644 -3633 4 2 0 1 706 1769 781 1936 -3634 4 2 0 1 680 587 1207 1937 -3635 4 2 0 1 1570 1886 1820 2291 -3636 4 2 0 1 164 1721 1173 2140 -3637 4 2 0 1 1541 2520 1938 2521 -3638 4 2 0 1 1580 2034 2203 2634 -3639 4 2 0 1 1763 2039 1876 2509 -3640 4 2 0 1 1553 1766 2459 2759 -3641 4 2 0 1 1670 1596 2003 2286 -3642 4 2 0 1 155 2055 1771 2670 -3643 4 2 0 1 1334 1935 1672 2420 -3644 4 2 0 1 1715 2488 1846 2491 -3645 4 2 0 1 1677 1897 1592 2380 -3646 4 2 0 1 1936 2014 1776 2045 -3647 4 2 0 1 1900 2290 1970 2796 -3648 4 2 0 1 1965 2286 1670 2391 -3649 4 2 0 1 1548 1741 1971 2839 -3650 4 2 0 1 2037 2370 1556 2429 -3651 4 2 0 1 1863 2025 1658 2202 -3652 4 2 0 1 1539 2232 1870 2710 -3653 4 2 0 1 1537 2243 2082 2318 -3654 4 2 0 1 604 1680 2536 2786 -3655 4 2 0 1 1751 1907 989 2125 -3656 4 2 0 1 1820 1886 1798 2760 -3657 4 2 0 1 2022 2151 1876 2181 -3658 4 2 0 1 1324 1706 1340 2655 -3659 4 2 0 1 1665 1867 2611 2671 -3660 4 2 0 1 1550 1806 1732 2293 -3661 4 2 0 1 1544 2244 1728 2335 -3662 4 2 0 1 193 1952 250 1961 -3663 4 2 0 1 1709 2418 2004 2519 -3664 4 2 0 1 691 2288 825 2451 -3665 4 2 0 1 1824 1987 1772 2550 -3666 4 2 0 1 1752 825 2288 2451 -3667 4 2 0 1 1774 1620 1834 2011 -3668 4 2 0 1 1681 1829 1819 2424 -3669 4 2 0 1 346 326 233 2556 -3670 4 2 0 1 1670 2286 2003 2604 -3671 4 2 0 1 1921 2281 1825 2749 -3672 4 2 0 1 1530 1854 1759 1998 -3673 4 2 0 1 2004 2362 2312 2748 -3674 4 2 0 1 1867 1892 1641 2118 -3675 4 2 0 1 1726 2305 1542 2360 -3676 4 2 0 1 1716 1918 1594 2176 -3677 4 2 0 1 729 1860 1794 2425 -3678 4 2 0 1 1549 1876 1763 2544 -3679 4 2 0 1 1784 2240 1691 2300 -3680 4 2 0 1 1859 2352 1665 2671 -3681 4 2 0 1 903 996 2049 2494 -3682 4 2 0 1 1766 1845 681 2192 -3683 4 2 0 1 1537 2082 1807 2318 -3684 4 2 0 1 457 240 1875 2127 -3685 4 2 0 1 1540 1702 1874 2524 -3686 4 2 0 1 2170 2541 1775 2584 -3687 4 2 0 1 1354 1663 2077 2507 -3688 4 2 0 1 1859 1619 2149 2352 -3689 4 2 0 1 1255 1705 2620 2640 -3690 4 2 0 1 1986 2234 1998 2476 -3691 4 2 0 1 204 2005 1801 2190 -3692 4 2 0 1 1550 1768 1941 2293 -3693 4 2 0 1 1550 1941 1768 2623 -3694 4 2 0 1 1516 2278 2146 2301 -3695 4 2 0 1 2117 2586 2273 2785 -3696 4 2 0 1 1611 2527 2295 2602 -3697 4 2 0 1 1536 1949 2047 2198 -3698 4 2 0 1 1587 1746 2138 2541 -3699 4 2 0 1 1683 1804 1541 2011 -3700 4 2 0 1 1587 2040 2541 2584 -3701 4 2 0 1 1876 2039 1763 2544 -3702 4 2 0 1 1867 2089 1811 2304 -3703 4 2 0 1 1951 1544 2244 2627 -3704 4 2 0 1 1707 2474 2146 2833 -3705 4 2 0 1 2025 1658 2336 2535 -3706 4 2 0 1 2069 2663 2393 2749 -3707 4 2 0 1 1528 1812 2465 2650 -3708 4 2 0 1 1850 2005 1634 2699 -3709 4 2 0 1 1777 2143 1611 2602 -3710 4 2 0 1 1736 1871 1540 2698 -3711 4 2 0 1 1611 1777 2295 2527 -3712 4 2 0 1 693 797 1942 2028 -3713 4 2 0 1 1774 1804 1620 2599 -3714 4 2 0 1 858 1002 2562 2588 -3715 4 2 0 1 1558 1778 1985 2773 -3716 4 2 0 1 1571 1942 1890 2288 -3717 4 2 0 1 1354 2342 1663 2507 -3718 4 2 0 1 1945 2004 1709 2418 -3719 4 2 0 1 1953 2204 1811 2532 -3720 4 2 0 1 1780 1922 1638 1986 -3721 4 2 0 1 1761 1931 871 2280 -3722 4 2 0 1 980 154 2115 2165 -3723 4 2 0 1 1010 163 1721 2734 -3724 4 2 0 1 1813 2067 1736 2200 -3725 4 2 0 1 1751 1907 1654 2279 -3726 4 2 0 1 1604 1825 1921 2281 -3727 4 2 0 1 1727 2337 2077 2340 -3728 4 2 0 1 1610 2363 1757 2426 -3729 4 2 0 1 1761 2280 871 2803 -3730 4 2 0 1 1296 1672 1334 2001 -3731 4 2 0 1 1673 1910 1827 2335 -3732 4 2 0 1 1847 2189 1754 2292 -3733 4 2 0 1 1584 1756 1882 2315 -3734 4 2 0 1 1739 1856 1611 2031 -3735 4 2 0 1 1601 1943 1784 2240 -3736 4 2 0 1 1910 2218 1827 2335 -3737 4 2 0 1 413 2066 2068 2106 -3738 4 2 0 1 1566 2096 1944 2558 -3739 4 2 0 1 1548 2480 1814 2839 -3740 4 2 0 1 1854 1998 1530 2354 -3741 4 2 0 1 1742 2356 1976 2434 -3742 4 2 0 1 1689 2010 1956 2630 -3743 4 2 0 1 1553 1766 2069 2663 -3744 4 2 0 1 1574 2050 1706 2415 -3745 4 2 0 1 244 2049 996 2494 -3746 4 2 0 1 1743 1854 1530 2354 -3747 4 2 0 1 950 1781 881 1889 -3748 4 2 0 1 1658 2075 1863 2535 -3749 4 2 0 1 1701 2032 1563 2038 -3750 4 2 0 1 1767 2084 452 2574 -3751 4 2 0 1 936 949 1961 2073 -3752 4 2 0 1 1558 1778 2027 2239 -3753 4 2 0 1 1689 2452 2010 2630 -3754 4 2 0 1 1783 1956 1689 2220 -3755 4 2 0 1 1634 2080 1850 2699 -3756 4 2 0 1 1609 2142 1762 2243 -3757 4 2 0 1 1780 1556 2037 2370 -3758 4 2 0 1 1587 1775 2040 2584 -3759 4 2 0 1 2152 2160 2048 2616 -3760 4 2 0 1 1819 2357 1829 2613 -3761 4 2 0 1 1089 1746 1091 1864 -3762 4 2 0 1 210 357 1789 2556 -3763 4 2 0 1 1803 2233 1817 2261 -3764 4 2 0 1 1835 1903 1590 2002 -3765 4 2 0 1 1730 1799 1607 1937 -3766 4 2 0 1 1785 1892 1565 2136 -3767 4 2 0 1 1865 2306 2011 2454 -3768 4 2 0 1 1665 2163 1917 2611 -3769 4 2 0 1 1419 1909 1438 2551 -3770 4 2 0 1 620 2053 1937 2367 -3771 4 2 0 1 1569 1918 1716 2176 -3772 4 2 0 1 1669 1651 1938 2257 -3773 4 2 0 1 1590 1835 2002 2270 -3774 4 2 0 1 1723 2225 2173 2789 -3775 4 2 0 1 1533 1980 1932 2838 -3776 4 2 0 1 1337 2033 2370 2835 -3777 4 2 0 1 2273 2586 2056 2785 -3778 4 2 0 1 1864 2138 1746 2541 -3779 4 2 0 1 1689 2630 1956 2652 -3780 4 2 0 1 866 1889 933 2233 -3781 4 2 0 1 1571 1685 1991 2265 -3782 4 2 0 1 1579 1672 1935 2420 -3783 4 2 0 1 2341 2404 1765 2702 -3784 4 2 0 1 1946 1729 2523 2793 -3785 4 2 0 1 2118 2266 1998 2354 -3786 4 2 0 1 1673 2058 2312 2748 -3787 4 2 0 1 1496 1490 576 1491 -3788 4 2 0 1 1675 2266 1958 2471 -3789 4 2 0 1 621 1990 534 2330 -3790 4 2 0 1 526 1961 885 2477 -3791 4 2 0 1 1815 1960 1617 2410 -3792 4 2 0 1 1571 1685 2265 2634 -3793 4 2 0 1 1626 1906 1858 2008 -3794 4 2 0 1 1587 2710 1710 2828 -3795 4 2 0 1 1770 1838 1598 2098 -3796 4 2 0 1 134 1815 1972 2410 -3797 4 2 0 1 1714 1911 1528 2048 -3798 4 2 0 1 1905 1985 1778 2017 -3799 4 2 0 1 1952 2086 1961 2545 -3800 4 2 0 1 1802 1675 2271 2334 -3801 4 2 0 1 357 2268 1789 2556 -3802 4 2 0 1 1601 1784 1945 2240 -3803 4 2 0 1 1766 2192 2459 2759 -3804 4 2 0 1 1759 1572 1865 2310 -3805 4 2 0 1 1665 2149 1867 2352 -3806 4 2 0 1 1475 1471 1944 2057 -3807 4 2 0 1 1580 2034 1826 2203 -3808 4 2 0 1 1603 2357 1819 2764 -3809 4 2 0 1 975 1748 2162 2382 -3810 4 2 0 1 1768 1919 1647 2134 -3811 4 2 0 1 729 2087 1794 2375 -3812 4 2 0 1 1966 2113 1980 2517 -3813 4 2 0 1 994 1931 1761 2155 -3814 4 2 0 1 1496 1491 576 1995 -3815 4 2 0 1 677 647 1934 2281 -3816 4 2 0 1 1553 2069 1758 2749 -3817 4 2 0 1 1591 2134 2085 2389 -3818 4 2 0 1 1632 1870 1661 1994 -3819 4 2 0 1 1859 2149 1619 2153 -3820 4 2 0 1 1827 1910 1614 2218 -3821 4 2 0 1 1681 1978 1606 2228 -3822 4 2 0 1 1673 2362 2058 2748 -3823 4 2 0 1 2007 2763 1243 2767 -3824 4 2 0 1 1794 1860 729 2375 -3825 4 2 0 1 1838 2032 1598 2098 -3826 4 2 0 1 1758 1828 1430 2812 -3827 4 2 0 1 822 748 742 1810 -3828 4 2 0 1 1556 1922 1780 1986 -3829 4 2 0 1 1002 1931 1790 2562 -3830 4 2 0 1 1669 1938 1556 2231 -3831 4 2 0 1 1759 2234 1638 2476 -3832 4 2 0 1 2054 2488 1846 2789 -3833 4 2 0 1 2052 2190 1585 2242 -3834 4 2 0 1 1536 1949 1734 2047 -3835 4 2 0 1 1430 1758 1185 1828 -3836 4 2 0 1 1558 2017 1778 2773 -3837 4 2 0 1 1703 2487 2000 2616 -3838 4 2 0 1 1749 1565 2008 2265 -3839 4 2 0 1 1863 2075 1775 2535 -3840 4 2 0 1 1853 2083 1645 2151 -3841 4 2 0 1 1953 2532 1811 2547 -3842 4 2 0 1 1253 1893 1824 2751 -3843 4 2 0 1 1637 1825 2281 2749 -3844 4 2 0 1 1206 2586 2117 2785 -3845 4 2 0 1 1846 2488 1092 2491 -3846 4 2 0 1 1550 1732 2004 2519 -3847 4 2 0 1 1383 1974 1780 2322 -3848 4 2 0 1 1609 1909 1887 2243 -3849 4 2 0 1 1003 1002 990 1790 -3850 4 2 0 1 1342 1780 1383 2835 -3851 4 2 0 1 1611 1856 1739 2527 -3852 4 2 0 1 1548 1812 1744 2708 -3853 4 2 0 1 1540 2059 1704 2122 -3854 4 2 0 1 1592 1841 1677 2380 -3855 4 2 0 1 1092 1846 1029 2488 -3856 4 2 0 1 2008 2265 1565 2801 -3857 4 2 0 1 863 1781 1484 2184 -3858 4 2 0 1 1615 1843 1814 2224 -3859 4 2 0 1 632 2281 1934 2283 -3860 4 2 0 1 1587 1710 2138 2828 -3861 4 2 0 1 781 1936 1769 2379 -3862 4 2 0 1 1530 1998 1759 2266 -3863 4 2 0 1 1860 2305 1794 2360 -3864 4 2 0 1 1553 1783 1921 2415 -3865 4 2 0 1 1599 1714 1911 2261 -3866 4 2 0 1 1622 1794 1860 2079 -3867 4 2 0 1 2127 2327 1687 2576 -3868 4 2 0 1 1693 1796 2183 2372 -3869 4 2 0 1 1917 2163 1551 2611 -3870 4 2 0 1 2040 2170 1606 2541 -3871 4 2 0 1 1670 2003 1596 2478 -3872 4 2 0 1 1774 1620 2011 2599 -3873 4 2 0 1 1730 1937 1607 2724 -3874 4 2 0 1 1839 2392 2000 2616 -3875 4 2 0 1 1802 1920 1675 2334 -3876 4 2 0 1 1328 1954 1758 2194 -3877 4 2 0 1 452 2084 1767 2159 -3878 4 2 0 1 2007 2609 1820 2767 -3879 4 2 0 1 457 430 1737 2468 -3880 4 2 0 1 1544 1951 2244 2335 -3881 4 2 0 1 1598 1836 1770 2249 -3882 4 2 0 1 1830 2183 1865 2471 -3883 4 2 0 1 1887 1909 1840 2629 -3884 4 2 0 1 1713 2028 1855 2074 -3885 4 2 0 1 1713 1581 2028 2074 -3886 4 2 0 1 1569 1966 1980 2517 -3887 4 2 0 1 1836 2238 1666 2356 -3888 4 2 0 1 1771 2115 154 2165 -3889 4 2 0 1 1118 286 1146 1904 -3890 4 2 0 1 1588 1736 2067 2200 -3891 4 2 0 1 1968 2047 1949 2198 -3892 4 2 0 1 1555 1906 1908 2263 -3893 4 2 0 1 1622 1794 2079 2305 -3894 4 2 0 1 1657 2517 1983 2590 -3895 4 2 0 1 1730 1639 2104 2342 -3896 4 2 0 1 2146 2474 1707 2640 -3897 4 2 0 1 1060 1052 1927 2394 -3898 4 2 0 1 1484 1204 1781 2081 -3899 4 2 0 1 792 2055 155 2670 -3900 4 2 0 1 326 2405 233 2556 -3901 4 2 0 1 1653 2009 1949 2587 -3902 4 2 0 1 1546 2023 1737 2127 -3903 4 2 0 1 1645 2151 2083 2549 -3904 4 2 0 1 2076 2137 1872 2715 -3905 4 2 0 1 1569 1902 1716 1918 -3906 4 2 0 1 1206 2056 2586 2785 -3907 4 2 0 1 1411 2012 1760 2263 -3908 4 2 0 1 1958 2266 1530 2471 -3909 4 2 0 1 138 671 1735 2179 -3910 4 2 0 1 1552 2103 1900 2482 -3911 4 2 0 1 442 1829 238 2556 -3912 4 2 0 1 1563 1684 2032 2098 -3913 4 2 0 1 1544 2335 1728 2800 -3914 4 2 0 1 1766 1956 1553 2496 -3915 4 2 0 1 1267 1820 1455 2021 -3916 4 2 0 1 1820 1243 2763 2767 -3917 4 2 0 1 1547 1745 1869 2282 -3918 4 2 0 1 1803 1628 2233 2261 -3919 4 2 0 1 587 680 1207 2053 -3920 4 2 0 1 1626 2008 1858 2265 -3921 4 2 0 1 1532 1916 1782 2150 -3922 4 2 0 1 1629 2066 1816 2106 -3923 4 2 0 1 1328 1758 1400 2132 -3924 4 2 0 1 1613 2037 1852 2429 -3925 4 2 0 1 1756 1531 1964 1981 -3926 4 2 0 1 1558 1816 1778 2017 -3927 4 2 0 1 1575 1846 1981 2025 -3928 4 2 0 1 1701 1871 1739 2698 -3929 4 2 0 1 1525 2135 2184 2822 -3930 4 2 0 1 1558 1985 1778 2239 -3931 4 2 0 1 1647 2085 2134 2389 -3932 4 2 0 1 1689 2050 1561 2348 -3933 4 2 0 1 1535 2089 1867 2304 -3934 4 2 0 1 1318 1354 2042 2077 -3935 4 2 0 1 379 1861 1965 2662 -3936 4 2 0 1 1550 1768 2113 2623 -3937 4 2 0 1 1770 1836 1598 2193 -3938 4 2 0 1 1556 2078 1669 2231 -3939 4 2 0 1 1577 2312 2029 2774 -3940 4 2 0 1 1678 1926 1372 2302 -3941 4 2 0 1 1645 2083 1756 2549 -3942 4 2 0 1 1572 1865 1830 2183 -3943 4 2 0 1 671 1869 1735 2179 -3944 4 2 0 1 1662 2443 2687 2705 -3945 4 2 0 1 2079 2305 1860 2360 -3946 4 2 0 1 647 1934 1825 2192 -3947 4 2 0 1 1561 2050 1689 2220 -3948 4 2 0 1 1819 1829 1603 1927 -3949 4 2 0 1 554 2530 2345 2536 -3950 4 2 0 1 1724 1610 2115 2160 -3951 4 2 0 1 134 1815 663 1972 -3952 4 2 0 1 1639 2042 2342 2463 -3953 4 2 0 1 1802 2052 1545 2401 -3954 4 2 0 1 1610 1757 2109 2426 -3955 4 2 0 1 1886 2240 1943 2479 -3956 4 2 0 1 1690 1765 2404 2702 -3957 4 2 0 1 1140 1721 163 2035 -3958 4 2 0 1 1799 1937 538 2408 -3959 4 2 0 1 1547 2238 1836 2356 -3960 4 2 0 1 1790 1931 1003 2155 -3961 4 2 0 1 2029 2312 2004 2774 -3962 4 2 0 1 1567 1725 2400 2661 -3963 4 2 0 1 1556 1938 1669 2664 -3964 4 2 0 1 1550 1732 2519 2568 -3965 4 2 0 1 1548 1814 1741 2839 -3966 4 2 0 1 1702 2139 1891 2580 -3967 4 2 0 1 1677 1592 1897 2046 -3968 4 2 0 1 1867 1892 2118 2829 -3969 4 2 0 1 193 1952 1729 2209 -3970 4 2 0 1 990 1790 1002 1931 -3971 4 2 0 1 1780 1974 1383 2835 -3972 4 2 0 1 681 1845 1766 2180 -3973 4 2 0 1 1892 2136 1785 2304 -3974 4 2 0 1 1538 2388 1691 2470 -3975 4 2 0 1 1257 1414 2053 2104 -3976 4 2 0 1 1949 1968 1734 2047 -3977 4 2 0 1 1484 1781 863 2081 -3978 4 2 0 1 1553 1825 2663 2749 -3979 4 2 0 1 1925 2006 1795 2312 -3980 4 2 0 1 1740 1942 801 2677 -3981 4 2 0 1 1606 1864 1681 2768 -3982 4 2 0 1 1416 1455 1267 1820 -3983 4 2 0 1 1539 1876 2151 2509 -3984 4 2 0 1 1036 1994 1870 2255 -3985 4 2 0 1 1701 1739 2437 2698 -3986 4 2 0 1 1669 1651 2257 2664 -3987 4 2 0 1 1253 1824 1893 2455 -3988 4 2 0 1 1675 2052 1802 2401 -3989 4 2 0 1 1722 2571 307 2691 -3990 4 2 0 1 1614 1721 2182 2274 -3991 4 2 0 1 1700 1899 2122 2618 -3992 4 2 0 1 1571 1890 2204 2288 -3993 4 2 0 1 1705 2021 2474 2640 -3994 4 2 0 1 581 577 275 1990 -3995 4 2 0 1 2006 2058 1795 2312 -3996 4 2 0 1 2173 2225 1940 2789 -3997 4 2 0 1 1183 822 1290 1810 -3998 4 2 0 1 1668 2207 2472 2481 -3999 4 2 0 1 1752 2288 1890 2451 -4000 4 2 0 1 930 1817 933 2365 -4001 4 2 0 1 278 2327 2127 2576 -4002 4 2 0 1 1768 2134 2085 2607 -4003 4 2 0 1 867 2073 1961 2280 -4004 4 2 0 1 279 581 275 1990 -4005 4 2 0 1 1571 2265 1785 2634 -4006 4 2 0 1 1679 2011 1865 2521 -4007 4 2 0 1 1516 2137 2278 2301 -4008 4 2 0 1 1544 2619 2140 2625 -4009 4 2 0 1 1556 1669 2078 2664 -4010 4 2 0 1 2331 2523 1729 2793 -4011 4 2 0 1 1766 1825 1553 2459 -4012 4 2 0 1 1103 2255 1763 2414 -4013 4 2 0 1 1801 1585 2190 2242 -4014 4 2 0 1 1730 2053 1937 2724 -4015 4 2 0 1 495 998 149 516 -4016 4 2 0 1 1598 2032 1928 2098 -4017 4 2 0 1 968 2165 980 2589 -4018 4 2 0 1 778 1933 2596 2684 -4019 4 2 0 1 1559 1793 1729 2793 -4020 4 2 0 1 1716 1918 1902 2641 -4021 4 2 0 1 1725 2359 2207 2481 -4022 4 2 0 1 1795 2058 2006 2681 -4023 4 2 0 1 1553 1956 1783 2220 -4024 4 2 0 1 1574 1921 2050 2415 -4025 4 2 0 1 899 1889 1781 2165 -4026 4 2 0 1 703 1993 773 2403 -4027 4 2 0 1 1904 2092 170 2225 -4028 4 2 0 1 168 325 1813 2200 -4029 4 2 0 1 1613 2429 1852 2566 -4030 4 2 0 1 1799 2215 2198 2272 -4031 4 2 0 1 1490 576 1491 1995 -4032 4 2 0 1 1691 1943 1538 2470 -4033 4 2 0 1 1684 2311 2296 2482 -4034 4 2 0 1 1699 1606 1979 2559 -4035 4 2 0 1 500 1904 2225 2626 -4036 4 2 0 1 1318 1727 1192 2042 -4037 4 2 0 1 192 270 286 1904 -4038 4 2 0 1 1530 1693 2183 2598 -4039 4 2 0 1 1829 1927 1819 2424 -4040 4 2 0 1 1618 2215 1799 2272 -4041 4 2 0 1 1831 2472 2359 2481 -4042 4 2 0 1 1550 2418 1709 2519 -4043 4 2 0 1 1814 1843 1615 2738 -4044 4 2 0 1 223 1904 270 2349 -4045 4 2 0 1 1588 2067 1813 2200 -4046 4 2 0 1 1647 1812 1744 2480 -4047 4 2 0 1 1729 1961 949 2073 -4048 4 2 0 1 1802 1611 2031 2364 -4049 4 2 0 1 1721 2140 1688 2274 -4050 4 2 0 1 337 2448 1979 2601 -4051 4 2 0 1 1684 2038 2032 2311 -4052 4 2 0 1 1570 1987 1691 2015 -4053 4 2 0 1 1604 1921 1825 2459 -4054 4 2 0 1 1709 2029 2004 2774 -4055 4 2 0 1 1754 941 2251 2259 -4056 4 2 0 1 481 2330 1897 2560 -4057 4 2 0 1 1789 1978 210 2556 -4058 4 2 0 1 1692 2000 1839 2392 -4059 4 2 0 1 1425 2148 1992 2770 -4060 4 2 0 1 1885 1986 1638 2234 -4061 4 2 0 1 1361 1411 1191 2711 -4062 4 2 0 1 1599 1889 1724 2152 -4063 4 2 0 1 1770 2003 1836 2595 -4064 4 2 0 1 1759 1865 2183 2471 -4065 4 2 0 1 1533 1852 2231 2583 -4066 4 2 0 1 1645 1876 2151 2181 -4067 4 2 0 1 1694 2189 1847 2292 -4068 4 2 0 1 1559 1729 1999 2545 -4069 4 2 0 1 1573 1700 1845 2139 -4070 4 2 0 1 1567 1891 1813 2433 -4071 4 2 0 1 1153 1870 1994 2603 -4072 4 2 0 1 1852 1980 1533 2373 -4073 4 2 0 1 1335 1341 1992 2077 -4074 4 2 0 1 1701 1563 1838 2071 -4075 4 2 0 1 1917 2547 2118 2611 -4076 4 2 0 1 1551 1792 1917 2762 -4077 4 2 0 1 1540 2067 1736 2417 -4078 4 2 0 1 1606 1681 2228 2768 -4079 4 2 0 1 1811 2089 1867 2149 -4080 4 2 0 1 1872 2076 1624 2137 -4081 4 2 0 1 1692 1839 2000 2487 -4082 4 2 0 1 1691 2072 1987 2747 -4083 4 2 0 1 1819 1829 1681 2613 -4084 4 2 0 1 1790 2155 1003 2542 -4085 4 2 0 1 1954 2579 1706 2655 -4086 4 2 0 1 807 2068 1765 2501 -4087 4 2 0 1 801 1942 1740 2028 -4088 4 2 0 1 1734 1878 1598 2252 -4089 4 2 0 1 1720 2166 1552 2575 -4090 4 2 0 1 2207 2359 218 2472 -4091 4 2 0 1 1786 1662 2443 2687 -4092 4 2 0 1 709 1765 2068 2144 -4093 4 2 0 1 1647 2224 1812 2480 -4094 4 2 0 1 1576 1710 1959 2043 -4095 4 2 0 1 1572 1923 1693 2183 -4096 4 2 0 1 1689 2452 2630 2652 -4097 4 2 0 1 1622 2041 2375 2666 -4098 4 2 0 1 1560 1987 1824 2550 -4099 4 2 0 1 1579 1886 1943 2479 -4100 4 2 0 1 710 2436 1822 2508 -4101 4 2 0 1 1546 1875 1737 2483 -4102 4 2 0 1 866 933 930 2233 -4103 4 2 0 1 1850 2080 1634 2528 -4104 4 2 0 1 1544 2182 1721 2619 -4105 4 2 0 1 759 1936 1740 2099 -4106 4 2 0 1 1758 1430 2469 2812 -4107 4 2 0 1 1639 2342 1730 2463 -4108 4 2 0 1 1891 1702 2546 2706 -4109 4 2 0 1 1462 2133 1672 2302 -4110 4 2 0 1 612 1841 2236 2344 -4111 4 2 0 1 1563 2038 1684 2482 -4112 4 2 0 1 1677 1841 1592 2761 -4113 4 2 0 1 307 1722 2353 2571 -4114 4 2 0 1 1875 2127 1737 2468 -4115 4 2 0 1 782 841 727 2161 -4116 4 2 0 1 706 806 1769 2099 -4117 4 2 0 1 1660 1715 1981 2491 -4118 4 2 0 1 798 801 1942 2677 -4119 4 2 0 1 1106 1715 1056 1960 -4120 4 2 0 1 1546 2023 2127 2444 -4121 4 2 0 1 1101 2488 1715 2491 -4122 4 2 0 1 1530 1998 2266 2354 -4123 4 2 0 1 1855 2028 1581 2074 -4124 4 2 0 1 998 982 149 1946 -4125 4 2 0 1 1676 2005 1850 2699 -4126 4 2 0 1 1618 1799 1730 2367 -4127 4 2 0 1 1565 1780 1885 1986 -4128 4 2 0 1 1682 2296 2311 2482 -4129 4 2 0 1 1534 2172 2189 2292 -4130 4 2 0 1 1574 1921 1783 2050 -4131 4 2 0 1 1551 1765 2532 2702 -4132 4 2 0 1 1877 2149 1977 2153 -4133 4 2 0 1 1572 1830 1923 2183 -4134 4 2 0 1 1751 1907 1566 2096 -4135 4 2 0 1 1685 2684 1933 2690 -4136 4 2 0 1 223 1979 344 2092 -4137 4 2 0 1 1634 2005 1850 2323 -4138 4 2 0 1 1776 1936 700 2041 -4139 4 2 0 1 1710 1587 2138 2191 -4140 4 2 0 1 442 2424 1829 2556 -4141 4 2 0 1 1610 2109 2331 2426 -4142 4 2 0 1 1706 1574 1821 2036 -4143 4 2 0 1 1865 2011 1679 2454 -4144 4 2 0 1 1578 2682 1950 2727 -4145 4 2 0 1 1221 2018 1731 2788 -4146 4 2 0 1 1808 1420 2033 2667 -4147 4 2 0 1 1551 1713 2074 2532 -4148 4 2 0 1 1579 1971 2420 2781 -4149 4 2 0 1 1635 2402 1784 2623 -4150 4 2 0 1 1762 2077 1992 2340 -4151 4 2 0 1 1965 1967 1670 2286 -4152 4 2 0 1 1193 2008 1749 2322 -4153 4 2 0 1 2058 2312 2006 2681 -4154 4 2 0 1 1685 2596 1933 2684 -4155 4 2 0 1 1693 1923 1830 2183 -4156 4 2 0 1 210 342 357 2556 -4157 4 2 0 1 491 1997 2298 2353 -4158 4 2 0 1 1979 2448 1699 2601 -4159 4 2 0 1 1599 2048 1714 2152 -4160 4 2 0 1 1700 2122 1868 2618 -4161 4 2 0 1 1591 2085 1843 2389 -4162 4 2 0 1 1575 1846 1975 1981 -4163 4 2 0 1 1724 2115 1793 2160 -4164 4 2 0 1 1768 1966 1635 2465 -4165 4 2 0 1 1568 1963 2142 2440 -4166 4 2 0 1 1688 2140 1721 2619 -4167 4 2 0 1 1573 1899 1700 2139 -4168 4 2 0 1 1503 2051 1810 2722 -4169 4 2 0 1 1804 2143 1777 2295 -4170 4 2 0 1 1496 576 667 2131 -4171 4 2 0 1 1690 1993 2445 2498 -4172 4 2 0 1 1876 1887 1645 2600 -4173 4 2 0 1 1791 2334 2231 2504 -4174 4 2 0 1 1615 1790 1751 2695 -4175 4 2 0 1 1860 2360 1794 2425 -4176 4 2 0 1 1528 1911 1714 2510 -4177 4 2 0 1 1819 1927 1060 2424 -4178 4 2 0 1 325 1813 2200 2328 -4179 4 2 0 1 1610 1862 2363 2426 -4180 4 2 0 1 1977 2149 1665 2153 -4181 4 2 0 1 193 521 526 1961 -4182 4 2 0 1 1586 1970 1900 2290 -4183 4 2 0 1 1814 2221 1843 2738 -4184 4 2 0 1 1717 2340 1818 2820 -4185 4 2 0 1 1093 2043 2346 2458 -4186 4 2 0 1 1645 1756 2083 2646 -4187 4 2 0 1 1342 1780 1353 2322 -4188 4 2 0 1 1328 1347 1954 2194 -4189 4 2 0 1 1572 2183 1854 2515 -4190 4 2 0 1 1583 2202 1904 2622 -4191 4 2 0 1 876 2057 1907 2279 -4192 4 2 0 1 457 472 240 2127 -4193 4 2 0 1 1645 2083 1853 2646 -4194 4 2 0 1 1681 1864 1606 2642 -4195 4 2 0 1 728 1771 155 2055 -4196 4 2 0 1 1604 1934 1825 2281 -4197 4 2 0 1 1635 1784 2402 2460 -4198 4 2 0 1 226 2127 1687 2576 -4199 4 2 0 1 1447 1937 1460 1984 -4200 4 2 0 1 1577 2029 2166 2774 -4201 4 2 0 1 957 2070 1797 2137 -4202 4 2 0 1 1578 1985 2682 2727 -4203 4 2 0 1 1561 2220 1689 2654 -4204 4 2 0 1 258 1767 452 2574 -4205 4 2 0 1 1635 1966 1768 2113 -4206 4 2 0 1 1709 1945 1784 2300 -4207 4 2 0 1 1581 1953 1747 2074 -4208 4 2 0 1 1739 1701 2116 2808 -4209 4 2 0 1 1744 1812 1647 2465 -4210 4 2 0 1 1830 1865 1597 2471 -4211 4 2 0 1 1348 1872 1357 2076 -4212 4 2 0 1 1746 1091 1864 2406 -4213 4 2 0 1 1553 2069 1766 2496 -4214 4 2 0 1 1632 1763 1876 2114 -4215 4 2 0 1 1411 2263 1191 2711 -4216 4 2 0 1 1697 1552 1989 2779 -4217 4 2 0 1 342 2268 357 2556 -4218 4 2 0 1 1432 2008 1906 2205 -4219 4 2 0 1 1484 1781 1204 2184 -4220 4 2 0 1 1530 2213 1693 2598 -4221 4 2 0 1 1530 2266 2118 2354 -4222 4 2 0 1 1695 1903 1835 2002 -4223 4 2 0 1 278 2127 226 2576 -4224 4 2 0 1 1929 2035 992 2259 -4225 4 2 0 1 1153 1994 1661 2603 -4226 4 2 0 1 204 324 373 2190 -4227 4 2 0 1 1630 2459 2192 2759 -4228 4 2 0 1 1573 1700 1868 2672 -4229 4 2 0 1 1646 1901 1745 2434 -4230 4 2 0 1 1847 1947 1603 2189 -4231 4 2 0 1 866 937 1889 2081 -4232 4 2 0 1 782 727 2120 2161 -4233 4 2 0 1 1784 2402 1941 2623 -4234 4 2 0 1 1445 2247 1772 2326 -4235 4 2 0 1 1579 1943 2285 2411 -4236 4 2 0 1 614 1948 2400 2530 -4237 4 2 0 1 1318 2013 1727 2042 -4238 4 2 0 1 1530 2183 1693 2213 -4239 4 2 0 1 1005 1748 975 2382 -4240 4 2 0 1 1563 1915 1989 2147 -4241 4 2 0 1 1663 1968 2047 2167 -4242 4 2 0 1 1891 2139 1702 2706 -4243 4 2 0 1 1602 2038 1861 2090 -4244 4 2 0 1 1793 2115 1610 2160 -4245 4 2 0 1 807 1765 709 2501 -4246 4 2 0 1 1896 1732 2298 2519 -4247 4 2 0 1 1545 1856 2031 2271 -4248 4 2 0 1 2099 2171 806 2631 -4249 4 2 0 1 1710 1587 2594 2710 -4250 4 2 0 1 1641 1998 1892 2136 -4251 4 2 0 1 1344 1758 1430 2469 -4252 4 2 0 1 1598 1838 1770 2193 -4253 4 2 0 1 1681 1606 1913 2642 -4254 4 2 0 1 258 2159 1767 2333 -4255 4 2 0 1 558 1937 1447 1984 -4256 4 2 0 1 1710 2043 1576 2095 -4257 4 2 0 1 1730 2198 1799 2215 -4258 4 2 0 1 1952 1961 1729 2545 -4259 4 2 0 1 1340 2579 1954 2655 -4260 4 2 0 1 1802 1970 1611 2364 -4261 4 2 0 1 1685 1571 1991 2634 -4262 4 2 0 1 1860 2079 1794 2305 -4263 4 2 0 1 1606 1978 1699 2228 -4264 4 2 0 1 1088 1975 1763 2119 -4265 4 2 0 1 852 155 728 1771 -4266 4 2 0 1 168 2200 1813 2399 -4267 4 2 0 1 1337 2033 2016 2370 -4268 4 2 0 1 875 871 2280 2803 -4269 4 2 0 1 1818 2340 1717 2599 -4270 4 2 0 1 982 1946 998 2477 -4271 4 2 0 1 677 1934 632 2281 -4272 4 2 0 1 1585 2211 2190 2653 -4273 4 2 0 1 1559 2331 1793 2793 -4274 4 2 0 1 1730 2053 1437 2104 -4275 4 2 0 1 1896 2004 1732 2519 -4276 4 2 0 1 1567 1813 2196 2433 -4277 4 2 0 1 1550 2004 2418 2519 -4278 4 2 0 1 1884 2124 261 2456 -4279 4 2 0 1 1673 2004 1806 2362 -4280 4 2 0 1 1572 1693 1923 2174 -4281 4 2 0 1 491 2353 307 2691 -4282 4 2 0 1 1588 1655 1982 2328 -4283 4 2 0 1 1721 1688 2182 2274 -4284 4 2 0 1 1106 1101 1056 1715 -4285 4 2 0 1 778 1933 2684 2690 -4286 4 2 0 1 1599 2152 1714 2261 -4287 4 2 0 1 1542 1726 2235 2305 -4288 4 2 0 1 1209 2001 1678 2302 -4289 4 2 0 1 1655 2430 1982 2727 -4290 4 2 0 1 1864 2138 1587 2584 -4291 4 2 0 1 2345 2687 2443 2705 -4292 4 2 0 1 1785 2136 2204 2304 -4293 4 2 0 1 1761 1931 1546 2155 -4294 4 2 0 1 1922 2016 1442 2493 -4295 4 2 0 1 1550 1941 2085 2293 -4296 4 2 0 1 783 717 1757 2186 -4297 4 2 0 1 1692 1839 2487 2665 -4298 4 2 0 1 1820 2755 1886 2760 -4299 4 2 0 1 1619 1800 1862 2490 -4300 4 2 0 1 1737 1591 1895 2832 -4301 4 2 0 1 1715 2060 1101 2491 -4302 4 2 0 1 787 2529 2135 2722 -4303 4 2 0 1 1728 2627 1544 2800 -4304 4 2 0 1 1587 1711 2075 2191 -4305 4 2 0 1 802 2028 1855 2585 -4306 4 2 0 1 1728 1601 1945 2240 -4307 4 2 0 1 709 2068 757 2144 -4308 4 2 0 1 1671 1874 2112 2116 -4309 4 2 0 1 1759 2183 1572 2515 -4310 4 2 0 1 1253 1893 2201 2455 -4311 4 2 0 1 1585 2030 2190 2211 -4312 4 2 0 1 1759 1854 2183 2515 -4313 4 2 0 1 926 2248 2125 2553 -4314 4 2 0 1 1840 2617 1887 2629 -4315 4 2 0 1 1946 2523 2331 2793 -4316 4 2 0 1 1826 2055 1771 2186 -4317 4 2 0 1 1641 2136 1892 2304 -4318 4 2 0 1 1862 2490 1800 2793 -4319 4 2 0 1 1199 1421 1976 2091 -4320 4 2 0 1 921 989 1751 2279 -4321 4 2 0 1 194 512 2173 2818 -4322 4 2 0 1 1328 1344 1400 1758 -4323 4 2 0 1 1639 2104 2042 2579 -4324 4 2 0 1 1882 2315 1964 2735 -4325 4 2 0 1 1862 1877 1619 2149 -4326 4 2 0 1 1871 2437 1739 2698 -4327 4 2 0 1 1558 1985 2239 2837 -4328 4 2 0 1 1371 1411 1373 2263 -4329 4 2 0 1 1530 2183 1854 2598 -4330 4 2 0 1 1089 1864 1091 2406 -4331 4 2 0 1 442 1927 1829 2424 -4332 4 2 0 1 1961 2107 914 2280 -4333 4 2 0 1 1577 1720 1848 2166 -4334 4 2 0 1 1730 1280 2053 2724 -4335 4 2 0 1 1587 1746 2108 2828 -4336 4 2 0 1 1663 2167 2047 2573 -4337 4 2 0 1 1615 2444 1894 2492 -4338 4 2 0 1 1744 2121 1812 2465 -4339 4 2 0 1 1257 2053 1828 2104 -4340 4 2 0 1 1563 1701 2038 2071 -4341 4 2 0 1 1774 2011 1804 2599 -4342 4 2 0 1 1669 1938 1651 2664 -4343 4 2 0 1 1595 2112 1874 2116 -4344 4 2 0 1 323 1979 337 2448 -4345 4 2 0 1 1867 2089 1535 2149 -4346 4 2 0 1 1255 2021 1705 2640 -4347 4 2 0 1 1669 2257 1844 2664 -4348 4 2 0 1 1660 1981 1715 2368 -4349 4 2 0 1 428 1897 2472 2560 -4350 4 2 0 1 1728 1945 1601 2227 -4351 4 2 0 1 1766 2192 1825 2459 -4352 4 2 0 1 1553 1825 1766 2663 -4353 4 2 0 1 452 1767 258 2159 -4354 4 2 0 1 1793 2331 1729 2793 -4355 4 2 0 1 1867 2149 1665 2611 -4356 4 2 0 1 385 2159 258 2333 -4357 4 2 0 1 1886 1728 2244 2540 -4358 4 2 0 1 1840 1887 1609 1909 -4359 4 2 0 1 1801 2005 1634 2190 -4360 4 2 0 1 1886 2240 1728 2540 -4361 4 2 0 1 1547 1745 1901 2434 -4362 4 2 0 1 1687 1600 1894 2023 -4363 4 2 0 1 1558 2239 2027 2837 -4364 4 2 0 1 1563 2038 1861 2071 -4365 4 2 0 1 1534 1827 1910 2172 -4366 4 2 0 1 1532 1950 1916 2150 -4367 4 2 0 1 1782 1916 1650 2150 -4368 4 2 0 1 1862 1877 1643 2793 -4369 4 2 0 1 587 1937 620 2053 -4370 4 2 0 1 1806 2004 1732 2680 -4371 4 2 0 1 1567 1891 2139 2580 -4372 4 2 0 1 2087 2375 785 2666 -4373 4 2 0 1 1328 1758 2132 2194 -4374 4 2 0 1 1688 2346 2043 2458 -4375 4 2 0 1 1475 1367 1471 2057 -4376 4 2 0 1 1714 2152 2048 2616 -4377 4 2 0 1 1778 1816 1558 2027 -4378 4 2 0 1 1722 2353 1997 2691 -4379 4 2 0 1 1529 2244 2240 2540 -4380 4 2 0 1 1660 1901 2544 2600 -4381 4 2 0 1 2298 2519 1732 2568 -4382 4 2 0 1 1784 1945 1709 2418 -4383 4 2 0 1 1807 1625 1988 2015 -4384 4 2 0 1 1842 1975 1120 2733 -4385 4 2 0 1 1654 2241 2057 2383 -4386 4 2 0 1 1727 2340 2077 2573 -4387 4 2 0 1 1742 2167 1609 2356 -4388 4 2 0 1 1610 2331 1862 2426 -4389 4 2 0 1 2118 2547 1867 2611 -4390 4 2 0 1 1335 1412 2077 2091 -4391 4 2 0 1 1566 1803 1731 2558 -4392 4 2 0 1 1730 1607 2198 2724 -4393 4 2 0 1 1794 2087 1622 2375 -4394 4 2 0 1 1793 1729 2331 2523 -4395 4 2 0 1 1530 2118 1880 2354 -4396 4 2 0 1 1665 1917 1792 1996 -4397 4 2 0 1 213 2020 2297 2438 -4398 4 2 0 1 1565 1785 2136 2265 -4399 4 2 0 1 1769 2099 806 2631 -4400 4 2 0 1 1618 2104 1730 2215 -4401 4 2 0 1 1870 2223 1661 2232 -4402 4 2 0 1 1724 1889 1599 2365 -4403 4 2 0 1 1529 2015 1691 2300 -4404 4 2 0 1 1623 1887 2617 2629 -4405 4 2 0 1 1720 1552 1989 2575 -4406 4 2 0 1 1643 1877 1862 2426 -4407 4 2 0 1 1704 1540 1874 2230 -4408 4 2 0 1 255 1967 499 2297 -4409 4 2 0 1 1122 2138 1864 2584 -4410 4 2 0 1 2139 2546 1702 2706 -4411 4 2 0 1 433 2445 1993 2498 -4412 4 2 0 1 1768 2113 1966 2517 -4413 4 2 0 1 1811 2204 1641 2304 -4414 4 2 0 1 957 164 1797 2070 -4415 4 2 0 1 1611 2168 1970 2796 -4416 4 2 0 1 2439 2487 1851 2731 -4417 4 2 0 1 1784 1709 2309 2418 -4418 4 2 0 1 1540 1899 1702 2067 -4419 4 2 0 1 1796 1958 2372 2506 -4420 4 2 0 1 1531 1756 1882 2063 -4421 4 2 0 1 2240 2244 1728 2540 -4422 4 2 0 1 1568 2142 1878 2440 -4423 4 2 0 1 293 2262 1686 2448 -4424 4 2 0 1 1490 1198 576 1995 -4425 4 2 0 1 2041 785 2375 2666 -4426 4 2 0 1 1924 2131 1794 2484 -4427 4 2 0 1 154 1771 828 2115 -4428 4 2 0 1 1594 1918 1716 2097 -4429 4 2 0 1 1701 2524 2116 2808 -4430 4 2 0 1 1635 1941 2402 2623 -4431 4 2 0 1 1793 1610 2115 2331 -4432 4 2 0 1 1773 1882 1584 2063 -4433 4 2 0 1 1739 2311 1701 2437 -4434 4 2 0 1 1185 1758 1328 1954 -4435 4 2 0 1 763 848 1855 2436 -4436 4 2 0 1 523 2157 1720 2624 -4437 4 2 0 1 1851 2439 2431 2487 -4438 4 2 0 1 210 1978 1789 2601 -4439 4 2 0 1 1844 1987 1560 1988 -4440 4 2 0 1 1583 2054 1846 2789 -4441 4 2 0 1 706 781 1769 2379 -4442 4 2 0 1 324 2190 2084 2323 -4443 4 2 0 1 1657 1850 2002 2270 -4444 4 2 0 1 1684 1989 1882 2098 -4445 4 2 0 1 1662 2687 2120 2705 -4446 4 2 0 1 1568 2142 1963 2167 -4447 4 2 0 1 2143 2295 1804 2602 -4448 4 2 0 1 2087 2131 1924 2484 -4449 4 2 0 1 1813 1891 1655 2433 -4450 4 2 0 1 1793 1999 1729 2073 -4451 4 2 0 1 1199 1976 1742 2091 -4452 4 2 0 1 613 554 2345 2536 -4453 4 2 0 1 1707 2146 1256 2278 -4454 4 2 0 1 1737 2023 1591 2832 -4455 4 2 0 1 1547 1878 1734 1968 -4456 4 2 0 1 1758 2069 1553 2206 -4457 4 2 0 1 1677 2330 621 2761 -4458 4 2 0 1 573 629 1995 2497 -4459 4 2 0 1 1977 1993 433 2445 -4460 4 2 0 1 1677 1592 2046 2761 -4461 4 2 0 1 1283 1976 1523 2264 -4462 4 2 0 1 1021 1688 1041 2346 -4463 4 2 0 1 1609 1762 2142 2167 -4464 4 2 0 1 1192 1341 2077 2337 -4465 4 2 0 1 768 2034 1826 2529 -4466 4 2 0 1 1615 1751 1898 2636 -4467 4 2 0 1 1547 1734 1878 2790 -4468 4 2 0 1 1653 1949 2009 2169 -4469 4 2 0 1 1207 1937 587 2053 -4470 4 2 0 1 413 2066 377 2068 -4471 4 2 0 1 1739 1871 1701 2808 -4472 4 2 0 1 329 1736 419 2399 -4473 4 2 0 1 1924 2087 1794 2131 -4474 4 2 0 1 1540 2059 1838 2230 -4475 4 2 0 1 1565 1892 1998 2136 -4476 4 2 0 1 2082 2181 2022 2629 -4477 4 2 0 1 419 1736 2200 2399 -4478 4 2 0 1 1342 1353 1780 2512 -4479 4 2 0 1 1673 1806 2004 2312 -4480 4 2 0 1 1571 2136 1785 2265 -4481 4 2 0 1 1557 2357 1819 2613 -4482 4 2 0 1 1341 1425 1762 1992 -4483 4 2 0 1 1710 1883 1576 1959 -4484 4 2 0 1 1873 2251 941 2259 -4485 4 2 0 1 1577 2004 2029 2312 -4486 4 2 0 1 346 1978 326 2556 -4487 4 2 0 1 1861 2391 2071 2438 -4488 4 2 0 1 1757 2307 776 2403 -4489 4 2 0 1 1342 1780 1337 2016 -4490 4 2 0 1 1792 1649 1996 2762 -4491 4 2 0 1 1753 1533 1980 2373 -4492 4 2 0 1 1767 1879 1602 2164 -4493 4 2 0 1 1822 2508 1718 2773 -4494 4 2 0 1 192 1904 1118 2349 -4495 4 2 0 1 787 2055 2135 2529 -4496 4 2 0 1 1567 2400 1809 2661 -4497 4 2 0 1 1693 2174 1572 2183 -4498 4 2 0 1 1496 1995 576 2131 -4499 4 2 0 1 1318 2042 1192 2077 -4500 4 2 0 1 1356 2007 1772 2247 -4501 4 2 0 1 1641 1867 2118 2547 -4502 4 2 0 1 538 1799 620 1937 -4503 4 2 0 1 935 968 980 2589 -4504 4 2 0 1 1569 2237 1983 2590 -4505 4 2 0 1 163 2035 1721 2734 -4506 4 2 0 1 1503 1810 2051 2615 -4507 4 2 0 1 1762 2142 1963 2243 -4508 4 2 0 1 1511 973 1872 2241 -4509 4 2 0 1 792 728 155 2055 -4510 4 2 0 1 1687 2127 2023 2444 -4511 4 2 0 1 1598 2032 1838 2678 -4512 4 2 0 1 634 2169 1841 2766 -4513 4 2 0 1 223 2092 1904 2349 -4514 4 2 0 1 1623 2617 1840 2629 -4515 4 2 0 1 1572 2174 2012 2515 -4516 4 2 0 1 2092 2225 1583 2516 -4517 4 2 0 1 2077 2340 1568 2573 -4518 4 2 0 1 1792 1996 1917 2762 -4519 4 2 0 1 1183 1933 1810 2557 -4520 4 2 0 1 1627 1924 1794 2484 -4521 4 2 0 1 2135 2184 1696 2670 -4522 4 2 0 1 1575 1846 2025 2570 -4523 4 2 0 1 184 1897 481 2330 -4524 4 2 0 1 599 1948 541 2530 -4525 4 2 0 1 193 267 1952 2209 -4526 4 2 0 1 781 2041 1936 2379 -4527 4 2 0 1 1743 1854 1998 2729 -4528 4 2 0 1 1824 2199 1893 2455 -4529 4 2 0 1 1528 2465 1919 2650 -4530 4 2 0 1 1644 2071 2391 2438 -4531 4 2 0 1 1328 1400 1231 2132 -4532 4 2 0 1 1342 1177 1780 2016 -4533 4 2 0 1 1789 2268 357 2269 -4534 4 2 0 1 1556 2370 2016 2429 -4535 4 2 0 1 1820 2609 2289 2767 -4536 4 2 0 1 1713 2288 2267 2585 -4537 4 2 0 1 313 317 2123 2795 -4538 4 2 0 1 1660 1842 1745 2733 -4539 4 2 0 1 1925 1795 2058 2312 -4540 4 2 0 1 928 975 1748 2162 -4541 4 2 0 1 1634 2190 2052 2242 -4542 4 2 0 1 1570 1820 1798 2007 -4543 4 2 0 1 1543 2075 2025 2336 -4544 4 2 0 1 1591 2023 1737 2134 -4545 4 2 0 1 1609 1909 2243 2721 -4546 4 2 0 1 317 2156 2123 2795 -4547 4 2 0 1 1569 1980 2113 2517 -4548 4 2 0 1 1681 1913 1606 1978 -4549 4 2 0 1 1583 2025 2202 2622 -4550 4 2 0 1 261 2124 1884 2533 -4551 4 2 0 1 313 2123 1732 2795 -4552 4 2 0 1 1531 2098 1770 2249 -4553 4 2 0 1 1445 1356 1772 2247 -4554 4 2 0 1 1559 2490 1862 2793 -4555 4 2 0 1 1609 2243 1762 2721 -4556 4 2 0 1 134 1960 1815 2410 -4557 4 2 0 1 1687 2327 1006 2576 -4558 4 2 0 1 1949 2009 1799 2587 -4559 4 2 0 1 387 1983 1902 2669 -4560 4 2 0 1 1638 2234 1986 2476 -4561 4 2 0 1 797 1713 758 2288 -4562 4 2 0 1 1535 2487 1839 2665 -4563 4 2 0 1 1528 1714 2048 2111 -4564 4 2 0 1 1786 2443 2345 2687 -4565 4 2 0 1 1658 2202 1904 2564 -4566 4 2 0 1 1432 2205 1906 2513 -4567 4 2 0 1 1590 2002 1850 2270 -4568 4 2 0 1 1788 2024 1627 2305 -4569 4 2 0 1 1626 2205 2008 2265 -4570 4 2 0 1 1539 1870 2114 2710 -4571 4 2 0 1 1547 1968 1734 2790 -4572 4 2 0 1 1243 1820 2289 2767 -4573 4 2 0 1 1959 2108 1640 2719 -4574 4 2 0 1 773 1993 1849 2403 -4575 4 2 0 1 1624 2137 2076 2301 -4576 4 2 0 1 324 398 373 2323 -4577 4 2 0 1 2431 2439 1851 2731 -4578 4 2 0 1 323 337 199 2448 -4579 4 2 0 1 703 2316 1993 2403 -4580 4 2 0 1 1529 2240 1945 2300 -4581 4 2 0 1 1703 1851 2487 2731 -4582 4 2 0 1 1794 2235 1726 2305 -4583 4 2 0 1 1775 1606 2040 2170 -4584 4 2 0 1 1388 1731 1221 2018 -4585 4 2 0 1 1642 2012 2174 2515 -4586 4 2 0 1 1583 2092 2516 2622 -4587 4 2 0 1 1909 2551 1840 2629 -4588 4 2 0 1 1658 1863 1775 2535 -4589 4 2 0 1 871 994 1761 2803 -4590 4 2 0 1 326 1978 1913 2405 -4591 4 2 0 1 914 867 1961 2280 -4592 4 2 0 1 1437 2053 1414 2104 -4593 4 2 0 1 1189 2620 2146 2640 -4594 4 2 0 1 1602 1879 1767 2333 -4595 4 2 0 1 1834 2396 1727 2654 -4596 4 2 0 1 1694 2366 1947 2683 -4597 4 2 0 1 706 1769 806 2631 -4598 4 2 0 1 1672 2001 1296 2302 -4599 4 2 0 1 2236 2344 1841 2745 -4600 4 2 0 1 1337 1342 1383 2835 -4601 4 2 0 1 1548 1805 1755 2254 -4602 4 2 0 1 1625 2015 1807 2019 -4603 4 2 0 1 1003 1931 990 2155 -4604 4 2 0 1 1437 1280 1730 2724 -4605 4 2 0 1 523 2222 2157 2624 -4606 4 2 0 1 1850 2080 1676 2699 -4607 4 2 0 1 1673 2218 1910 2335 -4608 4 2 0 1 378 1947 1847 2683 -4609 4 2 0 1 531 681 1845 2192 -4610 4 2 0 1 1959 2108 1746 2828 -4611 4 2 0 1 1675 1802 2271 2401 -4612 4 2 0 1 1808 2018 1420 2667 -4613 4 2 0 1 1550 2309 1709 2418 -4614 4 2 0 1 1540 1704 2059 2230 -4615 4 2 0 1 1812 2121 1744 2510 -4616 4 2 0 1 1694 1947 1847 2189 -4617 4 2 0 1 367 414 389 2641 -4618 4 2 0 1 1783 2526 1574 2538 -4619 4 2 0 1 1496 1491 1995 2131 -4620 4 2 0 1 871 1761 994 1931 -4621 4 2 0 1 1892 1998 1641 2118 -4622 4 2 0 1 1460 1984 1937 2724 -4623 4 2 0 1 1736 2438 2071 2756 -4624 4 2 0 1 2191 2594 1587 2710 -4625 4 2 0 1 840 1771 2055 2186 -4626 4 2 0 1 1689 1561 2112 2348 -4627 4 2 0 1 1552 2166 1720 2779 -4628 4 2 0 1 1721 2035 1140 2416 -4629 4 2 0 1 1584 2063 1756 2549 -4630 4 2 0 1 1870 2114 1632 2223 -4631 4 2 0 1 1780 1986 1565 2783 -4632 4 2 0 1 1221 1731 2531 2788 -4633 4 2 0 1 1318 1336 1727 2013 -4634 4 2 0 1 1574 1821 1921 2415 -4635 4 2 0 1 2032 2296 1684 2311 -4636 4 2 0 1 1670 2003 2478 2604 -4637 4 2 0 1 1978 2559 1699 2601 -4638 4 2 0 1 1142 158 1158 2049 -4639 4 2 0 1 2051 2055 1580 2529 -4640 4 2 0 1 2085 2134 1591 2607 -4641 4 2 0 1 998 149 516 1946 -4642 4 2 0 1 1490 1491 1198 1995 -4643 4 2 0 1 995 2137 893 2278 -4644 4 2 0 1 457 227 430 2468 -4645 4 2 0 1 357 352 321 1789 -4646 4 2 0 1 1352 1798 1935 2094 -4647 4 2 0 1 1525 2184 1284 2822 -4648 4 2 0 1 1764 2033 1808 2177 -4649 4 2 0 1 1283 1182 1523 1976 -4650 4 2 0 1 1709 2004 2312 2774 -4651 4 2 0 1 1937 2053 1280 2724 -4652 4 2 0 1 481 1897 428 2560 -4653 4 2 0 1 1563 1697 1915 2662 -4654 4 2 0 1 2084 2190 1634 2323 -4655 4 2 0 1 385 2159 2333 2407 -4656 4 2 0 1 1541 2310 1938 2476 -4657 4 2 0 1 1122 1864 1089 2584 -4658 4 2 0 1 1557 1819 2357 2764 -4659 4 2 0 1 1609 1887 2142 2243 -4660 4 2 0 1 1765 2144 709 2267 -4661 4 2 0 1 490 1918 387 1983 -4662 4 2 0 1 1759 1998 1854 2234 -4663 4 2 0 1 1140 1173 1721 2274 -4664 4 2 0 1 1638 1885 1780 1986 -4665 4 2 0 1 480 2456 582 2658 -4666 4 2 0 1 1814 1843 1647 2224 -4667 4 2 0 1 1602 2185 1861 2698 -4668 4 2 0 1 1655 1950 1891 2430 -4669 4 2 0 1 326 1978 2405 2556 -4670 4 2 0 1 1355 2077 1412 2091 -4671 4 2 0 1 2032 2116 1671 2651 -4672 4 2 0 1 1530 1880 2118 2266 -4673 4 2 0 1 1373 2358 1760 2441 -4674 4 2 0 1 401 2268 1829 2464 -4675 4 2 0 1 1529 2240 2244 2656 -4676 4 2 0 1 1976 2264 1646 2303 -4677 4 2 0 1 512 2225 2173 2818 -4678 4 2 0 1 1736 2067 1813 2417 -4679 4 2 0 1 1582 2316 1690 2816 -4680 4 2 0 1 1708 1820 1616 2022 -4681 4 2 0 1 926 1817 2248 2553 -4682 4 2 0 1 1218 2455 2044 2493 -4683 4 2 0 1 1715 2003 1617 2368 -4684 4 2 0 1 1778 1905 1659 1985 -4685 4 2 0 1 663 1972 1815 2236 -4686 4 2 0 1 1730 2104 1437 2342 -4687 4 2 0 1 1185 1328 1347 1954 -4688 4 2 0 1 1571 1785 2136 2204 -4689 4 2 0 1 1589 1731 2105 2320 -4690 4 2 0 1 192 270 1904 2349 -4691 4 2 0 1 1577 1925 1795 2058 -4692 4 2 0 1 1774 1620 2201 2737 -4693 4 2 0 1 1714 2048 2111 2616 -4694 4 2 0 1 1561 2396 1834 2654 -4695 4 2 0 1 1938 2310 1638 2476 -4696 4 2 0 1 1285 2056 1281 2586 -4697 4 2 0 1 1877 2149 1862 2426 -4698 4 2 0 1 604 599 541 2530 -4699 4 2 0 1 1548 1755 1805 2208 -4700 4 2 0 1 1511 1872 973 2715 -4701 4 2 0 1 1672 1971 1755 2420 -4702 4 2 0 1 1620 1804 1774 2199 -4703 4 2 0 1 769 2186 1826 2307 -4704 4 2 0 1 1547 2250 1869 2434 -4705 4 2 0 1 1568 1878 2142 2167 -4706 4 2 0 1 1799 1937 1730 2053 -4707 4 2 0 1 1523 2264 2303 2339 -4708 4 2 0 1 1848 1925 1584 2083 -4709 4 2 0 1 1731 1803 1628 2499 -4710 4 2 0 1 1762 1568 2077 2340 -4711 4 2 0 1 1659 2682 1985 2727 -4712 4 2 0 1 324 2084 398 2323 -4713 4 2 0 1 1119 1181 1083 2785 -4714 4 2 0 1 1696 2051 2055 2361 -4715 4 2 0 1 1013 155 154 1771 -4716 4 2 0 1 1687 2155 1006 2327 -4717 4 2 0 1 1530 1854 1743 2598 -4718 4 2 0 1 1655 2196 1813 2433 -4719 4 2 0 1 1559 1851 1862 2490 -4720 4 2 0 1 1593 2073 1961 2545 -4721 4 2 0 1 1572 2284 2012 2441 -4722 4 2 0 1 1887 2243 1909 2629 -4723 4 2 0 1 1906 2008 1626 2205 -4724 4 2 0 1 1627 1794 2235 2497 -4725 4 2 0 1 1218 2044 1922 2493 -4726 4 2 0 1 1528 2486 2650 2836 -4727 4 2 0 1 1940 1964 1531 1981 -4728 4 2 0 1 239 1977 2153 2567 -4729 4 2 0 1 1784 1943 1691 2240 -4730 4 2 0 1 1540 1702 1899 2630 -4731 4 2 0 1 1760 1923 1622 2329 -4732 4 2 0 1 1009 2162 1751 2562 -4733 4 2 0 1 2048 2466 2111 2616 -4734 4 2 0 1 1529 1698 2015 2216 -4735 4 2 0 1 1369 1437 2104 2342 -4736 4 2 0 1 1165 1120 1842 1975 -4737 4 2 0 1 1355 2091 1412 2507 -4738 4 2 0 1 1660 1975 1842 2733 -4739 4 2 0 1 1820 2291 1886 2755 -4740 4 2 0 1 1583 1846 2054 2202 -4741 4 2 0 1 1660 1975 1846 1981 -4742 4 2 0 1 1697 1989 2157 2779 -4743 4 2 0 1 1774 1834 1620 2737 -4744 4 2 0 1 1596 2286 1670 2752 -4745 4 2 0 1 1573 1845 1700 2672 -4746 4 2 0 1 1328 2132 1231 2194 -4747 4 2 0 1 1611 2168 1777 2527 -4748 4 2 0 1 168 330 325 2200 -4749 4 2 0 1 1687 2127 226 2679 -4750 4 2 0 1 1660 2491 1975 2733 -4751 4 2 0 1 1728 2240 1886 2479 -4752 4 2 0 1 1837 2188 1741 2511 -4753 4 2 0 1 836 465 837 2106 -4754 4 2 0 1 1545 2031 1856 2809 -4755 4 2 0 1 2100 2377 2161 2643 -4756 4 2 0 1 1719 2289 1438 2551 -4757 4 2 0 1 1754 2259 1929 2561 -4758 4 2 0 1 1541 1759 2310 2476 -4759 4 2 0 1 1594 1716 2176 2319 -4760 4 2 0 1 1342 1383 1780 2322 -4761 4 2 0 1 1834 2201 1620 2737 -4762 4 2 0 1 1173 163 1140 1721 -4763 4 2 0 1 1917 2118 1867 2611 -4764 4 2 0 1 768 1826 779 2529 -4765 4 2 0 1 1737 1895 2023 2832 -4766 4 2 0 1 1574 1782 2024 2308 -4767 4 2 0 1 1809 2400 644 2610 -4768 4 2 0 1 1630 1934 2459 2753 -4769 4 2 0 1 1732 2219 1591 2293 -4770 4 2 0 1 1119 1083 2056 2785 -4771 4 2 0 1 1793 2331 2115 2523 -4772 4 2 0 1 1173 2140 1721 2274 -4773 4 2 0 1 1780 2016 1556 2370 -4774 4 2 0 1 1582 1993 1957 2403 -4775 4 2 0 1 621 2344 1677 2761 -4776 4 2 0 1 218 2207 431 2359 -4777 4 2 0 1 1686 1823 1964 2797 -4778 4 2 0 1 1615 2224 1814 2738 -4779 4 2 0 1 193 1961 526 2477 -4780 4 2 0 1 1738 2650 2486 2836 -4781 4 2 0 1 1565 1892 1785 2665 -4782 4 2 0 1 1165 1975 1842 2414 -4783 4 2 0 1 706 1769 746 2379 -4784 4 2 0 1 1444 1749 1193 2008 -4785 4 2 0 1 1544 2627 2226 2800 -4786 4 2 0 1 1577 2029 1720 2166 -4787 4 2 0 1 1546 1761 2127 2689 -4788 4 2 0 1 1118 2349 1904 2564 -4789 4 2 0 1 876 1907 989 2279 -4790 4 2 0 1 1812 1744 2708 2794 -4791 4 2 0 1 1699 2062 316 2448 -4792 4 2 0 1 1556 1986 1780 2037 -4793 4 2 0 1 1531 1836 2003 2368 -4794 4 2 0 1 1618 1730 2053 2367 -4795 4 2 0 1 1684 1928 1773 2675 -4796 4 2 0 1 1967 2286 1965 2391 -4797 4 2 0 1 812 1936 759 2099 -4798 4 2 0 1 1555 1906 2174 2787 -4799 4 2 0 1 647 1934 2192 2786 -4800 4 2 0 1 1916 2150 1950 2682 -4801 4 2 0 1 1963 2142 1762 2167 -4802 4 2 0 1 1653 1949 1799 2587 -4803 4 2 0 1 1713 2532 1765 2702 -4804 4 2 0 1 1760 2012 1572 2174 -4805 4 2 0 1 1692 2037 1892 2487 -4806 4 2 0 1 1118 192 286 1904 -4807 4 2 0 1 1956 2496 1766 2759 -4808 4 2 0 1 349 1979 223 2349 -4809 4 2 0 1 1703 2487 2439 2731 -4810 4 2 0 1 319 2353 1939 2571 -4811 4 2 0 1 213 2020 1897 2297 -4812 4 2 0 1 1732 2123 1591 2219 -4813 4 2 0 1 1198 580 576 1995 -4814 4 2 0 1 1713 1765 2267 2702 -4815 4 2 0 1 1602 1767 2164 2437 -4816 4 2 0 1 462 1736 329 2020 -4817 4 2 0 1 2022 1623 2289 2609 -4818 4 2 0 1 1088 1055 1975 2119 -4819 4 2 0 1 1527 2296 2032 2311 -4820 4 2 0 1 1599 2048 2152 2160 -4821 4 2 0 1 1598 1836 1734 2193 -4822 4 2 0 1 671 566 1735 2197 -4823 4 2 0 1 535 2197 1984 2419 -4824 4 2 0 1 998 1946 516 2477 -4825 4 2 0 1 323 1979 2559 2601 -4826 4 2 0 1 1529 2015 1698 2540 -4827 4 2 0 1 1641 1892 1867 2304 -4828 4 2 0 1 1728 2226 2627 2800 -4829 4 2 0 1 1690 1993 1977 2445 -4830 4 2 0 1 1882 2098 1989 2147 -4831 4 2 0 1 1611 1970 1802 2504 -4832 4 2 0 1 1994 2056 1083 2785 -4833 4 2 0 1 1902 1983 1569 2237 -4834 4 2 0 1 1687 1894 1600 2514 -4835 4 2 0 1 1642 2174 1906 2787 -4836 4 2 0 1 2011 2454 2306 2572 -4837 4 2 0 1 1809 2196 1567 2661 -4838 4 2 0 1 2195 2356 1887 2600 -4839 4 2 0 1 1987 1988 1844 2388 -4840 4 2 0 1 1152 1106 1960 2060 -4841 4 2 0 1 1550 2085 1941 2418 -4842 4 2 0 1 1818 2396 2340 2599 -4843 4 2 0 1 1600 2292 1754 2492 -4844 4 2 0 1 1645 2151 1876 2509 -4845 4 2 0 1 1861 2185 1736 2698 -4846 4 2 0 1 629 565 1995 2497 -4847 4 2 0 1 1768 2085 1941 2293 -4848 4 2 0 1 1654 2057 1944 2383 -4849 4 2 0 1 825 1752 2316 2451 -4850 4 2 0 1 1669 1844 2078 2664 -4851 4 2 0 1 1774 1834 1679 2011 -4852 4 2 0 1 1083 1994 1127 2056 -4853 4 2 0 1 1737 1895 1591 2489 -4854 4 2 0 1 1540 1874 1702 2630 -4855 4 2 0 1 1902 1918 1569 1983 -4856 4 2 0 1 1962 2460 1784 2623 -4857 4 2 0 1 1688 1021 2274 2346 -4858 4 2 0 1 1571 1743 2136 2347 -4859 4 2 0 1 1695 2002 1835 2449 -4860 4 2 0 1 1820 1798 2387 2760 -4861 4 2 0 1 1676 1983 2237 2590 -4862 4 2 0 1 1783 1921 1574 2526 -4863 4 2 0 1 1722 1657 2113 2517 -4864 4 2 0 1 1988 2015 1625 2806 -4865 4 2 0 1 1125 2119 1763 2255 -4866 4 2 0 1 134 569 663 1815 -4867 4 2 0 1 1557 2357 1910 2764 -4868 4 2 0 1 1808 2177 1554 2392 -4869 4 2 0 1 519 2062 1720 2355 -4870 4 2 0 1 1438 2289 1719 2767 -4871 4 2 0 1 1587 2075 1775 2191 -4872 4 2 0 1 1653 1868 2122 2314 -4873 4 2 0 1 753 2267 2288 2585 -4874 4 2 0 1 1676 1983 1902 2237 -4875 4 2 0 1 1825 1934 1604 2459 -4876 4 2 0 1 1400 1758 1344 2469 -4877 4 2 0 1 1995 2131 1627 2497 -4878 4 2 0 1 1622 2375 2087 2666 -4879 4 2 0 1 352 1789 357 2269 -4880 4 2 0 1 1092 2488 1101 2491 -4881 4 2 0 1 1580 2055 2051 2361 -4882 4 2 0 1 717 1757 2186 2307 -4883 4 2 0 1 1549 1763 2273 2544 -4884 4 2 0 1 1356 1179 1772 2007 -4885 4 2 0 1 1861 2090 2038 2662 -4886 4 2 0 1 1720 1989 1552 2779 -4887 4 2 0 1 1815 2344 2236 2745 -4888 4 2 0 1 1333 2012 1857 2284 -4889 4 2 0 1 1460 1937 1477 2724 -4890 4 2 0 1 1571 2432 1743 2659 -4891 4 2 0 1 2038 2311 1684 2482 -4892 4 2 0 1 1603 2172 1754 2189 -4893 4 2 0 1 218 381 431 2207 -4894 4 2 0 1 1565 1749 2008 2322 -4895 4 2 0 1 1541 2065 1759 2476 -4896 4 2 0 1 1595 2116 1874 2524 -4897 4 2 0 1 1703 2385 1839 2616 -4898 4 2 0 1 1634 1801 2190 2242 -4899 4 2 0 1 1622 1923 1760 1924 -4900 4 2 0 1 1553 1689 1956 2220 -4901 4 2 0 1 226 2576 1687 2679 -4902 4 2 0 1 1812 2465 2121 2510 -4903 4 2 0 1 1633 2318 2243 2739 -4904 4 2 0 1 1666 1878 1836 2356 -4905 4 2 0 1 1371 1373 1760 2263 -4906 4 2 0 1 2267 2288 1713 2532 -4907 4 2 0 1 852 1771 840 2186 -4908 4 2 0 1 1770 1670 2286 2391 -4909 4 2 0 1 1713 2028 1581 2432 -4910 4 2 0 1 1541 1683 2011 2306 -4911 4 2 0 1 1529 2300 1945 2774 -4912 4 2 0 1 401 334 1829 2268 -4913 4 2 0 1 1704 2452 1874 2630 -4914 4 2 0 1 1635 1980 1966 2113 -4915 4 2 0 1 526 521 885 1961 -4916 4 2 0 1 634 1841 2321 2766 -4917 4 2 0 1 1574 1750 2050 2538 -4918 4 2 0 1 1792 2404 1690 2445 -4919 4 2 0 1 1777 2143 1804 2257 -4920 4 2 0 1 1887 2195 1609 2356 -4921 4 2 0 1 2284 2324 1679 2453 -4922 4 2 0 1 184 2297 1897 2330 -4923 4 2 0 1 1755 2420 1971 2781 -4924 4 2 0 1 1809 1948 1567 2433 -4925 4 2 0 1 1582 1977 1877 2149 -4926 4 2 0 1 1373 1760 2012 2441 -4927 4 2 0 1 1957 1993 1582 2316 -4928 4 2 0 1 1241 1908 2263 2358 -4929 4 2 0 1 1917 1996 1649 2762 -4930 4 2 0 1 1670 1967 1965 2752 -4931 4 2 0 1 1565 1885 1780 2322 -4932 4 2 0 1 1257 1200 651 2053 -4933 4 2 0 1 1630 2459 2210 2753 -4934 4 2 0 1 1803 1817 2233 2553 -4935 4 2 0 1 1830 2024 1782 2308 -4936 4 2 0 1 863 907 906 1484 -4937 4 2 0 1 1563 2098 1838 2391 -4938 4 2 0 1 473 2225 2092 2516 -4939 4 2 0 1 1598 1734 2252 2678 -4940 4 2 0 1 1545 2052 1802 2376 -4941 4 2 0 1 1361 2012 1411 2711 -4942 4 2 0 1 1812 2708 2510 2794 -4943 4 2 0 1 1177 1922 1780 2016 -4944 4 2 0 1 1577 1925 2058 2312 -4945 4 2 0 1 1861 2071 2038 2698 -4946 4 2 0 1 644 2400 590 2610 -4947 4 2 0 1 2125 2248 1817 2553 -4948 4 2 0 1 1329 2324 2284 2453 -4949 4 2 0 1 1852 1635 1962 2583 -4950 4 2 0 1 1010 1721 2070 2734 -4951 4 2 0 1 1547 1836 1878 2356 -4952 4 2 0 1 1595 2116 1739 2798 -4953 4 2 0 1 1798 2007 1820 2763 -4954 4 2 0 1 1613 1980 1852 2373 -4955 4 2 0 1 1572 2174 1854 2183 -4956 4 2 0 1 1668 2472 1831 2481 -4957 4 2 0 1 1871 2164 1739 2437 -4958 4 2 0 1 773 720 1849 1993 -4959 4 2 0 1 1888 1625 2015 2806 -4960 4 2 0 1 1634 1802 2052 2376 -4961 4 2 0 1 1886 2291 1616 2755 -4962 4 2 0 1 797 758 800 2288 -4963 4 2 0 1 1751 1898 2224 2428 -4964 4 2 0 1 313 1732 2123 2353 -4965 4 2 0 1 1868 2314 1653 2321 -4966 4 2 0 1 1851 2431 1862 2490 -4967 4 2 0 1 1664 1754 2221 2259 -4968 4 2 0 1 1640 2108 1959 2828 -4969 4 2 0 1 1608 1998 1892 2118 -4970 4 2 0 1 1543 2075 2336 2535 -4971 4 2 0 1 190 2124 254 2456 -4972 4 2 0 1 1936 2379 2041 2736 -4973 4 2 0 1 1533 1920 1753 2080 -4974 4 2 0 1 464 1849 720 1993 -4975 4 2 0 1 1552 1697 1903 2779 -4976 4 2 0 1 1754 1664 2172 2259 -4977 4 2 0 1 1632 2178 1661 2223 -4978 4 2 0 1 1552 1903 1697 2593 -4979 4 2 0 1 1648 1776 2079 2577 -4980 4 2 0 1 1140 163 162 2035 -4981 4 2 0 1 1600 1694 1895 2366 -4982 4 2 0 1 1430 1344 1185 1758 -4983 4 2 0 1 1530 1743 2213 2598 -4984 4 2 0 1 1614 1910 1827 2172 -4985 4 2 0 1 896 1929 2259 2561 -4986 4 2 0 1 1226 1296 1334 2001 -4987 4 2 0 1 1009 1751 983 2279 -4988 4 2 0 1 1529 1691 2240 2300 -4989 4 2 0 1 1003 922 1790 2542 -4990 4 2 0 1 1690 1582 1993 2316 -4991 4 2 0 1 680 1207 643 1937 -4992 4 2 0 1 1975 2491 1120 2733 -4993 4 2 0 1 1661 2563 1994 2582 -4994 4 2 0 1 921 1751 989 2562 -4995 4 2 0 1 1671 2116 2032 2678 -4996 4 2 0 1 1726 2093 1786 2212 -4997 4 2 0 1 1692 2487 1892 2665 -4998 4 2 0 1 2109 2115 1610 2331 -4999 4 2 0 1 1616 2022 1820 2291 -5000 4 2 0 1 1694 1600 1895 2832 -5001 4 2 0 1 305 307 2571 2691 -5002 4 2 0 1 1177 1780 1922 2512 -5003 4 2 0 1 1642 1906 2174 2263 -5004 4 2 0 1 450 278 226 2576 -5005 4 2 0 1 863 1484 906 2184 -5006 4 2 0 1 1565 2136 1858 2265 -5007 4 2 0 1 1829 2268 1947 2464 -5008 4 2 0 1 323 337 1979 2601 -5009 4 2 0 1 1754 2189 2172 2292 -5010 4 2 0 1 1610 1771 2186 2784 -5011 4 2 0 1 1690 1582 1977 1993 -5012 4 2 0 1 1645 1887 1876 2181 -5013 4 2 0 1 1994 2563 1292 2582 -5014 4 2 0 1 1402 904 995 2137 -5015 4 2 0 1 1894 2444 2023 2492 -5016 4 2 0 1 1400 2132 1758 2469 -5017 4 2 0 1 871 1931 994 2155 -5018 4 2 0 1 2034 2451 1890 2684 -5019 4 2 0 1 950 1889 881 2081 -5020 4 2 0 1 792 2135 1696 2670 -5021 4 2 0 1 1541 1791 2065 2476 -5022 4 2 0 1 1677 1990 2330 2694 -5023 4 2 0 1 1746 2108 1959 2719 -5024 4 2 0 1 1913 2170 1930 2713 -5025 4 2 0 1 1632 2056 1994 2785 -5026 4 2 0 1 771 1718 784 2714 -5027 4 2 0 1 2199 2201 1893 2455 -5028 4 2 0 1 1430 1828 1185 2104 -5029 4 2 0 1 213 2297 395 2438 -5030 4 2 0 1 1623 1840 2551 2629 -5031 4 2 0 1 1559 1716 1800 1952 -5032 4 2 0 1 2014 2079 1776 2577 -5033 4 2 0 1 1579 1728 1886 2479 -5034 4 2 0 1 814 1740 759 1936 -5035 4 2 0 1 1736 1861 2071 2438 -5036 4 2 0 1 1754 2172 1664 2221 -5037 4 2 0 1 1679 1834 1774 2737 -5038 4 2 0 1 1806 2293 2219 2680 -5039 4 2 0 1 1954 2104 1758 2206 -5040 4 2 0 1 1629 2068 2066 2106 -5041 4 2 0 1 1766 2069 593 2246 -5042 4 2 0 1 783 776 726 1757 -5043 4 2 0 1 1659 1985 1905 2727 -5044 4 2 0 1 1181 1994 1083 2785 -5045 4 2 0 1 1572 1760 1923 2441 -5046 4 2 0 1 1580 2203 1785 2634 -5047 4 2 0 1 949 1729 2073 2637 -5048 4 2 0 1 1759 1638 2310 2476 -5049 4 2 0 1 1563 2071 1861 2391 -5050 4 2 0 1 1564 1867 1917 2118 -5051 4 2 0 1 1589 2018 1731 2320 -5052 4 2 0 1 1279 1204 2081 2299 -5053 4 2 0 1 1758 2104 1828 2206 -5054 4 2 0 1 878 2241 2057 2279 -5055 4 2 0 1 1529 2015 1888 2216 -5056 4 2 0 1 1600 1847 1754 2292 -5057 4 2 0 1 1852 2429 1712 2566 -5058 4 2 0 1 2054 2225 1904 2626 -5059 4 2 0 1 1667 1931 1790 2771 -5060 4 2 0 1 1561 1689 2112 2654 -5061 4 2 0 1 1605 1720 1989 2575 -5062 4 2 0 1 1834 2011 1620 2396 -5063 4 2 0 1 1857 2012 1572 2284 -5064 4 2 0 1 1700 2256 662 2569 -5065 4 2 0 1 1614 1721 2274 2416 -5066 4 2 0 1 1872 2137 1624 2715 -5067 4 2 0 1 300 1778 2030 2776 -5068 4 2 0 1 1764 1554 2177 2392 -5069 4 2 0 1 1009 983 1751 2162 -5070 4 2 0 1 896 1929 992 2259 -5071 4 2 0 1 1549 2544 1901 2600 -5072 4 2 0 1 1852 2037 1556 2429 -5073 4 2 0 1 1729 1961 2073 2545 -5074 4 2 0 1 1119 1295 1466 1181 -5075 4 2 0 1 1530 1880 1958 2447 -5076 4 2 0 1 1546 1931 1761 2689 -5077 4 2 0 1 2069 2393 1758 2749 -5078 4 2 0 1 199 1699 316 2448 -5079 4 2 0 1 401 238 442 1829 -5080 4 2 0 1 1118 1146 1078 1904 -5081 4 2 0 1 1507 1525 157 2184 -5082 4 2 0 1 193 2209 1729 2477 -5083 4 2 0 1 1005 928 975 1748 -5084 4 2 0 1 1553 1956 1689 2782 -5085 4 2 0 1 747 707 2436 2501 -5086 4 2 0 1 1846 2025 1863 2202 -5087 4 2 0 1 1659 1905 1778 2397 -5088 4 2 0 1 1760 2263 1908 2358 -5089 4 2 0 1 1610 2186 2363 2784 -5090 4 2 0 1 1710 1587 2191 2594 -5091 4 2 0 1 1939 2353 1722 2571 -5092 4 2 0 1 2012 2263 1411 2711 -5093 4 2 0 1 573 1995 1912 2497 -5094 4 2 0 1 1847 2366 2101 2494 -5095 4 2 0 1 293 2448 1686 2516 -5096 4 2 0 1 1757 2109 783 2186 -5097 4 2 0 1 1578 1905 1985 2727 -5098 4 2 0 1 2015 2019 1888 2216 -5099 4 2 0 1 482 1927 1158 2049 -5100 4 2 0 1 909 526 885 2477 -5101 4 2 0 1 975 2382 2162 2421 -5102 4 2 0 1 1416 1708 1268 2289 -5103 4 2 0 1 1602 1861 2038 2698 -5104 4 2 0 1 167 452 258 2159 -5105 4 2 0 1 505 1849 464 1993 -5106 4 2 0 1 1352 1798 1449 1935 -5107 4 2 0 1 1751 2125 989 2562 -5108 4 2 0 1 1580 2034 2634 2718 -5109 4 2 0 1 1966 2121 1635 2465 -5110 4 2 0 1 1318 1192 1354 2077 -5111 4 2 0 1 1257 1360 1414 2104 -5112 4 2 0 1 1154 2170 1930 2565 -5113 4 2 0 1 227 358 430 1737 -5114 4 2 0 1 1697 1563 2038 2662 -5115 4 2 0 1 866 2081 1889 2233 -5116 4 2 0 1 1560 1824 1844 2257 -5117 4 2 0 1 1295 1181 1119 2056 -5118 4 2 0 1 1739 2031 1611 2527 -5119 4 2 0 1 1571 1743 2347 2659 -5120 4 2 0 1 1614 2182 2064 2274 -5121 4 2 0 1 1611 2031 1856 2271 -5122 4 2 0 1 230 239 2153 2567 -5123 4 2 0 1 1743 2136 1998 2354 -5124 4 2 0 1 412 387 1918 2641 -5125 4 2 0 1 519 1720 523 2157 -5126 4 2 0 1 1934 1604 2459 2753 -5127 4 2 0 1 1209 1678 1372 2302 -5128 4 2 0 1 1710 2095 1576 2232 -5129 4 2 0 1 495 503 998 516 -5130 4 2 0 1 1753 2080 1676 2590 -5131 4 2 0 1 1564 1801 2005 2699 -5132 4 2 0 1 1512 1764 1194 2835 -5133 4 2 0 1 629 2131 565 2497 -5134 4 2 0 1 566 1735 2197 2419 -5135 4 2 0 1 1900 2168 1970 2364 -5136 4 2 0 1 1713 2028 797 2585 -5137 4 2 0 1 729 1794 847 2425 -5138 4 2 0 1 1585 1778 2211 2653 -5139 4 2 0 1 352 321 1789 2130 -5140 4 2 0 1 1506 1516 2137 2278 -5141 4 2 0 1 1854 2183 1693 2598 -5142 4 2 0 1 1771 1839 1610 2385 -5143 4 2 0 1 2044 2325 1214 2512 -5144 4 2 0 1 1622 1860 1794 2375 -5145 4 2 0 1 840 2055 1826 2186 -5146 4 2 0 1 1572 1923 1788 2441 -5147 4 2 0 1 1794 1627 2235 2305 -5148 4 2 0 1 1648 2014 1776 2577 -5149 4 2 0 1 1547 2356 1742 2434 -5150 4 2 0 1 1554 2392 1839 2616 -5151 4 2 0 1 1790 1898 1751 2428 -5152 4 2 0 1 1876 1645 2039 2600 -5153 4 2 0 1 428 2472 242 2560 -5154 4 2 0 1 1546 1875 2483 2689 -5155 4 2 0 1 1741 2188 1837 2625 -5156 4 2 0 1 1621 1826 2034 2203 -5157 4 2 0 1 1584 1925 1848 2166 -5158 4 2 0 1 1842 2414 1975 2544 -5159 4 2 0 1 1703 2048 2160 2616 -5160 4 2 0 1 1822 2508 1881 2555 -5161 4 2 0 1 1537 1698 2019 2082 -5162 4 2 0 1 771 784 1718 2508 -5163 4 2 0 1 1641 1867 2547 2611 -5164 4 2 0 1 1873 2382 860 2421 -5165 4 2 0 1 1653 2169 2009 2587 -5166 4 2 0 1 134 1972 663 2410 -5167 4 2 0 1 1544 2182 1951 2335 -5168 4 2 0 1 1615 1898 2224 2636 -5169 4 2 0 1 1993 2316 1957 2403 -5170 4 2 0 1 1895 2123 354 2366 -5171 4 2 0 1 1663 1742 1968 2167 -5172 4 2 0 1 1537 2019 1698 2181 -5173 4 2 0 1 1598 1878 1836 2249 -5174 4 2 0 1 1486 1707 1256 2278 -5175 4 2 0 1 1896 2130 308 2269 -5176 4 2 0 1 1918 2097 389 2641 -5177 4 2 0 1 1595 2798 1739 2808 -5178 4 2 0 1 1471 1475 1944 2383 -5179 4 2 0 1 2005 2647 1564 2699 -5180 4 2 0 1 1875 2127 240 2612 -5181 4 2 0 1 1780 2370 1974 2835 -5182 4 2 0 1 1947 2268 343 2464 -5183 4 2 0 1 1858 1565 2265 2801 -5184 4 2 0 1 1546 2155 1931 2771 -5185 4 2 0 1 1542 1782 2024 2235 -5186 4 2 0 1 1486 1707 1189 2146 -5187 4 2 0 1 671 2197 1869 2390 -5188 4 2 0 1 1584 1773 2063 2549 -5189 4 2 0 1 1378 2289 1438 2767 -5190 4 2 0 1 1462 2133 1212 2420 -5191 4 2 0 1 295 1733 484 2446 -5192 4 2 0 1 852 840 1771 2055 -5193 4 2 0 1 1812 2510 1744 2794 -5194 4 2 0 1 792 2055 1696 2135 -5195 4 2 0 1 708 756 806 2171 -5196 4 2 0 1 1603 1847 1754 2561 -5197 4 2 0 1 1764 2177 1808 2392 -5198 4 2 0 1 418 1930 272 2713 -5199 4 2 0 1 565 2131 1995 2497 -5200 4 2 0 1 1843 2221 1615 2738 -5201 4 2 0 1 1574 2050 1783 2538 -5202 4 2 0 1 1743 1953 1581 2432 -5203 4 2 0 1 1966 2465 2176 2836 -5204 4 2 0 1 1324 2013 1706 2324 -5205 4 2 0 1 2143 2257 1777 2290 -5206 4 2 0 1 157 2135 723 2670 -5207 4 2 0 1 450 2576 226 2679 -5208 4 2 0 1 1713 1571 1942 2432 -5209 4 2 0 1 1587 2075 2126 2578 -5210 4 2 0 1 1732 2219 2293 2680 -5211 4 2 0 1 1550 2113 1768 2293 -5212 4 2 0 1 1571 1953 1713 2532 -5213 4 2 0 1 814 2028 1740 2045 -5214 4 2 0 1 1890 1942 803 2288 -5215 4 2 0 1 1635 2402 1941 2460 -5216 4 2 0 1 706 1769 1936 2099 -5217 4 2 0 1 985 955 979 2057 -5218 4 2 0 1 847 1794 729 2087 -5219 4 2 0 1 1616 1820 1708 2755 -5220 4 2 0 1 1833 2239 2150 2506 -5221 4 2 0 1 498 2262 2062 2355 -5222 4 2 0 1 1531 1770 2098 2604 -5223 4 2 0 1 2116 2230 2032 2678 -5224 4 2 0 1 1659 1733 2088 2446 -5225 4 2 0 1 1159 165 164 1797 -5226 4 2 0 1 1912 1995 1627 2497 -5227 4 2 0 1 1906 2008 1386 2711 -5228 4 2 0 1 1572 1923 1760 2174 -5229 4 2 0 1 2105 2320 1731 2534 -5230 4 2 0 1 1727 2013 1834 2654 -5231 4 2 0 1 1595 1739 2116 2808 -5232 4 2 0 1 1942 1991 752 2677 -5233 4 2 0 1 1768 2176 1966 2465 -5234 4 2 0 1 724 1794 847 2087 -5235 4 2 0 1 1585 1778 2030 2211 -5236 4 2 0 1 329 2020 1736 2399 -5237 4 2 0 1 1854 2174 1572 2515 -5238 4 2 0 1 1006 2155 1687 2542 -5239 4 2 0 1 1657 1722 1997 2691 -5240 4 2 0 1 1516 2146 1453 2301 -5241 4 2 0 1 1621 2203 2034 2634 -5242 4 2 0 1 1348 1872 2076 2383 -5243 4 2 0 1 1807 2019 2015 2082 -5244 4 2 0 1 1610 1839 1771 2784 -5245 4 2 0 1 1827 1614 2182 2218 -5246 4 2 0 1 602 1799 605 2009 -5247 4 2 0 1 1530 1759 1854 2183 -5248 4 2 0 1 1844 1988 1560 2290 -5249 4 2 0 1 1898 1812 2224 2428 -5250 4 2 0 1 1850 2080 2590 2614 -5251 4 2 0 1 1673 1945 1806 2312 -5252 4 2 0 1 1428 2131 2087 2484 -5253 4 2 0 1 1540 2059 2122 2827 -5254 4 2 0 1 1878 2047 1968 2167 -5255 4 2 0 1 1841 2344 612 2761 -5256 4 2 0 1 1782 1916 1604 2093 -5257 4 2 0 1 1871 2524 1701 2808 -5258 4 2 0 1 1533 1802 1920 2080 -5259 4 2 0 1 1428 2087 1924 2484 -5260 4 2 0 1 1582 1690 1977 2163 -5261 4 2 0 1 1801 1564 2005 2647 -5262 4 2 0 1 1747 1880 2597 2762 -5263 4 2 0 1 1314 1209 1372 2302 -5264 4 2 0 1 190 261 2124 2456 -5265 4 2 0 1 1856 2031 1739 2809 -5266 4 2 0 1 266 517 500 2626 -5267 4 2 0 1 1655 1950 2430 2727 -5268 4 2 0 1 462 1736 2020 2438 -5269 4 2 0 1 1586 1835 1900 1970 -5270 4 2 0 1 1638 1938 1922 2044 -5271 4 2 0 1 1838 2059 1704 2230 -5272 4 2 0 1 1056 1715 2488 2503 -5273 4 2 0 1 1225 1339 2076 2668 -5274 4 2 0 1 1686 2262 2062 2448 -5275 4 2 0 1 1630 1934 1825 2459 -5276 4 2 0 1 1725 1567 2207 2661 -5277 4 2 0 1 822 1183 1290 1210 -5278 4 2 0 1 1711 2075 1853 2126 -5279 4 2 0 1 367 389 2097 2641 -5280 4 2 0 1 1656 1795 2108 2578 -5281 4 2 0 1 2076 2254 1755 2383 -5282 4 2 0 1 1584 1756 2083 2549 -5283 4 2 0 1 1684 1882 1773 2098 -5284 4 2 0 1 835 748 1210 1933 -5285 4 2 0 1 1803 1944 1731 2558 -5286 4 2 0 1 1932 1962 1635 2583 -5287 4 2 0 1 1623 2022 2181 2629 -5288 4 2 0 1 1788 2284 1572 2441 -5289 4 2 0 1 1672 1755 1971 2208 -5290 4 2 0 1 1808 2033 2018 2667 -5291 4 2 0 1 1401 1399 1893 2770 -5292 4 2 0 1 1645 1756 2063 2549 -5293 4 2 0 1 165 1797 1159 2140 -5294 4 2 0 1 1533 1753 1980 2080 -5295 4 2 0 1 1437 1730 1280 2053 -5296 4 2 0 1 1600 1754 2251 2492 -5297 4 2 0 1 1009 2162 2562 2695 -5298 4 2 0 1 1846 1981 1715 2491 -5299 4 2 0 1 1445 1356 1179 1772 -5300 4 2 0 1 378 1847 2366 2683 -5301 4 2 0 1 594 1948 1845 2260 -5302 4 2 0 1 1584 2166 1888 2216 -5303 4 2 0 1 1739 2798 2398 2808 -5304 4 2 0 1 1823 1583 2225 2516 -5305 4 2 0 1 1574 2024 2276 2308 -5306 4 2 0 1 1533 2231 1852 2334 -5307 4 2 0 1 1335 2077 1762 2091 -5308 4 2 0 1 1753 1676 2080 2699 -5309 4 2 0 1 1746 1587 2138 2828 -5310 4 2 0 1 1529 1691 2015 2240 -5311 4 2 0 1 1822 1718 2502 2773 -5312 4 2 0 1 1981 1756 2063 2646 -5313 4 2 0 1 1741 2625 2226 2800 -5314 4 2 0 1 1900 2296 1682 2482 -5315 4 2 0 1 1827 2218 2182 2335 -5316 4 2 0 1 1574 2036 1706 2050 -5317 4 2 0 1 1590 1903 1835 2593 -5318 4 2 0 1 672 1845 681 2180 -5319 4 2 0 1 1013 1771 154 2165 -5320 4 2 0 1 1552 1697 2482 2593 -5321 4 2 0 1 1567 1948 1809 2400 -5322 4 2 0 1 1574 2050 2454 2746 -5323 4 2 0 1 1537 1698 2082 2181 -5324 4 2 0 1 1386 1906 1432 2008 -5325 4 2 0 1 1802 2334 2271 2504 -5326 4 2 0 1 1836 2003 1617 2595 -5327 4 2 0 1 1512 1194 1764 2822 -5328 4 2 0 1 1831 2472 1897 2560 -5329 4 2 0 1 1617 2003 1836 2368 -5330 4 2 0 1 1751 2428 2224 2636 -5331 4 2 0 1 368 214 382 2516 -5332 4 2 0 1 1793 2115 1724 2461 -5333 4 2 0 1 1820 2387 2021 2755 -5334 4 2 0 1 462 1861 1736 2438 -5335 4 2 0 1 1617 1715 1960 2003 -5336 4 2 0 1 1609 2195 1976 2356 -5337 4 2 0 1 1919 2650 1738 2836 -5338 4 2 0 1 1780 2037 1986 2783 -5339 4 2 0 1 1528 2650 1919 2836 -5340 4 2 0 1 1089 1122 1091 1746 -5341 4 2 0 1 1657 1722 2113 2568 -5342 4 2 0 1 379 1965 1915 2662 -5343 4 2 0 1 1255 2620 1189 2640 -5344 4 2 0 1 1959 2043 1710 2518 -5345 4 2 0 1 300 1778 182 2030 -5346 4 2 0 1 337 199 2448 2601 -5347 4 2 0 1 1889 2365 1724 2589 -5348 4 2 0 1 1847 1947 378 2464 -5349 4 2 0 1 293 2062 2262 2448 -5350 4 2 0 1 1587 2541 1864 2584 -5351 4 2 0 1 2224 2428 2096 2636 -5352 4 2 0 1 1587 2108 1746 2541 -5353 4 2 0 1 1628 2152 1889 2261 -5354 4 2 0 1 1565 1785 2265 2351 -5355 4 2 0 1 352 2130 1789 2269 -5356 4 2 0 1 1542 2093 1782 2235 -5357 4 2 0 1 1799 2009 602 2587 -5358 4 2 0 1 1816 2027 1778 2030 -5359 4 2 0 1 2196 2207 1567 2661 -5360 4 2 0 1 1815 1960 569 2350 -5361 4 2 0 1 1552 1697 1989 2482 -5362 4 2 0 1 614 541 1948 2530 -5363 4 2 0 1 823 2253 1776 2649 -5364 4 2 0 1 1624 2188 1837 2511 -5365 4 2 0 1 1562 1770 2193 2595 -5366 4 2 0 1 1777 2257 1804 2707 -5367 4 2 0 1 1575 1981 2039 2646 -5368 4 2 0 1 1830 2276 2024 2308 -5369 4 2 0 1 1583 1981 1846 2025 -5370 4 2 0 1 1967 1990 1596 2745 -5371 4 2 0 1 1540 2122 2630 2827 -5372 4 2 0 1 319 307 2353 2571 -5373 4 2 0 1 1837 2188 1624 2625 -5374 4 2 0 1 1646 2339 2264 2522 -5375 4 2 0 1 1577 1848 1720 2805 -5376 4 2 0 1 1041 2346 1688 2458 -5377 4 2 0 1 2173 2478 1723 2789 -5378 4 2 0 1 881 1781 899 1889 -5379 4 2 0 1 1683 2306 1541 2602 -5380 4 2 0 1 1890 1991 1571 2634 -5381 4 2 0 1 1863 2025 1846 2570 -5382 4 2 0 1 1799 2053 1730 2367 -5383 4 2 0 1 1144 1688 1021 2274 -5384 4 2 0 1 1832 2073 929 2280 -5385 4 2 0 1 354 2366 2123 2683 -5386 4 2 0 1 1632 1994 1661 2178 -5387 4 2 0 1 2063 2505 1981 2646 -5388 4 2 0 1 1449 1935 1798 2247 -5389 4 2 0 1 1588 1879 2200 2446 -5390 4 2 0 1 1595 2398 2798 2808 -5391 4 2 0 1 1009 921 1751 2279 -5392 4 2 0 1 2123 2156 1732 2795 -5393 4 2 0 1 1797 2140 165 2278 -5394 4 2 0 1 1676 2590 2080 2614 -5395 4 2 0 1 1227 1834 1336 2013 -5396 4 2 0 1 747 836 837 2106 -5397 4 2 0 1 1675 1791 2334 2701 -5398 4 2 0 1 1583 2516 1823 2622 -5399 4 2 0 1 1917 2597 1880 2762 -5400 4 2 0 1 1732 2293 1806 2680 -5401 4 2 0 1 766 776 2307 2403 -5402 4 2 0 1 2031 2168 1611 2527 -5403 4 2 0 1 1555 1936 2608 2659 -5404 4 2 0 1 759 1740 801 2677 -5405 4 2 0 1 1852 2037 1613 2373 -5406 4 2 0 1 1628 1889 1817 2261 -5407 4 2 0 1 1656 2187 1925 2216 -5408 4 2 0 1 1315 1944 2383 2531 -5409 4 2 0 1 1862 2431 1619 2490 -5410 4 2 0 1 1562 2193 2175 2595 -5411 4 2 0 1 1662 2161 2100 2377 -5412 4 2 0 1 1754 2251 1873 2259 -5413 4 2 0 1 1578 2443 1950 2682 -5414 4 2 0 1 1965 2391 1861 2438 -5415 4 2 0 1 2340 2396 1818 2820 -5416 4 2 0 1 1669 1938 2143 2257 -5417 4 2 0 1 765 710 1822 2555 -5418 4 2 0 1 138 2264 1735 2419 -5419 4 2 0 1 1635 1784 2460 2623 -5420 4 2 0 1 1802 1545 2271 2401 -5421 4 2 0 1 1583 2025 1846 2202 -5422 4 2 0 1 1529 1698 2216 2540 -5423 4 2 0 1 1486 1707 2278 2696 -5424 4 2 0 1 761 825 855 2316 -5425 4 2 0 1 352 357 2268 2269 -5426 4 2 0 1 1335 1341 1425 1762 -5427 4 2 0 1 313 317 315 2123 -5428 4 2 0 1 1401 1893 1399 2201 -5429 4 2 0 1 1563 1965 2147 2391 -5430 4 2 0 1 1686 2262 1823 2797 -5431 4 2 0 1 2266 2334 1791 2701 -5432 4 2 0 1 1810 2051 1580 2529 -5433 4 2 0 1 1575 2025 1981 2646 -5434 4 2 0 1 677 647 632 1934 -5435 4 2 0 1 1649 1996 1917 2597 -5436 4 2 0 1 1546 1898 2389 2444 -5437 4 2 0 1 1677 1990 1967 2745 -5438 4 2 0 1 1635 2113 1941 2623 -5439 4 2 0 1 1800 1952 1716 2826 -5440 4 2 0 1 1707 2346 1576 2474 -5441 4 2 0 1 1675 2266 1791 2701 -5442 4 2 0 1 1889 2152 1817 2261 -5443 4 2 0 1 758 1713 797 2585 -5444 4 2 0 1 1153 1870 1036 1994 -5445 4 2 0 1 1795 2006 1656 2108 -5446 4 2 0 1 1867 1892 1535 2304 -5447 4 2 0 1 1615 1790 1894 2444 -5448 4 2 0 1 608 621 2330 2761 -5449 4 2 0 1 1880 2118 1917 2547 -5450 4 2 0 1 1310 1788 2036 2475 -5451 4 2 0 1 1713 2267 1765 2585 -5452 4 2 0 1 210 1789 357 2601 -5453 4 2 0 1 1706 1954 1639 2579 -5454 4 2 0 1 1566 2125 1751 2428 -5455 4 2 0 1 2096 2224 1812 2428 -5456 4 2 0 1 803 1991 1890 2684 -5457 4 2 0 1 1747 1917 1880 2762 -5458 4 2 0 1 491 2298 292 2353 -5459 4 2 0 1 1635 2460 1962 2623 -5460 4 2 0 1 1531 2098 1882 2604 -5461 4 2 0 1 1761 2107 2280 2803 -5462 4 2 0 1 1753 2080 1920 2699 -5463 4 2 0 1 1880 2354 2118 2547 -5464 4 2 0 1 1694 2292 1600 2832 -5465 4 2 0 1 1772 2007 1179 2767 -5466 4 2 0 1 1671 2032 2651 2678 -5467 4 2 0 1 1558 1816 2017 2502 -5468 4 2 0 1 1779 1871 1588 2164 -5469 4 2 0 1 1698 2019 2015 2216 -5470 4 2 0 1 1862 2089 2149 2431 -5471 4 2 0 1 1354 1235 2342 2507 -5472 4 2 0 1 1671 2230 2116 2678 -5473 4 2 0 1 1127 1039 2056 2255 -5474 4 2 0 1 1757 2403 776 2628 -5475 4 2 0 1 1647 1843 1814 2673 -5476 4 2 0 1 1759 2065 1865 2471 -5477 4 2 0 1 1838 2059 1540 2071 -5478 4 2 0 1 1699 2448 199 2601 -5479 4 2 0 1 1937 1984 558 2408 -5480 4 2 0 1 791 1946 151 2628 -5481 4 2 0 1 1660 1745 2238 2733 -5482 4 2 0 1 1768 1919 1594 2176 -5483 4 2 0 1 1824 1893 1560 2550 -5484 4 2 0 1 1633 1992 1762 2148 -5485 4 2 0 1 1660 2544 2039 2600 -5486 4 2 0 1 239 2153 1977 2539 -5487 4 2 0 1 1571 1858 2136 2265 -5488 4 2 0 1 1402 995 1506 2137 -5489 4 2 0 1 1534 1754 2172 2292 -5490 4 2 0 1 1333 1322 2012 2284 -5491 4 2 0 1 1561 1818 2572 2599 -5492 4 2 0 1 1571 1713 1953 2432 -5493 4 2 0 1 1577 2029 1896 2624 -5494 4 2 0 1 1628 2261 1731 2534 -5495 4 2 0 1 206 1983 387 2669 -5496 4 2 0 1 1553 2206 2069 2496 -5497 4 2 0 1 1886 1691 2072 2240 -5498 4 2 0 1 1503 2557 1810 2615 -5499 4 2 0 1 193 1729 1961 2477 -5500 4 2 0 1 1788 1627 1924 2305 -5501 4 2 0 1 1575 1763 2039 2544 -5502 4 2 0 1 1771 828 2115 2186 -5503 4 2 0 1 580 1995 1198 2294 -5504 4 2 0 1 401 343 2268 2464 -5505 4 2 0 1 780 2436 707 2501 -5506 4 2 0 1 574 2345 554 2530 -5507 4 2 0 1 841 143 2120 2212 -5508 4 2 0 1 812 814 759 1936 -5509 4 2 0 1 768 805 1826 2034 -5510 4 2 0 1 1823 2262 1964 2797 -5511 4 2 0 1 1613 1852 1980 2566 -5512 4 2 0 1 1706 1639 2013 2579 -5513 4 2 0 1 1348 1298 1872 2383 -5514 4 2 0 1 1568 1727 2340 2396 -5515 4 2 0 1 1672 1589 2102 2302 -5516 4 2 0 1 1605 1720 2575 2797 -5517 4 2 0 1 308 2130 1896 2624 -5518 4 2 0 1 401 1829 442 1927 -5519 4 2 0 1 1582 1690 2163 2816 -5520 4 2 0 1 2100 2161 1648 2643 -5521 4 2 0 1 1728 2244 2240 2656 -5522 4 2 0 1 1870 1994 1632 2255 -5523 4 2 0 1 1926 2320 1712 2429 -5524 4 2 0 1 1639 1954 1706 2220 -5525 4 2 0 1 2076 2383 1755 2668 -5526 4 2 0 1 1575 2039 1763 2509 -5527 4 2 0 1 1715 1981 1846 2789 -5528 4 2 0 1 1863 2202 1658 2564 -5529 4 2 0 1 787 2055 731 2135 -5530 4 2 0 1 1625 1888 2015 2019 -5531 4 2 0 1 1662 2093 1786 2443 -5532 4 2 0 1 1290 1810 822 2722 -5533 4 2 0 1 1711 2191 1587 2710 -5534 4 2 0 1 1713 1765 2074 2585 -5535 4 2 0 1 1751 2096 2428 2636 -5536 4 2 0 1 1566 1944 1803 2558 -5537 4 2 0 1 1165 1842 1120 2733 -5538 4 2 0 1 1833 1958 2239 2506 -5539 4 2 0 1 1649 2027 1816 2030 -5540 4 2 0 1 747 2436 2106 2501 -5541 4 2 0 1 1687 1600 2023 2317 -5542 4 2 0 1 1817 2152 1889 2365 -5543 4 2 0 1 1592 2122 1868 2314 -5544 4 2 0 1 1634 2084 2052 2190 -5545 4 2 0 1 1602 1767 2437 2807 -5546 4 2 0 1 1733 1659 2088 2653 -5547 4 2 0 1 1257 651 1289 1828 -5548 4 2 0 1 1721 2140 1797 2625 -5549 4 2 0 1 1545 2031 1802 2271 -5550 4 2 0 1 1546 2444 2155 2771 -5551 4 2 0 1 289 2157 523 2222 -5552 4 2 0 1 1535 1892 1867 2110 -5553 4 2 0 1 2164 2437 1767 2807 -5554 4 2 0 1 1699 2559 1979 2601 -5555 4 2 0 1 1628 1781 1889 2592 -5556 4 2 0 1 1600 2292 1694 2366 -5557 4 2 0 1 1583 2092 1904 2225 -5558 4 2 0 1 1281 2056 1787 2586 -5559 4 2 0 1 1869 2250 1735 2434 -5560 4 2 0 1 1941 2113 1768 2623 -5561 4 2 0 1 1613 2111 2429 2566 -5562 4 2 0 1 602 2009 605 2587 -5563 4 2 0 1 1887 2600 1876 2617 -5564 4 2 0 1 1740 1936 2045 2659 -5565 4 2 0 1 226 2127 278 2327 -5566 4 2 0 1 1926 2102 1712 2320 -5567 4 2 0 1 1775 2170 1930 2535 -5568 4 2 0 1 316 1699 199 2601 -5569 4 2 0 1 1707 2140 2619 2625 -5570 4 2 0 1 1804 2199 1620 2245 -5571 4 2 0 1 1538 1943 1784 2402 -5572 4 2 0 1 1704 2122 2452 2630 -5573 4 2 0 1 1702 1891 2067 2580 -5574 4 2 0 1 1580 2634 1785 2718 -5575 4 2 0 1 1712 2320 2102 2794 -5576 4 2 0 1 1850 1676 2080 2614 -5577 4 2 0 1 1822 2436 1718 2508 -5578 4 2 0 1 466 444 520 1800 -5579 4 2 0 1 1965 1967 1644 2438 -5580 4 2 0 1 1552 1900 2369 2593 -5581 4 2 0 1 1886 1691 2240 2540 -5582 4 2 0 1 1624 1872 1748 2254 -5583 4 2 0 1 915 1803 2462 2775 -5584 4 2 0 1 720 1849 464 2692 -5585 4 2 0 1 1528 2048 2486 2836 -5586 4 2 0 1 1767 2333 2159 2407 -5587 4 2 0 1 514 1831 497 2359 -5588 4 2 0 1 1706 2050 2036 2746 -5589 4 2 0 1 1574 2036 2050 2746 -5590 4 2 0 1 1891 2546 2154 2706 -5591 4 2 0 1 1599 2486 2248 2778 -5592 4 2 0 1 213 1897 437 2297 -5593 4 2 0 1 2164 2437 1871 2698 -5594 4 2 0 1 1665 2149 1977 2163 -5595 4 2 0 1 1556 2037 1852 2231 -5596 4 2 0 1 854 2161 714 2649 -5597 4 2 0 1 401 1829 1927 2464 -5598 4 2 0 1 1588 1891 1813 2067 -5599 4 2 0 1 758 753 2288 2585 -5600 4 2 0 1 1579 1971 1943 2411 -5601 4 2 0 1 808 2253 1822 2378 -5602 4 2 0 1 431 2207 1725 2359 -5603 4 2 0 1 1547 1901 1745 2238 -5604 4 2 0 1 1594 1919 1768 2607 -5605 4 2 0 1 1739 2168 2031 2527 -5606 4 2 0 1 1836 1878 1734 2790 -5607 4 2 0 1 1342 1337 1177 2016 -5608 4 2 0 1 1736 2020 2438 2756 -5609 4 2 0 1 2210 2459 1604 2753 -5610 4 2 0 1 1649 2030 1816 2525 -5611 4 2 0 1 983 1751 2162 2279 -5612 4 2 0 1 2115 2331 2109 2523 -5613 4 2 0 1 778 1933 851 2596 -5614 4 2 0 1 1533 2334 1852 2373 -5615 4 2 0 1 1359 1231 2132 2467 -5616 4 2 0 1 1786 2345 618 2687 -5617 4 2 0 1 1593 1832 1999 2061 -5618 4 2 0 1 138 2179 1735 2264 -5619 4 2 0 1 1917 2597 1996 2671 -5620 4 2 0 1 685 652 1869 2777 -5621 4 2 0 1 1969 2038 1602 2090 -5622 4 2 0 1 1945 2227 1728 2656 -5623 4 2 0 1 1576 1914 1707 2474 -5624 4 2 0 1 213 437 395 2297 -5625 4 2 0 1 1881 2161 2377 2643 -5626 4 2 0 1 1807 1988 1987 2015 -5627 4 2 0 1 1600 2317 2101 2366 -5628 4 2 0 1 634 529 1841 2169 -5629 4 2 0 1 1659 2088 1982 2446 -5630 4 2 0 1 1846 2488 1715 2789 -5631 4 2 0 1 1779 2088 1833 2809 -5632 4 2 0 1 1710 2191 2138 2594 -5633 4 2 0 1 1572 1857 2284 2712 -5634 4 2 0 1 1838 2098 1770 2391 -5635 4 2 0 1 557 534 581 2330 -5636 4 2 0 1 792 1696 2055 2670 -5637 4 2 0 1 2082 2022 2291 2609 -5638 4 2 0 1 1660 1901 1842 2544 -5639 4 2 0 1 1657 1997 1722 2568 -5640 4 2 0 1 1118 1904 1078 2564 -5641 4 2 0 1 784 1718 2508 2714 -5642 4 2 0 1 2061 2280 1832 2588 -5643 4 2 0 1 1685 1991 2265 2596 -5644 4 2 0 1 1871 2343 2067 2524 -5645 4 2 0 1 1754 2251 941 2495 -5646 4 2 0 1 1907 1944 1654 2057 -5647 4 2 0 1 516 2209 1946 2338 -5648 4 2 0 1 176 2268 339 2269 -5649 4 2 0 1 1670 1770 2147 2391 -5650 4 2 0 1 881 1889 937 2081 -5651 4 2 0 1 1838 2032 1701 2230 -5652 4 2 0 1 1713 1581 2074 2432 -5653 4 2 0 1 1967 2297 1644 2438 -5654 4 2 0 1 1336 1192 1727 2337 -5655 4 2 0 1 1627 1794 1924 2305 -5656 4 2 0 1 759 801 798 2677 -5657 4 2 0 1 349 1930 1979 2349 -5658 4 2 0 1 1549 2273 2414 2544 -5659 4 2 0 1 1579 1943 1886 2072 -5660 4 2 0 1 1625 1900 2103 2296 -5661 4 2 0 1 1794 1726 2235 2497 -5662 4 2 0 1 762 1890 2451 2684 -5663 4 2 0 1 1594 1875 1737 2468 -5664 4 2 0 1 1685 2634 2034 2718 -5665 4 2 0 1 1846 1981 1583 2789 -5666 4 2 0 1 138 671 566 1735 -5667 4 2 0 1 779 768 805 1826 -5668 4 2 0 1 1740 2608 1936 2659 -5669 4 2 0 1 1358 2076 1357 2301 -5670 4 2 0 1 2018 1731 2320 2534 -5671 4 2 0 1 682 2283 1726 2497 -5672 4 2 0 1 184 428 481 1897 -5673 4 2 0 1 1553 1689 2220 2782 -5674 4 2 0 1 1546 1931 2689 2771 -5675 4 2 0 1 1539 2114 1853 2710 -5676 4 2 0 1 1743 1998 2136 2729 -5677 4 2 0 1 1733 1585 2052 2190 -5678 4 2 0 1 1883 1576 1959 2810 -5679 4 2 0 1 782 2120 1881 2161 -5680 4 2 0 1 1835 2369 1900 2593 -5681 4 2 0 1 1720 1605 1989 2355 -5682 4 2 0 1 1634 1920 2080 2699 -5683 4 2 0 1 947 914 2107 2280 -5684 4 2 0 1 1752 2288 2267 2532 -5685 4 2 0 1 1666 1836 1878 2249 -5686 4 2 0 1 2158 2224 1548 2636 -5687 4 2 0 1 1850 2590 1983 2614 -5688 4 2 0 1 1537 2019 1807 2082 -5689 4 2 0 1 1936 1769 2379 2736 -5690 4 2 0 1 1749 2008 1444 2205 -5691 4 2 0 1 1584 2083 1925 2216 -5692 4 2 0 1 1922 1938 1651 2044 -5693 4 2 0 1 1850 2005 1676 2614 -5694 4 2 0 1 1780 2370 2037 2783 -5695 4 2 0 1 967 2057 876 2279 -5696 4 2 0 1 1056 1715 1101 2488 -5697 4 2 0 1 804 2267 1752 2288 -5698 4 2 0 1 1540 1871 2067 2524 -5699 4 2 0 1 1324 2324 1706 2655 -5700 4 2 0 1 1009 983 921 2279 -5701 4 2 0 1 2195 2273 1840 2586 -5702 4 2 0 1 1503 1494 2051 2722 -5703 4 2 0 1 1777 2168 1611 2796 -5704 4 2 0 1 1566 1907 1751 2125 -5705 4 2 0 1 1285 1206 2056 2586 -5706 4 2 0 1 367 2097 414 2641 -5707 4 2 0 1 1531 1981 1756 2063 -5708 4 2 0 1 299 2005 1859 2647 -5709 4 2 0 1 1753 2237 2352 2431 -5710 4 2 0 1 1689 1874 2452 2652 -5711 4 2 0 1 1713 2267 2532 2702 -5712 4 2 0 1 1231 2194 2132 2467 -5713 4 2 0 1 1862 2439 2431 2731 -5714 4 2 0 1 1736 2067 1871 2632 -5715 4 2 0 1 1233 1199 1742 2091 -5716 4 2 0 1 1512 2822 1764 2835 -5717 4 2 0 1 1793 2073 1729 2637 -5718 4 2 0 1 1547 1878 1836 2790 -5719 4 2 0 1 1768 1941 1635 2113 -5720 4 2 0 1 852 828 154 1771 -5721 4 2 0 1 1789 2268 1829 2556 -5722 4 2 0 1 1569 2176 1716 2423 -5723 4 2 0 1 672 531 681 1845 -5724 4 2 0 1 1747 2597 1649 2762 -5725 4 2 0 1 1570 1807 1987 2015 -5726 4 2 0 1 1706 2013 1639 2220 -5727 4 2 0 1 875 2280 2107 2803 -5728 4 2 0 1 1600 1847 2292 2366 -5729 4 2 0 1 1734 2047 1878 2252 -5730 4 2 0 1 1159 1797 164 2140 -5731 4 2 0 1 901 2070 957 2137 -5732 4 2 0 1 2043 2095 1710 2518 -5733 4 2 0 1 2176 2465 1919 2836 -5734 4 2 0 1 151 1946 2523 2628 -5735 4 2 0 1 1557 1746 2108 2541 -5736 4 2 0 1 1603 1947 1847 2464 -5737 4 2 0 1 797 2028 802 2585 -5738 4 2 0 1 1753 2237 2431 2633 -5739 4 2 0 1 1820 2387 2755 2760 -5740 4 2 0 1 1042 1092 1029 2488 -5741 4 2 0 1 1687 2155 2127 2444 -5742 4 2 0 1 2077 2091 1355 2507 -5743 4 2 0 1 791 150 151 1946 -5744 4 2 0 1 1225 2076 1309 2668 -5745 4 2 0 1 1588 2200 1982 2446 -5746 4 2 0 1 1669 2231 1852 2583 -5747 4 2 0 1 1772 1179 2275 2767 -5748 4 2 0 1 244 502 996 2049 -5749 4 2 0 1 778 2596 815 2684 -5750 4 2 0 1 385 167 258 2159 -5751 4 2 0 1 1755 2076 1309 2740 -5752 4 2 0 1 1861 2038 1563 2662 -5753 4 2 0 1 190 2124 261 2533 -5754 4 2 0 1 1964 2262 1605 2797 -5755 4 2 0 1 1760 1234 2263 2358 -5756 4 2 0 1 339 2268 2156 2269 -5757 4 2 0 1 991 2461 2115 2523 -5758 4 2 0 1 1657 1850 2080 2590 -5759 4 2 0 1 1946 2477 892 2637 -5760 4 2 0 1 1582 1877 1849 2426 -5761 4 2 0 1 1930 2170 1035 2713 -5762 4 2 0 1 1779 1833 2688 2809 -5763 4 2 0 1 1656 2006 1925 2187 -5764 4 2 0 1 1867 2110 1892 2829 -5765 4 2 0 1 1833 2088 1545 2809 -5766 4 2 0 1 1565 2322 1780 2783 -5767 4 2 0 1 814 1740 1936 2045 -5768 4 2 0 1 1639 2220 2013 2654 -5769 4 2 0 1 1587 2126 1711 2710 -5770 4 2 0 1 1584 1925 2166 2216 -5771 4 2 0 1 618 2345 1786 2536 -5772 4 2 0 1 1683 1804 2295 2602 -5773 4 2 0 1 991 897 2461 2523 -5774 4 2 0 1 1056 1960 1715 2503 -5775 4 2 0 1 1564 2597 1917 2671 -5776 4 2 0 1 1756 1981 1964 2025 -5777 4 2 0 1 1568 2396 2340 2820 -5778 4 2 0 1 540 2281 2294 2393 -5779 4 2 0 1 1659 1982 2088 2430 -5780 4 2 0 1 1388 1731 2018 2374 -5781 4 2 0 1 1576 2095 2229 2232 -5782 4 2 0 1 1816 2502 2106 2635 -5783 4 2 0 1 1670 2147 1770 2604 -5784 4 2 0 1 1670 1770 2286 2604 -5785 4 2 0 1 1890 1942 1571 1991 -5786 4 2 0 1 2195 2273 2586 2716 -5787 4 2 0 1 1782 2024 1830 2693 -5788 4 2 0 1 1438 1719 1240 2767 -5789 4 2 0 1 1623 2022 1876 2181 -5790 4 2 0 1 1583 1964 1981 2025 -5791 4 2 0 1 1696 2184 2135 2822 -5792 4 2 0 1 1589 2102 2320 2794 -5793 4 2 0 1 994 2155 1761 2803 -5794 4 2 0 1 1690 1765 2144 2404 -5795 4 2 0 1 1604 1916 1782 2210 -5796 4 2 0 1 795 1765 709 2267 -5797 4 2 0 1 1143 1088 1763 2119 -5798 4 2 0 1 1868 1653 2122 2473 -5799 4 2 0 1 1571 1953 1743 2432 -5800 4 2 0 1 1724 2365 2129 2589 -5801 4 2 0 1 560 1841 2169 2236 -5802 4 2 0 1 1736 1540 2071 2698 -5803 4 2 0 1 1657 1983 1850 2590 -5804 4 2 0 1 1611 1970 2168 2364 -5805 4 2 0 1 1537 2019 2181 2549 -5806 4 2 0 1 1788 1923 2024 2305 -5807 4 2 0 1 1605 1964 1823 2262 -5808 4 2 0 1 1586 1962 1784 2309 -5809 4 2 0 1 1843 1647 2224 2389 -5810 4 2 0 1 1565 2265 1749 2351 -5811 4 2 0 1 1586 1900 1835 2369 -5812 4 2 0 1 1770 2391 2286 2823 -5813 4 2 0 1 866 937 2081 2233 -5814 4 2 0 1 1233 2091 1742 2507 -5815 4 2 0 1 1533 1753 2334 2373 -5816 4 2 0 1 2224 2636 2158 2738 -5817 4 2 0 1 473 170 2092 2225 -5818 4 2 0 1 760 802 1855 2585 -5819 4 2 0 1 1592 2314 1868 2321 -5820 4 2 0 1 1728 1601 2240 2479 -5821 4 2 0 1 677 1825 647 2281 -5822 4 2 0 1 316 2062 1699 2130 -5823 4 2 0 1 1564 1917 2611 2671 -5824 4 2 0 1 1218 1349 1922 2044 -5825 4 2 0 1 1770 2098 1598 2249 -5826 4 2 0 1 1765 2074 1855 2501 -5827 4 2 0 1 1566 1907 1803 1944 -5828 4 2 0 1 1578 1985 2443 2682 -5829 4 2 0 1 1539 2022 1876 2223 -5830 4 2 0 1 1587 2548 2108 2578 -5831 4 2 0 1 1715 2060 1660 2368 -5832 4 2 0 1 1615 1843 2224 2389 -5833 4 2 0 1 1763 2414 2273 2544 -5834 4 2 0 1 1543 2083 1848 2792 -5835 4 2 0 1 783 1757 726 2109 -5836 4 2 0 1 1725 2207 1567 2481 -5837 4 2 0 1 1629 2074 1765 2501 -5838 4 2 0 1 1554 1839 2385 2616 -5839 4 2 0 1 1976 2356 2195 2434 -5840 4 2 0 1 1563 1965 1915 2147 -5841 4 2 0 1 872 967 876 2279 -5842 4 2 0 1 1305 1926 1372 2016 -5843 4 2 0 1 1748 1624 2254 2511 -5844 4 2 0 1 1634 2080 1920 2528 -5845 4 2 0 1 1599 1832 2248 2486 -5846 4 2 0 1 1937 2053 1799 2367 -5847 4 2 0 1 1670 1596 2173 2478 -5848 4 2 0 1 681 1766 661 2246 -5849 4 2 0 1 1192 2077 1727 2337 -5850 4 2 0 1 1860 2161 854 2649 -5851 4 2 0 1 2393 2663 1825 2749 -5852 4 2 0 1 1930 2170 1775 2565 -5853 4 2 0 1 682 1726 145 2425 -5854 4 2 0 1 1697 2038 1969 2090 -5855 4 2 0 1 1775 2535 1930 2565 -5856 4 2 0 1 1849 1993 505 2567 -5857 4 2 0 1 1091 2406 1746 2543 -5858 4 2 0 1 1335 1412 2091 2721 -5859 4 2 0 1 1576 1883 1710 2232 -5860 4 2 0 1 498 2062 519 2355 -5861 4 2 0 1 1987 1988 1691 2015 -5862 4 2 0 1 1589 2510 2708 2794 -5863 4 2 0 1 1584 1882 1773 2675 -5864 4 2 0 1 538 605 1799 2009 -5865 4 2 0 1 1783 2210 2526 2538 -5866 4 2 0 1 1818 1683 2572 2599 -5867 4 2 0 1 1369 1364 1437 2342 -5868 4 2 0 1 1762 2077 1568 2167 -5869 4 2 0 1 1755 2383 2254 2668 -5870 4 2 0 1 2289 2609 1623 2629 -5871 4 2 0 1 1559 1800 1716 2490 -5872 4 2 0 1 1662 1786 2093 2212 -5873 4 2 0 1 1809 1680 2433 2450 -5874 4 2 0 1 1670 2147 1965 2391 -5875 4 2 0 1 1702 2343 2258 2652 -5876 4 2 0 1 693 1942 801 2028 -5877 4 2 0 1 1858 2136 1743 2347 -5878 4 2 0 1 624 2281 1912 2294 -5879 4 2 0 1 2158 2287 2070 2382 -5880 4 2 0 1 1789 2130 321 2601 -5881 4 2 0 1 1569 1716 1902 2490 -5882 4 2 0 1 1599 2152 1817 2365 -5883 4 2 0 1 1646 1745 2179 2434 -5884 4 2 0 1 357 1789 321 2601 -5885 4 2 0 1 1647 2085 1843 2673 -5886 4 2 0 1 1060 1109 2406 2424 -5887 4 2 0 1 1739 2527 2398 2798 -5888 4 2 0 1 1225 1331 1309 2076 -5889 4 2 0 1 823 1776 767 2649 -5890 4 2 0 1 1829 2268 334 2556 -5891 4 2 0 1 1009 921 989 2562 -5892 4 2 0 1 1399 1992 1893 2770 -5893 4 2 0 1 1748 2158 1624 2511 -5894 4 2 0 1 1529 1925 2187 2216 -5895 4 2 0 1 1669 1938 1791 2143 -5896 4 2 0 1 1535 2149 2089 2431 -5897 4 2 0 1 1618 2069 1766 2246 -5898 4 2 0 1 1144 1041 1021 1688 -5899 4 2 0 1 991 2115 897 2523 -5900 4 2 0 1 1005 1748 2287 2591 -5901 4 2 0 1 1978 2228 1681 2613 -5902 4 2 0 1 1533 1920 1802 2334 -5903 4 2 0 1 1548 1741 1814 2158 -5904 4 2 0 1 1615 1894 1790 2695 -5905 4 2 0 1 1737 1875 1594 2483 -5906 4 2 0 1 1580 2055 2361 2784 -5907 4 2 0 1 1620 2396 2011 2599 -5908 4 2 0 1 729 785 2087 2375 -5909 4 2 0 1 1650 2150 2239 2506 -5910 4 2 0 1 1841 2169 1653 2766 -5911 4 2 0 1 540 2281 611 2294 -5912 4 2 0 1 1475 1944 1367 2057 -5913 4 2 0 1 1468 2686 1984 2724 -5914 4 2 0 1 1525 1507 1284 2184 -5915 4 2 0 1 1599 1817 2152 2261 -5916 4 2 0 1 1533 1802 2080 2270 -5917 4 2 0 1 1666 2238 1901 2356 -5918 4 2 0 1 1687 1600 2317 2514 -5919 4 2 0 1 1214 2044 1857 2325 -5920 4 2 0 1 1537 1773 2386 2440 -5921 4 2 0 1 1736 1861 462 2185 -5922 4 2 0 1 1702 2524 2343 2652 -5923 4 2 0 1 1794 1627 2131 2497 -5924 4 2 0 1 678 2400 2260 2569 -5925 4 2 0 1 1576 2474 2346 2619 -5926 4 2 0 1 1706 2220 2050 2654 -5927 4 2 0 1 1610 2160 1724 2385 -5928 4 2 0 1 1709 2166 2029 2774 -5929 4 2 0 1 795 709 2144 2267 -5930 4 2 0 1 752 1942 803 1991 -5931 4 2 0 1 1093 2043 1041 2346 -5932 4 2 0 1 1259 1808 1420 2033 -5933 4 2 0 1 1310 2036 1788 2284 -5934 4 2 0 1 1844 2664 2257 2704 -5935 4 2 0 1 1577 1720 2029 2624 -5936 4 2 0 1 914 947 867 2280 -5937 4 2 0 1 1742 1976 1609 2091 -5938 4 2 0 1 1484 1279 1204 2081 -5939 4 2 0 1 1734 2313 2252 2678 -5940 4 2 0 1 1837 2226 1741 2625 -5941 4 2 0 1 1663 1742 2167 2507 -5942 4 2 0 1 235 2002 1850 2159 -5943 4 2 0 1 1813 1891 1567 2580 -5944 4 2 0 1 1783 2210 1921 2526 -5945 4 2 0 1 1700 2139 1899 2481 -5946 4 2 0 1 1703 1839 2439 2487 -5947 4 2 0 1 1949 2141 1652 2169 -5948 4 2 0 1 1731 1944 1803 2720 -5949 4 2 0 1 1727 2396 1568 2573 -5950 4 2 0 1 1984 2026 1607 2724 -5951 4 2 0 1 935 1724 2115 2461 -5952 4 2 0 1 1138 272 1930 2713 -5953 4 2 0 1 1852 2231 2037 2373 -5954 4 2 0 1 1572 2284 1788 2712 -5955 4 2 0 1 1801 2597 1564 2671 -5956 4 2 0 1 1598 2098 1773 2249 -5957 4 2 0 1 761 825 2316 2451 -5958 4 2 0 1 1732 1591 2123 2353 -5959 4 2 0 1 182 2030 1778 2211 -5960 4 2 0 1 401 343 334 2268 -5961 4 2 0 1 2143 2257 1938 2520 -5962 4 2 0 1 1772 2275 1893 2550 -5963 4 2 0 1 1670 2478 1940 2604 -5964 4 2 0 1 1994 2178 1292 2563 -5965 4 2 0 1 1570 1798 1886 2072 -5966 4 2 0 1 1650 2150 1916 2682 -5967 4 2 0 1 1276 2171 1933 2205 -5968 4 2 0 1 488 1069 1065 1927 -5969 4 2 0 1 255 2297 499 2438 -5970 4 2 0 1 1724 2461 935 2589 -5971 4 2 0 1 1784 1962 1538 2460 -5972 4 2 0 1 1796 2027 1558 2145 -5973 4 2 0 1 1820 2291 2022 2609 -5974 4 2 0 1 1862 2431 1851 2731 -5975 4 2 0 1 1536 1734 1949 2313 -5976 4 2 0 1 1850 2323 2005 2614 -5977 4 2 0 1 1547 1901 2238 2356 -5978 4 2 0 1 989 1907 1016 2125 -5979 4 2 0 1 2178 2563 1708 2730 -5980 4 2 0 1 1335 1341 1762 1992 -5981 4 2 0 1 2176 2319 1716 2423 -5982 4 2 0 1 1751 2224 1898 2636 -5983 4 2 0 1 1575 1763 2119 2509 -5984 4 2 0 1 325 2200 330 2328 -5985 4 2 0 1 1911 2105 1714 2510 -5986 4 2 0 1 1641 2118 1998 2354 -5987 4 2 0 1 1649 2027 1747 2762 -5988 4 2 0 1 708 2171 2099 2596 -5989 4 2 0 1 1813 2200 1736 2399 -5990 4 2 0 1 1724 1599 2129 2365 -5991 4 2 0 1 1720 2157 1989 2779 -5992 4 2 0 1 1354 1368 1235 2507 -5993 4 2 0 1 500 2225 504 2626 -5994 4 2 0 1 2109 2523 1946 2628 -5995 4 2 0 1 1988 2290 1844 2388 -5996 4 2 0 1 1685 2265 1933 2596 -5997 4 2 0 1 1318 1336 1192 1727 -5998 4 2 0 1 1133 1787 1271 2056 -5999 4 2 0 1 1271 1049 1281 1787 -6000 4 2 0 1 1635 1941 1768 2465 -6001 4 2 0 1 1420 1808 1195 2018 -6002 4 2 0 1 1557 1746 2541 2768 -6003 4 2 0 1 1672 2133 1589 2302 -6004 4 2 0 1 231 837 465 2068 -6005 4 2 0 1 1999 2061 1832 2486 -6006 4 2 0 1 1660 1981 1846 2491 -6007 4 2 0 1 1588 2067 1736 2632 -6008 4 2 0 1 975 860 2382 2421 -6009 4 2 0 1 1205 1281 1049 1787 -6010 4 2 0 1 1649 1747 2027 2597 -6011 4 2 0 1 881 1889 899 2589 -6012 4 2 0 1 1940 2478 2173 2789 -6013 4 2 0 1 1707 1914 1576 2346 -6014 4 2 0 1 1882 2098 1531 2249 -6015 4 2 0 1 1546 1898 2444 2771 -6016 4 2 0 1 1579 1886 1728 2226 -6017 4 2 0 1 1849 1877 1643 2426 -6018 4 2 0 1 497 2359 399 2472 -6019 4 2 0 1 1724 1771 2385 2644 -6020 4 2 0 1 1753 1676 2237 2590 -6021 4 2 0 1 1653 2141 1949 2169 -6022 4 2 0 1 565 573 629 1995 -6023 4 2 0 1 2217 2508 1718 2714 -6024 4 2 0 1 2005 2614 361 2669 -6025 4 2 0 1 1904 2054 1072 2202 -6026 4 2 0 1 1535 1892 2487 2665 -6027 4 2 0 1 2229 2552 2232 2563 -6028 4 2 0 1 1564 1917 1867 2611 -6029 4 2 0 1 1620 1804 2245 2707 -6030 4 2 0 1 1749 2615 2351 2718 -6031 4 2 0 1 1540 2071 1701 2230 -6032 4 2 0 1 1933 2265 1685 2718 -6033 4 2 0 1 1855 2074 1765 2585 -6034 4 2 0 1 899 881 950 1781 -6035 4 2 0 1 1800 2409 1877 2685 -6036 4 2 0 1 1830 2024 1542 2693 -6037 4 2 0 1 1705 2620 2474 2833 -6038 4 2 0 1 1565 1749 2322 2351 -6039 4 2 0 1 155 1771 1013 2165 -6040 4 2 0 1 752 799 803 1942 -6041 4 2 0 1 1359 2132 2294 2467 -6042 4 2 0 1 1545 2437 2164 2807 -6043 4 2 0 1 1533 2334 1802 2504 -6044 4 2 0 1 556 2236 2169 2390 -6045 4 2 0 1 1587 2040 1775 2075 -6046 4 2 0 1 1866 2112 1689 2654 -6047 4 2 0 1 1564 2647 1801 2671 -6048 4 2 0 1 1086 2518 2138 2594 -6049 4 2 0 1 2494 2495 2049 2561 -6050 4 2 0 1 168 1813 325 2399 -6051 4 2 0 1 1533 1753 1920 2334 -6052 4 2 0 1 1777 2290 2257 2707 -6053 4 2 0 1 1878 2249 1598 2440 -6054 4 2 0 1 1674 2705 1985 2773 -6055 4 2 0 1 852 828 1771 2186 -6056 4 2 0 1 325 1813 356 2399 -6057 4 2 0 1 829 1890 725 2684 -6058 4 2 0 1 1009 1751 921 2562 -6059 4 2 0 1 1834 2013 1561 2654 -6060 4 2 0 1 392 2262 1823 2516 -6061 4 2 0 1 1817 2233 1628 2261 -6062 4 2 0 1 1701 1540 2524 2698 -6063 4 2 0 1 871 875 994 2803 -6064 4 2 0 1 1158 1065 1142 1927 -6065 4 2 0 1 1547 2238 1745 2282 -6066 4 2 0 1 1799 538 2009 2408 -6067 4 2 0 1 1931 2280 2061 2588 -6068 4 2 0 1 1715 1660 2060 2491 -6069 4 2 0 1 1642 2174 1854 2515 -6070 4 2 0 1 2013 2220 1706 2654 -6071 4 2 0 1 1636 1844 1824 2704 -6072 4 2 0 1 1544 1721 2182 2537 -6073 4 2 0 1 2264 2339 1053 2522 -6074 4 2 0 1 1628 1889 1781 2081 -6075 4 2 0 1 1563 1861 1965 2391 -6076 4 2 0 1 388 418 272 2713 -6077 4 2 0 1 2401 2688 1833 2809 -6078 4 2 0 1 1777 1900 2290 2806 -6079 4 2 0 1 1809 2450 1884 2530 -6080 4 2 0 1 801 1740 814 2028 -6081 4 2 0 1 2070 2158 1624 2287 -6082 4 2 0 1 1780 1638 1922 2512 -6083 4 2 0 1 787 731 2055 2529 -6084 4 2 0 1 1734 1968 1878 2047 -6085 4 2 0 1 1648 1776 2014 2717 -6086 4 2 0 1 1709 2300 1784 2309 -6087 4 2 0 1 1745 2060 1617 2238 -6088 4 2 0 1 1792 2163 1690 2702 -6089 4 2 0 1 1578 2345 2443 2705 -6090 4 2 0 1 1538 2102 2078 2703 -6091 4 2 0 1 1784 1962 1932 2309 -6092 4 2 0 1 1732 2123 2219 2680 -6093 4 2 0 1 1656 1795 1925 2006 -6094 4 2 0 1 1694 2292 1847 2366 -6095 4 2 0 1 1314 1372 1926 2302 -6096 4 2 0 1 1060 2406 1819 2424 -6097 4 2 0 1 1574 2454 2036 2746 -6098 4 2 0 1 1113 1060 1819 2394 -6099 4 2 0 1 1557 2108 1746 2218 -6100 4 2 0 1 1905 2017 1778 2815 -6101 4 2 0 1 1158 488 1065 1927 -6102 4 2 0 1 1125 1143 2119 2255 -6103 4 2 0 1 1005 928 1748 2591 -6104 4 2 0 1 1700 662 2256 2672 -6105 4 2 0 1 1552 2482 1900 2593 -6106 4 2 0 1 1822 1881 2508 2773 -6107 4 2 0 1 1545 1833 2052 2088 -6108 4 2 0 1 1835 1903 1695 2799 -6109 4 2 0 1 1600 2101 1847 2366 -6110 4 2 0 1 1926 2429 1712 2765 -6111 4 2 0 1 1238 2008 1432 2205 -6112 4 2 0 1 1634 2084 2159 2376 -6113 4 2 0 1 1626 2265 1991 2596 -6114 4 2 0 1 1266 1708 2563 2730 -6115 4 2 0 1 2114 2119 1763 2509 -6116 4 2 0 1 1579 2072 1935 2285 -6117 4 2 0 1 447 2200 1879 2446 -6118 4 2 0 1 1694 1631 2189 2680 -6119 4 2 0 1 1551 2074 1765 2341 -6120 4 2 0 1 805 769 1826 2307 -6121 4 2 0 1 1603 1947 1829 2357 -6122 4 2 0 1 1617 2060 1715 2368 -6123 4 2 0 1 2214 2296 1928 2813 -6124 4 2 0 1 1568 1963 2440 2820 -6125 4 2 0 1 516 1946 149 2338 -6126 4 2 0 1 1552 2369 1835 2593 -6127 4 2 0 1 1788 1924 1223 2441 -6128 4 2 0 1 340 366 2159 2323 -6129 4 2 0 1 512 194 489 2626 -6130 4 2 0 1 1164 1089 1864 2584 -6131 4 2 0 1 2187 2216 1698 2540 -6132 4 2 0 1 1760 2174 1923 2329 -6133 4 2 0 1 1529 1925 2006 2187 -6134 4 2 0 1 1849 1877 1582 2567 -6135 4 2 0 1 1634 2159 2084 2323 -6136 4 2 0 1 1528 1911 1812 2650 -6137 4 2 0 1 1809 1680 2450 2530 -6138 4 2 0 1 1754 2292 2221 2492 -6139 4 2 0 1 1571 1858 2265 2347 -6140 4 2 0 1 1957 2316 1752 2451 -6141 4 2 0 1 1706 2654 2050 2746 -6142 4 2 0 1 2123 1694 2219 2680 -6143 4 2 0 1 1585 2027 1778 2239 -6144 4 2 0 1 1553 2496 1956 2782 -6145 4 2 0 1 1558 2027 1796 2837 -6146 4 2 0 1 1880 1917 1564 2597 -6147 4 2 0 1 1125 1763 1103 2255 -6148 4 2 0 1 1627 1794 2131 2484 -6149 4 2 0 1 885 949 862 2477 -6150 4 2 0 1 1573 1868 2180 2672 -6151 4 2 0 1 1568 2396 2820 2831 -6152 4 2 0 1 1742 1976 1199 2435 -6153 4 2 0 1 2306 2454 1750 2572 -6154 4 2 0 1 1632 2117 1876 2617 -6155 4 2 0 1 1528 1714 2111 2510 -6156 4 2 0 1 1680 1948 1809 2433 -6157 4 2 0 1 1905 1985 1674 2705 -6158 4 2 0 1 2085 2219 1806 2293 -6159 4 2 0 1 1125 1143 1763 2119 -6160 4 2 0 1 706 746 781 2379 -6161 4 2 0 1 1206 2117 1278 2785 -6162 4 2 0 1 1009 983 2162 2695 -6163 4 2 0 1 1558 2502 2017 2773 -6164 4 2 0 1 1737 1594 2134 2483 -6165 4 2 0 1 1610 2363 1839 2784 -6166 4 2 0 1 1553 1758 2206 2415 -6167 4 2 0 1 1967 1596 2286 2745 -6168 4 2 0 1 1545 2164 2676 2807 -6169 4 2 0 1 1468 1984 1460 2724 -6170 4 2 0 1 399 497 514 1831 -6171 4 2 0 1 707 747 2068 2501 -6172 4 2 0 1 1618 2206 2104 2215 -6173 4 2 0 1 165 957 164 1797 -6174 4 2 0 1 1733 2088 2052 2653 -6175 4 2 0 1 574 1884 2345 2530 -6176 4 2 0 1 1618 1766 2069 2496 -6177 4 2 0 1 2037 2110 1892 2487 -6178 4 2 0 1 299 2005 361 2669 -6179 4 2 0 1 764 700 1776 1936 -6180 4 2 0 1 1775 1863 1658 2565 -6181 4 2 0 1 1692 2392 1839 2754 -6182 4 2 0 1 1732 2293 1591 2353 -6183 4 2 0 1 1720 2166 2029 2779 -6184 4 2 0 1 2179 2264 1053 2522 -6185 4 2 0 1 1552 2029 2166 2779 -6186 4 2 0 1 1517 2026 1235 2507 -6187 4 2 0 1 230 2153 1877 2567 -6188 4 2 0 1 2140 2278 1707 2696 -6189 4 2 0 1 1820 2021 1708 2755 -6190 4 2 0 1 2123 2156 1694 2680 -6191 4 2 0 1 852 1771 728 2055 -6192 4 2 0 1 784 2508 2217 2714 -6193 4 2 0 1 1790 2444 1898 2771 -6194 4 2 0 1 1841 2141 1653 2728 -6195 4 2 0 1 1874 2630 2452 2652 -6196 4 2 0 1 1823 1964 1605 2735 -6197 4 2 0 1 1805 1755 2254 2668 -6198 4 2 0 1 1589 2102 1926 2320 -6199 4 2 0 1 1754 1603 1929 2172 -6200 4 2 0 1 681 2180 1766 2246 -6201 4 2 0 1 786 773 720 1849 -6202 4 2 0 1 1563 1965 1861 2662 -6203 4 2 0 1 799 692 803 1942 -6204 4 2 0 1 1606 1699 1979 2757 -6205 4 2 0 1 1956 2496 1689 2782 -6206 4 2 0 1 1675 2065 1791 2266 -6207 4 2 0 1 1862 1535 2089 2431 -6208 4 2 0 1 1712 2429 1852 2765 -6209 4 2 0 1 1888 2166 1925 2216 -6210 4 2 0 1 299 1859 2005 2669 -6211 4 2 0 1 1579 1935 1798 2094 -6212 4 2 0 1 419 2200 168 2399 -6213 4 2 0 1 227 1737 430 2468 -6214 4 2 0 1 1510 1872 1298 2241 -6215 4 2 0 1 2039 1981 2505 2646 -6216 4 2 0 1 524 1946 2209 2477 -6217 4 2 0 1 465 2068 837 2106 -6218 4 2 0 1 2106 2502 1718 2635 -6219 4 2 0 1 1555 1908 1906 2608 -6220 4 2 0 1 457 430 472 2127 -6221 4 2 0 1 1880 1917 1747 2547 -6222 4 2 0 1 1748 1872 1624 2287 -6223 4 2 0 1 1580 2203 1839 2665 -6224 4 2 0 1 574 613 554 2345 -6225 4 2 0 1 1892 2037 1608 2373 -6226 4 2 0 1 1702 2258 2546 2652 -6227 4 2 0 1 612 1841 603 2236 -6228 4 2 0 1 1729 2073 1999 2545 -6229 4 2 0 1 2171 2205 1276 2513 -6230 4 2 0 1 1670 2286 1967 2752 -6231 4 2 0 1 1997 2298 1695 2741 -6232 4 2 0 1 1704 2313 2230 2427 -6233 4 2 0 1 1625 2296 2214 2813 -6234 4 2 0 1 1576 2232 2229 2552 -6235 4 2 0 1 1778 2017 1816 2776 -6236 4 2 0 1 1945 2004 1806 2312 -6237 4 2 0 1 1642 2012 1760 2174 -6238 4 2 0 1 1606 2228 1699 2757 -6239 4 2 0 1 1689 1783 2220 2348 -6240 4 2 0 1 1700 2260 2139 2481 -6241 4 2 0 1 717 2186 769 2307 -6242 4 2 0 1 1559 1729 1952 2793 -6243 4 2 0 1 1982 2088 1588 2446 -6244 4 2 0 1 1150 1775 1085 2170 -6245 4 2 0 1 1582 1977 2149 2163 -6246 4 2 0 1 1927 2049 478 2464 -6247 4 2 0 1 1325 2012 1361 2325 -6248 4 2 0 1 1540 1838 2071 2230 -6249 4 2 0 1 1087 1029 1846 2202 -6250 4 2 0 1 1616 1883 2187 2244 -6251 4 2 0 1 1575 2025 1863 2570 -6252 4 2 0 1 1740 1942 1571 2432 -6253 4 2 0 1 678 1725 2400 2569 -6254 4 2 0 1 1696 2055 2051 2135 -6255 4 2 0 1 1893 1992 1399 2201 -6256 4 2 0 1 399 2472 1831 2560 -6257 4 2 0 1 460 1809 2610 2661 -6258 4 2 0 1 1661 2178 1994 2563 -6259 4 2 0 1 1531 1836 2368 2505 -6260 4 2 0 1 2083 2315 1848 2792 -6261 4 2 0 1 1882 1989 1684 2103 -6262 4 2 0 1 2187 2244 1883 2548 -6263 4 2 0 1 1583 1964 1940 1981 -6264 4 2 0 1 891 2494 2049 2561 -6265 4 2 0 1 1352 1935 1316 2094 -6266 4 2 0 1 587 2053 620 2367 -6267 4 2 0 1 1540 2071 2059 2756 -6268 4 2 0 1 1701 1540 2230 2524 -6269 4 2 0 1 1727 1568 2340 2573 -6270 4 2 0 1 1848 2575 1720 2797 -6271 4 2 0 1 1621 1785 2204 2304 -6272 4 2 0 1 1618 2053 1828 2367 -6273 4 2 0 1 1586 1932 1962 2309 -6274 4 2 0 1 2015 2019 1698 2082 -6275 4 2 0 1 293 368 2448 2516 -6276 4 2 0 1 1607 1949 1799 2198 -6277 4 2 0 1 227 358 1737 2468 -6278 4 2 0 1 1152 2060 1960 2410 -6279 4 2 0 1 356 2196 1813 2328 -6280 4 2 0 1 762 2451 2034 2684 -6281 4 2 0 1 1647 1843 2085 2389 -6282 4 2 0 1 1559 1716 1952 2545 -6283 4 2 0 1 1363 1369 2042 2342 -6284 4 2 0 1 1531 2604 1882 2735 -6285 4 2 0 1 1639 1730 2215 2463 -6286 4 2 0 1 852 154 155 1771 -6287 4 2 0 1 1367 1944 1320 2462 -6288 4 2 0 1 1773 1882 1684 2675 -6289 4 2 0 1 291 2298 1997 2741 -6290 4 2 0 1 490 412 387 1918 -6291 4 2 0 1 1550 2004 1806 2418 -6292 4 2 0 1 2101 2366 411 2494 -6293 4 2 0 1 1528 2465 1966 2836 -6294 4 2 0 1 1564 2611 1867 2671 -6295 4 2 0 1 1626 1933 2265 2596 -6296 4 2 0 1 1704 2230 1874 2427 -6297 4 2 0 1 1913 1035 2170 2713 -6298 4 2 0 1 1682 2038 1969 2482 -6299 4 2 0 1 1879 1588 2088 2446 -6300 4 2 0 1 1538 1962 1784 2388 -6301 4 2 0 1 1189 2146 1707 2640 -6302 4 2 0 1 342 334 2268 2556 -6303 4 2 0 1 1617 1815 1972 2175 -6304 4 2 0 1 2052 2088 1833 2653 -6305 4 2 0 1 710 775 2508 2555 -6306 4 2 0 1 1272 1808 1259 2177 -6307 4 2 0 1 1564 1920 1753 2829 -6308 4 2 0 1 1771 2055 1696 2670 -6309 4 2 0 1 1581 1740 2045 2659 -6310 4 2 0 1 649 1845 594 1948 -6311 4 2 0 1 1954 2206 1758 2415 -6312 4 2 0 1 2258 2343 1702 2546 -6313 4 2 0 1 1886 2072 1943 2240 -6314 4 2 0 1 1756 1981 2025 2646 -6315 4 2 0 1 1858 2265 2008 2801 -6316 4 2 0 1 1699 2726 2412 2757 -6317 4 2 0 1 848 780 811 1855 -6318 4 2 0 1 1669 2078 1852 2231 -6319 4 2 0 1 1439 1798 2387 2763 -6320 4 2 0 1 2134 2389 1591 2832 -6321 4 2 0 1 324 224 398 2084 -6322 4 2 0 1 1609 1742 2091 2167 -6323 4 2 0 1 1984 2686 2026 2724 -6324 4 2 0 1 1869 1972 652 2390 -6325 4 2 0 1 680 643 587 1937 -6326 4 2 0 1 1928 2296 2214 2675 -6327 4 2 0 1 1658 2092 1904 2622 -6328 4 2 0 1 1594 2134 1919 2607 -6329 4 2 0 1 1613 2111 2000 2429 -6330 4 2 0 1 1617 1960 1715 2060 -6331 4 2 0 1 2214 2296 1625 2675 -6332 4 2 0 1 2260 2400 1725 2569 -6333 4 2 0 1 1498 2057 959 2241 -6334 4 2 0 1 1531 1981 2063 2505 -6335 4 2 0 1 311 2084 1733 2574 -6336 4 2 0 1 1709 2309 1550 2519 -6337 4 2 0 1 1680 2154 1934 2706 -6338 4 2 0 1 1790 1667 2428 2562 -6339 4 2 0 1 1245 1774 1321 2455 -6340 4 2 0 1 1388 2018 1221 2788 -6341 4 2 0 1 2022 2232 1539 2648 -6342 4 2 0 1 1983 2590 1676 2614 -6343 4 2 0 1 1760 1924 1923 2441 -6344 4 2 0 1 1950 2443 1916 2682 -6345 4 2 0 1 958 1006 2327 2576 -6346 4 2 0 1 140 2277 1955 2456 -6347 4 2 0 1 1584 2103 1882 2675 -6348 4 2 0 1 1561 2572 2011 2599 -6349 4 2 0 1 1799 1949 1653 2272 -6350 4 2 0 1 1912 1995 1637 2371 -6351 4 2 0 1 915 2233 1803 2775 -6352 4 2 0 1 1656 2108 2548 2578 -6353 4 2 0 1 1638 2044 1857 2310 -6354 4 2 0 1 1660 2238 2060 2733 -6355 4 2 0 1 464 1849 505 2692 -6356 4 2 0 1 1529 1888 2015 2300 -6357 4 2 0 1 1285 1206 1293 2056 -6358 4 2 0 1 1486 1256 1707 2146 -6359 4 2 0 1 503 998 516 2477 -6360 4 2 0 1 2057 2241 1654 2279 -6361 4 2 0 1 2061 2280 1931 2689 -6362 4 2 0 1 1559 1952 1729 2545 -6363 4 2 0 1 1893 2275 1772 2751 -6364 4 2 0 1 1664 2158 2070 2382 -6365 4 2 0 1 1897 2059 1592 2380 -6366 4 2 0 1 1575 2509 2114 2817 -6367 4 2 0 1 2343 2524 1595 2652 -6368 4 2 0 1 344 2092 1979 2448 -6369 4 2 0 1 1629 1765 2074 2341 -6370 4 2 0 1 764 2045 1776 2253 -6371 4 2 0 1 1961 2073 1593 2280 -6372 4 2 0 1 1315 1944 1187 2383 -6373 4 2 0 1 488 1069 1927 2424 -6374 4 2 0 1 2031 2437 1739 2809 -6375 4 2 0 1 661 1766 593 2246 -6376 4 2 0 1 1232 1333 1322 2012 -6377 4 2 0 1 1751 1790 2428 2562 -6378 4 2 0 1 1797 2188 1721 2625 -6379 4 2 0 1 1449 1798 1222 2247 -6380 4 2 0 1 766 2307 1957 2403 -6381 4 2 0 1 1945 2300 1709 2774 -6382 4 2 0 1 1852 2429 1556 2765 -6383 4 2 0 1 1471 2057 1307 2241 -6384 4 2 0 1 1006 2542 1687 2576 -6385 4 2 0 1 1363 1369 1217 2042 -6386 4 2 0 1 1537 2181 2386 2549 -6387 4 2 0 1 1585 2190 1733 2653 -6388 4 2 0 1 1954 2206 1553 2220 -6389 4 2 0 1 1529 2216 2187 2540 -6390 4 2 0 1 1618 1828 2104 2206 -6391 4 2 0 1 1785 1892 2304 2665 -6392 4 2 0 1 1321 1774 1245 2453 -6393 4 2 0 1 1760 2174 1908 2263 -6394 4 2 0 1 1893 2550 2275 2770 -6395 4 2 0 1 1133 1049 1271 1787 -6396 4 2 0 1 230 239 509 2153 -6397 4 2 0 1 1996 2597 1801 2671 -6398 4 2 0 1 2126 2548 1587 2578 -6399 4 2 0 1 351 208 1879 2333 -6400 4 2 0 1 1529 2240 2015 2540 -6401 4 2 0 1 1700 2569 662 2672 -6402 4 2 0 1 1646 2264 2179 2522 -6403 4 2 0 1 773 1849 786 2403 -6404 4 2 0 1 1716 1594 2097 2319 -6405 4 2 0 1 1566 2105 1731 2261 -6406 4 2 0 1 1778 1985 1659 2239 -6407 4 2 0 1 1607 1937 1799 2408 -6408 4 2 0 1 1315 1475 1187 1944 -6409 4 2 0 1 1773 1537 2214 2440 -6410 4 2 0 1 1593 1961 2086 2545 -6411 4 2 0 1 693 797 800 2288 -6412 4 2 0 1 2265 2351 1785 2718 -6413 4 2 0 1 150 2338 1946 2628 -6414 4 2 0 1 1998 2136 1641 2354 -6415 4 2 0 1 1702 1874 2524 2652 -6416 4 2 0 1 1564 2647 2671 2699 -6417 4 2 0 1 939 868 2287 2715 -6418 4 2 0 1 209 2200 1982 2328 -6419 4 2 0 1 1648 2100 2079 2360 -6420 4 2 0 1 770 1860 854 2638 -6421 4 2 0 1 1401 1426 1399 2770 -6422 4 2 0 1 893 1797 165 2278 -6423 4 2 0 1 299 1859 183 2647 -6424 4 2 0 1 1584 2019 1773 2549 -6425 4 2 0 1 1253 2201 1178 2455 -6426 4 2 0 1 379 1861 420 1965 -6427 4 2 0 1 242 1831 514 2560 -6428 4 2 0 1 1093 2346 1041 2458 -6429 4 2 0 1 1784 1538 2402 2460 -6430 4 2 0 1 1631 1694 2156 2680 -6431 4 2 0 1 1844 2257 1824 2704 -6432 4 2 0 1 1588 2088 1982 2430 -6433 4 2 0 1 1630 1934 2154 2706 -6434 4 2 0 1 1893 2550 1824 2751 -6435 4 2 0 1 1825 1934 1630 2192 -6436 4 2 0 1 708 2596 2099 2677 -6437 4 2 0 1 835 1210 1264 1933 -6438 4 2 0 1 1596 1967 2286 2752 -6439 4 2 0 1 2113 2517 1657 2590 -6440 4 2 0 1 626 2359 515 2610 -6441 4 2 0 1 703 1957 2316 2403 -6442 4 2 0 1 1561 1818 1866 2112 -6443 4 2 0 1 1718 2436 771 2508 -6444 4 2 0 1 1550 1806 2293 2418 -6445 4 2 0 1 1132 517 266 2626 -6446 4 2 0 1 1663 1968 1742 2026 -6447 4 2 0 1 1555 1769 2608 2736 -6448 4 2 0 1 308 207 2130 2624 -6449 4 2 0 1 500 1904 504 2225 -6450 4 2 0 1 1915 1965 379 2791 -6451 4 2 0 1 1712 2429 2111 2566 -6452 4 2 0 1 206 2614 1983 2669 -6453 4 2 0 1 1720 1989 2157 2355 -6454 4 2 0 1 1448 1906 1386 2263 -6455 4 2 0 1 1892 1986 1608 2037 -6456 4 2 0 1 1587 2108 2040 2578 -6457 4 2 0 1 1659 1778 2239 2653 -6458 4 2 0 1 1367 2057 1944 2462 -6459 4 2 0 1 1005 2287 1748 2382 -6460 4 2 0 1 1592 2059 1897 2827 -6461 4 2 0 1 1175 1018 1086 2138 -6462 4 2 0 1 1644 2391 1965 2438 -6463 4 2 0 1 2351 2615 1580 2718 -6464 4 2 0 1 1737 1591 1939 2489 -6465 4 2 0 1 1740 1581 2028 2432 -6466 4 2 0 1 1621 1757 2307 2363 -6467 4 2 0 1 1681 2613 2228 2768 -6468 4 2 0 1 149 1946 150 2338 -6469 4 2 0 1 1266 2563 2178 2730 -6470 4 2 0 1 764 1776 823 2253 -6471 4 2 0 1 1763 1975 1088 2414 -6472 4 2 0 1 1625 2103 1900 2806 -6473 4 2 0 1 523 1720 519 2624 -6474 4 2 0 1 1818 2820 2396 2831 -6475 4 2 0 1 1423 580 1198 2294 -6476 4 2 0 1 1694 1631 2156 2189 -6477 4 2 0 1 1541 2065 1865 2310 -6478 4 2 0 1 1660 1842 1975 2544 -6479 4 2 0 1 1561 1866 1818 2396 -6480 4 2 0 1 2161 2555 714 2649 -6481 4 2 0 1 1054 2278 2140 2696 -6482 4 2 0 1 1838 2391 1770 2823 -6483 4 2 0 1 2116 2527 1739 2798 -6484 4 2 0 1 1846 1975 1660 2491 -6485 4 2 0 1 1549 1876 2039 2600 -6486 4 2 0 1 1531 1964 1940 2735 -6487 4 2 0 1 1143 1055 1088 2119 -6488 4 2 0 1 1958 2471 2183 2506 -6489 4 2 0 1 1536 2313 1949 2723 -6490 4 2 0 1 1580 2665 1839 2754 -6491 4 2 0 1 2177 2184 1204 2299 -6492 4 2 0 1 1140 2035 162 2416 -6493 4 2 0 1 386 431 2207 2661 -6494 4 2 0 1 1947 2366 1847 2683 -6495 4 2 0 1 1759 2234 1854 2515 -6496 4 2 0 1 778 851 815 2596 -6497 4 2 0 1 1907 2057 1654 2279 -6498 4 2 0 1 2085 2293 1806 2418 -6499 4 2 0 1 1551 1792 2341 2702 -6500 4 2 0 1 1746 2138 1959 2828 -6501 4 2 0 1 1634 2005 1801 2242 -6502 4 2 0 1 1828 1618 2367 2725 -6503 4 2 0 1 423 2173 512 2225 -6504 4 2 0 1 438 2128 1156 2422 -6505 4 2 0 1 1102 1904 1072 2202 -6506 4 2 0 1 497 1831 399 2359 -6507 4 2 0 1 1585 1733 2052 2653 -6508 4 2 0 1 1195 2018 1808 2374 -6509 4 2 0 1 955 1390 1436 2057 -6510 4 2 0 1 2044 2455 1651 2493 -6511 4 2 0 1 1036 1127 1994 2255 -6512 4 2 0 1 2275 2550 1633 2770 -6513 4 2 0 1 2060 2238 1745 2733 -6514 4 2 0 1 1575 1975 1763 2544 -6515 4 2 0 1 426 1809 644 2610 -6516 4 2 0 1 1537 2386 2142 2440 -6517 4 2 0 1 747 2106 2068 2501 -6518 4 2 0 1 671 1869 640 2390 -6519 4 2 0 1 1702 1899 2139 2580 -6520 4 2 0 1 1841 2728 2236 2745 -6521 4 2 0 1 1851 1619 2431 2490 -6522 4 2 0 1 1781 1204 2184 2299 -6523 4 2 0 1 924 1907 1016 2553 -6524 4 2 0 1 1769 1555 1908 2736 -6525 4 2 0 1 1302 1315 2383 2531 -6526 4 2 0 1 1651 2044 1938 2520 -6527 4 2 0 1 1953 2136 1743 2354 -6528 4 2 0 1 949 2477 1729 2637 -6529 4 2 0 1 1567 2196 1813 2207 -6530 4 2 0 1 368 382 2448 2516 -6531 4 2 0 1 1003 1790 1000 2562 -6532 4 2 0 1 235 1850 456 2159 -6533 4 2 0 1 1672 2420 2208 2668 -6534 4 2 0 1 2015 2240 1691 2540 -6535 4 2 0 1 1206 1293 2056 2785 -6536 4 2 0 1 1906 1386 2263 2711 -6537 4 2 0 1 592 1831 514 2359 -6538 4 2 0 1 306 2190 1801 2744 -6539 4 2 0 1 1537 1807 2019 2214 -6540 4 2 0 1 2038 2071 1701 2698 -6541 4 2 0 1 2125 2248 858 2588 -6542 4 2 0 1 717 776 1757 2307 -6543 4 2 0 1 1609 2142 1887 2356 -6544 4 2 0 1 1545 2088 2052 2676 -6545 4 2 0 1 311 1733 295 2574 -6546 4 2 0 1 190 254 261 2456 -6547 4 2 0 1 950 881 937 2081 -6548 4 2 0 1 1669 1791 1938 2231 -6549 4 2 0 1 1620 2199 1774 2201 -6550 4 2 0 1 1536 2047 1734 2313 -6551 4 2 0 1 1733 2446 1659 2653 -6552 4 2 0 1 1897 2330 2046 2560 -6553 4 2 0 1 1539 2151 1853 2509 -6554 4 2 0 1 1549 1901 2544 2716 -6555 4 2 0 1 413 2068 377 2106 -6556 4 2 0 1 1309 2076 1755 2668 -6557 4 2 0 1 1164 1122 1089 2584 -6558 4 2 0 1 1565 2351 2322 2783 -6559 4 2 0 1 1887 2142 1666 2356 -6560 4 2 0 1 1150 1775 1031 2565 -6561 4 2 0 1 1625 2019 1807 2214 -6562 4 2 0 1 794 754 1933 2171 -6563 4 2 0 1 1567 2139 2260 2481 -6564 4 2 0 1 1865 2065 1759 2310 -6565 4 2 0 1 2005 2323 205 2614 -6566 4 2 0 1 354 2123 1895 2489 -6567 4 2 0 1 1584 2019 1888 2103 -6568 4 2 0 1 1753 2431 2110 2633 -6569 4 2 0 1 1963 2214 2440 2820 -6570 4 2 0 1 1830 1865 1572 2276 -6571 4 2 0 1 1784 1601 1945 2418 -6572 4 2 0 1 1511 1473 973 2241 -6573 4 2 0 1 1773 2019 2386 2549 -6574 4 2 0 1 1853 2646 2083 2660 -6575 4 2 0 1 1233 1412 2091 2507 -6576 4 2 0 1 921 876 989 2279 -6577 4 2 0 1 1592 1841 2321 2761 -6578 4 2 0 1 1016 1907 870 2553 -6579 4 2 0 1 1934 1680 2706 2786 -6580 4 2 0 1 1962 1844 2290 2388 -6581 4 2 0 1 763 1855 848 2378 -6582 4 2 0 1 663 1815 617 2236 -6583 4 2 0 1 1647 2134 1919 2389 -6584 4 2 0 1 1542 1830 1923 2024 -6585 4 2 0 1 1541 1938 1791 2476 -6586 4 2 0 1 1425 1992 1228 2770 -6587 4 2 0 1 1797 2070 1721 2188 -6588 4 2 0 1 290 2062 293 2448 -6589 4 2 0 1 1737 2127 2023 2679 -6590 4 2 0 1 1072 1904 1132 2054 -6591 4 2 0 1 1593 1832 2061 2280 -6592 4 2 0 1 1571 2347 2432 2659 -6593 4 2 0 1 372 351 208 1879 -6594 4 2 0 1 410 1965 499 1967 -6595 4 2 0 1 1839 2392 2361 2754 -6596 4 2 0 1 652 640 685 1869 -6597 4 2 0 1 1868 2122 1592 2618 -6598 4 2 0 1 2027 2145 1796 2447 -6599 4 2 0 1 1772 1824 2550 2751 -6600 4 2 0 1 1771 2361 1839 2385 -6601 4 2 0 1 548 593 2069 2246 -6602 4 2 0 1 504 1904 170 2225 -6603 4 2 0 1 1662 2212 2120 2687 -6604 4 2 0 1 1377 1214 2325 2512 -6605 4 2 0 1 1926 2016 1305 2667 -6606 4 2 0 1 1836 2175 1734 2193 -6607 4 2 0 1 1773 2019 1537 2386 -6608 4 2 0 1 614 2400 584 2530 -6609 4 2 0 1 1209 1678 2381 2493 -6610 4 2 0 1 1961 2086 274 2107 -6611 4 2 0 1 1233 1421 1199 2091 -6612 4 2 0 1 2052 2088 1733 2676 -6613 4 2 0 1 1633 2148 1762 2243 -6614 4 2 0 1 621 534 1990 2344 -6615 4 2 0 1 1573 1956 2010 2630 -6616 4 2 0 1 710 701 1822 2436 -6617 4 2 0 1 1608 2118 1892 2829 -6618 4 2 0 1 1840 2195 1549 2273 -6619 4 2 0 1 1579 1943 2072 2285 -6620 4 2 0 1 929 2073 867 2280 -6621 4 2 0 1 1693 1854 2174 2183 -6622 4 2 0 1 1820 2022 2289 2609 -6623 4 2 0 1 1181 1478 1115 1994 -6624 4 2 0 1 1835 2593 1903 2799 -6625 4 2 0 1 323 2559 337 2601 -6626 4 2 0 1 1867 2149 1535 2431 -6627 4 2 0 1 1746 2138 1122 2458 -6628 4 2 0 1 892 2523 1946 2637 -6629 4 2 0 1 1371 1760 1234 2263 -6630 4 2 0 1 1847 1947 1694 2366 -6631 4 2 0 1 1549 1876 2600 2617 -6632 4 2 0 1 1624 2158 2070 2188 -6633 4 2 0 1 1118 1166 2349 2564 -6634 4 2 0 1 1538 2078 2102 2460 -6635 4 2 0 1 584 590 644 2400 -6636 4 2 0 1 1677 1897 2297 2330 -6637 4 2 0 1 1548 2158 1814 2224 -6638 4 2 0 1 204 1801 2005 2647 -6639 4 2 0 1 1268 2289 1708 2730 -6640 4 2 0 1 1581 1740 2028 2045 -6641 4 2 0 1 1571 1942 1740 2347 -6642 4 2 0 1 725 1890 762 2684 -6643 4 2 0 1 649 1845 1948 2786 -6644 4 2 0 1 1865 2065 1597 2471 -6645 4 2 0 1 618 2212 1786 2687 -6646 4 2 0 1 1532 2150 1782 2538 -6647 4 2 0 1 447 209 2200 2446 -6648 4 2 0 1 2026 2342 1235 2507 -6649 4 2 0 1 1003 990 877 2155 -6650 4 2 0 1 1794 1924 1622 2087 -6651 4 2 0 1 1699 2621 2726 2757 -6652 4 2 0 1 2093 2443 2100 2693 -6653 4 2 0 1 708 2099 817 2677 -6654 4 2 0 1 1606 1930 1913 2170 -6655 4 2 0 1 1825 2459 1921 2749 -6656 4 2 0 1 340 2159 1850 2323 -6657 4 2 0 1 1669 1962 1844 2290 -6658 4 2 0 1 1743 1953 1571 2136 -6659 4 2 0 1 1576 2619 2346 2810 -6660 4 2 0 1 2052 2084 1733 2190 -6661 4 2 0 1 1988 2300 2015 2806 -6662 4 2 0 1 924 1016 1907 2125 -6663 4 2 0 1 1528 1919 2465 2836 -6664 4 2 0 1 1667 2248 2486 2778 -6665 4 2 0 1 1671 2047 1866 2427 -6666 4 2 0 1 1570 2082 2015 2291 -6667 4 2 0 1 1667 2248 1832 2486 -6668 4 2 0 1 2286 2391 2380 2823 -6669 4 2 0 1 1666 1887 2356 2600 -6670 4 2 0 1 1877 2409 444 2685 -6671 4 2 0 1 565 667 576 2131 -6672 4 2 0 1 1861 2090 415 2185 -6673 4 2 0 1 399 1831 242 2560 -6674 4 2 0 1 1731 1589 2531 2788 -6675 4 2 0 1 2157 2657 1903 2741 -6676 4 2 0 1 1957 2307 1757 2403 -6677 4 2 0 1 566 138 1735 2419 -6678 4 2 0 1 1599 1724 2129 2160 -6679 4 2 0 1 1620 1717 2340 2599 -6680 4 2 0 1 1693 1923 2174 2329 -6681 4 2 0 1 1874 2116 1671 2524 -6682 4 2 0 1 1542 2079 1923 2372 -6683 4 2 0 1 1731 2018 1589 2788 -6684 4 2 0 1 1612 2320 1926 2429 -6685 4 2 0 1 1678 2001 1209 2381 -6686 4 2 0 1 584 644 1809 2400 -6687 4 2 0 1 405 2196 356 2328 -6688 4 2 0 1 1572 1788 2276 2712 -6689 4 2 0 1 1788 1924 1923 2305 -6690 4 2 0 1 1933 2557 2265 2718 -6691 4 2 0 1 1581 2045 2014 2659 -6692 4 2 0 1 1813 2196 356 2207 -6693 4 2 0 1 1794 1622 1924 2305 -6694 4 2 0 1 1594 1918 2571 2607 -6695 4 2 0 1 893 2137 1797 2278 -6696 4 2 0 1 1836 1617 2175 2595 -6697 4 2 0 1 1558 1881 1822 2773 -6698 4 2 0 1 962 2129 1832 2365 -6699 4 2 0 1 1563 1915 1965 2662 -6700 4 2 0 1 1517 1235 2026 2342 -6701 4 2 0 1 1592 1897 2618 2827 -6702 4 2 0 1 399 514 242 1831 -6703 4 2 0 1 860 1873 887 2382 -6704 4 2 0 1 1841 1653 2169 2728 -6705 4 2 0 1 1641 1811 1867 2611 -6706 4 2 0 1 1803 2057 1907 2462 -6707 4 2 0 1 225 2576 450 2679 -6708 4 2 0 1 757 831 468 2068 -6709 4 2 0 1 1748 2254 2158 2511 -6710 4 2 0 1 1440 1259 1420 2033 -6711 4 2 0 1 1875 2086 179 2097 -6712 4 2 0 1 2117 2223 1876 2617 -6713 4 2 0 1 1633 1963 1762 2340 -6714 4 2 0 1 2032 2116 1701 2230 -6715 4 2 0 1 1830 1923 1693 2372 -6716 4 2 0 1 1581 2014 1743 2659 -6717 4 2 0 1 1616 2187 1883 2648 -6718 4 2 0 1 761 2316 1957 2451 -6719 4 2 0 1 2000 2370 2037 2429 -6720 4 2 0 1 1324 2013 1340 2579 -6721 4 2 0 1 1567 2139 1891 2706 -6722 4 2 0 1 1888 2103 2019 2675 -6723 4 2 0 1 592 514 1831 2560 -6724 4 2 0 1 1625 1888 2019 2675 -6725 4 2 0 1 1859 2153 2409 2669 -6726 4 2 0 1 308 2130 207 2269 -6727 4 2 0 1 1608 2037 1986 2231 -6728 4 2 0 1 1241 2263 1234 2358 -6729 4 2 0 1 1699 2412 2726 2805 -6730 4 2 0 1 2119 2384 1019 2570 -6731 4 2 0 1 2011 2572 1683 2599 -6732 4 2 0 1 1555 1769 1908 2608 -6733 4 2 0 1 1541 2065 1791 2602 -6734 4 2 0 1 1593 1999 1738 2061 -6735 4 2 0 1 1551 2163 1792 2702 -6736 4 2 0 1 399 2359 1831 2472 -6737 4 2 0 1 1813 1588 2200 2328 -6738 4 2 0 1 1892 2373 1608 2829 -6739 4 2 0 1 915 1803 874 2462 -6740 4 2 0 1 1701 2071 1540 2698 -6741 4 2 0 1 1623 1876 2022 2223 -6742 4 2 0 1 1586 2290 1900 2806 -6743 4 2 0 1 1887 1537 2142 2243 -6744 4 2 0 1 1943 2072 1691 2240 -6745 4 2 0 1 1579 1935 2094 2420 -6746 4 2 0 1 1348 1511 1357 1872 -6747 4 2 0 1 1103 2056 1039 2255 -6748 4 2 0 1 182 1778 300 2211 -6749 4 2 0 1 1421 1248 1976 2091 -6750 4 2 0 1 955 1436 979 2057 -6751 4 2 0 1 1809 1884 2450 2533 -6752 4 2 0 1 2092 2448 382 2516 -6753 4 2 0 1 1601 1784 1943 2402 -6754 4 2 0 1 1969 2038 1697 2482 -6755 4 2 0 1 1641 2136 1953 2354 -6756 4 2 0 1 1578 2124 1955 2457 -6757 4 2 0 1 1632 1876 2117 2223 -6758 4 2 0 1 1165 1088 1975 2414 -6759 4 2 0 1 1734 1968 1949 2790 -6760 4 2 0 1 1819 1927 1603 2394 -6761 4 2 0 1 1622 1924 1760 2358 -6762 4 2 0 1 512 2626 2225 2818 -6763 4 2 0 1 1018 1086 2138 2594 -6764 4 2 0 1 1757 1621 2089 2363 -6765 4 2 0 1 1581 1743 2014 2213 -6766 4 2 0 1 1630 1948 1845 2786 -6767 4 2 0 1 1601 2402 1971 2480 -6768 4 2 0 1 1737 1939 1591 2134 -6769 4 2 0 1 1047 1101 1106 2060 -6770 4 2 0 1 612 2236 1815 2344 -6771 4 2 0 1 1177 1442 1922 2016 -6772 4 2 0 1 1800 444 2409 2685 -6773 4 2 0 1 1603 1910 2357 2764 -6774 4 2 0 1 792 723 2135 2670 -6775 4 2 0 1 1663 2026 1742 2507 -6776 4 2 0 1 922 1790 2542 2695 -6777 4 2 0 1 1807 2015 1570 2082 -6778 4 2 0 1 1873 2259 887 2382 -6779 4 2 0 1 1549 2273 2195 2716 -6780 4 2 0 1 638 1948 594 2260 -6781 4 2 0 1 1650 2239 2150 2682 -6782 4 2 0 1 1646 1745 1901 2522 -6783 4 2 0 1 1803 1944 1907 2057 -6784 4 2 0 1 349 344 223 1979 -6785 4 2 0 1 1361 2325 2012 2711 -6786 4 2 0 1 1796 2027 2447 2837 -6787 4 2 0 1 1065 1927 1069 2424 -6788 4 2 0 1 194 2626 512 2818 -6789 4 2 0 1 1596 1670 2173 2752 -6790 4 2 0 1 1897 2046 1831 2560 -6791 4 2 0 1 1792 1690 2163 2445 -6792 4 2 0 1 816 1860 729 2425 -6793 4 2 0 1 2206 2220 1954 2782 -6794 4 2 0 1 1721 1140 2274 2416 -6795 4 2 0 1 1805 2383 1944 2531 -6796 4 2 0 1 1809 1948 1680 2530 -6797 4 2 0 1 1843 2085 1591 2219 -6798 4 2 0 1 1630 1845 1948 2706 -6799 4 2 0 1 2098 2147 1882 2604 -6800 4 2 0 1 1534 2221 1754 2292 -6801 4 2 0 1 2077 2167 2091 2507 -6802 4 2 0 1 1678 2493 2016 2664 -6803 4 2 0 1 1944 2057 1803 2462 -6804 4 2 0 1 1533 1802 2270 2504 -6805 4 2 0 1 901 2070 2137 2287 -6806 4 2 0 1 1694 2156 1947 2189 -6807 4 2 0 1 1637 1921 1821 2749 -6808 4 2 0 1 1606 2170 1913 2642 -6809 4 2 0 1 1767 2676 2164 2807 -6810 4 2 0 1 1773 2098 1882 2249 -6811 4 2 0 1 885 936 949 1961 -6812 4 2 0 1 1560 1893 1824 2199 -6813 4 2 0 1 1562 1770 2286 2823 -6814 4 2 0 1 602 538 605 1799 -6815 4 2 0 1 1685 2265 1785 2718 -6816 4 2 0 1 2162 2421 2382 2738 -6817 4 2 0 1 1086 2518 2594 2603 -6818 4 2 0 1 1580 2615 2351 2754 -6819 4 2 0 1 1342 1780 1177 2512 -6820 4 2 0 1 1629 2106 1816 2502 -6821 4 2 0 1 1779 1588 2088 2164 -6822 4 2 0 1 212 1939 2123 2489 -6823 4 2 0 1 1826 2034 1580 2529 -6824 4 2 0 1 1710 2594 2518 2603 -6825 4 2 0 1 1645 2063 2039 2600 -6826 4 2 0 1 1108 2095 2043 2518 -6827 4 2 0 1 1047 1101 2060 2491 -6828 4 2 0 1 1368 1517 1235 2507 -6829 4 2 0 1 770 854 1860 2161 -6830 4 2 0 1 1564 1753 1920 2699 -6831 4 2 0 1 2016 2033 1337 2667 -6832 4 2 0 1 995 893 166 2278 -6833 4 2 0 1 1667 1790 2428 2771 -6834 4 2 0 1 626 515 451 2610 -6835 4 2 0 1 1154 1031 2170 2565 -6836 4 2 0 1 1525 1284 2135 2822 -6837 4 2 0 1 1941 2085 1768 2465 -6838 4 2 0 1 1150 2191 1775 2384 -6839 4 2 0 1 710 771 2436 2508 -6840 4 2 0 1 1764 2177 1554 2361 -6841 4 2 0 1 1588 1871 1779 2343 -6842 4 2 0 1 1622 2079 1923 2305 -6843 4 2 0 1 1216 1324 1340 2655 -6844 4 2 0 1 1924 2087 1456 2358 -6845 4 2 0 1 1570 1798 2072 2747 -6846 4 2 0 1 1637 1995 1912 2294 -6847 4 2 0 1 1686 2262 293 2516 -6848 4 2 0 1 2023 2389 2134 2832 -6849 4 2 0 1 141 1955 140 2277 -6850 4 2 0 1 1763 1876 2114 2509 -6851 4 2 0 1 1559 1862 1851 2731 -6852 4 2 0 1 1778 2027 1585 2030 -6853 4 2 0 1 274 1961 250 2086 -6854 4 2 0 1 1918 1722 2571 2607 -6855 4 2 0 1 1584 2019 2103 2675 -6856 4 2 0 1 306 1801 204 2744 -6857 4 2 0 1 1335 1230 1412 2721 -6858 4 2 0 1 1589 1731 2531 2558 -6859 4 2 0 1 1416 1267 1268 1708 -6860 4 2 0 1 1652 1949 1734 2141 -6861 4 2 0 1 1510 1511 1298 1872 -6862 4 2 0 1 1238 1386 1432 2008 -6863 4 2 0 1 150 1946 791 2628 -6864 4 2 0 1 2038 2090 1697 2662 -6865 4 2 0 1 176 339 309 2269 -6866 4 2 0 1 1682 1900 2482 2593 -6867 4 2 0 1 758 2288 1713 2585 -6868 4 2 0 1 1732 2004 1896 2748 -6869 4 2 0 1 1932 1962 1784 2623 -6870 4 2 0 1 2032 2230 1838 2678 -6871 4 2 0 1 935 1014 968 2589 -6872 4 2 0 1 1881 1648 2161 2643 -6873 4 2 0 1 1880 1747 2354 2547 -6874 4 2 0 1 1629 1855 2074 2501 -6875 4 2 0 1 2141 2169 1653 2728 -6876 4 2 0 1 1150 1031 1775 2170 -6877 4 2 0 1 1636 1987 1844 2470 -6878 4 2 0 1 1726 1786 2093 2283 -6879 4 2 0 1 1843 1591 2389 2832 -6880 4 2 0 1 756 806 2171 2631 -6881 4 2 0 1 1734 1949 2313 2723 -6882 4 2 0 1 2152 2385 2160 2616 -6883 4 2 0 1 1638 2234 1759 2515 -6884 4 2 0 1 1987 2072 1691 2470 -6885 4 2 0 1 1970 2270 1802 2504 -6886 4 2 0 1 2199 2245 1804 2707 -6887 4 2 0 1 1831 2481 2359 2569 -6888 4 2 0 1 1572 1788 1923 2276 -6889 4 2 0 1 482 478 1927 2049 -6890 4 2 0 1 535 566 2197 2419 -6891 4 2 0 1 1300 2301 1837 2740 -6892 4 2 0 1 1711 2509 1853 2817 -6893 4 2 0 1 762 1890 725 2451 -6894 4 2 0 1 675 2569 2260 2672 -6895 4 2 0 1 1569 1851 1966 2423 -6896 4 2 0 1 1611 1856 2527 2602 -6897 4 2 0 1 1223 1924 1788 2475 -6898 4 2 0 1 1609 1887 1840 2195 -6899 4 2 0 1 2015 2300 1888 2806 -6900 4 2 0 1 165 893 957 1797 -6901 4 2 0 1 1692 2037 2000 2370 -6902 4 2 0 1 783 769 717 2186 -6903 4 2 0 1 1592 2321 2046 2761 -6904 4 2 0 1 216 392 302 1823 -6905 4 2 0 1 1739 2116 1701 2311 -6906 4 2 0 1 1194 2177 1764 2822 -6907 4 2 0 1 1643 1946 2331 2793 -6908 4 2 0 1 1322 2012 2284 2441 -6909 4 2 0 1 1565 1885 2322 2801 -6910 4 2 0 1 1701 2311 2038 2437 -6911 4 2 0 1 1671 2230 2313 2427 -6912 4 2 0 1 1321 1774 2453 2455 -6913 4 2 0 1 1320 1944 1452 2462 -6914 4 2 0 1 2041 2485 716 2666 -6915 4 2 0 1 1822 1855 763 2378 -6916 4 2 0 1 1539 1708 2022 2223 -6917 4 2 0 1 1965 2147 1670 2791 -6918 4 2 0 1 1795 2726 2621 2757 -6919 4 2 0 1 1729 2523 1793 2637 -6920 4 2 0 1 1968 2250 1949 2790 -6921 4 2 0 1 1791 1938 1541 2143 -6922 4 2 0 1 540 611 583 2294 -6923 4 2 0 1 2075 2191 1711 2384 -6924 4 2 0 1 1575 2039 1975 2544 -6925 4 2 0 1 1864 2541 2170 2584 -6926 4 2 0 1 2041 2379 716 2485 -6927 4 2 0 1 1771 2385 2644 2742 -6928 4 2 0 1 1575 2119 2114 2509 -6929 4 2 0 1 1859 2671 2647 2699 -6930 4 2 0 1 1597 1833 2150 2506 -6931 4 2 0 1 2084 2376 2052 2676 -6932 4 2 0 1 1614 2274 2064 2416 -6933 4 2 0 1 213 1897 2020 2472 -6934 4 2 0 1 1647 1919 1768 2465 -6935 4 2 0 1 274 2107 2086 2612 -6936 4 2 0 1 1602 2090 1861 2185 -6937 4 2 0 1 1676 2237 1859 2352 -6938 4 2 0 1 1923 1924 1788 2441 -6939 4 2 0 1 2298 2353 1732 2795 -6940 4 2 0 1 692 803 1942 2288 -6941 4 2 0 1 1839 2361 1771 2784 -6942 4 2 0 1 1859 1619 2237 2669 -6943 4 2 0 1 1923 2079 1693 2372 -6944 4 2 0 1 1776 1648 2079 2649 -6945 4 2 0 1 1814 2224 2158 2738 -6946 4 2 0 1 1805 2254 2383 2668 -6947 4 2 0 1 1171 2095 1108 2518 -6948 4 2 0 1 1951 2182 1640 2335 -6949 4 2 0 1 1569 2113 1980 2590 -6950 4 2 0 1 1579 1798 1935 2072 -6951 4 2 0 1 274 2086 483 2612 -6952 4 2 0 1 1527 1928 2032 2296 -6953 4 2 0 1 805 1826 2034 2307 -6954 4 2 0 1 1924 2475 1311 2484 -6955 4 2 0 1 1568 1963 1762 2167 -6956 4 2 0 1 1574 2308 1750 2538 -6957 4 2 0 1 1783 2050 1750 2538 -6958 4 2 0 1 1633 1762 1963 2243 -6959 4 2 0 1 1601 1728 2227 2479 -6960 4 2 0 1 1919 2176 1768 2465 -6961 4 2 0 1 1153 1661 1994 2582 -6962 4 2 0 1 1305 1372 1442 2016 -6963 4 2 0 1 1607 2026 1984 2686 -6964 4 2 0 1 1900 1970 1835 2364 -6965 4 2 0 1 779 1826 2055 2529 -6966 4 2 0 1 2000 2320 2111 2834 -6967 4 2 0 1 1661 2229 2095 2232 -6968 4 2 0 1 1554 2361 1771 2385 -6969 4 2 0 1 1082 1019 2384 2570 -6970 4 2 0 1 1369 1217 2042 2579 -6971 4 2 0 1 594 675 2260 2672 -6972 4 2 0 1 1646 2522 1901 2716 -6973 4 2 0 1 2059 2071 1838 2756 -6974 4 2 0 1 1430 1360 1828 2104 -6975 4 2 0 1 884 2461 888 2589 -6976 4 2 0 1 1982 2200 209 2446 -6977 4 2 0 1 1564 1801 2242 2597 -6978 4 2 0 1 1553 2220 2206 2782 -6979 4 2 0 1 854 1860 816 2638 -6980 4 2 0 1 1734 1949 1652 2790 -6981 4 2 0 1 1676 1753 2352 2699 -6982 4 2 0 1 351 1879 372 2333 -6983 4 2 0 1 891 2495 2494 2561 -6984 4 2 0 1 1613 1980 2373 2633 -6985 4 2 0 1 1878 1666 2249 2440 -6986 4 2 0 1 874 1803 915 2233 -6987 4 2 0 1 1551 1811 2532 2547 -6988 4 2 0 1 1724 2165 1771 2644 -6989 4 2 0 1 1698 2181 2019 2549 -6990 4 2 0 1 652 1972 1869 2777 -6991 4 2 0 1 726 1757 776 2628 -6992 4 2 0 1 511 1849 2567 2685 -6993 4 2 0 1 1816 2030 1778 2776 -6994 4 2 0 1 1030 1176 1036 1870 -6995 4 2 0 1 1528 1812 1911 2510 -6996 4 2 0 1 1531 2249 1836 2505 -6997 4 2 0 1 515 2359 451 2610 -6998 4 2 0 1 594 2260 1845 2672 -6999 4 2 0 1 1839 2385 1703 2439 -7000 4 2 0 1 1358 1348 1357 2076 -7001 4 2 0 1 299 183 1859 2669 -7002 4 2 0 1 1660 2039 1981 2505 -7003 4 2 0 1 1603 2189 1947 2357 -7004 4 2 0 1 706 1936 812 2099 -7005 4 2 0 1 2004 2680 2362 2748 -7006 4 2 0 1 1773 2386 2063 2549 -7007 4 2 0 1 1367 1320 1452 2462 -7008 4 2 0 1 1898 2428 1790 2771 -7009 4 2 0 1 754 1933 2171 2596 -7010 4 2 0 1 2050 2220 1783 2348 -7011 4 2 0 1 1970 1802 2270 2364 -7012 4 2 0 1 1118 1078 1166 2564 -7013 4 2 0 1 1617 2060 1745 2410 -7014 4 2 0 1 1775 2191 2075 2384 -7015 4 2 0 1 1736 1813 2399 2417 -7016 4 2 0 1 2195 2356 1901 2434 -7017 4 2 0 1 1782 1574 2024 2526 -7018 4 2 0 1 1468 1460 1477 2724 -7019 4 2 0 1 551 2069 2393 2469 -7020 4 2 0 1 1754 1847 1600 2495 -7021 4 2 0 1 1395 1221 1388 1731 -7022 4 2 0 1 771 2436 1718 2714 -7023 4 2 0 1 1617 1836 2238 2368 -7024 4 2 0 1 202 353 347 1816 -7025 4 2 0 1 1430 1185 1360 2104 -7026 4 2 0 1 1637 1821 2194 2749 -7027 4 2 0 1 1657 2002 1997 2449 -7028 4 2 0 1 306 2030 2190 2744 -7029 4 2 0 1 1454 1276 2205 2513 -7030 4 2 0 1 2108 2218 1640 2719 -7031 4 2 0 1 1923 2079 1622 2329 -7032 4 2 0 1 1733 2084 2052 2676 -7033 4 2 0 1 240 186 1761 2127 -7034 4 2 0 1 1588 1736 2200 2632 -7035 4 2 0 1 1486 1189 1707 2640 -7036 4 2 0 1 1324 1227 2013 2324 -7037 4 2 0 1 1018 2138 2191 2594 -7038 4 2 0 1 147 847 724 1794 -7039 4 2 0 1 1565 2322 2008 2801 -7040 4 2 0 1 1892 2110 2373 2829 -7041 4 2 0 1 2040 2108 1795 2578 -7042 4 2 0 1 1947 2156 1631 2189 -7043 4 2 0 1 1544 2226 2625 2800 -7044 4 2 0 1 903 996 891 2049 -7045 4 2 0 1 1852 2334 2231 2373 -7046 4 2 0 1 1738 2486 2048 2836 -7047 4 2 0 1 1586 2300 1784 2388 -7048 4 2 0 1 1397 1425 1228 2770 -7049 4 2 0 1 888 2461 2129 2589 -7050 4 2 0 1 1923 1924 1622 2305 -7051 4 2 0 1 342 334 357 2268 -7052 4 2 0 1 1320 1452 1944 2720 -7053 4 2 0 1 1621 1957 1757 2089 -7054 4 2 0 1 316 2130 1699 2601 -7055 4 2 0 1 520 1800 444 2409 -7056 4 2 0 1 1708 1539 2022 2232 -7057 4 2 0 1 1616 1708 2552 2755 -7058 4 2 0 1 1720 2062 519 2624 -7059 4 2 0 1 991 897 945 2461 -7060 4 2 0 1 1571 1785 2204 2634 -7061 4 2 0 1 157 843 723 2135 -7062 4 2 0 1 444 1877 509 2153 -7063 4 2 0 1 1667 2061 1832 2588 -7064 4 2 0 1 537 576 580 1995 -7065 4 2 0 1 1691 1784 2300 2388 -7066 4 2 0 1 1339 2383 2076 2668 -7067 4 2 0 1 1877 2153 1977 2567 -7068 4 2 0 1 1144 1041 1688 2458 -7069 4 2 0 1 1754 2035 1929 2259 -7070 4 2 0 1 1294 716 2379 2485 -7071 4 2 0 1 624 555 1912 2281 -7072 4 2 0 1 1834 2013 1227 2324 -7073 4 2 0 1 1545 2437 2031 2809 -7074 4 2 0 1 655 1766 681 2192 -7075 4 2 0 1 1939 2134 1737 2468 -7076 4 2 0 1 1753 1980 2080 2590 -7077 4 2 0 1 845 2087 1488 2131 -7078 4 2 0 1 1954 2220 1553 2415 -7079 4 2 0 1 213 2020 406 2472 -7080 4 2 0 1 804 813 1752 2267 -7081 4 2 0 1 794 1933 1264 2171 -7082 4 2 0 1 1841 1653 2141 2314 -7083 4 2 0 1 360 1895 354 2366 -7084 4 2 0 1 959 2057 923 2241 -7085 4 2 0 1 1664 2070 2158 2188 -7086 4 2 0 1 1768 1966 2176 2517 -7087 4 2 0 1 1547 1742 1968 2500 -7088 4 2 0 1 1217 2013 1374 2042 -7089 4 2 0 1 804 1752 825 2288 -7090 4 2 0 1 780 747 707 2436 -7091 4 2 0 1 1941 2402 2121 2460 -7092 4 2 0 1 653 145 682 1726 -7093 4 2 0 1 647 1825 600 2192 -7094 4 2 0 1 1553 1758 2415 2749 -7095 4 2 0 1 2047 2198 1663 2463 -7096 4 2 0 1 628 1955 574 2456 -7097 4 2 0 1 1198 1995 1359 2294 -7098 4 2 0 1 1972 2175 1815 2236 -7099 4 2 0 1 2046 2321 601 2761 -7100 4 2 0 1 1857 2044 1638 2325 -7101 4 2 0 1 2047 2252 1734 2313 -7102 4 2 0 1 330 2200 209 2328 -7103 4 2 0 1 1684 2032 1928 2296 -7104 4 2 0 1 2222 2298 200 2741 -7105 4 2 0 1 306 204 1801 2190 -7106 4 2 0 1 1316 2094 1935 2420 -7107 4 2 0 1 1677 2046 1897 2330 -7108 4 2 0 1 1335 2091 1762 2721 -7109 4 2 0 1 134 569 1815 1960 -7110 4 2 0 1 1700 1868 2256 2618 -7111 4 2 0 1 2422 2488 1111 2626 -7112 4 2 0 1 1782 1916 1532 2210 -7113 4 2 0 1 1545 2401 1833 2809 -7114 4 2 0 1 1005 2287 868 2591 -7115 4 2 0 1 1569 1983 1918 2517 -7116 4 2 0 1 1647 2085 1941 2465 -7117 4 2 0 1 461 448 179 1875 -7118 4 2 0 1 1597 1958 1833 2506 -7119 4 2 0 1 1397 2148 1425 2770 -7120 4 2 0 1 1733 2446 295 2574 -7121 4 2 0 1 1590 2270 1850 2528 -7122 4 2 0 1 1633 1762 1992 2340 -7123 4 2 0 1 1940 2478 2003 2604 -7124 4 2 0 1 1724 2115 1771 2165 -7125 4 2 0 1 795 818 709 1765 -7126 4 2 0 1 2232 2552 1708 2563 -7127 4 2 0 1 261 2533 1884 2658 -7128 4 2 0 1 1545 2031 2437 2807 -7129 4 2 0 1 1929 2035 1754 2172 -7130 4 2 0 1 1630 1845 2192 2786 -7131 4 2 0 1 1657 2113 2449 2568 -7132 4 2 0 1 456 1850 340 2159 -7133 4 2 0 1 1879 2333 208 2574 -7134 4 2 0 1 1776 2041 700 2375 -7135 4 2 0 1 1589 1672 2102 2208 -7136 4 2 0 1 1598 1773 1928 2440 -7137 4 2 0 1 1302 1315 1187 2383 -7138 4 2 0 1 1082 2384 1863 2570 -7139 4 2 0 1 1608 1791 2266 2334 -7140 4 2 0 1 1452 2462 1944 2720 -7141 4 2 0 1 1786 2093 1916 2443 -7142 4 2 0 1 1782 1542 2024 2693 -7143 4 2 0 1 1569 2423 1716 2490 -7144 4 2 0 1 381 386 431 2207 -7145 4 2 0 1 163 981 2035 2734 -7146 4 2 0 1 1540 1736 2071 2417 -7147 4 2 0 1 1641 1867 1811 2304 -7148 4 2 0 1 1117 2179 1053 2522 -7149 4 2 0 1 780 1855 848 2436 -7150 4 2 0 1 1606 1864 2170 2642 -7151 4 2 0 1 423 194 512 2173 -7152 4 2 0 1 1937 1984 1607 2724 -7153 4 2 0 1 1634 2376 2159 2528 -7154 4 2 0 1 2150 2239 1833 2682 -7155 4 2 0 1 1806 2004 1945 2418 -7156 4 2 0 1 354 1895 178 2489 -7157 4 2 0 1 1775 2170 1031 2565 -7158 4 2 0 1 1302 2383 1805 2531 -7159 4 2 0 1 2344 2350 1596 2745 -7160 4 2 0 1 1736 2185 419 2200 -7161 4 2 0 1 182 2190 2030 2211 -7162 4 2 0 1 1901 1660 2505 2600 -7163 4 2 0 1 147 1794 724 2131 -7164 4 2 0 1 1578 1884 1955 2124 -7165 4 2 0 1 1820 2022 1708 2289 -7166 4 2 0 1 759 2099 1740 2677 -7167 4 2 0 1 747 837 2068 2106 -7168 4 2 0 1 1538 2402 2460 2794 -7169 4 2 0 1 1325 1411 1361 2012 -7170 4 2 0 1 1543 2660 2083 2792 -7171 4 2 0 1 1701 2437 2038 2698 -7172 4 2 0 1 1662 2093 1726 2212 -7173 4 2 0 1 1557 1746 2768 2814 -7174 4 2 0 1 1266 1708 1267 2563 -7175 4 2 0 1 929 1832 931 2073 -7176 4 2 0 1 763 1855 1822 2436 -7177 4 2 0 1 1225 1309 1339 2668 -7178 4 2 0 1 1594 1737 2134 2468 -7179 4 2 0 1 1897 2020 1668 2827 -7180 4 2 0 1 1662 2100 2093 2443 -7181 4 2 0 1 1695 2298 2222 2741 -7182 4 2 0 1 1754 1929 1603 2561 -7183 4 2 0 1 1627 2235 1912 2497 -7184 4 2 0 1 1291 1008 919 2775 -7185 4 2 0 1 1726 2212 1786 2283 -7186 4 2 0 1 1298 2241 1872 2383 -7187 4 2 0 1 1541 1791 2143 2602 -7188 4 2 0 1 1537 2386 2019 2549 -7189 4 2 0 1 1720 1848 2166 2575 -7190 4 2 0 1 423 2173 2225 2554 -7191 4 2 0 1 1738 2319 2176 2423 -7192 4 2 0 1 1171 2095 2518 2603 -7193 4 2 0 1 1224 1511 973 2715 -7194 4 2 0 1 170 1904 270 2092 -7195 4 2 0 1 1915 2147 1965 2791 -7196 4 2 0 1 295 311 484 1733 -7197 4 2 0 1 1559 1999 1793 2160 -7198 4 2 0 1 1902 1983 1676 2669 -7199 4 2 0 1 1699 2726 2621 2805 -7200 4 2 0 1 1528 2486 1911 2650 -7201 4 2 0 1 1756 2315 2083 2792 -7202 4 2 0 1 708 817 2596 2677 -7203 4 2 0 1 1507 1525 1501 157 -7204 4 2 0 1 1548 1971 1755 2208 -7205 4 2 0 1 649 2192 1845 2786 -7206 4 2 0 1 193 524 2209 2477 -7207 4 2 0 1 1906 2608 1908 2780 -7208 4 2 0 1 1232 2012 1322 2441 -7209 4 2 0 1 1612 2000 2111 2429 -7210 4 2 0 1 508 2217 2017 2635 -7211 4 2 0 1 1928 2440 2214 2820 -7212 4 2 0 1 333 2399 2207 2472 -7213 4 2 0 1 958 2327 278 2576 -7214 4 2 0 1 1882 2103 1684 2675 -7215 4 2 0 1 1809 2400 1948 2530 -7216 4 2 0 1 1576 2043 1959 2810 -7217 4 2 0 1 1654 2096 1805 2558 -7218 4 2 0 1 305 307 319 2571 -7219 4 2 0 1 1638 2325 2044 2512 -7220 4 2 0 1 1575 2114 2119 2817 -7221 4 2 0 1 783 717 776 1757 -7222 4 2 0 1 1681 1819 2613 2768 -7223 4 2 0 1 531 1845 649 2192 -7224 4 2 0 1 1532 1891 2343 2546 -7225 4 2 0 1 1564 2701 1920 2829 -7226 4 2 0 1 1072 2054 1132 2626 -7227 4 2 0 1 1785 1621 2204 2634 -7228 4 2 0 1 1882 2063 1773 2249 -7229 4 2 0 1 1765 2501 1855 2585 -7230 4 2 0 1 1503 2051 1244 2615 -7231 4 2 0 1 1975 2119 1055 2570 -7232 4 2 0 1 1544 1721 2188 2625 -7233 4 2 0 1 1671 2313 2047 2427 -7234 4 2 0 1 1800 2409 520 2826 -7235 4 2 0 1 448 1875 461 2086 -7236 4 2 0 1 1541 2143 1804 2602 -7237 4 2 0 1 1211 1484 907 2081 -7238 4 2 0 1 1035 1913 2170 2642 -7239 4 2 0 1 661 681 593 1766 -7240 4 2 0 1 1802 2364 2031 2807 -7241 4 2 0 1 822 1810 742 2722 -7242 4 2 0 1 151 2523 2109 2628 -7243 4 2 0 1 1612 2018 1808 2033 -7244 4 2 0 1 1537 2142 1963 2214 -7245 4 2 0 1 949 862 2477 2637 -7246 4 2 0 1 557 621 534 2330 -7247 4 2 0 1 1647 1768 2085 2465 -7248 4 2 0 1 757 2068 468 2144 -7249 4 2 0 1 1943 1971 1601 2402 -7250 4 2 0 1 1537 2019 1773 2214 -7251 4 2 0 1 1746 2218 2108 2719 -7252 4 2 0 1 1775 2040 1606 2535 -7253 4 2 0 1 1667 2248 2125 2588 -7254 4 2 0 1 1643 1877 1849 2685 -7255 4 2 0 1 2239 2447 2027 2837 -7256 4 2 0 1 1567 1899 2139 2481 -7257 4 2 0 1 583 2294 2132 2393 -7258 4 2 0 1 2013 2042 1217 2579 -7259 4 2 0 1 1730 2104 1639 2215 -7260 4 2 0 1 1567 2207 1813 2580 -7261 4 2 0 1 2142 2214 1537 2440 -7262 4 2 0 1 1594 2517 1918 2607 -7263 4 2 0 1 1708 2021 1267 2563 -7264 4 2 0 1 1602 1969 1767 2807 -7265 4 2 0 1 2275 2751 1893 2770 -7266 4 2 0 1 547 2046 1831 2256 -7267 4 2 0 1 1233 1742 1199 2507 -7268 4 2 0 1 1958 1530 2183 2471 -7269 4 2 0 1 1582 1757 1957 2089 -7270 4 2 0 1 1656 2108 2006 2548 -7271 4 2 0 1 1845 2139 1700 2260 -7272 4 2 0 1 235 456 2002 2159 -7273 4 2 0 1 1657 2080 1850 2270 -7274 4 2 0 1 1831 1700 2481 2569 -7275 4 2 0 1 2042 2077 1663 2573 -7276 4 2 0 1 926 2125 924 2553 -7277 4 2 0 1 1723 2488 2422 2626 -7278 4 2 0 1 1581 2432 1740 2659 -7279 4 2 0 1 1782 2506 2150 2693 -7280 4 2 0 1 1081 2119 1143 2255 -7281 4 2 0 1 325 356 1813 2328 -7282 4 2 0 1 1646 2303 2264 2339 -7283 4 2 0 1 1651 1938 2257 2520 -7284 4 2 0 1 1558 1822 1881 2643 -7285 4 2 0 1 957 1797 893 2137 -7286 4 2 0 1 1876 2181 1887 2617 -7287 4 2 0 1 1071 1787 1133 2056 -7288 4 2 0 1 1777 1900 1625 2296 -7289 4 2 0 1 2003 2286 1770 2604 -7290 4 2 0 1 1329 1188 2284 2324 -7291 4 2 0 1 565 576 1995 2131 -7292 4 2 0 1 926 1817 964 2248 -7293 4 2 0 1 1632 1876 2273 2617 -7294 4 2 0 1 2080 2270 1802 2528 -7295 4 2 0 1 424 2225 1823 2554 -7296 4 2 0 1 606 1786 618 2212 -7297 4 2 0 1 1637 2132 2194 2467 -7298 4 2 0 1 2322 2351 1974 2783 -7299 4 2 0 1 1614 2182 1721 2537 -7300 4 2 0 1 1560 2257 2290 2707 -7301 4 2 0 1 1621 2307 1826 2363 -7302 4 2 0 1 634 529 603 1841 -7303 4 2 0 1 1401 1893 1426 2770 -7304 4 2 0 1 1664 2221 2172 2700 -7305 4 2 0 1 1334 1462 1212 2420 -7306 4 2 0 1 962 1832 2248 2365 -7307 4 2 0 1 1648 2079 1860 2360 -7308 4 2 0 1 1610 1724 2115 2385 -7309 4 2 0 1 1761 240 2127 2612 -7310 4 2 0 1 2168 2311 1739 2437 -7311 4 2 0 1 2267 2316 1690 2498 -7312 4 2 0 1 1840 1623 2551 2617 -7313 4 2 0 1 1936 2041 1776 2736 -7314 4 2 0 1 339 2156 309 2269 -7315 4 2 0 1 1910 2218 1557 2764 -7316 4 2 0 1 1674 2017 1905 2645 -7317 4 2 0 1 2153 2539 350 2639 -7318 4 2 0 1 1730 2342 1437 2724 -7319 4 2 0 1 1138 1930 272 2349 -7320 4 2 0 1 1897 1668 2618 2827 -7321 4 2 0 1 1613 2110 1851 2633 -7322 4 2 0 1 1346 1336 1834 2337 -7323 4 2 0 1 1598 2193 1734 2678 -7324 4 2 0 1 1878 1568 2047 2167 -7325 4 2 0 1 1777 1611 2143 2796 -7326 4 2 0 1 456 340 366 2159 -7327 4 2 0 1 1564 2671 1859 2699 -7328 4 2 0 1 1582 1849 1993 2403 -7329 4 2 0 1 1780 1922 1556 2016 -7330 4 2 0 1 1386 1448 1432 1906 -7331 4 2 0 1 2083 2660 1756 2792 -7332 4 2 0 1 1599 1817 2261 2778 -7333 4 2 0 1 360 178 354 1895 -7334 4 2 0 1 314 300 1778 2211 -7335 4 2 0 1 1563 1770 2098 2391 -7336 4 2 0 1 1585 2239 1778 2653 -7337 4 2 0 1 1331 1309 2076 2740 -7338 4 2 0 1 1559 1800 2490 2793 -7339 4 2 0 1 1734 2175 2141 2193 -7340 4 2 0 1 1881 2508 775 2555 -7341 4 2 0 1 2114 2509 1711 2817 -7342 4 2 0 1 1697 2157 1903 2779 -7343 4 2 0 1 1578 1916 1950 2443 -7344 4 2 0 1 1556 2078 1852 2765 -7345 4 2 0 1 1873 2251 1754 2492 -7346 4 2 0 1 1735 2179 1869 2434 -7347 4 2 0 1 1726 2425 682 2497 -7348 4 2 0 1 1538 1962 1844 2078 -7349 4 2 0 1 1135 1120 1975 2491 -7350 4 2 0 1 1802 1920 2080 2528 -7351 4 2 0 1 1675 2471 1958 2750 -7352 4 2 0 1 1512 1251 2822 2835 -7353 4 2 0 1 1851 2110 1613 2487 -7354 4 2 0 1 1748 2158 1548 2636 -7355 4 2 0 1 485 508 2017 2635 -7356 4 2 0 1 1263 1810 1290 2722 -7357 4 2 0 1 1087 2202 1846 2570 -7358 4 2 0 1 2096 2254 1805 2708 -7359 4 2 0 1 227 358 2468 2489 -7360 4 2 0 1 1732 2680 2004 2748 -7361 4 2 0 1 1771 2115 1724 2385 -7362 4 2 0 1 1877 1977 1582 2567 -7363 4 2 0 1 313 2353 2298 2795 -7364 4 2 0 1 548 661 593 2246 -7365 4 2 0 1 414 2097 367 2821 -7366 4 2 0 1 1747 2074 1953 2547 -7367 4 2 0 1 1578 1905 2457 2705 -7368 4 2 0 1 1564 1917 1880 2118 -7369 4 2 0 1 1784 1962 1586 2388 -7370 4 2 0 1 1561 2013 1834 2746 -7371 4 2 0 1 966 2542 1894 2695 -7372 4 2 0 1 540 1825 2281 2393 -7373 4 2 0 1 559 2283 1934 2536 -7374 4 2 0 1 2236 2728 1815 2745 -7375 4 2 0 1 2140 2274 1021 2346 -7376 4 2 0 1 1586 1835 2309 2369 -7377 4 2 0 1 1757 1957 1621 2307 -7378 4 2 0 1 1209 1372 1678 2493 -7379 4 2 0 1 511 2338 1849 2685 -7380 4 2 0 1 1753 2352 2110 2431 -7381 4 2 0 1 1963 2214 2142 2440 -7382 4 2 0 1 618 613 2345 2536 -7383 4 2 0 1 2345 2443 1786 2802 -7384 4 2 0 1 466 2209 1800 2826 -7385 4 2 0 1 1571 2265 1991 2347 -7386 4 2 0 1 764 823 2045 2253 -7387 4 2 0 1 2138 2518 1710 2594 -7388 4 2 0 1 1699 2228 1978 2601 -7389 4 2 0 1 2205 2265 1933 2557 -7390 4 2 0 1 1650 1782 2150 2693 -7391 4 2 0 1 406 2020 2399 2472 -7392 4 2 0 1 1539 1853 2114 2509 -7393 4 2 0 1 1585 2030 1801 2190 -7394 4 2 0 1 1534 2172 1754 2221 -7395 4 2 0 1 2111 2320 1612 2429 -7396 4 2 0 1 2032 2038 1701 2311 -7397 4 2 0 1 665 1828 651 2053 -7398 4 2 0 1 1205 1787 1049 2339 -7399 4 2 0 1 1697 2157 1989 2355 -7400 4 2 0 1 1746 1557 2218 2814 -7401 4 2 0 1 202 1816 347 2635 -7402 4 2 0 1 1859 2153 183 2639 -7403 4 2 0 1 2023 2134 1591 2832 -7404 4 2 0 1 841 143 727 2120 -7405 4 2 0 1 1662 1881 2161 2377 -7406 4 2 0 1 2064 2182 1688 2274 -7407 4 2 0 1 1894 2444 1790 2542 -7408 4 2 0 1 143 2120 2212 2687 -7409 4 2 0 1 1554 2177 1808 2592 -7410 4 2 0 1 1780 1885 1638 2512 -7411 4 2 0 1 524 516 1946 2477 -7412 4 2 0 1 1409 2381 1824 2493 -7413 4 2 0 1 413 234 377 2066 -7414 4 2 0 1 1564 2242 1880 2597 -7415 4 2 0 1 1538 2411 2402 2794 -7416 4 2 0 1 1612 2320 2000 2834 -7417 4 2 0 1 1542 1923 1830 2372 -7418 4 2 0 1 1194 1764 2033 2835 -7419 4 2 0 1 574 1955 1884 2456 -7420 4 2 0 1 1894 2542 1790 2695 -7421 4 2 0 1 1821 1921 2415 2749 -7422 4 2 0 1 1727 2077 2042 2573 -7423 4 2 0 1 1593 2107 2280 2689 -7424 4 2 0 1 1593 2280 2061 2689 -7425 4 2 0 1 1003 1002 1790 2562 -7426 4 2 0 1 1563 2098 1770 2147 -7427 4 2 0 1 1764 2822 2051 2835 -7428 4 2 0 1 1918 2517 1722 2607 -7429 4 2 0 1 1728 2240 1945 2656 -7430 4 2 0 1 1955 2124 1884 2457 -7431 4 2 0 1 1146 286 1132 1904 -7432 4 2 0 1 2014 2577 1648 2717 -7433 4 2 0 1 1630 1934 2706 2786 -7434 4 2 0 1 653 145 1726 2638 -7435 4 2 0 1 254 2456 2124 2457 -7436 4 2 0 1 168 325 356 2399 -7437 4 2 0 1 524 1946 516 2209 -7438 4 2 0 1 1791 2271 1675 2334 -7439 4 2 0 1 516 264 2209 2338 -7440 4 2 0 1 850 2316 2267 2498 -7441 4 2 0 1 1652 2009 1949 2169 -7442 4 2 0 1 1754 2172 2035 2259 -7443 4 2 0 1 924 1016 870 2553 -7444 4 2 0 1 825 804 813 1752 -7445 4 2 0 1 1597 1865 1830 2308 -7446 4 2 0 1 1838 2193 1598 2678 -7447 4 2 0 1 1657 1997 1983 2691 -7448 4 2 0 1 915 2462 919 2775 -7449 4 2 0 1 1528 2048 1911 2486 -7450 4 2 0 1 1700 1831 2481 2618 -7451 4 2 0 1 2188 2625 1741 2800 -7452 4 2 0 1 2035 2172 1664 2259 -7453 4 2 0 1 1550 2293 1732 2568 -7454 4 2 0 1 1292 1202 1994 2582 -7455 4 2 0 1 926 930 1817 2553 -7456 4 2 0 1 1591 1843 2219 2832 -7457 4 2 0 1 1592 1897 1831 2618 -7458 4 2 0 1 2049 2494 1847 2495 -7459 4 2 0 1 1587 2126 2710 2828 -7460 4 2 0 1 936 1961 867 2073 -7461 4 2 0 1 1548 1971 1744 2480 -7462 4 2 0 1 1602 2185 1879 2333 -7463 4 2 0 1 1644 2297 2020 2438 -7464 4 2 0 1 1799 1949 1607 2009 -7465 4 2 0 1 1116 132 2350 2503 -7466 4 2 0 1 2095 2232 1710 2603 -7467 4 2 0 1 2041 1622 2485 2666 -7468 4 2 0 1 1564 2242 1801 2699 -7469 4 2 0 1 1859 2237 1619 2352 -7470 4 2 0 1 1989 2103 1882 2575 -7471 4 2 0 1 2030 2525 383 2776 -7472 4 2 0 1 1809 2450 2433 2533 -7473 4 2 0 1 1650 1916 2443 2682 -7474 4 2 0 1 1659 1778 2211 2397 -7475 4 2 0 1 1853 2114 1711 2710 -7476 4 2 0 1 1805 2096 1654 2254 -7477 4 2 0 1 976 1946 892 2523 -7478 4 2 0 1 1801 2190 2030 2744 -7479 4 2 0 1 1932 1784 2309 2623 -7480 4 2 0 1 1815 2236 2175 2728 -7481 4 2 0 1 2454 2572 2011 2746 -7482 4 2 0 1 1982 2200 1588 2328 -7483 4 2 0 1 2129 2160 1724 2461 -7484 4 2 0 1 1682 2296 2168 2311 -7485 4 2 0 1 1439 1798 1352 2387 -7486 4 2 0 1 1409 1824 2455 2493 -7487 4 2 0 1 2187 2291 1698 2648 -7488 4 2 0 1 1910 2058 1673 2362 -7489 4 2 0 1 147 847 1794 2497 -7490 4 2 0 1 274 483 265 2612 -7491 4 2 0 1 298 2397 1982 2446 -7492 4 2 0 1 1859 365 2153 2669 -7493 4 2 0 1 353 2066 1816 2525 -7494 4 2 0 1 1707 1797 2140 2625 -7495 4 2 0 1 716 2485 1294 2666 -7496 4 2 0 1 427 407 2097 2468 -7497 4 2 0 1 1590 2364 1802 2807 -7498 4 2 0 1 1590 2270 1802 2364 -7499 4 2 0 1 1677 1967 2380 2745 -7500 4 2 0 1 1618 1799 1973 2272 -7501 4 2 0 1 1247 2201 1399 2337 -7502 4 2 0 1 1881 2120 1662 2161 -7503 4 2 0 1 1663 2047 1968 2198 -7504 4 2 0 1 569 617 663 1815 -7505 4 2 0 1 540 2294 583 2393 -7506 4 2 0 1 1622 1908 1760 2329 -7507 4 2 0 1 431 451 515 2359 -7508 4 2 0 1 1486 1189 1256 2146 -7509 4 2 0 1 1820 2007 1570 2609 -7510 4 2 0 1 1596 2344 1990 2350 -7511 4 2 0 1 1708 2223 1539 2232 -7512 4 2 0 1 1716 2097 1918 2641 -7513 4 2 0 1 1449 1352 1222 1798 -7514 4 2 0 1 1912 1995 573 2294 -7515 4 2 0 1 1652 1949 2009 2250 -7516 4 2 0 1 1599 2261 1911 2778 -7517 4 2 0 1 1553 2206 1954 2415 -7518 4 2 0 1 1357 1872 1511 2715 -7519 4 2 0 1 939 2591 868 2715 -7520 4 2 0 1 1569 1983 2517 2590 -7521 4 2 0 1 1455 1820 1384 2387 -7522 4 2 0 1 1620 1717 2245 2340 -7523 4 2 0 1 302 1823 392 2262 -7524 4 2 0 1 1621 2204 1811 2304 -7525 4 2 0 1 2023 2127 1687 2679 -7526 4 2 0 1 1561 2050 2654 2746 -7527 4 2 0 1 755 2144 850 2267 -7528 4 2 0 1 557 581 279 2330 -7529 4 2 0 1 1085 2170 1775 2584 -7530 4 2 0 1 1373 1392 2358 2441 -7531 4 2 0 1 1765 2267 818 2585 -7532 4 2 0 1 1897 2756 2020 2827 -7533 4 2 0 1 916 947 914 2107 -7534 4 2 0 1 1644 2380 2391 2823 -7535 4 2 0 1 759 814 801 1740 -7536 4 2 0 1 1545 2164 2437 2809 -7537 4 2 0 1 1896 2130 1577 2624 -7538 4 2 0 1 1847 411 2366 2494 -7539 4 2 0 1 1698 2015 2082 2291 -7540 4 2 0 1 1536 2198 2047 2463 -7541 4 2 0 1 2002 2159 312 2407 -7542 4 2 0 1 154 828 153 2115 -7543 4 2 0 1 1720 2355 2262 2797 -7544 4 2 0 1 1745 2410 2733 2777 -7545 4 2 0 1 765 710 701 1822 -7546 4 2 0 1 1395 1376 1221 2720 -7547 4 2 0 1 1566 2553 2125 2778 -7548 4 2 0 1 763 808 1822 2378 -7549 4 2 0 1 1156 438 268 2128 -7550 4 2 0 1 1596 1990 2344 2745 -7551 4 2 0 1 1821 2415 2194 2749 -7552 4 2 0 1 1770 2193 1838 2823 -7553 4 2 0 1 1922 2044 1651 2493 -7554 4 2 0 1 1556 1938 1986 2231 -7555 4 2 0 1 1577 2166 1925 2774 -7556 4 2 0 1 1711 2384 2594 2769 -7557 4 2 0 1 1803 2499 1731 2720 -7558 4 2 0 1 1858 2347 1743 2659 -7559 4 2 0 1 1542 1726 2093 2235 -7560 4 2 0 1 252 272 1930 2349 -7561 4 2 0 1 1683 1818 2572 2798 -7562 4 2 0 1 678 2260 545 2569 -7563 4 2 0 1 1747 1880 2447 2597 -7564 4 2 0 1 1526 1525 1284 2135 -7565 4 2 0 1 1817 1889 1628 2233 -7566 4 2 0 1 1702 2067 1899 2580 -7567 4 2 0 1 1635 1941 2121 2460 -7568 4 2 0 1 1594 2134 1939 2468 -7569 4 2 0 1 626 1725 2359 2610 -7570 4 2 0 1 1732 2748 1896 2795 -7571 4 2 0 1 1893 1633 2550 2770 -7572 4 2 0 1 1654 1805 1944 2558 -7573 4 2 0 1 1527 2032 2116 2311 -7574 4 2 0 1 911 1872 973 2241 -7575 4 2 0 1 1532 2343 1891 2430 -7576 4 2 0 1 1672 2208 2133 2668 -7577 4 2 0 1 1543 1848 2083 2726 -7578 4 2 0 1 1620 2245 1717 2599 -7579 4 2 0 1 560 1841 603 2169 -7580 4 2 0 1 1668 2481 1831 2618 -7581 4 2 0 1 1778 2776 300 2815 -7582 4 2 0 1 724 847 729 2087 -7583 4 2 0 1 703 743 773 1993 -7584 4 2 0 1 655 1766 2192 2663 -7585 4 2 0 1 341 337 2559 2601 -7586 4 2 0 1 225 450 226 2679 -7587 4 2 0 1 1544 2182 1827 2537 -7588 4 2 0 1 1586 1932 1835 1970 -7589 4 2 0 1 1908 2608 1769 2780 -7590 4 2 0 1 1557 2764 2218 2814 -7591 4 2 0 1 1733 2211 2446 2653 -7592 4 2 0 1 1903 2657 2407 2741 -7593 4 2 0 1 765 1822 808 2253 -7594 4 2 0 1 362 2049 244 2494 -7595 4 2 0 1 802 809 1855 2028 -7596 4 2 0 1 399 242 2472 2560 -7597 4 2 0 1 2346 2474 1707 2619 -7598 4 2 0 1 1054 165 2140 2278 -7599 4 2 0 1 1092 1087 1029 1846 -7600 4 2 0 1 1918 2517 1983 2691 -7601 4 2 0 1 1571 2347 1740 2432 -7602 4 2 0 1 1607 2009 1949 2250 -7603 4 2 0 1 1897 2020 1644 2297 -7604 4 2 0 1 794 748 835 1933 -7605 4 2 0 1 2173 2225 1723 2818 -7606 4 2 0 1 829 725 762 2684 -7607 4 2 0 1 1900 2103 1552 2369 -7608 4 2 0 1 1759 2266 1998 2476 -7609 4 2 0 1 2102 2208 1672 2411 -7610 4 2 0 1 1592 2314 1841 2380 -7611 4 2 0 1 1774 2201 2455 2737 -7612 4 2 0 1 1754 2221 1873 2492 -7613 4 2 0 1 1548 2254 1755 2511 -7614 4 2 0 1 276 1961 477 2107 -7615 4 2 0 1 1241 1371 1234 2263 -7616 4 2 0 1 1638 1986 1938 2476 -7617 4 2 0 1 1511 1348 1298 1872 -7618 4 2 0 1 1549 2414 2273 2716 -7619 4 2 0 1 1548 2254 2096 2708 -7620 4 2 0 1 1654 1944 2096 2558 -7621 4 2 0 1 1767 1879 2164 2676 -7622 4 2 0 1 1811 2089 1621 2304 -7623 4 2 0 1 175 471 453 1792 -7624 4 2 0 1 511 1849 2338 2692 -7625 4 2 0 1 1593 2086 1961 2107 -7626 4 2 0 1 794 835 1264 1933 -7627 4 2 0 1 1280 1937 1207 2053 -7628 4 2 0 1 526 885 521 282 -7629 4 2 0 1 1599 1889 2152 2365 -7630 4 2 0 1 678 545 2260 2400 -7631 4 2 0 1 964 2248 1817 2365 -7632 4 2 0 1 729 1860 695 2375 -7633 4 2 0 1 1564 1867 2352 2671 -7634 4 2 0 1 1125 1763 1088 2414 -7635 4 2 0 1 276 885 521 1961 -7636 4 2 0 1 1568 2167 2077 2573 -7637 4 2 0 1 845 724 2087 2131 -7638 4 2 0 1 1625 2296 2103 2675 -7639 4 2 0 1 1676 1859 2237 2669 -7640 4 2 0 1 1395 1731 1388 2374 -7641 4 2 0 1 1744 2208 2708 2794 -7642 4 2 0 1 700 1936 781 2041 -7643 4 2 0 1 1756 1645 2063 2646 -7644 4 2 0 1 1940 2173 1670 2554 -7645 4 2 0 1 1562 2193 1770 2823 -7646 4 2 0 1 469 1861 379 2662 -7647 4 2 0 1 1724 2129 2461 2589 -7648 4 2 0 1 484 1733 2211 2446 -7649 4 2 0 1 1904 2092 1658 2349 -7650 4 2 0 1 1697 1989 1915 2355 -7651 4 2 0 1 2287 2382 944 2734 -7652 4 2 0 1 1126 1863 2202 2570 -7653 4 2 0 1 1892 2110 2037 2373 -7654 4 2 0 1 1560 1987 1807 1988 -7655 4 2 0 1 2111 2616 2000 2834 -7656 4 2 0 1 1234 1760 1373 2358 -7657 4 2 0 1 1615 1751 2162 2695 -7658 4 2 0 1 767 1776 700 2375 -7659 4 2 0 1 1541 1759 2065 2310 -7660 4 2 0 1 1825 2192 1630 2459 -7661 4 2 0 1 1616 1951 1883 2244 -7662 4 2 0 1 1395 1221 1731 2720 -7663 4 2 0 1 965 2279 2162 2591 -7664 4 2 0 1 926 930 964 1817 -7665 4 2 0 1 1003 1000 1002 2562 -7666 4 2 0 1 1704 2059 1838 2823 -7667 4 2 0 1 1739 2437 2164 2809 -7668 4 2 0 1 1604 1786 2093 2753 -7669 4 2 0 1 1623 1876 2223 2617 -7670 4 2 0 1 850 2267 2144 2498 -7671 4 2 0 1 1956 2010 1689 2496 -7672 4 2 0 1 401 334 238 1829 -7673 4 2 0 1 1652 2141 1734 2790 -7674 4 2 0 1 1852 2078 1712 2765 -7675 4 2 0 1 1443 2026 1742 2686 -7676 4 2 0 1 881 866 937 1889 -7677 4 2 0 1 1558 1822 2502 2773 -7678 4 2 0 1 1589 2531 1805 2558 -7679 4 2 0 1 603 1841 560 2236 -7680 4 2 0 1 2345 2120 2687 2705 -7681 4 2 0 1 1548 1744 1971 2208 -7682 4 2 0 1 443 415 2090 2185 -7683 4 2 0 1 1616 1708 2022 2552 -7684 4 2 0 1 1744 1971 2402 2480 -7685 4 2 0 1 1711 2114 1853 2509 -7686 4 2 0 1 2264 2419 1283 2435 -7687 4 2 0 1 1758 2469 2069 2812 -7688 4 2 0 1 1602 2632 2185 2698 -7689 4 2 0 1 659 1429 1252 2132 -7690 4 2 0 1 1776 2079 2014 2329 -7691 4 2 0 1 1185 1344 1328 1758 -7692 4 2 0 1 930 964 1817 2365 -7693 4 2 0 1 1817 1599 2248 2778 -7694 4 2 0 1 1479 1467 1769 2379 -7695 4 2 0 1 1761 2280 2107 2689 -7696 4 2 0 1 1720 2262 2062 2797 -7697 4 2 0 1 1419 1909 1385 2148 -7698 4 2 0 1 1605 2355 1720 2797 -7699 4 2 0 1 1732 2680 2748 2795 -7700 4 2 0 1 1528 2465 1812 2510 -7701 4 2 0 1 1951 1640 2244 2335 -7702 4 2 0 1 1785 2634 1685 2718 -7703 4 2 0 1 900 892 2477 2637 -7704 4 2 0 1 1086 1171 2518 2603 -7705 4 2 0 1 1941 2465 1744 2480 -7706 4 2 0 1 1608 2037 2231 2373 -7707 4 2 0 1 868 2591 2287 2715 -7708 4 2 0 1 414 2641 2097 2821 -7709 4 2 0 1 1548 2158 1748 2254 -7710 4 2 0 1 1703 2466 2048 2616 -7711 4 2 0 1 1599 2152 1724 2160 -7712 4 2 0 1 1967 1990 1677 2694 -7713 4 2 0 1 431 451 2359 2610 -7714 4 2 0 1 1884 1955 574 2345 -7715 4 2 0 1 350 2153 239 2539 -7716 4 2 0 1 2298 2353 1997 2568 -7717 4 2 0 1 1612 2111 2000 2320 -7718 4 2 0 1 312 2002 456 2159 -7719 4 2 0 1 447 335 1879 2200 -7720 4 2 0 1 489 2626 194 2818 -7721 4 2 0 1 1853 2126 2075 2578 -7722 4 2 0 1 289 519 523 2157 -7723 4 2 0 1 1677 2297 1897 2380 -7724 4 2 0 1 1559 2423 1716 2545 -7725 4 2 0 1 823 764 767 1776 -7726 4 2 0 1 1205 1281 1787 2339 -7727 4 2 0 1 157 723 156 2670 -7728 4 2 0 1 1454 2205 1432 2513 -7729 4 2 0 1 1552 1835 2369 2799 -7730 4 2 0 1 1747 2447 2027 2597 -7731 4 2 0 1 1606 2541 1864 2768 -7732 4 2 0 1 1679 2324 1834 2737 -7733 4 2 0 1 1569 1966 1851 2633 -7734 4 2 0 1 1153 1661 2582 2603 -7735 4 2 0 1 1082 1863 1163 2565 -7736 4 2 0 1 377 2068 2066 2404 -7737 4 2 0 1 1187 1944 1475 2383 -7738 4 2 0 1 1521 1484 1204 2184 -7739 4 2 0 1 693 801 797 2028 -7740 4 2 0 1 1754 1600 2251 2495 -7741 4 2 0 1 1609 1762 2091 2721 -7742 4 2 0 1 1567 1725 2260 2400 -7743 4 2 0 1 538 620 585 1937 -7744 4 2 0 1 1597 2401 1958 2471 -7745 4 2 0 1 1842 1901 1745 2522 -7746 4 2 0 1 547 1831 2046 2560 -7747 4 2 0 1 360 369 1895 2366 -7748 4 2 0 1 1925 2166 1888 2774 -7749 4 2 0 1 1760 1572 2012 2441 -7750 4 2 0 1 1904 2202 1102 2564 -7751 4 2 0 1 1877 2153 444 2409 -7752 4 2 0 1 1216 1340 1954 2655 -7753 4 2 0 1 1621 2204 1752 2816 -7754 4 2 0 1 928 2162 1748 2591 -7755 4 2 0 1 2101 2317 411 2366 -7756 4 2 0 1 1625 2103 1888 2675 -7757 4 2 0 1 1831 1897 1592 2046 -7758 4 2 0 1 1771 2165 155 2670 -7759 4 2 0 1 1634 2159 2323 2528 -7760 4 2 0 1 1826 2203 1621 2363 -7761 4 2 0 1 2031 2168 1739 2437 -7762 4 2 0 1 312 2159 456 2407 -7763 4 2 0 1 1781 2184 2177 2299 -7764 4 2 0 1 1940 2225 1823 2789 -7765 4 2 0 1 1644 2059 1897 2380 -7766 4 2 0 1 443 2090 188 2185 -7767 4 2 0 1 1488 2087 1428 2131 -7768 4 2 0 1 2021 2552 2229 2563 -7769 4 2 0 1 1030 1870 1153 2603 -7770 4 2 0 1 1729 1946 2209 2793 -7771 4 2 0 1 1901 2356 2195 2600 -7772 4 2 0 1 1321 2453 2044 2455 -7773 4 2 0 1 1635 2121 1941 2465 -7774 4 2 0 1 2099 2513 2171 2631 -7775 4 2 0 1 1603 2049 1847 2561 -7776 4 2 0 1 1901 2522 1842 2716 -7777 4 2 0 1 482 1158 158 2049 -7778 4 2 0 1 624 1912 573 2294 -7779 4 2 0 1 1792 2445 2163 2539 -7780 4 2 0 1 1887 1537 2243 2629 -7781 4 2 0 1 1806 2362 2004 2680 -7782 4 2 0 1 1445 1772 1179 2751 -7783 4 2 0 1 1541 2011 1804 2520 -7784 4 2 0 1 430 1737 358 2679 -7785 4 2 0 1 1799 683 2367 2587 -7786 4 2 0 1 1533 2270 1970 2504 -7787 4 2 0 1 2190 2211 1733 2653 -7788 4 2 0 1 1097 2043 1914 2346 -7789 4 2 0 1 1335 1762 1425 2721 -7790 4 2 0 1 1685 1991 1890 2634 -7791 4 2 0 1 1606 2228 2541 2768 -7792 4 2 0 1 705 807 709 2501 -7793 4 2 0 1 990 1931 877 2155 -7794 4 2 0 1 396 2090 417 2662 -7795 4 2 0 1 339 1947 2156 2268 -7796 4 2 0 1 1791 1611 2143 2602 -7797 4 2 0 1 1625 1900 1777 2806 -7798 4 2 0 1 1580 2203 1826 2784 -7799 4 2 0 1 1352 1449 1316 1935 -7800 4 2 0 1 1206 1278 1293 2785 -7801 4 2 0 1 1585 2242 1880 2750 -7802 4 2 0 1 585 538 1937 2408 -7803 4 2 0 1 1755 2208 2420 2668 -7804 4 2 0 1 1647 1744 2465 2480 -7805 4 2 0 1 1165 1135 1120 1975 -7806 4 2 0 1 772 785 2041 2666 -7807 4 2 0 1 1566 1911 1812 2105 -7808 4 2 0 1 1958 2447 1880 2750 -7809 4 2 0 1 1875 2127 1761 2689 -7810 4 2 0 1 275 1990 577 2830 -7811 4 2 0 1 1642 2263 2012 2711 -7812 4 2 0 1 1083 1181 1115 1994 -7813 4 2 0 1 1752 2204 1890 2288 -7814 4 2 0 1 1189 1483 2146 2620 -7815 4 2 0 1 1767 1969 1602 2333 -7816 4 2 0 1 825 1752 813 2316 -7817 4 2 0 1 1969 2482 1697 2593 -7818 4 2 0 1 1910 2357 2058 2362 -7819 4 2 0 1 1531 2063 1882 2249 -7820 4 2 0 1 1580 2529 2034 2718 -7821 4 2 0 1 1545 1856 2271 2401 -7822 4 2 0 1 941 887 1873 2259 -7823 4 2 0 1 1919 2134 1768 2607 -7824 4 2 0 1 1560 1988 1807 2413 -7825 4 2 0 1 1897 2059 2756 2827 -7826 4 2 0 1 1125 1103 1763 2414 -7827 4 2 0 1 1584 1773 2019 2675 -7828 4 2 0 1 2063 2505 2039 2600 -7829 4 2 0 1 1581 1743 2432 2659 -7830 4 2 0 1 1544 2188 1721 2537 -7831 4 2 0 1 1842 2544 1901 2716 -7832 4 2 0 1 1567 2196 1809 2433 -7833 4 2 0 1 1987 2388 1844 2470 -7834 4 2 0 1 323 341 337 2559 -7835 4 2 0 1 1694 2123 2366 2683 -7836 4 2 0 1 1862 2149 2089 2426 -7837 4 2 0 1 485 2017 508 2217 -7838 4 2 0 1 2128 2350 132 2503 -7839 4 2 0 1 1144 1688 2274 2458 -7840 4 2 0 1 1607 1799 2009 2408 -7841 4 2 0 1 1714 2616 2111 2834 -7842 4 2 0 1 1553 1921 1783 2459 -7843 4 2 0 1 1682 2482 1969 2593 -7844 4 2 0 1 171 433 1977 1993 -7845 4 2 0 1 628 574 1955 2345 -7846 4 2 0 1 1560 1777 2290 2413 -7847 4 2 0 1 1542 2079 2100 2360 -7848 4 2 0 1 1799 2198 1949 2272 -7849 4 2 0 1 1702 2343 1891 2546 -7850 4 2 0 1 1577 1720 2624 2805 -7851 4 2 0 1 1558 2027 1816 2502 -7852 4 2 0 1 1243 1416 1820 2763 -7853 4 2 0 1 1662 1786 2212 2687 -7854 4 2 0 1 1291 919 2462 2775 -7855 4 2 0 1 1635 1980 1852 2566 -7856 4 2 0 1 681 1766 655 2663 -7857 4 2 0 1 1797 1624 2188 2625 -7858 4 2 0 1 1272 1808 2177 2299 -7859 4 2 0 1 1888 2216 1925 2774 -7860 4 2 0 1 1147 1295 1119 2056 -7861 4 2 0 1 764 1936 1776 2045 -7862 4 2 0 1 1539 1853 2126 2710 -7863 4 2 0 1 1791 2271 1611 2602 -7864 4 2 0 1 298 2211 2397 2446 -7865 4 2 0 1 1874 2112 1595 2652 -7866 4 2 0 1 1753 2237 1676 2352 -7867 4 2 0 1 1833 1659 2088 2430 -7868 4 2 0 1 223 170 270 2092 -7869 4 2 0 1 1931 2280 1761 2689 -7870 4 2 0 1 1081 2119 2255 2769 -7871 4 2 0 1 1689 1874 2427 2452 -7872 4 2 0 1 1643 2109 1946 2628 -7873 4 2 0 1 678 1725 626 2610 -7874 4 2 0 1 171 505 1993 2567 -7875 4 2 0 1 1718 2436 1822 2502 -7876 4 2 0 1 1257 1828 1360 2104 -7877 4 2 0 1 2175 2236 1972 2728 -7878 4 2 0 1 1625 1777 2413 2806 -7879 4 2 0 1 1742 2026 1443 2507 -7880 4 2 0 1 1656 1925 1795 2726 -7881 4 2 0 1 1997 2002 1695 2449 -7882 4 2 0 1 2258 1783 2546 2652 -7883 4 2 0 1 390 475 2333 2407 -7884 4 2 0 1 1583 1940 1823 2789 -7885 4 2 0 1 818 1765 795 2267 -7886 4 2 0 1 1939 1591 2293 2353 -7887 4 2 0 1 1667 1832 2061 2486 -7888 4 2 0 1 1788 1627 2024 2811 -7889 4 2 0 1 1563 2147 1770 2391 -7890 4 2 0 1 363 2123 354 2489 -7891 4 2 0 1 477 2107 274 2612 -7892 4 2 0 1 1604 2093 1786 2283 -7893 4 2 0 1 1443 1742 2435 2686 -7894 4 2 0 1 646 2587 2169 2766 -7895 4 2 0 1 1763 1975 1575 2119 -7896 4 2 0 1 1621 1752 1957 2816 -7897 4 2 0 1 267 2209 466 2826 -7898 4 2 0 1 1866 2047 1671 2831 -7899 4 2 0 1 1736 2185 2632 2698 -7900 4 2 0 1 1006 954 958 2327 -7901 4 2 0 1 1946 1643 2331 2523 -7902 4 2 0 1 212 2123 1939 2353 -7903 4 2 0 1 726 2109 1757 2628 -7904 4 2 0 1 540 600 1825 2393 -7905 4 2 0 1 1850 1983 1657 2605 -7906 4 2 0 1 1637 2294 2281 2393 -7907 4 2 0 1 878 2057 967 2279 -7908 4 2 0 1 1826 2363 2186 2784 -7909 4 2 0 1 1183 1290 1263 1810 -7910 4 2 0 1 2036 2454 2276 2712 -7911 4 2 0 1 337 316 199 2601 -7912 4 2 0 1 1874 2427 2112 2652 -7913 4 2 0 1 1592 2256 1868 2618 -7914 4 2 0 1 826 1955 141 2732 -7915 4 2 0 1 1656 2083 1853 2151 -7916 4 2 0 1 145 2425 1726 2638 -7917 4 2 0 1 1677 1967 2297 2380 -7918 4 2 0 1 1532 2150 1779 2430 -7919 4 2 0 1 1382 908 904 2137 -7920 4 2 0 1 1663 2198 2026 2724 -7921 4 2 0 1 1913 1978 1681 2405 -7922 4 2 0 1 1906 2205 1626 2513 -7923 4 2 0 1 1632 1763 2114 2255 -7924 4 2 0 1 1647 1898 1812 2224 -7925 4 2 0 1 1992 2148 1633 2770 -7926 4 2 0 1 1444 1275 1193 1749 -7927 4 2 0 1 1561 2011 1834 2396 -7928 4 2 0 1 2345 2530 1680 2536 -7929 4 2 0 1 973 1872 911 2715 -7930 4 2 0 1 1820 1384 2387 2763 -7931 4 2 0 1 1953 2074 1713 2532 -7932 4 2 0 1 770 854 816 2638 -7933 4 2 0 1 1617 1815 2175 2595 -7934 4 2 0 1 1751 2096 1566 2428 -7935 4 2 0 1 1986 2231 1938 2476 -7936 4 2 0 1 1572 1923 1830 2276 -7937 4 2 0 1 1506 1516 1474 2137 -7938 4 2 0 1 1623 2223 2117 2617 -7939 4 2 0 1 1794 2087 724 2131 -7940 4 2 0 1 1833 1958 1597 2401 -7941 4 2 0 1 1984 2197 1735 2419 -7942 4 2 0 1 1611 2168 2031 2364 -7943 4 2 0 1 1751 2562 2162 2695 -7944 4 2 0 1 1863 2384 1163 2565 -7945 4 2 0 1 1054 165 1159 2140 -7946 4 2 0 1 368 293 214 2516 -7947 4 2 0 1 1678 2016 1926 2765 -7948 4 2 0 1 1840 1909 1609 2442 -7949 4 2 0 1 1193 1389 2008 2322 -7950 4 2 0 1 1159 164 1173 2140 -7951 4 2 0 1 1471 2241 1298 2383 -7952 4 2 0 1 602 683 1799 2587 -7953 4 2 0 1 1026 1914 2043 2095 -7954 4 2 0 1 2139 2260 1845 2706 -7955 4 2 0 1 1078 1146 1132 1904 -7956 4 2 0 1 240 461 457 1875 -7957 4 2 0 1 1359 1423 1198 2294 -7958 4 2 0 1 1581 2145 1747 2213 -7959 4 2 0 1 1610 2115 1771 2385 -7960 4 2 0 1 1779 2150 1833 2430 -7961 4 2 0 1 1671 2112 1874 2427 -7962 4 2 0 1 1968 2026 1663 2198 -7963 4 2 0 1 2016 2493 1922 2664 -7964 4 2 0 1 896 941 1754 2259 -7965 4 2 0 1 1903 2593 1552 2799 -7966 4 2 0 1 1071 1787 2056 2414 -7967 4 2 0 1 1017 1746 1122 2458 -7968 4 2 0 1 1973 2180 530 2246 -7969 4 2 0 1 1061 1053 2339 2522 -7970 4 2 0 1 1977 2153 1665 2539 -7971 4 2 0 1 926 1011 930 2553 -7972 4 2 0 1 1620 2199 1893 2245 -7973 4 2 0 1 1271 1787 1281 2056 -7974 4 2 0 1 985 2057 979 2462 -7975 4 2 0 1 795 2144 755 2267 -7976 4 2 0 1 1607 1984 1937 2408 -7977 4 2 0 1 930 2233 1817 2553 -7978 4 2 0 1 466 1800 520 2826 -7979 4 2 0 1 1739 2164 1871 2808 -7980 4 2 0 1 1969 2159 1767 2807 -7981 4 2 0 1 1554 2361 1839 2392 -7982 4 2 0 1 1726 2093 1662 2360 -7983 4 2 0 1 1008 915 919 2775 -7984 4 2 0 1 389 2097 1918 2571 -7985 4 2 0 1 240 186 251 1761 -7986 4 2 0 1 484 1733 311 2211 -7987 4 2 0 1 909 885 862 2477 -7988 4 2 0 1 1125 1081 1143 2255 -7989 4 2 0 1 1807 1988 1625 2413 -7990 4 2 0 1 1895 2317 1600 2366 -7991 4 2 0 1 2238 2368 1836 2505 -7992 4 2 0 1 994 2327 2155 2803 -7993 4 2 0 1 1023 1054 2140 2696 -7994 4 2 0 1 1659 2446 2211 2653 -7995 4 2 0 1 240 1761 251 2612 -7996 4 2 0 1 1355 1335 1412 2077 -7997 4 2 0 1 1583 1823 2225 2789 -7998 4 2 0 1 618 1786 559 2536 -7999 4 2 0 1 1743 1858 2659 2787 -8000 4 2 0 1 558 1447 579 1984 -8001 4 2 0 1 1749 2351 2265 2718 -8002 4 2 0 1 2146 2301 1837 2620 -8003 4 2 0 1 1650 1916 1782 2693 -8004 4 2 0 1 1793 1999 2129 2160 -8005 4 2 0 1 1821 2036 1299 2655 -8006 4 2 0 1 1782 2308 2150 2506 -8007 4 2 0 1 1679 2453 2324 2737 -8008 4 2 0 1 238 1829 334 2556 -8009 4 2 0 1 288 2157 327 2657 -8010 4 2 0 1 1551 1953 2074 2547 -8011 4 2 0 1 1569 2517 2113 2590 -8012 4 2 0 1 2286 2380 1967 2745 -8013 4 2 0 1 1894 2023 1600 2492 -8014 4 2 0 1 1791 2266 2065 2476 -8015 4 2 0 1 1119 1466 1083 1181 -8016 4 2 0 1 1757 1610 2186 2363 -8017 4 2 0 1 752 799 1942 2677 -8018 4 2 0 1 2044 2453 1774 2455 -8019 4 2 0 1 1594 1768 2176 2607 -8020 4 2 0 1 297 2030 383 2776 -8021 4 2 0 1 1707 2140 1797 2278 -8022 4 2 0 1 1819 2764 1557 2814 -8023 4 2 0 1 1678 2664 2016 2765 -8024 4 2 0 1 1713 2074 1855 2585 -8025 4 2 0 1 1566 1812 1911 2428 -8026 4 2 0 1 1883 1951 1640 2244 -8027 4 2 0 1 431 2359 1725 2610 -8028 4 2 0 1 327 2657 2157 2741 -8029 4 2 0 1 2105 2510 1812 2708 -8030 4 2 0 1 2324 2453 1329 2737 -8031 4 2 0 1 1350 839 838 2379 -8032 4 2 0 1 908 2137 1382 2715 -8033 4 2 0 1 1758 2393 2069 2469 -8034 4 2 0 1 932 941 1873 2251 -8035 4 2 0 1 1676 2352 1859 2699 -8036 4 2 0 1 1907 2125 1566 2553 -8037 4 2 0 1 1658 1979 1930 2349 -8038 4 2 0 1 1744 2121 2402 2460 -8039 4 2 0 1 1641 2547 1811 2611 -8040 4 2 0 1 1672 1589 2133 2208 -8041 4 2 0 1 1312 1218 1349 1922 -8042 4 2 0 1 1561 2396 1818 2599 -8043 4 2 0 1 1681 2424 2406 2642 -8044 4 2 0 1 1601 2085 1941 2480 -8045 4 2 0 1 1727 2337 2340 2396 -8046 4 2 0 1 1085 1775 1150 2191 -8047 4 2 0 1 1856 2398 1739 2527 -8048 4 2 0 1 1785 2203 1580 2665 -8049 4 2 0 1 1948 2706 1680 2786 -8050 4 2 0 1 1918 1983 490 2691 -8051 4 2 0 1 600 1825 2393 2663 -8052 4 2 0 1 2090 2333 1969 2407 -8053 4 2 0 1 1766 1618 2246 2496 -8054 4 2 0 1 136 2410 1972 2777 -8055 4 2 0 1 1750 2306 1597 2308 -8056 4 2 0 1 1663 2077 2167 2573 -8057 4 2 0 1 1532 1779 2343 2430 -8058 4 2 0 1 1568 2573 2396 2831 -8059 4 2 0 1 1604 2093 1726 2235 -8060 4 2 0 1 1681 2405 1978 2556 -8061 4 2 0 1 1006 879 2542 2576 -8062 4 2 0 1 1558 2145 2027 2332 -8063 4 2 0 1 1113 1052 1060 2394 -8064 4 2 0 1 1378 1438 1240 2767 -8065 4 2 0 1 1973 2367 683 2587 -8066 4 2 0 1 1747 1581 2074 2145 -8067 4 2 0 1 1589 2510 2105 2708 -8068 4 2 0 1 1871 1736 2632 2698 -8069 4 2 0 1 842 2115 153 2186 -8070 4 2 0 1 1755 2208 1672 2420 -8071 4 2 0 1 461 2086 1875 2612 -8072 4 2 0 1 1308 2324 1324 2655 -8073 4 2 0 1 874 1803 2233 2553 -8074 4 2 0 1 1621 1957 2089 2816 -8075 4 2 0 1 1844 1560 2257 2290 -8076 4 2 0 1 873 1003 2155 2542 -8077 4 2 0 1 1138 272 446 2349 -8078 4 2 0 1 1841 1653 2321 2766 -8079 4 2 0 1 2112 2427 1689 2652 -8080 4 2 0 1 1828 2367 2053 2725 -8081 4 2 0 1 1693 2079 1923 2329 -8082 4 2 0 1 2103 2369 1900 2806 -8083 4 2 0 1 1548 1755 1971 2511 -8084 4 2 0 1 2018 2033 1612 2667 -8085 4 2 0 1 1650 2100 2372 2837 -8086 4 2 0 1 1561 2050 2220 2654 -8087 4 2 0 1 1593 2107 1961 2280 -8088 4 2 0 1 1416 1243 1820 2289 -8089 4 2 0 1 1738 1999 1559 2758 -8090 4 2 0 1 695 1860 854 2649 -8091 4 2 0 1 1557 2613 1819 2768 -8092 4 2 0 1 2070 2382 2287 2734 -8093 4 2 0 1 2074 2547 1747 2762 -8094 4 2 0 1 2022 1698 2291 2648 -8095 4 2 0 1 1649 1996 2597 2744 -8096 4 2 0 1 714 2555 718 2649 -8097 4 2 0 1 2209 2338 264 2685 -8098 4 2 0 1 1988 2413 1777 2806 -8099 4 2 0 1 1532 1950 2150 2430 -8100 4 2 0 1 1576 2346 2043 2810 -8101 4 2 0 1 1609 2091 1762 2167 -8102 4 2 0 1 2070 2287 944 2734 -8103 4 2 0 1 1578 2457 1955 2705 -8104 4 2 0 1 1722 1997 2353 2568 -8105 4 2 0 1 1622 2079 1860 2375 -8106 4 2 0 1 1583 1823 1940 1964 -8107 4 2 0 1 815 1991 803 2684 -8108 4 2 0 1 863 1781 950 2081 -8109 4 2 0 1 617 1815 625 2344 -8110 4 2 0 1 188 2185 2090 2333 -8111 4 2 0 1 1577 1795 1925 2726 -8112 4 2 0 1 1593 1738 1999 2545 -8113 4 2 0 1 1233 1355 1412 2507 -8114 4 2 0 1 1560 2199 1824 2257 -8115 4 2 0 1 1577 1925 2312 2774 -8116 4 2 0 1 1080 388 272 2713 -8117 4 2 0 1 1716 2423 2319 2545 -8118 4 2 0 1 1655 2433 2450 2533 -8119 4 2 0 1 1626 2171 2099 2513 -8120 4 2 0 1 1022 1060 1927 2424 -8121 4 2 0 1 444 1800 466 2685 -8122 4 2 0 1 1733 2190 311 2211 -8123 4 2 0 1 584 2400 1809 2530 -8124 4 2 0 1 1218 1922 1312 2493 -8125 4 2 0 1 2062 2130 316 2624 -8126 4 2 0 1 1976 2264 1283 2435 -8127 4 2 0 1 840 1826 769 2186 -8128 4 2 0 1 705 709 1765 2501 -8129 4 2 0 1 1985 2705 2377 2773 -8130 4 2 0 1 1590 2159 1969 2807 -8131 4 2 0 1 1685 1991 2596 2684 -8132 4 2 0 1 1673 2058 1910 2681 -8133 4 2 0 1 1102 1072 2054 2202 -8134 4 2 0 1 1802 1634 1920 2528 -8135 4 2 0 1 1587 2040 2075 2578 -8136 4 2 0 1 1826 2529 1580 2784 -8137 4 2 0 1 1078 1904 1102 2564 -8138 4 2 0 1 1535 1892 2110 2487 -8139 4 2 0 1 290 316 2062 2448 -8140 4 2 0 1 1812 2105 1911 2510 -8141 4 2 0 1 1760 1908 1622 2358 -8142 4 2 0 1 1879 2185 372 2333 -8143 4 2 0 1 1454 1238 1432 2205 -8144 4 2 0 1 601 2046 619 2321 -8145 4 2 0 1 1066 1519 1508 2278 -8146 4 2 0 1 274 193 250 1961 -8147 4 2 0 1 1932 1635 2113 2838 -8148 4 2 0 1 1705 2021 1255 2387 -8149 4 2 0 1 1574 1782 2308 2538 -8150 4 2 0 1 1813 2207 356 2399 -8151 4 2 0 1 1253 1409 1824 2455 -8152 4 2 0 1 1675 1791 2065 2271 -8153 4 2 0 1 1663 2167 2077 2507 -8154 4 2 0 1 1542 2100 2079 2372 -8155 4 2 0 1 418 2559 1930 2713 -8156 4 2 0 1 1342 1239 1383 2322 -8157 4 2 0 1 1108 2043 1090 2518 -8158 4 2 0 1 1275 1193 1749 2615 -8159 4 2 0 1 1694 2123 1895 2366 -8160 4 2 0 1 1823 1605 2395 2735 -8161 4 2 0 1 2021 1708 2552 2563 -8162 4 2 0 1 1593 2061 1738 2319 -8163 4 2 0 1 2406 2424 1096 2642 -8164 4 2 0 1 2076 2301 1331 2740 -8165 4 2 0 1 1102 1078 1072 1904 -8166 4 2 0 1 2208 2411 2102 2794 -8167 4 2 0 1 1227 1346 1336 1834 -8168 4 2 0 1 1903 2779 1695 2799 -8169 4 2 0 1 931 2073 1832 2129 -8170 4 2 0 1 706 750 1769 2631 -8171 4 2 0 1 1806 1945 1673 2227 -8172 4 2 0 1 1605 1989 1915 2147 -8173 4 2 0 1 1762 2091 2077 2167 -8174 4 2 0 1 1071 1049 1133 1787 -8175 4 2 0 1 2039 2063 1645 2646 -8176 4 2 0 1 1682 2311 2168 2437 -8177 4 2 0 1 1374 2013 1217 2579 -8178 4 2 0 1 1769 2379 1467 2631 -8179 4 2 0 1 1818 2651 2813 2820 -8180 4 2 0 1 1199 1742 1443 2507 -8181 4 2 0 1 1573 2180 1845 2672 -8182 4 2 0 1 1528 2121 1966 2465 -8183 4 2 0 1 1568 1878 2252 2440 -8184 4 2 0 1 1564 2352 1753 2699 -8185 4 2 0 1 717 766 776 2307 -8186 4 2 0 1 1572 2310 1759 2515 -8187 4 2 0 1 1650 2150 2506 2693 -8188 4 2 0 1 1958 2471 2401 2750 -8189 4 2 0 1 896 946 941 2259 -8190 4 2 0 1 2116 2230 1671 2524 -8191 4 2 0 1 1057 2416 1929 2709 -8192 4 2 0 1 1777 2143 2290 2796 -8193 4 2 0 1 2140 2346 1023 2696 -8194 4 2 0 1 2000 2037 1692 2487 -8195 4 2 0 1 1604 1782 2093 2526 -8196 4 2 0 1 1668 2472 1897 2618 -8197 4 2 0 1 240 472 186 2127 -8198 4 2 0 1 1728 1579 2226 2479 -8199 4 2 0 1 653 1726 2212 2638 -8200 4 2 0 1 1640 2548 2108 2828 -8201 4 2 0 1 543 662 2256 2569 -8202 4 2 0 1 406 2020 320 2399 -8203 4 2 0 1 1646 2264 1976 2434 -8204 4 2 0 1 1601 2480 2479 2839 -8205 4 2 0 1 1594 2176 1738 2319 -8206 4 2 0 1 582 480 441 2456 -8207 4 2 0 1 2155 2444 1790 2771 -8208 4 2 0 1 1713 2074 1953 2432 -8209 4 2 0 1 333 2207 218 2472 -8210 4 2 0 1 896 1754 941 2495 -8211 4 2 0 1 1463 1287 1994 2785 -8212 4 2 0 1 1837 2301 2076 2740 -8213 4 2 0 1 302 216 1823 2395 -8214 4 2 0 1 2024 2235 1782 2526 -8215 4 2 0 1 1920 1675 2334 2701 -8216 4 2 0 1 1761 2127 1875 2612 -8217 4 2 0 1 306 2030 182 2190 -8218 4 2 0 1 1682 1969 2038 2437 -8219 4 2 0 1 1999 2073 1793 2129 -8220 4 2 0 1 634 1841 603 2321 -8221 4 2 0 1 1632 2114 1870 2255 -8222 4 2 0 1 844 527 149 2338 -8223 4 2 0 1 1880 2242 1675 2750 -8224 4 2 0 1 1601 1971 2479 2480 -8225 4 2 0 1 1512 1194 1251 2835 -8226 4 2 0 1 1550 2293 2085 2418 -8227 4 2 0 1 1549 2273 1876 2617 -8228 4 2 0 1 1743 2659 2598 2787 -8229 4 2 0 1 1443 1742 1199 2435 -8230 4 2 0 1 1857 2310 2044 2521 -8231 4 2 0 1 1711 2384 2191 2594 -8232 4 2 0 1 874 1907 2462 2553 -8233 4 2 0 1 1732 2156 2123 2680 -8234 4 2 0 1 550 638 2260 2400 -8235 4 2 0 1 493 426 658 2610 -8236 4 2 0 1 1559 2731 1851 2758 -8237 4 2 0 1 620 1799 683 2367 -8238 4 2 0 1 1736 2071 1861 2698 -8239 4 2 0 1 1411 1232 1373 2012 -8240 4 2 0 1 485 393 508 2635 -8241 4 2 0 1 1555 2174 1908 2329 -8242 4 2 0 1 1317 1388 1221 2788 -8243 4 2 0 1 1610 1793 2160 2331 -8244 4 2 0 1 2402 1744 2460 2794 -8245 4 2 0 1 537 1995 580 2294 -8246 4 2 0 1 1498 923 959 2057 -8247 4 2 0 1 1290 719 1505 2722 -8248 4 2 0 1 431 386 416 2661 -8249 4 2 0 1 1551 2547 2074 2762 -8250 4 2 0 1 812 849 814 1936 -8251 4 2 0 1 1930 2170 1606 2535 -8252 4 2 0 1 592 1831 547 2560 -8253 4 2 0 1 1833 1958 2401 2750 -8254 4 2 0 1 460 1809 426 2610 -8255 4 2 0 1 876 1016 989 1907 -8256 4 2 0 1 1604 1916 2210 2753 -8257 4 2 0 1 267 1952 2209 2826 -8258 4 2 0 1 1179 1772 2275 2751 -8259 4 2 0 1 1946 2109 1643 2523 -8260 4 2 0 1 1418 2008 2322 2711 -8261 4 2 0 1 640 1869 652 2390 -8262 4 2 0 1 1310 2036 1299 2475 -8263 4 2 0 1 652 136 1972 2777 -8264 4 2 0 1 683 620 602 1799 -8265 4 2 0 1 1129 1164 1864 2584 -8266 4 2 0 1 1663 2342 2198 2724 -8267 4 2 0 1 1823 2554 1940 2735 -8268 4 2 0 1 382 223 344 2092 -8269 4 2 0 1 2083 2646 1756 2660 -8270 4 2 0 1 1002 925 1931 2588 -8271 4 2 0 1 1359 2294 1995 2467 -8272 4 2 0 1 1086 2594 1171 2603 -8273 4 2 0 1 2049 2495 1847 2561 -8274 4 2 0 1 1829 2424 1681 2556 -8275 4 2 0 1 1908 2174 1760 2329 -8276 4 2 0 1 2225 2626 1723 2818 -8277 4 2 0 1 878 967 2057 2241 -8278 4 2 0 1 1540 1899 2067 2417 -8279 4 2 0 1 412 1902 387 2641 -8280 4 2 0 1 314 1778 300 2815 -8281 4 2 0 1 1980 2113 1635 2838 -8282 4 2 0 1 475 385 258 2333 -8283 4 2 0 1 389 412 1918 2641 -8284 4 2 0 1 606 559 618 1786 -8285 4 2 0 1 1631 2748 2680 2795 -8286 4 2 0 1 1664 1721 2188 2537 -8287 4 2 0 1 1711 2594 2191 2710 -8288 4 2 0 1 1193 2322 1749 2615 -8289 4 2 0 1 1359 1198 1326 1995 -8290 4 2 0 1 1753 2237 1980 2590 -8291 4 2 0 1 1185 1954 1327 2104 -8292 4 2 0 1 365 2409 2153 2669 -8293 4 2 0 1 1794 2131 147 2497 -8294 4 2 0 1 1652 2175 2141 2790 -8295 4 2 0 1 2106 2436 1629 2501 -8296 4 2 0 1 2157 2222 1720 2624 -8297 4 2 0 1 1797 2146 1707 2278 -8298 4 2 0 1 820 1405 1294 2379 -8299 4 2 0 1 1726 2093 1604 2283 -8300 4 2 0 1 1271 1205 1281 1049 -8301 4 2 0 1 365 183 1859 2153 -8302 4 2 0 1 1402 1506 1474 2137 -8303 4 2 0 1 1624 2070 1797 2188 -8304 4 2 0 1 1672 2133 2420 2668 -8305 4 2 0 1 1916 2443 2093 2693 -8306 4 2 0 1 1202 1139 1994 2582 -8307 4 2 0 1 2048 2160 1999 2758 -8308 4 2 0 1 362 2049 1847 2464 -8309 4 2 0 1 1616 2291 2187 2648 -8310 4 2 0 1 1719 2148 1240 2767 -8311 4 2 0 1 603 1841 612 2761 -8312 4 2 0 1 1547 1836 2238 2282 -8313 4 2 0 1 1737 2468 358 2489 -8314 4 2 0 1 456 235 340 1850 -8315 4 2 0 1 1796 2372 2100 2837 -8316 4 2 0 1 1890 2204 1752 2451 -8317 4 2 0 1 1710 2232 1870 2603 -8318 4 2 0 1 1584 1882 2103 2575 -8319 4 2 0 1 1625 1888 2103 2806 -8320 4 2 0 1 1683 2011 2306 2572 -8321 4 2 0 1 1580 1785 2351 2718 -8322 4 2 0 1 1738 2048 1999 2758 -8323 4 2 0 1 464 257 741 2692 -8324 4 2 0 1 202 383 353 1816 -8325 4 2 0 1 252 446 272 2349 -8326 4 2 0 1 361 2005 205 2614 -8327 4 2 0 1 1772 1987 1636 2747 -8328 4 2 0 1 417 2090 396 2657 -8329 4 2 0 1 307 2353 1722 2691 -8330 4 2 0 1 471 453 1792 2445 -8331 4 2 0 1 1321 1351 2044 2453 -8332 4 2 0 1 1749 2205 1444 2557 -8333 4 2 0 1 1597 2306 1865 2308 -8334 4 2 0 1 1667 1931 2061 2588 -8335 4 2 0 1 897 945 2461 2523 -8336 4 2 0 1 1246 1276 1933 2205 -8337 4 2 0 1 1245 1774 2455 2737 -8338 4 2 0 1 1826 2186 1757 2307 -8339 4 2 0 1 903 2049 891 2494 -8340 4 2 0 1 1712 2102 2078 2460 -8341 4 2 0 1 1536 1866 2047 2427 -8342 4 2 0 1 940 2073 2129 2637 -8343 4 2 0 1 186 251 1761 2803 -8344 4 2 0 1 1864 1606 2170 2541 -8345 4 2 0 1 1727 2463 2042 2654 -8346 4 2 0 1 2085 2219 1843 2673 -8347 4 2 0 1 1026 1914 1097 2043 -8348 4 2 0 1 1796 2372 1650 2506 -8349 4 2 0 1 2104 2215 2206 2782 -8350 4 2 0 1 1654 2279 2591 2636 -8351 4 2 0 1 1129 1864 2170 2584 -8352 4 2 0 1 1646 2195 1901 2434 -8353 4 2 0 1 1546 1737 2134 2483 -8354 4 2 0 1 1500 1840 1261 2586 -8355 4 2 0 1 1637 1912 2281 2294 -8356 4 2 0 1 1324 1374 1340 2013 -8357 4 2 0 1 1431 1423 1359 2294 -8358 4 2 0 1 1715 1981 1940 2368 -8359 4 2 0 1 1601 1971 1943 2479 -8360 4 2 0 1 253 279 275 1990 -8361 4 2 0 1 325 405 356 2328 -8362 4 2 0 1 1792 2066 1649 2341 -8363 4 2 0 1 1931 2155 1790 2771 -8364 4 2 0 1 1663 2026 2342 2724 -8365 4 2 0 1 1531 2003 1770 2604 -8366 4 2 0 1 1976 2434 2264 2435 -8367 4 2 0 1 2333 2407 2090 2657 -8368 4 2 0 1 222 462 329 2020 -8369 4 2 0 1 1608 2266 1791 2476 -8370 4 2 0 1 2061 2689 1931 2771 -8371 4 2 0 1 926 858 2125 2248 -8372 4 2 0 1 1548 1805 2254 2708 -8373 4 2 0 1 1632 2273 2117 2617 -8374 4 2 0 1 1701 2116 2032 2311 -8375 4 2 0 1 1558 2145 2332 2502 -8376 4 2 0 1 1916 2093 1786 2753 -8377 4 2 0 1 1548 1744 2208 2708 -8378 4 2 0 1 1360 1437 1414 2104 -8379 4 2 0 1 548 2246 2069 2725 -8380 4 2 0 1 1540 2630 1899 2827 -8381 4 2 0 1 2013 2654 1706 2746 -8382 4 2 0 1 436 1977 433 2445 -8383 4 2 0 1 1123 1846 1975 2570 -8384 4 2 0 1 1925 2083 1848 2726 -8385 4 2 0 1 1897 2472 1831 2618 -8386 4 2 0 1 1538 1844 1962 2388 -8387 4 2 0 1 1758 2069 1828 2812 -8388 4 2 0 1 1686 1964 1823 2622 -8389 4 2 0 1 1199 1421 1248 1976 -8390 4 2 0 1 1650 2372 1796 2837 -8391 4 2 0 1 1567 2260 1948 2400 -8392 4 2 0 1 1528 2111 1966 2566 -8393 4 2 0 1 1615 2224 1898 2389 -8394 4 2 0 1 1548 1971 1741 2511 -8395 4 2 0 1 653 1726 682 2283 -8396 4 2 0 1 2010 1689 2496 2782 -8397 4 2 0 1 1720 2062 1848 2797 -8398 4 2 0 1 171 1993 1977 2567 -8399 4 2 0 1 1418 2322 1885 2711 -8400 4 2 0 1 1570 1772 1987 2318 -8401 4 2 0 1 582 2456 536 2658 -8402 4 2 0 1 1578 1950 1916 2802 -8403 4 2 0 1 1468 2026 2686 2724 -8404 4 2 0 1 448 179 1875 2086 -8405 4 2 0 1 1416 1384 1455 1820 -8406 4 2 0 1 1654 1748 2254 2636 -8407 4 2 0 1 1137 2202 1087 2570 -8408 4 2 0 1 1447 1460 579 1984 -8409 4 2 0 1 1888 2019 1584 2216 -8410 4 2 0 1 2479 2480 1971 2839 -8411 4 2 0 1 1560 2290 1777 2707 -8412 4 2 0 1 1725 2207 431 2661 -8413 4 2 0 1 1547 2434 1742 2500 -8414 4 2 0 1 1818 2396 1866 2831 -8415 4 2 0 1 1605 2262 1823 2395 -8416 4 2 0 1 2039 2505 2063 2646 -8417 4 2 0 1 256 419 2185 2200 -8418 4 2 0 1 1150 2384 1775 2565 -8419 4 2 0 1 2051 2822 1251 2835 -8420 4 2 0 1 1601 1941 2085 2418 -8421 4 2 0 1 2014 2079 1693 2329 -8422 4 2 0 1 1511 1510 1473 2241 -8423 4 2 0 1 1738 2176 1594 2483 -8424 4 2 0 1 2195 2586 2303 2716 -8425 4 2 0 1 1569 1918 2176 2517 -8426 4 2 0 1 1694 2189 2219 2680 -8427 4 2 0 1 1871 2524 1540 2698 -8428 4 2 0 1 1705 2387 1255 2620 -8429 4 2 0 1 2295 2527 1683 2602 -8430 4 2 0 1 1932 2449 2270 2838 -8431 4 2 0 1 1882 2604 2147 2735 -8432 4 2 0 1 1538 2078 1844 2703 -8433 4 2 0 1 1594 2176 1918 2517 -8434 4 2 0 1 1585 2242 1801 2597 -8435 4 2 0 1 691 804 825 2288 -8436 4 2 0 1 1608 1986 1892 1998 -8437 4 2 0 1 1686 1823 2516 2622 -8438 4 2 0 1 1818 2651 2295 2813 -8439 4 2 0 1 1428 1924 1456 2358 -8440 4 2 0 1 581 534 577 1990 -8441 4 2 0 1 1649 1792 2341 2762 -8442 4 2 0 1 372 335 2185 2200 -8443 4 2 0 1 1874 1671 2230 2524 -8444 4 2 0 1 1528 2111 2048 2466 -8445 4 2 0 1 1793 2523 2461 2637 -8446 4 2 0 1 1297 2044 1214 2512 -8447 4 2 0 1 1463 1292 1202 1994 -8448 4 2 0 1 1083 1127 1039 2056 -8449 4 2 0 1 778 748 1933 2690 -8450 4 2 0 1 530 1973 1868 2180 -8451 4 2 0 1 1138 1080 272 2713 -8452 4 2 0 1 1268 1708 1266 2730 -8453 4 2 0 1 677 600 647 1825 -8454 4 2 0 1 213 428 437 1897 -8455 4 2 0 1 481 428 242 2560 -8456 4 2 0 1 1911 2428 1812 2650 -8457 4 2 0 1 545 2260 675 2569 -8458 4 2 0 1 795 755 850 2267 -8459 4 2 0 1 1889 2081 1628 2233 -8460 4 2 0 1 1674 2457 1905 2705 -8461 4 2 0 1 1672 2001 2102 2285 -8462 4 2 0 1 1030 1036 1153 1870 -8463 4 2 0 1 531 594 649 1845 -8464 4 2 0 1 1542 2093 1726 2360 -8465 4 2 0 1 1727 2463 1866 2573 -8466 4 2 0 1 1542 1782 2093 2693 -8467 4 2 0 1 2025 2646 1575 2660 -8468 4 2 0 1 1602 2038 1969 2437 -8469 4 2 0 1 1982 2211 1659 2446 -8470 4 2 0 1 1602 2437 1969 2807 -8471 4 2 0 1 382 2092 344 2448 -8472 4 2 0 1 984 2129 2365 2589 -8473 4 2 0 1 772 2041 785 2375 -8474 4 2 0 1 1603 1847 2049 2464 -8475 4 2 0 1 1785 1621 2203 2304 -8476 4 2 0 1 1609 2167 2142 2356 -8477 4 2 0 1 1618 1973 1799 2367 -8478 4 2 0 1 543 2256 1831 2569 -8479 4 2 0 1 1685 2034 2690 2718 -8480 4 2 0 1 1142 2049 1927 2394 -8481 4 2 0 1 612 1815 617 2344 -8482 4 2 0 1 1551 1811 2163 2532 -8483 4 2 0 1 1591 1939 2293 2607 -8484 4 2 0 1 1698 2022 2082 2181 -8485 4 2 0 1 2102 2285 2001 2703 -8486 4 2 0 1 770 2161 1860 2638 -8487 4 2 0 1 1826 1771 2055 2784 -8488 4 2 0 1 612 617 1815 2236 -8489 4 2 0 1 436 171 433 1977 -8490 4 2 0 1 1748 1624 2158 2287 -8491 4 2 0 1 1993 2316 777 2498 -8492 4 2 0 1 816 695 729 1860 -8493 4 2 0 1 1060 1052 1022 1927 -8494 4 2 0 1 1096 2424 2405 2642 -8495 4 2 0 1 1154 1930 1035 2713 -8496 4 2 0 1 1132 500 286 517 -8497 4 2 0 1 1567 1899 2481 2580 -8498 4 2 0 1 874 1907 870 2462 -8499 4 2 0 1 671 571 566 2197 -8500 4 2 0 1 1788 1924 1627 2475 -8501 4 2 0 1 1755 2076 1837 2511 -8502 4 2 0 1 1658 2025 2336 2622 -8503 4 2 0 1 1584 2083 1756 2315 -8504 4 2 0 1 2151 2216 2083 2549 -8505 4 2 0 1 2258 2343 1595 2652 -8506 4 2 0 1 1910 2172 1603 2189 -8507 4 2 0 1 1644 1897 2059 2756 -8508 4 2 0 1 1569 1966 2176 2423 -8509 4 2 0 1 230 509 444 1877 -8510 4 2 0 1 1719 2148 1633 2243 -8511 4 2 0 1 329 462 419 1736 -8512 4 2 0 1 2109 2115 842 2186 -8513 4 2 0 1 1385 1909 1419 2721 -8514 4 2 0 1 224 2084 324 2190 -8515 4 2 0 1 2219 2292 1843 2673 -8516 4 2 0 1 1589 2708 2208 2794 -8517 4 2 0 1 1821 1627 2371 2467 -8518 4 2 0 1 301 1997 2002 2741 -8519 4 2 0 1 1691 2015 1988 2300 -8520 4 2 0 1 1466 1083 1181 1115 -8521 4 2 0 1 1620 1893 2199 2201 -8522 4 2 0 1 749 1993 777 2498 -8523 4 2 0 1 1541 1865 2065 2306 -8524 4 2 0 1 1620 2340 2396 2599 -8525 4 2 0 1 1779 2150 1532 2258 -8526 4 2 0 1 1670 2173 1940 2478 -8527 4 2 0 1 372 1879 335 2200 -8528 4 2 0 1 1824 1651 2455 2493 -8529 4 2 0 1 1113 2394 1819 2709 -8530 4 2 0 1 1552 2779 1903 2799 -8531 4 2 0 1 593 2069 1766 2663 -8532 4 2 0 1 1619 1859 2409 2669 -8533 4 2 0 1 744 716 2041 2379 -8534 4 2 0 1 1749 2265 2557 2718 -8535 4 2 0 1 511 505 1849 2692 -8536 4 2 0 1 1565 1892 1986 1998 -8537 4 2 0 1 179 2097 2086 2821 -8538 4 2 0 1 1010 981 163 2734 -8539 4 2 0 1 1340 2013 1374 2579 -8540 4 2 0 1 444 2153 509 2409 -8541 4 2 0 1 1620 2340 2337 2396 -8542 4 2 0 1 571 2197 671 2390 -8543 4 2 0 1 1570 2291 2015 2540 -8544 4 2 0 1 1838 2071 1563 2391 -8545 4 2 0 1 175 1792 453 2404 -8546 4 2 0 1 1544 1827 2188 2537 -8547 4 2 0 1 1870 2232 1710 2710 -8548 4 2 0 1 1873 2221 1754 2259 -8549 4 2 0 1 849 1936 764 2045 -8550 4 2 0 1 1591 2219 2085 2293 -8551 4 2 0 1 1385 2148 1909 2721 -8552 4 2 0 1 1733 2084 311 2190 -8553 4 2 0 1 1005 868 928 2591 -8554 4 2 0 1 1665 1792 2163 2539 -8555 4 2 0 1 818 705 709 1765 -8556 4 2 0 1 2047 2167 1568 2573 -8557 4 2 0 1 372 2185 1879 2200 -8558 4 2 0 1 1618 2069 2206 2496 -8559 4 2 0 1 779 1826 840 2055 -8560 4 2 0 1 163 981 162 2035 -8561 4 2 0 1 966 922 2542 2695 -8562 4 2 0 1 1689 1956 1783 2652 -8563 4 2 0 1 940 2129 2461 2637 -8564 4 2 0 1 1335 1192 1341 2077 -8565 4 2 0 1 624 555 573 1912 -8566 4 2 0 1 1778 2397 1905 2815 -8567 4 2 0 1 1953 2074 1581 2432 -8568 4 2 0 1 1568 2440 2252 2820 -8569 4 2 0 1 1644 2059 1838 2756 -8570 4 2 0 1 706 750 746 1769 -8571 4 2 0 1 1465 1803 1415 2499 -8572 4 2 0 1 1654 1751 2279 2636 -8573 4 2 0 1 1575 2025 2660 2817 -8574 4 2 0 1 1738 1594 2319 2483 -8575 4 2 0 1 786 1849 720 2692 -8576 4 2 0 1 1516 1220 2137 2301 -8577 4 2 0 1 1833 1659 2430 2682 -8578 4 2 0 1 1682 2168 2031 2437 -8579 4 2 0 1 1869 2179 671 2777 -8580 4 2 0 1 363 354 178 2489 -8581 4 2 0 1 1179 2007 1404 2767 -8582 4 2 0 1 1817 2248 2125 2778 -8583 4 2 0 1 1695 1896 2298 2519 -8584 4 2 0 1 471 2539 1792 2674 -8585 4 2 0 1 261 2456 480 2658 -8586 4 2 0 1 1956 2459 1630 2759 -8587 4 2 0 1 601 2321 1841 2761 -8588 4 2 0 1 1974 2322 1441 2615 -8589 4 2 0 1 2258 2348 1783 2652 -8590 4 2 0 1 782 788 1881 2120 -8591 4 2 0 1 1900 2364 1835 2593 -8592 4 2 0 1 1644 1838 2071 2756 -8593 4 2 0 1 1666 2238 1836 2505 -8594 4 2 0 1 1916 1950 1532 2154 -8595 4 2 0 1 378 362 1847 2464 -8596 4 2 0 1 896 2259 1754 2561 -8597 4 2 0 1 1757 1582 1957 2403 -8598 4 2 0 1 1579 2420 2094 2740 -8599 4 2 0 1 1982 2430 1659 2727 -8600 4 2 0 1 1701 2071 1838 2230 -8601 4 2 0 1 2078 2102 1678 2703 -8602 4 2 0 1 1738 2061 1999 2486 -8603 4 2 0 1 353 1816 383 2525 -8604 4 2 0 1 1748 2162 2382 2738 -8605 4 2 0 1 1760 2012 1642 2263 -8606 4 2 0 1 1635 1852 1962 2460 -8607 4 2 0 1 585 620 587 1937 -8608 4 2 0 1 1671 1874 2230 2427 -8609 4 2 0 1 659 2132 1252 2469 -8610 4 2 0 1 369 2317 1895 2366 -8611 4 2 0 1 2029 2222 1896 2624 -8612 4 2 0 1 1591 2293 2085 2607 -8613 4 2 0 1 315 2123 317 2156 -8614 4 2 0 1 212 2123 363 2489 -8615 4 2 0 1 1654 2096 1751 2636 -8616 4 2 0 1 1882 1605 2315 2735 -8617 4 2 0 1 1318 1374 2013 2042 -8618 4 2 0 1 1489 2387 2094 2620 -8619 4 2 0 1 547 2046 588 2560 -8620 4 2 0 1 1158 482 488 1927 -8621 4 2 0 1 1511 1872 1510 2241 -8622 4 2 0 1 1579 2420 2740 2781 -8623 4 2 0 1 1817 2248 1599 2365 -8624 4 2 0 1 462 256 419 2185 -8625 4 2 0 1 1621 2089 1811 2816 -8626 4 2 0 1 2046 2256 619 2321 -8627 4 2 0 1 1767 2159 1969 2407 -8628 4 2 0 1 852 728 840 2055 -8629 4 2 0 1 1607 2026 1968 2198 -8630 4 2 0 1 1577 1848 1925 2166 -8631 4 2 0 1 1343 2324 1329 2737 -8632 4 2 0 1 1926 2102 1589 2302 -8633 4 2 0 1 1975 2414 1763 2544 -8634 4 2 0 1 555 2281 624 2294 -8635 4 2 0 1 1785 1580 2351 2665 -8636 4 2 0 1 1568 1762 1963 2340 -8637 4 2 0 1 1706 2324 2036 2655 -8638 4 2 0 1 1958 2447 2239 2837 -8639 4 2 0 1 616 1912 2281 2283 -8640 4 2 0 1 2141 2175 1734 2790 -8641 4 2 0 1 558 1476 1447 1937 -8642 4 2 0 1 877 1931 871 2155 -8643 4 2 0 1 1556 1852 2078 2231 -8644 4 2 0 1 1321 1245 1351 2453 -8645 4 2 0 1 1684 2296 1928 2675 -8646 4 2 0 1 1622 1776 2041 2736 -8647 4 2 0 1 1640 1883 2244 2548 -8648 4 2 0 1 2115 2461 1793 2523 -8649 4 2 0 1 1593 2086 2107 2612 -8650 4 2 0 1 2099 1769 2513 2631 -8651 4 2 0 1 1599 2129 1999 2160 -8652 4 2 0 1 1612 1926 2016 2429 -8653 4 2 0 1 1757 1610 2109 2186 -8654 4 2 0 1 1597 2065 1865 2306 -8655 4 2 0 1 1528 1966 2121 2566 -8656 4 2 0 1 1899 2630 2122 2827 -8657 4 2 0 1 1215 2467 1323 2484 -8658 4 2 0 1 652 1972 136 2410 -8659 4 2 0 1 805 717 769 2307 -8660 4 2 0 1 1269 2135 1526 2822 -8661 4 2 0 1 1604 2281 1912 2283 -8662 4 2 0 1 1866 2463 1727 2654 -8663 4 2 0 1 139 2264 138 2419 -8664 4 2 0 1 1644 2380 2286 2391 -8665 4 2 0 1 852 840 828 2186 -8666 4 2 0 1 1463 1994 1287 2178 -8667 4 2 0 1 1291 2462 1464 2775 -8668 4 2 0 1 579 1984 1398 2419 -8669 4 2 0 1 1819 2406 1681 2424 -8670 4 2 0 1 467 2445 246 2498 -8671 4 2 0 1 1644 1967 1965 2391 -8672 4 2 0 1 1534 2292 2219 2673 -8673 4 2 0 1 1682 2364 2593 2807 -8674 4 2 0 1 313 2298 201 2795 -8675 4 2 0 1 1916 1650 2443 2693 -8676 4 2 0 1 1589 2105 1731 2558 -8677 4 2 0 1 1801 2597 1996 2744 -8678 4 2 0 1 1750 1597 2306 2688 -8679 4 2 0 1 2091 2167 1742 2507 -8680 4 2 0 1 1777 2290 1988 2806 -8681 4 2 0 1 1566 1731 2105 2558 -8682 4 2 0 1 1898 1812 2428 2650 -8683 4 2 0 1 1708 2232 2022 2648 -8684 4 2 0 1 1797 2070 1624 2137 -8685 4 2 0 1 1612 2370 2000 2429 -8686 4 2 0 1 220 354 2123 2683 -8687 4 2 0 1 1300 1331 2301 2740 -8688 4 2 0 1 1752 1621 1957 2451 -8689 4 2 0 1 1857 2012 1333 2325 -8690 4 2 0 1 603 1841 529 2169 -8691 4 2 0 1 1801 2242 2005 2699 -8692 4 2 0 1 1724 2160 2152 2385 -8693 4 2 0 1 1582 2149 1811 2163 -8694 4 2 0 1 1638 1759 2310 2515 -8695 4 2 0 1 1102 2054 1029 2202 -8696 4 2 0 1 1145 1115 1139 1994 -8697 4 2 0 1 870 1907 874 2553 -8698 4 2 0 1 1647 1814 2480 2673 -8699 4 2 0 1 1782 1574 2526 2538 -8700 4 2 0 1 1255 1417 1189 2620 -8701 4 2 0 1 1532 1782 2210 2538 -8702 4 2 0 1 1479 1769 1467 2780 -8703 4 2 0 1 1698 2082 2022 2291 -8704 4 2 0 1 1821 1921 1637 2371 -8705 4 2 0 1 563 1955 628 2456 -8706 4 2 0 1 1914 2043 1576 2346 -8707 4 2 0 1 1144 1093 1041 2458 -8708 4 2 0 1 1308 2036 2324 2655 -8709 4 2 0 1 1243 1384 1416 2763 -8710 4 2 0 1 957 898 164 2070 -8711 4 2 0 1 1622 2329 1776 2736 -8712 4 2 0 1 1570 1987 1772 2747 -8713 4 2 0 1 385 2333 475 2407 -8714 4 2 0 1 1851 2431 2237 2633 -8715 4 2 0 1 849 814 1936 2045 -8716 4 2 0 1 822 742 719 2722 -8717 4 2 0 1 1714 2534 2152 2592 -8718 4 2 0 1 1577 1925 1848 2726 -8719 4 2 0 1 1602 2164 1879 2632 -8720 4 2 0 1 2085 2293 1768 2607 -8721 4 2 0 1 1808 2033 1764 2392 -8722 4 2 0 1 1934 2283 1786 2536 -8723 4 2 0 1 1792 1996 1649 2674 -8724 4 2 0 1 430 2127 1737 2679 -8725 4 2 0 1 1559 1999 2160 2758 -8726 4 2 0 1 290 199 316 2448 -8727 4 2 0 1 230 2567 1877 2685 -8728 4 2 0 1 1902 2237 1619 2669 -8729 4 2 0 1 1749 2265 2205 2557 -8730 4 2 0 1 794 754 851 1933 -8731 4 2 0 1 820 1294 716 2379 -8732 4 2 0 1 1560 1893 2199 2245 -8733 4 2 0 1 1589 2208 2102 2794 -8734 4 2 0 1 1760 2358 1924 2441 -8735 4 2 0 1 1798 2094 1352 2387 -8736 4 2 0 1 1121 1175 2138 2191 -8737 4 2 0 1 1866 2654 1689 2743 -8738 4 2 0 1 612 603 560 2236 -8739 4 2 0 1 1905 2397 1659 2727 -8740 4 2 0 1 1650 2372 2100 2693 -8741 4 2 0 1 1654 2591 1748 2636 -8742 4 2 0 1 1773 1666 2386 2440 -8743 4 2 0 1 754 851 1933 2596 -8744 4 2 0 1 1905 2124 259 2397 -8745 4 2 0 1 1555 2014 2329 2736 -8746 4 2 0 1 1300 1837 1469 2740 -8747 4 2 0 1 2121 2460 1744 2794 -8748 4 2 0 1 2409 1902 2641 2826 -8749 4 2 0 1 1469 2301 2146 2620 -8750 4 2 0 1 1618 2069 2246 2725 -8751 4 2 0 1 755 795 709 2144 -8752 4 2 0 1 1371 1373 1234 1760 -8753 4 2 0 1 1859 2647 2005 2699 -8754 4 2 0 1 1703 1851 2731 2758 -8755 4 2 0 1 1318 1217 1374 2042 -8756 4 2 0 1 1559 1999 1738 2545 -8757 4 2 0 1 1764 1974 2615 2754 -8758 4 2 0 1 1281 2303 1787 2339 -8759 4 2 0 1 2118 2354 1641 2547 -8760 4 2 0 1 1741 2226 1837 2781 -8761 4 2 0 1 931 1832 962 2129 -8762 4 2 0 1 1651 1824 2199 2257 -8763 4 2 0 1 1969 2159 1590 2407 -8764 4 2 0 1 1718 2017 1816 2502 -8765 4 2 0 1 1049 1787 1099 2804 -8766 4 2 0 1 298 348 1982 2397 -8767 4 2 0 1 1594 2176 1919 2483 -8768 4 2 0 1 1731 1628 2374 2499 -8769 4 2 0 1 2052 2084 1634 2376 -8770 4 2 0 1 1570 2007 1798 2747 -8771 4 2 0 1 1222 1798 1439 2763 -8772 4 2 0 1 1616 2552 2022 2648 -8773 4 2 0 1 1621 1752 2204 2451 -8774 4 2 0 1 171 505 464 1993 -8775 4 2 0 1 1707 2625 2619 2833 -8776 4 2 0 1 1947 2189 1631 2357 -8777 4 2 0 1 1259 1195 1420 1808 -8778 4 2 0 1 1645 2386 2063 2600 -8779 4 2 0 1 1257 1200 1289 651 -8780 4 2 0 1 1818 2813 2295 2820 -8781 4 2 0 1 1176 2594 1870 2603 -8782 4 2 0 1 1010 164 898 2070 -8783 4 2 0 1 1995 2131 1491 2484 -8784 4 2 0 1 614 541 599 1948 -8785 4 2 0 1 1720 2157 519 2355 -8786 4 2 0 1 198 2277 140 2456 -8787 4 2 0 1 1879 2088 1588 2164 -8788 4 2 0 1 341 2559 1978 2601 -8789 4 2 0 1 539 2046 601 2761 -8790 4 2 0 1 1649 2332 2027 2762 -8791 4 2 0 1 1917 1996 1665 2671 -8792 4 2 0 1 2226 2627 1951 2833 -8793 4 2 0 1 1582 1849 2403 2426 -8794 4 2 0 1 1582 1757 2089 2426 -8795 4 2 0 1 1958 1796 2447 2837 -8796 4 2 0 1 1499 2131 1428 2484 -8797 4 2 0 1 413 353 234 2066 -8798 4 2 0 1 1597 1830 2471 2506 -8799 4 2 0 1 1626 1933 2205 2265 -8800 4 2 0 1 1651 1938 1922 2664 -8801 4 2 0 1 1876 1623 2181 2617 -8802 4 2 0 1 1558 2332 2027 2502 -8803 4 2 0 1 1754 2495 896 2561 -8804 4 2 0 1 863 894 1781 2184 -8805 4 2 0 1 1637 2132 1758 2194 -8806 4 2 0 1 1767 1969 2333 2407 -8807 4 2 0 1 1311 1924 1223 2475 -8808 4 2 0 1 1714 2592 2152 2834 -8809 4 2 0 1 1528 2121 2111 2566 -8810 4 2 0 1 1748 2279 2162 2636 -8811 4 2 0 1 1719 1623 2551 2629 -8812 4 2 0 1 1643 2331 2109 2426 -8813 4 2 0 1 1868 2321 1653 2766 -8814 4 2 0 1 995 904 893 2137 -8815 4 2 0 1 804 753 2267 2288 -8816 4 2 0 1 1900 2168 1682 2296 -8817 4 2 0 1 1837 2076 1755 2740 -8818 4 2 0 1 501 263 740 2217 -8819 4 2 0 1 1883 2187 2548 2648 -8820 4 2 0 1 1588 1871 2067 2632 -8821 4 2 0 1 1689 2220 2050 2348 -8822 4 2 0 1 1933 1685 2690 2718 -8823 4 2 0 1 1611 1802 2031 2271 -8824 4 2 0 1 1816 2017 1718 2635 -8825 4 2 0 1 330 209 402 2328 -8826 4 2 0 1 2407 2657 327 2741 -8827 4 2 0 1 2229 2232 1661 2563 -8828 4 2 0 1 1923 2024 1830 2276 -8829 4 2 0 1 1639 2206 1954 2782 -8830 4 2 0 1 1277 2303 1976 2442 -8831 4 2 0 1 413 187 347 2635 -8832 4 2 0 1 1948 1567 2433 2706 -8833 4 2 0 1 447 209 335 2200 -8834 4 2 0 1 1554 1771 2361 2742 -8835 4 2 0 1 1534 1843 2292 2673 -8836 4 2 0 1 870 1907 993 2462 -8837 4 2 0 1 2534 2592 1714 2834 -8838 4 2 0 1 230 509 1877 2153 -8839 4 2 0 1 252 272 418 1930 -8840 4 2 0 1 1123 1087 1846 2570 -8841 4 2 0 1 1589 2133 1805 2531 -8842 4 2 0 1 1290 822 719 2722 -8843 4 2 0 1 746 1769 750 2631 -8844 4 2 0 1 1548 2254 1748 2636 -8845 4 2 0 1 1540 1899 2417 2827 -8846 4 2 0 1 1082 1863 1126 2570 -8847 4 2 0 1 1956 2139 1702 2630 -8848 4 2 0 1 1560 2290 1988 2413 -8849 4 2 0 1 454 2445 433 2498 -8850 4 2 0 1 671 685 1869 2777 -8851 4 2 0 1 467 2144 2445 2498 -8852 4 2 0 1 276 970 1961 2107 -8853 4 2 0 1 1617 1960 1815 2595 -8854 4 2 0 1 2514 2542 879 2576 -8855 4 2 0 1 2072 2470 1987 2747 -8856 4 2 0 1 1213 1926 1305 2667 -8857 4 2 0 1 855 825 813 2316 -8858 4 2 0 1 540 1825 600 2281 -8859 4 2 0 1 1588 1891 2343 2430 -8860 4 2 0 1 1771 2644 2165 2742 -8861 4 2 0 1 556 2169 656 2390 -8862 4 2 0 1 626 1725 684 2359 -8863 4 2 0 1 1705 2094 1837 2226 -8864 4 2 0 1 706 704 806 2099 -8865 4 2 0 1 1786 2283 1934 2753 -8866 4 2 0 1 2079 2372 2100 2577 -8867 4 2 0 1 1554 2361 2177 2742 -8868 4 2 0 1 1795 2058 1557 2228 -8869 4 2 0 1 1669 1791 2504 2796 -8870 4 2 0 1 1526 1269 1494 2135 -8871 4 2 0 1 1570 2007 1772 2318 -8872 4 2 0 1 1644 2286 1967 2391 -8873 4 2 0 1 418 181 2559 2713 -8874 4 2 0 1 1566 1803 1907 2553 -8875 4 2 0 1 1063 438 1156 2422 -8876 4 2 0 1 186 1761 2127 2327 -8877 4 2 0 1 1947 2268 1829 2357 -8878 4 2 0 1 1891 1532 1950 2154 -8879 4 2 0 1 1795 1577 2621 2726 -8880 4 2 0 1 1604 2093 1916 2753 -8881 4 2 0 1 742 1810 774 2722 -8882 4 2 0 1 1633 1719 2243 2318 -8883 4 2 0 1 1285 1281 1206 2586 -8884 4 2 0 1 1406 1924 1428 2358 -8885 4 2 0 1 2076 2301 1837 2511 -8886 4 2 0 1 1849 1582 1993 2567 -8887 4 2 0 1 1353 1885 1418 2322 -8888 4 2 0 1 1810 1933 2690 2718 -8889 4 2 0 1 1702 2139 1956 2546 -8890 4 2 0 1 1621 1811 2204 2816 -8891 4 2 0 1 1551 2074 1953 2532 -8892 4 2 0 1 1487 1283 2419 2435 -8893 4 2 0 1 1275 1749 1444 2557 -8894 4 2 0 1 1550 2418 1941 2623 -8895 4 2 0 1 1590 1802 2270 2528 -8896 4 2 0 1 647 2192 567 2786 -8897 4 2 0 1 1588 1879 2164 2632 -8898 4 2 0 1 1676 2614 2005 2669 -8899 4 2 0 1 1431 561 1423 2294 -8900 4 2 0 1 1768 2293 2113 2517 -8901 4 2 0 1 1532 2343 2258 2546 -8902 4 2 0 1 2089 2203 1621 2304 -8903 4 2 0 1 1832 1599 2248 2365 -8904 4 2 0 1 958 954 278 2327 -8905 4 2 0 1 1578 1905 2124 2457 -8906 4 2 0 1 1310 1788 1223 2441 -8907 4 2 0 1 2295 2813 1717 2820 -8908 4 2 0 1 1826 2055 2529 2784 -8909 4 2 0 1 1531 1940 1981 2368 -8910 4 2 0 1 1827 2335 2182 2800 -8911 4 2 0 1 690 2028 814 2045 -8912 4 2 0 1 809 848 1855 2378 -8913 4 2 0 1 1099 1787 2414 2804 -8914 4 2 0 1 1561 2011 2572 2746 -8915 4 2 0 1 2032 2252 1928 2651 -8916 4 2 0 1 1574 2050 1750 2454 -8917 4 2 0 1 410 1965 1967 2752 -8918 4 2 0 1 1763 2119 2114 2255 -8919 4 2 0 1 2270 2449 1657 2838 -8920 4 2 0 1 1299 2036 1821 2475 -8921 4 2 0 1 1444 1193 1389 2008 -8922 4 2 0 1 291 200 2298 2741 -8923 4 2 0 1 1601 2085 2480 2673 -8924 4 2 0 1 1613 2466 1851 2487 -8925 4 2 0 1 1126 2202 1863 2564 -8926 4 2 0 1 1126 2202 1137 2570 -8927 4 2 0 1 1436 979 2057 2462 -8928 4 2 0 1 1570 1987 1807 2318 -8929 4 2 0 1 1772 2550 1893 2751 -8930 4 2 0 1 1652 2009 2197 2250 -8931 4 2 0 1 204 2005 373 2647 -8932 4 2 0 1 1675 1880 2266 2701 -8933 4 2 0 1 1648 2079 2100 2577 -8934 4 2 0 1 1348 2076 1339 2383 -8935 4 2 0 1 787 774 2529 2722 -8936 4 2 0 1 1940 2554 1670 2735 -8937 4 2 0 1 1753 2373 1980 2633 -8938 4 2 0 1 237 520 2409 2826 -8939 4 2 0 1 1620 2599 1804 2707 -8940 4 2 0 1 1468 1518 1984 2686 -8941 4 2 0 1 1660 2238 1901 2505 -8942 4 2 0 1 1644 2297 1967 2380 -8943 4 2 0 1 221 359 1947 2683 -8944 4 2 0 1 1649 1816 2027 2332 -8945 4 2 0 1 1317 2018 1388 2788 -8946 4 2 0 1 413 2106 187 2635 -8947 4 2 0 1 377 2066 234 2404 -8948 4 2 0 1 1307 2057 1498 2241 -8949 4 2 0 1 545 594 675 2260 -8950 4 2 0 1 332 200 2222 2298 -8951 4 2 0 1 1289 1828 651 2812 -8952 4 2 0 1 1734 2175 1836 2790 -8953 4 2 0 1 1624 2137 2070 2287 -8954 4 2 0 1 1693 2213 1796 2577 -8955 4 2 0 1 2027 2332 1747 2762 -8956 4 2 0 1 787 2135 699 2722 -8957 4 2 0 1 1616 2244 2540 2627 -8958 4 2 0 1 1787 2303 1281 2586 -8959 4 2 0 1 691 1890 803 2288 -8960 4 2 0 1 485 2017 393 2635 -8961 4 2 0 1 839 746 838 2379 -8962 4 2 0 1 1555 2659 1858 2787 -8963 4 2 0 1 2000 2037 1613 2429 -8964 4 2 0 1 1822 2253 765 2555 -8965 4 2 0 1 2036 1679 2454 2712 -8966 4 2 0 1 1726 2235 1912 2283 -8967 4 2 0 1 914 867 936 1961 -8968 4 2 0 1 332 2222 1896 2298 -8969 4 2 0 1 431 416 451 2610 -8970 4 2 0 1 1530 1958 1796 2447 -8971 4 2 0 1 1951 2226 1544 2627 -8972 4 2 0 1 1789 1557 2058 2228 -8973 4 2 0 1 1583 1981 1940 2789 -8974 4 2 0 1 1639 2104 1954 2206 -8975 4 2 0 1 1948 1845 2260 2706 -8976 4 2 0 1 1729 2477 1946 2637 -8977 4 2 0 1 2319 2423 1738 2545 -8978 4 2 0 1 1785 2265 1685 2634 -8979 4 2 0 1 246 2445 454 2498 -8980 4 2 0 1 2100 2443 1650 2693 -8981 4 2 0 1 1682 2593 1969 2807 -8982 4 2 0 1 1679 2011 1834 2746 -8983 4 2 0 1 1033 1126 1863 2564 -8984 4 2 0 1 1546 1919 1898 2650 -8985 4 2 0 1 1893 2245 1560 2550 -8986 4 2 0 1 1128 2140 1173 2274 -8987 4 2 0 1 746 2379 1769 2631 -8988 4 2 0 1 1004 1832 929 2280 -8989 4 2 0 1 1870 2232 1661 2603 -8990 4 2 0 1 1885 2322 2008 2711 -8991 4 2 0 1 1574 1921 1821 2811 -8992 4 2 0 1 1855 2028 1713 2585 -8993 4 2 0 1 1544 2182 2335 2800 -8994 4 2 0 1 1955 2277 141 2732 -8995 4 2 0 1 1693 2079 2014 2577 -8996 4 2 0 1 1554 2616 2152 2834 -8997 4 2 0 1 560 603 529 2169 -8998 4 2 0 1 1913 1930 1606 2559 -8999 4 2 0 1 1765 1629 2068 2341 -9000 4 2 0 1 1350 2379 838 2631 -9001 4 2 0 1 1554 2152 2592 2834 -9002 4 2 0 1 301 291 1997 2741 -9003 4 2 0 1 1532 1891 1950 2430 -9004 4 2 0 1 1512 2177 1194 2822 -9005 4 2 0 1 1817 2553 1566 2778 -9006 4 2 0 1 1653 2314 2122 2723 -9007 4 2 0 1 1645 1876 2039 2509 -9008 4 2 0 1 1921 2210 1783 2459 -9009 4 2 0 1 1782 2235 2093 2526 -9010 4 2 0 1 1559 1716 2423 2490 -9011 4 2 0 1 1857 2044 1214 2453 -9012 4 2 0 1 1692 1839 2665 2754 -9013 4 2 0 1 2066 2068 1629 2341 -9014 4 2 0 1 1584 1848 2083 2315 -9015 4 2 0 1 1529 2187 2244 2540 -9016 4 2 0 1 2405 2424 1681 2642 -9017 4 2 0 1 648 132 654 2830 -9018 4 2 0 1 1756 2646 2025 2660 -9019 4 2 0 1 1764 2615 1974 2835 -9020 4 2 0 1 1476 1460 1447 1937 -9021 4 2 0 1 1841 1653 2314 2321 -9022 4 2 0 1 462 419 1736 2185 -9023 4 2 0 1 791 151 2109 2628 -9024 4 2 0 1 1619 1877 1800 2409 -9025 4 2 0 1 619 2046 547 2256 -9026 4 2 0 1 1659 2211 1778 2653 -9027 4 2 0 1 1745 2238 1617 2282 -9028 4 2 0 1 488 476 1069 2424 -9029 4 2 0 1 1548 2224 1812 2708 -9030 4 2 0 1 1728 2227 1827 2335 -9031 4 2 0 1 1719 2609 2289 2629 -9032 4 2 0 1 1679 1774 2453 2737 -9033 4 2 0 1 1161 2594 2384 2769 -9034 4 2 0 1 1793 2160 2129 2461 -9035 4 2 0 1 1738 1919 2176 2483 -9036 4 2 0 1 677 600 1825 2281 -9037 4 2 0 1 1652 2197 2009 2390 -9038 4 2 0 1 1951 1705 2627 2755 -9039 4 2 0 1 1743 1530 2213 2354 -9040 4 2 0 1 209 1982 402 2328 -9041 4 2 0 1 1832 1593 1999 2073 -9042 4 2 0 1 1933 2171 1626 2205 -9043 4 2 0 1 543 549 662 2569 -9044 4 2 0 1 1725 2359 2481 2569 -9045 4 2 0 1 1616 2627 1886 2755 -9046 4 2 0 1 1267 1266 1268 1708 -9047 4 2 0 1 1862 2089 1535 2439 -9048 4 2 0 1 2113 2293 1722 2517 -9049 4 2 0 1 1675 2401 2471 2750 -9050 4 2 0 1 1559 2160 1793 2731 -9051 4 2 0 1 2252 2651 2032 2678 -9052 4 2 0 1 193 524 267 2209 -9053 4 2 0 1 1657 2113 1932 2449 -9054 4 2 0 1 1085 1775 2191 2584 -9055 4 2 0 1 2158 2636 1748 2738 -9056 4 2 0 1 1601 2418 2085 2673 -9057 4 2 0 1 409 2084 311 2574 -9058 4 2 0 1 1759 2183 1530 2471 -9059 4 2 0 1 1886 2540 2244 2627 -9060 4 2 0 1 1764 2615 2051 2754 -9061 4 2 0 1 2090 2407 1969 2657 -9062 4 2 0 1 390 2407 2333 2657 -9063 4 2 0 1 2351 2615 1974 2754 -9064 4 2 0 1 1795 2228 2108 2541 -9065 4 2 0 1 1913 1978 326 2559 -9066 4 2 0 1 1680 1934 2154 2753 -9067 4 2 0 1 1555 2347 1858 2659 -9068 4 2 0 1 1111 2488 2054 2626 -9069 4 2 0 1 1003 922 1000 1790 -9070 4 2 0 1 2058 2357 1910 2681 -9071 4 2 0 1 592 547 588 2560 -9072 4 2 0 1 1556 1986 2037 2231 -9073 4 2 0 1 1037 1150 1031 2565 -9074 4 2 0 1 715 784 2217 2714 -9075 4 2 0 1 1537 1963 2243 2739 -9076 4 2 0 1 780 1855 2436 2501 -9077 4 2 0 1 1544 2226 1951 2833 -9078 4 2 0 1 287 1007 970 2107 -9079 4 2 0 1 1111 2054 1098 2626 -9080 4 2 0 1 1610 2331 2160 2731 -9081 4 2 0 1 1630 2154 1934 2753 -9082 4 2 0 1 1972 2410 2282 2777 -9083 4 2 0 1 477 274 265 2612 -9084 4 2 0 1 2529 2690 2034 2718 -9085 4 2 0 1 2082 2243 1719 2318 -9086 4 2 0 1 387 1902 318 2669 -9087 4 2 0 1 1439 1222 1352 1798 -9088 4 2 0 1 997 1507 157 2184 -9089 4 2 0 1 313 1732 2353 2795 -9090 4 2 0 1 1568 1878 2047 2252 -9091 4 2 0 1 1582 2089 1811 2149 -9092 4 2 0 1 567 647 600 2192 -9093 4 2 0 1 1132 286 500 1904 -9094 4 2 0 1 1675 2401 2065 2471 -9095 4 2 0 1 1151 2416 1057 2709 -9096 4 2 0 1 1624 2076 1872 2254 -9097 4 2 0 1 510 592 514 2359 -9098 4 2 0 1 930 948 2233 2553 -9099 4 2 0 1 1666 1901 2238 2505 -9100 4 2 0 1 760 797 802 2585 -9101 4 2 0 1 1560 1777 2413 2707 -9102 4 2 0 1 1585 1880 2447 2750 -9103 4 2 0 1 2089 2363 1862 2426 -9104 4 2 0 1 1409 1253 1824 2751 -9105 4 2 0 1 1082 1163 1863 2384 -9106 4 2 0 1 1356 1404 1179 2007 -9107 4 2 0 1 1729 2209 1952 2793 -9108 4 2 0 1 1564 1867 2118 2829 -9109 4 2 0 1 175 471 1792 2674 -9110 4 2 0 1 1632 2114 1876 2223 -9111 4 2 0 1 660 2283 682 2497 -9112 4 2 0 1 1573 2139 1956 2630 -9113 4 2 0 1 894 1781 2184 2670 -9114 4 2 0 1 1653 2122 2473 2723 -9115 4 2 0 1 2144 2267 1690 2498 -9116 4 2 0 1 1345 1821 2194 2467 -9117 4 2 0 1 2094 2387 1705 2620 -9118 4 2 0 1 2066 2068 2341 2404 -9119 4 2 0 1 1583 1823 1964 2622 -9120 4 2 0 1 301 2002 1997 2605 -9121 4 2 0 1 721 150 791 2628 -9122 4 2 0 1 1669 1844 1962 2078 -9123 4 2 0 1 1939 2123 1591 2353 -9124 4 2 0 1 1719 1633 2148 2318 -9125 4 2 0 1 390 2333 2090 2657 -9126 4 2 0 1 584 1809 644 2658 -9127 4 2 0 1 2461 2523 945 2637 -9128 4 2 0 1 674 2180 1868 2672 -9129 4 2 0 1 1791 2143 1611 2504 -9130 4 2 0 1 1715 1940 1981 2789 -9131 4 2 0 1 1750 1865 2306 2308 -9132 4 2 0 1 1617 2003 1960 2595 -9133 4 2 0 1 1610 2363 1862 2439 -9134 4 2 0 1 1544 2625 2188 2800 -9135 4 2 0 1 626 678 684 1725 -9136 4 2 0 1 693 692 799 1942 -9137 4 2 0 1 1835 2270 1932 2449 -9138 4 2 0 1 255 499 395 2438 -9139 4 2 0 1 607 1972 2236 2390 -9140 4 2 0 1 1815 1596 2350 2745 -9141 4 2 0 1 616 2281 632 2283 -9142 4 2 0 1 899 2165 1781 2670 -9143 4 2 0 1 1569 2237 1851 2490 -9144 4 2 0 1 587 620 546 2367 -9145 4 2 0 1 1664 2221 1873 2259 -9146 4 2 0 1 674 530 1868 2180 -9147 4 2 0 1 1544 2188 1827 2800 -9148 4 2 0 1 1586 1835 1932 2309 -9149 4 2 0 1 1866 2112 1818 2831 -9150 4 2 0 1 1657 2449 1997 2568 -9151 4 2 0 1 1564 1753 2352 2829 -9152 4 2 0 1 1694 2123 2219 2832 -9153 4 2 0 1 1910 2189 1603 2357 -9154 4 2 0 1 744 2041 781 2379 -9155 4 2 0 1 1778 314 2211 2815 -9156 4 2 0 1 2163 2532 1811 2702 -9157 4 2 0 1 1761 251 2612 2803 -9158 4 2 0 1 1551 2532 2163 2702 -9159 4 2 0 1 1619 1862 2149 2431 -9160 4 2 0 1 690 2028 2045 2378 -9161 4 2 0 1 1661 2232 2095 2603 -9162 4 2 0 1 1852 1962 1669 2583 -9163 4 2 0 1 1599 1911 2486 2778 -9164 4 2 0 1 1640 1951 1883 2810 -9165 4 2 0 1 2169 2236 1652 2390 -9166 4 2 0 1 1541 2143 1938 2520 -9167 4 2 0 1 1647 2465 1941 2480 -9168 4 2 0 1 1652 2250 2197 2390 -9169 4 2 0 1 818 2267 753 2585 -9170 4 2 0 1 1863 2025 1575 2817 -9171 4 2 0 1 1596 1960 2003 2595 -9172 4 2 0 1 1687 2023 1894 2444 -9173 4 2 0 1 1613 2566 1980 2633 -9174 4 2 0 1 1567 2481 2207 2580 -9175 4 2 0 1 302 1823 2262 2395 -9176 4 2 0 1 1830 2372 2183 2506 -9177 4 2 0 1 939 911 2591 2715 -9178 4 2 0 1 1791 2065 2271 2602 -9179 4 2 0 1 1442 1312 1922 2493 -9180 4 2 0 1 1708 2022 2552 2648 -9181 4 2 0 1 1862 2363 2089 2439 -9182 4 2 0 1 1915 1989 1605 2355 -9183 4 2 0 1 1642 2234 1885 2325 -9184 4 2 0 1 1687 2576 2317 2679 -9185 4 2 0 1 810 1957 2307 2451 -9186 4 2 0 1 1529 1888 2300 2774 -9187 4 2 0 1 1642 2008 1906 2711 -9188 4 2 0 1 428 1897 213 2472 -9189 4 2 0 1 1811 2547 1551 2611 -9190 4 2 0 1 203 327 2407 2657 -9191 4 2 0 1 1651 2257 2664 2704 -9192 4 2 0 1 1059 1023 2140 2346 -9193 4 2 0 1 507 2128 438 2422 -9194 4 2 0 1 1574 1750 2308 2454 -9195 4 2 0 1 1721 2070 1664 2188 -9196 4 2 0 1 2178 2223 1708 2232 -9197 4 2 0 1 2062 2262 1720 2355 -9198 4 2 0 1 1950 2154 1916 2802 -9199 4 2 0 1 1536 2047 2313 2427 -9200 4 2 0 1 230 511 2567 2685 -9201 4 2 0 1 2035 2537 1721 2734 -9202 4 2 0 1 1711 2119 2114 2817 -9203 4 2 0 1 1932 1980 1635 2838 -9204 4 2 0 1 1310 1188 2036 2284 -9205 4 2 0 1 1669 2143 1791 2796 -9206 4 2 0 1 1800 2685 1877 2793 -9207 4 2 0 1 1213 1372 1305 1926 -9208 4 2 0 1 1604 2093 2235 2526 -9209 4 2 0 1 805 2034 824 2307 -9210 4 2 0 1 500 170 504 1904 -9211 4 2 0 1 1666 1836 2249 2505 -9212 4 2 0 1 1908 2358 1241 2485 -9213 4 2 0 1 1343 1834 1227 2324 -9214 4 2 0 1 2111 2320 1714 2834 -9215 4 2 0 1 1771 1554 2385 2742 -9216 4 2 0 1 872 876 921 2279 -9217 4 2 0 1 1557 2108 1795 2228 -9218 4 2 0 1 2467 2475 1627 2484 -9219 4 2 0 1 991 152 897 2115 -9220 4 2 0 1 1740 2099 1936 2608 -9221 4 2 0 1 1998 2118 1608 2266 -9222 4 2 0 1 1666 1901 2505 2600 -9223 4 2 0 1 1066 1508 1519 2696 -9224 4 2 0 1 149 150 721 2338 -9225 4 2 0 1 1775 1587 2191 2584 -9226 4 2 0 1 1711 2126 1853 2710 -9227 4 2 0 1 1584 2166 1848 2575 -9228 4 2 0 1 2084 2159 452 2323 -9229 4 2 0 1 2159 2528 2376 2807 -9230 4 2 0 1 150 976 151 1946 -9231 4 2 0 1 592 666 1831 2359 -9232 4 2 0 1 1858 1906 1626 2608 -9233 4 2 0 1 1588 1891 2067 2343 -9234 4 2 0 1 1949 2250 1652 2790 -9235 4 2 0 1 1615 2162 1751 2636 -9236 4 2 0 1 949 900 862 2637 -9237 4 2 0 1 1239 1441 1383 2322 -9238 4 2 0 1 765 2253 808 2555 -9239 4 2 0 1 1291 1464 1008 2775 -9240 4 2 0 1 1647 2480 2085 2673 -9241 4 2 0 1 1153 1994 1139 2582 -9242 4 2 0 1 681 593 1766 2663 -9243 4 2 0 1 1241 2379 1479 2780 -9244 4 2 0 1 1178 2455 2201 2737 -9245 4 2 0 1 644 590 658 2610 -9246 4 2 0 1 1558 1985 2377 2773 -9247 4 2 0 1 389 412 490 1918 -9248 4 2 0 1 1596 1815 1960 2595 -9249 4 2 0 1 1535 1839 2203 2665 -9250 4 2 0 1 877 871 994 2155 -9251 4 2 0 1 1363 2042 1354 2342 -9252 4 2 0 1 857 2129 962 2365 -9253 4 2 0 1 2094 2226 1579 2781 -9254 4 2 0 1 440 2328 232 2819 -9255 4 2 0 1 718 2555 689 2649 -9256 4 2 0 1 2079 2329 1776 2375 -9257 4 2 0 1 561 580 1423 2294 -9258 4 2 0 1 1708 2552 2232 2648 -9259 4 2 0 1 1544 1827 2182 2800 -9260 4 2 0 1 1540 2417 2071 2756 -9261 4 2 0 1 1573 2010 2452 2630 -9262 4 2 0 1 1784 2300 1586 2309 -9263 4 2 0 1 1471 1187 1475 2383 -9264 4 2 0 1 1637 2294 2132 2467 -9265 4 2 0 1 816 729 847 2425 -9266 4 2 0 1 570 1912 2283 2497 -9267 4 2 0 1 1691 1988 1987 2388 -9268 4 2 0 1 1057 1929 2394 2709 -9269 4 2 0 1 1277 1840 1500 2586 -9270 4 2 0 1 1651 1824 2257 2704 -9271 4 2 0 1 721 2338 150 2628 -9272 4 2 0 1 689 2555 2253 2649 -9273 4 2 0 1 1549 1887 2195 2617 -9274 4 2 0 1 2111 2466 2000 2616 -9275 4 2 0 1 2051 2615 1810 2718 -9276 4 2 0 1 1960 2060 1617 2410 -9277 4 2 0 1 1579 2740 2094 2781 -9278 4 2 0 1 1948 2260 638 2400 -9279 4 2 0 1 383 2030 297 2525 -9280 4 2 0 1 1635 1962 1932 2623 -9281 4 2 0 1 2033 2392 1808 2834 -9282 4 2 0 1 1661 2223 2178 2232 -9283 4 2 0 1 1583 1904 2054 2225 -9284 4 2 0 1 1532 1779 2258 2343 -9285 4 2 0 1 1683 2398 1856 2527 -9286 4 2 0 1 1850 2270 2080 2528 -9287 4 2 0 1 1257 1430 1360 1828 -9288 4 2 0 1 1076 1913 1035 2642 -9289 4 2 0 1 1867 2352 2149 2431 -9290 4 2 0 1 1843 1615 2221 2492 -9291 4 2 0 1 1848 2062 1720 2805 -9292 4 2 0 1 1272 2177 1204 2299 -9293 4 2 0 1 300 297 383 2776 -9294 4 2 0 1 193 274 521 1961 -9295 4 2 0 1 2543 2768 1746 2814 -9296 4 2 0 1 1035 1930 1154 2170 -9297 4 2 0 1 1897 2297 1644 2380 -9298 4 2 0 1 1571 2204 1953 2532 -9299 4 2 0 1 468 757 789 831 -9300 4 2 0 1 715 771 784 2714 -9301 4 2 0 1 1586 2290 1962 2583 -9302 4 2 0 1 1939 2353 2293 2607 -9303 4 2 0 1 1712 2102 1926 2765 -9304 4 2 0 1 1553 1783 1956 2459 -9305 4 2 0 1 760 802 809 1855 -9306 4 2 0 1 885 276 521 282 -9307 4 2 0 1 2120 2345 1955 2705 -9308 4 2 0 1 152 897 2115 2523 -9309 4 2 0 1 899 1781 894 2670 -9310 4 2 0 1 1575 1853 2509 2817 -9311 4 2 0 1 1586 1970 2290 2583 -9312 4 2 0 1 141 2277 830 2732 -9313 4 2 0 1 1441 1974 1383 2322 -9314 4 2 0 1 1562 2141 2175 2193 -9315 4 2 0 1 1672 2208 1971 2411 -9316 4 2 0 1 928 965 2162 2591 -9317 4 2 0 1 1991 2596 752 2677 -9318 4 2 0 1 960 860 887 2382 -9319 4 2 0 1 1712 2320 2111 2429 -9320 4 2 0 1 1983 1997 1657 2605 -9321 4 2 0 1 1954 2194 1347 2655 -9322 4 2 0 1 1773 1598 2249 2440 -9323 4 2 0 1 1018 2138 1175 2191 -9324 4 2 0 1 1593 2319 1738 2545 -9325 4 2 0 1 1527 2295 2651 2813 -9326 4 2 0 1 1571 2136 1858 2347 -9327 4 2 0 1 1731 2374 1628 2534 -9328 4 2 0 1 255 410 499 1967 -9329 4 2 0 1 731 2055 792 2135 -9330 4 2 0 1 2273 2414 1787 2716 -9331 4 2 0 1 1548 1741 2158 2511 -9332 4 2 0 1 1583 1904 2092 2622 -9333 4 2 0 1 1122 1017 1091 1746 -9334 4 2 0 1 1752 2204 2288 2532 -9335 4 2 0 1 1610 1771 2115 2186 -9336 4 2 0 1 1215 2475 2467 2484 -9337 4 2 0 1 1642 2234 2325 2515 -9338 4 2 0 1 2191 2384 1161 2594 -9339 4 2 0 1 1555 2608 1906 2787 -9340 4 2 0 1 638 649 594 1948 -9341 4 2 0 1 1657 1932 2113 2838 -9342 4 2 0 1 2075 2660 2025 2817 -9343 4 2 0 1 1810 2529 774 2722 -9344 4 2 0 1 1891 2154 1950 2433 -9345 4 2 0 1 1650 2506 1958 2837 -9346 4 2 0 1 960 887 2259 2382 -9347 4 2 0 1 1891 1950 1655 2433 -9348 4 2 0 1 1593 2073 1832 2280 -9349 4 2 0 1 1744 2121 1941 2402 -9350 4 2 0 1 1789 2058 1631 2748 -9351 4 2 0 1 365 1859 183 2669 -9352 4 2 0 1 811 1855 780 2501 -9353 4 2 0 1 720 821 464 1993 -9354 4 2 0 1 1899 1567 2139 2580 -9355 4 2 0 1 1564 2352 1867 2829 -9356 4 2 0 1 133 569 1960 2350 -9357 4 2 0 1 1324 1227 1374 2013 -9358 4 2 0 1 1833 2150 1779 2688 -9359 4 2 0 1 1121 2191 2138 2584 -9360 4 2 0 1 1767 2159 2084 2376 -9361 4 2 0 1 1796 1958 2506 2837 -9362 4 2 0 1 1789 1631 2269 2748 -9363 4 2 0 1 1373 2012 1232 2441 -9364 4 2 0 1 815 752 803 1991 -9365 4 2 0 1 1189 1417 1483 2620 -9366 4 2 0 1 329 419 168 2399 -9367 4 2 0 1 783 2109 842 2186 -9368 4 2 0 1 1333 1214 1857 2325 -9369 4 2 0 1 2091 2442 1609 2721 -9370 4 2 0 1 1428 1456 1924 2087 -9371 4 2 0 1 1690 2404 2144 2445 -9372 4 2 0 1 1585 2027 2239 2447 -9373 4 2 0 1 2017 2502 1718 2773 -9374 4 2 0 1 1664 1721 2537 2734 -9375 4 2 0 1 1751 1790 2562 2695 -9376 4 2 0 1 614 584 541 2530 -9377 4 2 0 1 772 2041 716 2666 -9378 4 2 0 1 1877 2685 1643 2793 -9379 4 2 0 1 1726 2283 1912 2497 -9380 4 2 0 1 861 881 899 2589 -9381 4 2 0 1 603 1841 601 2321 -9382 4 2 0 1 1778 2211 2397 2815 -9383 4 2 0 1 822 1210 835 748 -9384 4 2 0 1 1728 2227 2335 2656 -9385 4 2 0 1 1469 1837 2301 2620 -9386 4 2 0 1 1776 2329 2014 2736 -9387 4 2 0 1 1380 1824 1409 2381 -9388 4 2 0 1 1557 2108 2228 2541 -9389 4 2 0 1 1728 1886 2244 2627 -9390 4 2 0 1 2083 2151 1656 2216 -9391 4 2 0 1 984 888 2129 2589 -9392 4 2 0 1 1243 2289 1378 2767 -9393 4 2 0 1 1630 2706 1948 2786 -9394 4 2 0 1 1123 1975 1846 2491 -9395 4 2 0 1 1567 2260 2139 2706 -9396 4 2 0 1 1840 2195 1887 2617 -9397 4 2 0 1 179 427 407 2097 -9398 4 2 0 1 1245 2453 1774 2737 -9399 4 2 0 1 2621 2726 1577 2805 -9400 4 2 0 1 1561 2654 2013 2746 -9401 4 2 0 1 805 769 840 1826 -9402 4 2 0 1 901 2287 2137 2715 -9403 4 2 0 1 646 2009 2169 2587 -9404 4 2 0 1 1630 1956 2139 2546 -9405 4 2 0 1 1345 2194 1821 2655 -9406 4 2 0 1 938 869 2101 2251 -9407 4 2 0 1 1554 2644 2385 2742 -9408 4 2 0 1 1469 1837 1300 2301 -9409 4 2 0 1 1851 2431 2110 2487 -9410 4 2 0 1 2183 2471 1830 2506 -9411 4 2 0 1 1726 1662 2212 2360 -9412 4 2 0 1 1757 2109 2426 2628 -9413 4 2 0 1 564 648 654 2830 -9414 4 2 0 1 1549 2195 1887 2600 -9415 4 2 0 1 2290 2583 1970 2796 -9416 4 2 0 1 984 1889 933 2589 -9417 4 2 0 1 2409 2490 1902 2826 -9418 4 2 0 1 2276 2284 2036 2712 -9419 4 2 0 1 1264 1933 1276 2171 -9420 4 2 0 1 2379 2485 1908 2780 -9421 4 2 0 1 1612 1808 2018 2834 -9422 4 2 0 1 453 2404 1792 2445 -9423 4 2 0 1 1752 2532 2267 2702 -9424 4 2 0 1 1527 2116 2032 2651 -9425 4 2 0 1 1559 1738 2423 2545 -9426 4 2 0 1 1398 579 1460 1984 -9427 4 2 0 1 1983 2614 1676 2669 -9428 4 2 0 1 1310 2284 1788 2441 -9429 4 2 0 1 559 632 1934 2283 -9430 4 2 0 1 787 731 699 2135 -9431 4 2 0 1 1637 2132 2294 2393 -9432 4 2 0 1 1200 591 651 2053 -9433 4 2 0 1 782 727 788 2120 -9434 4 2 0 1 1659 2211 1982 2397 -9435 4 2 0 1 1548 2158 2254 2511 -9436 4 2 0 1 1827 2227 1728 2800 -9437 4 2 0 1 1775 1658 2535 2565 -9438 4 2 0 1 1779 1833 2088 2430 -9439 4 2 0 1 1624 2301 2076 2511 -9440 4 2 0 1 2051 2615 1764 2835 -9441 4 2 0 1 2162 2279 1748 2591 -9442 4 2 0 1 1818 2295 1717 2820 -9443 4 2 0 1 666 543 1831 2569 -9444 4 2 0 1 1898 1919 1546 2389 -9445 4 2 0 1 1253 1893 1401 2201 -9446 4 2 0 1 858 1001 2125 2562 -9447 4 2 0 1 431 1725 416 2610 -9448 4 2 0 1 1928 2032 1598 2252 -9449 4 2 0 1 1163 2384 1150 2565 -9450 4 2 0 1 1849 1877 2567 2685 -9451 4 2 0 1 1608 2334 2266 2701 -9452 4 2 0 1 1793 2461 2129 2637 -9453 4 2 0 1 949 936 880 2073 -9454 4 2 0 1 1573 2010 1956 2496 -9455 4 2 0 1 1194 2033 1440 2835 -9456 4 2 0 1 428 399 242 2472 -9457 4 2 0 1 1812 2224 2096 2708 -9458 4 2 0 1 678 550 545 2400 -9459 4 2 0 1 394 1905 259 2397 -9460 4 2 0 1 1750 2050 1783 2348 -9461 4 2 0 1 1602 1879 2185 2632 -9462 4 2 0 1 1850 2002 235 2605 -9463 4 2 0 1 2188 2700 1827 2800 -9464 4 2 0 1 1284 1526 2135 2822 -9465 4 2 0 1 1539 1876 2114 2223 -9466 4 2 0 1 861 899 2165 2589 -9467 4 2 0 1 813 1752 2267 2316 -9468 4 2 0 1 1601 2227 1945 2418 -9469 4 2 0 1 1399 2201 1992 2337 -9470 4 2 0 1 1520 1204 2177 2184 -9471 4 2 0 1 1881 788 2508 2732 -9472 4 2 0 1 527 516 149 2338 -9473 4 2 0 1 1988 2290 1777 2413 -9474 4 2 0 1 1548 2208 1805 2708 -9475 4 2 0 1 2168 2295 1777 2527 -9476 4 2 0 1 932 941 887 1873 -9477 4 2 0 1 960 2382 2259 2734 -9478 4 2 0 1 1026 1073 1914 2095 -9479 4 2 0 1 1618 2206 2069 2725 -9480 4 2 0 1 1489 1255 2387 2620 -9481 4 2 0 1 798 801 693 1942 -9482 4 2 0 1 782 2161 1881 2555 -9483 4 2 0 1 1711 2075 2384 2817 -9484 4 2 0 1 2093 2100 1662 2360 -9485 4 2 0 1 746 838 2379 2631 -9486 4 2 0 1 1527 2168 2296 2311 -9487 4 2 0 1 2422 2488 1723 2503 -9488 4 2 0 1 267 449 1952 2826 -9489 4 2 0 1 477 287 276 2107 -9490 4 2 0 1 2150 2308 1782 2538 -9491 4 2 0 1 818 705 1765 2585 -9492 4 2 0 1 1710 2518 2095 2603 -9493 4 2 0 1 1841 2314 2141 2728 -9494 4 2 0 1 1616 2540 1886 2627 -9495 4 2 0 1 467 454 246 2445 -9496 4 2 0 1 1579 1886 2226 2760 -9497 4 2 0 1 1554 1839 2361 2385 -9498 4 2 0 1 2163 2445 1977 2539 -9499 4 2 0 1 477 1961 274 2107 -9500 4 2 0 1 1883 1951 1576 2810 -9501 4 2 0 1 1776 1622 2041 2375 -9502 4 2 0 1 1564 1880 2242 2701 -9503 4 2 0 1 1382 2137 1357 2715 -9504 4 2 0 1 1536 2047 1866 2463 -9505 4 2 0 1 1731 2374 1395 2720 -9506 4 2 0 1 267 466 180 2826 -9507 4 2 0 1 1680 2345 1884 2530 -9508 4 2 0 1 1950 2150 2430 2682 -9509 4 2 0 1 2005 2242 1634 2699 -9510 4 2 0 1 1698 2015 2291 2540 -9511 4 2 0 1 1759 1530 2266 2471 -9512 4 2 0 1 1115 1478 1139 1994 -9513 4 2 0 1 1813 2067 1891 2580 -9514 4 2 0 1 1764 2392 2370 2754 -9515 4 2 0 1 1741 2700 2188 2800 -9516 4 2 0 1 1277 1840 2303 2442 -9517 4 2 0 1 794 1264 1201 2171 -9518 4 2 0 1 2207 2399 1668 2472 -9519 4 2 0 1 923 2057 967 2241 -9520 4 2 0 1 1216 1340 1347 1954 -9521 4 2 0 1 1474 904 1402 2137 -9522 4 2 0 1 1546 1737 2023 2134 -9523 4 2 0 1 290 293 2062 2262 -9524 4 2 0 1 1569 1851 2423 2490 -9525 4 2 0 1 2160 2385 1703 2616 -9526 4 2 0 1 1715 1940 2003 2368 -9527 4 2 0 1 1151 162 2035 2416 -9528 4 2 0 1 2142 2167 1878 2356 -9529 4 2 0 1 579 1398 578 2419 -9530 4 2 0 1 1801 2647 204 2744 -9531 4 2 0 1 175 1792 2404 2674 -9532 4 2 0 1 1881 2161 1648 2555 -9533 4 2 0 1 2490 2641 1902 2826 -9534 4 2 0 1 1811 2702 2532 2816 -9535 4 2 0 1 1656 2548 2126 2578 -9536 4 2 0 1 1745 2733 2522 2777 -9537 4 2 0 1 929 962 931 1832 -9538 4 2 0 1 1737 2489 358 2679 -9539 4 2 0 1 1577 2130 1896 2748 -9540 4 2 0 1 1894 2251 927 2421 -9541 4 2 0 1 1734 2141 1949 2723 -9542 4 2 0 1 1359 1995 1326 2467 -9543 4 2 0 1 757 468 789 2144 -9544 4 2 0 1 1748 1654 2254 2591 -9545 4 2 0 1 1669 1962 1852 2078 -9546 4 2 0 1 1833 2401 1597 2688 -9547 4 2 0 1 705 2501 1765 2585 -9548 4 2 0 1 1585 1880 2242 2597 -9549 4 2 0 1 1652 2169 2141 2728 -9550 4 2 0 1 939 868 883 2287 -9551 4 2 0 1 2277 2456 198 2457 -9552 4 2 0 1 1545 2676 2376 2807 -9553 4 2 0 1 1040 1819 1060 2406 -9554 4 2 0 1 900 892 862 2477 -9555 4 2 0 1 1629 2436 1855 2501 -9556 4 2 0 1 1588 2343 1779 2430 -9557 4 2 0 1 315 220 2123 2156 -9558 4 2 0 1 633 2256 1868 2321 -9559 4 2 0 1 1561 1834 2011 2746 -9560 4 2 0 1 1619 1859 2153 2409 -9561 4 2 0 1 1144 1174 2064 2274 -9562 4 2 0 1 1889 2592 1781 2644 -9563 4 2 0 1 652 136 135 2410 -9564 4 2 0 1 1582 2403 1757 2426 -9565 4 2 0 1 1942 2028 1713 2432 -9566 4 2 0 1 1560 1807 1987 2550 -9567 4 2 0 1 1561 2112 1866 2654 -9568 4 2 0 1 462 2020 222 2438 -9569 4 2 0 1 1924 2358 1392 2441 -9570 4 2 0 1 1343 1834 2324 2737 -9571 4 2 0 1 1547 1901 2356 2434 -9572 4 2 0 1 1602 2038 2437 2698 -9573 4 2 0 1 671 685 640 1869 -9574 4 2 0 1 1741 2188 2158 2511 -9575 4 2 0 1 847 2425 1794 2497 -9576 4 2 0 1 1230 2091 1412 2721 -9577 4 2 0 1 1580 2529 2055 2784 -9578 4 2 0 1 1722 2293 2113 2568 -9579 4 2 0 1 2016 2429 1926 2765 -9580 4 2 0 1 1745 2282 1617 2410 -9581 4 2 0 1 2155 2327 1761 2803 -9582 4 2 0 1 1441 1974 2615 2835 -9583 4 2 0 1 2308 2538 2150 2688 -9584 4 2 0 1 1644 2391 1838 2823 -9585 4 2 0 1 1839 1535 2439 2487 -9586 4 2 0 1 507 268 438 2128 -9587 4 2 0 1 1850 1657 2002 2605 -9588 4 2 0 1 1307 1390 1498 2057 -9589 4 2 0 1 1165 1088 1135 1975 -9590 4 2 0 1 2068 2106 1629 2501 -9591 4 2 0 1 428 213 406 2472 -9592 4 2 0 1 1597 1750 2308 2688 -9593 4 2 0 1 1910 1603 2172 2764 -9594 4 2 0 1 940 2073 931 2129 -9595 4 2 0 1 442 404 2424 2556 -9596 4 2 0 1 1626 2205 2171 2513 -9597 4 2 0 1 1590 2528 2159 2807 -9598 4 2 0 1 423 2225 424 2554 -9599 4 2 0 1 1860 2425 816 2638 -9600 4 2 0 1 1896 2222 1695 2298 -9601 4 2 0 1 1760 1642 2174 2263 -9602 4 2 0 1 1335 1425 1230 2721 -9603 4 2 0 1 1261 2117 1278 2586 -9604 4 2 0 1 1683 1804 2011 2599 -9605 4 2 0 1 1821 2036 1574 2811 -9606 4 2 0 1 1123 1975 1055 2570 -9607 4 2 0 1 1727 2042 2463 2573 -9608 4 2 0 1 706 806 750 2631 -9609 4 2 0 1 1787 2273 2056 2414 -9610 4 2 0 1 1374 1227 1336 2013 -9611 4 2 0 1 1555 1858 2608 2787 -9612 4 2 0 1 431 416 1725 2661 -9613 4 2 0 1 1622 2329 2079 2375 -9614 4 2 0 1 1571 1991 1942 2347 -9615 4 2 0 1 1639 1954 2220 2782 -9616 4 2 0 1 1548 2224 1814 2480 -9617 4 2 0 1 1645 1853 2151 2509 -9618 4 2 0 1 1277 2303 1840 2586 -9619 4 2 0 1 587 546 2053 2367 -9620 4 2 0 1 1578 2443 2345 2802 -9621 4 2 0 1 1569 2176 1966 2517 -9622 4 2 0 1 1585 1801 2030 2597 -9623 4 2 0 1 573 1995 537 2294 -9624 4 2 0 1 339 1947 359 2683 -9625 4 2 0 1 343 1947 339 2268 -9626 4 2 0 1 1585 2239 1958 2447 -9627 4 2 0 1 1745 2282 2410 2777 -9628 4 2 0 1 2067 2417 1899 2580 -9629 4 2 0 1 1171 1108 1090 2518 -9630 4 2 0 1 1776 2375 767 2649 -9631 4 2 0 1 993 1907 876 2057 -9632 4 2 0 1 530 1868 1973 2766 -9633 4 2 0 1 1574 2308 2276 2454 -9634 4 2 0 1 2006 2244 2187 2548 -9635 4 2 0 1 1648 2649 1776 2717 -9636 4 2 0 1 1534 2221 1843 2673 -9637 4 2 0 1 1709 2004 1945 2312 -9638 4 2 0 1 1584 2103 1888 2166 -9639 4 2 0 1 1009 859 983 2695 -9640 4 2 0 1 2058 2357 1631 2362 -9641 4 2 0 1 644 1809 426 2658 -9642 4 2 0 1 1793 1724 2160 2461 -9643 4 2 0 1 1604 1921 2210 2526 -9644 4 2 0 1 1748 2591 2279 2636 -9645 4 2 0 1 692 691 803 2288 -9646 4 2 0 1 1603 1829 1947 2464 -9647 4 2 0 1 1642 1906 2008 2801 -9648 4 2 0 1 2118 2266 1880 2701 -9649 4 2 0 1 1946 2523 1729 2637 -9650 4 2 0 1 634 646 2169 2766 -9651 4 2 0 1 1692 2370 2000 2392 -9652 4 2 0 1 1162 2191 1150 2384 -9653 4 2 0 1 1726 1604 2235 2283 -9654 4 2 0 1 1384 1820 1416 2763 -9655 4 2 0 1 571 535 566 2197 -9656 4 2 0 1 1576 1951 1883 2552 -9657 4 2 0 1 1539 1883 2232 2710 -9658 4 2 0 1 1116 2350 133 2503 -9659 4 2 0 1 1805 2383 1302 2668 -9660 4 2 0 1 497 218 2359 2472 -9661 4 2 0 1 1909 1609 2442 2721 -9662 4 2 0 1 1921 2371 1821 2811 -9663 4 2 0 1 376 350 239 2539 -9664 4 2 0 1 1980 2237 1753 2633 -9665 4 2 0 1 418 349 1930 2559 -9666 4 2 0 1 1735 2434 2250 2500 -9667 4 2 0 1 1865 1679 2521 2712 -9668 4 2 0 1 1967 2286 1644 2380 -9669 4 2 0 1 1679 1774 2011 2521 -9670 4 2 0 1 532 559 632 1934 -9671 4 2 0 1 2071 2417 1736 2756 -9672 4 2 0 1 2396 2573 1866 2831 -9673 4 2 0 1 1546 2689 2061 2771 -9674 4 2 0 1 1921 2526 2371 2811 -9675 4 2 0 1 193 267 250 1952 -9676 4 2 0 1 697 729 785 2087 -9677 4 2 0 1 1624 1837 2301 2511 -9678 4 2 0 1 1850 2002 1590 2159 -9679 4 2 0 1 1958 2239 1650 2837 -9680 4 2 0 1 1772 2007 1570 2747 -9681 4 2 0 1 1539 2126 1883 2710 -9682 4 2 0 1 1656 1795 2578 2726 -9683 4 2 0 1 1623 2022 2289 2730 -9684 4 2 0 1 1882 1989 1605 2147 -9685 4 2 0 1 2148 2275 1240 2767 -9686 4 2 0 1 1644 2071 1838 2391 -9687 4 2 0 1 1934 2283 1604 2753 -9688 4 2 0 1 1431 1359 2132 2294 -9689 4 2 0 1 1477 1937 1280 2724 -9690 4 2 0 1 1380 2381 1409 2493 -9691 4 2 0 1 1137 1126 1087 2202 -9692 4 2 0 1 2317 2576 225 2679 -9693 4 2 0 1 1160 2384 2119 2769 -9694 4 2 0 1 1537 1807 2214 2739 -9695 4 2 0 1 2036 2284 1188 2324 -9696 4 2 0 1 2099 2171 1626 2596 -9697 4 2 0 1 416 2610 1725 2661 -9698 4 2 0 1 1837 2226 2094 2781 -9699 4 2 0 1 2047 2463 1663 2573 -9700 4 2 0 1 571 671 640 2390 -9701 4 2 0 1 939 911 868 2591 -9702 4 2 0 1 1884 2450 1680 2530 -9703 4 2 0 1 1630 2546 2139 2706 -9704 4 2 0 1 1582 2089 1957 2816 -9705 4 2 0 1 1241 2485 2379 2780 -9706 4 2 0 1 1471 1367 1307 2057 -9707 4 2 0 1 1704 1838 2230 2678 -9708 4 2 0 1 1627 2467 1821 2475 -9709 4 2 0 1 2189 2357 1910 2362 -9710 4 2 0 1 1640 2182 1951 2810 -9711 4 2 0 1 1463 1292 1994 2178 -9712 4 2 0 1 1555 1858 2347 2608 -9713 4 2 0 1 2065 2266 1759 2476 -9714 4 2 0 1 1647 1919 1898 2389 -9715 4 2 0 1 401 1927 478 2464 -9716 4 2 0 1 1884 2456 261 2658 -9717 4 2 0 1 1033 1863 1082 2565 -9718 4 2 0 1 510 650 592 2359 -9719 4 2 0 1 646 605 2009 2587 -9720 4 2 0 1 1832 1999 1599 2129 -9721 4 2 0 1 1278 2117 1206 2586 -9722 4 2 0 1 1521 1485 1484 2184 -9723 4 2 0 1 1888 2369 2103 2806 -9724 4 2 0 1 779 805 840 1826 -9725 4 2 0 1 406 2399 333 2472 -9726 4 2 0 1 1113 1819 1060 2709 -9727 4 2 0 1 488 1927 476 2424 -9728 4 2 0 1 202 1816 2635 2776 -9729 4 2 0 1 648 2350 132 2830 -9730 4 2 0 1 1636 2703 1844 2704 -9731 4 2 0 1 1627 2526 2024 2811 -9732 4 2 0 1 1577 2058 1795 2621 -9733 4 2 0 1 1663 2198 2342 2463 -9734 4 2 0 1 471 2445 1792 2539 -9735 4 2 0 1 1621 2034 1826 2307 -9736 4 2 0 1 342 238 334 2556 -9737 4 2 0 1 2384 2570 2119 2817 -9738 4 2 0 1 1693 2183 1830 2372 -9739 4 2 0 1 1533 2080 1980 2838 -9740 4 2 0 1 900 2477 862 2637 -9741 4 2 0 1 1559 2423 1738 2758 -9742 4 2 0 1 663 607 1972 2236 -9743 4 2 0 1 1565 1785 2351 2665 -9744 4 2 0 1 2114 2255 2119 2769 -9745 4 2 0 1 1547 2250 2434 2500 -9746 4 2 0 1 1749 2557 1275 2615 -9747 4 2 0 1 1627 2131 1995 2484 -9748 4 2 0 1 1769 1479 2379 2780 -9749 4 2 0 1 528 474 253 2606 -9750 4 2 0 1 559 1786 2283 2536 -9751 4 2 0 1 411 1847 445 2494 -9752 4 2 0 1 1951 2474 1705 2755 -9753 4 2 0 1 1631 2269 2748 2795 -9754 4 2 0 1 1464 1803 1465 2499 -9755 4 2 0 1 1160 1019 2119 2384 -9756 4 2 0 1 2123 2156 220 2683 -9757 4 2 0 1 1787 2056 2273 2586 -9758 4 2 0 1 532 632 647 1934 -9759 4 2 0 1 1559 1952 1800 2793 -9760 4 2 0 1 491 292 307 2353 -9761 4 2 0 1 1640 1883 1959 2810 -9762 4 2 0 1 1679 2284 2036 2324 -9763 4 2 0 1 1945 2227 1806 2418 -9764 4 2 0 1 1529 2216 1888 2774 -9765 4 2 0 1 409 311 295 2574 -9766 4 2 0 1 1597 2065 2401 2471 -9767 4 2 0 1 1557 2768 1819 2814 -9768 4 2 0 1 1631 2357 2189 2362 -9769 4 2 0 1 1810 2557 1933 2718 -9770 4 2 0 1 1539 2126 1853 2151 -9771 4 2 0 1 1033 2564 1863 2565 -9772 4 2 0 1 1666 2063 1773 2386 -9773 4 2 0 1 2371 2526 1627 2811 -9774 4 2 0 1 1851 1966 2423 2836 -9775 4 2 0 1 1318 1374 1336 2013 -9776 4 2 0 1 1689 2427 2010 2452 -9777 4 2 0 1 686 556 656 2390 -9778 4 2 0 1 539 619 601 2046 -9779 4 2 0 1 1582 2163 1811 2816 -9780 4 2 0 1 2287 2591 1872 2715 -9781 4 2 0 1 673 2180 681 2246 -9782 4 2 0 1 1789 2130 2621 2748 -9783 4 2 0 1 2014 2045 1581 2717 -9784 4 2 0 1 1290 1505 1263 2722 -9785 4 2 0 1 1285 1271 1281 2056 -9786 4 2 0 1 1692 2370 2392 2754 -9787 4 2 0 1 426 644 658 2610 -9788 4 2 0 1 1419 1385 1240 2148 -9789 4 2 0 1 1764 2361 1554 2392 -9790 4 2 0 1 485 2017 2217 2645 -9791 4 2 0 1 1076 1035 1913 2713 -9792 4 2 0 1 1721 1664 2070 2734 -9793 4 2 0 1 1782 2526 2210 2538 -9794 4 2 0 1 752 1991 815 2596 -9795 4 2 0 1 2016 2370 2033 2667 -9796 4 2 0 1 1950 2450 2154 2802 -9797 4 2 0 1 598 1973 683 2587 -9798 4 2 0 1 372 447 335 1879 -9799 4 2 0 1 1982 2397 2211 2446 -9800 4 2 0 1 1033 1082 1163 2565 -9801 4 2 0 1 1695 2519 2298 2568 -9802 4 2 0 1 2142 2386 1666 2440 -9803 4 2 0 1 1903 1969 1697 2593 -9804 4 2 0 1 1125 1143 1088 1763 -9805 4 2 0 1 1287 2178 1994 2785 -9806 4 2 0 1 1591 2219 2123 2832 -9807 4 2 0 1 1226 1935 1334 2420 -9808 4 2 0 1 1396 1385 1419 2721 -9809 4 2 0 1 1259 1194 1260 2177 -9810 4 2 0 1 1418 2008 1389 2322 -9811 4 2 0 1 176 352 357 2268 -9812 4 2 0 1 1812 1566 2096 2428 -9813 4 2 0 1 990 1002 925 1931 -9814 4 2 0 1 2309 2369 1835 2799 -9815 4 2 0 1 1929 2172 1603 2764 -9816 4 2 0 1 1268 1266 2178 2730 -9817 4 2 0 1 1574 2276 2036 2454 -9818 4 2 0 1 597 1868 2256 2672 -9819 4 2 0 1 663 1972 135 2410 -9820 4 2 0 1 2092 2336 1979 2448 -9821 4 2 0 1 516 284 264 2338 -9822 4 2 0 1 1886 2755 2627 2760 -9823 4 2 0 1 1590 1802 2528 2807 -9824 4 2 0 1 1823 2262 1686 2516 -9825 4 2 0 1 1955 1884 2456 2457 -9826 4 2 0 1 421 478 2049 2464 -9827 4 2 0 1 1314 1372 1213 1926 -9828 4 2 0 1 1704 2193 1838 2678 -9829 4 2 0 1 1999 2073 1593 2545 -9830 4 2 0 1 1717 2599 2245 2707 -9831 4 2 0 1 1853 1575 2660 2817 -9832 4 2 0 1 1152 1106 1056 1960 -9833 4 2 0 1 1922 1938 1556 2664 -9834 4 2 0 1 1637 2371 1995 2467 -9835 4 2 0 1 2008 2322 1885 2801 -9836 4 2 0 1 202 383 1816 2776 -9837 4 2 0 1 2402 2411 1744 2794 -9838 4 2 0 1 1980 2566 1966 2633 -9839 4 2 0 1 706 812 704 2099 -9840 4 2 0 1 1906 2608 1858 2787 -9841 4 2 0 1 1072 1050 2054 2626 -9842 4 2 0 1 1631 2058 1789 2357 -9843 4 2 0 1 858 1002 1001 2562 -9844 4 2 0 1 1557 1910 2357 2681 -9845 4 2 0 1 1503 1494 1244 2051 -9846 4 2 0 1 2000 2370 1612 2392 -9847 4 2 0 1 869 1894 942 2514 -9848 4 2 0 1 389 211 2097 2571 -9849 4 2 0 1 1498 1390 923 2057 -9850 4 2 0 1 1503 1183 1263 1810 -9851 4 2 0 1 401 442 478 1927 -9852 4 2 0 1 1406 1428 1456 2358 -9853 4 2 0 1 1566 1812 2096 2558 -9854 4 2 0 1 1539 2114 1876 2509 -9855 4 2 0 1 1774 2201 2199 2455 -9856 4 2 0 1 396 2657 2090 2662 -9857 4 2 0 1 1789 1631 2268 2269 -9858 4 2 0 1 1777 2296 1625 2813 -9859 4 2 0 1 1611 2271 1791 2504 -9860 4 2 0 1 1680 1934 2536 2786 -9861 4 2 0 1 1107 1129 1164 1864 -9862 4 2 0 1 1138 1930 1080 2713 -9863 4 2 0 1 1789 2556 1829 2613 -9864 4 2 0 1 1589 2018 2320 2788 -9865 4 2 0 1 703 743 1993 2316 -9866 4 2 0 1 1995 2371 1627 2467 -9867 4 2 0 1 1445 2326 1772 2751 -9868 4 2 0 1 1707 2146 1797 2625 -9869 4 2 0 1 1789 2058 1557 2357 -9870 4 2 0 1 141 563 140 1955 -9871 4 2 0 1 1174 1144 1021 2274 -9872 4 2 0 1 231 831 837 2068 -9873 4 2 0 1 1872 2241 911 2591 -9874 4 2 0 1 1874 1689 2427 2652 -9875 4 2 0 1 596 1973 530 2246 -9876 4 2 0 1 1223 1788 1310 2475 -9877 4 2 0 1 628 2345 1955 2687 -9878 4 2 0 1 1642 2012 2325 2711 -9879 4 2 0 1 2172 2221 1534 2700 -9880 4 2 0 1 1410 1396 2442 2721 -9881 4 2 0 1 2227 1728 2800 2839 -9882 4 2 0 1 1949 1968 1607 2250 -9883 4 2 0 1 1977 1993 1582 2567 -9884 4 2 0 1 1848 1577 2726 2805 -9885 4 2 0 1 1589 2558 1805 2708 -9886 4 2 0 1 2276 2308 1865 2454 -9887 4 2 0 1 1815 2595 1596 2745 -9888 4 2 0 1 1600 1843 2023 2832 -9889 4 2 0 1 1464 2462 1803 2775 -9890 4 2 0 1 1029 1102 1072 2054 -9891 4 2 0 1 1003 873 922 2542 -9892 4 2 0 1 1071 1099 1787 2414 -9893 4 2 0 1 2058 2362 1631 2748 -9894 4 2 0 1 997 1507 1501 157 -9895 4 2 0 1 511 2338 280 2692 -9896 4 2 0 1 792 156 723 2670 -9897 4 2 0 1 1714 2105 1911 2261 -9898 4 2 0 1 300 182 297 2030 -9899 4 2 0 1 602 620 538 1799 -9900 4 2 0 1 236 259 2124 2397 -9901 4 2 0 1 1724 2152 1889 2644 -9902 4 2 0 1 863 899 950 1781 -9903 4 2 0 1 294 519 2062 2624 -9904 4 2 0 1 205 2323 340 2614 -9905 4 2 0 1 532 559 1934 2536 -9906 4 2 0 1 457 461 407 1875 -9907 4 2 0 1 1256 1189 1483 2146 -9908 4 2 0 1 1775 1606 2170 2535 -9909 4 2 0 1 1720 2222 2029 2624 -9910 4 2 0 1 845 1488 148 2131 -9911 4 2 0 1 1788 2036 2276 2284 -9912 4 2 0 1 1543 2040 2075 2535 -9913 4 2 0 1 1788 2024 1923 2276 -9914 4 2 0 1 1883 1951 1616 2552 -9915 4 2 0 1 2124 2456 1884 2457 -9916 4 2 0 1 1880 1675 2242 2701 -9917 4 2 0 1 1555 2598 2659 2787 -9918 4 2 0 1 369 178 1895 2679 -9919 4 2 0 1 2027 2332 1816 2502 -9920 4 2 0 1 1843 1600 2023 2492 -9921 4 2 0 1 767 764 700 1776 -9922 4 2 0 1 1409 1824 1457 2751 -9923 4 2 0 1 1580 1839 2203 2784 -9924 4 2 0 1 2064 2274 1688 2458 -9925 4 2 0 1 1598 2252 2032 2678 -9926 4 2 0 1 1664 2172 2035 2537 -9927 4 2 0 1 708 806 704 2099 -9928 4 2 0 1 1804 2011 1774 2520 -9929 4 2 0 1 1129 1864 1107 2170 -9930 4 2 0 1 1875 2097 407 2468 -9931 4 2 0 1 494 2355 1915 2395 -9932 4 2 0 1 1874 1704 2427 2452 -9933 4 2 0 1 1566 2105 1812 2558 -9934 4 2 0 1 258 2333 1767 2574 -9935 4 2 0 1 349 1979 1930 2559 -9936 4 2 0 1 1528 1966 2111 2466 -9937 4 2 0 1 1650 2239 1958 2506 -9938 4 2 0 1 1295 1181 2056 2785 -9939 4 2 0 1 1926 2302 1589 2788 -9940 4 2 0 1 1614 1721 2416 2537 -9941 4 2 0 1 1740 2028 1942 2432 -9942 4 2 0 1 1976 2091 1248 2442 -9943 4 2 0 1 1272 1259 1260 2177 -9944 4 2 0 1 1637 2281 1912 2371 -9945 4 2 0 1 639 2069 2469 2812 -9946 4 2 0 1 1506 995 166 2278 -9947 4 2 0 1 2273 1787 2586 2716 -9948 4 2 0 1 1665 1996 1792 2539 -9949 4 2 0 1 1654 2254 2096 2636 -9950 4 2 0 1 457 1875 407 2468 -9951 4 2 0 1 294 2062 316 2624 -9952 4 2 0 1 173 2317 2101 2576 -9953 4 2 0 1 2227 2479 1728 2839 -9954 4 2 0 1 1529 2187 2006 2244 -9955 4 2 0 1 1341 1192 1362 2337 -9956 4 2 0 1 869 927 942 1894 -9957 4 2 0 1 966 1894 977 2695 -9958 4 2 0 1 1577 2004 1896 2029 -9959 4 2 0 1 1545 1802 2031 2376 -9960 4 2 0 1 473 504 170 2225 -9961 4 2 0 1 1691 2388 1987 2470 -9962 4 2 0 1 938 2101 869 2514 -9963 4 2 0 1 1612 2392 2033 2834 -9964 4 2 0 1 1838 2059 1644 2823 -9965 4 2 0 1 815 2596 1991 2684 -9966 4 2 0 1 351 372 2185 2333 -9967 4 2 0 1 1730 2342 2198 2463 -9968 4 2 0 1 1176 1870 1030 2603 -9969 4 2 0 1 1781 1628 2081 2592 -9970 4 2 0 1 1221 1376 2531 2720 -9971 4 2 0 1 1811 2163 2149 2611 -9972 4 2 0 1 2001 2102 1678 2302 -9973 4 2 0 1 1226 2001 1935 2825 -9974 4 2 0 1 830 141 140 2277 -9975 4 2 0 1 300 2030 297 2776 -9976 4 2 0 1 1604 2210 1782 2526 -9977 4 2 0 1 1796 2506 1650 2837 -9978 4 2 0 1 1633 2275 2148 2318 -9979 4 2 0 1 1531 1940 2604 2735 -9980 4 2 0 1 1650 2443 1985 2682 -9981 4 2 0 1 466 520 180 2826 -9982 4 2 0 1 607 2236 556 2390 -9983 4 2 0 1 1800 2209 466 2685 -9984 4 2 0 1 1690 2144 1765 2267 -9985 4 2 0 1 1288 1976 1283 2435 -9986 4 2 0 1 1648 2161 2100 2360 -9987 4 2 0 1 1619 2409 1902 2669 -9988 4 2 0 1 1590 2593 2364 2807 -9989 4 2 0 1 1579 2226 2094 2760 -9990 4 2 0 1 1297 1922 2044 2512 -9991 4 2 0 1 878 2241 2279 2591 -9992 4 2 0 1 1683 2527 1856 2602 -9993 4 2 0 1 1083 1039 1077 2056 -9994 4 2 0 1 530 2180 673 2246 -9995 4 2 0 1 1346 2201 2337 2737 -9996 4 2 0 1 1550 2113 2293 2568 -9997 4 2 0 1 290 293 368 2448 -9998 4 2 0 1 1547 1836 2282 2790 -9999 4 2 0 1 1071 2056 1103 2414 -10000 4 2 0 1 1792 1649 2066 2674 -10001 4 2 0 1 1831 2046 1592 2256 -10002 4 2 0 1 1353 1219 1885 2512 -10003 4 2 0 1 765 763 808 1822 -10004 4 2 0 1 1671 1818 2651 2798 -10005 4 2 0 1 2206 2215 1618 2782 -10006 4 2 0 1 1708 2289 2022 2730 -10007 4 2 0 1 1691 2072 1943 2470 -10008 4 2 0 1 1723 2128 2478 2818 -10009 4 2 0 1 392 293 2262 2516 -10010 4 2 0 1 360 369 178 1895 -10011 4 2 0 1 1577 2624 2130 2805 -10012 4 2 0 1 1629 1765 2068 2501 -10013 4 2 0 1 1819 2768 2543 2814 -10014 4 2 0 1 1580 2051 1810 2718 -10015 4 2 0 1 186 1761 2327 2803 -10016 4 2 0 1 1589 2320 1926 2788 -10017 4 2 0 1 221 378 1947 2464 -10018 4 2 0 1 2104 1639 2215 2782 -10019 4 2 0 1 2110 2431 1851 2633 -10020 4 2 0 1 1545 2052 1833 2401 -10021 4 2 0 1 1378 1236 1438 2289 -10022 4 2 0 1 1661 2178 1708 2232 -10023 4 2 0 1 1998 2266 1608 2476 -10024 4 2 0 1 1840 2117 1261 2586 -10025 4 2 0 1 625 1815 569 2350 -10026 4 2 0 1 1943 2240 1601 2479 -10027 4 2 0 1 471 248 2539 2674 -10028 4 2 0 1 1995 2467 1627 2484 -10029 4 2 0 1 874 2462 1803 2553 -10030 4 2 0 1 1914 2229 1497 2640 -10031 4 2 0 1 1745 1646 2179 2522 -10032 4 2 0 1 1607 2197 2009 2250 -10033 4 2 0 1 1809 2196 1655 2433 -10034 4 2 0 1 1719 2289 1623 2629 -10035 4 2 0 1 1560 2245 2199 2707 -10036 4 2 0 1 1864 2541 1746 2768 -10037 4 2 0 1 445 1847 411 2366 -10038 4 2 0 1 1527 2311 2116 2527 -10039 4 2 0 1 314 182 300 2211 -10040 4 2 0 1 1038 1078 1102 2564 -10041 4 2 0 1 1883 1959 1710 2828 -10042 4 2 0 1 1916 2093 1782 2693 -10043 4 2 0 1 1541 2011 2520 2521 -10044 4 2 0 1 1869 1972 1652 2282 -10045 4 2 0 1 1278 2117 2178 2785 -10046 4 2 0 1 1833 2088 1659 2653 -10047 4 2 0 1 828 153 2115 2186 -10048 4 2 0 1 2195 2303 1840 2442 -10049 4 2 0 1 1552 1989 2103 2482 -10050 4 2 0 1 690 801 814 2028 -10051 4 2 0 1 1696 2177 1764 2361 -10052 4 2 0 1 574 623 1884 2530 -10053 4 2 0 1 1719 1623 2289 2551 -10054 4 2 0 1 1599 1999 2048 2160 -10055 4 2 0 1 618 664 2212 2687 -10056 4 2 0 1 984 2365 1889 2589 -10057 4 2 0 1 1613 2110 2037 2487 -10058 4 2 0 1 863 906 894 2184 -10059 4 2 0 1 2403 2426 1849 2628 -10060 4 2 0 1 1229 1337 2033 2667 -10061 4 2 0 1 1084 1171 1086 2594 -10062 4 2 0 1 1950 2433 2154 2450 -10063 4 2 0 1 1346 2337 1834 2737 -10064 4 2 0 1 1542 2100 2093 2360 -10065 4 2 0 1 1597 2150 1833 2688 -10066 4 2 0 1 1180 2021 2229 2563 -10067 4 2 0 1 984 884 888 2589 -10068 4 2 0 1 1944 2462 1803 2720 -10069 4 2 0 1 1323 2467 1995 2484 -10070 4 2 0 1 2198 2215 1536 2272 -10071 4 2 0 1 1663 2342 2026 2507 -10072 4 2 0 1 1780 2322 1974 2783 -10073 4 2 0 1 810 1957 766 2307 -10074 4 2 0 1 1171 2594 1084 2603 -10075 4 2 0 1 1799 2367 1973 2587 -10076 4 2 0 1 1601 1806 2418 2673 -10077 4 2 0 1 1571 2204 1890 2634 -10078 4 2 0 1 1547 1869 2250 2282 -10079 4 2 0 1 1800 2490 2409 2826 -10080 4 2 0 1 1245 2455 1178 2737 -10081 4 2 0 1 2163 2702 1811 2816 -10082 4 2 0 1 1984 2197 622 2408 -10083 4 2 0 1 1543 1848 2412 2792 -10084 4 2 0 1 1486 2278 1519 2696 -10085 4 2 0 1 1827 2172 1534 2700 -10086 4 2 0 1 1789 2269 2130 2748 -10087 4 2 0 1 1643 2426 2109 2628 -10088 4 2 0 1 1703 2000 2466 2616 -10089 4 2 0 1 639 657 1828 2812 -10090 4 2 0 1 1061 1053 1025 2339 -10091 4 2 0 1 1215 1323 2475 2484 -10092 4 2 0 1 1542 2093 2100 2693 -10093 4 2 0 1 544 548 593 2069 -10094 4 2 0 1 1221 2531 1731 2720 -10095 4 2 0 1 1612 2033 2370 2667 -10096 4 2 0 1 1561 2011 2396 2599 -10097 4 2 0 1 2103 2296 1684 2675 -10098 4 2 0 1 1621 2204 1890 2451 -10099 4 2 0 1 216 1823 2395 2554 -10100 4 2 0 1 1957 2316 1582 2816 -10101 4 2 0 1 2141 2175 1652 2728 -10102 4 2 0 1 142 141 826 1955 -10103 4 2 0 1 255 395 2297 2438 -10104 4 2 0 1 142 1955 826 2732 -10105 4 2 0 1 2158 2188 1624 2511 -10106 4 2 0 1 600 2393 615 2663 -10107 4 2 0 1 274 250 483 2086 -10108 4 2 0 1 1990 2606 253 2694 -10109 4 2 0 1 1990 1677 2344 2745 -10110 4 2 0 1 1851 2466 1703 2487 -10111 4 2 0 1 1099 1049 1071 1787 -10112 4 2 0 1 1548 2096 2254 2636 -10113 4 2 0 1 1941 2121 1744 2465 -10114 4 2 0 1 1472 1497 1914 2229 -10115 4 2 0 1 428 184 437 2297 -10116 4 2 0 1 1773 2063 1666 2249 -10117 4 2 0 1 1744 2510 2121 2794 -10118 4 2 0 1 1091 1746 1017 2543 -10119 4 2 0 1 1549 2544 2414 2716 -10120 4 2 0 1 1682 2168 1900 2364 -10121 4 2 0 1 1557 2058 1795 2681 -10122 4 2 0 1 1837 2094 1705 2620 -10123 4 2 0 1 1358 1331 2076 2301 -10124 4 2 0 1 1649 2066 1816 2332 -10125 4 2 0 1 1747 2145 2027 2447 -10126 4 2 0 1 1578 2124 1905 2727 -10127 4 2 0 1 1556 2016 1922 2664 -10128 4 2 0 1 463 171 436 1977 -10129 4 2 0 1 1727 1866 2396 2573 -10130 4 2 0 1 1654 1944 1805 2383 -10131 4 2 0 1 1582 2149 1877 2426 -10132 4 2 0 1 1731 2261 2105 2534 -10133 4 2 0 1 418 391 181 2713 -10134 4 2 0 1 1833 2430 2150 2682 -10135 4 2 0 1 1546 2061 1919 2650 -10136 4 2 0 1 1548 2096 2224 2708 -10137 4 2 0 1 1880 2354 1747 2447 -10138 4 2 0 1 1653 1799 2272 2587 -10139 4 2 0 1 1871 2164 1779 2808 -10140 4 2 0 1 1858 2008 1906 2801 -10141 4 2 0 1 531 655 681 2192 -10142 4 2 0 1 1272 1260 1204 2177 -10143 4 2 0 1 773 743 720 1993 -10144 4 2 0 1 1728 2226 1886 2627 -10145 4 2 0 1 1790 2444 2155 2542 -10146 4 2 0 1 1530 2354 1880 2447 -10147 4 2 0 1 1116 132 133 2350 -10148 4 2 0 1 1625 2214 1807 2413 -10149 4 2 0 1 221 378 359 2683 -10150 4 2 0 1 1622 2087 1924 2358 -10151 4 2 0 1 1727 2396 1866 2654 -10152 4 2 0 1 1596 1990 1967 2606 -10153 4 2 0 1 869 2251 1894 2514 -10154 4 2 0 1 259 254 2124 2457 -10155 4 2 0 1 1926 2320 2018 2788 -10156 4 2 0 1 1432 1906 1448 2780 -10157 4 2 0 1 1617 2238 2060 2368 -10158 4 2 0 1 1637 1758 2132 2393 -10159 4 2 0 1 1689 2112 1866 2427 -10160 4 2 0 1 1735 2419 2264 2435 -10161 4 2 0 1 420 1965 1861 2438 -10162 4 2 0 1 564 2350 648 2830 -10163 4 2 0 1 1040 1060 1109 2406 -10164 4 2 0 1 1151 161 1057 2416 -10165 4 2 0 1 350 183 2153 2639 -10166 4 2 0 1 1014 935 2461 2589 -10167 4 2 0 1 1930 2535 1658 2565 -10168 4 2 0 1 1764 2361 2051 2822 -10169 4 2 0 1 734 196 844 527 -10170 4 2 0 1 253 279 1990 2694 -10171 4 2 0 1 1711 1853 2075 2817 -10172 4 2 0 1 1643 1849 2338 2685 -10173 4 2 0 1 1477 1460 1476 1937 -10174 4 2 0 1 1979 2092 1658 2336 -10175 4 2 0 1 1242 2094 1489 2387 -10176 4 2 0 1 1488 845 737 2087 -10177 4 2 0 1 1789 1557 2228 2613 -10178 4 2 0 1 1638 2044 1922 2512 -10179 4 2 0 1 1757 2186 1826 2363 -10180 4 2 0 1 952 2287 901 2715 -10181 4 2 0 1 901 898 957 2070 -10182 4 2 0 1 1494 2135 2051 2722 -10183 4 2 0 1 1531 2003 1940 2368 -10184 4 2 0 1 1749 1974 2351 2615 -10185 4 2 0 1 1689 1783 2348 2652 -10186 4 2 0 1 1837 2511 1741 2781 -10187 4 2 0 1 1197 2442 1909 2551 -10188 4 2 0 1 1627 2235 2024 2526 -10189 4 2 0 1 1555 2608 1936 2736 -10190 4 2 0 1 949 2073 880 2637 -10191 4 2 0 1 1715 1960 2003 2478 -10192 4 2 0 1 1643 1849 2426 2628 -10193 4 2 0 1 2078 2102 1712 2765 -10194 4 2 0 1 1549 2039 2544 2600 -10195 4 2 0 1 927 1894 869 2251 -10196 4 2 0 1 1004 962 1832 2588 -10197 4 2 0 1 1614 2172 1827 2537 -10198 4 2 0 1 1338 1420 1195 2018 -10199 4 2 0 1 684 2359 1725 2569 -10200 4 2 0 1 511 1849 505 2567 -10201 4 2 0 1 1955 2457 1674 2705 -10202 4 2 0 1 1972 2282 1869 2777 -10203 4 2 0 1 1624 1797 2301 2625 -10204 4 2 0 1 1843 2389 2023 2832 -10205 4 2 0 1 586 608 2330 2761 -10206 4 2 0 1 597 2256 662 2672 -10207 4 2 0 1 1822 2555 1881 2643 -10208 4 2 0 1 532 1934 635 2536 -10209 4 2 0 1 1616 2022 2291 2648 -10210 4 2 0 1 1604 2210 1921 2459 -10211 4 2 0 1 1346 2201 1247 2337 -10212 4 2 0 1 277 464 821 1993 -10213 4 2 0 1 367 389 211 2097 -10214 4 2 0 1 410 177 499 1965 -10215 4 2 0 1 1603 1927 1829 2464 -10216 4 2 0 1 563 628 574 2456 -10217 4 2 0 1 1590 1969 2593 2807 -10218 4 2 0 1 1516 1453 1220 2301 -10219 4 2 0 1 442 238 404 2556 -10220 4 2 0 1 428 437 1897 2297 -10221 4 2 0 1 849 781 764 1936 -10222 4 2 0 1 1637 2194 1758 2749 -10223 4 2 0 1 213 320 406 2020 -10224 4 2 0 1 443 2185 188 2333 -10225 4 2 0 1 1543 2726 2040 2757 -10226 4 2 0 1 1580 2615 2051 2718 -10227 4 2 0 1 2116 2311 1739 2527 -10228 4 2 0 1 1061 1117 1053 2522 -10229 4 2 0 1 256 2185 335 2200 -10230 4 2 0 1 179 407 1875 2097 -10231 4 2 0 1 1503 1183 1810 2557 -10232 4 2 0 1 563 140 1955 2456 -10233 4 2 0 1 771 745 2436 2714 -10234 4 2 0 1 263 715 740 2217 -10235 4 2 0 1 1816 2525 2030 2776 -10236 4 2 0 1 502 244 362 2049 -10237 4 2 0 1 1830 2308 1782 2693 -10238 4 2 0 1 1942 1740 2347 2677 -10239 4 2 0 1 2203 2363 1826 2784 -10240 4 2 0 1 1486 2640 1707 2696 -10241 4 2 0 1 1172 1154 1930 2565 -10242 4 2 0 1 1564 2118 1880 2701 -10243 4 2 0 1 1723 2478 2128 2503 -10244 4 2 0 1 1890 1991 1685 2684 -10245 4 2 0 1 535 1984 579 2419 -10246 4 2 0 1 772 700 2041 2375 -10247 4 2 0 1 612 617 625 2344 -10248 4 2 0 1 340 2323 1850 2614 -10249 4 2 0 1 1469 1300 1453 2301 -10250 4 2 0 1 2258 2150 2538 2688 -10251 4 2 0 1 1912 2235 1604 2283 -10252 4 2 0 1 601 1841 603 2761 -10253 4 2 0 1 924 2125 1907 2553 -10254 4 2 0 1 383 2525 1816 2776 -10255 4 2 0 1 1669 1844 2257 2290 -10256 4 2 0 1 1620 2201 1834 2337 -10257 4 2 0 1 1543 2578 2040 2726 -10258 4 2 0 1 1843 2221 1534 2292 -10259 4 2 0 1 1706 2036 1821 2655 -10260 4 2 0 1 1811 2149 1867 2611 -10261 4 2 0 1 1854 2234 1642 2515 -10262 4 2 0 1 1597 1856 2065 2306 -10263 4 2 0 1 198 140 668 2456 -10264 4 2 0 1 1747 2145 2074 2332 -10265 4 2 0 1 1689 2654 2220 2743 -10266 4 2 0 1 1593 2612 2107 2689 -10267 4 2 0 1 1651 2493 1824 2704 -10268 4 2 0 1 2100 2161 1662 2360 -10269 4 2 0 1 1216 1954 1347 2655 -10270 4 2 0 1 1364 1184 1437 2342 -10271 4 2 0 1 947 929 867 2280 -10272 4 2 0 1 175 2404 2066 2674 -10273 4 2 0 1 953 2523 892 2637 -10274 4 2 0 1 589 2393 2132 2469 -10275 4 2 0 1 1602 2437 2164 2698 -10276 4 2 0 1 1212 2420 2133 2668 -10277 4 2 0 1 1247 1399 1362 2337 -10278 4 2 0 1 1696 2361 2055 2784 -10279 4 2 0 1 133 2350 1960 2503 -10280 4 2 0 1 1468 1518 1460 1984 -10281 4 2 0 1 568 618 613 2345 -10282 4 2 0 1 1805 1302 2531 2668 -10283 4 2 0 1 1869 1652 2250 2282 -10284 4 2 0 1 1207 1476 643 1937 -10285 4 2 0 1 1532 2154 1891 2546 -10286 4 2 0 1 1125 1088 1103 2414 -10287 4 2 0 1 1586 2309 2300 2369 -10288 4 2 0 1 333 381 218 2207 -10289 4 2 0 1 1872 1624 2287 2715 -10290 4 2 0 1 1277 1976 1248 2442 -10291 4 2 0 1 932 927 2251 2421 -10292 4 2 0 1 1475 1320 1367 1944 -10293 4 2 0 1 899 863 894 1781 -10294 4 2 0 1 1753 1920 2334 2829 -10295 4 2 0 1 1614 1827 2182 2537 -10296 4 2 0 1 550 638 545 2260 -10297 4 2 0 1 915 874 919 2462 -10298 4 2 0 1 932 2251 1873 2421 -10299 4 2 0 1 1936 2608 1769 2736 -10300 4 2 0 1 1609 2091 1976 2442 -10301 4 2 0 1 1608 1986 1998 2476 -10302 4 2 0 1 1517 2342 2026 2724 -10303 4 2 0 1 864 2494 891 2495 -10304 4 2 0 1 1558 1822 2145 2502 -10305 4 2 0 1 914 1961 970 2107 -10306 4 2 0 1 1705 2094 2226 2760 -10307 4 2 0 1 1561 1818 2112 2572 -10308 4 2 0 1 1438 2289 1236 2551 -10309 4 2 0 1 905 982 998 2477 -10310 4 2 0 1 1980 2590 2237 2633 -10311 4 2 0 1 1080 1930 1154 2713 -10312 4 2 0 1 1878 1598 2252 2440 -10313 4 2 0 1 2104 2206 1639 2782 -10314 4 2 0 1 1377 1297 1214 2512 -10315 4 2 0 1 1930 2349 1172 2565 -10316 4 2 0 1 695 2375 1860 2649 -10317 4 2 0 1 1817 2125 2553 2778 -10318 4 2 0 1 1592 2256 2046 2321 -10319 4 2 0 1 313 292 201 2298 -10320 4 2 0 1 1590 1835 2364 2593 -10321 4 2 0 1 1816 1718 2502 2635 -10322 4 2 0 1 1581 2145 2717 2772 -10323 4 2 0 1 976 151 1946 2523 -10324 4 2 0 1 907 863 886 2081 -10325 4 2 0 1 1541 2310 1865 2521 -10326 4 2 0 1 1614 2035 1929 2172 -10327 4 2 0 1 2050 2572 2454 2746 -10328 4 2 0 1 1463 1478 1181 1994 -10329 4 2 0 1 1147 1119 1077 2056 -10330 4 2 0 1 298 2211 322 2397 -10331 4 2 0 1 2039 2505 1660 2600 -10332 4 2 0 1 1169 1160 2119 2769 -10333 4 2 0 1 297 2030 219 2525 -10334 4 2 0 1 634 603 601 2321 -10335 4 2 0 1 1816 2066 1649 2525 -10336 4 2 0 1 633 641 2256 2321 -10337 4 2 0 1 1222 2247 1798 2763 -10338 4 2 0 1 1000 1790 922 2695 -10339 4 2 0 1 339 2156 1947 2683 -10340 4 2 0 1 1768 2293 2517 2607 -10341 4 2 0 1 1588 1779 2088 2430 -10342 4 2 0 1 747 837 751 2068 -10343 4 2 0 1 653 2212 1726 2283 -10344 4 2 0 1 1645 1887 2386 2600 -10345 4 2 0 1 1612 2033 1808 2834 -10346 4 2 0 1 1786 1604 2283 2753 -10347 4 2 0 1 1932 1657 2449 2838 -10348 4 2 0 1 1141 1148 2410 2777 -10349 4 2 0 1 962 2248 1832 2588 -10350 4 2 0 1 1572 2012 1857 2515 -10351 4 2 0 1 1619 2149 1877 2153 -10352 4 2 0 1 1579 2094 1798 2760 -10353 4 2 0 1 1557 1789 2357 2613 -10354 4 2 0 1 315 220 354 2123 -10355 4 2 0 1 1551 2341 1765 2702 -10356 4 2 0 1 1633 1992 1893 2245 -10357 4 2 0 1 1431 2132 561 2294 -10358 4 2 0 1 1202 1139 1478 1994 -10359 4 2 0 1 1072 1132 1050 2626 -10360 4 2 0 1 1591 1895 2123 2489 -10361 4 2 0 1 535 579 578 2419 -10362 4 2 0 1 1184 1437 2342 2724 -10363 4 2 0 1 1529 2244 2006 2656 -10364 4 2 0 1 1636 2072 1935 2247 -10365 4 2 0 1 1437 1184 1280 2724 -10366 4 2 0 1 570 660 682 2497 -10367 4 2 0 1 177 379 1965 2791 -10368 4 2 0 1 418 181 349 2559 -10369 4 2 0 1 232 440 2196 2328 -10370 4 2 0 1 1831 2256 1700 2569 -10371 4 2 0 1 2037 2370 1692 2783 -10372 4 2 0 1 1348 1339 1298 2383 -10373 4 2 0 1 1648 1860 2161 2360 -10374 4 2 0 1 2297 2330 184 2694 -10375 4 2 0 1 1297 1922 1349 2044 -10376 4 2 0 1 2125 2428 1667 2562 -10377 4 2 0 1 1671 2112 1818 2798 -10378 4 2 0 1 1807 2082 1570 2318 -10379 4 2 0 1 1596 2350 2128 2503 -10380 4 2 0 1 219 2525 2030 2744 -10381 4 2 0 1 1591 2123 1939 2489 -10382 4 2 0 1 2149 2352 1619 2431 -10383 4 2 0 1 1719 2148 2275 2318 -10384 4 2 0 1 1277 1261 1500 1840 -10385 4 2 0 1 1605 1989 1882 2575 -10386 4 2 0 1 1756 2025 1964 2792 -10387 4 2 0 1 2087 2485 1622 2666 -10388 4 2 0 1 1680 2450 1884 2802 -10389 4 2 0 1 161 1929 1057 2416 -10390 4 2 0 1 1082 1126 1137 2570 -10391 4 2 0 1 1747 2547 1917 2762 -10392 4 2 0 1 2271 2334 1791 2504 -10393 4 2 0 1 2156 2268 1631 2269 -10394 4 2 0 1 1764 1696 2361 2822 -10395 4 2 0 1 1123 1137 1087 2570 -10396 4 2 0 1 264 2338 284 2685 -10397 4 2 0 1 751 707 747 2068 -10398 4 2 0 1 1750 2538 2308 2688 -10399 4 2 0 1 1696 1764 2177 2822 -10400 4 2 0 1 1333 1857 1303 2284 -10401 4 2 0 1 652 135 1972 2410 -10402 4 2 0 1 1601 1806 2227 2418 -10403 4 2 0 1 215 1847 445 2366 -10404 4 2 0 1 1617 2238 1836 2282 -10405 4 2 0 1 673 681 661 2246 -10406 4 2 0 1 1828 2053 665 2725 -10407 4 2 0 1 1565 1998 1986 2234 -10408 4 2 0 1 1682 2311 2038 2482 -10409 4 2 0 1 994 1012 2155 2327 -10410 4 2 0 1 1779 2164 2088 2809 -10411 4 2 0 1 1805 2254 1654 2383 -10412 4 2 0 1 297 182 306 2030 -10413 4 2 0 1 1719 2551 1909 2629 -10414 4 2 0 1 1910 2218 1673 2681 -10415 4 2 0 1 423 512 424 2225 -10416 4 2 0 1 216 424 1823 2554 -10417 4 2 0 1 1830 2506 2308 2693 -10418 4 2 0 1 269 501 736 2217 -10419 4 2 0 1 1620 2337 1834 2396 -10420 4 2 0 1 2058 2228 1795 2621 -10421 4 2 0 1 375 2468 427 2571 -10422 4 2 0 1 1796 2372 1693 2577 -10423 4 2 0 1 1617 1836 2175 2282 -10424 4 2 0 1 349 252 1930 2349 -10425 4 2 0 1 1256 2146 1516 2278 -10426 4 2 0 1 1776 2045 2014 2717 -10427 4 2 0 1 1863 2570 2384 2817 -10428 4 2 0 1 1769 2631 1467 2780 -10429 4 2 0 1 1884 2450 2345 2802 -10430 4 2 0 1 968 1013 980 2165 -10431 4 2 0 1 2293 2353 1722 2607 -10432 4 2 0 1 1839 2363 2203 2784 -10433 4 2 0 1 1150 1085 1031 2170 -10434 4 2 0 1 400 1809 460 2661 -10435 4 2 0 1 2100 2377 1650 2443 -10436 4 2 0 1 1022 1065 1069 2424 -10437 4 2 0 1 2071 2438 1644 2756 -10438 4 2 0 1 1197 1840 2442 2551 -10439 4 2 0 1 1621 2203 2089 2363 -10440 4 2 0 1 1716 2490 1800 2826 -10441 4 2 0 1 1211 907 886 2081 -10442 4 2 0 1 1851 2466 1966 2836 -10443 4 2 0 1 1642 1906 2263 2711 -10444 4 2 0 1 550 2260 545 2400 -10445 4 2 0 1 639 1828 657 2725 -10446 4 2 0 1 1589 2302 2133 2788 -10447 4 2 0 1 1554 1808 2392 2834 -10448 4 2 0 1 1949 2198 1536 2272 -10449 4 2 0 1 376 350 2539 2639 -10450 4 2 0 1 1559 1793 2331 2731 -10451 4 2 0 1 1788 2475 1627 2811 -10452 4 2 0 1 319 212 1939 2353 -10453 4 2 0 1 1414 1437 1280 2053 -10454 4 2 0 1 1410 2442 2091 2721 -10455 4 2 0 1 574 554 623 2530 -10456 4 2 0 1 1261 1278 1206 2586 -10457 4 2 0 1 230 444 262 1877 -10458 4 2 0 1 962 2248 964 2365 -10459 4 2 0 1 1821 2415 1706 2655 -10460 4 2 0 1 573 565 537 1995 -10461 4 2 0 1 1650 2506 2372 2693 -10462 4 2 0 1 1660 2060 2491 2733 -10463 4 2 0 1 869 2101 2251 2514 -10464 4 2 0 1 2000 2466 1613 2487 -10465 4 2 0 1 1445 1391 1356 2247 -10466 4 2 0 1 1700 2256 1868 2672 -10467 4 2 0 1 1656 1853 2083 2578 -10468 4 2 0 1 1396 1419 1909 2721 -10469 4 2 0 1 976 892 953 2523 -10470 4 2 0 1 1668 2399 2020 2472 -10471 4 2 0 1 1738 1919 2061 2650 -10472 4 2 0 1 1734 2313 2141 2723 -10473 4 2 0 1 1542 1923 2079 2305 -10474 4 2 0 1 1750 2258 2538 2688 -10475 4 2 0 1 1686 2448 2092 2516 -10476 4 2 0 1 415 462 1861 2185 -10477 4 2 0 1 1705 1951 2627 2833 -10478 4 2 0 1 1358 1300 1331 2301 -10479 4 2 0 1 1773 2214 2019 2675 -10480 4 2 0 1 1469 1453 2146 2301 -10481 4 2 0 1 1676 1859 2005 2699 -10482 4 2 0 1 1656 1925 2083 2216 -10483 4 2 0 1 2013 2324 1834 2746 -10484 4 2 0 1 697 2087 785 2666 -10485 4 2 0 1 463 171 1977 2567 -10486 4 2 0 1 1234 1373 1392 2358 -10487 4 2 0 1 1242 1352 2094 2387 -10488 4 2 0 1 1695 2002 1997 2741 -10489 4 2 0 1 1627 2371 2235 2526 -10490 4 2 0 1 1672 2102 2001 2302 -10491 4 2 0 1 1538 2460 2102 2794 -10492 4 2 0 1 1049 2339 1787 2804 -10493 4 2 0 1 1241 1908 2485 2780 -10494 4 2 0 1 749 821 1993 2498 -10495 4 2 0 1 1644 2020 1897 2756 -10496 4 2 0 1 1873 2382 2421 2738 -10497 4 2 0 1 362 1847 2049 2494 -10498 4 2 0 1 777 2316 850 2498 -10499 4 2 0 1 1684 2103 1989 2482 -10500 4 2 0 1 1773 2249 1666 2440 -10501 4 2 0 1 1241 1470 1479 2379 -10502 4 2 0 1 1628 2152 2261 2534 -10503 4 2 0 1 913 2081 937 2233 -10504 4 2 0 1 764 781 700 1936 -10505 4 2 0 1 1350 1467 2379 2631 -10506 4 2 0 1 1803 2462 1907 2553 -10507 4 2 0 1 551 2393 2069 2663 -10508 4 2 0 1 665 651 591 2053 -10509 4 2 0 1 2050 2220 1706 2415 -10510 4 2 0 1 2051 2361 1696 2822 -10511 4 2 0 1 427 2468 2097 2571 -10512 4 2 0 1 1942 2347 1991 2677 -10513 4 2 0 1 557 608 621 2330 -10514 4 2 0 1 461 179 407 1875 -10515 4 2 0 1 313 292 2298 2353 -10516 4 2 0 1 1565 1986 1892 2783 -10517 4 2 0 1 1222 2007 2247 2763 -10518 4 2 0 1 708 817 796 2596 -10519 4 2 0 1 1847 2101 1600 2495 -10520 4 2 0 1 1575 1975 1846 2570 -10521 4 2 0 1 1955 2456 2277 2457 -10522 4 2 0 1 391 2559 181 2713 -10523 4 2 0 1 1825 2192 1766 2663 -10524 4 2 0 1 1033 1126 1082 1863 -10525 4 2 0 1 1893 1992 1620 2245 -10526 4 2 0 1 1707 2346 2140 2696 -10527 4 2 0 1 585 1937 558 2408 -10528 4 2 0 1 1696 1771 2670 2742 -10529 4 2 0 1 568 618 2345 2687 -10530 4 2 0 1 2087 2358 1622 2485 -10531 4 2 0 1 1881 2120 788 2732 -10532 4 2 0 1 1943 1971 2402 2411 -10533 4 2 0 1 1585 2447 1958 2750 -10534 4 2 0 1 703 761 855 2316 -10535 4 2 0 1 1635 2121 1966 2566 -10536 4 2 0 1 1148 2733 2410 2777 -10537 4 2 0 1 1832 2129 1599 2365 -10538 4 2 0 1 1811 1551 2163 2611 -10539 4 2 0 1 833 854 714 2649 -10540 4 2 0 1 1604 1912 2281 2371 -10541 4 2 0 1 1967 1596 2606 2752 -10542 4 2 0 1 1832 2073 1999 2129 -10543 4 2 0 1 461 1875 240 2612 -10544 4 2 0 1 1796 2213 1530 2447 -10545 4 2 0 1 1573 2496 1956 2759 -10546 4 2 0 1 1624 2076 2254 2511 -10547 4 2 0 1 1881 2555 1648 2643 -10548 4 2 0 1 1827 2227 1673 2335 -10549 4 2 0 1 331 204 2647 2744 -10550 4 2 0 1 2133 2531 1589 2788 -10551 4 2 0 1 1628 2299 2081 2592 -10552 4 2 0 1 301 1997 338 2605 -10553 4 2 0 1 315 313 2123 2353 -10554 4 2 0 1 236 394 259 2397 -10555 4 2 0 1 1564 1859 2352 2699 -10556 4 2 0 1 2152 2534 1628 2592 -10557 4 2 0 1 1935 2072 1798 2247 -10558 4 2 0 1 1724 2385 2152 2644 -10559 4 2 0 1 1714 2152 2616 2834 -10560 4 2 0 1 1772 1636 2326 2747 -10561 4 2 0 1 1819 2394 1603 2764 -10562 4 2 0 1 1726 1794 2425 2497 -10563 4 2 0 1 1447 1398 579 1460 -10564 4 2 0 1 719 742 774 2722 -10565 4 2 0 1 1554 2177 2592 2742 -10566 4 2 0 1 1890 2451 2034 2634 -10567 4 2 0 1 1488 1428 1499 2131 -10568 4 2 0 1 1597 2065 1856 2401 -10569 4 2 0 1 1633 1992 2245 2340 -10570 4 2 0 1 1454 1190 1276 2513 -10571 4 2 0 1 287 970 276 2107 -10572 4 2 0 1 606 1786 2212 2283 -10573 4 2 0 1 341 326 1978 2559 -10574 4 2 0 1 1823 2225 424 2516 -10575 4 2 0 1 2362 2680 1631 2748 -10576 4 2 0 1 2141 2193 1704 2313 -10577 4 2 0 1 1946 2209 1643 2685 -10578 4 2 0 1 144 2212 841 2638 -10579 4 2 0 1 1755 2511 1837 2781 -10580 4 2 0 1 1464 1415 1465 1803 -10581 4 2 0 1 1569 1902 2237 2490 -10582 4 2 0 1 1391 2247 1445 2326 -10583 4 2 0 1 2069 2206 1828 2725 -10584 4 2 0 1 641 619 2256 2321 -10585 4 2 0 1 1594 1919 2134 2483 -10586 4 2 0 1 1976 2303 2195 2442 -10587 4 2 0 1 1512 1260 1194 2177 -10588 4 2 0 1 1144 2274 2064 2458 -10589 4 2 0 1 1885 1565 2234 2801 -10590 4 2 0 1 1771 2361 1696 2784 -10591 4 2 0 1 370 2030 306 2744 -10592 4 2 0 1 682 2425 145 2497 -10593 4 2 0 1 1631 2680 2156 2795 -10594 4 2 0 1 1097 1026 1073 1914 -10595 4 2 0 1 2007 1772 2318 2767 -10596 4 2 0 1 1622 1776 2329 2375 -10597 4 2 0 1 775 1881 788 2508 -10598 4 2 0 1 540 615 600 2393 -10599 4 2 0 1 858 925 1002 2588 -10600 4 2 0 1 1717 2214 1963 2820 -10601 4 2 0 1 1565 1892 2665 2783 -10602 4 2 0 1 1572 1865 2310 2712 -10603 4 2 0 1 1746 2406 1864 2768 -10604 4 2 0 1 277 1993 821 2498 -10605 4 2 0 1 1776 2649 2253 2717 -10606 4 2 0 1 166 893 165 2278 -10607 4 2 0 1 1783 1750 2348 2538 -10608 4 2 0 1 1569 2590 1980 2633 -10609 4 2 0 1 1795 2006 2108 2681 -10610 4 2 0 1 1128 1021 2140 2274 -10611 4 2 0 1 370 306 204 2744 -10612 4 2 0 1 315 2123 212 2353 -10613 4 2 0 1 1142 1927 1052 2394 -10614 4 2 0 1 1342 1306 1353 2512 -10615 4 2 0 1 2308 2506 1782 2693 -10616 4 2 0 1 606 559 1786 2283 -10617 4 2 0 1 2159 2376 1767 2807 -10618 4 2 0 1 1596 1960 1815 2350 -10619 4 2 0 1 237 2409 2641 2826 -10620 4 2 0 1 1546 2650 1898 2771 -10621 4 2 0 1 379 469 420 1861 -10622 4 2 0 1 1588 2067 1871 2343 -10623 4 2 0 1 1722 2517 2293 2607 -10624 4 2 0 1 2051 2135 1269 2822 -10625 4 2 0 1 2089 2363 1535 2439 -10626 4 2 0 1 1655 1809 2433 2533 -10627 4 2 0 1 1570 1886 2291 2540 -10628 4 2 0 1 646 2009 605 2169 -10629 4 2 0 1 1363 1354 1235 2342 -10630 4 2 0 1 1181 1466 1115 1478 -10631 4 2 0 1 1097 1914 1110 2346 -10632 4 2 0 1 1747 2213 2145 2447 -10633 4 2 0 1 1534 2172 1910 2189 -10634 4 2 0 1 1064 1053 2264 2339 -10635 4 2 0 1 1606 1979 1930 2535 -10636 4 2 0 1 132 2350 2128 2830 -10637 4 2 0 1 557 279 189 2330 -10638 4 2 0 1 1690 2267 1765 2702 -10639 4 2 0 1 1525 1514 843 2135 -10640 4 2 0 1 944 2382 960 2734 -10641 4 2 0 1 1747 2354 2213 2447 -10642 4 2 0 1 1486 1256 1519 2278 -10643 4 2 0 1 1656 2083 1925 2726 -10644 4 2 0 1 1154 1037 1031 2565 -10645 4 2 0 1 2376 2676 1767 2807 -10646 4 2 0 1 1599 1999 1832 2486 -10647 4 2 0 1 2130 2269 1896 2748 -10648 4 2 0 1 482 421 478 2049 -10649 4 2 0 1 2051 2615 1580 2754 -10650 4 2 0 1 1607 1984 2197 2500 -10651 4 2 0 1 545 638 594 2260 -10652 4 2 0 1 662 2569 549 2672 -10653 4 2 0 1 1576 2043 1914 2095 -10654 4 2 0 1 2066 2332 1649 2341 -10655 4 2 0 1 845 724 737 2087 -10656 4 2 0 1 448 2086 461 2612 -10657 4 2 0 1 1463 1287 1292 2178 -10658 4 2 0 1 980 154 153 2115 -10659 4 2 0 1 1652 2236 1972 2390 -10660 4 2 0 1 464 741 720 2692 -10661 4 2 0 1 1712 2510 2320 2794 -10662 4 2 0 1 1805 2133 1589 2208 -10663 4 2 0 1 592 666 547 1831 -10664 4 2 0 1 1520 2184 2177 2822 -10665 4 2 0 1 1474 1382 904 2137 -10666 4 2 0 1 1612 2370 2016 2667 -10667 4 2 0 1 1467 2631 2513 2780 -10668 4 2 0 1 1456 2358 2087 2485 -10669 4 2 0 1 246 454 433 2498 -10670 4 2 0 1 1308 1299 2036 2655 -10671 4 2 0 1 1455 1255 2021 2387 -10672 4 2 0 1 1674 2120 1881 2732 -10673 4 2 0 1 137 671 2179 2777 -10674 4 2 0 1 1656 2151 2126 2648 -10675 4 2 0 1 1562 1841 2314 2380 -10676 4 2 0 1 1533 1932 1970 2270 -10677 4 2 0 1 2260 2569 1700 2672 -10678 4 2 0 1 483 2086 265 2612 -10679 4 2 0 1 1853 2126 1656 2151 -10680 4 2 0 1 1991 2099 1626 2596 -10681 4 2 0 1 1843 2221 1814 2673 -10682 4 2 0 1 1452 1803 1464 2462 -10683 4 2 0 1 1565 2136 1998 2729 -10684 4 2 0 1 1464 2499 1465 2775 -10685 4 2 0 1 1549 1840 2273 2617 -10686 4 2 0 1 1552 2166 2103 2575 -10687 4 2 0 1 1648 2643 1822 2717 -10688 4 2 0 1 1569 2237 2590 2633 -10689 4 2 0 1 1588 2164 1871 2632 -10690 4 2 0 1 161 2035 1929 2416 -10691 4 2 0 1 1804 2295 1777 2707 -10692 4 2 0 1 2040 2726 1795 2757 -10693 4 2 0 1 1578 1985 1905 2705 -10694 4 2 0 1 269 2217 736 2277 -10695 4 2 0 1 636 2587 646 2766 -10696 4 2 0 1 1831 2359 666 2569 -10697 4 2 0 1 1674 1881 2120 2705 -10698 4 2 0 1 1625 2413 1988 2806 -10699 4 2 0 1 762 824 2034 2451 -10700 4 2 0 1 1630 2139 1845 2706 -10701 4 2 0 1 1660 2060 2238 2368 -10702 4 2 0 1 796 752 2596 2677 -10703 4 2 0 1 1309 2668 1755 2740 -10704 4 2 0 1 1558 2145 1822 2643 -10705 4 2 0 1 1353 1418 1389 2322 -10706 4 2 0 1 1649 2341 2332 2762 -10707 4 2 0 1 2137 2287 1624 2715 -10708 4 2 0 1 600 2192 1825 2663 -10709 4 2 0 1 1538 1962 2078 2460 -10710 4 2 0 1 874 870 993 2462 -10711 4 2 0 1 1815 2350 2344 2745 -10712 4 2 0 1 1176 1084 2594 2603 -10713 4 2 0 1 1932 2449 2113 2623 -10714 4 2 0 1 1100 1060 1819 2709 -10715 4 2 0 1 1667 2061 1931 2771 -10716 4 2 0 1 701 710 771 2436 -10717 4 2 0 1 2189 2362 2219 2680 -10718 4 2 0 1 1345 2194 1375 2467 -10719 4 2 0 1 1946 2338 2209 2685 -10720 4 2 0 1 2145 2213 1796 2447 -10721 4 2 0 1 1628 1889 2152 2592 -10722 4 2 0 1 1593 2061 2319 2689 -10723 4 2 0 1 2009 2169 1652 2390 -10724 4 2 0 1 1487 2435 2419 2686 -10725 4 2 0 1 1895 2317 369 2679 -10726 4 2 0 1 684 1725 678 2569 -10727 4 2 0 1 1586 1962 1932 2583 -10728 4 2 0 1 1673 2335 2227 2656 -10729 4 2 0 1 370 297 306 2030 -10730 4 2 0 1 1590 2159 2002 2407 -10731 4 2 0 1 1821 2371 1627 2811 -10732 4 2 0 1 1257 1828 1289 2812 -10733 4 2 0 1 972 271 2101 2576 -10734 4 2 0 1 1746 2543 2406 2768 -10735 4 2 0 1 1272 1195 1259 1808 -10736 4 2 0 1 1697 2355 1915 2824 -10737 4 2 0 1 1220 1357 2137 2301 -10738 4 2 0 1 1915 1670 2147 2791 -10739 4 2 0 1 1683 2295 1804 2599 -10740 4 2 0 1 850 2144 755 2498 -10741 4 2 0 1 1920 2701 2334 2829 -10742 4 2 0 1 607 652 1972 2390 -10743 4 2 0 1 444 262 1877 2685 -10744 4 2 0 1 773 712 703 2403 -10745 4 2 0 1 1895 2023 1600 2317 -10746 4 2 0 1 1814 2224 1647 2480 -10747 4 2 0 1 1769 1908 2379 2736 -10748 4 2 0 1 2157 2222 289 2741 -10749 4 2 0 1 1903 1590 2002 2407 -10750 4 2 0 1 205 2005 373 2323 -10751 4 2 0 1 391 1913 326 2559 -10752 4 2 0 1 227 345 358 2489 -10753 4 2 0 1 351 208 2333 2574 -10754 4 2 0 1 2213 2354 1530 2447 -10755 4 2 0 1 1680 1884 2345 2802 -10756 4 2 0 1 1625 2214 2413 2813 -10757 4 2 0 1 1835 1552 2593 2799 -10758 4 2 0 1 1618 1828 2206 2725 -10759 4 2 0 1 1708 1661 2232 2563 -10760 4 2 0 1 1896 1695 2029 2519 -10761 4 2 0 1 1872 2241 1654 2383 -10762 4 2 0 1 1676 2005 1859 2669 -10763 4 2 0 1 1640 1959 1883 2828 -10764 4 2 0 1 1826 2186 1771 2784 -10765 4 2 0 1 1226 1316 1935 2420 -10766 4 2 0 1 1613 2037 2000 2487 -10767 4 2 0 1 1652 1972 1869 2390 -10768 4 2 0 1 2227 2800 1827 2839 -10769 4 2 0 1 2085 2418 1806 2673 -10770 4 2 0 1 2026 2198 1607 2724 -10771 4 2 0 1 1546 1919 2061 2483 -10772 4 2 0 1 1626 2513 2099 2608 -10773 4 2 0 1 1160 1082 1019 2384 -10774 4 2 0 1 476 1927 442 2424 -10775 4 2 0 1 1269 2051 1494 2135 -10776 4 2 0 1 1866 2112 1671 2427 -10777 4 2 0 1 1574 2526 1921 2811 -10778 4 2 0 1 923 1390 955 2057 -10779 4 2 0 1 2099 2596 1991 2677 -10780 4 2 0 1 1652 2175 1972 2728 -10781 4 2 0 1 1775 2075 1863 2384 -10782 4 2 0 1 1755 1805 2208 2668 -10783 4 2 0 1 2351 2665 1580 2754 -10784 4 2 0 1 1601 2479 2227 2839 -10785 4 2 0 1 1251 2615 2051 2835 -10786 4 2 0 1 308 1896 296 2624 -10787 4 2 0 1 1766 2496 2246 2697 -10788 4 2 0 1 1793 2129 2073 2637 -10789 4 2 0 1 1288 1199 1976 2435 -10790 4 2 0 1 1605 1882 2147 2735 -10791 4 2 0 1 1853 2660 2075 2817 -10792 4 2 0 1 1769 2513 2631 2780 -10793 4 2 0 1 635 2536 1934 2786 -10794 4 2 0 1 1789 2228 2058 2621 -10795 4 2 0 1 2008 2205 1749 2265 -10796 4 2 0 1 1650 2377 2100 2837 -10797 4 2 0 1 625 617 569 1815 -10798 4 2 0 1 597 674 530 1868 -10799 4 2 0 1 2078 2664 1844 2704 -10800 4 2 0 1 1739 2398 1856 2809 -10801 4 2 0 1 1762 2243 2148 2721 -10802 4 2 0 1 1656 2126 2548 2648 -10803 4 2 0 1 1698 2151 2181 2549 -10804 4 2 0 1 1669 1962 2290 2583 -10805 4 2 0 1 1950 2682 1659 2727 -10806 4 2 0 1 1149 1870 1176 2594 -10807 4 2 0 1 2000 2111 1613 2466 -10808 4 2 0 1 1560 2199 1804 2707 -10809 4 2 0 1 1605 2262 2355 2797 -10810 4 2 0 1 1946 1643 2338 2685 -10811 4 2 0 1 1557 1795 2108 2681 -10812 4 2 0 1 918 2514 879 2576 -10813 4 2 0 1 1222 2007 1356 2247 -10814 4 2 0 1 1066 1519 2278 2696 -10815 4 2 0 1 1492 1155 139 2264 -10816 4 2 0 1 2376 2528 1802 2807 -10817 4 2 0 1 535 622 1984 2197 -10818 4 2 0 1 232 2196 405 2328 -10819 4 2 0 1 2127 2155 1687 2327 -10820 4 2 0 1 1624 1797 2137 2301 -10821 4 2 0 1 415 417 2090 2662 -10822 4 2 0 1 1042 1029 2054 2488 -10823 4 2 0 1 2043 2458 1093 2518 -10824 4 2 0 1 212 315 363 2123 -10825 4 2 0 1 796 752 815 2596 -10826 4 2 0 1 1656 2548 2187 2648 -10827 4 2 0 1 1341 1228 1425 1992 -10828 4 2 0 1 1810 2615 2557 2718 -10829 4 2 0 1 1328 1330 1347 2194 -10830 4 2 0 1 1601 2227 1806 2673 -10831 4 2 0 1 1816 2066 1629 2332 -10832 4 2 0 1 844 149 721 2338 -10833 4 2 0 1 1929 2035 1614 2416 -10834 4 2 0 1 772 744 716 2041 -10835 4 2 0 1 607 556 686 2390 -10836 4 2 0 1 1951 2552 2474 2755 -10837 4 2 0 1 926 924 1011 2553 -10838 4 2 0 1 933 1889 984 2365 -10839 4 2 0 1 1059 1023 1054 2140 -10840 4 2 0 1 1851 1619 2237 2431 -10841 4 2 0 1 230 1877 262 2685 -10842 4 2 0 1 1631 2268 1947 2357 -10843 4 2 0 1 497 218 431 2359 -10844 4 2 0 1 1890 1621 2451 2634 -10845 4 2 0 1 1786 2443 1916 2802 -10846 4 2 0 1 1781 2081 2299 2592 -10847 4 2 0 1 537 565 576 1995 -10848 4 2 0 1 1747 2027 2145 2332 -10849 4 2 0 1 1645 2181 2151 2549 -10850 4 2 0 1 1448 1906 2263 2780 -10851 4 2 0 1 1017 1746 2458 2543 -10852 4 2 0 1 1895 2123 1694 2832 -10853 4 2 0 1 1441 1383 1974 2835 -10854 4 2 0 1 1022 1927 1065 2424 -10855 4 2 0 1 1396 1909 2442 2721 -10856 4 2 0 1 1649 2027 2030 2597 -10857 4 2 0 1 2040 2578 1795 2726 -10858 4 2 0 1 1121 1018 1175 2191 -10859 4 2 0 1 299 205 361 2005 -10860 4 2 0 1 2086 2097 1875 2319 -10861 4 2 0 1 916 947 2107 2280 -10862 4 2 0 1 1529 2006 1925 2312 -10863 4 2 0 1 775 788 730 2508 -10864 4 2 0 1 1586 1932 1970 2583 -10865 4 2 0 1 1345 1215 1821 2467 -10866 4 2 0 1 1555 2608 2347 2659 -10867 4 2 0 1 1024 2488 2422 2503 -10868 4 2 0 1 1527 2168 2295 2813 -10869 4 2 0 1 656 2169 2009 2390 -10870 4 2 0 1 2150 2258 1779 2688 -10871 4 2 0 1 1464 1803 2499 2775 -10872 4 2 0 1 1973 2246 596 2367 -10873 4 2 0 1 1757 2426 2403 2628 -10874 4 2 0 1 1330 1347 2194 2655 -10875 4 2 0 1 528 2606 253 2830 -10876 4 2 0 1 1585 2052 2242 2750 -10877 4 2 0 1 1627 1995 1912 2371 -10878 4 2 0 1 1771 1696 2055 2784 -10879 4 2 0 1 1811 2532 2204 2816 -10880 4 2 0 1 1435 1240 2275 2767 -10881 4 2 0 1 1532 1916 2154 2210 -10882 4 2 0 1 1072 1078 1132 1904 -10883 4 2 0 1 1690 2445 2144 2498 -10884 4 2 0 1 1956 2459 1783 2546 -10885 4 2 0 1 597 674 1868 2672 -10886 4 2 0 1 1666 2142 1887 2386 -10887 4 2 0 1 370 297 2030 2744 -10888 4 2 0 1 1327 2104 1954 2579 -10889 4 2 0 1 2173 2478 2128 2818 -10890 4 2 0 1 1926 1678 2102 2302 -10891 4 2 0 1 1934 1630 2192 2786 -10892 4 2 0 1 1581 2378 1822 2717 -10893 4 2 0 1 1260 1520 1204 2177 -10894 4 2 0 1 616 1912 555 2281 -10895 4 2 0 1 786 2403 1849 2628 -10896 4 2 0 1 551 2393 589 2469 -10897 4 2 0 1 1748 2287 2158 2382 -10898 4 2 0 1 1456 2485 2087 2666 -10899 4 2 0 1 299 328 183 2669 -10900 4 2 0 1 1758 2194 1954 2415 -10901 4 2 0 1 314 2397 2211 2815 -10902 4 2 0 1 353 403 2066 2525 -10903 4 2 0 1 1057 2394 1113 2709 -10904 4 2 0 1 152 2115 2109 2523 -10905 4 2 0 1 1177 1305 1442 2016 -10906 4 2 0 1 1671 2651 2116 2798 -10907 4 2 0 1 778 742 748 2690 -10908 4 2 0 1 1200 1207 680 2053 -10909 4 2 0 1 1708 2178 1661 2563 -10910 4 2 0 1 1738 2176 1919 2836 -10911 4 2 0 1 916 2107 875 2280 -10912 4 2 0 1 2246 2496 1618 2697 -10913 4 2 0 1 1407 1410 1396 2442 -10914 4 2 0 1 527 2338 844 2692 -10915 4 2 0 1 390 385 475 2407 -10916 4 2 0 1 1974 2322 1749 2351 -10917 4 2 0 1 1359 1231 1431 2132 -10918 4 2 0 1 1712 2078 1852 2460 -10919 4 2 0 1 1943 2285 1538 2470 -10920 4 2 0 1 1727 2042 2013 2654 -10921 4 2 0 1 1734 2193 2141 2313 -10922 4 2 0 1 1551 2341 1792 2762 -10923 4 2 0 1 932 860 963 1873 -10924 4 2 0 1 1301 2420 2668 2740 -10925 4 2 0 1 1108 2095 1171 2603 -10926 4 2 0 1 1633 2340 2245 2739 -10927 4 2 0 1 1997 2605 1983 2691 -10928 4 2 0 1 267 180 449 2826 -10929 4 2 0 1 1795 2621 2228 2757 -10930 4 2 0 1 1573 2010 2496 2697 -10931 4 2 0 1 1250 1914 1131 2581 -10932 4 2 0 1 1534 2189 1910 2362 -10933 4 2 0 1 1770 2147 2098 2604 -10934 4 2 0 1 2034 2451 1621 2634 -10935 4 2 0 1 1980 2590 2113 2838 -10936 4 2 0 1 1755 2668 2420 2740 -10937 4 2 0 1 774 2529 1810 2690 -10938 4 2 0 1 1655 2433 1950 2450 -10939 4 2 0 1 1742 2026 1968 2500 -10940 4 2 0 1 1636 1824 2381 2704 -10941 4 2 0 1 511 280 505 2692 -10942 4 2 0 1 570 2283 660 2497 -10943 4 2 0 1 1846 2202 1863 2570 -10944 4 2 0 1 489 506 2422 2818 -10945 4 2 0 1 2082 1719 2243 2629 -10946 4 2 0 1 1747 1953 2354 2547 -10947 4 2 0 1 1966 1980 1635 2566 -10948 4 2 0 1 2099 2513 1769 2608 -10949 4 2 0 1 231 468 831 2068 -10950 4 2 0 1 216 424 392 1823 -10951 4 2 0 1 766 1957 703 2403 -10952 4 2 0 1 377 2068 465 2106 -10953 4 2 0 1 1582 1811 2089 2816 -10954 4 2 0 1 339 343 359 1947 -10955 4 2 0 1 722 736 2217 2277 -10956 4 2 0 1 1523 2303 1493 2339 -10957 4 2 0 1 1545 2088 2164 2809 -10958 4 2 0 1 1241 2263 1908 2780 -10959 4 2 0 1 1633 1963 2340 2739 -10960 4 2 0 1 902 896 941 2495 -10961 4 2 0 1 1534 2673 2227 2700 -10962 4 2 0 1 1626 2099 1991 2347 -10963 4 2 0 1 1834 2337 1727 2396 -10964 4 2 0 1 1525 1501 157 843 -10965 4 2 0 1 1637 1821 2371 2467 -10966 4 2 0 1 749 743 777 1993 -10967 4 2 0 1 332 2298 1896 2795 -10968 4 2 0 1 1596 1960 2350 2503 -10969 4 2 0 1 1941 2085 1647 2480 -10970 4 2 0 1 2107 2612 1761 2689 -10971 4 2 0 1 1776 2253 2045 2717 -10972 4 2 0 1 1554 2592 1808 2834 -10973 4 2 0 1 2258 2348 1750 2538 -10974 4 2 0 1 2173 2606 1596 2752 -10975 4 2 0 1 1631 1789 2268 2357 -10976 4 2 0 1 259 2124 1905 2457 -10977 4 2 0 1 1573 1868 2122 2473 -10978 4 2 0 1 2204 2532 1752 2816 -10979 4 2 0 1 1714 2261 2152 2534 -10980 4 2 0 1 494 1915 229 2395 -10981 4 2 0 1 1607 1968 1949 2198 -10982 4 2 0 1 1179 2275 1433 2751 -10983 4 2 0 1 1241 1470 2379 2485 -10984 4 2 0 1 1283 2264 1522 2419 -10985 4 2 0 1 1153 2582 1034 2603 -10986 4 2 0 1 1561 1866 2396 2654 -10987 4 2 0 1 1841 2745 2344 2761 -10988 4 2 0 1 585 558 609 2408 -10989 4 2 0 1 972 2101 2514 2576 -10990 4 2 0 1 1396 1909 1197 2442 -10991 4 2 0 1 842 152 153 2115 -10992 4 2 0 1 1636 1824 2326 2381 -10993 4 2 0 1 1735 2197 1984 2500 -10994 4 2 0 1 1777 1625 2413 2813 -10995 4 2 0 1 1612 2016 1926 2667 -10996 4 2 0 1 984 2129 857 2365 -10997 4 2 0 1 1390 1367 1436 2057 -10998 4 2 0 1 1202 1478 1463 1994 -10999 4 2 0 1 833 714 718 2649 -11000 4 2 0 1 1292 1446 1282 2563 -11001 4 2 0 1 234 2066 175 2404 -11002 4 2 0 1 1678 2102 2001 2703 -11003 4 2 0 1 1741 2700 2800 2839 -11004 4 2 0 1 1599 1911 2048 2486 -11005 4 2 0 1 1427 1241 2358 2485 -11006 4 2 0 1 1744 2402 1971 2411 -11007 4 2 0 1 963 1873 860 2421 -11008 4 2 0 1 1600 1894 2251 2514 -11009 4 2 0 1 1896 2029 1695 2222 -11010 4 2 0 1 1177 1442 1312 1922 -11011 4 2 0 1 1673 2227 1945 2656 -11012 4 2 0 1 1645 1887 2181 2386 -11013 4 2 0 1 1642 2325 1885 2711 -11014 4 2 0 1 1677 2380 1841 2745 -11015 4 2 0 1 1696 2361 1771 2742 -11016 4 2 0 1 196 527 734 2692 -11017 4 2 0 1 2169 2587 1653 2766 -11018 4 2 0 1 1581 2717 1822 2772 -11019 4 2 0 1 774 1810 742 2690 -11020 4 2 0 1 969 2280 1931 2588 -11021 4 2 0 1 969 871 1931 2280 -11022 4 2 0 1 1827 2800 2700 2839 -11023 4 2 0 1 1479 1350 1467 2379 -11024 4 2 0 1 1305 2016 1337 2667 -11025 4 2 0 1 1040 1100 1060 1819 -11026 4 2 0 1 498 294 519 2062 -11027 4 2 0 1 415 2090 1861 2662 -11028 4 2 0 1 1777 2168 1900 2296 -11029 4 2 0 1 1359 1375 1231 2467 -11030 4 2 0 1 1939 1722 2353 2607 -11031 4 2 0 1 826 141 830 2732 -11032 4 2 0 1 225 2317 173 2576 -11033 4 2 0 1 639 2069 1828 2725 -11034 4 2 0 1 1969 2090 1602 2333 -11035 4 2 0 1 1325 1333 2012 2325 -11036 4 2 0 1 1314 1926 1213 2302 -11037 4 2 0 1 1887 2181 1623 2617 -11038 4 2 0 1 1590 1969 1903 2593 -11039 4 2 0 1 1705 2226 1837 2833 -11040 4 2 0 1 1182 1976 1277 2303 -11041 4 2 0 1 468 2144 2068 2404 -11042 4 2 0 1 315 317 220 2156 -11043 4 2 0 1 1399 1992 1362 2337 -11044 4 2 0 1 1476 558 643 1937 -11045 4 2 0 1 639 1828 2069 2812 -11046 4 2 0 1 614 1948 638 2400 -11047 4 2 0 1 391 326 181 2559 -11048 4 2 0 1 1036 2255 1870 2769 -11049 4 2 0 1 1547 1968 2250 2500 -11050 4 2 0 1 1894 2421 977 2695 -11051 4 2 0 1 782 1881 775 2555 -11052 4 2 0 1 1534 2227 1827 2700 -11053 4 2 0 1 1278 2117 1196 2178 -11054 4 2 0 1 765 775 710 2555 -11055 4 2 0 1 1351 1214 2044 2453 -11056 4 2 0 1 1567 2260 1725 2481 -11057 4 2 0 1 926 858 924 2125 -11058 4 2 0 1 476 488 442 1927 -11059 4 2 0 1 1822 1648 2555 2643 -11060 4 2 0 1 1649 2597 1917 2762 -11061 4 2 0 1 352 2268 176 2269 -11062 4 2 0 1 1690 2316 1993 2498 -11063 4 2 0 1 1589 1805 2208 2708 -11064 4 2 0 1 486 2330 279 2694 -11065 4 2 0 1 1602 2090 2185 2333 -11066 4 2 0 1 1914 2474 1576 2640 -11067 4 2 0 1 692 1942 693 2288 -11068 4 2 0 1 1956 2139 1573 2759 -11069 4 2 0 1 1332 1310 1223 2441 -11070 4 2 0 1 263 715 2217 2714 -11071 4 2 0 1 1553 2459 1825 2749 -11072 4 2 0 1 415 443 462 2185 -11073 4 2 0 1 1987 2318 1772 2550 -11074 4 2 0 1 1397 1435 1240 2275 -11075 4 2 0 1 1242 1439 1352 2387 -11076 4 2 0 1 1845 2180 672 2672 -11077 4 2 0 1 1576 2229 2021 2552 -11078 4 2 0 1 1005 944 2287 2382 -11079 4 2 0 1 159 2049 1142 2394 -11080 4 2 0 1 1586 1962 2290 2388 -11081 4 2 0 1 340 1850 235 2605 -11082 4 2 0 1 1527 2651 1818 2798 -11083 4 2 0 1 1621 1785 2203 2634 -11084 4 2 0 1 1560 1804 2199 2257 -11085 4 2 0 1 2195 1840 2303 2586 -11086 4 2 0 1 1726 2360 2212 2638 -11087 4 2 0 1 1422 1419 1438 2551 -11088 4 2 0 1 169 491 307 2691 -11089 4 2 0 1 533 553 2197 2390 -11090 4 2 0 1 1886 1616 2291 2540 -11091 4 2 0 1 1819 2406 2543 2768 -11092 4 2 0 1 1758 2393 1637 2749 -11093 4 2 0 1 408 379 1915 2662 -11094 4 2 0 1 1223 1924 1392 2441 -11095 4 2 0 1 1000 2562 1790 2695 -11096 4 2 0 1 1838 2193 1704 2823 -11097 4 2 0 1 473 424 2225 2516 -11098 4 2 0 1 1004 1832 2280 2588 -11099 4 2 0 1 1575 2119 1975 2570 -11100 4 2 0 1 1562 2286 1770 2595 -11101 4 2 0 1 1821 2467 1215 2475 -11102 4 2 0 1 1789 2621 2058 2748 -11103 4 2 0 1 1569 1851 2237 2633 -11104 4 2 0 1 1503 1810 1263 2722 -11105 4 2 0 1 160 1929 896 2561 -11106 4 2 0 1 1345 1330 1375 2194 -11107 4 2 0 1 1916 2443 1578 2802 -11108 4 2 0 1 1997 2002 1657 2605 -11109 4 2 0 1 885 276 970 1961 -11110 4 2 0 1 1375 2194 1231 2467 -11111 4 2 0 1 1616 1951 2627 2755 -11112 4 2 0 1 1738 2061 1919 2483 -11113 4 2 0 1 930 1011 948 2553 -11114 4 2 0 1 1538 1844 2388 2470 -11115 4 2 0 1 474 253 2606 2694 -11116 4 2 0 1 172 2277 198 2457 -11117 4 2 0 1 1024 1111 2422 2488 -11118 4 2 0 1 217 356 2196 2207 -11119 4 2 0 1 208 447 1879 2574 -11120 4 2 0 1 1554 2385 2152 2616 -11121 4 2 0 1 1578 1955 1884 2345 -11122 4 2 0 1 508 2217 2635 2714 -11123 4 2 0 1 597 1868 633 2256 -11124 4 2 0 1 536 2456 1884 2658 -11125 4 2 0 1 992 1929 161 2035 -11126 4 2 0 1 1556 2016 2664 2765 -11127 4 2 0 1 2419 2435 1735 2686 -11128 4 2 0 1 2172 2537 1664 2700 -11129 4 2 0 1 372 208 447 1879 -11130 4 2 0 1 2074 2332 2145 2772 -11131 4 2 0 1 191 281 793 2498 -11132 4 2 0 1 1668 1831 2472 2618 -11133 4 2 0 1 2504 2583 1669 2796 -11134 4 2 0 1 1527 1818 2295 2798 -11135 4 2 0 1 722 2277 2217 2732 -11136 4 2 0 1 1869 2197 1735 2250 -11137 4 2 0 1 1860 2079 1648 2649 -11138 4 2 0 1 309 2269 2156 2795 -11139 4 2 0 1 1432 2513 1906 2780 -11140 4 2 0 1 656 605 2009 2169 -11141 4 2 0 1 1271 1295 1147 2056 -11142 4 2 0 1 1288 1182 1283 1976 -11143 4 2 0 1 896 992 946 2259 -11144 4 2 0 1 1538 2102 2411 2794 -11145 4 2 0 1 1665 2163 1977 2539 -11146 4 2 0 1 1722 1939 2571 2607 -11147 4 2 0 1 1562 1841 2380 2745 -11148 4 2 0 1 804 753 813 2267 -11149 4 2 0 1 1702 2067 1891 2343 -11150 4 2 0 1 1557 2357 2058 2681 -11151 4 2 0 1 916 914 970 2107 -11152 4 2 0 1 1261 2117 1840 2551 -11153 4 2 0 1 1654 2279 2241 2591 -11154 4 2 0 1 296 1896 332 2222 -11155 4 2 0 1 433 1993 277 2498 -11156 4 2 0 1 675 549 2569 2672 -11157 4 2 0 1 1706 2220 1954 2415 -11158 4 2 0 1 730 2508 788 2732 -11159 4 2 0 1 1600 2023 1895 2832 -11160 4 2 0 1 598 687 1973 2766 -11161 4 2 0 1 485 422 518 2645 -11162 4 2 0 1 1041 2043 1097 2346 -11163 4 2 0 1 1552 2103 1989 2575 -11164 4 2 0 1 219 2030 297 2744 -11165 4 2 0 1 1343 1346 1227 1834 -11166 4 2 0 1 1835 1970 1932 2270 -11167 4 2 0 1 1254 2551 2289 2730 -11168 4 2 0 1 1515 1064 2264 2339 -11169 4 2 0 1 1308 2036 1188 2324 -11170 4 2 0 1 2112 2572 1818 2798 -11171 4 2 0 1 383 297 219 2525 -11172 4 2 0 1 624 573 537 2294 -11173 4 2 0 1 768 824 805 2034 -11174 4 2 0 1 491 1997 291 2298 -11175 4 2 0 1 2175 2595 1815 2728 -11176 4 2 0 1 237 1902 318 2641 -11177 4 2 0 1 1717 2295 1818 2599 -11178 4 2 0 1 1434 1356 1222 2007 -11179 4 2 0 1 834 821 749 2498 -11180 4 2 0 1 584 2530 1809 2658 -11181 4 2 0 1 274 477 276 1961 -11182 4 2 0 1 1197 1840 1277 2442 -11183 4 2 0 1 1737 2023 1895 2679 -11184 4 2 0 1 1452 1803 2462 2720 -11185 4 2 0 1 308 332 1896 2795 -11186 4 2 0 1 1570 2291 1820 2609 -11187 4 2 0 1 1784 2418 2309 2623 -11188 4 2 0 1 1677 2330 2297 2694 -11189 4 2 0 1 1678 2102 2078 2765 -11190 4 2 0 1 2193 2313 1734 2678 -11191 4 2 0 1 983 2162 965 2279 -11192 4 2 0 1 1855 2028 809 2378 -11193 4 2 0 1 1865 2308 1750 2454 -11194 4 2 0 1 845 148 724 2131 -11195 4 2 0 1 1668 2020 1897 2472 -11196 4 2 0 1 751 837 831 2068 -11197 4 2 0 1 1633 2243 1963 2739 -11198 4 2 0 1 500 286 270 1904 -11199 4 2 0 1 2066 2404 1792 2674 -11200 4 2 0 1 1535 2203 1839 2439 -11201 4 2 0 1 1955 2345 2120 2687 -11202 4 2 0 1 1541 1804 2143 2520 -11203 4 2 0 1 1928 2214 1773 2675 -11204 4 2 0 1 447 2446 1879 2574 -11205 4 2 0 1 312 235 456 2002 -11206 4 2 0 1 763 1822 701 2436 -11207 4 2 0 1 1532 2258 2150 2538 -11208 4 2 0 1 1528 2121 2465 2510 -11209 4 2 0 1 1813 1668 2417 2580 -11210 4 2 0 1 2009 2197 553 2390 -11211 4 2 0 1 842 2109 152 2115 -11212 4 2 0 1 2079 2375 1776 2649 -11213 4 2 0 1 866 913 937 2233 -11214 4 2 0 1 1596 2003 1960 2478 -11215 4 2 0 1 169 1997 491 2691 -11216 4 2 0 1 1712 2111 2320 2510 -11217 4 2 0 1 1562 2286 2380 2823 -11218 4 2 0 1 1867 2352 2110 2829 -11219 4 2 0 1 564 1990 2344 2350 -11220 4 2 0 1 1527 1928 2296 2813 -11221 4 2 0 1 735 843 1514 2135 -11222 4 2 0 1 1658 1930 1979 2535 -11223 4 2 0 1 366 452 2159 2323 -11224 4 2 0 1 992 2259 2035 2734 -11225 4 2 0 1 1887 2142 1537 2386 -11226 4 2 0 1 2035 2416 1721 2537 -11227 4 2 0 1 2227 2362 1806 2673 -11228 4 2 0 1 1611 1802 2271 2504 -11229 4 2 0 1 1527 2032 1928 2651 -11230 4 2 0 1 525 514 679 2560 -11231 4 2 0 1 538 605 2009 2408 -11232 4 2 0 1 1789 1978 2556 2613 -11233 4 2 0 1 1671 2252 2047 2313 -11234 4 2 0 1 1054 1066 2278 2696 -11235 4 2 0 1 1612 2018 1926 2320 -11236 4 2 0 1 1682 2364 1900 2593 -11237 4 2 0 1 142 2120 1955 2732 -11238 4 2 0 1 1585 2030 2027 2597 -11239 4 2 0 1 533 2009 553 2390 -11240 4 2 0 1 938 2251 2101 2495 -11241 4 2 0 1 2250 2282 1652 2790 -11242 4 2 0 1 1688 2182 2064 2719 -11243 4 2 0 1 1122 2138 1134 2458 -11244 4 2 0 1 1405 1470 1294 2379 -11245 4 2 0 1 1607 1968 2026 2500 -11246 4 2 0 1 932 887 860 1873 -11247 4 2 0 1 1237 2033 1337 2835 -11248 4 2 0 1 1800 2209 1952 2826 -11249 4 2 0 1 527 495 149 516 -11250 4 2 0 1 1239 1342 1353 2322 -11251 4 2 0 1 464 505 257 2692 -11252 4 2 0 1 530 1973 687 2766 -11253 4 2 0 1 1908 2263 1906 2780 -11254 4 2 0 1 1688 2274 2140 2346 -11255 4 2 0 1 1004 961 962 2588 -11256 4 2 0 1 177 379 420 1965 -11257 4 2 0 1 1338 1420 2018 2667 -11258 4 2 0 1 227 2468 345 2489 -11259 4 2 0 1 1366 2001 1226 2825 -11260 4 2 0 1 494 2262 2355 2395 -11261 4 2 0 1 794 790 754 2171 -11262 4 2 0 1 1616 2244 2187 2540 -11263 4 2 0 1 1710 2232 1883 2710 -11264 4 2 0 1 1572 1857 2310 2515 -11265 4 2 0 1 1452 1415 1464 1803 -11266 4 2 0 1 1686 2336 2092 2448 -11267 4 2 0 1 1616 2552 1951 2755 -11268 4 2 0 1 1316 2094 2420 2740 -11269 4 2 0 1 1585 2447 1880 2597 -11270 4 2 0 1 1535 2363 2203 2439 -11271 4 2 0 1 1675 2065 2266 2471 -11272 4 2 0 1 1562 1815 2595 2728 -11273 4 2 0 1 1397 1240 2148 2275 -11274 4 2 0 1 1783 2538 2258 2546 -11275 4 2 0 1 1256 1453 1516 2146 -11276 4 2 0 1 1581 1822 2378 2772 -11277 4 2 0 1 1583 1964 2025 2622 -11278 4 2 0 1 1879 2446 2088 2676 -11279 4 2 0 1 1660 1975 2039 2544 -11280 4 2 0 1 2303 2586 1787 2716 -11281 4 2 0 1 659 645 1429 2132 -11282 4 2 0 1 1866 1689 2427 2743 -11283 4 2 0 1 1983 2605 1850 2614 -11284 4 2 0 1 1299 1821 1215 2475 -11285 4 2 0 1 1606 2040 2228 2757 -11286 4 2 0 1 1856 2306 1597 2688 -11287 4 2 0 1 1636 2001 1935 2285 -11288 4 2 0 1 1738 2319 2061 2483 -11289 4 2 0 1 1755 2254 2076 2511 -11290 4 2 0 1 796 2596 817 2677 -11291 4 2 0 1 1694 2219 2189 2292 -11292 4 2 0 1 1915 2147 1670 2395 -11293 4 2 0 1 1044 2064 1174 2274 -11294 4 2 0 1 1558 1796 2145 2643 -11295 4 2 0 1 428 1897 184 2297 -11296 4 2 0 1 1345 1821 1299 2655 -11297 4 2 0 1 392 1823 424 2516 -11298 4 2 0 1 1795 2108 2040 2541 -11299 4 2 0 1 1715 2003 1940 2478 -11300 4 2 0 1 625 2344 1815 2350 -11301 4 2 0 1 1562 2314 1841 2728 -11302 4 2 0 1 1281 1493 2303 2339 -11303 4 2 0 1 1134 2138 1124 2518 -11304 4 2 0 1 2110 2352 1867 2431 -11305 4 2 0 1 639 2069 551 2469 -11306 4 2 0 1 1574 2036 2276 2811 -11307 4 2 0 1 1180 1267 2021 2563 -11308 4 2 0 1 570 1912 660 2283 -11309 4 2 0 1 2412 2797 1848 2805 -11310 4 2 0 1 940 2129 888 2461 -11311 4 2 0 1 1409 1457 1253 2751 -11312 4 2 0 1 546 2053 2367 2725 -11313 4 2 0 1 1080 1154 1035 2713 -11314 4 2 0 1 1141 1170 1148 2777 -11315 4 2 0 1 725 1890 691 2451 -11316 4 2 0 1 1703 2466 2000 2487 -11317 4 2 0 1 1040 1100 1819 2406 -11318 4 2 0 1 929 1004 962 1832 -11319 4 2 0 1 346 341 326 1978 -11320 4 2 0 1 1552 2369 2166 2799 -11321 4 2 0 1 1434 2007 1222 2763 -11322 4 2 0 1 1642 2787 1906 2801 -11323 4 2 0 1 1577 1896 2004 2748 -11324 4 2 0 1 411 2317 369 2366 -11325 4 2 0 1 2228 2621 1699 2757 -11326 4 2 0 1 2336 2412 1699 2448 -11327 4 2 0 1 1579 1798 2072 2760 -11328 4 2 0 1 1322 2284 1310 2441 -11329 4 2 0 1 2068 1765 2341 2404 -11330 4 2 0 1 178 2489 1895 2679 -11331 4 2 0 1 1057 1929 160 2394 -11332 4 2 0 1 1534 2362 2227 2673 -11333 4 2 0 1 1623 2223 2022 2730 -11334 4 2 0 1 1354 2077 1355 2507 -11335 4 2 0 1 500 270 170 1904 -11336 4 2 0 1 405 217 356 2196 -11337 4 2 0 1 1566 1911 2105 2261 -11338 4 2 0 1 891 902 2495 2561 -11339 4 2 0 1 1538 2285 2102 2703 -11340 4 2 0 1 1826 2307 1757 2363 -11341 4 2 0 1 1006 918 879 2576 -11342 4 2 0 1 1560 2413 1807 2550 -11343 4 2 0 1 1903 1969 1590 2407 -11344 4 2 0 1 2227 2700 2673 2839 -11345 4 2 0 1 1807 2318 1987 2550 -11346 4 2 0 1 1043 2414 1842 2804 -11347 4 2 0 1 253 1990 275 2830 -11348 4 2 0 1 2149 2163 1665 2611 -11349 4 2 0 1 1806 2227 1673 2362 -11350 4 2 0 1 1827 2537 2172 2700 -11351 4 2 0 1 448 179 2086 2821 -11352 4 2 0 1 1014 2461 884 2589 -11353 4 2 0 1 1704 2122 2314 2723 -11354 4 2 0 1 1583 2054 1904 2202 -11355 4 2 0 1 1680 1948 2433 2706 -11356 4 2 0 1 1674 1881 2705 2773 -11357 4 2 0 1 1559 2423 1851 2490 -11358 4 2 0 1 1622 2041 1908 2736 -11359 4 2 0 1 2145 2502 1822 2772 -11360 4 2 0 1 1160 1161 2384 2769 -11361 4 2 0 1 1446 1180 1282 2563 -11362 4 2 0 1 149 982 150 1946 -11363 4 2 0 1 1971 2511 1755 2781 -11364 4 2 0 1 1457 1824 1380 2381 -11365 4 2 0 1 1428 1924 1311 2484 -11366 4 2 0 1 202 2635 393 2776 -11367 4 2 0 1 1594 2176 2517 2607 -11368 4 2 0 1 906 1484 1485 2184 -11369 4 2 0 1 547 1831 543 2256 -11370 4 2 0 1 2006 1640 2244 2548 -11371 4 2 0 1 2203 2363 1839 2439 -11372 4 2 0 1 2160 2331 1793 2731 -11373 4 2 0 1 1550 2309 2418 2623 -11374 4 2 0 1 2182 2619 1951 2810 -11375 4 2 0 1 1225 1339 1348 2076 -11376 4 2 0 1 1197 1261 1840 2551 -11377 4 2 0 1 2347 2608 1740 2659 -11378 4 2 0 1 351 258 208 2574 -11379 4 2 0 1 1758 1828 2069 2206 -11380 4 2 0 1 681 655 593 2663 -11381 4 2 0 1 443 415 188 2090 -11382 4 2 0 1 775 782 788 1881 -11383 4 2 0 1 2176 2423 1966 2836 -11384 4 2 0 1 1537 2082 2243 2629 -11385 4 2 0 1 1184 1477 1280 2724 -11386 4 2 0 1 1561 2572 2050 2746 -11387 4 2 0 1 901 944 2070 2287 -11388 4 2 0 1 1499 1491 2131 2484 -11389 4 2 0 1 232 440 405 2196 -11390 4 2 0 1 763 765 701 1822 -11391 4 2 0 1 1584 1848 2315 2575 -11392 4 2 0 1 1795 2228 2040 2757 -11393 4 2 0 1 1663 2463 2042 2573 -11394 4 2 0 1 1628 1803 2233 2499 -11395 4 2 0 1 1562 1815 2728 2745 -11396 4 2 0 1 1012 1006 2155 2327 -11397 4 2 0 1 1310 1188 1299 2036 -11398 4 2 0 1 1642 2325 2012 2515 -11399 4 2 0 1 1197 1909 1419 2551 -11400 4 2 0 1 2166 2369 1709 2799 -11401 4 2 0 1 1017 2458 2064 2543 -11402 4 2 0 1 1666 2063 2386 2600 -11403 4 2 0 1 1665 2539 2153 2639 -11404 4 2 0 1 604 2530 554 2536 -11405 4 2 0 1 1578 2450 1950 2802 -11406 4 2 0 1 1282 2229 2581 2582 -11407 4 2 0 1 1822 2717 2145 2772 -11408 4 2 0 1 1611 2504 2143 2796 -11409 4 2 0 1 586 2330 2046 2761 -11410 4 2 0 1 1619 1851 2237 2490 -11411 4 2 0 1 1709 2300 2309 2369 -11412 4 2 0 1 2619 2625 1544 2833 -11413 4 2 0 1 1630 2459 1956 2546 -11414 4 2 0 1 1628 2374 1808 2534 -11415 4 2 0 1 2072 2285 1943 2470 -11416 4 2 0 1 1527 2651 1928 2813 -11417 4 2 0 1 1226 1334 1316 2420 -11418 4 2 0 1 287 276 970 1007 -11419 4 2 0 1 1153 1036 1127 1994 -11420 4 2 0 1 824 2307 2034 2451 -11421 4 2 0 1 1774 2520 2011 2521 -11422 4 2 0 1 1301 2668 1309 2740 -11423 4 2 0 1 2275 2318 1772 2767 -11424 4 2 0 1 1542 2235 2024 2305 -11425 4 2 0 1 533 656 2009 2390 -11426 4 2 0 1 1930 1979 1606 2559 -11427 4 2 0 1 596 530 673 2246 -11428 4 2 0 1 501 508 263 2217 -11429 4 2 0 1 1543 2412 1848 2726 -11430 4 2 0 1 834 277 821 2498 -11431 4 2 0 1 1640 2719 2182 2810 -11432 4 2 0 1 1912 2235 1726 2497 -11433 4 2 0 1 1278 2178 1196 2785 -11434 4 2 0 1 2162 1615 2421 2738 -11435 4 2 0 1 1631 2156 1947 2268 -11436 4 2 0 1 1845 1573 2139 2759 -11437 4 2 0 1 1671 2112 1866 2831 -11438 4 2 0 1 1415 2499 1803 2720 -11439 4 2 0 1 2062 1848 2797 2805 -11440 4 2 0 1 2033 2370 1764 2392 -11441 4 2 0 1 203 288 327 2657 -11442 4 2 0 1 524 516 264 2209 -11443 4 2 0 1 1601 1784 2402 2418 -11444 4 2 0 1 1534 1806 2362 2673 -11445 4 2 0 1 1918 2571 1722 2691 -11446 4 2 0 1 204 373 310 2647 -11447 4 2 0 1 1345 1215 1299 1821 -11448 4 2 0 1 345 1939 212 2489 -11449 4 2 0 1 1238 1444 1389 2008 -11450 4 2 0 1 318 387 412 1902 -11451 4 2 0 1 1636 2072 2247 2747 -11452 4 2 0 1 703 1957 761 2316 -11453 4 2 0 1 2212 2360 1662 2638 -11454 4 2 0 1 1768 2517 2176 2607 -11455 4 2 0 1 683 1973 596 2367 -11456 4 2 0 1 1741 2158 2188 2700 -11457 4 2 0 1 1904 2349 1658 2564 -11458 4 2 0 1 1539 2126 2151 2648 -11459 4 2 0 1 622 558 1984 2408 -11460 4 2 0 1 1863 2075 2025 2817 -11461 4 2 0 1 1280 1476 1207 1937 -11462 4 2 0 1 1741 2511 1971 2781 -11463 4 2 0 1 1357 1382 1474 2137 -11464 4 2 0 1 931 962 857 2129 -11465 4 2 0 1 896 2495 902 2561 -11466 4 2 0 1 1710 2518 2138 2828 -11467 4 2 0 1 1681 2406 1819 2768 -11468 4 2 0 1 807 751 757 2068 -11469 4 2 0 1 866 881 933 1889 -11470 4 2 0 1 685 136 652 2777 -11471 4 2 0 1 1668 2020 2417 2827 -11472 4 2 0 1 221 1947 378 2683 -11473 4 2 0 1 1652 1972 2236 2728 -11474 4 2 0 1 215 378 1847 2366 -11475 4 2 0 1 1422 1438 1236 2551 -11476 4 2 0 1 975 2162 895 2421 -11477 4 2 0 1 1655 2196 1809 2533 -11478 4 2 0 1 812 759 704 2099 -11479 4 2 0 1 147 146 847 2497 -11480 4 2 0 1 1596 2595 2286 2745 -11481 4 2 0 1 1858 1906 2787 2801 -11482 4 2 0 1 1109 1096 2406 2424 -11483 4 2 0 1 1935 2072 1636 2285 -11484 4 2 0 1 1572 2276 1865 2712 -11485 4 2 0 1 1872 2591 911 2715 -11486 4 2 0 1 1253 1401 1178 2201 -11487 4 2 0 1 1134 2458 2138 2518 -11488 4 2 0 1 349 252 418 1930 -11489 4 2 0 1 940 2461 945 2637 -11490 4 2 0 1 1972 2175 1652 2282 -11491 4 2 0 1 221 1947 343 2464 -11492 4 2 0 1 1620 1992 1893 2201 -11493 4 2 0 1 1570 2007 2318 2609 -11494 4 2 0 1 1907 2057 993 2462 -11495 4 2 0 1 1327 1369 2104 2579 -11496 4 2 0 1 896 161 992 1929 -11497 4 2 0 1 1844 2703 2078 2704 -11498 4 2 0 1 2096 2558 1812 2708 -11499 4 2 0 1 1865 2276 1830 2308 -11500 4 2 0 1 1214 1303 1857 2453 -11501 4 2 0 1 1534 1806 2219 2362 -11502 4 2 0 1 1581 2145 2213 2717 -11503 4 2 0 1 1610 2115 2109 2186 -11504 4 2 0 1 467 2144 2404 2445 -11505 4 2 0 1 762 856 2684 2690 -11506 4 2 0 1 942 2514 1894 2542 -11507 4 2 0 1 1664 2537 2035 2734 -11508 4 2 0 1 1546 2061 2650 2771 -11509 4 2 0 1 1951 2182 1544 2619 -11510 4 2 0 1 1750 2454 2050 2572 -11511 4 2 0 1 1874 2230 1540 2524 -11512 4 2 0 1 833 718 689 2649 -11513 4 2 0 1 1740 2432 2347 2659 -11514 4 2 0 1 1638 2310 1857 2515 -11515 4 2 0 1 1646 1976 2195 2434 -11516 4 2 0 1 1363 1364 1369 2342 -11517 4 2 0 1 2014 2329 1693 2598 -11518 4 2 0 1 1195 1808 2299 2374 -11519 4 2 0 1 1671 2116 2112 2798 -11520 4 2 0 1 1706 2324 2013 2746 -11521 4 2 0 1 1654 2254 1872 2383 -11522 4 2 0 1 1855 2436 1629 2772 -11523 4 2 0 1 1600 2251 2101 2514 -11524 4 2 0 1 2316 2702 1690 2816 -11525 4 2 0 1 1858 1743 2729 2787 -11526 4 2 0 1 1666 2505 2063 2600 -11527 4 2 0 1 2074 2145 1581 2772 -11528 4 2 0 1 1825 1637 2393 2749 -11529 4 2 0 1 1717 2413 2214 2813 -11530 4 2 0 1 1615 2162 2636 2738 -11531 4 2 0 1 932 1873 963 2421 -11532 4 2 0 1 482 478 488 1927 -11533 4 2 0 1 351 2333 258 2574 -11534 4 2 0 1 966 942 1894 2542 -11535 4 2 0 1 1061 2522 2339 2804 -11536 4 2 0 1 1506 166 1381 2278 -11537 4 2 0 1 1572 2310 1857 2712 -11538 4 2 0 1 1783 2348 2258 2538 -11539 4 2 0 1 2040 2108 1587 2541 -11540 4 2 0 1 1630 2154 2546 2706 -11541 4 2 0 1 372 335 256 2185 -11542 4 2 0 1 1764 2370 1974 2754 -11543 4 2 0 1 1233 1199 1443 2507 -11544 4 2 0 1 938 912 2101 2514 -11545 4 2 0 1 1421 1410 1248 2091 -11546 4 2 0 1 1585 2027 2447 2597 -11547 4 2 0 1 2128 2173 1596 2478 -11548 4 2 0 1 1550 2449 2113 2568 -11549 4 2 0 1 1549 1901 2195 2600 -11550 4 2 0 1 311 2190 182 2211 -11551 4 2 0 1 1772 2247 2007 2747 -11552 4 2 0 1 1619 2153 1877 2409 -11553 4 2 0 1 1619 2352 2237 2431 -11554 4 2 0 1 763 780 848 2436 -11555 4 2 0 1 1935 2001 1636 2825 -11556 4 2 0 1 2313 2427 1704 2452 -11557 4 2 0 1 904 908 865 2137 -11558 4 2 0 1 409 224 311 2084 -11559 4 2 0 1 1741 1814 2158 2839 -11560 4 2 0 1 1813 1668 2399 2417 -11561 4 2 0 1 1125 1103 1039 2255 -11562 4 2 0 1 1218 1349 2044 2455 -11563 4 2 0 1 1541 2306 2065 2602 -11564 4 2 0 1 758 818 753 2585 -11565 4 2 0 1 1881 1662 2120 2377 -11566 4 2 0 1 239 1977 245 2539 -11567 4 2 0 1 1573 2697 2496 2759 -11568 4 2 0 1 1210 1183 1264 1933 -11569 4 2 0 1 2097 2641 1716 2821 -11570 4 2 0 1 1627 2475 1924 2484 -11571 4 2 0 1 1264 1246 1276 1933 -11572 4 2 0 1 1614 2064 2182 2719 -11573 4 2 0 1 351 2185 443 2333 -11574 4 2 0 1 1543 2336 2025 2792 -11575 4 2 0 1 1930 2559 1913 2713 -11576 4 2 0 1 1697 1969 1903 2657 -11577 4 2 0 1 1367 1436 2057 2462 -11578 4 2 0 1 2143 2504 1791 2796 -11579 4 2 0 1 1119 1083 1077 2056 -11580 4 2 0 1 1152 1094 1106 2060 -11581 4 2 0 1 1852 2078 1962 2460 -11582 4 2 0 1 1319 1188 1329 2324 -11583 4 2 0 1 1664 1873 2221 2738 -11584 4 2 0 1 671 137 685 2777 -11585 4 2 0 1 1640 2006 2335 2681 -11586 4 2 0 1 678 2400 1725 2610 -11587 4 2 0 1 1562 2728 1841 2745 -11588 4 2 0 1 1716 2545 2319 2821 -11589 4 2 0 1 1138 1172 1930 2349 -11590 4 2 0 1 1700 2256 1831 2618 -11591 4 2 0 1 2105 2558 1589 2708 -11592 4 2 0 1 969 1931 925 2588 -11593 4 2 0 1 1632 2117 2273 2785 -11594 4 2 0 1 1539 1883 2126 2648 -11595 4 2 0 1 1566 2261 1817 2778 -11596 4 2 0 1 1913 2559 391 2713 -11597 4 2 0 1 1928 2813 2651 2820 -11598 4 2 0 1 1338 2018 1195 2374 -11599 4 2 0 1 1529 1925 2216 2774 -11600 4 2 0 1 319 307 212 2353 -11601 4 2 0 1 1272 1195 1808 2299 -11602 4 2 0 1 1822 2643 2145 2717 -11603 4 2 0 1 1534 2189 2219 2292 -11604 4 2 0 1 2017 2217 1718 2635 -11605 4 2 0 1 975 963 860 2421 -11606 4 2 0 1 1581 2045 2028 2378 -11607 4 2 0 1 1682 2031 2168 2364 -11608 4 2 0 1 711 2375 695 2649 -11609 4 2 0 1 1545 1856 2401 2809 -11610 4 2 0 1 419 330 168 2200 -11611 4 2 0 1 564 1990 2350 2830 -11612 4 2 0 1 1565 2665 2351 2783 -11613 4 2 0 1 1620 2245 2599 2707 -11614 4 2 0 1 1963 2340 1717 2820 -11615 4 2 0 1 1561 2112 2348 2572 -11616 4 2 0 1 809 763 848 2378 -11617 4 2 0 1 1580 1839 2361 2754 -11618 4 2 0 1 510 514 497 2359 -11619 4 2 0 1 1452 1415 1803 2720 -11620 4 2 0 1 962 961 2248 2588 -11621 4 2 0 1 1824 1772 2326 2751 -11622 4 2 0 1 2111 2466 1966 2566 -11623 4 2 0 1 1209 1296 2001 2302 -11624 4 2 0 1 1965 2752 177 2791 -11625 4 2 0 1 2194 2415 1758 2749 -11626 4 2 0 1 327 2157 289 2741 -11627 4 2 0 1 1580 2361 2051 2754 -11628 4 2 0 1 1872 2254 2076 2383 -11629 4 2 0 1 1990 2128 1596 2350 -11630 4 2 0 1 167 366 452 2159 -11631 4 2 0 1 2349 2564 1172 2565 -11632 4 2 0 1 2062 2797 2412 2805 -11633 4 2 0 1 940 880 931 2073 -11634 4 2 0 1 299 361 328 2669 -11635 4 2 0 1 1581 2213 2014 2717 -11636 4 2 0 1 847 146 2425 2497 -11637 4 2 0 1 1756 2660 2025 2792 -11638 4 2 0 1 304 490 387 1983 -11639 4 2 0 1 1361 1219 2325 2711 -11640 4 2 0 1 532 635 604 2536 -11641 4 2 0 1 1707 2474 1914 2640 -11642 4 2 0 1 2228 2601 1699 2621 -11643 4 2 0 1 1868 1573 2180 2473 -11644 4 2 0 1 1668 1813 2207 2580 -11645 4 2 0 1 1698 2151 2022 2181 -11646 4 2 0 1 1620 2245 1992 2340 -11647 4 2 0 1 1469 1837 2620 2740 -11648 4 2 0 1 1527 2295 2168 2527 -11649 4 2 0 1 1554 2152 2385 2644 -11650 4 2 0 1 1614 2182 2218 2719 -11651 4 2 0 1 207 316 2130 2624 -11652 4 2 0 1 720 743 821 1993 -11653 4 2 0 1 1705 2474 1951 2833 -11654 4 2 0 1 1679 2036 2284 2712 -11655 4 2 0 1 173 2101 271 2576 -11656 4 2 0 1 2189 1631 2362 2680 -11657 4 2 0 1 263 2217 508 2714 -11658 4 2 0 1 1657 2113 2590 2838 -11659 4 2 0 1 1679 1834 2324 2746 -11660 4 2 0 1 1748 2636 2162 2738 -11661 4 2 0 1 1986 2037 1892 2783 -11662 4 2 0 1 1595 2524 2343 2808 -11663 4 2 0 1 1360 1369 1437 2104 -11664 4 2 0 1 1396 1419 1197 1909 -11665 4 2 0 1 1640 1883 2548 2828 -11666 4 2 0 1 1866 2463 2047 2573 -11667 4 2 0 1 311 2084 224 2190 -11668 4 2 0 1 340 1850 2605 2614 -11669 4 2 0 1 1979 2336 1699 2448 -11670 4 2 0 1 1520 2177 1260 2822 -11671 4 2 0 1 1896 2029 2004 2519 -11672 4 2 0 1 1516 1220 1474 2137 -11673 4 2 0 1 2166 2369 1888 2774 -11674 4 2 0 1 850 813 2267 2316 -11675 4 2 0 1 760 1855 811 2585 -11676 4 2 0 1 1111 1050 2422 2626 -11677 4 2 0 1 938 869 912 2514 -11678 4 2 0 1 930 933 974 2365 -11679 4 2 0 1 358 2489 178 2679 -11680 4 2 0 1 2179 2264 1646 2434 -11681 4 2 0 1 1858 2136 1565 2729 -11682 4 2 0 1 1898 2224 1647 2389 -11683 4 2 0 1 2258 2538 1532 2546 -11684 4 2 0 1 1561 2348 2050 2572 -11685 4 2 0 1 1671 1818 2112 2831 -11686 4 2 0 1 1887 2181 1537 2629 -11687 4 2 0 1 1409 2455 1218 2493 -11688 4 2 0 1 641 676 619 2321 -11689 4 2 0 1 2318 2609 2007 2767 -11690 4 2 0 1 878 923 967 2241 -11691 4 2 0 1 1564 2352 1859 2671 -11692 4 2 0 1 484 2211 298 2446 -11693 4 2 0 1 2641 2821 414 2826 -11694 4 2 0 1 1533 1970 1932 2583 -11695 4 2 0 1 1111 1098 1050 2626 -11696 4 2 0 1 400 426 460 1809 -11697 4 2 0 1 663 617 607 2236 -11698 4 2 0 1 1651 2199 1824 2455 -11699 4 2 0 1 1252 2132 1400 2469 -11700 4 2 0 1 1716 1952 2545 2821 -11701 4 2 0 1 762 2684 2034 2690 -11702 4 2 0 1 396 2657 2662 2824 -11703 4 2 0 1 1772 2326 2247 2747 -11704 4 2 0 1 1365 1433 2275 2770 -11705 4 2 0 1 677 540 600 2281 -11706 4 2 0 1 1822 2555 1648 2717 -11707 4 2 0 1 1723 2478 2173 2818 -11708 4 2 0 1 1193 1441 2322 2615 -11709 4 2 0 1 2019 2214 1625 2675 -11710 4 2 0 1 2145 2577 2213 2717 -11711 4 2 0 1 226 186 2127 2327 -11712 4 2 0 1 1322 1333 1303 2284 -11713 4 2 0 1 1590 1835 2270 2364 -11714 4 2 0 1 206 387 318 2669 -11715 4 2 0 1 1628 2299 1808 2374 -11716 4 2 0 1 1343 1319 1329 2324 -11717 4 2 0 1 1872 2254 1654 2591 -11718 4 2 0 1 474 255 492 2297 -11719 4 2 0 1 665 657 1828 2725 -11720 4 2 0 1 1718 2217 2017 2773 -11721 4 2 0 1 560 2169 556 2236 -11722 4 2 0 1 2006 2187 1656 2548 -11723 4 2 0 1 2020 2756 2417 2827 -11724 4 2 0 1 800 758 753 2288 -11725 4 2 0 1 808 2253 689 2555 -11726 4 2 0 1 1055 2119 1019 2570 -11727 4 2 0 1 1515 2264 1523 2339 -11728 4 2 0 1 1991 2265 1626 2347 -11729 4 2 0 1 231 465 377 2068 -11730 4 2 0 1 485 2217 422 2645 -11731 4 2 0 1 1504 1984 1518 2686 -11732 4 2 0 1 1487 1283 1522 2419 -11733 4 2 0 1 1608 2231 1986 2476 -11734 4 2 0 1 2151 2187 1656 2216 -11735 4 2 0 1 1601 2673 2480 2839 -11736 4 2 0 1 1608 2231 1791 2334 -11737 4 2 0 1 2047 2252 1671 2831 -11738 4 2 0 1 1609 2195 1840 2442 -11739 4 2 0 1 1872 2287 1748 2591 -11740 4 2 0 1 1893 1992 1633 2770 -11741 4 2 0 1 880 2073 940 2637 -11742 4 2 0 1 1051 1156 2128 2422 -11743 4 2 0 1 1578 1955 2345 2705 -11744 4 2 0 1 829 691 725 1890 -11745 4 2 0 1 845 1488 1480 148 -11746 4 2 0 1 999 2165 899 2670 -11747 4 2 0 1 993 876 967 2057 -11748 4 2 0 1 1026 2043 1108 2095 -11749 4 2 0 1 1738 1999 2048 2486 -11750 4 2 0 1 1496 1499 1491 2131 -11751 4 2 0 1 1622 1908 2329 2736 -11752 4 2 0 1 332 291 200 2298 -11753 4 2 0 1 1533 1932 2270 2838 -11754 4 2 0 1 555 616 573 1912 -11755 4 2 0 1 1552 2166 2029 2799 -11756 4 2 0 1 1262 1250 1131 2581 -11757 4 2 0 1 1083 1115 1145 1994 -11758 4 2 0 1 1692 1892 2037 2783 -11759 4 2 0 1 1560 1804 2257 2707 -11760 4 2 0 1 1081 2255 1036 2769 -11761 4 2 0 1 1586 1900 2369 2806 -11762 4 2 0 1 1564 2118 2701 2829 -11763 4 2 0 1 1777 2295 2168 2813 -11764 4 2 0 1 1323 1995 1491 2484 -11765 4 2 0 1 1717 2214 1928 2813 -11766 4 2 0 1 1584 2103 2166 2575 -11767 4 2 0 1 1949 2141 1653 2723 -11768 4 2 0 1 1429 1400 1252 2132 -11769 4 2 0 1 977 1894 927 2421 -11770 4 2 0 1 1669 2257 2143 2290 -11771 4 2 0 1 1224 1357 1511 2715 -11772 4 2 0 1 1445 1179 1433 2751 -11773 4 2 0 1 1220 1358 1357 2301 -11774 4 2 0 1 1165 1842 1043 2414 -11775 4 2 0 1 1537 2181 1887 2386 -11776 4 2 0 1 1534 2219 1806 2673 -11777 4 2 0 1 734 527 844 2692 -11778 4 2 0 1 1081 1032 1036 2255 -11779 4 2 0 1 1753 2110 2352 2829 -11780 4 2 0 1 1648 2555 2253 2717 -11781 4 2 0 1 318 1902 2409 2669 -11782 4 2 0 1 224 452 398 2084 -11783 4 2 0 1 1698 2187 2151 2216 -11784 4 2 0 1 440 2533 2328 2819 -11785 4 2 0 1 778 748 851 1933 -11786 4 2 0 1 237 2409 1902 2641 -11787 4 2 0 1 1041 1026 1097 2043 -11788 4 2 0 1 1886 2072 1798 2760 -11789 4 2 0 1 421 2049 362 2464 -11790 4 2 0 1 1162 1085 1150 2191 -11791 4 2 0 1 1592 2122 2059 2827 -11792 4 2 0 1 2151 2187 1698 2648 -11793 4 2 0 1 1878 2142 1666 2440 -11794 4 2 0 1 1639 2220 2654 2743 -11795 4 2 0 1 531 672 594 1845 -11796 4 2 0 1 1138 446 1114 2349 -11797 4 2 0 1 171 464 277 1993 -11798 4 2 0 1 1322 1310 1332 2441 -11799 4 2 0 1 1667 2428 1898 2771 -11800 4 2 0 1 1699 2130 2062 2805 -11801 4 2 0 1 261 441 480 2456 -11802 4 2 0 1 2218 2335 1673 2681 -11803 4 2 0 1 1865 1750 2306 2454 -11804 4 2 0 1 1630 2139 1956 2759 -11805 4 2 0 1 1444 2008 1238 2205 -11806 4 2 0 1 1496 667 1480 2131 -11807 4 2 0 1 373 2005 310 2647 -11808 4 2 0 1 2377 2705 1881 2773 -11809 4 2 0 1 574 1884 536 2456 -11810 4 2 0 1 1738 2061 2486 2650 -11811 4 2 0 1 1741 2158 2700 2839 -11812 4 2 0 1 1854 1743 2598 2729 -11813 4 2 0 1 1610 2385 1839 2439 -11814 4 2 0 1 1297 1312 1349 1922 -11815 4 2 0 1 865 2137 908 2715 -11816 4 2 0 1 606 618 664 2212 -11817 4 2 0 1 1666 2356 1901 2600 -11818 4 2 0 1 1243 1404 1434 2007 -11819 4 2 0 1 305 389 1918 2571 -11820 4 2 0 1 1788 2276 2036 2811 -11821 4 2 0 1 934 960 2259 2734 -11822 4 2 0 1 1853 1575 2646 2660 -11823 4 2 0 1 2029 2166 1709 2799 -11824 4 2 0 1 1182 1248 1277 1976 -11825 4 2 0 1 1996 2539 248 2674 -11826 4 2 0 1 2017 2217 1674 2773 -11827 4 2 0 1 134 663 135 2410 -11828 4 2 0 1 1545 2376 2031 2807 -11829 4 2 0 1 1679 2453 1774 2521 -11830 4 2 0 1 1964 2315 1605 2735 -11831 4 2 0 1 365 350 183 2153 -11832 4 2 0 1 1712 2121 2111 2510 -11833 4 2 0 1 1853 1656 2126 2578 -11834 4 2 0 1 1659 2239 1985 2682 -11835 4 2 0 1 1100 1819 2406 2543 -11836 4 2 0 1 755 709 757 2144 -11837 4 2 0 1 1613 1966 2566 2633 -11838 4 2 0 1 406 320 333 2399 -11839 4 2 0 1 1323 1326 1995 2467 -11840 4 2 0 1 1247 1401 1399 2201 -11841 4 2 0 1 1142 1065 1052 1927 -11842 4 2 0 1 1613 2037 2110 2373 -11843 4 2 0 1 1648 2555 2161 2649 -11844 4 2 0 1 1242 1489 1255 2387 -11845 4 2 0 1 1995 2294 1637 2467 -11846 4 2 0 1 1683 1818 2295 2599 -11847 4 2 0 1 1798 1820 2387 2763 -11848 4 2 0 1 1926 2018 1612 2667 -11849 4 2 0 1 966 927 977 1894 -11850 4 2 0 1 1092 1042 1101 2488 -11851 4 2 0 1 1675 1920 2242 2701 -11852 4 2 0 1 2007 2247 1798 2747 -11853 4 2 0 1 838 1265 1350 2631 -11854 4 2 0 1 1741 2479 2226 2781 -11855 4 2 0 1 499 177 420 1965 -11856 4 2 0 1 1366 2381 2001 2825 -11857 4 2 0 1 287 920 1007 2107 -11858 4 2 0 1 298 322 348 2397 -11859 4 2 0 1 1366 1296 1226 2001 -11860 4 2 0 1 2422 2503 1723 2818 -11861 4 2 0 1 1959 2138 2518 2828 -11862 4 2 0 1 1410 1248 2091 2442 -11863 4 2 0 1 534 564 1990 2344 -11864 4 2 0 1 1110 1914 1097 2696 -11865 4 2 0 1 702 2034 768 2690 -11866 4 2 0 1 1527 2295 1818 2651 -11867 4 2 0 1 2226 2479 1579 2781 -11868 4 2 0 1 1709 2312 1945 2774 -11869 4 2 0 1 467 246 2144 2498 -11870 4 2 0 1 1418 1353 1219 1885 -11871 4 2 0 1 1670 1915 2395 2791 -11872 4 2 0 1 256 335 419 2200 -11873 4 2 0 1 1883 2710 2126 2828 -11874 4 2 0 1 1669 2290 2143 2796 -11875 4 2 0 1 2196 2328 440 2533 -11876 4 2 0 1 1407 1396 1197 2442 -11877 4 2 0 1 1042 1029 1098 2054 -11878 4 2 0 1 1855 2501 811 2585 -11879 4 2 0 1 2034 2529 768 2690 -11880 4 2 0 1 308 201 332 2795 -11881 4 2 0 1 1481 2299 1279 2499 -11882 4 2 0 1 2110 2373 1753 2633 -11883 4 2 0 1 1865 2521 2310 2712 -11884 4 2 0 1 1831 2256 1592 2618 -11885 4 2 0 1 1595 2524 1874 2652 -11886 4 2 0 1 1991 2347 2099 2677 -11887 4 2 0 1 1595 2258 2348 2398 -11888 4 2 0 1 2374 2499 1395 2720 -11889 4 2 0 1 1307 1367 1390 2057 -11890 4 2 0 1 836 819 465 2106 -11891 4 2 0 1 1798 2247 2072 2747 -11892 4 2 0 1 838 746 750 2631 -11893 4 2 0 1 530 598 687 1973 -11894 4 2 0 1 1580 2361 1839 2784 -11895 4 2 0 1 1822 2253 2555 2717 -11896 4 2 0 1 635 604 2536 2786 -11897 4 2 0 1 501 740 736 2217 -11898 4 2 0 1 1579 1943 1971 2479 -11899 4 2 0 1 2146 2301 1797 2625 -11900 4 2 0 1 1788 2284 2276 2712 -11901 4 2 0 1 1059 2140 1021 2346 -11902 4 2 0 1 190 259 254 2124 -11903 4 2 0 1 393 2635 2017 2776 -11904 4 2 0 1 1637 2194 1821 2467 -11905 4 2 0 1 301 291 338 1997 -11906 4 2 0 1 1741 2479 1971 2839 -11907 4 2 0 1 1600 2292 1843 2832 -11908 4 2 0 1 1618 2272 1973 2697 -11909 4 2 0 1 1613 1851 2466 2633 -11910 4 2 0 1 1542 2024 1923 2305 -11911 4 2 0 1 2102 2285 1538 2411 -11912 4 2 0 1 1481 2499 2081 2775 -11913 4 2 0 1 766 703 712 2403 -11914 4 2 0 1 1639 2042 2463 2654 -11915 4 2 0 1 1064 1053 1155 2264 -11916 4 2 0 1 794 851 748 1933 -11917 4 2 0 1 1601 2402 1941 2418 -11918 4 2 0 1 1705 1837 2620 2833 -11919 4 2 0 1 1198 1491 1326 1995 -11920 4 2 0 1 1584 2315 1882 2575 -11921 4 2 0 1 201 2298 332 2795 -11922 4 2 0 1 2160 2731 1559 2758 -11923 4 2 0 1 1549 2195 1840 2617 -11924 4 2 0 1 1074 1096 2405 2642 -11925 4 2 0 1 1795 2040 2228 2541 -11926 4 2 0 1 1825 1637 2281 2393 -11927 4 2 0 1 690 809 2028 2378 -11928 4 2 0 1 1624 2301 1837 2625 -11929 4 2 0 1 1820 1616 2291 2755 -11930 4 2 0 1 295 2446 447 2574 -11931 4 2 0 1 1618 2010 2215 2272 -11932 4 2 0 1 1932 2113 1635 2623 -11933 4 2 0 1 1197 1261 1277 1840 -11934 4 2 0 1 2221 2492 1615 2738 -11935 4 2 0 1 1733 2088 2446 2676 -11936 4 2 0 1 1271 1147 1133 2056 -11937 4 2 0 1 753 818 795 2267 -11938 4 2 0 1 1673 2006 2312 2681 -11939 4 2 0 1 1845 2260 1700 2672 -11940 4 2 0 1 1552 2103 2166 2369 -11941 4 2 0 1 951 2101 2494 2495 -11942 4 2 0 1 1270 1914 1497 2640 -11943 4 2 0 1 1614 2035 2172 2537 -11944 4 2 0 1 966 942 927 1894 -11945 4 2 0 1 1073 1914 2095 2581 -11946 4 2 0 1 1634 1802 2376 2528 -11947 4 2 0 1 1915 2355 494 2824 -11948 4 2 0 1 777 1993 743 2316 -11949 4 2 0 1 1728 2335 1827 2800 -11950 4 2 0 1 1641 2354 1953 2547 -11951 4 2 0 1 798 1942 799 2677 -11952 4 2 0 1 1709 2369 2166 2774 -11953 4 2 0 1 1185 1347 1327 1954 -11954 4 2 0 1 2031 2376 1802 2807 -11955 4 2 0 1 1535 2431 2439 2487 -11956 4 2 0 1 1399 1341 1362 1992 -11957 4 2 0 1 1673 2312 2058 2681 -11958 4 2 0 1 1581 2028 1855 2378 -11959 4 2 0 1 1211 1279 1484 2081 -11960 4 2 0 1 236 2397 2124 2819 -11961 4 2 0 1 1956 2630 1702 2652 -11962 4 2 0 1 881 933 1889 2589 -11963 4 2 0 1 1814 2700 2158 2839 -11964 4 2 0 1 1569 1980 1966 2633 -11965 4 2 0 1 1667 2486 1911 2778 -11966 4 2 0 1 2061 2483 2319 2689 -11967 4 2 0 1 410 177 1965 2752 -11968 4 2 0 1 1481 1279 2081 2499 -11969 4 2 0 1 1592 2618 2122 2827 -11970 4 2 0 1 1534 1814 2221 2673 -11971 4 2 0 1 633 1868 530 2766 -11972 4 2 0 1 987 1498 959 2241 -11973 4 2 0 1 2044 2455 1774 2520 -11974 4 2 0 1 1433 2751 2275 2770 -11975 4 2 0 1 1908 2041 1622 2485 -11976 4 2 0 1 1783 1956 2546 2652 -11977 4 2 0 1 1761 2155 2127 2327 -11978 4 2 0 1 628 1955 142 2687 -11979 4 2 0 1 1136 1142 1052 2394 -11980 4 2 0 1 786 1849 698 2628 -11981 4 2 0 1 1605 1882 2315 2575 -11982 4 2 0 1 1585 1958 2239 2750 -11983 4 2 0 1 916 875 947 2280 -11984 4 2 0 1 751 831 757 2068 -11985 4 2 0 1 666 543 547 1831 -11986 4 2 0 1 1697 2157 2355 2824 -11987 4 2 0 1 1457 2326 1824 2381 -11988 4 2 0 1 1594 1918 2097 2571 -11989 4 2 0 1 1403 1247 1346 2201 -11990 4 2 0 1 1950 1659 2430 2727 -11991 4 2 0 1 1535 2110 1867 2431 -11992 4 2 0 1 1471 1307 1298 2241 -11993 4 2 0 1 585 643 558 1937 -11994 4 2 0 1 597 633 641 2256 -11995 4 2 0 1 1869 2250 1652 2390 -11996 4 2 0 1 1808 1628 2534 2592 -11997 4 2 0 1 2112 2348 1595 2652 -11998 4 2 0 1 1698 2291 2187 2540 -11999 4 2 0 1 349 223 252 2349 -12000 4 2 0 1 159 1142 1136 2394 -12001 4 2 0 1 1676 2237 1902 2669 -12002 4 2 0 1 206 304 1983 2614 -12003 4 2 0 1 833 695 854 2649 -12004 4 2 0 1 553 2009 605 2408 -12005 4 2 0 1 1614 2719 2218 2814 -12006 4 2 0 1 1626 2171 1933 2596 -12007 4 2 0 1 1472 1497 1270 1914 -12008 4 2 0 1 1576 1883 2232 2552 -12009 4 2 0 1 1940 1964 1823 2735 -12010 4 2 0 1 1338 1388 2018 2374 -12011 4 2 0 1 1883 1710 2710 2828 -12012 4 2 0 1 1671 2313 2230 2678 -12013 4 2 0 1 1409 1380 1457 1824 -12014 4 2 0 1 2022 2151 1698 2648 -12015 4 2 0 1 1425 2148 1385 2721 -12016 4 2 0 1 192 223 270 2349 -12017 4 2 0 1 1658 2349 1930 2565 -12018 4 2 0 1 1151 162 161 2035 -12019 4 2 0 1 1590 1850 2159 2528 -12020 4 2 0 1 1573 1899 2139 2630 -12021 4 2 0 1 1745 2179 1869 2777 -12022 4 2 0 1 1859 1665 2153 2639 -12023 4 2 0 1 2598 2729 1743 2787 -12024 4 2 0 1 1329 2284 1303 2453 -12025 4 2 0 1 1863 2384 2075 2817 -12026 4 2 0 1 1913 2405 1130 2713 -12027 4 2 0 1 1813 2196 1655 2328 -12028 4 2 0 1 1668 2207 1813 2399 -12029 4 2 0 1 1582 2089 2149 2426 -12030 4 2 0 1 1955 2120 142 2687 -12031 4 2 0 1 689 2253 823 2649 -12032 4 2 0 1 138 1053 2179 2264 -12033 4 2 0 1 1604 2371 1921 2526 -12034 4 2 0 1 1353 1306 1219 2512 -12035 4 2 0 1 308 332 296 1896 -12036 4 2 0 1 1472 1914 1250 2581 -12037 4 2 0 1 1076 2405 1913 2642 -12038 4 2 0 1 253 2606 1990 2830 -12039 4 2 0 1 2013 2042 1639 2654 -12040 4 2 0 1 589 2132 659 2469 -12041 4 2 0 1 615 2132 589 2393 -12042 4 2 0 1 1009 2562 859 2695 -12043 4 2 0 1 1360 1185 1327 2104 -12044 4 2 0 1 708 704 817 2099 -12045 4 2 0 1 1752 2702 2316 2816 -12046 4 2 0 1 1098 2054 1050 2626 -12047 4 2 0 1 2041 2379 1908 2736 -12048 4 2 0 1 1967 1677 2297 2694 -12049 4 2 0 1 206 304 387 1983 -12050 4 2 0 1 1949 1653 2272 2723 -12051 4 2 0 1 1343 1227 1319 2324 -12052 4 2 0 1 2003 2286 1596 2595 -12053 4 2 0 1 985 923 955 2057 -12054 4 2 0 1 2128 2478 1596 2503 -12055 4 2 0 1 1608 1791 2231 2476 -12056 4 2 0 1 1864 1107 2170 2642 -12057 4 2 0 1 1520 1284 2184 2822 -12058 4 2 0 1 1732 2293 2353 2568 -12059 4 2 0 1 2230 2313 1704 2678 -12060 4 2 0 1 1116 133 1960 2503 -12061 4 2 0 1 1027 1864 1089 2406 -12062 4 2 0 1 1868 2180 1973 2473 -12063 4 2 0 1 1896 2748 2269 2795 -12064 4 2 0 1 2332 2502 2145 2772 -12065 4 2 0 1 912 972 2101 2514 -12066 4 2 0 1 1434 1243 2007 2763 -12067 4 2 0 1 939 2287 883 2715 -12068 4 2 0 1 1643 2209 1946 2793 -12069 4 2 0 1 1977 2163 1690 2445 -12070 4 2 0 1 1592 2059 2314 2380 -12071 4 2 0 1 353 403 234 2066 -12072 4 2 0 1 816 854 695 1860 -12073 4 2 0 1 2187 2291 1616 2540 -12074 4 2 0 1 1537 2214 1963 2739 -12075 4 2 0 1 1515 1064 1155 2264 -12076 4 2 0 1 374 2366 354 2683 -12077 4 2 0 1 1144 1174 1044 2064 -12078 4 2 0 1 2064 2458 1746 2543 -12079 4 2 0 1 1595 2348 2258 2652 -12080 4 2 0 1 1451 1467 2513 2780 -12081 4 2 0 1 134 1152 1960 2410 -12082 4 2 0 1 507 2128 2422 2818 -12083 4 2 0 1 1559 1851 2423 2758 -12084 4 2 0 1 467 2404 453 2445 -12085 4 2 0 1 1325 1361 1219 2325 -12086 4 2 0 1 725 691 825 2451 -12087 4 2 0 1 2095 2229 1661 2582 -12088 4 2 0 1 1963 2142 1537 2243 -12089 4 2 0 1 1132 266 1050 2626 -12090 4 2 0 1 2124 2450 1884 2533 -12091 4 2 0 1 917 911 2241 2591 -12092 4 2 0 1 1699 2336 1979 2757 -12093 4 2 0 1 889 908 1382 2715 -12094 4 2 0 1 1534 2219 2189 2362 -12095 4 2 0 1 762 2034 702 2690 -12096 4 2 0 1 229 2395 1915 2791 -12097 4 2 0 1 759 817 2099 2677 -12098 4 2 0 1 1691 2300 1988 2388 -12099 4 2 0 1 1472 2229 1914 2581 -12100 4 2 0 1 1092 1123 1087 1846 -12101 4 2 0 1 1642 1854 2174 2787 -12102 4 2 0 1 398 205 373 2323 -12103 4 2 0 1 1899 2580 2417 2827 -12104 4 2 0 1 1719 2082 2609 2629 -12105 4 2 0 1 1821 2475 2036 2811 -12106 4 2 0 1 1100 1113 1060 2709 -12107 4 2 0 1 1834 2337 2201 2737 -12108 4 2 0 1 1535 2089 2203 2363 -12109 4 2 0 1 990 871 877 1931 -12110 4 2 0 1 1105 2543 2064 2709 -12111 4 2 0 1 1651 2455 2044 2520 -12112 4 2 0 1 1558 1796 2643 2837 -12113 4 2 0 1 169 338 491 1997 -12114 4 2 0 1 237 318 1902 2409 -12115 4 2 0 1 1718 2106 2436 2502 -12116 4 2 0 1 866 930 948 2233 -12117 4 2 0 1 1219 2325 1885 2512 -12118 4 2 0 1 1551 2532 1953 2547 -12119 4 2 0 1 1646 1901 2195 2716 -12120 4 2 0 1 1042 2054 1098 2488 -12121 4 2 0 1 1770 2286 2003 2595 -12122 4 2 0 1 984 888 857 2129 -12123 4 2 0 1 1075 2581 2095 2582 -12124 4 2 0 1 529 634 646 2169 -12125 4 2 0 1 1577 2312 2058 2748 -12126 4 2 0 1 2054 2488 1723 2626 -12127 4 2 0 1 2119 2384 1711 2769 -12128 4 2 0 1 375 319 345 2468 -12129 4 2 0 1 355 358 178 2679 -12130 4 2 0 1 1370 2475 1323 2484 -12131 4 2 0 1 1750 2348 2258 2398 -12132 4 2 0 1 1939 2134 1594 2607 -12133 4 2 0 1 1153 1127 1145 1994 -12134 4 2 0 1 490 1983 304 2691 -12135 4 2 0 1 1597 2401 1856 2688 -12136 4 2 0 1 1679 2454 2011 2746 -12137 4 2 0 1 1274 1281 2303 2586 -12138 4 2 0 1 770 816 827 2638 -12139 4 2 0 1 346 210 1978 2556 -12140 4 2 0 1 1688 2346 2140 2619 -12141 4 2 0 1 892 1946 982 2477 -12142 4 2 0 1 920 287 479 2803 -12143 4 2 0 1 1674 2277 1955 2732 -12144 4 2 0 1 744 820 716 2379 -12145 4 2 0 1 1148 2522 2733 2777 -12146 4 2 0 1 1282 2563 2229 2582 -12147 4 2 0 1 810 761 1957 2451 -12148 4 2 0 1 1693 2372 2079 2577 -12149 4 2 0 1 2133 2531 1302 2668 -12150 4 2 0 1 1909 2442 1840 2551 -12151 4 2 0 1 1051 1063 1156 2422 -12152 4 2 0 1 874 915 948 2233 -12153 4 2 0 1 499 1965 420 2438 -12154 4 2 0 1 494 229 371 2395 -12155 4 2 0 1 1767 2333 1879 2574 -12156 4 2 0 1 1586 1988 2300 2388 -12157 4 2 0 1 1542 2372 1830 2693 -12158 4 2 0 1 1709 1888 2369 2774 -12159 4 2 0 1 1534 2221 1814 2700 -12160 4 2 0 1 1675 2242 2052 2750 -12161 4 2 0 1 503 905 998 2477 -12162 4 2 0 1 1105 2064 1044 2416 -12163 4 2 0 1 1858 1626 2265 2347 -12164 4 2 0 1 2188 2537 1827 2700 -12165 4 2 0 1 248 2539 1996 2639 -12166 4 2 0 1 1599 2048 1999 2486 -12167 4 2 0 1 228 2457 1905 2645 -12168 4 2 0 1 1757 2363 2089 2426 -12169 4 2 0 1 1341 1362 1992 2337 -12170 4 2 0 1 1128 1159 1173 2140 -12171 4 2 0 1 401 221 343 2464 -12172 4 2 0 1 489 2422 2626 2818 -12173 4 2 0 1 1966 2466 1851 2633 -12174 4 2 0 1 1775 2384 1863 2565 -12175 4 2 0 1 1941 2402 1784 2418 -12176 4 2 0 1 1635 1852 2460 2566 -12177 4 2 0 1 952 901 865 2715 -12178 4 2 0 1 733 2045 823 2253 -12179 4 2 0 1 1808 2299 1628 2592 -12180 4 2 0 1 1696 2177 2361 2742 -12181 4 2 0 1 1932 2309 1835 2449 -12182 4 2 0 1 1242 1352 1489 2094 -12183 4 2 0 1 1779 2808 2164 2809 -12184 4 2 0 1 1258 1391 2326 2825 -12185 4 2 0 1 1015 858 2248 2588 -12186 4 2 0 1 1295 2056 1293 2785 -12187 4 2 0 1 1545 2052 2376 2676 -12188 4 2 0 1 1238 1386 2008 2711 -12189 4 2 0 1 702 768 2529 2690 -12190 4 2 0 1 1610 1839 2363 2439 -12191 4 2 0 1 1677 2745 1841 2761 -12192 4 2 0 1 1761 2612 1875 2689 -12193 4 2 0 1 1857 1679 2284 2712 -12194 4 2 0 1 1544 2625 2226 2833 -12195 4 2 0 1 1151 2035 161 2416 -12196 4 2 0 1 1123 1846 1092 2491 -12197 4 2 0 1 1851 2423 2466 2836 -12198 4 2 0 1 997 906 1485 2184 -12199 4 2 0 1 351 443 188 2333 -12200 4 2 0 1 1707 2146 2625 2833 -12201 4 2 0 1 1612 2016 2370 2429 -12202 4 2 0 1 1675 2271 2065 2401 -12203 4 2 0 1 1584 2216 2019 2549 -12204 4 2 0 1 1648 2253 2649 2717 -12205 4 2 0 1 816 2425 827 2638 -12206 4 2 0 1 1397 1385 1425 2148 -12207 4 2 0 1 215 445 411 2366 -12208 4 2 0 1 1773 2214 1928 2440 -12209 4 2 0 1 1398 1984 1504 2419 -12210 4 2 0 1 320 2020 329 2399 -12211 4 2 0 1 1562 2595 1815 2745 -12212 4 2 0 1 810 766 694 2307 -12213 4 2 0 1 534 572 564 2344 -12214 4 2 0 1 924 989 1016 2125 -12215 4 2 0 1 318 1902 412 2641 -12216 4 2 0 1 1238 2008 1418 2711 -12217 4 2 0 1 1404 2007 1243 2767 -12218 4 2 0 1 634 636 646 2766 -12219 4 2 0 1 1905 2397 394 2815 -12220 4 2 0 1 2226 2625 1837 2833 -12221 4 2 0 1 762 725 824 2451 -12222 4 2 0 1 1845 2180 1573 2759 -12223 4 2 0 1 1110 2346 1914 2696 -12224 4 2 0 1 2002 2407 312 2741 -12225 4 2 0 1 1779 2398 2258 2808 -12226 4 2 0 1 2309 2449 1932 2623 -12227 4 2 0 1 614 638 550 2400 -12228 4 2 0 1 2169 2236 1841 2728 -12229 4 2 0 1 890 951 2101 2494 -12230 4 2 0 1 1343 1346 1834 2737 -12231 4 2 0 1 985 993 967 2057 -12232 4 2 0 1 1615 2421 1894 2695 -12233 4 2 0 1 1693 2174 1854 2598 -12234 4 2 0 1 682 145 146 2497 -12235 4 2 0 1 463 1977 239 2567 -12236 4 2 0 1 1531 1940 2003 2604 -12237 4 2 0 1 1522 1492 139 2264 -12238 4 2 0 1 1600 1843 2292 2492 -12239 4 2 0 1 230 262 511 2685 -12240 4 2 0 1 1614 2416 2035 2537 -12241 4 2 0 1 1640 2335 2218 2681 -12242 4 2 0 1 1591 2134 1939 2607 -12243 4 2 0 1 1443 1199 1509 2435 -12244 4 2 0 1 997 1485 1507 2184 -12245 4 2 0 1 508 2635 336 2714 -12246 4 2 0 1 1336 1362 1192 2337 -12247 4 2 0 1 1535 2203 2089 2304 -12248 4 2 0 1 1016 876 870 1907 -12249 4 2 0 1 891 956 902 2561 -12250 4 2 0 1 241 455 397 2554 -12251 4 2 0 1 2164 2808 1739 2809 -12252 4 2 0 1 1546 2389 2023 2444 -12253 4 2 0 1 1246 1454 1276 2205 -12254 4 2 0 1 1591 2123 1895 2832 -12255 4 2 0 1 1748 2254 1872 2591 -12256 4 2 0 1 140 198 487 2277 -12257 4 2 0 1 368 382 344 2448 -12258 4 2 0 1 1607 1984 2500 2686 -12259 4 2 0 1 2021 1576 2474 2640 -12260 4 2 0 1 1935 2001 1672 2285 -12261 4 2 0 1 1547 2250 1968 2790 -12262 4 2 0 1 1613 2373 2110 2633 -12263 4 2 0 1 667 148 1480 2131 -12264 4 2 0 1 1156 268 131 2128 -12265 4 2 0 1 925 969 871 1931 -12266 4 2 0 1 2152 2592 1889 2644 -12267 4 2 0 1 1562 2141 2314 2728 -12268 4 2 0 1 1638 1885 2234 2325 -12269 4 2 0 1 623 1884 2530 2658 -12270 4 2 0 1 2109 2331 1643 2523 -12271 4 2 0 1 844 2338 721 2692 -12272 4 2 0 1 1789 2601 2228 2621 -12273 4 2 0 1 296 1896 2222 2624 -12274 4 2 0 1 1036 1176 1149 1870 -12275 4 2 0 1 1534 1814 2673 2700 -12276 4 2 0 1 1026 1108 1073 2095 -12277 4 2 0 1 1603 1927 2049 2394 -12278 4 2 0 1 2251 2421 1894 2492 -12279 4 2 0 1 1557 2218 1910 2681 -12280 4 2 0 1 213 222 2020 2438 -12281 4 2 0 1 1601 1941 2402 2480 -12282 4 2 0 1 1863 2564 1658 2565 -12283 4 2 0 1 1682 1969 2437 2807 -12284 4 2 0 1 1567 1891 2433 2706 -12285 4 2 0 1 1883 1539 2232 2648 -12286 4 2 0 1 1743 2136 1858 2729 -12287 4 2 0 1 2128 2350 1990 2830 -12288 4 2 0 1 901 957 893 2137 -12289 4 2 0 1 1850 2323 2159 2528 -12290 4 2 0 1 1209 1379 1372 2493 -12291 4 2 0 1 1674 1881 2508 2732 -12292 4 2 0 1 2019 2216 1698 2549 -12293 4 2 0 1 1885 2325 1219 2711 -12294 4 2 0 1 343 339 176 2268 -12295 4 2 0 1 633 676 641 2321 -12296 4 2 0 1 463 436 239 1977 -12297 4 2 0 1 546 665 2053 2725 -12298 4 2 0 1 1596 2128 1990 2606 -12299 4 2 0 1 474 2297 492 2694 -12300 4 2 0 1 1014 935 884 2461 -12301 4 2 0 1 1498 959 923 1390 -12302 4 2 0 1 1536 2010 2452 2723 -12303 4 2 0 1 145 2425 146 2497 -12304 4 2 0 1 427 375 407 2468 -12305 4 2 0 1 1543 2040 2535 2757 -12306 4 2 0 1 996 502 158 2049 -12307 4 2 0 1 1666 2142 1878 2356 -12308 4 2 0 1 657 651 665 2812 -12309 4 2 0 1 2036 2475 1788 2811 -12310 4 2 0 1 1709 2004 2029 2519 -12311 4 2 0 1 239 436 245 1977 -12312 4 2 0 1 267 449 250 1952 -12313 4 2 0 1 251 2107 477 2612 -12314 4 2 0 1 1636 2381 2703 2704 -12315 4 2 0 1 1347 1340 1327 1954 -12316 4 2 0 1 1693 2213 2014 2598 -12317 4 2 0 1 916 970 1007 2107 -12318 4 2 0 1 616 677 632 2281 -12319 4 2 0 1 2051 2361 1764 2754 -12320 4 2 0 1 1275 2557 1503 2615 -12321 4 2 0 1 1860 2375 2079 2649 -12322 4 2 0 1 1905 2645 2017 2815 -12323 4 2 0 1 1209 1314 1296 2302 -12324 4 2 0 1 1606 1978 1913 2559 -12325 4 2 0 1 172 198 2456 2457 -12326 4 2 0 1 1730 2198 2215 2463 -12327 4 2 0 1 2031 2364 1682 2807 -12328 4 2 0 1 468 2068 425 2404 -12329 4 2 0 1 945 2523 953 2637 -12330 4 2 0 1 1426 1893 2751 2770 -12331 4 2 0 1 1236 2289 1254 2551 -12332 4 2 0 1 455 397 2554 2791 -12333 4 2 0 1 1812 2558 2105 2708 -12334 4 2 0 1 1606 2228 2040 2541 -12335 4 2 0 1 2245 2340 1717 2739 -12336 4 2 0 1 1253 1426 1401 1893 -12337 4 2 0 1 1595 2343 2258 2808 -12338 4 2 0 1 2023 2317 1895 2679 -12339 4 2 0 1 1372 1379 1442 2493 -12340 4 2 0 1 1977 2445 245 2539 -12341 4 2 0 1 962 961 1015 2248 -12342 4 2 0 1 1152 1094 2060 2410 -12343 4 2 0 1 269 422 2217 2277 -12344 4 2 0 1 1862 2331 1643 2426 -12345 4 2 0 1 1686 2412 2336 2448 -12346 4 2 0 1 1536 2010 2427 2452 -12347 4 2 0 1 191 793 2144 2498 -12348 4 2 0 1 1555 2329 2014 2598 -12349 4 2 0 1 751 2068 807 2501 -12350 4 2 0 1 2064 2274 1095 2416 -12351 4 2 0 1 2021 2229 1576 2640 -12352 4 2 0 1 1687 2542 2514 2576 -12353 4 2 0 1 305 389 490 1918 -12354 4 2 0 1 1224 973 889 2715 -12355 4 2 0 1 1104 1842 1165 2733 -12356 4 2 0 1 404 2405 2424 2556 -12357 4 2 0 1 1338 1388 1317 2018 -12358 4 2 0 1 1340 1327 1954 2579 -12359 4 2 0 1 1573 2122 1899 2630 -12360 4 2 0 1 1824 2493 2381 2704 -12361 4 2 0 1 1672 2285 2102 2411 -12362 4 2 0 1 1884 2124 1578 2450 -12363 4 2 0 1 2427 2452 2313 2723 -12364 4 2 0 1 1397 2275 2148 2770 -12365 4 2 0 1 1431 645 561 2132 -12366 4 2 0 1 1632 2273 2056 2785 -12367 4 2 0 1 1810 2529 1580 2718 -12368 4 2 0 1 941 2251 882 2495 -12369 4 2 0 1 1633 2245 1893 2550 -12370 4 2 0 1 1650 2443 2377 2837 -12371 4 2 0 1 1896 2269 308 2795 -12372 4 2 0 1 1578 2345 1884 2450 -12373 4 2 0 1 1592 1841 2314 2321 -12374 4 2 0 1 755 789 793 2144 -12375 4 2 0 1 1111 1098 2054 2488 -12376 4 2 0 1 262 444 466 2685 -12377 4 2 0 1 1645 2386 2181 2549 -12378 4 2 0 1 1618 2010 2272 2697 -12379 4 2 0 1 1278 1196 1287 2785 -12380 4 2 0 1 1705 2627 2226 2833 -12381 4 2 0 1 1857 2284 1679 2453 -12382 4 2 0 1 1854 2729 2598 2787 -12383 4 2 0 1 305 2571 1918 2691 -12384 4 2 0 1 798 693 799 1942 -12385 4 2 0 1 1517 2026 1468 2724 -12386 4 2 0 1 1614 2064 2719 2814 -12387 4 2 0 1 2008 2711 1642 2801 -12388 4 2 0 1 2088 2164 1879 2676 -12389 4 2 0 1 1093 1090 2043 2518 -12390 4 2 0 1 594 1845 672 2672 -12391 4 2 0 1 1449 1935 2247 2825 -12392 4 2 0 1 1140 1128 1173 2274 -12393 4 2 0 1 1829 2268 1789 2357 -12394 4 2 0 1 1527 2116 2651 2798 -12395 4 2 0 1 2480 2673 1814 2839 -12396 4 2 0 1 1224 1511 1473 973 -12397 4 2 0 1 1859 2639 183 2647 -12398 4 2 0 1 1035 2170 1107 2642 -12399 4 2 0 1 1333 1214 1303 1857 -12400 4 2 0 1 1656 2187 2151 2648 -12401 4 2 0 1 992 2035 981 2734 -12402 4 2 0 1 794 1201 790 2171 -12403 4 2 0 1 1328 1231 1330 2194 -12404 4 2 0 1 651 1828 665 2812 -12405 4 2 0 1 2097 2319 2086 2821 -12406 4 2 0 1 930 974 964 2365 -12407 4 2 0 1 1869 2197 2250 2390 -12408 4 2 0 1 621 572 534 2344 -12409 4 2 0 1 1856 2688 2401 2809 -12410 4 2 0 1 1871 2343 2524 2808 -12411 4 2 0 1 698 1849 786 2692 -12412 4 2 0 1 488 478 442 1927 -12413 4 2 0 1 1597 2308 2150 2688 -12414 4 2 0 1 536 1884 623 2658 -12415 4 2 0 1 2065 1856 2271 2602 -12416 4 2 0 1 688 542 2246 2725 -12417 4 2 0 1 912 972 2514 2576 -12418 4 2 0 1 1073 1131 1914 2581 -12419 4 2 0 1 1886 2627 2226 2760 -12420 4 2 0 1 484 311 182 2211 -12421 4 2 0 1 1764 1974 2370 2835 -12422 4 2 0 1 1677 2344 2745 2761 -12423 4 2 0 1 1640 2108 2006 2681 -12424 4 2 0 1 1288 1199 1248 1976 -12425 4 2 0 1 1315 1944 2531 2720 -12426 4 2 0 1 1919 2134 1546 2389 -12427 4 2 0 1 1858 1626 2347 2608 -12428 4 2 0 1 1257 1430 1828 2812 -12429 4 2 0 1 512 489 2225 2626 -12430 4 2 0 1 422 2217 2277 2645 -12431 4 2 0 1 467 2144 468 2404 -12432 4 2 0 1 413 377 465 2106 -12433 4 2 0 1 1634 2323 1850 2528 -12434 4 2 0 1 1739 2311 2168 2527 -12435 4 2 0 1 1688 2043 2346 2810 -12436 4 2 0 1 319 1939 345 2468 -12437 4 2 0 1 690 2045 733 2378 -12438 4 2 0 1 323 344 1979 2448 -12439 4 2 0 1 1631 2156 2269 2795 -12440 4 2 0 1 1648 2161 1860 2649 -12441 4 2 0 1 1538 2285 1943 2411 -12442 4 2 0 1 208 295 447 2574 -12443 4 2 0 1 1095 2064 1044 2274 -12444 4 2 0 1 1630 1845 2139 2759 -12445 4 2 0 1 1579 2072 1886 2760 -12446 4 2 0 1 1629 2436 2106 2502 -12447 4 2 0 1 1774 2199 1804 2520 -12448 4 2 0 1 2121 2510 1712 2794 -12449 4 2 0 1 1830 1597 2308 2506 -12450 4 2 0 1 138 1053 1117 2179 -12451 4 2 0 1 770 714 854 2161 -12452 4 2 0 1 426 1809 247 2658 -12453 4 2 0 1 1243 1236 1378 2289 -12454 4 2 0 1 463 239 230 2567 -12455 4 2 0 1 1180 2021 1482 2229 -12456 4 2 0 1 2423 2758 2466 2836 -12457 4 2 0 1 1048 1017 2064 2543 -12458 4 2 0 1 1954 2104 1639 2579 -12459 4 2 0 1 1529 1945 2312 2774 -12460 4 2 0 1 2120 2377 1662 2705 -12461 4 2 0 1 1567 1948 2260 2706 -12462 4 2 0 1 1027 1089 1864 2642 -12463 4 2 0 1 1166 1172 2349 2564 -12464 4 2 0 1 229 1915 379 2791 -12465 4 2 0 1 1766 2180 1845 2759 -12466 4 2 0 1 1952 2209 1800 2793 -12467 4 2 0 1 731 792 723 2135 -12468 4 2 0 1 452 398 2084 2323 -12469 4 2 0 1 934 960 887 2259 -12470 4 2 0 1 1735 2250 2197 2500 -12471 4 2 0 1 1005 960 944 2382 -12472 4 2 0 1 425 2068 377 2404 -12473 4 2 0 1 1719 2275 2148 2767 -12474 4 2 0 1 1963 1717 2340 2739 -12475 4 2 0 1 1295 1293 1181 2785 -12476 4 2 0 1 547 619 588 2046 -12477 4 2 0 1 1906 1769 2608 2780 -12478 4 2 0 1 1047 1092 1101 2491 -12479 4 2 0 1 1735 2264 2179 2434 -12480 4 2 0 1 1664 2259 1873 2382 -12481 4 2 0 1 400 2196 1809 2661 -12482 4 2 0 1 260 2422 1070 2626 -12483 4 2 0 1 1330 1216 1347 2655 -12484 4 2 0 1 1674 2217 2017 2645 -12485 4 2 0 1 385 456 167 2159 -12486 4 2 0 1 1929 2394 1603 2561 -12487 4 2 0 1 1809 2530 1884 2658 -12488 4 2 0 1 486 189 279 2330 -12489 4 2 0 1 1232 1325 1333 2012 -12490 4 2 0 1 704 759 817 2099 -12491 4 2 0 1 1929 2416 1614 2709 -12492 4 2 0 1 1936 2099 1769 2608 -12493 4 2 0 1 1629 2074 1855 2772 -12494 4 2 0 1 338 2605 1997 2691 -12495 4 2 0 1 706 781 812 1936 -12496 4 2 0 1 1766 1845 2192 2759 -12497 4 2 0 1 1873 2421 2251 2492 -12498 4 2 0 1 1196 2178 2117 2730 -12499 4 2 0 1 2198 2342 1730 2724 -12500 4 2 0 1 2117 2223 1623 2730 -12501 4 2 0 1 1917 1551 2547 2611 -12502 4 2 0 1 1674 1955 2705 2732 -12503 4 2 0 1 1638 1857 2325 2515 -12504 4 2 0 1 2289 2609 1719 2767 -12505 4 2 0 1 1279 2299 2081 2499 -12506 4 2 0 1 1613 2466 2111 2566 -12507 4 2 0 1 1914 1576 2229 2640 -12508 4 2 0 1 633 2321 1868 2766 -12509 4 2 0 1 1884 2533 1809 2658 -12510 4 2 0 1 1536 2272 2010 2723 -12511 4 2 0 1 1418 1238 1389 2008 -12512 4 2 0 1 1854 2234 1998 2729 -12513 4 2 0 1 1122 1124 1134 2138 -12514 4 2 0 1 2086 2319 1875 2689 -12515 4 2 0 1 1745 2410 2060 2733 -12516 4 2 0 1 363 315 354 2123 -12517 4 2 0 1 641 619 547 2256 -12518 4 2 0 1 1262 1472 1250 2581 -12519 4 2 0 1 1543 2025 2075 2660 -12520 4 2 0 1 1714 2320 2105 2534 -12521 4 2 0 1 1595 2398 2348 2572 -12522 4 2 0 1 1213 2302 1926 2788 -12523 4 2 0 1 1546 2134 2023 2389 -12524 4 2 0 1 1699 2412 2336 2757 -12525 4 2 0 1 660 1912 616 2283 -12526 4 2 0 1 352 207 2130 2269 -12527 4 2 0 1 1680 2536 2753 2802 -12528 4 2 0 1 1702 2139 1899 2630 -12529 4 2 0 1 1664 2382 1873 2738 -12530 4 2 0 1 1148 1058 2522 2777 -12531 4 2 0 1 1535 2431 1862 2439 -12532 4 2 0 1 1946 2338 1643 2628 -12533 4 2 0 1 829 803 691 1890 -12534 4 2 0 1 1304 2133 1462 2302 -12535 4 2 0 1 1703 2466 1851 2758 -12536 4 2 0 1 1313 1302 2133 2531 -12537 4 2 0 1 1920 1564 2242 2701 -12538 4 2 0 1 1538 1844 2470 2703 -12539 4 2 0 1 1112 1049 1099 2804 -12540 4 2 0 1 1688 2346 2619 2810 -12541 4 2 0 1 755 2144 793 2498 -12542 4 2 0 1 1386 1191 2263 2711 -12543 4 2 0 1 974 962 964 2365 -12544 4 2 0 1 1034 2582 2095 2603 -12545 4 2 0 1 1565 1998 2234 2729 -12546 4 2 0 1 191 793 789 2144 -12547 4 2 0 1 1617 2175 1972 2282 -12548 4 2 0 1 169 338 1997 2691 -12549 4 2 0 1 1536 2427 2313 2723 -12550 4 2 0 1 1315 1320 1475 1944 -12551 4 2 0 1 1134 1093 2458 2518 -12552 4 2 0 1 604 541 554 2530 -12553 4 2 0 1 1992 2337 1620 2340 -12554 4 2 0 1 1138 1154 1080 1930 -12555 4 2 0 1 1536 2463 1866 2743 -12556 4 2 0 1 1654 2241 1872 2591 -12557 4 2 0 1 1568 2340 1963 2820 -12558 4 2 0 1 1085 1129 2170 2584 -12559 4 2 0 1 1736 2399 2020 2417 -12560 4 2 0 1 1506 1381 1516 2278 -12561 4 2 0 1 1135 1020 1120 2491 -12562 4 2 0 1 1612 2370 2033 2392 -12563 4 2 0 1 175 2066 403 2674 -12564 4 2 0 1 1909 2148 1719 2243 -12565 4 2 0 1 1342 1177 1306 2512 -12566 4 2 0 1 1687 2317 2023 2679 -12567 4 2 0 1 1712 2460 1852 2566 -12568 4 2 0 1 1701 2524 1871 2698 -12569 4 2 0 1 1609 1976 2195 2442 -12570 4 2 0 1 566 139 138 2419 -12571 4 2 0 1 2275 2318 1633 2550 -12572 4 2 0 1 2068 2144 1765 2404 -12573 4 2 0 1 975 860 960 2382 -12574 4 2 0 1 575 582 441 2456 -12575 4 2 0 1 834 195 277 2498 -12576 4 2 0 1 2062 2412 1686 2448 -12577 4 2 0 1 929 931 867 2073 -12578 4 2 0 1 1775 2075 2040 2535 -12579 4 2 0 1 458 1996 248 2674 -12580 4 2 0 1 739 735 1203 2135 -12581 4 2 0 1 1681 2424 2405 2556 -12582 4 2 0 1 243 2606 2173 2752 -12583 4 2 0 1 1959 2043 1688 2810 -12584 4 2 0 1 1105 2064 2416 2709 -12585 4 2 0 1 1311 1428 1223 1924 -12586 4 2 0 1 810 761 766 1957 -12587 4 2 0 1 1595 2112 2116 2798 -12588 4 2 0 1 1633 2550 2318 2739 -12589 4 2 0 1 1607 2500 2026 2686 -12590 4 2 0 1 1285 1293 1295 2056 -12591 4 2 0 1 1046 1131 1250 1914 -12592 4 2 0 1 2022 2223 1708 2730 -12593 4 2 0 1 1529 2006 2312 2656 -12594 4 2 0 1 1733 2446 2574 2676 -12595 4 2 0 1 1822 2436 1855 2772 -12596 4 2 0 1 675 662 549 2672 -12597 4 2 0 1 982 892 976 1946 -12598 4 2 0 1 1615 2636 2224 2738 -12599 4 2 0 1 196 280 527 2692 -12600 4 2 0 1 2065 2271 1856 2401 -12601 4 2 0 1 1821 1627 2475 2811 -12602 4 2 0 1 1337 1305 1177 2016 -12603 4 2 0 1 302 2262 494 2395 -12604 4 2 0 1 1076 1913 1130 2713 -12605 4 2 0 1 739 2135 1203 2722 -12606 4 2 0 1 1879 2574 2446 2676 -12607 4 2 0 1 290 498 293 2262 -12608 4 2 0 1 2014 2213 1743 2598 -12609 4 2 0 1 801 802 797 2028 -12610 4 2 0 1 191 246 281 2498 -12611 4 2 0 1 2042 1663 2342 2463 -12612 4 2 0 1 1333 1377 1214 2325 -12613 4 2 0 1 1798 2247 2007 2763 -12614 4 2 0 1 1172 1037 1154 2565 -12615 4 2 0 1 1529 2312 1925 2774 -12616 4 2 0 1 1366 1393 2381 2825 -12617 4 2 0 1 1038 1102 2202 2564 -12618 4 2 0 1 1772 2318 2275 2550 -12619 4 2 0 1 1849 698 2628 2692 -12620 4 2 0 1 422 2277 518 2645 -12621 4 2 0 1 1709 2369 2309 2799 -12622 4 2 0 1 1786 2753 2536 2802 -12623 4 2 0 1 1696 2184 2177 2742 -12624 4 2 0 1 2213 2577 2014 2717 -12625 4 2 0 1 227 457 407 2468 -12626 4 2 0 1 469 396 417 2662 -12627 4 2 0 1 1618 2246 1973 2367 -12628 4 2 0 1 928 965 983 2162 -12629 4 2 0 1 1605 2147 1915 2395 -12630 4 2 0 1 1630 2192 1845 2759 -12631 4 2 0 1 2400 2610 1809 2661 -12632 4 2 0 1 1107 1164 1089 1864 -12633 4 2 0 1 1023 2346 1110 2696 -12634 4 2 0 1 1740 2347 2099 2608 -12635 4 2 0 1 767 2375 711 2649 -12636 4 2 0 1 138 137 671 2179 -12637 4 2 0 1 1448 1386 1191 2263 -12638 4 2 0 1 1955 2277 1674 2457 -12639 4 2 0 1 2193 1704 2313 2678 -12640 4 2 0 1 319 2468 375 2571 -12641 4 2 0 1 1704 2193 2141 2823 -12642 4 2 0 1 1662 2377 2100 2443 -12643 4 2 0 1 1693 2014 2213 2577 -12644 4 2 0 1 1816 2332 1629 2502 -12645 4 2 0 1 2258 2398 1779 2688 -12646 4 2 0 1 598 596 683 1973 -12647 4 2 0 1 2361 2392 1764 2754 -12648 4 2 0 1 714 2161 718 2555 -12649 4 2 0 1 1517 1184 2342 2724 -12650 4 2 0 1 1640 2006 2244 2335 -12651 4 2 0 1 440 232 439 2819 -12652 4 2 0 1 2036 2454 1679 2746 -12653 4 2 0 1 299 183 310 2647 -12654 4 2 0 1 1862 2331 1559 2793 -12655 4 2 0 1 350 509 239 2153 -12656 4 2 0 1 333 356 2207 2399 -12657 4 2 0 1 1354 1355 1368 2507 -12658 4 2 0 1 1689 2348 2112 2652 -12659 4 2 0 1 2078 2703 1678 2704 -12660 4 2 0 1 2398 2527 1683 2798 -12661 4 2 0 1 1819 2709 2394 2764 -12662 4 2 0 1 2226 2479 1741 2800 -12663 4 2 0 1 2165 2670 1771 2742 -12664 4 2 0 1 1595 2116 2524 2808 -12665 4 2 0 1 614 599 638 1948 -12666 4 2 0 1 1294 2379 1470 2485 -12667 4 2 0 1 920 2107 287 2803 -12668 4 2 0 1 1851 2466 2423 2758 -12669 4 2 0 1 1297 1349 1214 2044 -12670 4 2 0 1 577 1990 564 2830 -12671 4 2 0 1 2232 2552 1883 2648 -12672 4 2 0 1 2162 2279 1751 2636 -12673 4 2 0 1 1837 2740 1755 2781 -12674 4 2 0 1 2160 2385 1610 2731 -12675 4 2 0 1 772 711 700 2375 -12676 4 2 0 1 552 2344 621 2761 -12677 4 2 0 1 1829 2357 1789 2613 -12678 4 2 0 1 420 1861 462 2438 -12679 4 2 0 1 564 2344 625 2350 -12680 4 2 0 1 1562 2175 2141 2728 -12681 4 2 0 1 1967 2606 243 2752 -12682 4 2 0 1 535 558 579 1984 -12683 4 2 0 1 901 944 898 2070 -12684 4 2 0 1 1717 1928 2214 2820 -12685 4 2 0 1 2150 2308 1597 2506 -12686 4 2 0 1 321 2130 316 2601 -12687 4 2 0 1 1225 1358 1331 2076 -12688 4 2 0 1 1410 1412 1230 2091 -12689 4 2 0 1 1370 1215 1323 2475 -12690 4 2 0 1 1914 1576 2095 2229 -12691 4 2 0 1 708 754 2171 2596 -12692 4 2 0 1 917 923 878 2241 -12693 4 2 0 1 846 269 736 2277 -12694 4 2 0 1 1918 1722 2517 2691 -12695 4 2 0 1 1316 1186 2094 2740 -12696 4 2 0 1 1303 2284 1857 2453 -12697 4 2 0 1 1888 2166 2103 2369 -12698 4 2 0 1 912 2514 918 2576 -12699 4 2 0 1 600 655 2192 2663 -12700 4 2 0 1 2452 2473 2122 2723 -12701 4 2 0 1 809 848 811 1855 -12702 4 2 0 1 1308 1188 1319 2324 -12703 4 2 0 1 341 1978 210 2601 -12704 4 2 0 1 452 2084 409 2574 -12705 4 2 0 1 707 751 807 2501 -12706 4 2 0 1 185 642 189 2330 -12707 4 2 0 1 1578 1950 2450 2727 -12708 4 2 0 1 1375 1330 1231 2194 -12709 4 2 0 1 445 215 362 1847 -12710 4 2 0 1 1959 2518 1710 2828 -12711 4 2 0 1 1983 2605 304 2691 -12712 4 2 0 1 2034 2307 1621 2451 -12713 4 2 0 1 1066 1508 1157 2278 -12714 4 2 0 1 1048 2064 1105 2543 -12715 4 2 0 1 1731 2499 2374 2720 -12716 4 2 0 1 215 378 362 1847 -12717 4 2 0 1 376 2539 248 2639 -12718 4 2 0 1 1107 1864 1089 2642 -12719 4 2 0 1 1190 2171 1276 2513 -12720 4 2 0 1 596 688 542 2246 -12721 4 2 0 1 1269 1512 1251 2822 -12722 4 2 0 1 611 2281 555 2294 -12723 4 2 0 1 744 781 746 2379 -12724 4 2 0 1 2021 2387 1705 2755 -12725 4 2 0 1 1863 1575 2570 2817 -12726 4 2 0 1 1868 2256 1592 2321 -12727 4 2 0 1 2063 2386 1645 2549 -12728 4 2 0 1 1844 1636 2470 2703 -12729 4 2 0 1 1209 2381 1379 2493 -12730 4 2 0 1 298 1982 209 2446 -12731 4 2 0 1 1577 2004 2312 2748 -12732 4 2 0 1 1908 1622 2358 2485 -12733 4 2 0 1 1835 1695 2449 2799 -12734 4 2 0 1 1674 2508 1881 2773 -12735 4 2 0 1 1695 1997 2449 2568 -12736 4 2 0 1 1292 2563 1282 2582 -12737 4 2 0 1 934 2259 992 2734 -12738 4 2 0 1 2117 2551 1623 2617 -12739 4 2 0 1 1193 1441 1239 2322 -12740 4 2 0 1 1667 1832 2248 2588 -12741 4 2 0 1 734 844 721 2692 -12742 4 2 0 1 1177 1922 1297 2512 -12743 4 2 0 1 1480 148 1488 2131 -12744 4 2 0 1 1755 2740 2420 2781 -12745 4 2 0 1 1196 1268 2178 2730 -12746 4 2 0 1 1855 2074 1581 2772 -12747 4 2 0 1 494 2262 498 2355 -12748 4 2 0 1 385 456 2159 2407 -12749 4 2 0 1 1818 1683 2295 2798 -12750 4 2 0 1 2168 2296 1777 2813 -12751 4 2 0 1 1527 2295 2527 2798 -12752 4 2 0 1 1903 2157 1697 2657 -12753 4 2 0 1 1640 2218 2108 2681 -12754 4 2 0 1 2101 2251 1600 2495 -12755 4 2 0 1 1926 2102 1678 2765 -12756 4 2 0 1 1756 1964 2315 2792 -12757 4 2 0 1 1196 2178 1287 2785 -12758 4 2 0 1 864 891 902 2495 -12759 4 2 0 1 1527 2296 2168 2813 -12760 4 2 0 1 474 243 1967 2606 -12761 4 2 0 1 1201 1264 1276 2171 -12762 4 2 0 1 327 288 289 2157 -12763 4 2 0 1 378 421 362 2464 -12764 4 2 0 1 1586 1988 2290 2806 -12765 4 2 0 1 803 1890 829 2684 -12766 4 2 0 1 1137 1123 1055 2570 -12767 4 2 0 1 1325 1232 1411 2012 -12768 4 2 0 1 1245 1321 1178 2455 -12769 4 2 0 1 361 2614 206 2669 -12770 4 2 0 1 1688 2043 1959 2458 -12771 4 2 0 1 1779 2398 2808 2809 -12772 4 2 0 1 873 2155 1006 2542 -12773 4 2 0 1 653 144 145 2638 -12774 4 2 0 1 1559 2331 1862 2731 -12775 4 2 0 1 209 348 402 1982 -12776 4 2 0 1 872 878 967 2279 -12777 4 2 0 1 2128 2503 2422 2818 -12778 4 2 0 1 1443 2026 1517 2507 -12779 4 2 0 1 2673 2700 1814 2839 -12780 4 2 0 1 1680 2536 1934 2753 -12781 4 2 0 1 656 646 605 2169 -12782 4 2 0 1 2328 2533 1655 2819 -12783 4 2 0 1 663 652 135 1972 -12784 4 2 0 1 1927 1603 2049 2464 -12785 4 2 0 1 1108 1026 1090 2043 -12786 4 2 0 1 349 323 1979 2559 -12787 4 2 0 1 1536 1866 2427 2743 -12788 4 2 0 1 474 1967 255 2297 -12789 4 2 0 1 739 1203 1524 2722 -12790 4 2 0 1 1141 1094 2410 2733 -12791 4 2 0 1 1679 1865 2454 2712 -12792 4 2 0 1 1482 2021 1255 2640 -12793 4 2 0 1 749 821 743 1993 -12794 4 2 0 1 1674 1905 2457 2645 -12795 4 2 0 1 1759 2266 2065 2471 -12796 4 2 0 1 1258 1391 1445 2326 -12797 4 2 0 1 1054 1023 1066 2696 -12798 4 2 0 1 513 519 2157 2355 -12799 4 2 0 1 978 2327 994 2803 -12800 4 2 0 1 209 298 348 1982 -12801 4 2 0 1 1127 1036 1032 2255 -12802 4 2 0 1 2229 2563 1661 2582 -12803 4 2 0 1 744 700 781 2041 -12804 4 2 0 1 1613 2466 1966 2633 -12805 4 2 0 1 1887 1666 2386 2600 -12806 4 2 0 1 411 434 2101 2494 -12807 4 2 0 1 1807 2318 2550 2739 -12808 4 2 0 1 160 161 896 1929 -12809 4 2 0 1 429 2606 2128 2818 -12810 4 2 0 1 1269 1251 2051 2822 -12811 4 2 0 1 247 426 400 1809 -12812 4 2 0 1 760 809 811 1855 -12813 4 2 0 1 1638 2325 2234 2515 -12814 4 2 0 1 1527 2527 2116 2798 -12815 4 2 0 1 2120 2705 1955 2732 -12816 4 2 0 1 1959 2138 1746 2458 -12817 4 2 0 1 2132 2393 1758 2469 -12818 4 2 0 1 327 312 2407 2741 -12819 4 2 0 1 1406 1392 1924 2358 -12820 4 2 0 1 1175 2138 1086 2518 -12821 4 2 0 1 1688 2619 2182 2810 -12822 4 2 0 1 369 355 178 2679 -12823 4 2 0 1 1752 2532 2702 2816 -12824 4 2 0 1 1186 2620 2094 2740 -12825 4 2 0 1 1912 2235 1627 2371 -12826 4 2 0 1 1027 1864 2406 2642 -12827 4 2 0 1 436 245 1977 2445 -12828 4 2 0 1 207 294 316 2624 -12829 4 2 0 1 1704 2452 2122 2723 -12830 4 2 0 1 1680 2154 2450 2802 -12831 4 2 0 1 1449 1226 1935 2825 -12832 4 2 0 1 2006 2108 1640 2548 -12833 4 2 0 1 1138 1172 1154 1930 -12834 4 2 0 1 1655 2328 2196 2533 -12835 4 2 0 1 2010 2452 2272 2473 -12836 4 2 0 1 1606 1979 2535 2757 -12837 4 2 0 1 1581 2378 1855 2772 -12838 4 2 0 1 2252 2440 1928 2820 -12839 4 2 0 1 2024 2235 1627 2305 -12840 4 2 0 1 302 392 293 2262 -12841 4 2 0 1 1098 1072 1050 2054 -12842 4 2 0 1 1282 2229 1472 2581 -12843 4 2 0 1 2065 2306 1856 2602 -12844 4 2 0 1 1724 1889 2589 2644 -12845 4 2 0 1 901 2137 865 2715 -12846 4 2 0 1 458 1996 2674 2744 -12847 4 2 0 1 653 2212 144 2638 -12848 4 2 0 1 2095 2581 2229 2582 -12849 4 2 0 1 1679 1857 2521 2712 -12850 4 2 0 1 874 2233 948 2553 -12851 4 2 0 1 696 2217 2508 2732 -12852 4 2 0 1 1632 2117 2178 2223 -12853 4 2 0 1 491 291 292 2298 -12854 4 2 0 1 1682 2437 2031 2807 -12855 4 2 0 1 352 308 207 2269 -12856 4 2 0 1 552 612 2344 2761 -12857 4 2 0 1 1668 2481 1899 2580 -12858 4 2 0 1 1536 2215 2010 2272 -12859 4 2 0 1 314 394 2397 2815 -12860 4 2 0 1 2336 2622 2025 2792 -12861 4 2 0 1 1862 2331 1610 2731 -12862 4 2 0 1 1459 1481 2081 2775 -12863 4 2 0 1 1529 2312 1945 2656 -12864 4 2 0 1 802 690 809 2028 -12865 4 2 0 1 926 1015 858 2248 -12866 4 2 0 1 1576 2474 2619 2810 -12867 4 2 0 1 2138 2191 1587 2584 -12868 4 2 0 1 1833 2653 2239 2750 -12869 4 2 0 1 602 598 683 2587 -12870 4 2 0 1 2267 2316 1752 2702 -12871 4 2 0 1 305 1918 490 2691 -12872 4 2 0 1 1735 2500 1984 2686 -12873 4 2 0 1 2348 2398 1750 2572 -12874 4 2 0 1 1082 1137 1019 2570 -12875 4 2 0 1 364 2641 414 2826 -12876 4 2 0 1 584 610 2530 2658 -12877 4 2 0 1 1616 1883 2552 2648 -12878 4 2 0 1 1630 2210 2154 2753 -12879 4 2 0 1 2107 2612 251 2803 -12880 4 2 0 1 1835 2449 2309 2799 -12881 4 2 0 1 1642 2234 1854 2787 -12882 4 2 0 1 2175 2282 1836 2790 -12883 4 2 0 1 315 212 313 2353 -12884 4 2 0 1 1818 1671 2651 2831 -12885 4 2 0 1 1135 1088 1055 1975 -12886 4 2 0 1 2247 2326 1391 2825 -12887 4 2 0 1 454 436 433 2445 -12888 4 2 0 1 2163 1690 2702 2816 -12889 4 2 0 1 1368 1443 1517 2507 -12890 4 2 0 1 1017 1122 1134 2458 -12891 4 2 0 1 747 745 2106 2436 -12892 4 2 0 1 306 324 204 2190 -12893 4 2 0 1 290 2062 498 2262 -12894 4 2 0 1 1535 2304 1892 2665 -12895 4 2 0 1 1038 2202 1126 2564 -12896 4 2 0 1 1581 2045 2378 2717 -12897 4 2 0 1 1680 2154 2433 2450 -12898 4 2 0 1 1048 1044 1105 2064 -12899 4 2 0 1 1260 2177 1512 2822 -12900 4 2 0 1 1890 2204 1621 2634 -12901 4 2 0 1 1315 2531 1376 2720 -12902 4 2 0 1 1315 1320 1944 2720 -12903 4 2 0 1 1145 1139 1153 1994 -12904 4 2 0 1 587 643 585 1937 -12905 4 2 0 1 1664 2221 2700 2738 -12906 4 2 0 1 411 2101 173 2317 -12907 4 2 0 1 1623 2181 1887 2629 -12908 4 2 0 1 1012 877 994 2155 -12909 4 2 0 1 1683 2306 1856 2398 -12910 4 2 0 1 1744 2402 1941 2480 -12911 4 2 0 1 657 665 1828 2812 -12912 4 2 0 1 1920 1634 2242 2699 -12913 4 2 0 1 1903 2157 2741 2779 -12914 4 2 0 1 1457 1824 2326 2751 -12915 4 2 0 1 1875 1594 2097 2468 -12916 4 2 0 1 1890 2634 2034 2684 -12917 4 2 0 1 1653 2272 1973 2587 -12918 4 2 0 1 1224 1382 1357 2715 -12919 4 2 0 1 1744 2411 2208 2794 -12920 4 2 0 1 482 158 502 2049 -12921 4 2 0 1 1712 2102 2460 2794 -12922 4 2 0 1 1548 2224 2096 2636 -12923 4 2 0 1 191 2144 246 2498 -12924 4 2 0 1 990 925 871 1931 -12925 4 2 0 1 425 234 175 2404 -12926 4 2 0 1 628 568 2345 2687 -12927 4 2 0 1 1183 1246 1933 2557 -12928 4 2 0 1 696 722 736 2217 -12929 4 2 0 1 1605 2575 2315 2797 -12930 4 2 0 1 1789 1978 2228 2601 -12931 4 2 0 1 483 448 265 2086 -12932 4 2 0 1 597 530 633 1868 -12933 4 2 0 1 2006 1673 2335 2681 -12934 4 2 0 1 1667 2428 1911 2650 -12935 4 2 0 1 1699 2412 2062 2448 -12936 4 2 0 1 1700 2481 1899 2618 -12937 4 2 0 1 1742 2026 2500 2686 -12938 4 2 0 1 900 953 892 2637 -12939 4 2 0 1 1176 1030 1084 2603 -12940 4 2 0 1 1257 1414 1200 2053 -12941 4 2 0 1 1941 2418 1784 2623 -12942 4 2 0 1 772 785 711 2375 -12943 4 2 0 1 1059 1110 1023 2346 -12944 4 2 0 1 1611 2271 1856 2602 -12945 4 2 0 1 615 583 2132 2393 -12946 4 2 0 1 1967 474 2606 2694 -12947 4 2 0 1 1903 2002 1695 2741 -12948 4 2 0 1 1716 2641 2490 2826 -12949 4 2 0 1 1928 2252 1598 2440 -12950 4 2 0 1 1704 2122 2059 2314 -12951 4 2 0 1 592 650 666 2359 -12952 4 2 0 1 810 2307 694 2451 -12953 4 2 0 1 1161 2191 1162 2384 -12954 4 2 0 1 331 2647 1996 2744 -12955 4 2 0 1 1613 1966 2466 2566 -12956 4 2 0 1 2122 2618 1899 2827 -12957 4 2 0 1 2317 2514 2101 2576 -12958 4 2 0 1 544 2069 593 2663 -12959 4 2 0 1 319 1939 2468 2571 -12960 4 2 0 1 173 972 271 2101 -12961 4 2 0 1 1175 1124 2138 2518 -12962 4 2 0 1 249 414 2821 2826 -12963 4 2 0 1 768 702 762 2034 -12964 4 2 0 1 1639 2042 2013 2579 -12965 4 2 0 1 1064 1025 1053 2339 -12966 4 2 0 1 1229 1413 1337 2667 -12967 4 2 0 1 993 2057 985 2462 -12968 4 2 0 1 2264 2434 1735 2435 -12969 4 2 0 1 1617 2282 1972 2410 -12970 4 2 0 1 1558 1881 2377 2643 -12971 4 2 0 1 2111 2121 1528 2510 -12972 4 2 0 1 1120 2491 2060 2733 -12973 4 2 0 1 213 395 222 2438 -12974 4 2 0 1 1432 1451 2513 2780 -12975 4 2 0 1 1577 2621 2130 2748 -12976 4 2 0 1 1253 1426 1893 2751 -12977 4 2 0 1 1075 2095 1034 2582 -12978 4 2 0 1 2113 2449 1550 2623 -12979 4 2 0 1 1148 1170 1058 2777 -12980 4 2 0 1 1523 1182 1493 2303 -12981 4 2 0 1 1729 2209 1946 2477 -12982 4 2 0 1 1664 2382 2070 2734 -12983 4 2 0 1 1015 961 858 2588 -12984 4 2 0 1 345 212 363 2489 -12985 4 2 0 1 1739 2808 2398 2809 -12986 4 2 0 1 1781 2299 2177 2592 -12987 4 2 0 1 1522 2264 139 2419 -12988 4 2 0 1 2125 2428 1566 2778 -12989 4 2 0 1 425 468 377 2068 -12990 4 2 0 1 1722 2353 2293 2568 -12991 4 2 0 1 1208 1394 1168 2582 -12992 4 2 0 1 1779 2688 2398 2809 -12993 4 2 0 1 999 899 894 2670 -12994 4 2 0 1 886 863 950 2081 -12995 4 2 0 1 1076 1130 1913 2405 -12996 4 2 0 1 134 133 569 1960 -12997 4 2 0 1 1960 1596 2478 2503 -12998 4 2 0 1 408 1915 494 2824 -12999 4 2 0 1 2086 1875 2612 2689 -13000 4 2 0 1 1099 2414 1043 2804 -13001 4 2 0 1 2449 2519 2309 2799 -13002 4 2 0 1 1659 1833 2653 2682 -13003 4 2 0 1 2010 1536 2427 2743 -13004 4 2 0 1 318 2409 365 2669 -13005 4 2 0 1 1883 2548 2126 2648 -13006 4 2 0 1 1229 1337 1237 2033 -13007 4 2 0 1 553 2197 2009 2408 -13008 4 2 0 1 1646 2339 2522 2804 -13009 4 2 0 1 1947 2156 1694 2683 -13010 4 2 0 1 1899 2481 1668 2618 -13011 4 2 0 1 1600 2251 1894 2492 -13012 4 2 0 1 2180 1973 2473 2697 -13013 4 2 0 1 1410 2091 1230 2721 -13014 4 2 0 1 390 188 2090 2333 -13015 4 2 0 1 2222 2741 2157 2779 -13016 4 2 0 1 2315 1848 2792 2797 -13017 4 2 0 1 248 1996 384 2639 -13018 4 2 0 1 1843 2292 2219 2832 -13019 4 2 0 1 1862 1610 2439 2731 -13020 4 2 0 1 1460 1518 1504 1984 -13021 4 2 0 1 2095 2582 1661 2603 -13022 4 2 0 1 1681 1864 2642 2768 -13023 4 2 0 1 360 411 369 2366 -13024 4 2 0 1 159 956 2049 2561 -13025 4 2 0 1 1693 2329 2174 2598 -13026 4 2 0 1 2145 2643 2577 2717 -13027 4 2 0 1 545 675 549 2569 -13028 4 2 0 1 1690 2316 2267 2702 -13029 4 2 0 1 492 2297 184 2694 -13030 4 2 0 1 941 946 887 2259 -13031 4 2 0 1 958 278 197 2576 -13032 4 2 0 1 2303 2339 1646 2716 -13033 4 2 0 1 782 718 2161 2555 -13034 4 2 0 1 938 882 2251 2495 -13035 4 2 0 1 1469 2146 1483 2620 -13036 4 2 0 1 1403 2201 1346 2737 -13037 4 2 0 1 1714 2105 2320 2510 -13038 4 2 0 1 1643 2331 1862 2793 -13039 4 2 0 1 1461 1395 2374 2499 -13040 4 2 0 1 1801 2647 1996 2671 -13041 4 2 0 1 1745 1869 2282 2777 -13042 4 2 0 1 1667 1911 2486 2650 -13043 4 2 0 1 283 1167 432 2713 -13044 4 2 0 1 890 972 173 2101 -13045 4 2 0 1 284 2338 511 2685 -13046 4 2 0 1 1829 2556 1681 2613 -13047 4 2 0 1 1044 2064 1095 2416 -13048 4 2 0 1 1881 2377 2120 2705 -13049 4 2 0 1 1169 1160 1019 2119 -13050 4 2 0 1 298 484 322 2211 -13051 4 2 0 1 2239 2653 1585 2750 -13052 4 2 0 1 1504 2419 1984 2686 -13053 4 2 0 1 2177 2299 1808 2592 -13054 4 2 0 1 323 199 344 2448 -13055 4 2 0 1 402 2328 1982 2819 -13056 4 2 0 1 1418 1885 1219 2711 -13057 4 2 0 1 265 251 477 2612 -13058 4 2 0 1 406 333 218 2472 -13059 4 2 0 1 596 2246 542 2367 -13060 4 2 0 1 427 2097 211 2571 -13061 4 2 0 1 1840 2551 2117 2617 -13062 4 2 0 1 2220 2743 1639 2782 -13063 4 2 0 1 1604 2235 1912 2371 -13064 4 2 0 1 623 2530 610 2658 -13065 4 2 0 1 258 452 409 2574 -13066 4 2 0 1 375 427 211 2571 -13067 4 2 0 1 234 403 175 2066 -13068 4 2 0 1 894 2184 157 2670 -13069 4 2 0 1 319 212 345 1939 -13070 4 2 0 1 1588 2200 1879 2632 -13071 4 2 0 1 1667 1898 2428 2650 -13072 4 2 0 1 1073 2095 1075 2581 -13073 4 2 0 1 917 2241 878 2591 -13074 4 2 0 1 1694 2156 2123 2683 -13075 4 2 0 1 2272 2473 2452 2723 -13076 4 2 0 1 856 762 702 2690 -13077 4 2 0 1 552 603 612 2761 -13078 4 2 0 1 2010 2743 1689 2782 -13079 4 2 0 1 1679 1857 2453 2521 -13080 4 2 0 1 1179 1365 1433 2275 -13081 4 2 0 1 345 2468 1939 2489 -13082 4 2 0 1 885 914 936 1961 -13083 4 2 0 1 1646 2195 1976 2303 -13084 4 2 0 1 1769 2379 1908 2780 -13085 4 2 0 1 1732 2156 2680 2795 -13086 4 2 0 1 348 402 1982 2819 -13087 4 2 0 1 2182 2719 1688 2810 -13088 4 2 0 1 1695 2222 2029 2779 -13089 4 2 0 1 2239 2653 1833 2682 -13090 4 2 0 1 1909 2243 1719 2629 -13091 4 2 0 1 2171 2513 1190 2631 -13092 4 2 0 1 2313 2452 1704 2723 -13093 4 2 0 1 1183 1246 1264 1933 -13094 4 2 0 1 1537 2181 2082 2629 -13095 4 2 0 1 1750 2306 2398 2688 -13096 4 2 0 1 274 276 521 1961 -13097 4 2 0 1 2385 2439 1610 2731 -13098 4 2 0 1 485 508 422 2217 -13099 4 2 0 1 1546 2134 1919 2483 -13100 4 2 0 1 1427 1241 1234 2358 -13101 4 2 0 1 1767 2376 2084 2676 -13102 4 2 0 1 1970 2270 1835 2364 -13103 4 2 0 1 1695 2779 2029 2799 -13104 4 2 0 1 449 250 1952 2821 -13105 4 2 0 1 1254 2117 2551 2730 -13106 4 2 0 1 917 943 911 2591 -13107 4 2 0 1 2111 2121 1712 2566 -13108 4 2 0 1 2272 2452 2010 2723 -13109 4 2 0 1 836 231 837 465 -13110 4 2 0 1 1213 1926 2667 2788 -13111 4 2 0 1 1502 1068 1064 2339 -13112 4 2 0 1 226 278 186 2327 -13113 4 2 0 1 2010 1618 2215 2782 -13114 4 2 0 1 2094 2387 1798 2760 -13115 4 2 0 1 614 590 584 2400 -13116 4 2 0 1 1689 2010 2427 2743 -13117 4 2 0 1 2177 2184 1781 2742 -13118 4 2 0 1 737 697 738 2666 -13119 4 2 0 1 1338 1195 1388 2374 -13120 4 2 0 1 582 470 480 2658 -13121 4 2 0 1 1814 2700 2221 2738 -13122 4 2 0 1 1549 2600 1887 2617 -13123 4 2 0 1 1237 1337 1383 2835 -13124 4 2 0 1 2059 2380 1644 2823 -13125 4 2 0 1 467 468 425 2404 -13126 4 2 0 1 598 1973 2587 2766 -13127 4 2 0 1 458 331 248 1996 -13128 4 2 0 1 1973 2272 1799 2587 -13129 4 2 0 1 1683 1856 2306 2602 -13130 4 2 0 1 1718 2635 2217 2714 -13131 4 2 0 1 861 2165 968 2589 -13132 4 2 0 1 894 906 997 2184 -13133 4 2 0 1 1650 1985 2239 2682 -13134 4 2 0 1 1536 2215 2198 2463 -13135 4 2 0 1 1809 2196 400 2533 -13136 4 2 0 1 703 777 743 2316 -13137 4 2 0 1 1045 2405 1096 2424 -13138 4 2 0 1 1463 1994 1181 2785 -13139 4 2 0 1 1853 2083 2578 2660 -13140 4 2 0 1 570 616 660 1912 -13141 4 2 0 1 2106 2436 745 2714 -13142 4 2 0 1 367 211 427 2097 -13143 4 2 0 1 696 722 2217 2732 -13144 4 2 0 1 425 377 234 2404 -13145 4 2 0 1 1459 2081 886 2775 -13146 4 2 0 1 304 2605 338 2691 -13147 4 2 0 1 1549 2195 1901 2716 -13148 4 2 0 1 489 194 506 2818 -13149 4 2 0 1 1612 2000 2392 2834 -13150 4 2 0 1 2154 2210 1916 2753 -13151 4 2 0 1 2247 2326 1636 2747 -13152 4 2 0 1 2044 2520 1774 2521 -13153 4 2 0 1 1754 1847 2495 2561 -13154 4 2 0 1 850 777 813 2316 -13155 4 2 0 1 1323 1326 1491 1995 -13156 4 2 0 1 2101 2317 1600 2514 -13157 4 2 0 1 143 841 144 2212 -13158 4 2 0 1 269 422 501 2217 -13159 4 2 0 1 1974 2370 1692 2754 -13160 4 2 0 1 1483 1469 1453 2146 -13161 4 2 0 1 226 472 430 2127 -13162 4 2 0 1 2168 2311 1527 2527 -13163 4 2 0 1 2295 2599 1717 2707 -13164 4 2 0 1 2141 2314 1653 2723 -13165 4 2 0 1 607 640 652 2390 -13166 4 2 0 1 1515 1502 1064 2339 -13167 4 2 0 1 1774 2455 2199 2520 -13168 4 2 0 1 2066 1629 2332 2341 -13169 4 2 0 1 1664 2700 2158 2738 -13170 4 2 0 1 1428 1406 1392 1924 -13171 4 2 0 1 1048 2064 1017 2458 -13172 4 2 0 1 1814 2158 2700 2738 -13173 4 2 0 1 2315 2575 1848 2797 -13174 4 2 0 1 1619 2237 1902 2490 -13175 4 2 0 1 1313 2133 1302 2668 -13176 4 2 0 1 1308 1299 1188 2036 -13177 4 2 0 1 1249 2485 1456 2666 -13178 4 2 0 1 171 277 433 1993 -13179 4 2 0 1 1070 2422 1050 2626 -13180 4 2 0 1 615 2393 551 2663 -13181 4 2 0 1 1698 2216 2151 2549 -13182 4 2 0 1 1875 2097 1594 2319 -13183 4 2 0 1 765 808 689 2555 -13184 4 2 0 1 1873 1615 2421 2492 -13185 4 2 0 1 1796 2213 2145 2577 -13186 4 2 0 1 629 147 2131 2497 -13187 4 2 0 1 1695 2298 1997 2568 -13188 4 2 0 1 1692 2370 1974 2783 -13189 4 2 0 1 1324 1319 1227 2324 -13190 4 2 0 1 1120 1047 2060 2491 -13191 4 2 0 1 592 679 514 2560 -13192 4 2 0 1 1871 2632 2164 2698 -13193 4 2 0 1 1703 2439 2385 2731 -13194 4 2 0 1 1779 2258 2343 2808 -13195 4 2 0 1 1703 2160 2048 2758 -13196 4 2 0 1 1051 2422 2128 2503 -13197 4 2 0 1 247 1809 2533 2658 -13198 4 2 0 1 1807 2413 2214 2739 -13199 4 2 0 1 1500 1261 1206 2586 -13200 4 2 0 1 1749 2322 1974 2615 -13201 4 2 0 1 382 170 223 2092 -13202 4 2 0 1 766 761 703 1957 -13203 4 2 0 1 2052 2653 1833 2750 -13204 4 2 0 1 1951 1576 2474 2552 -13205 4 2 0 1 1536 2452 2427 2723 -13206 4 2 0 1 191 789 468 2144 -13207 4 2 0 1 944 988 2070 2734 -13208 4 2 0 1 1764 2370 2033 2835 -13209 4 2 0 1 247 1809 400 2533 -13210 4 2 0 1 1302 2383 1339 2668 -13211 4 2 0 1 1792 2539 1996 2674 -13212 4 2 0 1 474 1967 2297 2694 -13213 4 2 0 1 538 553 605 2408 -13214 4 2 0 1 299 310 373 2005 -13215 4 2 0 1 1057 160 1113 2394 -13216 4 2 0 1 1481 1279 1459 2081 -13217 4 2 0 1 1909 2148 2243 2721 -13218 4 2 0 1 268 131 2128 2830 -13219 4 2 0 1 2175 1652 2282 2790 -13220 4 2 0 1 1827 2700 2227 2839 -13221 4 2 0 1 159 158 1142 2049 -13222 4 2 0 1 1539 2151 2022 2648 -13223 4 2 0 1 2394 2709 1929 2764 -13224 4 2 0 1 873 1003 877 2155 -13225 4 2 0 1 1896 2298 1732 2795 -13226 4 2 0 1 1051 132 1116 2503 -13227 4 2 0 1 1543 2535 2336 2757 -13228 4 2 0 1 570 629 573 2497 -13229 4 2 0 1 1671 2252 2313 2678 -13230 4 2 0 1 1123 1135 1055 1975 -13231 4 2 0 1 1732 2353 2298 2568 -13232 4 2 0 1 1636 2381 2001 2703 -13233 4 2 0 1 2141 2313 1704 2723 -13234 4 2 0 1 322 2211 314 2397 -13235 4 2 0 1 1345 1330 2194 2655 -13236 4 2 0 1 1024 1111 1050 2422 -13237 4 2 0 1 1753 2334 2373 2829 -13238 4 2 0 1 1536 1949 2272 2723 -13239 4 2 0 1 304 2605 1983 2614 -13240 4 2 0 1 947 1004 929 2280 -13241 4 2 0 1 287 251 479 2803 -13242 4 2 0 1 688 2246 548 2725 -13243 4 2 0 1 1443 2435 1509 2686 -13244 4 2 0 1 1783 2459 2210 2546 -13245 4 2 0 1 2021 2552 1708 2755 -13246 4 2 0 1 1515 1155 1492 2264 -13247 4 2 0 1 1317 1221 2531 2788 -13248 4 2 0 1 1001 989 2125 2562 -13249 4 2 0 1 486 184 2330 2694 -13250 4 2 0 1 532 647 635 1934 -13251 4 2 0 1 1956 1702 2546 2652 -13252 4 2 0 1 940 931 888 2129 -13253 4 2 0 1 1338 2667 2018 2788 -13254 4 2 0 1 1628 2233 2081 2499 -13255 4 2 0 1 1246 2205 1933 2557 -13256 4 2 0 1 2099 2347 1740 2677 -13257 4 2 0 1 535 571 622 2197 -13258 4 2 0 1 1004 2280 969 2588 -13259 4 2 0 1 1607 2197 2250 2500 -13260 4 2 0 1 2199 2455 1651 2520 -13261 4 2 0 1 1656 2578 2083 2726 -13262 4 2 0 1 458 331 1996 2744 -13263 4 2 0 1 1566 1911 2261 2778 -13264 4 2 0 1 1051 2128 132 2503 -13265 4 2 0 1 203 327 312 2407 -13266 4 2 0 1 1196 1268 1266 2178 -13267 4 2 0 1 384 1996 331 2647 -13268 4 2 0 1 1157 1508 1381 2278 -13269 4 2 0 1 544 551 2069 2663 -13270 4 2 0 1 1043 1842 1104 2804 -13271 4 2 0 1 1047 2060 1094 2733 -13272 4 2 0 1 672 681 673 2180 -13273 4 2 0 1 1971 2208 1744 2411 -13274 4 2 0 1 548 688 661 2246 -13275 4 2 0 1 1558 2377 1881 2773 -13276 4 2 0 1 1422 1236 1254 2551 -13277 4 2 0 1 707 2068 751 2501 -13278 4 2 0 1 1507 1520 1284 2184 -13279 4 2 0 1 601 619 676 2321 -13280 4 2 0 1 997 157 894 2184 -13281 4 2 0 1 308 296 207 2624 -13282 4 2 0 1 2182 2218 1640 2335 -13283 4 2 0 1 966 977 922 2695 -13284 4 2 0 1 591 1200 680 2053 -13285 4 2 0 1 2060 2410 1094 2733 -13286 4 2 0 1 1595 2258 2398 2808 -13287 4 2 0 1 496 2606 528 2830 -13288 4 2 0 1 1842 2522 1104 2804 -13289 4 2 0 1 2180 2473 1573 2697 -13290 4 2 0 1 1636 2001 2381 2825 -13291 4 2 0 1 1520 1260 1284 2822 -13292 4 2 0 1 1715 1960 2478 2503 -13293 4 2 0 1 1781 2592 2177 2742 -13294 4 2 0 1 2398 2572 1595 2798 -13295 4 2 0 1 816 847 853 2425 -13296 4 2 0 1 1840 2273 2117 2586 -13297 4 2 0 1 1589 2320 2510 2794 -13298 4 2 0 1 1104 1043 1165 1842 -13299 4 2 0 1 1160 1169 1161 2769 -13300 4 2 0 1 1614 2218 1910 2764 -13301 4 2 0 1 380 393 2017 2776 -13302 4 2 0 1 1449 1387 1226 2825 -13303 4 2 0 1 2130 2624 2062 2805 -13304 4 2 0 1 1494 1269 1244 2051 -13305 4 2 0 1 2413 2550 2245 2739 -13306 4 2 0 1 570 573 1912 2497 -13307 4 2 0 1 895 2162 859 2695 -13308 4 2 0 1 1056 2488 1062 2503 -13309 4 2 0 1 697 724 729 2087 -13310 4 2 0 1 575 536 582 2456 -13311 4 2 0 1 410 1967 243 2752 -13312 4 2 0 1 2164 2632 1602 2698 -13313 4 2 0 1 915 913 948 2233 -13314 4 2 0 1 1898 2650 1667 2771 -13315 4 2 0 1 2101 1847 2494 2495 -13316 4 2 0 1 1645 1853 2509 2646 -13317 4 2 0 1 974 857 962 2365 -13318 4 2 0 1 1695 2449 2519 2568 -13319 4 2 0 1 1779 2343 1871 2808 -13320 4 2 0 1 542 2367 2246 2725 -13321 4 2 0 1 1513 1522 1492 139 -13322 4 2 0 1 1945 2312 1673 2656 -13323 4 2 0 1 853 146 145 2425 -13324 4 2 0 1 365 509 2153 2409 -13325 4 2 0 1 1787 2339 2303 2716 -13326 4 2 0 1 1687 2444 1894 2542 -13327 4 2 0 1 1531 2368 1981 2505 -13328 4 2 0 1 875 2107 920 2803 -13329 4 2 0 1 260 1070 1050 2626 -13330 4 2 0 1 621 552 572 2344 -13331 4 2 0 1 1587 2108 2548 2828 -13332 4 2 0 1 1868 1653 2473 2766 -13333 4 2 0 1 1046 1073 1131 1914 -13334 4 2 0 1 361 205 340 2614 -13335 4 2 0 1 2017 2635 1816 2776 -13336 4 2 0 1 833 711 695 2649 -13337 4 2 0 1 1449 2247 1387 2825 -13338 4 2 0 1 1664 2188 2158 2700 -13339 4 2 0 1 1019 1055 1143 2119 -13340 4 2 0 1 1040 1100 2406 2543 -13341 4 2 0 1 2345 2536 1680 2802 -13342 4 2 0 1 981 992 162 2035 -13343 4 2 0 1 380 2017 485 2645 -13344 4 2 0 1 1944 2531 1731 2558 -13345 4 2 0 1 435 404 2405 2424 -13346 4 2 0 1 577 534 564 1990 -13347 4 2 0 1 397 177 2752 2791 -13348 4 2 0 1 460 426 493 2610 -13349 4 2 0 1 299 373 205 2005 -13350 4 2 0 1 1135 1975 1123 2491 -13351 4 2 0 1 2210 2459 1630 2546 -13352 4 2 0 1 563 574 536 2456 -13353 4 2 0 1 507 496 2128 2818 -13354 4 2 0 1 1967 2606 1990 2694 -13355 4 2 0 1 749 777 850 2498 -13356 4 2 0 1 1085 1129 1031 2170 -13357 4 2 0 1 938 2101 951 2495 -13358 4 2 0 1 928 895 975 2162 -13359 4 2 0 1 1711 2384 2119 2817 -13360 4 2 0 1 722 830 736 2277 -13361 4 2 0 1 1859 1665 2639 2671 -13362 4 2 0 1 1543 2075 2040 2578 -13363 4 2 0 1 859 2162 983 2695 -13364 4 2 0 1 1603 2394 1929 2764 -13365 4 2 0 1 1711 2114 2119 2769 -13366 4 2 0 1 82 1431 561 1423 -13367 4 2 0 1 1112 2339 1049 2804 -13368 4 2 0 1 381 333 356 2207 -13369 4 2 0 1 1738 2048 2758 2836 -13370 4 2 0 1 1640 1959 2719 2810 -13371 4 2 0 1 1873 1615 2492 2738 -13372 4 2 0 1 1603 2394 2049 2561 -13373 4 2 0 1 1709 1888 2300 2369 -13374 4 2 0 1 885 970 914 1961 -13375 4 2 0 1 1531 2063 2249 2505 -13376 4 2 0 1 1121 2138 1122 2584 -13377 4 2 0 1 494 498 519 2355 -13378 4 2 0 1 415 1861 469 2662 -13379 4 2 0 1 1097 1914 1046 2696 -13380 4 2 0 1 290 316 294 2062 -13381 4 2 0 1 1905 2124 2397 2727 -13382 4 2 0 1 1214 1351 1303 2453 -13383 4 2 0 1 567 600 655 2192 -13384 4 2 0 1 1473 987 973 2241 -13385 4 2 0 1 2479 2800 1728 2839 -13386 4 2 0 1 1992 2201 1620 2337 -13387 4 2 0 1 1668 2207 2481 2580 -13388 4 2 0 1 1012 954 1006 2327 -13389 4 2 0 1 548 2069 639 2725 -13390 4 2 0 1 2020 1736 2417 2756 -13391 4 2 0 1 1213 2667 1338 2788 -13392 4 2 0 1 2083 2216 1584 2549 -13393 4 2 0 1 1908 1555 2329 2736 -13394 4 2 0 1 788 2120 826 2732 -13395 4 2 0 1 1934 2536 1786 2753 -13396 4 2 0 1 1973 2473 1653 2766 -13397 4 2 0 1 1560 2245 2413 2550 -13398 4 2 0 1 1350 1265 1467 2631 -13399 4 2 0 1 533 2197 571 2390 -13400 4 2 0 1 430 226 2127 2679 -13401 4 2 0 1 1274 1281 1493 2303 -13402 4 2 0 1 1592 2059 2122 2314 -13403 4 2 0 1 1000 859 2562 2695 -13404 4 2 0 1 1642 1885 2234 2801 -13405 4 2 0 1 1449 1226 1316 1935 -13406 4 2 0 1 376 248 384 2639 -13407 4 2 0 1 1209 2001 1366 2381 -13408 4 2 0 1 390 475 188 2333 -13409 4 2 0 1 1697 2090 1969 2657 -13410 4 2 0 1 587 591 680 2053 -13411 4 2 0 1 410 474 243 1967 -13412 4 2 0 1 917 987 959 2241 -13413 4 2 0 1 1813 2417 2067 2580 -13414 4 2 0 1 511 284 280 2338 -13415 4 2 0 1 1716 1902 2490 2641 -13416 4 2 0 1 425 175 453 2404 -13417 4 2 0 1 1110 1097 1046 2696 -13418 4 2 0 1 449 2821 1952 2826 -13419 4 2 0 1 747 819 836 2106 -13420 4 2 0 1 2412 2792 1848 2797 -13421 4 2 0 1 1720 2029 2222 2779 -13422 4 2 0 1 417 390 2090 2657 -13423 4 2 0 1 1650 1985 2443 2837 -13424 4 2 0 1 1005 975 960 2382 -13425 4 2 0 1 2125 2248 1667 2778 -13426 4 2 0 1 1646 2716 2339 2804 -13427 4 2 0 1 1804 2257 2143 2520 -13428 4 2 0 1 2010 2496 1618 2782 -13429 4 2 0 1 1566 2428 1911 2778 -13430 4 2 0 1 1557 2108 2218 2681 -13431 4 2 0 1 1550 2449 2309 2623 -13432 4 2 0 1 1525 1203 1514 2135 -13433 4 2 0 1 445 1847 362 2494 -13434 4 2 0 1 560 656 556 2169 -13435 4 2 0 1 805 824 694 2307 -13436 4 2 0 1 1005 883 868 2287 -13437 4 2 0 1 1394 2581 1168 2582 -13438 4 2 0 1 1009 1000 859 2562 -13439 4 2 0 1 628 141 142 1955 -13440 4 2 0 1 994 978 1012 2327 -13441 4 2 0 1 443 351 372 2185 -13442 4 2 0 1 1614 1910 2172 2764 -13443 4 2 0 1 346 210 341 1978 -13444 4 2 0 1 692 693 800 2288 -13445 4 2 0 1 1450 2171 1190 2631 -13446 4 2 0 1 1659 2653 2239 2682 -13447 4 2 0 1 1903 2407 2002 2741 -13448 4 2 0 1 159 2049 2394 2561 -13449 4 2 0 1 1205 1493 1281 2339 -13450 4 2 0 1 1666 2249 2063 2505 -13451 4 2 0 1 455 2554 371 2791 -13452 4 2 0 1 496 2128 429 2606 -13453 4 2 0 1 2117 2273 1840 2617 -13454 4 2 0 1 1517 1184 1235 2342 -13455 4 2 0 1 1614 2416 2064 2814 -13456 4 2 0 1 1593 2319 2086 2689 -13457 4 2 0 1 1059 1128 1021 2140 -13458 4 2 0 1 635 1934 647 2786 -13459 4 2 0 1 1254 2117 1261 2551 -13460 4 2 0 1 301 235 2002 2605 -13461 4 2 0 1 628 568 574 2345 -13462 4 2 0 1 1473 1498 987 2241 -13463 4 2 0 1 415 417 188 2090 -13464 4 2 0 1 1660 1981 2368 2505 -13465 4 2 0 1 1915 2355 1605 2395 -13466 4 2 0 1 237 318 412 2641 -13467 4 2 0 1 737 738 1495 2666 -13468 4 2 0 1 1594 1875 2319 2483 -13469 4 2 0 1 384 2639 1996 2647 -13470 4 2 0 1 2038 2311 1682 2437 -13471 4 2 0 1 2434 2435 1742 2500 -13472 4 2 0 1 551 615 589 2393 -13473 4 2 0 1 1714 2320 2111 2510 -13474 4 2 0 1 653 682 660 2283 -13475 4 2 0 1 335 209 330 2200 -13476 4 2 0 1 2050 2348 1750 2572 -13477 4 2 0 1 1742 2500 2435 2686 -13478 4 2 0 1 497 399 218 2472 -13479 4 2 0 1 1285 1295 1271 2056 -13480 4 2 0 1 769 783 842 2186 -13481 4 2 0 1 1175 1086 1124 2518 -13482 4 2 0 1 553 622 2197 2408 -13483 4 2 0 1 253 486 279 2694 -13484 4 2 0 1 766 717 694 2307 -13485 4 2 0 1 1411 1371 1191 2263 -13486 4 2 0 1 494 408 229 1915 -13487 4 2 0 1 1696 2670 2184 2742 -13488 4 2 0 1 236 2124 190 2819 -13489 4 2 0 1 1890 1685 2634 2684 -13490 4 2 0 1 2138 2458 1959 2518 -13491 4 2 0 1 2220 1689 2743 2782 -13492 4 2 0 1 1974 2370 1780 2783 -13493 4 2 0 1 1254 2289 1268 2730 -13494 4 2 0 1 786 732 2403 2628 -13495 4 2 0 1 1440 2033 1237 2835 -13496 4 2 0 1 1873 2421 1615 2738 -13497 4 2 0 1 415 469 417 2662 -13498 4 2 0 1 1573 2452 2010 2473 -13499 4 2 0 1 1427 2358 1456 2485 -13500 4 2 0 1 1275 1503 1244 2615 -13501 4 2 0 1 1595 2572 2112 2798 -13502 4 2 0 1 895 983 859 2162 -13503 4 2 0 1 932 963 927 2421 -13504 4 2 0 1 1706 2036 2324 2746 -13505 4 2 0 1 1911 2428 1667 2778 -13506 4 2 0 1 1313 1212 2133 2668 -13507 4 2 0 1 622 609 558 2408 -13508 4 2 0 1 1715 2478 2488 2503 -13509 4 2 0 1 1149 1870 2594 2769 -13510 4 2 0 1 1856 2398 2306 2688 -13511 4 2 0 1 2006 2335 1673 2656 -13512 4 2 0 1 1172 2564 1033 2565 -13513 4 2 0 1 1036 1870 1149 2769 -13514 4 2 0 1 1529 1945 2240 2656 -13515 4 2 0 1 1547 2282 2250 2790 -13516 4 2 0 1 381 386 2207 2661 -13517 4 2 0 1 1543 2025 2660 2792 -13518 4 2 0 1 535 622 558 1984 -13519 4 2 0 1 1711 2114 1870 2710 -13520 4 2 0 1 2259 2382 1664 2734 -13521 4 2 0 1 705 811 2501 2585 -13522 4 2 0 1 1133 1147 1077 2056 -13523 4 2 0 1 380 202 393 2776 -13524 4 2 0 1 665 639 657 2725 -13525 4 2 0 1 1683 2306 2398 2572 -13526 4 2 0 1 1169 2119 1143 2769 -13527 4 2 0 1 574 568 613 2345 -13528 4 2 0 1 306 182 311 2190 -13529 4 2 0 1 1301 2420 1212 2668 -13530 4 2 0 1 1707 2140 2346 2619 -13531 4 2 0 1 1229 2033 1420 2667 -13532 4 2 0 1 2014 2598 1743 2659 -13533 4 2 0 1 1141 2410 1148 2733 -13534 4 2 0 1 1954 1706 2415 2655 -13535 4 2 0 1 249 414 367 2821 -13536 4 2 0 1 1718 2436 2106 2714 -13537 4 2 0 1 2097 2468 1594 2571 -13538 4 2 0 1 225 173 271 2576 -13539 4 2 0 1 1233 1412 1421 2091 -13540 4 2 0 1 2074 2332 1629 2341 -13541 4 2 0 1 2062 2624 1720 2805 -13542 4 2 0 1 1479 1467 1451 2780 -13543 4 2 0 1 832 756 790 2171 -13544 4 2 0 1 952 883 901 2287 -13545 4 2 0 1 1650 2239 1985 2837 -13546 4 2 0 1 1586 2300 1988 2806 -13547 4 2 0 1 1935 1636 2247 2825 -13548 4 2 0 1 1696 2135 2051 2822 -13549 4 2 0 1 226 186 472 2127 -13550 4 2 0 1 2036 1679 2324 2746 -13551 4 2 0 1 1332 1223 1392 2441 -13552 4 2 0 1 1636 2470 2072 2747 -13553 4 2 0 1 2272 2473 1973 2697 -13554 4 2 0 1 1596 2173 2128 2606 -13555 4 2 0 1 1723 2488 2478 2503 -13556 4 2 0 1 1459 1211 886 2081 -13557 4 2 0 1 1669 2583 2290 2796 -13558 4 2 0 1 1703 2385 2160 2731 -13559 4 2 0 1 1800 1619 2409 2490 -13560 4 2 0 1 202 347 393 2635 -13561 4 2 0 1 1692 1974 2351 2783 -13562 4 2 0 1 1950 2430 1659 2682 -13563 4 2 0 1 1033 1038 1126 2564 -13564 4 2 0 1 1614 2172 1929 2764 -13565 4 2 0 1 1578 2345 2450 2802 -13566 4 2 0 1 299 310 2005 2647 -13567 4 2 0 1 1251 1244 2051 2615 -13568 4 2 0 1 553 533 656 2009 -13569 4 2 0 1 2114 1870 2255 2769 -13570 4 2 0 1 1413 1305 1337 2667 -13571 4 2 0 1 1297 1177 1312 1922 -13572 4 2 0 1 1636 1987 2470 2747 -13573 4 2 0 1 1562 2141 2193 2823 -13574 4 2 0 1 216 423 424 2554 -13575 4 2 0 1 1318 1363 1217 2042 -13576 4 2 0 1 1894 2421 1615 2492 -13577 4 2 0 1 1833 2239 1958 2750 -13578 4 2 0 1 1808 2592 2534 2834 -13579 4 2 0 1 824 810 694 2451 -13580 4 2 0 1 1377 2325 1219 2512 -13581 4 2 0 1 1081 1143 2119 2769 -13582 4 2 0 1 1354 1192 1355 2077 -13583 4 2 0 1 1579 2479 1971 2781 -13584 4 2 0 1 2221 2292 1843 2492 -13585 4 2 0 1 916 1007 920 2107 -13586 4 2 0 1 1562 2595 2175 2728 -13587 4 2 0 1 779 2055 731 2529 -13588 4 2 0 1 1586 2369 2300 2806 -13589 4 2 0 1 846 487 269 2277 -13590 4 2 0 1 563 668 140 2456 -13591 4 2 0 1 169 304 338 2691 -13592 4 2 0 1 1751 2428 2125 2562 -13593 4 2 0 1 429 2173 243 2606 -13594 4 2 0 1 1709 2300 1888 2774 -13595 4 2 0 1 912 918 972 2576 -13596 4 2 0 1 1695 1903 2741 2779 -13597 4 2 0 1 2012 2325 1857 2515 -13598 4 2 0 1 1938 2231 1791 2476 -13599 4 2 0 1 136 1141 2410 2777 -13600 4 2 0 1 229 408 379 1915 -13601 4 2 0 1 589 645 659 2132 -13602 4 2 0 1 969 875 871 2280 -13603 4 2 0 1 232 2328 402 2819 -13604 4 2 0 1 346 342 210 2556 -13605 4 2 0 1 2154 2433 1891 2706 -13606 4 2 0 1 1450 832 790 2171 -13607 4 2 0 1 1528 1966 2466 2836 -13608 4 2 0 1 1805 2558 2096 2708 -13609 4 2 0 1 1099 1028 1043 2414 -13610 4 2 0 1 2025 2622 1964 2792 -13611 4 2 0 1 1344 2469 1430 2812 -13612 4 2 0 1 774 702 2529 2690 -13613 4 2 0 1 1093 1134 1090 2518 -13614 4 2 0 1 917 973 987 2241 -13615 4 2 0 1 1180 1267 1482 2021 -13616 4 2 0 1 1071 1028 1099 2414 -13617 4 2 0 1 1833 2401 2052 2750 -13618 4 2 0 1 982 976 150 1946 -13619 4 2 0 1 287 2107 251 2803 -13620 4 2 0 1 1928 1717 2813 2820 -13621 4 2 0 1 773 786 712 2403 -13622 4 2 0 1 735 1514 1203 2135 -13623 4 2 0 1 364 414 249 2826 -13624 4 2 0 1 1538 1943 2402 2411 -13625 4 2 0 1 1255 1489 1417 2620 -13626 4 2 0 1 1857 2044 2453 2521 -13627 4 2 0 1 469 415 420 1861 -13628 4 2 0 1 1108 1075 1073 2095 -13629 4 2 0 1 1194 1440 1237 2835 -13630 4 2 0 1 1895 2489 1737 2679 -13631 4 2 0 1 1969 2407 1903 2657 -13632 4 2 0 1 778 2684 856 2690 -13633 4 2 0 1 1585 2653 2052 2750 -13634 4 2 0 1 909 522 526 2477 -13635 4 2 0 1 1454 1444 1238 2205 -13636 4 2 0 1 1701 2230 2116 2524 -13637 4 2 0 1 1742 2434 1976 2435 -13638 4 2 0 1 1515 1523 1493 2339 -13639 4 2 0 1 1670 2395 2147 2735 -13640 4 2 0 1 1370 1311 1223 2475 -13641 4 2 0 1 1990 2606 2128 2830 -13642 4 2 0 1 757 789 755 2144 -13643 4 2 0 1 280 2338 527 2692 -13644 4 2 0 1 2244 2335 2006 2656 -13645 4 2 0 1 1315 1376 1320 2720 -13646 4 2 0 1 250 2086 1952 2821 -13647 4 2 0 1 1973 2272 1653 2473 -13648 4 2 0 1 1308 1319 1324 2324 -13649 4 2 0 1 1308 1324 1216 2655 -13650 4 2 0 1 733 764 823 2045 -13651 4 2 0 1 2157 2657 288 2824 -13652 4 2 0 1 1655 2450 2124 2533 -13653 4 2 0 1 255 474 410 1967 -13654 4 2 0 1 767 700 711 2375 -13655 4 2 0 1 1664 2537 2188 2700 -13656 4 2 0 1 384 248 331 1996 -13657 4 2 0 1 1544 1951 2619 2833 -13658 4 2 0 1 374 360 354 2366 -13659 4 2 0 1 1733 2574 2084 2676 -13660 4 2 0 1 1595 2348 2112 2572 -13661 4 2 0 1 1431 1231 1400 2132 -13662 4 2 0 1 229 371 2395 2791 -13663 4 2 0 1 1222 1356 1391 2247 -13664 4 2 0 1 1196 2117 1254 2730 -13665 4 2 0 1 1432 1448 1451 2780 -13666 4 2 0 1 2020 1644 2438 2756 -13667 4 2 0 1 812 781 849 1936 -13668 4 2 0 1 890 2101 434 2494 -13669 4 2 0 1 2000 2616 2392 2834 -13670 4 2 0 1 1746 2218 2719 2814 -13671 4 2 0 1 646 602 605 2587 -13672 4 2 0 1 1594 2571 1939 2607 -13673 4 2 0 1 138 139 1053 2264 -13674 4 2 0 1 1608 2266 2118 2701 -13675 4 2 0 1 1477 1476 1280 1937 -13676 4 2 0 1 1583 2225 2054 2789 -13677 4 2 0 1 1329 1188 1303 2284 -13678 4 2 0 1 669 1522 1513 139 -13679 4 2 0 1 2046 2330 1677 2761 -13680 4 2 0 1 1692 2665 1892 2783 -13681 4 2 0 1 311 224 324 2190 -13682 4 2 0 1 228 259 1905 2457 -13683 4 2 0 1 698 786 720 2692 -13684 4 2 0 1 1543 2412 2726 2757 -13685 4 2 0 1 1317 1338 2018 2788 -13686 4 2 0 1 1575 2509 1853 2646 -13687 4 2 0 1 696 2508 730 2732 -13688 4 2 0 1 1894 2514 1687 2542 -13689 4 2 0 1 1589 2320 2105 2510 -13690 4 2 0 1 309 339 317 2156 -13691 4 2 0 1 1426 2751 1433 2770 -13692 4 2 0 1 572 625 564 2344 -13693 4 2 0 1 842 783 726 2109 -13694 4 2 0 1 696 730 722 2732 -13695 4 2 0 1 142 826 2120 2732 -13696 4 2 0 1 2034 2634 1685 2684 -13697 4 2 0 1 1750 2398 2306 2572 -13698 4 2 0 1 355 430 358 2679 -13699 4 2 0 1 1806 2219 2085 2673 -13700 4 2 0 1 482 502 421 2049 -13701 4 2 0 1 2414 2544 1842 2716 -13702 4 2 0 1 2478 2488 1723 2789 -13703 4 2 0 1 2090 2657 1697 2662 -13704 4 2 0 1 415 462 420 1861 -13705 4 2 0 1 2319 2545 2086 2821 -13706 4 2 0 1 429 2128 496 2818 -13707 4 2 0 1 1719 2318 2275 2767 -13708 4 2 0 1 305 169 307 2691 -13709 4 2 0 1 237 2641 364 2826 -13710 4 2 0 1 1167 1076 1130 2713 -13711 4 2 0 1 1604 2235 2371 2526 -13712 4 2 0 1 217 2207 2196 2661 -13713 4 2 0 1 1899 1668 2580 2827 -13714 4 2 0 1 1555 2174 2329 2598 -13715 4 2 0 1 1039 1103 1077 2056 -13716 4 2 0 1 394 228 1905 2815 -13717 4 2 0 1 2128 1723 2503 2818 -13718 4 2 0 1 1469 2620 1186 2740 -13719 4 2 0 1 1052 1065 1022 1927 -13720 4 2 0 1 875 916 920 2107 -13721 4 2 0 1 1649 2597 2030 2744 -13722 4 2 0 1 600 615 637 2663 -13723 4 2 0 1 1632 2178 2117 2785 -13724 4 2 0 1 1441 2615 1251 2835 -13725 4 2 0 1 733 2045 2253 2378 -13726 4 2 0 1 1350 1405 839 2379 -13727 4 2 0 1 1819 2543 1100 2709 -13728 4 2 0 1 1360 1327 1369 2104 -13729 4 2 0 1 340 2605 303 2614 -13730 4 2 0 1 1056 1101 1062 2488 -13731 4 2 0 1 1489 2094 1186 2620 -13732 4 2 0 1 1939 1594 2468 2571 -13733 4 2 0 1 642 557 189 2330 -13734 4 2 0 1 964 962 1015 2248 -13735 4 2 0 1 305 211 389 2571 -13736 4 2 0 1 1673 2312 2006 2656 -13737 4 2 0 1 1321 2044 1349 2455 -13738 4 2 0 1 915 913 2233 2775 -13739 4 2 0 1 2148 2275 1633 2770 -13740 4 2 0 1 1472 1270 1250 1914 -13741 4 2 0 1 548 544 639 2069 -13742 4 2 0 1 466 2209 264 2685 -13743 4 2 0 1 1490 1198 580 576 -13744 4 2 0 1 589 615 583 2132 -13745 4 2 0 1 1614 2709 2416 2814 -13746 4 2 0 1 2339 2716 1787 2804 -13747 4 2 0 1 934 992 981 2734 -13748 4 2 0 1 737 1495 2087 2666 -13749 4 2 0 1 1121 1122 1164 2584 -13750 4 2 0 1 1607 2197 1984 2408 -13751 4 2 0 1 1731 2531 1944 2720 -13752 4 2 0 1 2017 2645 380 2815 -13753 4 2 0 1 397 2752 2554 2791 -13754 4 2 0 1 1022 1109 1060 2424 -13755 4 2 0 1 1929 2709 1614 2764 -13756 4 2 0 1 2377 2443 1985 2837 -13757 4 2 0 1 1868 2473 1973 2766 -13758 4 2 0 1 302 494 371 2395 -13759 4 2 0 1 890 951 938 2101 -13760 4 2 0 1 1643 2338 1849 2628 -13761 4 2 0 1 1796 2577 2145 2643 -13762 4 2 0 1 432 2405 1913 2713 -13763 4 2 0 1 1521 1507 1485 2184 -13764 4 2 0 1 2010 2473 2272 2697 -13765 4 2 0 1 733 2253 808 2378 -13766 4 2 0 1 830 2277 722 2732 -13767 4 2 0 1 185 642 2330 2560 -13768 4 2 0 1 1837 2301 2146 2625 -13769 4 2 0 1 1705 2387 2094 2760 -13770 4 2 0 1 841 2161 770 2638 -13771 4 2 0 1 832 756 2171 2631 -13772 4 2 0 1 1723 2054 2225 2789 -13773 4 2 0 1 1220 1357 1474 2137 -13774 4 2 0 1 1331 1300 1469 2740 -13775 4 2 0 1 1321 1351 1349 2044 -13776 4 2 0 1 1719 2609 2318 2767 -13777 4 2 0 1 1166 1033 1172 2564 -13778 4 2 0 1 2046 2330 586 2560 -13779 4 2 0 1 582 536 562 2658 -13780 4 2 0 1 1658 2336 2092 2622 -13781 4 2 0 1 1902 2409 1619 2490 -13782 4 2 0 1 2034 2684 1685 2690 -13783 4 2 0 1 1346 1247 1362 2337 -13784 4 2 0 1 1449 1391 1387 2247 -13785 4 2 0 1 467 246 191 2144 -13786 4 2 0 1 936 867 880 2073 -13787 4 2 0 1 1274 1277 1500 2586 -13788 4 2 0 1 1450 832 2171 2631 -13789 4 2 0 1 370 219 297 2744 -13790 4 2 0 1 210 357 321 2601 -13791 4 2 0 1 1050 1070 1024 2422 -13792 4 2 0 1 1080 388 47 272 -13793 4 2 0 1 1667 2486 2061 2650 -13794 4 2 0 1 1071 1077 1103 2056 -13795 4 2 0 1 131 654 132 2830 -13796 4 2 0 1 2217 2277 1674 2732 -13797 4 2 0 1 1398 1460 1504 1984 -13798 4 2 0 1 1822 2378 2253 2717 -13799 4 2 0 1 1496 1480 1499 2131 -13800 4 2 0 1 216 2395 371 2554 -13801 4 2 0 1 1046 1914 1250 2696 -13802 4 2 0 1 530 596 598 1973 -13803 4 2 0 1 2066 2525 403 2674 -13804 4 2 0 1 1586 2290 1988 2388 -13805 4 2 0 1 2154 2210 1630 2546 -13806 4 2 0 1 1120 2060 1047 2733 -13807 4 2 0 1 737 2087 697 2666 -13808 4 2 0 1 1963 2214 1717 2739 -13809 4 2 0 1 1040 1109 1096 2406 -13810 4 2 0 1 2044 1774 2453 2521 -13811 4 2 0 1 378 2366 374 2683 -13812 4 2 0 1 787 713 731 2529 -13813 4 2 0 1 1267 1455 1255 2021 -13814 4 2 0 1 439 232 402 2819 -13815 4 2 0 1 1168 2581 1075 2582 -13816 4 2 0 1 421 502 362 2049 -13817 4 2 0 1 1195 2299 1458 2374 -13818 4 2 0 1 1564 1920 2242 2699 -13819 4 2 0 1 1061 2339 1025 2804 -13820 4 2 0 1 1318 1354 1363 2042 -13821 4 2 0 1 1658 2564 2349 2565 -13822 4 2 0 1 776 2403 732 2628 -13823 4 2 0 1 1636 2381 2326 2825 -13824 4 2 0 1 1180 2229 1282 2563 -13825 4 2 0 1 1556 2429 2016 2765 -13826 4 2 0 1 2094 2740 1837 2781 -13827 4 2 0 1 1789 2228 1978 2613 -13828 4 2 0 1 1461 1395 2499 2720 -13829 4 2 0 1 1521 1204 1520 2184 -13830 4 2 0 1 278 954 285 2327 -13831 4 2 0 1 266 500 504 2626 -13832 4 2 0 1 1399 1228 1992 2770 -13833 4 2 0 1 952 883 2287 2715 -13834 4 2 0 1 1767 2574 1879 2676 -13835 4 2 0 1 1738 2758 2423 2836 -13836 4 2 0 1 1723 2626 2422 2818 -13837 4 2 0 1 1355 1192 1335 2077 -13838 4 2 0 1 1671 2651 2252 2678 -13839 4 2 0 1 1908 2379 2041 2485 -13840 4 2 0 1 411 445 434 2494 -13841 4 2 0 1 1304 2302 1213 2788 -13842 4 2 0 1 615 540 583 2393 -13843 4 2 0 1 1292 1282 1202 2582 -13844 4 2 0 1 525 592 679 514 -13845 4 2 0 1 686 640 607 2390 -13846 4 2 0 1 611 540 555 2281 -13847 4 2 0 1 2416 2709 2064 2814 -13848 4 2 0 1 1159 1059 1054 2140 -13849 4 2 0 1 486 184 481 2330 -13850 4 2 0 1 1313 1317 1221 2531 -13851 4 2 0 1 1397 1365 2275 2770 -13852 4 2 0 1 2276 2454 1865 2712 -13853 4 2 0 1 1081 1169 1143 2769 -13854 4 2 0 1 302 371 216 2395 -13855 4 2 0 1 1314 1213 1304 2302 -13856 4 2 0 1 1076 1074 2405 2642 -13857 4 2 0 1 287 477 251 2107 -13858 4 2 0 1 991 935 2115 2461 -13859 4 2 0 1 824 694 2307 2451 -13860 4 2 0 1 714 782 718 2161 -13861 4 2 0 1 895 2421 2162 2695 -13862 4 2 0 1 1562 2314 2141 2823 -13863 4 2 0 1 1095 1044 1174 2274 -13864 4 2 0 1 1458 2374 2299 2499 -13865 4 2 0 1 1616 1951 2244 2627 -13866 4 2 0 1 459 465 819 2106 -13867 4 2 0 1 507 429 496 2818 -13868 4 2 0 1 1286 1513 669 2419 -13869 4 2 0 1 352 207 321 2130 -13870 4 2 0 1 1728 2479 2226 2800 -13871 4 2 0 1 2178 2223 2117 2730 -13872 4 2 0 1 1452 1464 1291 2462 -13873 4 2 0 1 1711 1870 2114 2769 -13874 4 2 0 1 2133 2208 1805 2668 -13875 4 2 0 1 669 1522 139 2419 -13876 4 2 0 1 190 236 259 2124 -13877 4 2 0 1 408 469 379 2662 -13878 4 2 0 1 1749 2557 2615 2718 -13879 4 2 0 1 1607 2009 2197 2408 -13880 4 2 0 1 1597 2471 1958 2506 -13881 4 2 0 1 2253 2555 1648 2649 -13882 4 2 0 1 2010 2215 1536 2743 -13883 4 2 0 1 585 609 538 2408 -13884 4 2 0 1 1704 2314 2141 2723 -13885 4 2 0 1 2377 2443 1662 2705 -13886 4 2 0 1 1352 1316 1186 2094 -13887 4 2 0 1 411 173 369 2317 -13888 4 2 0 1 1494 1503 1263 2722 -13889 4 2 0 1 1416 1236 1243 2289 -13890 4 2 0 1 2141 2314 1704 2823 -13891 4 2 0 1 140 487 846 2277 -13892 4 2 0 1 1532 2538 2210 2546 -13893 4 2 0 1 1842 2522 1745 2733 -13894 4 2 0 1 917 911 973 2241 -13895 4 2 0 1 2081 2233 913 2775 -13896 4 2 0 1 1607 2250 1968 2500 -13897 4 2 0 1 2177 2184 1696 2822 -13898 4 2 0 1 879 2514 942 2542 -13899 4 2 0 1 1346 1362 1336 2337 -13900 4 2 0 1 1674 2277 2217 2645 -13901 4 2 0 1 917 878 943 2591 -13902 4 2 0 1 833 689 823 2649 -13903 4 2 0 1 894 157 156 2670 -13904 4 2 0 1 1651 1922 2493 2664 -13905 4 2 0 1 991 153 152 2115 -13906 4 2 0 1 268 670 131 2830 -13907 4 2 0 1 974 933 984 2365 -13908 4 2 0 1 1807 2550 2413 2739 -13909 4 2 0 1 715 784 696 2217 -13910 4 2 0 1 1805 2531 1944 2558 -13911 4 2 0 1 1229 1440 1420 2033 -13912 4 2 0 1 828 842 153 2186 -13913 4 2 0 1 175 248 471 2674 -13914 4 2 0 1 886 2081 913 2775 -13915 4 2 0 1 2147 2395 1605 2735 -13916 4 2 0 1 1269 1251 1244 2051 -13917 4 2 0 1 429 243 2173 2752 -13918 4 2 0 1 510 515 650 2359 -13919 4 2 0 1 1915 408 2662 2824 -13920 4 2 0 1 1546 2483 2061 2689 -13921 4 2 0 1 1398 1286 578 2419 -13922 4 2 0 1 1674 2508 2217 2732 -13923 4 2 0 1 850 755 793 2498 -13924 4 2 0 1 1087 1102 1029 2202 -13925 4 2 0 1 2018 2534 2320 2834 -13926 4 2 0 1 973 911 889 2715 -13927 4 2 0 1 971 1459 886 2775 -13928 4 2 0 1 473 424 504 2225 -13929 4 2 0 1 747 780 745 2436 -13930 4 2 0 1 269 501 740 736 -13931 4 2 0 1 708 754 756 2171 -13932 4 2 0 1 349 181 323 2559 -13933 4 2 0 1 237 180 520 2826 -13934 4 2 0 1 376 239 245 2539 -13935 4 2 0 1 1593 2086 2612 2689 -13936 4 2 0 1 1574 2276 2024 2811 -13937 4 2 0 1 370 204 331 2744 -13938 4 2 0 1 2105 2261 1714 2534 -13939 4 2 0 1 820 839 1405 2379 -13940 4 2 0 1 1716 2319 2097 2821 -13941 4 2 0 1 705 760 811 2585 -13942 4 2 0 1 833 767 711 2649 -13943 4 2 0 1 1695 2519 2449 2799 -13944 4 2 0 1 1304 1212 1462 2133 -13945 4 2 0 1 1440 1229 1237 2033 -13946 4 2 0 1 1855 2378 1822 2772 -13947 4 2 0 1 1885 1642 2711 2801 -13948 4 2 0 1 1601 2227 2673 2839 -13949 4 2 0 1 531 649 567 2192 -13950 4 2 0 1 394 228 259 1905 -13951 4 2 0 1 1345 1375 1215 2467 -13952 4 2 0 1 1982 2397 348 2819 -13953 4 2 0 1 782 775 718 2555 -13954 4 2 0 1 1323 1215 1326 2467 -13955 4 2 0 1 2474 2552 2021 2755 -13956 4 2 0 1 1510 1298 1307 2241 -13957 4 2 0 1 853 145 827 2425 -13958 4 2 0 1 1674 2217 2508 2773 -13959 4 2 0 1 1015 2248 961 2588 -13960 4 2 0 1 187 2635 2106 2714 -13961 4 2 0 1 1313 1317 2531 2788 -13962 4 2 0 1 1223 1428 1392 1924 -13963 4 2 0 1 160 2394 1929 2561 -13964 4 2 0 1 616 570 573 1912 -13965 4 2 0 1 131 132 2128 2830 -13966 4 2 0 1 546 665 591 2053 -13967 4 2 0 1 1578 2443 1985 2705 -13968 4 2 0 1 2395 2554 1823 2735 -13969 4 2 0 1 1766 2496 2697 2759 -13970 4 2 0 1 638 599 649 1948 -13971 4 2 0 1 381 217 386 2661 -13972 4 2 0 1 890 173 434 2101 -13973 4 2 0 1 1994 2178 1632 2785 -13974 4 2 0 1 1636 2001 2285 2703 -13975 4 2 0 1 233 2405 404 2556 -13976 4 2 0 1 1313 1302 1212 2668 -13977 4 2 0 1 2338 2628 721 2692 -13978 4 2 0 1 23 464 257 741 -13979 4 2 0 1 349 323 344 1979 -13980 4 2 0 1 2210 2538 1783 2546 -13981 4 2 0 1 2412 1848 2726 2805 -13982 4 2 0 1 485 380 393 2017 -13983 4 2 0 1 1081 1036 1149 2769 -13984 4 2 0 1 1686 2092 2336 2622 -13985 4 2 0 1 1517 1468 1184 2724 -13986 4 2 0 1 1810 2690 2529 2718 -13987 4 2 0 1 1952 2086 2545 2821 -13988 4 2 0 1 462 443 256 2185 -13989 4 2 0 1 940 945 953 2637 -13990 4 2 0 1 2309 2449 1550 2519 -13991 4 2 0 1 996 158 891 2049 -13992 4 2 0 1 1664 2158 2382 2738 -13993 4 2 0 1 1587 2548 2126 2828 -13994 4 2 0 1 1048 1144 2064 2458 -13995 4 2 0 1 361 206 328 2669 -13996 4 2 0 1 1246 1444 2205 2557 -13997 4 2 0 1 1565 1858 2729 2801 -13998 4 2 0 1 198 172 487 2277 -13999 4 2 0 1 674 673 530 2180 -14000 4 2 0 1 1424 2469 1344 2812 -14001 4 2 0 1 1652 2236 2169 2728 -14002 4 2 0 1 597 543 662 2256 -14003 4 2 0 1 1034 2095 1108 2603 -14004 4 2 0 1 1272 1458 1195 2299 -14005 4 2 0 1 384 183 2639 2647 -14006 4 2 0 1 536 574 623 1884 -14007 4 2 0 1 1197 1419 1422 2551 -14008 4 2 0 1 2219 2292 1694 2832 -14009 4 2 0 1 1808 2374 2018 2534 -14010 4 2 0 1 1459 1279 1211 2081 -14011 4 2 0 1 1674 2705 2120 2732 -14012 4 2 0 1 1718 2508 2217 2773 -14013 4 2 0 1 1808 2534 2018 2834 -14014 4 2 0 1 1971 2479 1741 2781 -14015 4 2 0 1 1058 2179 2522 2777 -14016 4 2 0 1 338 291 491 1997 -14017 4 2 0 1 1093 1026 1041 2043 -14018 4 2 0 1 343 221 359 1947 -14019 4 2 0 1 1636 2285 2072 2470 -14020 4 2 0 1 1678 2664 2078 2704 -14021 4 2 0 1 1458 2299 1481 2499 -14022 4 2 0 1 1528 2466 2048 2836 -14023 4 2 0 1 1113 1136 1052 2394 -14024 4 2 0 1 2062 2262 1686 2797 -14025 4 2 0 1 849 764 814 2045 -14026 4 2 0 1 880 867 931 2073 -14027 4 2 0 1 496 429 528 2606 -14028 4 2 0 1 1095 2274 1140 2416 -14029 4 2 0 1 1413 1213 1305 2667 -14030 4 2 0 1 496 2128 2606 2830 -14031 4 2 0 1 649 1948 599 2786 -14032 4 2 0 1 1766 2697 2180 2759 -14033 4 2 0 1 241 2554 397 2752 -14034 4 2 0 1 1202 1208 1079 2582 -14035 4 2 0 1 2417 2580 1668 2827 -14036 4 2 0 1 1379 1409 1218 2493 -14037 4 2 0 1 1705 2474 2021 2755 -14038 4 2 0 1 1715 2488 2478 2789 -14039 4 2 0 1 1578 2450 2124 2727 -14040 4 2 0 1 260 489 506 2422 -14041 4 2 0 1 1138 1114 1172 2349 -14042 4 2 0 1 1366 1209 1296 2001 -14043 4 2 0 1 2030 2597 1801 2744 -14044 4 2 0 1 1551 2074 2341 2762 -14045 4 2 0 1 1480 1488 1499 2131 -14046 4 2 0 1 159 956 891 2049 -14047 4 2 0 1 1126 1038 1102 2202 -14048 4 2 0 1 676 2321 633 2766 -14049 4 2 0 1 1954 2415 2194 2655 -14050 4 2 0 1 1695 2741 2222 2779 -14051 4 2 0 1 999 155 1013 2165 -14052 4 2 0 1 1097 1073 1046 1914 -14053 4 2 0 1 870 876 993 1907 -14054 4 2 0 1 663 607 652 1972 -14055 4 2 0 1 1640 2218 2182 2719 -14056 4 2 0 1 1428 1488 1456 2087 -14057 4 2 0 1 2052 2401 1675 2750 -14058 4 2 0 1 2080 2590 1980 2838 -14059 4 2 0 1 763 733 808 2378 -14060 4 2 0 1 1387 2247 1391 2825 -14061 4 2 0 1 811 780 707 2501 -14062 4 2 0 1 1200 1280 1207 2053 -14063 4 2 0 1 1253 1178 1409 2455 -14064 4 2 0 1 649 567 2192 2786 -14065 4 2 0 1 135 136 1141 2410 -14066 4 2 0 1 1781 2184 2670 2742 -14067 4 2 0 1 309 2156 317 2795 -14068 4 2 0 1 313 201 317 2795 -14069 4 2 0 1 2161 2360 1860 2638 -14070 4 2 0 1 1996 2647 1801 2744 -14071 4 2 0 1 2199 2257 1804 2520 -14072 4 2 0 1 1327 1217 1369 2579 -14073 4 2 0 1 148 147 724 2131 -14074 4 2 0 1 1114 192 1118 2349 -14075 4 2 0 1 1761 2612 2107 2803 -14076 4 2 0 1 544 637 551 2663 -14077 4 2 0 1 1767 2084 2574 2676 -14078 4 2 0 1 1906 2513 1626 2608 -14079 4 2 0 1 1788 2024 2276 2811 -14080 4 2 0 1 726 791 2109 2628 -14081 4 2 0 1 1250 1914 1270 2696 -14082 4 2 0 1 1062 2488 1024 2503 -14083 4 2 0 1 231 377 468 2068 -14084 4 2 0 1 1116 1960 1056 2503 -14085 4 2 0 1 1182 1288 1248 1976 -14086 4 2 0 1 611 555 624 2294 -14087 4 2 0 1 448 461 265 2612 -14088 4 2 0 1 1167 1130 432 2713 -14089 4 2 0 1 1076 1035 1107 2642 -14090 4 2 0 1 557 586 608 2330 -14091 4 2 0 1 385 312 456 2407 -14092 4 2 0 1 1979 2336 1658 2535 -14093 4 2 0 1 1153 1034 1030 2603 -14094 4 2 0 1 778 815 856 2684 -14095 4 2 0 1 2231 2334 1608 2373 -14096 4 2 0 1 1605 2355 2262 2395 -14097 4 2 0 1 1686 2516 2092 2622 -14098 4 2 0 1 263 508 336 2714 -14099 4 2 0 1 331 204 310 2647 -14100 4 2 0 1 816 853 827 2425 -14101 4 2 0 1 1621 2307 1957 2451 -14102 4 2 0 1 713 779 731 2529 -14103 4 2 0 1 1024 2422 1051 2503 -14104 4 2 0 1 732 786 698 2628 -14105 4 2 0 1 953 945 897 2523 -14106 4 2 0 1 905 892 982 2477 -14107 4 2 0 1 1532 2210 2154 2546 -14108 4 2 0 1 923 959 955 1390 -14109 4 2 0 1 1130 2405 432 2713 -14110 4 2 0 1 1443 1468 1517 2026 -14111 4 2 0 1 1399 1228 1341 1992 -14112 4 2 0 1 853 847 146 2425 -14113 4 2 0 1 1288 1509 1199 2435 -14114 4 2 0 1 486 492 184 2694 -14115 4 2 0 1 522 909 905 2477 -14116 4 2 0 1 1576 1951 2474 2810 -14117 4 2 0 1 1370 1311 2475 2484 -14118 4 2 0 1 1482 1255 1189 2640 -14119 4 2 0 1 934 946 992 2259 -14120 4 2 0 1 674 672 2180 2672 -14121 4 2 0 1 1482 2229 2021 2640 -14122 4 2 0 1 1137 1055 1019 2570 -14123 4 2 0 1 533 571 640 2390 -14124 4 2 0 1 1612 2018 2320 2834 -14125 4 2 0 1 720 741 698 2692 -14126 4 2 0 1 1554 2392 2616 2834 -14127 4 2 0 1 1646 2522 2716 2804 -14128 4 2 0 1 873 1012 1006 2155 -14129 4 2 0 1 785 729 711 2375 -14130 4 2 0 1 1570 2318 2082 2609 -14131 4 2 0 1 1723 2225 2054 2626 -14132 4 2 0 1 429 241 243 2752 -14133 4 2 0 1 411 434 173 2101 -14134 4 2 0 1 241 2173 2554 2752 -14135 4 2 0 1 341 210 337 2601 -14136 4 2 0 1 515 626 650 2359 -14137 4 2 0 1 1476 558 1447 643 -14138 4 2 0 1 1403 1178 2201 2737 -14139 4 2 0 1 435 2405 1045 2424 -14140 4 2 0 1 476 442 404 2424 -14141 4 2 0 1 2180 2697 1573 2759 -14142 4 2 0 1 2154 2753 1916 2802 -14143 4 2 0 1 2094 2620 1837 2740 -14144 4 2 0 1 1626 2099 2347 2608 -14145 4 2 0 1 435 476 404 2424 -14146 4 2 0 1 1349 1351 1214 2044 -14147 4 2 0 1 715 696 740 2217 -14148 4 2 0 1 367 2097 179 2821 -14149 4 2 0 1 417 390 188 2090 -14150 4 2 0 1 1358 1225 1348 2076 -14151 4 2 0 1 289 2222 200 2741 -14152 4 2 0 1 633 530 687 2766 -14153 4 2 0 1 890 37 173 972 -14154 4 2 0 1 713 768 779 2529 -14155 4 2 0 1 1639 2654 2463 2743 -14156 4 2 0 1 792 155 156 2670 -14157 4 2 0 1 1874 1702 2630 2652 -14158 4 2 0 1 1870 2594 1710 2603 -14159 4 2 0 1 1048 1144 1044 2064 -14160 4 2 0 1 1562 2380 2314 2823 -14161 4 2 0 1 1454 1432 1190 2513 -14162 4 2 0 1 1573 2122 2452 2473 -14163 4 2 0 1 1098 1029 1072 2054 -14164 4 2 0 1 1665 2611 1917 2671 -14165 4 2 0 1 684 678 545 2569 -14166 4 2 0 1 396 2662 469 2824 -14167 4 2 0 1 1643 2685 2209 2793 -14168 4 2 0 1 1165 1028 1088 2414 -14169 4 2 0 1 1800 2209 2685 2793 -14170 4 2 0 1 1472 1282 1180 2229 -14171 4 2 0 1 1380 1409 1379 2493 -14172 4 2 0 1 1443 1468 2026 2686 -14173 4 2 0 1 771 710 784 2508 -14174 4 2 0 1 207 316 321 2130 -14175 4 2 0 1 268 174 670 2830 -14176 4 2 0 1 1180 1266 1267 2563 -14177 4 2 0 1 1224 889 1382 2715 -14178 4 2 0 1 932 927 869 2251 -14179 4 2 0 1 1471 1298 1187 2383 -14180 4 2 0 1 1558 2377 1985 2837 -14181 4 2 0 1 1104 2522 1842 2733 -14182 4 2 0 1 885 29 276 282 -14183 4 2 0 1 1525 1526 1203 2135 -14184 4 2 0 1 1488 737 1495 2087 -14185 4 2 0 1 145 827 2425 2638 -14186 4 2 0 1 1448 2263 1241 2780 -14187 4 2 0 1 1692 2665 2351 2754 -14188 4 2 0 1 1533 2270 2080 2838 -14189 4 2 0 1 563 141 628 1955 -14190 4 2 0 1 1105 1044 1095 2416 -14191 4 2 0 1 139 1155 1053 2264 -14192 4 2 0 1 2043 1959 2458 2518 -14193 4 2 0 1 2332 2341 2074 2762 -14194 4 2 0 1 1236 1268 1254 2289 -14195 4 2 0 1 1045 1074 1096 2405 -14196 4 2 0 1 304 303 2605 2614 -14197 4 2 0 1 944 960 988 2734 -14198 4 2 0 1 1242 1384 1439 2763 -14199 4 2 0 1 1692 2351 1974 2754 -14200 4 2 0 1 735 723 843 2135 -14201 4 2 0 1 1752 2316 1957 2816 -14202 4 2 0 1 2021 2474 1576 2552 -14203 4 2 0 1 1964 2792 1686 2797 -14204 4 2 0 1 459 2106 819 2714 -14205 4 2 0 1 296 332 200 2222 -14206 4 2 0 1 1638 1885 2325 2512 -14207 4 2 0 1 1435 2275 1179 2767 -14208 4 2 0 1 473 2092 382 2516 -14209 4 2 0 1 881 984 933 2589 -14210 4 2 0 1 968 861 899 2165 -14211 4 2 0 1 1457 1393 2326 2381 -14212 4 2 0 1 801 690 802 2028 -14213 4 2 0 1 891 2049 956 2561 -14214 4 2 0 1 645 1431 1429 2132 -14215 4 2 0 1 1553 1921 2459 2749 -14216 4 2 0 1 446 192 1114 2349 -14217 4 2 0 1 2124 2533 190 2819 -14218 4 2 0 1 564 625 648 2350 -14219 4 2 0 1 630 626 451 2610 -14220 4 2 0 1 245 2445 471 2539 -14221 4 2 0 1 1747 2332 2074 2762 -14222 4 2 0 1 731 728 792 2055 -14223 4 2 0 1 2018 2374 1731 2534 -14224 4 2 0 1 1805 2531 2133 2668 -14225 4 2 0 1 1434 1404 1356 2007 -14226 4 2 0 1 2360 2425 1860 2638 -14227 4 2 0 1 1553 2415 1921 2749 -14228 4 2 0 1 2233 2499 1803 2775 -14229 4 2 0 1 1939 2468 1737 2489 -14230 4 2 0 1 1020 1135 1123 2491 -14231 4 2 0 1 1787 2716 2414 2804 -14232 4 2 0 1 562 644 470 2658 -14233 4 2 0 1 592 525 679 61 -14234 4 2 0 1 938 882 869 2251 -14235 4 2 0 1 1724 2589 2165 2644 -14236 4 2 0 1 294 523 519 2624 -14237 4 2 0 1 992 161 162 2035 -14238 4 2 0 1 1545 2164 2088 2676 -14239 4 2 0 1 507 438 506 2422 -14240 4 2 0 1 917 959 923 2241 -14241 4 2 0 1 526 909 885 282 -14242 4 2 0 1 1680 2753 2154 2802 -14243 4 2 0 1 312 301 235 2002 -14244 4 2 0 1 1410 1407 1248 2442 -14245 4 2 0 1 1141 1148 1094 2733 -14246 4 2 0 1 181 326 341 2559 -14247 4 2 0 1 1653 2587 1973 2766 -14248 4 2 0 1 1648 2577 2643 2717 -14249 4 2 0 1 779 840 728 2055 -14250 4 2 0 1 561 2132 583 2294 -14251 4 2 0 1 1964 2622 1686 2792 -14252 4 2 0 1 943 2279 965 2591 -14253 4 2 0 1 2161 1662 2360 2638 -14254 4 2 0 1 1120 1047 1094 2733 -14255 4 2 0 1 1978 1681 2556 2613 -14256 4 2 0 1 1526 1494 1203 2135 -14257 4 2 0 1 369 173 225 2317 -14258 4 2 0 1 1651 2257 2199 2520 -14259 4 2 0 1 553 656 605 2009 -14260 4 2 0 1 630 678 626 2610 -14261 4 2 0 1 1068 1025 1064 2339 -14262 4 2 0 1 458 2525 219 2744 -14263 4 2 0 1 1668 2020 2399 2417 -14264 4 2 0 1 726 791 151 2109 -14265 4 2 0 1 159 2394 160 2561 -14266 4 2 0 1 1184 1468 1477 2724 -14267 4 2 0 1 328 365 183 2669 -14268 4 2 0 1 772 716 785 2666 -14269 4 2 0 1 1535 2203 2304 2665 -14270 4 2 0 1 107 979 1436 2462 -14271 4 2 0 1 1466 1119 1083 1115 -14272 4 2 0 1 118 1067 1046 1250 -14273 4 2 0 1 470 644 426 2658 -14274 4 2 0 1 1705 2627 2755 2760 -14275 4 2 0 1 983 965 921 2279 -14276 4 2 0 1 1166 1078 1038 2564 -14277 4 2 0 1 167 456 366 2159 -14278 4 2 0 1 2436 2502 1629 2772 -14279 4 2 0 1 949 880 900 2637 -14280 4 2 0 1 1705 2755 2387 2760 -14281 4 2 0 1 2081 2499 2233 2775 -14282 4 2 0 1 1180 1482 1497 2229 -14283 4 2 0 1 1190 1451 1467 2513 -14284 4 2 0 1 1175 1122 1121 2138 -14285 4 2 0 1 1821 2194 2415 2655 -14286 4 2 0 1 293 392 214 2516 -14287 4 2 0 1 1769 2513 1906 2608 -14288 4 2 0 1 1577 2058 2621 2748 -14289 4 2 0 1 1885 2711 2008 2801 -14290 4 2 0 1 1035 1154 1031 2170 -14291 4 2 0 1 932 882 941 2251 -14292 4 2 0 1 1034 1108 1171 2603 -14293 4 2 0 1 1242 1439 2387 2763 -14294 4 2 0 1 1125 1032 1081 2255 -14295 4 2 0 1 247 2533 261 2658 -14296 4 2 0 1 216 371 455 2554 -14297 4 2 0 1 107 1436 1291 2462 -14298 4 2 0 1 513 2355 2157 2824 -14299 4 2 0 1 1209 1366 1393 2381 -14300 4 2 0 1 1618 1973 2246 2697 -14301 4 2 0 1 1533 2504 1970 2583 -14302 4 2 0 1 268 2128 496 2830 -14303 4 2 0 1 2195 2303 1646 2716 -14304 4 2 0 1 1535 2110 2431 2487 -14305 4 2 0 1 1313 2531 2133 2788 -14306 4 2 0 1 1899 2618 1668 2827 -14307 4 2 0 1 1950 1655 2450 2727 -14308 4 2 0 1 637 615 551 2663 -14309 4 2 0 1 1190 2513 1467 2631 -14310 4 2 0 1 371 2554 2395 2791 -14311 4 2 0 1 1018 2191 1161 2594 -14312 4 2 0 1 142 826 788 2120 -14313 4 2 0 1 1735 2435 2434 2500 -14314 4 2 0 1 2326 2381 1393 2825 -14315 4 2 0 1 1568 2252 2047 2831 -14316 4 2 0 1 1550 2519 2449 2568 -14317 4 2 0 1 172 2456 254 2457 -14318 4 2 0 1 241 2173 423 2554 -14319 4 2 0 1 481 185 2330 2560 -14320 4 2 0 1 1010 2070 988 2734 -14321 4 2 0 1 1301 1334 1212 2420 -14322 4 2 0 1 1786 2536 2345 2802 -14323 4 2 0 1 1339 1302 1187 2383 -14324 4 2 0 1 944 988 898 2070 -14325 4 2 0 1 301 338 235 2605 -14326 4 2 0 1 577 564 654 2830 -14327 4 2 0 1 1001 1009 989 2562 -14328 4 2 0 1 1486 1270 2640 2696 -14329 4 2 0 1 2463 2654 1866 2743 -14330 4 2 0 1 1397 1240 1385 2148 -14331 4 2 0 1 1153 1139 1079 2582 -14332 4 2 0 1 1027 1107 1089 2642 -14333 4 2 0 1 1085 2191 1121 2584 -14334 4 2 0 1 1697 2662 2657 2824 -14335 4 2 0 1 2100 2372 1796 2577 -14336 4 2 0 1 598 2587 687 2766 -14337 4 2 0 1 1605 2315 1964 2797 -14338 4 2 0 1 1165 1043 1028 2414 -14339 4 2 0 1 2218 2764 1614 2814 -14340 4 2 0 1 971 886 913 2775 -14341 4 2 0 1 1276 1190 1450 2171 -14342 4 2 0 1 2260 2481 1700 2569 -14343 4 2 0 1 2234 2729 1854 2787 -14344 4 2 0 1 448 265 2086 2612 -14345 4 2 0 1 1133 127 1271 1049 -14346 4 2 0 1 1697 1915 2662 2824 -14347 4 2 0 1 1066 1273 1508 2696 -14348 4 2 0 1 1104 1165 1120 2733 -14349 4 2 0 1 1710 2594 1870 2710 -14350 4 2 0 1 1570 2082 2291 2609 -14351 4 2 0 1 690 733 809 2378 -14352 4 2 0 1 536 623 562 2658 -14353 4 2 0 1 410 397 177 2752 -14354 4 2 0 1 1278 1254 1196 2117 -14355 4 2 0 1 2414 2716 1842 2804 -14356 4 2 0 1 1202 1079 1139 2582 -14357 4 2 0 1 940 888 945 2461 -14358 4 2 0 1 220 2156 339 2683 -14359 4 2 0 1 185 189 481 2330 -14360 4 2 0 1 1424 1344 1430 2812 -14361 4 2 0 1 1218 1321 1349 2455 -14362 4 2 0 1 285 954 978 2327 -14363 4 2 0 1 629 147 565 2131 -14364 4 2 0 1 1345 1299 1308 2655 -14365 4 2 0 1 1870 2594 1711 2710 -14366 4 2 0 1 518 2277 172 2645 -14367 4 2 0 1 1202 1208 122 1079 -14368 4 2 0 1 634 2321 676 2766 -14369 4 2 0 1 766 712 776 2403 -14370 4 2 0 1 2246 2367 1618 2725 -14371 4 2 0 1 524 503 516 2477 -14372 4 2 0 1 1917 2547 1551 2762 -14373 4 2 0 1 97 1290 719 1505 -14374 4 2 0 1 507 496 268 2128 -14375 4 2 0 1 419 335 330 2200 -14376 4 2 0 1 326 1913 432 2405 -14377 4 2 0 1 2289 2551 1623 2730 -14378 4 2 0 1 1573 2452 2122 2630 -14379 4 2 0 1 1163 1162 1150 2384 -14380 4 2 0 1 246 433 195 2498 -14381 4 2 0 1 1670 2554 2395 2735 -14382 4 2 0 1 1606 2535 2040 2757 -14383 4 2 0 1 217 381 356 2207 -14384 4 2 0 1 2081 2299 1628 2499 -14385 4 2 0 1 2029 2519 1695 2799 -14386 4 2 0 1 1397 1365 1435 2275 -14387 4 2 0 1 999 155 2165 2670 -14388 4 2 0 1 819 2106 745 2714 -14389 4 2 0 1 1796 2100 2643 2837 -14390 4 2 0 1 1037 1163 1150 2565 -14391 4 2 0 1 2086 2319 1593 2545 -14392 4 2 0 1 1687 2514 2317 2576 -14393 4 2 0 1 2062 1686 2412 2797 -14394 4 2 0 1 2309 2519 1709 2799 -14395 4 2 0 1 301 2002 312 2741 -14396 4 2 0 1 437 255 395 2297 -14397 4 2 0 1 991 935 980 2115 -14398 4 2 0 1 1282 2581 1394 2582 -14399 4 2 0 1 1316 2420 1301 2740 -14400 4 2 0 1 1325 1377 1333 2325 -14401 4 2 0 1 1707 2640 1914 2696 -14402 4 2 0 1 639 2469 595 2812 -14403 4 2 0 1 924 858 1001 2125 -14404 4 2 0 1 1914 2346 1707 2696 -14405 4 2 0 1 2253 2378 2045 2717 -14406 4 2 0 1 2080 2270 1657 2838 -14407 4 2 0 1 2320 2534 1714 2834 -14408 4 2 0 1 2146 2620 1837 2833 -14409 4 2 0 1 1431 1400 1429 2132 -14410 4 2 0 1 1149 1176 1084 2594 -14411 4 2 0 1 1984 2419 1735 2686 -14412 4 2 0 1 1766 2246 2180 2697 -14413 4 2 0 1 1088 1028 1103 2414 -14414 4 2 0 1 1232 1322 1332 2441 -14415 4 2 0 1 432 326 391 1913 -14416 4 2 0 1 381 2207 217 2661 -14417 4 2 0 1 586 2046 539 2761 -14418 4 2 0 1 1071 1133 1077 2056 -14419 4 2 0 1 1151 1140 162 2416 -14420 4 2 0 1 352 176 309 2269 -14421 4 2 0 1 409 452 224 2084 -14422 4 2 0 1 1519 1381 1508 2278 -14423 4 2 0 1 886 950 937 2081 -14424 4 2 0 1 1822 2502 2436 2772 -14425 4 2 0 1 1873 2492 2221 2738 -14426 4 2 0 1 1681 2642 2406 2768 -14427 4 2 0 1 546 2367 542 2725 -14428 4 2 0 1 1670 2752 1965 2791 -14429 4 2 0 1 365 444 509 2409 -14430 4 2 0 1 273 285 978 2327 -14431 4 2 0 1 1717 2413 2245 2739 -14432 4 2 0 1 127 1205 1271 1049 -14433 4 2 0 1 760 758 797 2585 -14434 4 2 0 1 895 977 2421 2695 -14435 4 2 0 1 1542 2100 2372 2693 -14436 4 2 0 1 584 644 562 2658 -14437 4 2 0 1 1238 1418 1386 2711 -14438 4 2 0 1 1509 1283 1487 2435 -14439 4 2 0 1 1678 2001 2381 2703 -14440 4 2 0 1 429 2173 241 2752 -14441 4 2 0 1 991 980 153 2115 -14442 4 2 0 1 1659 2397 1982 2727 -14443 4 2 0 1 565 148 667 2131 -14444 4 2 0 1 1398 1504 1286 2419 -14445 4 2 0 1 1726 2425 2360 2638 -14446 4 2 0 1 698 721 2628 2692 -14447 4 2 0 1 1113 160 1136 2394 -14448 4 2 0 1 1209 1380 1379 2381 -14449 4 2 0 1 784 696 2217 2508 -14450 4 2 0 1 901 893 865 2137 -14451 4 2 0 1 2214 2413 1717 2739 -14452 4 2 0 1 711 729 695 2375 -14453 4 2 0 1 2030 2525 1649 2744 -14454 4 2 0 1 1712 2460 2121 2794 -14455 4 2 0 1 501 12 269 740 -14456 4 2 0 1 713 774 702 2529 -14457 4 2 0 1 2474 2619 1951 2833 -14458 4 2 0 1 2066 2341 1792 2404 -14459 4 2 0 1 584 562 610 2658 -14460 4 2 0 1 659 1252 631 2469 -14461 4 2 0 1 1126 1102 1087 2202 -14462 4 2 0 1 322 314 394 2397 -14463 4 2 0 1 1365 1426 1433 2770 -14464 4 2 0 1 1205 1049 1068 2339 -14465 4 2 0 1 1258 2326 1393 2825 -14466 4 2 0 1 325 330 402 2328 -14467 4 2 0 1 1519 1508 1273 2696 -14468 4 2 0 1 1145 1127 1083 1994 -14469 4 2 0 1 1699 2601 2130 2621 -14470 4 2 0 1 924 1001 989 2125 -14471 4 2 0 1 2117 1623 2551 2730 -14472 4 2 0 1 1642 2234 2787 2801 -14473 4 2 0 1 1373 1232 1332 2441 -14474 4 2 0 1 1557 2541 2228 2768 -14475 4 2 0 1 1497 2229 1482 2640 -14476 4 2 0 1 1538 2470 2285 2703 -14477 4 2 0 1 228 2645 1905 2815 -14478 4 2 0 1 581 557 279 58 -14479 4 2 0 1 186 2327 273 2803 -14480 4 2 0 1 1160 1161 1162 2384 -14481 4 2 0 1 2185 2200 1736 2632 -14482 4 2 0 1 1071 1103 1028 2414 -14483 4 2 0 1 770 841 782 2161 -14484 4 2 0 1 1985 2443 2377 2705 -14485 4 2 0 1 474 528 243 2606 -14486 4 2 0 1 1067 118 1273 1250 -14487 4 2 0 1 2130 2601 1789 2621 -14488 4 2 0 1 1027 2406 1096 2642 -14489 4 2 0 1 513 519 289 2157 -14490 4 2 0 1 796 817 752 2677 -14491 4 2 0 1 247 190 261 2533 -14492 4 2 0 1 586 588 619 2046 -14493 4 2 0 1 675 594 672 2672 -14494 4 2 0 1 1879 2200 2185 2632 -14495 4 2 0 1 2299 2374 1628 2499 -14496 4 2 0 1 221 421 378 2464 -14497 4 2 0 1 524 264 267 2209 -14498 4 2 0 1 1611 1970 2504 2796 -14499 4 2 0 1 435 1045 476 2424 -14500 4 2 0 1 2100 2577 1796 2643 -14501 4 2 0 1 1635 2460 2121 2566 -14502 4 2 0 1 2245 2413 1717 2707 -14503 4 2 0 1 1116 133 1056 1960 -14504 4 2 0 1 1252 1400 1344 2469 -14505 4 2 0 1 1027 1089 1091 2406 -14506 4 2 0 1 997 1507 1485 1501 -14507 4 2 0 1 683 596 542 2367 -14508 4 2 0 1 284 516 527 2338 -14509 4 2 0 1 582 480 470 562 -14510 4 2 0 1 278 958 34 954 -14511 4 2 0 1 590 2400 678 2610 -14512 4 2 0 1 739 699 735 2135 -14513 4 2 0 1 1906 2513 1769 2780 -14514 4 2 0 1 674 672 673 2180 -14515 4 2 0 1 1058 137 2179 2777 -14516 4 2 0 1 1114 1118 1166 2349 -14517 4 2 0 1 1866 2573 2047 2831 -14518 4 2 0 1 1692 2351 2665 2783 -14519 4 2 0 1 1703 2731 2160 2758 -14520 4 2 0 1 1704 2314 2059 2823 -14521 4 2 0 1 942 879 918 2514 -14522 4 2 0 1 439 190 2533 2819 -14523 4 2 0 1 287 30 276 1007 -14524 4 2 0 1 467 453 454 2445 -14525 4 2 0 1 1806 2219 2362 2680 -14526 4 2 0 1 504 512 489 2225 -14527 4 2 0 1 458 2674 2525 2744 -14528 4 2 0 1 966 879 942 2542 -14529 4 2 0 1 1670 2604 1940 2735 -14530 4 2 0 1 533 553 571 2197 -14531 4 2 0 1 1304 1313 2133 2788 -14532 4 2 0 1 1608 2373 2334 2829 -14533 4 2 0 1 2128 2606 2173 2818 -14534 4 2 0 1 2206 1618 2496 2782 -14535 4 2 0 1 1208 1168 1079 2582 -14536 4 2 0 1 2047 2573 1568 2831 -14537 4 2 0 1 1725 2481 2260 2569 -14538 4 2 0 1 1274 2303 1277 2586 -14539 4 2 0 1 496 528 253 2830 -14540 4 2 0 1 901 883 944 2287 -14541 4 2 0 1 440 439 2533 2819 -14542 4 2 0 1 606 2212 653 2283 -14543 4 2 0 1 1278 1261 1254 2117 -14544 4 2 0 1 648 133 132 2350 -14545 4 2 0 1 1504 1518 1487 2686 -14546 4 2 0 1 1153 1079 1034 2582 -14547 4 2 0 1 1777 2413 2707 2813 -14548 4 2 0 1 2010 1573 2473 2697 -14549 4 2 0 1 1748 2382 2158 2738 -14550 4 2 0 1 1456 2087 1495 2666 -14551 4 2 0 1 1067 1046 1273 2696 -14552 4 2 0 1 623 610 562 2658 -14553 4 2 0 1 325 232 405 2328 -14554 4 2 0 1 889 113 1382 908 -14555 4 2 0 1 588 2046 586 2560 -14556 4 2 0 1 943 965 928 2591 -14557 4 2 0 1 260 489 2422 2626 -14558 4 2 0 1 586 539 608 2761 -14559 4 2 0 1 1842 2716 2522 2804 -14560 4 2 0 1 29 885 276 970 -14561 4 2 0 1 904 865 893 2137 -14562 4 2 0 1 396 288 2657 2824 -14563 4 2 0 1 1106 1094 1047 2060 -14564 4 2 0 1 320 329 168 2399 -14565 4 2 0 1 886 937 913 2081 -14566 4 2 0 1 384 310 183 2647 -14567 4 2 0 1 890 864 951 2494 -14568 4 2 0 1 273 2327 978 2803 -14569 4 2 0 1 1725 2610 2400 2661 -14570 4 2 0 1 2106 2635 1718 2714 -14571 4 2 0 1 501 422 508 2217 -14572 4 2 0 1 642 586 2330 2560 -14573 4 2 0 1 1504 1487 2419 2686 -14574 4 2 0 1 1524 1505 719 2722 -14575 4 2 0 1 1249 1427 1456 2485 -14576 4 2 0 1 220 374 354 2683 -14577 4 2 0 1 592 588 679 2560 -14578 4 2 0 1 1996 1649 2674 2744 -14579 4 2 0 1 938 951 882 2495 -14580 4 2 0 1 1688 2458 1959 2719 -14581 4 2 0 1 1951 2619 2474 2810 -14582 4 2 0 1 1076 1074 1130 2405 -14583 4 2 0 1 233 326 432 2405 -14584 4 2 0 1 1649 2525 2066 2674 -14585 4 2 0 1 176 357 334 2268 -14586 4 2 0 1 225 369 2317 2679 -14587 4 2 0 1 1543 2578 2083 2660 -14588 4 2 0 1 2398 2688 1856 2809 -14589 4 2 0 1 1750 2398 2258 2688 -14590 4 2 0 1 873 1006 879 2542 -14591 4 2 0 1 1070 260 54 2422 -14592 4 2 0 1 1275 1441 1193 2615 -14593 4 2 0 1 1888 2300 2369 2806 -14594 4 2 0 1 327 289 200 2741 -14595 4 2 0 1 1914 2640 1270 2696 -14596 4 2 0 1 74 1476 1447 643 -14597 4 2 0 1 254 172 198 2456 -14598 4 2 0 1 1536 2215 2463 2743 -14599 4 2 0 1 2180 2246 1973 2697 -14600 4 2 0 1 1050 260 53 1070 -14601 4 2 0 1 1331 1301 1309 2740 -14602 4 2 0 1 1916 2753 1786 2802 -14603 4 2 0 1 739 699 2135 2722 -14604 4 2 0 1 264 466 267 2209 -14605 4 2 0 1 1431 645 82 561 -14606 4 2 0 1 943 878 965 2279 -14607 4 2 0 1 737 724 697 2087 -14608 4 2 0 1 1719 2082 2318 2609 -14609 4 2 0 1 133 625 569 2350 -14610 4 2 0 1 1645 2509 2039 2646 -14611 4 2 0 1 1745 2522 2179 2777 -14612 4 2 0 1 1080 47 1138 272 -14613 4 2 0 1 726 776 732 2628 -14614 4 2 0 1 473 382 214 2516 -14615 4 2 0 1 2314 2380 2059 2823 -14616 4 2 0 1 720 464 23 741 -14617 4 2 0 1 1323 1491 1499 2484 -14618 4 2 0 1 780 763 701 2436 -14619 4 2 0 1 2406 2642 1864 2768 -14620 4 2 0 1 1715 2478 1940 2789 -14621 4 2 0 1 1309 1302 1339 2668 -14622 4 2 0 1 1914 2229 2095 2581 -14623 4 2 0 1 498 290 294 2062 -14624 4 2 0 1 1168 1394 1262 2581 -14625 4 2 0 1 836 15 465 819 -14626 4 2 0 1 1177 1297 1306 2512 -14627 4 2 0 1 1996 2539 1665 2639 -14628 4 2 0 1 787 774 713 2529 -14629 4 2 0 1 1010 898 988 2070 -14630 4 2 0 1 2377 2643 2100 2837 -14631 4 2 0 1 1230 1425 1385 2721 -14632 4 2 0 1 260 1050 266 2626 -14633 4 2 0 1 467 425 453 2404 -14634 4 2 0 1 1959 2458 1746 2719 -14635 4 2 0 1 833 823 767 2649 -14636 4 2 0 1 1720 2222 2157 2779 -14637 4 2 0 1 1063 1070 54 2422 -14638 4 2 0 1 1000 922 859 2695 -14639 4 2 0 1 1494 1203 2135 2722 -14640 4 2 0 1 531 567 655 2192 -14641 4 2 0 1 1051 1156 131 2128 -14642 4 2 0 1 1648 2577 2100 2643 -14643 4 2 0 1 558 74 1447 643 -14644 4 2 0 1 1543 2083 2578 2726 -14645 4 2 0 1 1018 1084 1086 2594 -14646 4 2 0 1 1674 2457 2277 2645 -14647 4 2 0 1 1560 2413 2245 2707 -14648 4 2 0 1 429 2173 2606 2818 -14649 4 2 0 1 1412 1410 1421 2091 -14650 4 2 0 1 429 194 2173 2818 -14651 4 2 0 1 522 193 526 2477 -14652 4 2 0 1 463 505 171 2567 -14653 4 2 0 1 2336 2535 1979 2757 -14654 4 2 0 1 413 465 187 2106 -14655 4 2 0 1 222 329 320 2020 -14656 4 2 0 1 796 815 851 2596 -14657 4 2 0 1 552 612 572 2344 -14658 4 2 0 1 2146 1837 2625 2833 -14659 4 2 0 1 975 895 963 2421 -14660 4 2 0 1 2133 2302 1304 2788 -14661 4 2 0 1 890 910 864 2494 -14662 4 2 0 1 690 814 733 2045 -14663 4 2 0 1 1085 1018 1121 2191 -14664 4 2 0 1 1067 1273 1046 1250 -14665 4 2 0 1 684 666 2359 2569 -14666 4 2 0 1 1197 1277 1407 2442 -14667 4 2 0 1 1200 1414 1280 2053 -14668 4 2 0 1 510 497 515 2359 -14669 4 2 0 1 513 494 519 2355 -14670 4 2 0 1 1686 2336 2412 2792 -14671 4 2 0 1 1687 2155 2444 2542 -14672 4 2 0 1 1680 2433 2154 2706 -14673 4 2 0 1 1785 2304 2203 2665 -14674 4 2 0 1 2121 2460 1712 2566 -14675 4 2 0 1 1380 1379 2381 2493 -14676 4 2 0 1 639 544 551 2069 -14677 4 2 0 1 2372 2506 1830 2693 -14678 4 2 0 1 1461 2374 1458 2499 -14679 4 2 0 1 1653 2473 2272 2723 -14680 4 2 0 1 830 846 736 2277 -14681 4 2 0 1 443 372 256 2185 -14682 4 2 0 1 1717 2295 2707 2813 -14683 4 2 0 1 678 590 550 2400 -14684 4 2 0 1 1267 1255 1482 2021 -14685 4 2 0 1 582 562 470 2658 -14686 4 2 0 1 2074 1629 2332 2772 -14687 4 2 0 1 696 736 740 2217 -14688 4 2 0 1 336 2635 187 2714 -14689 4 2 0 1 1853 2578 2075 2660 -14690 4 2 0 1 634 676 633 2766 -14691 4 2 0 1 309 308 2269 2795 -14692 4 2 0 1 1387 1366 1226 2825 -14693 4 2 0 1 2018 2667 1926 2788 -14694 4 2 0 1 12 269 740 736 -14695 4 2 0 1 557 279 58 189 -14696 4 2 0 1 636 687 2587 2766 -14697 4 2 0 1 1481 1458 1279 2299 -14698 4 2 0 1 537 580 561 2294 -14699 4 2 0 1 1058 2179 1117 2522 -14700 4 2 0 1 225 355 369 2679 -14701 4 2 0 1 553 622 571 2197 -14702 4 2 0 1 2310 2521 1857 2712 -14703 4 2 0 1 452 366 398 2323 -14704 4 2 0 1 604 635 599 2786 -14705 4 2 0 1 1608 2334 2701 2829 -14706 4 2 0 1 260 438 54 2422 -14707 4 2 0 1 1442 1379 1312 2493 -14708 4 2 0 1 1667 2650 2061 2771 -14709 4 2 0 1 1258 1387 1391 2825 -14710 4 2 0 1 1026 1093 1090 2043 -14711 4 2 0 1 1982 2328 1655 2819 -14712 4 2 0 1 1381 1506 10 995 -14713 4 2 0 1 598 636 687 2587 -14714 4 2 0 1 2729 2787 2234 2801 -14715 4 2 0 1 10 1381 995 166 -14716 4 2 0 1 974 984 857 2365 -14717 4 2 0 1 1448 1371 1241 2263 -14718 4 2 0 1 337 321 316 2601 -14719 4 2 0 1 634 601 676 2321 -14720 4 2 0 1 552 621 608 2761 -14721 4 2 0 1 1162 1161 1018 2191 -14722 4 2 0 1 504 2225 489 2626 -14723 4 2 0 1 340 235 303 2605 -14724 4 2 0 1 280 284 527 2338 -14725 4 2 0 1 1804 2599 2295 2707 -14726 4 2 0 1 1449 1222 1391 2247 -14727 4 2 0 1 912 972 890 2101 -14728 4 2 0 1 1075 1108 1034 2095 -14729 4 2 0 1 1615 2162 2421 2695 -14730 4 2 0 1 423 429 194 2173 -14731 4 2 0 1 971 1459 104 886 -14732 4 2 0 1 639 551 595 2469 -14733 4 2 0 1 1432 1451 1190 2513 -14734 4 2 0 1 1728 2335 2244 2656 -14735 4 2 0 1 2215 2743 2010 2782 -14736 4 2 0 1 215 374 378 2366 -14737 4 2 0 1 1683 2572 2398 2798 -14738 4 2 0 1 926 964 1015 2248 -14739 4 2 0 1 1469 1489 1186 2620 -14740 4 2 0 1 903 891 864 2494 -14741 4 2 0 1 476 1045 1069 2424 -14742 4 2 0 1 1781 2670 2165 2742 -14743 4 2 0 1 1711 2594 1870 2769 -14744 4 2 0 1 134 1152 1056 1960 -14745 4 2 0 1 1242 1255 1455 2387 -14746 4 2 0 1 62 592 510 650 -14747 4 2 0 1 1063 54 438 2422 -14748 4 2 0 1 203 2407 390 2657 -14749 4 2 0 1 708 796 754 2596 -14750 4 2 0 1 1452 1320 1415 2720 -14751 4 2 0 1 715 745 771 2714 -14752 4 2 0 1 733 763 809 2378 -14753 4 2 0 1 1723 2488 2054 2789 -14754 4 2 0 1 1242 2387 1384 2763 -14755 4 2 0 1 642 586 557 2330 -14756 4 2 0 1 1465 2499 1481 2775 -14757 4 2 0 1 389 414 412 2641 -14758 4 2 0 1 878 2279 943 2591 -14759 4 2 0 1 1059 1159 1128 2140 -14760 4 2 0 1 924 870 1011 2553 -14761 4 2 0 1 1117 1058 137 2179 -14762 4 2 0 1 507 2422 506 2818 -14763 4 2 0 1 645 583 561 2132 -14764 4 2 0 1 840 769 828 2186 -14765 4 2 0 1 228 380 485 2645 -14766 4 2 0 1 1253 1433 1426 2751 -14767 4 2 0 1 1035 1129 1107 2170 -14768 4 2 0 1 637 544 593 2663 -14769 4 2 0 1 1717 2707 2413 2813 -14770 4 2 0 1 107 919 979 2462 -14771 4 2 0 1 1086 1171 1090 2518 -14772 4 2 0 1 220 339 359 2683 -14773 4 2 0 1 1246 1275 1444 2557 -14774 4 2 0 1 473 170 382 2092 -14775 4 2 0 1 1127 1032 1039 2255 -14776 4 2 0 1 1574 2024 2526 2811 -14777 4 2 0 1 1382 1402 1474 904 -14778 4 2 0 1 1410 1230 1396 2721 -14779 4 2 0 1 1913 2405 1681 2642 -14780 4 2 0 1 333 168 356 2399 -14781 4 2 0 1 365 509 350 2153 -14782 4 2 0 1 830 140 846 2277 -14783 4 2 0 1 1688 2719 1959 2810 -14784 4 2 0 1 1059 1021 1041 2346 -14785 4 2 0 1 952 939 883 2715 -14786 4 2 0 1 1555 2598 2014 2659 -14787 4 2 0 1 1067 1273 1066 2696 -14788 4 2 0 1 1136 160 159 2394 -14789 4 2 0 1 1408 716 1294 2666 -14790 4 2 0 1 107 1291 919 2462 -14791 4 2 0 1 131 132 1051 2128 -14792 4 2 0 1 747 745 819 2106 -14793 4 2 0 1 1515 1493 1502 2339 -14794 4 2 0 1 353 383 403 2525 -14795 4 2 0 1 890 434 910 2494 -14796 4 2 0 1 493 426 66 658 -14797 4 2 0 1 50 1146 1118 286 -14798 4 2 0 1 458 403 219 2525 -14799 4 2 0 1 433 277 195 2498 -14800 4 2 0 1 1688 2064 2458 2719 -14801 4 2 0 1 572 612 625 2344 -14802 4 2 0 1 774 742 702 2690 -14803 4 2 0 1 787 719 774 2722 -14804 4 2 0 1 710 775 730 2508 -14805 4 2 0 1 805 694 717 2307 -14806 4 2 0 1 1310 1322 1188 2284 -14807 4 2 0 1 1543 2412 2336 2792 -14808 4 2 0 1 538 609 553 2408 -14809 4 2 0 1 1301 1212 1309 2668 -14810 4 2 0 1 317 339 220 2156 -14811 4 2 0 1 228 518 172 2645 -14812 4 2 0 1 1061 1104 2522 2804 -14813 4 2 0 1 951 2494 864 2495 -14814 4 2 0 1 928 983 895 2162 -14815 4 2 0 1 1306 1377 1219 2512 -14816 4 2 0 1 533 686 656 2390 -14817 4 2 0 1 902 941 882 2495 -14818 4 2 0 1 866 948 913 2233 -14819 4 2 0 1 257 505 280 2692 -14820 4 2 0 1 575 198 668 2456 -14821 4 2 0 1 336 508 393 2635 -14822 4 2 0 1 375 345 227 2468 -14823 4 2 0 1 546 542 665 2725 -14824 4 2 0 1 196 741 257 2692 -14825 4 2 0 1 458 403 2525 2674 -14826 4 2 0 1 1557 2228 2613 2768 -14827 4 2 0 1 1416 1268 1236 2289 -14828 4 2 0 1 192 446 1114 49 -14829 4 2 0 1 1405 820 1294 89 -14830 4 2 0 1 1435 1179 1404 2767 -14831 4 2 0 1 1552 2029 2779 2799 -14832 4 2 0 1 249 2821 449 2826 -14833 4 2 0 1 242 514 525 2560 -14834 4 2 0 1 2029 1709 2519 2799 -14835 4 2 0 1 1461 1415 1395 2720 -14836 4 2 0 1 323 181 341 2559 -14837 4 2 0 1 1040 2406 1091 2543 -14838 4 2 0 1 1257 1289 1430 2812 -14839 4 2 0 1 2336 2412 1543 2757 -14840 4 2 0 1 592 525 61 514 -14841 4 2 0 1 1394 1282 1472 2581 -14842 4 2 0 1 768 762 824 2034 -14843 4 2 0 1 1683 2527 2295 2798 -14844 4 2 0 1 1340 1374 1217 2579 -14845 4 2 0 1 1660 2368 2238 2505 -14846 4 2 0 1 1329 2453 1245 2737 -14847 4 2 0 1 1746 2458 2064 2719 -14848 4 2 0 1 2319 2483 1875 2689 -14849 4 2 0 1 1307 1498 1473 2241 -14850 4 2 0 1 1655 2727 1982 2819 -14851 4 2 0 1 1316 1301 1186 2740 -14852 4 2 0 1 186 273 251 2803 -14853 4 2 0 1 432 1913 391 2713 -14854 4 2 0 1 1753 2373 2110 2829 -14855 4 2 0 1 295 484 298 2446 -14856 4 2 0 1 213 222 320 2020 -14857 4 2 0 1 1553 2206 2496 2782 -14858 4 2 0 1 455 371 397 2791 -14859 4 2 0 1 731 723 699 2135 -14860 4 2 0 1 145 144 827 2638 -14861 4 2 0 1 903 910 244 2494 -14862 4 2 0 1 1522 1515 1492 2264 -14863 4 2 0 1 1057 161 160 1929 -14864 4 2 0 1 174 275 577 2830 -14865 4 2 0 1 1239 1353 1389 2322 -14866 4 2 0 1 1020 1123 1092 2491 -14867 4 2 0 1 205 366 340 2323 -14868 4 2 0 1 1041 1097 1110 2346 -14869 4 2 0 1 450 197 278 2576 -14870 4 2 0 1 881 861 984 2589 -14871 4 2 0 1 196 734 741 2692 -14872 4 2 0 1 1258 1457 1393 2326 -14873 4 2 0 1 1367 1452 1436 2462 -14874 4 2 0 1 237 365 318 2409 -14875 4 2 0 1 467 191 468 2144 -14876 4 2 0 1 1403 1245 1178 2737 -14877 4 2 0 1 263 13 501 740 -14878 4 2 0 1 966 922 873 2542 -14879 4 2 0 1 1122 1175 1124 2138 -14880 4 2 0 1 159 891 158 2049 -14881 4 2 0 1 513 494 2355 2824 -14882 4 2 0 1 1004 969 961 2588 -14883 4 2 0 1 1489 1352 1186 2094 -14884 4 2 0 1 584 610 541 2530 -14885 4 2 0 1 1450 1190 1467 2631 -14886 4 2 0 1 586 619 539 2046 -14887 4 2 0 1 1139 1202 122 1079 -14888 4 2 0 1 1082 1160 1163 2384 -14889 4 2 0 1 296 289 523 2222 -14890 4 2 0 1 136 1170 1141 2777 -14891 4 2 0 1 1636 2326 2247 2825 -14892 4 2 0 1 1242 1455 1384 2387 -14893 4 2 0 1 813 777 855 2316 -14894 4 2 0 1 1373 1332 1392 2441 -14895 4 2 0 1 612 560 617 2236 -14896 4 2 0 1 313 307 292 2353 -14897 4 2 0 1 228 380 2645 2815 -14898 4 2 0 1 993 985 979 2462 -14899 4 2 0 1 713 702 768 2529 -14900 4 2 0 1 1509 2435 1487 2686 -14901 4 2 0 1 813 795 850 2267 -14902 4 2 0 1 1461 2499 1415 2720 -14903 4 2 0 1 296 2222 523 2624 -14904 4 2 0 1 592 62 510 514 -14905 4 2 0 1 1716 1952 2821 2826 -14906 4 2 0 1 1169 1019 1143 2119 -14907 4 2 0 1 958 918 1006 2576 -14908 4 2 0 1 1445 1457 2326 2751 -14909 4 2 0 1 177 229 379 2791 -14910 4 2 0 1 1667 2428 2125 2778 -14911 4 2 0 1 203 385 390 2407 -14912 4 2 0 1 641 543 597 2256 -14913 4 2 0 1 826 830 722 2732 -14914 4 2 0 1 1125 1039 1032 2255 -14915 4 2 0 1 1048 1017 1144 2458 -14916 4 2 0 1 1307 1473 1510 2241 -14917 4 2 0 1 1562 2380 2286 2745 -14918 4 2 0 1 1664 2035 2259 2734 -14919 4 2 0 1 1575 2039 2509 2646 -14920 4 2 0 1 666 549 543 2569 -14921 4 2 0 1 1413 1229 1420 2667 -14922 4 2 0 1 1079 1168 1075 2582 -14923 4 2 0 1 1363 1235 1364 2342 -14924 4 2 0 1 895 859 977 2695 -14925 4 2 0 1 1359 1326 1375 2467 -14926 4 2 0 1 606 664 653 2212 -14927 4 2 0 1 1441 1251 1383 2835 -14928 4 2 0 1 343 176 334 2268 -14929 4 2 0 1 2315 2792 1964 2797 -14930 4 2 0 1 142 788 727 2120 -14931 4 2 0 1 240 251 265 2612 -14932 4 2 0 1 1618 2496 2010 2697 -14933 4 2 0 1 179 367 427 2097 -14934 4 2 0 1 1205 1068 1502 2339 -14935 4 2 0 1 1047 1020 1092 2491 -14936 4 2 0 1 1970 2583 2504 2796 -14937 4 2 0 1 828 769 842 2186 -14938 4 2 0 1 355 225 226 2679 -14939 4 2 0 1 2062 2412 1699 2805 -14940 4 2 0 1 67 470 562 644 -14941 4 2 0 1 1379 1218 1312 2493 -14942 4 2 0 1 1256 1483 1453 2146 -14943 4 2 0 1 651 1200 77 591 -14944 4 2 0 1 241 429 423 2173 -14945 4 2 0 1 1639 2463 2215 2743 -14946 4 2 0 1 1996 2639 1665 2671 -14947 4 2 0 1 1558 2643 2377 2837 -14948 4 2 0 1 376 471 248 2539 -14949 4 2 0 1 836 231 16 837 -14950 4 2 0 1 1068 1049 1025 2339 -14951 4 2 0 1 511 505 463 2567 -14952 4 2 0 1 890 37 434 173 -14953 4 2 0 1 1304 1313 1212 2133 -14954 4 2 0 1 1524 98 719 1505 -14955 4 2 0 1 471 245 453 2445 -14956 4 2 0 1 384 331 310 2647 -14957 4 2 0 1 1114 192 49 1118 -14958 4 2 0 1 1272 1204 1279 2299 -14959 4 2 0 1 641 547 543 2256 -14960 4 2 0 1 249 367 179 2821 -14961 4 2 0 1 546 620 683 2367 -14962 4 2 0 1 1777 2707 2295 2813 -14963 4 2 0 1 1370 1323 1311 2484 -14964 4 2 0 1 1716 2821 2641 2826 -14965 4 2 0 1 752 798 799 2677 -14966 4 2 0 1 448 2086 250 2821 -14967 4 2 0 1 2075 2578 1543 2660 -14968 4 2 0 1 716 1408 1294 88 -14969 4 2 0 1 539 601 603 2761 -14970 4 2 0 1 1012 978 954 2327 -14971 4 2 0 1 1201 1450 790 2171 -14972 4 2 0 1 2124 2450 1655 2727 -14973 4 2 0 1 1054 1066 1157 2278 -14974 4 2 0 1 287 1007 920 479 -14975 4 2 0 1 2119 2570 1575 2817 -14976 4 2 0 1 606 632 559 2283 -14977 4 2 0 1 688 596 661 2246 -14978 4 2 0 1 1377 1325 1219 2325 -14979 4 2 0 1 1746 2719 2064 2814 -14980 4 2 0 1 237 520 444 2409 -14981 4 2 0 1 858 961 925 2588 -14982 4 2 0 1 1655 2533 2124 2819 -14983 4 2 0 1 617 556 607 2236 -14984 4 2 0 1 380 300 2776 2815 -14985 4 2 0 1 228 172 2457 2645 -14986 4 2 0 1 712 786 732 2403 -14987 4 2 0 1 1435 1365 1179 2275 -14988 4 2 0 1 587 546 591 2053 -14989 4 2 0 1 1023 1067 1066 2696 -14990 4 2 0 1 1024 1062 1111 2488 -14991 4 2 0 1 1056 133 134 1960 -14992 4 2 0 1 701 771 745 2436 -14993 4 2 0 1 1197 1422 1261 2551 -14994 4 2 0 1 2174 2598 1555 2787 -14995 4 2 0 1 257 196 24 741 -14996 4 2 0 1 417 396 390 2657 -14997 4 2 0 1 230 511 463 2567 -14998 4 2 0 1 378 374 359 2683 -14999 4 2 0 1 1459 1211 104 886 -15000 4 2 0 1 626 684 650 2359 -15001 4 2 0 1 348 439 402 2819 -15002 4 2 0 1 1174 1128 1095 2274 -15003 4 2 0 1 1105 1100 2543 2709 -15004 4 2 0 1 1381 1506 995 166 -15005 4 2 0 1 947 969 1004 2280 -15006 4 2 0 1 1005 944 883 2287 -15007 4 2 0 1 557 59 642 189 -15008 4 2 0 1 430 355 226 2679 -15009 4 2 0 1 903 244 40 996 -15010 4 2 0 1 497 431 515 2359 -15011 4 2 0 1 2064 2709 2543 2814 -15012 4 2 0 1 308 352 309 2269 -15013 4 2 0 1 1443 1509 1487 2686 -15014 4 2 0 1 59 185 642 189 -15015 4 2 0 1 473 392 424 2516 -15016 4 2 0 1 513 2157 288 2824 -15017 4 2 0 1 200 291 301 2741 -15018 4 2 0 1 138 1117 137 2179 -15019 4 2 0 1 348 2397 236 2819 -15020 4 2 0 1 1095 1128 1140 2274 -15021 4 2 0 1 5 268 670 131 -15022 4 2 0 1 868 943 928 2591 -15023 4 2 0 1 994 875 920 2803 -15024 4 2 0 1 1670 2554 2173 2752 -15025 4 2 0 1 821 720 464 22 -15026 4 2 0 1 1554 2592 2152 2644 -15027 4 2 0 1 440 439 190 2533 -15028 4 2 0 1 1708 2223 2178 2730 -15029 4 2 0 1 250 448 483 2086 -15030 4 2 0 1 237 364 180 2826 -15031 4 2 0 1 597 662 674 2672 -15032 4 2 0 1 400 2196 440 2533 -15033 4 2 0 1 1014 884 984 2589 -15034 4 2 0 1 2277 2457 172 2645 -15035 4 2 0 1 529 656 560 2169 -15036 4 2 0 1 276 30 970 1007 -15037 4 2 0 1 2165 2644 1781 2742 -15038 4 2 0 1 1494 1524 1203 2722 -15039 4 2 0 1 582 480 562 68 -15040 4 2 0 1 648 625 133 2350 -15041 4 2 0 1 1849 2628 2338 2692 -15042 4 2 0 1 1556 2664 2078 2765 -15043 4 2 0 1 262 284 511 2685 -15044 4 2 0 1 283 1167 45 1130 -15045 4 2 0 1 1286 1522 1513 2419 -15046 4 2 0 1 635 647 567 2786 -15047 4 2 0 1 1011 874 948 2553 -15048 4 2 0 1 18 468 789 831 -15049 4 2 0 1 1399 1426 1228 2770 -15050 4 2 0 1 1233 1443 1368 2507 -15051 4 2 0 1 233 435 404 2405 -15052 4 2 0 1 134 135 1152 2410 -15053 4 2 0 1 551 589 595 2469 -15054 4 2 0 1 691 692 804 2288 -15055 4 2 0 1 206 303 304 2614 -15056 4 2 0 1 159 160 956 2561 -15057 4 2 0 1 1608 2701 2118 2829 -15058 4 2 0 1 1422 1254 1261 2551 -15059 4 2 0 1 351 475 258 2333 -15060 4 2 0 1 2639 2647 1859 2671 -15061 4 2 0 1 2048 2466 1703 2758 -15062 4 2 0 1 1540 2756 2059 2827 -15063 4 2 0 1 1697 2657 2157 2824 -15064 4 2 0 1 890 938 912 2101 -15065 4 2 0 1 2285 2470 1636 2703 -15066 4 2 0 1 1235 1184 1364 2342 -15067 4 2 0 1 1200 1289 651 77 -15068 4 2 0 1 266 1132 52 517 -15069 4 2 0 1 288 513 289 2157 -15070 4 2 0 1 2215 1639 2743 2782 -15071 4 2 0 1 820 716 1294 89 -15072 4 2 0 1 1614 2764 2709 2814 -15073 4 2 0 1 955 108 979 1436 -15074 4 2 0 1 972 986 271 2576 -15075 4 2 0 1 84 1490 580 576 -15076 4 2 0 1 814 764 733 2045 -15077 4 2 0 1 712 732 776 2403 -15078 4 2 0 1 985 967 923 2057 -15079 4 2 0 1 1427 1406 1456 2358 -15080 4 2 0 1 322 182 314 2211 -15081 4 2 0 1 1472 1180 1497 2229 -15082 4 2 0 1 328 318 365 2669 -15083 4 2 0 1 1378 1240 1435 2767 -15084 4 2 0 1 2525 2674 1649 2744 -15085 4 2 0 1 2397 2727 2124 2819 -15086 4 2 0 1 714 770 782 2161 -15087 4 2 0 1 1457 1380 1393 2381 -15088 4 2 0 1 1104 1148 2522 2733 -15089 4 2 0 1 1345 1216 1330 2655 -15090 4 2 0 1 1296 1304 1462 2302 -15091 4 2 0 1 873 877 1012 2155 -15092 4 2 0 1 192 50 1118 286 -15093 4 2 0 1 1105 1151 1057 2709 -15094 4 2 0 1 947 875 969 2280 -15095 4 2 0 1 650 684 666 2359 -15096 4 2 0 1 1317 1213 1338 2788 -15097 4 2 0 1 2245 2550 1633 2739 -15098 4 2 0 1 263 14 715 2714 -15099 4 2 0 1 1456 1488 1495 2087 -15100 4 2 0 1 1370 1223 1310 2475 -15101 4 2 0 1 108 955 1390 1436 -15102 4 2 0 1 1105 2416 1151 2709 -15103 4 2 0 1 13 263 715 740 -15104 4 2 0 1 2017 2776 1778 2815 -15105 4 2 0 1 1114 1166 1172 2349 -15106 4 2 0 1 920 479 32 273 -15107 4 2 0 1 548 639 665 2725 -15108 4 2 0 1 956 896 902 2561 -15109 4 2 0 1 1741 2800 2479 2839 -15110 4 2 0 1 2592 2644 1554 2742 -15111 4 2 0 1 1200 76 680 1207 -15112 4 2 0 1 1657 2590 2080 2838 -15113 4 2 0 1 400 405 440 2196 -15114 4 2 0 1 731 779 728 2055 -15115 4 2 0 1 971 1008 105 2775 -15116 4 2 0 1 614 550 590 2400 -15117 4 2 0 1 1213 1413 1338 2667 -15118 4 2 0 1 273 186 285 2327 -15119 4 2 0 1 503 522 905 2477 -15120 4 2 0 1 1025 1049 1112 2339 -15121 4 2 0 1 972 918 986 2576 -15122 4 2 0 1 420 462 222 2438 -15123 4 2 0 1 1397 1228 1365 2770 -15124 4 2 0 1 1249 1456 1495 2666 -15125 4 2 0 1 1050 260 266 53 -15126 4 2 0 1 999 1013 968 2165 -15127 4 2 0 1 1746 2064 2543 2814 -15128 4 2 0 1 772 700 744 2041 -15129 4 2 0 1 1738 2423 2176 2836 -15130 4 2 0 1 739 1524 719 2722 -15131 4 2 0 1 151 152 2109 2523 -15132 4 2 0 1 1434 1384 1243 2763 -15133 4 2 0 1 1519 1256 1516 2278 -15134 4 2 0 1 1490 1198 84 580 -15135 4 2 0 1 920 479 273 2803 -15136 4 2 0 1 1315 1221 1376 2531 -15137 4 2 0 1 669 1513 1522 2419 -15138 4 2 0 1 1287 1196 1292 2178 -15139 4 2 0 1 738 716 1408 2666 -15140 4 2 0 1 1008 1464 105 2775 -15141 4 2 0 1 302 498 494 2262 -15142 4 2 0 1 1157 1381 166 2278 -15143 4 2 0 1 790 756 754 2171 -15144 4 2 0 1 24 196 734 741 -15145 4 2 0 1 1149 2594 1161 2769 -15146 4 2 0 1 813 753 795 2267 -15147 4 2 0 1 193 522 524 2477 -15148 4 2 0 1 27 522 909 905 -15149 4 2 0 1 1629 2502 2332 2772 -15150 4 2 0 1 1427 1470 1241 2485 -15151 4 2 0 1 1781 2644 2592 2742 -15152 4 2 0 1 669 139 566 2419 -15153 4 2 0 1 470 67 426 644 -15154 4 2 0 1 262 466 264 2685 -15155 4 2 0 1 1705 2226 2627 2760 -15156 4 2 0 1 613 618 559 2536 -15157 4 2 0 1 596 673 661 2246 -15158 4 2 0 1 1678 2703 2381 2704 -15159 4 2 0 1 645 589 583 2132 -15160 4 2 0 1 993 919 874 2462 -15161 4 2 0 1 611 561 583 2294 -15162 4 2 0 1 285 278 34 954 -15163 4 2 0 1 1735 2435 2500 2686 -15164 4 2 0 1 565 147 148 2131 -15165 4 2 0 1 725 825 761 2451 -15166 4 2 0 1 5 268 174 670 -15167 4 2 0 1 449 249 250 2821 -15168 4 2 0 1 66 426 644 658 -15169 4 2 0 1 815 803 829 2684 -15170 4 2 0 1 1274 1182 1277 2303 -15171 4 2 0 1 281 195 793 2498 -15172 4 2 0 1 1407 1277 1248 2442 -15173 4 2 0 1 1079 1075 1034 2582 -15174 4 2 0 1 1670 2147 2604 2735 -15175 4 2 0 1 474 486 253 2694 -15176 4 2 0 1 1128 1174 1021 2274 -15177 4 2 0 1 298 209 447 2446 -15178 4 2 0 1 1048 1105 1100 2543 -15179 4 2 0 1 888 931 857 2129 -15180 4 2 0 1 1196 1266 1292 2178 -15181 4 2 0 1 281 191 793 19 -15182 4 2 0 1 408 469 2662 2824 -15183 4 2 0 1 1292 2178 1266 2563 -15184 4 2 0 1 1699 2621 2130 2805 -15185 4 2 0 1 1565 2729 2234 2801 -15186 4 2 0 1 756 750 806 2631 -15187 4 2 0 1 380 2776 2017 2815 -15188 4 2 0 1 1996 2647 2639 2671 -15189 4 2 0 1 435 44 1045 2405 -15190 4 2 0 1 566 535 578 2419 -15191 4 2 0 1 252 223 192 2349 -15192 4 2 0 1 855 777 703 2316 -15193 4 2 0 1 231 836 16 465 -15194 4 2 0 1 180 249 449 2826 -15195 4 2 0 1 1111 1042 1098 2488 -15196 4 2 0 1 623 554 610 2530 -15197 4 2 0 1 1463 1181 1287 2785 -15198 4 2 0 1 2252 2651 1671 2831 -15199 4 2 0 1 655 600 637 2663 -15200 4 2 0 1 1104 1148 1058 2522 -15201 4 2 0 1 999 968 899 2165 -15202 4 2 0 1 295 298 447 2446 -15203 4 2 0 1 287 1007 479 31 -15204 4 2 0 1 1152 1141 1094 2410 -15205 4 2 0 1 187 2106 459 2714 -15206 4 2 0 1 2078 2664 1678 2765 -15207 4 2 0 1 143 142 727 2120 -15208 4 2 0 1 169 490 304 2691 -15209 4 2 0 1 487 422 269 2277 -15210 4 2 0 1 659 80 631 1252 -15211 4 2 0 1 759 798 817 2677 -15212 4 2 0 1 1338 1413 1420 2667 -15213 4 2 0 1 450 225 271 2576 -15214 4 2 0 1 1686 2622 2336 2792 -15215 4 2 0 1 2126 2548 1883 2828 -15216 4 2 0 1 504 424 512 2225 -15217 4 2 0 1 1361 1418 1219 2711 -15218 4 2 0 1 653 664 144 2212 -15219 4 2 0 1 439 236 190 2819 -15220 4 2 0 1 733 823 808 2253 -15221 4 2 0 1 1304 1317 1313 2788 -15222 4 2 0 1 1854 2598 2174 2787 -15223 4 2 0 1 616 555 677 2281 -15224 4 2 0 1 1274 1493 1182 2303 -15225 4 2 0 1 657 627 651 2812 -15226 4 2 0 1 1201 1276 1450 2171 -15227 4 2 0 1 1061 1043 1104 2804 -15228 4 2 0 1 261 480 470 2658 -15229 4 2 0 1 1562 2286 2595 2745 -15230 4 2 0 1 446 252 192 2349 -15231 4 2 0 1 793 195 834 2498 -15232 4 2 0 1 290 368 199 2448 -15233 4 2 0 1 1233 1368 1355 2507 -15234 4 2 0 1 388 391 418 2713 -15235 4 2 0 1 604 554 613 2536 -15236 4 2 0 1 909 862 905 2477 -15237 4 2 0 1 217 405 400 2196 -15238 4 2 0 1 912 942 918 2514 -15239 4 2 0 1 1509 1288 1283 2435 -15240 4 2 0 1 151 897 152 2523 -15241 4 2 0 1 775 765 718 2555 -15242 4 2 0 1 399 428 406 2472 -15243 4 2 0 1 861 968 1014 2589 -15244 4 2 0 1 95 794 835 1264 -15245 4 2 0 1 1450 832 93 790 -15246 4 2 0 1 629 146 147 2497 -15247 4 2 0 1 1302 1313 1315 2531 -15248 4 2 0 1 1459 1465 1481 2775 -15249 4 2 0 1 1707 2619 2474 2833 -15250 4 2 0 1 934 887 946 2259 -15251 4 2 0 1 824 725 810 2451 -15252 4 2 0 1 11 846 269 736 -15253 4 2 0 1 670 174 577 2830 -15254 4 2 0 1 384 183 350 2639 -15255 4 2 0 1 1928 2651 2252 2820 -15256 4 2 0 1 1499 1428 1311 2484 -15257 4 2 0 1 738 1408 1495 2666 -15258 4 2 0 1 1424 631 1252 2469 -15259 4 2 0 1 963 977 927 2421 -15260 4 2 0 1 911 943 868 2591 -15261 4 2 0 1 1210 95 835 1264 -15262 4 2 0 1 532 604 559 2536 -15263 4 2 0 1 1249 1294 2485 2666 -15264 4 2 0 1 272 1138 446 48 -15265 4 2 0 1 2124 2727 1655 2819 -15266 4 2 0 1 14 263 459 2714 -15267 4 2 0 1 1046 1250 1273 2696 -15268 4 2 0 1 319 375 211 2571 -15269 4 2 0 1 436 454 245 2445 -15270 4 2 0 1 1317 1304 1213 2788 -15271 4 2 0 1 375 227 407 2468 -15272 4 2 0 1 1196 1254 1268 2730 -15273 4 2 0 1 461 240 265 2612 -15274 4 2 0 1 332 201 292 2298 -15275 4 2 0 1 2381 2493 1678 2704 -15276 4 2 0 1 1054 166 165 2278 -15277 4 2 0 1 1263 1505 1524 2722 -15278 4 2 0 1 1040 1027 1091 2406 -15279 4 2 0 1 1284 1269 1526 2822 -15280 4 2 0 1 738 1408 716 88 -15281 4 2 0 1 120 1168 1394 1262 -15282 4 2 0 1 838 832 1265 2631 -15283 4 2 0 1 561 624 537 2294 -15284 4 2 0 1 1007 920 479 31 -15285 4 2 0 1 241 423 455 2554 -15286 4 2 0 1 1286 669 578 2419 -15287 4 2 0 1 991 945 935 2461 -15288 4 2 0 1 2554 2752 1670 2791 -15289 4 2 0 1 660 616 632 2283 -15290 4 2 0 1 889 865 908 2715 -15291 4 2 0 1 202 300 383 2776 -15292 4 2 0 1 277 821 464 22 -15293 4 2 0 1 486 481 189 2330 -15294 4 2 0 1 2130 2621 1577 2805 -15295 4 2 0 1 1076 1080 1035 2713 -15296 4 2 0 1 15 459 465 819 -15297 4 2 0 1 228 172 259 2457 -15298 4 2 0 1 305 490 169 2691 -15299 4 2 0 1 258 409 208 2574 -15300 4 2 0 1 237 412 364 2641 -15301 4 2 0 1 1168 1262 1131 2581 -15302 4 2 0 1 581 577 57 275 -15303 4 2 0 1 1188 1322 1303 2284 -15304 4 2 0 1 1030 1171 1084 2603 -15305 4 2 0 1 510 515 63 650 -15306 4 2 0 1 1403 1401 1247 2201 -15307 4 2 0 1 435 476 1045 43 -15308 4 2 0 1 827 144 841 2638 -15309 4 2 0 1 1436 1452 1291 2462 -15310 4 2 0 1 217 2196 400 2661 -15311 4 2 0 1 1370 1299 1215 2475 -15312 4 2 0 1 804 800 753 2288 -15313 4 2 0 1 172 518 422 2277 -15314 4 2 0 1 448 249 179 2821 -15315 4 2 0 1 1120 1020 1047 2491 -15316 4 2 0 1 266 504 489 2626 -15317 4 2 0 1 191 789 793 19 -15318 4 2 0 1 1284 1260 1512 2822 -15319 4 2 0 1 198 140 487 3 -15320 4 2 0 1 293 498 302 2262 -15321 4 2 0 1 32 920 273 978 -15322 4 2 0 1 313 212 307 2353 -15323 4 2 0 1 1326 1215 1375 2467 -15324 4 2 0 1 912 869 942 2514 -15325 4 2 0 1 255 437 492 2297 -15326 4 2 0 1 1301 1316 1334 2420 -15327 4 2 0 1 1310 1299 1370 2475 -15328 4 2 0 1 1350 1470 1405 2379 -15329 4 2 0 1 283 1167 1130 432 -15330 4 2 0 1 1025 2339 1112 2804 -15331 4 2 0 1 332 292 291 2298 -15332 4 2 0 1 1396 1230 1385 2721 -15333 4 2 0 1 1382 114 904 908 -15334 4 2 0 1 1523 1515 1283 2264 -15335 4 2 0 1 726 152 842 2109 -15336 4 2 0 1 1274 1206 1281 2586 -15337 4 2 0 1 368 344 199 2448 -15338 4 2 0 1 1403 1178 1401 2201 -15339 4 2 0 1 1386 1361 1191 2711 -15340 4 2 0 1 261 254 441 2456 -15341 4 2 0 1 273 978 920 2803 -15342 4 2 0 1 459 187 465 2106 -15343 4 2 0 1 934 988 960 2734 -15344 4 2 0 1 932 869 882 2251 -15345 4 2 0 1 739 1524 98 719 -15346 4 2 0 1 726 151 152 2109 -15347 4 2 0 1 2651 2820 1818 2831 -15348 4 2 0 1 289 296 200 2222 -15349 4 2 0 1 656 529 646 2169 -15350 4 2 0 1 958 278 34 197 -15351 4 2 0 1 754 796 851 2596 -15352 4 2 0 1 1651 2664 2493 2704 -15353 4 2 0 1 630 658 590 2610 -15354 4 2 0 1 1168 1208 121 1394 -15355 4 2 0 1 630 590 678 2610 -15356 4 2 0 1 475 351 188 2333 -15357 4 2 0 1 1454 1246 1444 2205 -15358 4 2 0 1 1162 1018 1085 2191 -15359 4 2 0 1 215 411 360 2366 -15360 4 2 0 1 184 492 437 2297 -15361 4 2 0 1 260 506 438 2422 -15362 4 2 0 1 823 689 808 2253 -15363 4 2 0 1 1486 1270 1189 2640 -15364 4 2 0 1 976 953 151 2523 -15365 4 2 0 1 575 441 198 2456 -15366 4 2 0 1 958 197 986 2576 -15367 4 2 0 1 2466 2758 2048 2836 -15368 4 2 0 1 525 679 185 2560 -15369 4 2 0 1 320 168 333 2399 -15370 4 2 0 1 664 143 144 2212 -15371 4 2 0 1 253 275 174 2830 -15372 4 2 0 1 268 496 174 2830 -15373 4 2 0 1 322 484 182 2211 -15374 4 2 0 1 872 921 965 2279 -15375 4 2 0 1 1062 1024 1051 2503 -15376 4 2 0 1 2395 2554 1670 2791 -15377 4 2 0 1 142 2120 143 2687 -15378 4 2 0 1 345 363 358 2489 -15379 4 2 0 1 1503 1275 1183 2557 -15380 4 2 0 1 730 788 722 2732 -15381 4 2 0 1 705 707 807 2501 -15382 4 2 0 1 827 841 770 2638 -15383 4 2 0 1 249 448 250 2821 -15384 4 2 0 1 1151 1095 1140 2416 -15385 4 2 0 1 1061 1058 1117 2522 -15386 4 2 0 1 732 698 721 2628 -15387 4 2 0 1 1132 1050 266 52 -15388 4 2 0 1 918 958 986 2576 -15389 4 2 0 1 959 109 955 1390 -15390 4 2 0 1 180 364 249 2826 -15391 4 2 0 1 1450 1265 832 2631 -15392 4 2 0 1 895 977 963 2421 -15393 4 2 0 1 1521 1520 1507 2184 -15394 4 2 0 1 1343 1329 1245 2737 -15395 4 2 0 1 1134 1124 1090 2518 -15396 4 2 0 1 859 922 977 2695 -15397 4 2 0 1 1331 1469 1186 2740 -15398 4 2 0 1 1160 1162 1163 2384 -15399 4 2 0 1 14 819 715 2714 -15400 4 2 0 1 1149 1084 1161 2594 -15401 4 2 0 1 398 366 205 2323 -15402 4 2 0 1 198 668 140 3 -15403 4 2 0 1 42 488 1069 1065 -15404 4 2 0 1 1504 1487 1522 2419 -15405 4 2 0 1 435 432 1130 2405 -15406 4 2 0 1 1445 1433 1457 2751 -15407 4 2 0 1 1982 2727 2397 2819 -15408 4 2 0 1 409 295 208 2574 -15409 4 2 0 1 185 525 60 679 -15410 4 2 0 1 1298 1339 1187 2383 -15411 4 2 0 1 1405 820 90 839 -15412 4 2 0 1 385 203 312 2407 -15413 4 2 0 1 99 739 735 1203 -15414 4 2 0 1 1258 1445 1457 2326 -15415 4 2 0 1 460 2610 416 2661 -15416 4 2 0 1 905 862 892 2477 -15417 4 2 0 1 1329 1351 1245 2453 -15418 4 2 0 1 476 1069 1045 43 -15419 4 2 0 1 961 969 925 2588 -15420 4 2 0 1 262 264 284 2685 -15421 4 2 0 1 1300 1358 1220 2301 -15422 4 2 0 1 1461 1465 1415 2499 -15423 4 2 0 1 1468 1487 1518 2686 -15424 4 2 0 1 561 83 1423 580 -15425 4 2 0 1 434 244 910 2494 -15426 4 2 0 1 1033 1166 1038 2564 -15427 4 2 0 1 956 160 896 2561 -15428 4 2 0 1 113 1224 889 1382 -15429 4 2 0 1 602 636 598 2587 -15430 4 2 0 1 1486 1519 1273 2696 -15431 4 2 0 1 903 864 910 2494 -15432 4 2 0 1 1273 1250 1270 2696 -15433 4 2 0 1 1350 1405 90 839 -15434 4 2 0 1 1058 1170 137 2777 -15435 4 2 0 1 1200 76 591 680 -15436 4 2 0 1 1193 1239 1389 2322 -15437 4 2 0 1 1406 1234 1392 2358 -15438 4 2 0 1 1272 1279 1458 2299 -15439 4 2 0 1 515 626 63 650 -15440 4 2 0 1 1251 1441 1244 2615 -15441 4 2 0 1 1423 83 1198 580 -15442 4 2 0 1 784 730 696 2508 -15443 4 2 0 1 358 363 178 2489 -15444 4 2 0 1 791 732 721 2628 -15445 4 2 0 1 458 370 331 2744 -15446 4 2 0 1 306 311 324 2190 -15447 4 2 0 1 630 493 658 2610 -15448 4 2 0 1 376 245 471 2539 -15449 4 2 0 1 277 834 821 21 -15450 4 2 0 1 1249 1495 1408 2666 -15451 4 2 0 1 376 384 350 2639 -15452 4 2 0 1 1208 1282 1394 2582 -15453 4 2 0 1 560 556 617 2236 -15454 4 2 0 1 380 314 300 2815 -15455 4 2 0 1 14 459 819 2714 -15456 4 2 0 1 1152 135 1141 2410 -15457 4 2 0 1 1515 1522 1283 2264 -15458 4 2 0 1 1105 1095 1151 2416 -15459 4 2 0 1 627 631 1424 2812 -15460 4 2 0 1 1343 1403 1346 2737 -15461 4 2 0 1 429 243 528 2606 -15462 4 2 0 1 1037 1033 1163 2565 -15463 4 2 0 1 846 487 11 269 -15464 4 2 0 1 973 1224 889 112 -15465 4 2 0 1 458 175 403 2674 -15466 4 2 0 1 1453 1300 1220 2301 -15467 4 2 0 1 684 545 549 2569 -15468 4 2 0 1 1130 1045 44 2405 -15469 4 2 0 1 555 540 677 2281 -15470 4 2 0 1 191 18 468 789 -15471 4 2 0 1 1183 1275 1246 2557 -15472 4 2 0 1 1293 1278 1287 2785 -15473 4 2 0 1 1424 631 2469 2812 -15474 4 2 0 1 237 444 365 2409 -15475 4 2 0 1 1116 1062 1051 2503 -15476 4 2 0 1 1059 1041 1110 2346 -15477 4 2 0 1 283 432 391 2713 -15478 4 2 0 1 749 850 793 2498 -15479 4 2 0 1 822 97 1290 719 -15480 4 2 0 1 749 793 834 2498 -15481 4 2 0 1 309 201 308 2795 -15482 4 2 0 1 1172 1033 1037 2565 -15483 4 2 0 1 458 248 175 2674 -15484 4 2 0 1 1061 1025 1112 2804 -15485 4 2 0 1 236 348 322 2397 -15486 4 2 0 1 820 746 839 2379 -15487 4 2 0 1 1027 1096 1074 2642 -15488 4 2 0 1 285 33 978 954 -15489 4 2 0 1 1274 1500 1206 2586 -15490 4 2 0 1 655 637 593 2663 -15491 4 2 0 1 1417 1469 1483 2620 -15492 4 2 0 1 1382 114 1402 904 -15493 4 2 0 1 718 765 689 2555 -15494 4 2 0 1 999 156 155 2670 -15495 4 2 0 1 900 940 953 2637 -15496 4 2 0 1 1443 1487 1468 2686 -15497 4 2 0 1 346 233 404 2556 -15498 4 2 0 1 872 965 878 2279 -15499 4 2 0 1 1040 1091 1100 2543 -15500 4 2 0 1 1045 1096 1109 2424 -15501 4 2 0 1 1540 2417 2756 2827 -15502 4 2 0 1 1461 1458 1481 2499 -15503 4 2 0 1 739 99 1524 1203 -15504 4 2 0 1 1084 1018 1161 2594 -15505 4 2 0 1 1461 1195 1458 2374 -15506 4 2 0 1 778 856 702 2690 -15507 4 2 0 1 328 206 318 2669 -15508 4 2 0 1 1350 1479 1470 2379 -15509 4 2 0 1 470 426 247 2658 -15510 4 2 0 1 705 811 707 2501 -15511 4 2 0 1 1308 1216 1345 2655 -15512 4 2 0 1 1381 1519 1516 2278 -15513 4 2 0 1 1292 1266 1446 2563 -15514 4 2 0 1 1001 1002 1000 2562 -15515 4 2 0 1 1431 645 1429 82 -15516 4 2 0 1 1129 1035 1031 2170 -15517 4 2 0 1 1138 446 48 1114 -15518 4 2 0 1 553 609 622 2408 -15519 4 2 0 1 319 211 305 2571 -15520 4 2 0 1 1105 1113 1100 2709 -15521 4 2 0 1 552 539 603 2761 -15522 4 2 0 1 1289 651 627 2812 -15523 4 2 0 1 1371 1448 1191 2263 -15524 4 2 0 1 1067 1066 1273 117 -15525 4 2 0 1 810 725 761 2451 -15526 4 2 0 1 2 527 495 149 -15527 4 2 0 1 793 281 20 195 -15528 4 2 0 1 563 536 575 2456 -15529 4 2 0 1 845 1488 737 86 -15530 4 2 0 1 575 668 563 2456 -15531 4 2 0 1 143 2212 664 2687 -15532 4 2 0 1 458 219 370 2744 -15533 4 2 0 1 636 634 687 2766 -15534 4 2 0 1 186 278 285 2327 -15535 4 2 0 1 1448 1241 1451 2780 -15536 4 2 0 1 1819 2543 2709 2814 -15537 4 2 0 1 1085 1121 1129 2584 -15538 4 2 0 1 1104 1058 1061 2522 -15539 4 2 0 1 1194 1237 1251 2835 -15540 4 2 0 1 784 710 730 2508 -15541 4 2 0 1 739 719 699 2722 -15542 4 2 0 1 1027 1040 1096 2406 -15543 4 2 0 1 1130 44 435 2405 -15544 4 2 0 1 570 682 146 2497 -15545 4 2 0 1 1568 2820 2252 2831 -15546 4 2 0 1 41 1158 488 1065 -15547 4 2 0 1 575 198 70 668 -15548 4 2 0 1 244 445 362 2494 -15549 4 2 0 1 1459 971 105 2775 -15550 4 2 0 1 395 499 420 2438 -15551 4 2 0 1 244 502 40 996 -15552 4 2 0 1 2252 2820 2651 2831 -15553 4 2 0 1 338 304 303 2605 -15554 4 2 0 1 513 288 396 2824 -15555 4 2 0 1 628 142 568 2687 -15556 4 2 0 1 408 396 469 2824 -15557 4 2 0 1 1446 1266 1180 2563 -15558 4 2 0 1 884 945 888 2461 -15559 4 2 0 1 1459 105 1464 2775 -15560 4 2 0 1 735 699 723 2135 -15561 4 2 0 1 1314 1304 1296 2302 -15562 4 2 0 1 126 1271 1295 1147 -15563 4 2 0 1 480 470 562 68 -15564 4 2 0 1 818 760 705 2585 -15565 4 2 0 1 140 846 487 3 -15566 4 2 0 1 889 911 939 2715 -15567 4 2 0 1 1441 1275 1244 2615 -15568 4 2 0 1 684 549 666 2569 -15569 4 2 0 1 1395 1388 1461 2374 -15570 4 2 0 1 688 548 542 2725 -15571 4 2 0 1 216 455 423 2554 -15572 4 2 0 1 1253 1457 1433 2751 -15573 4 2 0 1 1208 1168 121 1079 -15574 4 2 0 1 396 288 203 2657 -15575 4 2 0 1 474 492 486 2694 -15576 4 2 0 1 906 907 102 1484 -15577 4 2 0 1 327 301 312 2741 -15578 4 2 0 1 1380 1209 1393 2381 -15579 4 2 0 1 386 460 416 2661 -15580 4 2 0 1 1249 1294 1470 2485 -15581 4 2 0 1 839 1350 838 91 -15582 4 2 0 1 715 819 745 2714 -15583 4 2 0 1 487 172 422 2277 -15584 4 2 0 1 1147 1295 125 1119 -15585 4 2 0 1 829 762 856 2684 -15586 4 2 0 1 1686 2792 2412 2797 -15587 4 2 0 1 45 283 1130 432 -15588 4 2 0 1 780 701 745 2436 -15589 4 2 0 1 394 236 322 2397 -15590 4 2 0 1 966 873 879 2542 -15591 4 2 0 1 260 266 489 2626 -15592 4 2 0 1 481 242 185 2560 -15593 4 2 0 1 174 56 577 275 -15594 4 2 0 1 910 903 244 39 -15595 4 2 0 1 1091 1017 1048 2543 -15596 4 2 0 1 1513 1492 6 139 -15597 4 2 0 1 793 20 834 195 -15598 4 2 0 1 610 554 541 2530 -15599 4 2 0 1 1066 1273 117 1508 -15600 4 2 0 1 589 659 631 2469 -15601 4 2 0 1 403 383 219 2525 -15602 4 2 0 1 646 636 602 2587 -15603 4 2 0 1 1129 1121 1164 2584 -15604 4 2 0 1 439 348 236 2819 -15605 4 2 0 1 1258 1393 1387 2825 -15606 4 2 0 1 1046 1131 119 1250 -15607 4 2 0 1 1340 1217 1327 2579 -15608 4 2 0 1 259 172 254 2457 -15609 4 2 0 1 1409 1321 1218 2455 -15610 4 2 0 1 271 986 197 2576 -15611 4 2 0 1 894 156 999 2670 -15612 4 2 0 1 1306 1297 1377 2512 -15613 4 2 0 1 231 468 17 831 -15614 4 2 0 1 1486 1273 1270 2696 -15615 4 2 0 1 151 953 897 2523 -15616 4 2 0 1 900 880 940 2637 -15617 4 2 0 1 1378 1404 1243 2767 -15618 4 2 0 1 73 1447 1398 579 -15619 4 2 0 1 119 1131 1262 1250 -15620 4 2 0 1 1023 1046 1067 2696 -15621 4 2 0 1 2493 2664 1678 2704 -15622 4 2 0 1 951 902 882 2495 -15623 4 2 0 1 337 210 321 2601 -15624 4 2 0 1 1130 1074 1045 2405 -15625 4 2 0 1 630 451 493 2610 -15626 4 2 0 1 626 64 451 515 -15627 4 2 0 1 834 277 195 21 -15628 4 2 0 1 126 1133 1271 1147 -15629 4 2 0 1 361 340 303 2614 -15630 4 2 0 1 832 750 756 2631 -15631 4 2 0 1 1434 1222 1439 2763 -15632 4 2 0 1 1124 1086 1090 2518 -15633 4 2 0 1 17 231 831 837 -15634 4 2 0 1 37 173 972 271 -15635 4 2 0 1 80 1424 631 1252 -15636 4 2 0 1 787 699 719 2722 -15637 4 2 0 1 96 822 1210 835 -15638 4 2 0 1 568 664 618 2687 -15639 4 2 0 1 630 626 64 451 -15640 4 2 0 1 1424 1252 1344 2469 -15641 4 2 0 1 336 187 459 2714 -15642 4 2 0 1 1409 1178 1321 2455 -15643 4 2 0 1 380 300 202 2776 -15644 4 2 0 1 1131 1168 120 1262 -15645 4 2 0 1 1315 1313 1221 2531 -15646 4 2 0 1 401 421 221 2464 -15647 4 2 0 1 1473 1224 973 112 -15648 4 2 0 1 1144 1134 1093 2458 -15649 4 2 0 1 1157 166 1054 2278 -15650 4 2 0 1 232 325 402 2328 -15651 4 2 0 1 1350 838 91 1265 -15652 4 2 0 1 670 577 654 2830 -15653 4 2 0 1 1073 1075 1131 2581 -15654 4 2 0 1 1116 1056 1062 2503 -15655 4 2 0 1 581 57 279 275 -15656 4 2 0 1 1493 1205 1502 2339 -15657 4 2 0 1 915 1008 971 2775 -15658 4 2 0 1 778 702 742 2690 -15659 4 2 0 1 659 1429 81 1252 -15660 4 2 0 1 952 865 889 2715 -15661 4 2 0 1 336 347 187 2635 -15662 4 2 0 1 1113 1105 1057 2709 -15663 4 2 0 1 473 214 392 2516 -15664 4 2 0 1 1424 1289 627 2812 -15665 4 2 0 1 1241 1479 1451 2780 -15666 4 2 0 1 1819 2709 2764 2814 -15667 4 2 0 1 479 251 273 2803 -15668 4 2 0 1 397 229 177 2791 -15669 4 2 0 1 1101 1042 1062 2488 -15670 4 2 0 1 281 246 195 2498 -15671 4 2 0 1 460 493 416 2610 -15672 4 2 0 1 374 215 360 2366 -15673 4 2 0 1 1011 870 874 2553 -15674 4 2 0 1 1061 1112 1043 2804 -15675 4 2 0 1 1023 1110 1046 2696 -15676 4 2 0 1 130 1515 1064 1155 -15677 4 2 0 1 844 527 2 149 -15678 4 2 0 1 611 624 561 2294 -15679 4 2 0 1 606 660 632 2283 -15680 4 2 0 1 482 1158 4 158 -15681 4 2 0 1 1076 1107 1074 2642 -15682 4 2 0 1 388 46 283 2713 -15683 4 2 0 1 454 453 245 2445 -15684 4 2 0 1 254 198 441 2456 -15685 4 2 0 1 1024 1063 1051 2422 -15686 4 2 0 1 1858 2787 2729 2801 -15687 4 2 0 1 822 1290 96 1210 -15688 4 2 0 1 37 890 434 38 -15689 4 2 0 1 503 522 27 905 -15690 4 2 0 1 675 672 674 2672 -15691 4 2 0 1 1393 1366 1387 2825 -15692 4 2 0 1 513 408 494 2824 -15693 4 2 0 1 633 687 634 2766 -15694 4 2 0 1 838 750 832 2631 -15695 4 2 0 1 606 653 660 2283 -15696 4 2 0 1 401 478 421 2464 -15697 4 2 0 1 1022 1069 1045 2424 -15698 4 2 0 1 738 697 716 2666 -15699 4 2 0 1 604 613 559 2536 -15700 4 2 0 1 338 303 235 2605 -15701 4 2 0 1 309 317 201 2795 -15702 4 2 0 1 1010 988 981 2734 -15703 4 2 0 1 404 238 342 2556 -15704 4 2 0 1 920 978 994 2803 -15705 4 2 0 1 336 393 347 2635 -15706 4 2 0 1 273 285 33 978 -15707 4 2 0 1 51 1132 286 517 -15708 4 2 0 1 1202 1282 1208 2582 -15709 4 2 0 1 174 56 670 577 -15710 4 2 0 1 744 746 820 2379 -15711 4 2 0 1 1130 435 44 432 -15712 4 2 0 1 73 558 1447 579 -15713 4 2 0 1 476 42 488 1069 -15714 4 2 0 1 1212 1302 1309 2668 -15715 4 2 0 1 1001 1000 1009 2562 -15716 4 2 0 1 1461 1388 1195 2374 -15717 4 2 0 1 1466 124 1115 1478 -15718 4 2 0 1 1207 680 643 75 -15719 4 2 0 1 503 524 522 2477 -15720 4 2 0 1 760 818 758 2585 -15721 4 2 0 1 374 220 359 2683 -15722 4 2 0 1 697 785 716 2666 -15723 4 2 0 1 247 440 190 2533 -15724 4 2 0 1 915 971 913 2775 -15725 4 2 0 1 1329 1303 1351 2453 -15726 4 2 0 1 1249 1470 1427 2485 -15727 4 2 0 1 386 217 460 2661 -15728 4 2 0 1 645 659 1429 81 -15729 4 2 0 1 1132 1146 51 286 -15730 4 2 0 1 493 630 658 65 -15731 4 2 0 1 247 400 440 2533 -15732 4 2 0 1 296 523 294 2624 -15733 4 2 0 1 1408 1294 1249 2666 -15734 4 2 0 1 283 46 1167 2713 -15735 4 2 0 1 196 734 844 25 -15736 4 2 0 1 1394 1472 1262 2581 -15737 4 2 0 1 649 599 635 2786 -15738 4 2 0 1 685 137 136 2777 -15739 4 2 0 1 979 919 993 2462 -15740 4 2 0 1 1501 1525 1514 843 -15741 4 2 0 1 396 203 390 2657 -15742 4 2 0 1 399 406 218 2472 -15743 4 2 0 1 1294 716 88 89 -15744 4 2 0 1 1157 116 1381 1508 -15745 4 2 0 1 1295 125 1119 1466 -15746 4 2 0 1 1395 1415 1376 2720 -15747 4 2 0 1 1201 1450 93 790 -15748 4 2 0 1 434 445 244 2494 -15749 4 2 0 1 361 303 206 2614 -15750 4 2 0 1 2 495 998 149 -15751 4 2 0 1 1181 1293 1287 2785 -15752 4 2 0 1 595 2469 631 2812 -15753 4 2 0 1 241 397 410 2752 -15754 4 2 0 1 1286 1504 1522 2419 -15755 4 2 0 1 669 566 578 2419 -15756 4 2 0 1 296 294 207 2624 -15757 4 2 0 1 14 13 263 715 -15758 4 2 0 1 26 503 905 998 -15759 4 2 0 1 649 635 567 2786 -15760 4 2 0 1 394 314 228 2815 -15761 4 2 0 1 434 910 244 39 -15762 4 2 0 1 493 630 65 451 -15763 4 2 0 1 1498 109 959 1390 -15764 4 2 0 1 395 420 222 2438 -15765 4 2 0 1 721 698 734 2692 -15766 4 2 0 1 935 945 884 2461 -15767 4 2 0 1 1417 1489 1469 2620 -15768 4 2 0 1 174 496 253 2830 -15769 4 2 0 1 1323 1499 1311 2484 -15770 4 2 0 1 642 185 679 2560 -15771 4 2 0 1 1091 1048 1100 2543 -15772 4 2 0 1 1228 1426 1365 2770 -15773 4 2 0 1 1450 1467 1265 2631 -15774 4 2 0 1 1022 1045 1109 2424 -15775 4 2 0 1 726 732 791 2628 -15776 4 2 0 1 438 1156 268 55 -15777 4 2 0 1 185 60 642 679 -15778 4 2 0 1 1301 1331 1186 2740 -15779 4 2 0 1 502 482 4 158 -15780 4 2 0 1 570 146 629 2497 -15781 4 2 0 1 804 692 800 2288 -15782 4 2 0 1 686 533 640 2390 -15783 4 2 0 1 642 588 586 2560 -15784 4 2 0 1 1158 482 41 488 -15785 4 2 0 1 546 683 542 2367 -15786 4 2 0 1 582 69 441 480 -15787 4 2 0 1 627 595 631 2812 -15788 4 2 0 1 1378 1435 1404 2767 -15789 4 2 0 1 257 280 196 2692 -15790 4 2 0 1 441 575 198 70 -15791 4 2 0 1 26 503 27 905 -15792 4 2 0 1 192 50 49 1118 -15793 4 2 0 1 92 832 1450 1265 -15794 4 2 0 1 1139 1202 1478 123 -15795 4 2 0 1 59 557 58 189 -15796 4 2 0 1 1120 1094 1148 2733 -15797 4 2 0 1 1169 1149 1161 2769 -15798 4 2 0 1 247 261 470 2658 -15799 4 2 0 1 1062 1042 1111 2488 -15800 4 2 0 1 1270 1497 1482 2640 -15801 4 2 0 1 1343 1245 1403 2737 -15802 4 2 0 1 577 56 57 275 -15803 4 2 0 1 1080 46 388 2713 -15804 4 2 0 1 1476 1207 643 75 -15805 4 2 0 1 404 342 346 2556 -15806 4 2 0 1 200 301 327 2741 -15807 4 2 0 1 106 1008 1291 1464 -15808 4 2 0 1 502 4 996 158 -15809 4 2 0 1 228 485 518 2645 -15810 4 2 0 1 1045 435 43 44 -15811 4 2 0 1 542 548 665 2725 -15812 4 2 0 1 1406 1427 1234 2358 -15813 4 2 0 1 241 410 243 2752 -15814 4 2 0 1 675 674 662 2672 -15815 4 2 0 1 815 829 856 2684 -15816 4 2 0 1 720 464 22 23 -15817 4 2 0 1 1024 1070 1063 2422 -15818 4 2 0 1 1270 1482 1189 2640 -15819 4 2 0 1 1251 1237 1383 2835 -15820 4 2 0 1 575 582 69 441 -15821 4 2 0 1 1424 1430 1289 2812 -15822 4 2 0 1 788 826 722 2732 -15823 4 2 0 1 95 94 794 1201 -15824 4 2 0 1 627 1424 631 79 -15825 4 2 0 1 429 507 194 2818 -15826 4 2 0 1 98 97 719 1505 -15827 4 2 0 1 1075 1168 1131 2581 -15828 4 2 0 1 493 451 416 2610 -15829 4 2 0 1 1515 130 1492 1155 -15830 4 2 0 1 263 336 459 2714 -15831 4 2 0 1 1157 1381 10 166 -15832 4 2 0 1 752 817 798 2677 -15833 4 2 0 1 861 1014 984 2589 -15834 4 2 0 1 1139 1202 123 122 -15835 4 2 0 1 522 27 909 526 -15836 4 2 0 1 552 608 539 2761 -15837 4 2 0 1 196 844 527 25 -15838 4 2 0 1 94 794 1201 790 -15839 4 2 0 1 124 1119 1466 1115 -15840 4 2 0 1 62 592 61 514 -15841 4 2 0 1 589 631 595 2469 -15842 4 2 0 1 832 92 838 1265 -15843 4 2 0 1 136 137 1170 2777 -15844 4 2 0 1 12 11 269 736 -15845 4 2 0 1 217 400 460 2661 -15846 4 2 0 1 1169 1081 1149 2769 -15847 4 2 0 1 1063 1156 438 55 -15848 4 2 0 1 507 506 194 2818 -15849 4 2 0 1 1415 1320 1376 2720 -15850 4 2 0 1 271 197 450 2576 -15851 4 2 0 1 1017 1134 1144 2458 -15852 4 2 0 1 737 1488 1495 86 -15853 4 2 0 1 951 864 902 2495 -15854 4 2 0 1 1515 129 130 1064 -15855 4 2 0 1 1524 1494 1263 2722 -15856 4 2 0 1 229 397 371 2791 -15857 4 2 0 1 233 432 435 2405 -15858 4 2 0 1 626 64 515 63 -15859 4 2 0 1 1030 1034 1171 2603 -15860 4 2 0 1 1289 1424 627 79 -15861 4 2 0 1 228 314 380 2815 -15862 4 2 0 1 670 654 131 2830 -15863 4 2 0 1 1156 268 5 131 -15864 4 2 0 1 669 1513 71 6 -15865 4 2 0 1 890 434 38 910 -15866 4 2 0 1 266 1050 53 52 -15867 4 2 0 1 1481 1465 1461 2499 -15868 4 2 0 1 83 82 561 1423 -15869 4 2 0 1 1080 1167 46 2713 -15870 4 2 0 1 513 396 408 2824 -15871 4 2 0 1 525 185 242 2560 -15872 4 2 0 1 95 794 1264 1201 -15873 4 2 0 1 62 510 63 650 -15874 4 2 0 1 1286 669 1513 71 -15875 4 2 0 1 1459 1464 1465 2775 -15876 4 2 0 1 1104 1120 1148 2733 -15877 4 2 0 1 889 939 952 2715 -15878 4 2 0 1 1284 1512 1269 2822 -15879 4 2 0 1 1099 1043 1112 2804 -15880 4 2 0 1 698 741 734 2692 -15881 4 2 0 1 1107 1027 1074 2642 -15882 4 2 0 1 16 836 15 465 -15883 4 2 0 1 35 958 34 197 -15884 4 2 0 1 1496 1490 85 576 -15885 4 2 0 1 23 257 24 741 -15886 4 2 0 1 669 1513 6 139 -15887 4 2 0 1 1008 106 105 1464 -15888 4 2 0 1 281 793 20 19 -15889 4 2 0 1 568 142 143 2687 -15890 4 2 0 1 283 391 388 2713 -15891 4 2 0 1 129 1515 1502 1064 -15892 4 2 0 1 364 412 414 2641 -15893 4 2 0 1 738 737 1495 87 -15894 4 2 0 1 1080 1076 1167 2713 -15895 4 2 0 1 1418 1361 1386 2711 -15896 4 2 0 1 45 1130 44 432 -15897 4 2 0 1 27 28 909 526 -15898 4 2 0 1 987 1473 110 1498 -15899 4 2 0 1 468 18 17 831 -15900 4 2 0 1 1398 72 579 578 -15901 4 2 0 1 277 821 22 21 -15902 4 2 0 1 832 92 1450 93 -15903 4 2 0 1 568 143 664 2687 -15904 4 2 0 1 102 906 1484 1485 -15905 4 2 0 1 972 36 271 986 -15906 4 2 0 1 80 659 81 1252 -15907 4 2 0 1 639 595 657 2812 -15908 4 2 0 1 1492 6 139 1155 -15909 4 2 0 1 1295 126 1147 125 -15910 4 2 0 1 15 14 459 819 -15911 4 2 0 1 667 1496 85 576 -15912 4 2 0 1 630 64 65 451 -15913 4 2 0 1 1068 1205 128 1049 -15914 4 2 0 1 388 1080 47 46 -15915 4 2 0 1 101 997 1485 1501 -15916 4 2 0 1 1434 1439 1384 2763 -15917 4 2 0 1 47 1138 272 48 -15918 4 2 0 1 78 1289 651 627 -15919 4 2 0 1 1157 1066 116 1508 -15920 4 2 0 1 104 1211 103 886 -15921 4 2 0 1 503 26 495 998 -15922 4 2 0 1 470 67 562 68 -15923 4 2 0 1 99 739 1524 98 -15924 4 2 0 1 1211 907 103 886 -15925 4 2 0 1 1198 83 84 580 -15926 4 2 0 1 32 273 33 978 -15927 4 2 0 1 446 48 1114 49 -15928 4 2 0 1 118 1046 119 1250 -15929 4 2 0 1 909 28 885 282 -15930 4 2 0 1 907 1211 102 1484 -15931 4 2 0 1 1224 113 889 112 -15932 4 2 0 1 1289 78 651 77 -15933 4 2 0 1 33 285 34 954 -15934 4 2 0 1 920 479 31 32 -15935 4 2 0 1 128 1205 127 1049 -15936 4 2 0 1 191 18 789 19 -15937 4 2 0 1 1200 76 77 591 -15938 4 2 0 1 99 735 1514 1203 -15939 4 2 0 1 42 41 488 1065 -15940 4 2 0 1 28 909 526 282 -15941 4 2 0 1 1488 845 1480 86 -15942 4 2 0 1 426 67 66 644 -15943 4 2 0 1 1168 121 120 1394 -15944 4 2 0 1 669 1286 578 71 -15945 4 2 0 1 738 1495 1408 87 -15946 4 2 0 1 90 1350 839 91 -15947 4 2 0 1 907 1211 103 102 -15948 4 2 0 1 260 53 1070 54 -15949 4 2 0 1 934 981 988 2734 -15950 4 2 0 1 1208 121 122 1079 -15951 4 2 0 1 108 107 979 1436 -15952 4 2 0 1 1473 111 973 987 -15953 4 2 0 1 74 73 558 1447 -15954 4 2 0 1 1459 971 104 105 -15955 4 2 0 1 1115 1139 1478 123 -15956 4 2 0 1 642 679 588 2560 -15957 4 2 0 1 78 1289 627 79 -15958 4 2 0 1 109 108 955 1390 -15959 4 2 0 1 36 37 972 271 -15960 4 2 0 1 57 581 279 58 -15961 4 2 0 1 1408 738 87 88 -15962 4 2 0 1 111 1473 973 112 -15963 4 2 0 1 903 244 39 40 -15964 4 2 0 1 26 2 495 998 -15965 4 2 0 1 1473 111 987 110 -15966 4 2 0 1 129 1502 1068 1064 -15967 4 2 0 1 76 680 1207 75 -15968 4 2 0 1 1398 1286 72 578 -15969 4 2 0 1 110 987 1498 959 -15970 4 2 0 1 196 24 734 25 -15971 4 2 0 1 35 36 986 197 -15972 4 2 0 1 54 1063 438 55 -15973 4 2 0 1 958 35 986 197 -15974 4 2 0 1 885 28 29 282 -15975 4 2 0 1 501 13 12 740 -15976 4 2 0 1 66 493 658 65 -15977 4 2 0 1 74 1476 643 75 -15978 4 2 0 1 85 1490 84 576 -15979 4 2 0 1 30 29 276 970 -15980 4 2 0 1 1286 72 578 71 -15981 4 2 0 1 1492 130 6 1155 -15982 4 2 0 1 118 1067 1273 117 -15983 4 2 0 1 100 1501 1514 843 -15984 4 2 0 1 657 595 627 2812 -15985 4 2 0 1 20 834 195 21 -15986 4 2 0 1 36 271 986 197 -15987 4 2 0 1 116 1157 1381 10 -15988 4 2 0 1 582 69 480 68 -15989 4 2 0 1 287 30 1007 31 -15990 4 2 0 1 737 1495 87 86 -15991 4 2 0 1 1008 106 1291 919 -15992 4 2 0 1 434 38 910 39 -15993 4 2 0 1 1382 113 114 908 -15994 4 2 0 1 73 1398 72 579 -15995 4 2 0 1 198 70 668 3 -15996 4 2 0 1 116 1066 117 1508 -15997 4 2 0 1 1131 120 119 1262 -15998 4 2 0 1 645 1429 82 81 -15999 4 2 0 1 185 60 59 642 -16000 4 2 0 1 1156 268 55 5 -16001 4 2 0 1 997 906 101 1485 -16002 4 2 0 1 1501 9 157 843 -16003 4 2 0 1 101 997 1501 9 -16004 4 2 0 1 1405 820 89 90 -16005 4 2 0 1 99 735 100 1514 -16006 4 2 0 1 487 846 11 3 -16007 4 2 0 1 69 575 441 70 -16008 4 2 0 1 283 1167 46 45 -16009 4 2 0 1 1501 100 9 843 -16010 4 2 0 1 838 92 91 1265 -16011 4 2 0 1 96 1210 95 835 -16012 4 2 0 1 1146 50 51 286 -16013 4 2 0 1 525 60 679 61 -16014 4 2 0 1 56 5 174 670 -16015 4 2 0 1 97 822 1290 96 -16016 4 2 0 1 1424 80 631 79 -16017 4 2 0 1 997 1501 9 157 -16018 4 2 0 1 1205 1502 1068 128 -16019 4 2 0 1 1402 114 115 904 -16020 4 2 0 1 482 1158 41 4 -16021 4 2 0 1 476 42 1069 43 -16022 4 2 0 1 125 124 1119 1466 -16023 4 2 0 1 52 1132 51 517 -16024 4 2 0 1 1506 115 10 995 -16025 4 2 0 1 231 17 16 837 -16026 4 2 0 1 127 126 1133 1271 -16027 4 2 0 1 94 1201 93 790 -16028 4 2 0 1 1402 115 995 904 -16029 4 2 0 1 844 527 25 2 -16030 4 2 0 1 1480 667 8 148 -16031 4 2 0 1 845 1480 86 8 -16032 4 2 0 1 906 102 101 1485 -16033 4 2 0 1 124 1115 1478 123 -16034 4 2 0 1 502 4 40 996 -16035 4 2 0 1 1480 667 85 8 -16036 4 2 0 1 845 1480 8 148 -16037 4 2 0 1 106 107 1291 919 -16038 4 2 0 1 667 1496 1480 85 -16039 4 2 0 1 735 100 1514 843 -16040 4 2 0 1 1506 1402 115 995 -16041 4 2 0 1 1502 129 1068 128 -16042 4 2 0 1 110 1498 109 959 -$EndElements diff --git a/test/mixeddimension/embedded/1p_1p/plot.py b/test/mixeddimension/embedded/1p_1p/plot.py deleted file mode 100644 index 24f3113008a30b143742e7692466abdf3c990c49..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_1p/plot.py +++ /dev/null @@ -1,61 +0,0 @@ -#! /usr/bin/python - -import subprocess -from math import log, floor, fabs -import numpy - -radius = 0.05 -# # maximum allowed refinement is numCells = 2/radius then the average operator has to be implemented -# # only even numbers allowed otherwise log(0) will be evaluated -# levels = [int(i) for i in numpy.linspace(7, 21, 5)] -# levels = [(i+1 if i%2 == 0 else i) for i in levels] - -# #initialize log file -# file = open("log.txt", "w+") -# file.write("#l2-norms\n") -# file.close() - -# for numCells in levels: -# subprocess.call(['./dangelo', '-VesselGrid.Cells', str(numCells), -# '-TissueGrid.Cells', " ".join([str(numCells)]*3), -# '-SpatialParams.Radius', str(radius)]) - -# calculate the rates -hmax3 = [] -hmax1 = [] -p3 = [] -p1 = [] -for line in open("log.txt"): - line = line.strip() - if line.startswith('#'): - continue - list = line.split(' ') - hmax3.append(float(list[0])) - hmax1.append(float(list[1])) - p3.append(float(list[2])) - p1.append(float(list[3])) - -rates3d = [] -rates1d = [] -for i in range(1, len(p1)): - try: - rate1 = (log(p1[i-1]) - log(p1[i]))/(log(hmax1[i-1]) - log(hmax1[i])) - rate3 = (log(p3[i-1]) - log(p3[i]))/(log(hmax3[i-1]) - log(hmax3[i])) - except ValueError: - continue - print('1d: {0:.5f} 3d: {1:.5f}'.format(rate1, rate3)) - rates3d.append(rate3) - rates1d.append(rate1) - - -# plot the results -import matplotlib.pyplot as plt -plt.grid("on") -plt.plot(hmax1, p1, label='|pv-pv^h|L2') -plt.plot(hmax3, p3, label='|pt-pt^h|L2') -plt.plot(hmax1, [h*fabs(log(h)) for h in hmax1], label='h') #label='h*|log h|') -plt.plot(hmax3, [h*fabs(log(h)) for h in hmax3], label='h') #label='h*|log h|') -plt.xscale('log') -plt.yscale('log') -plt.legend() -plt.show() diff --git a/test/mixeddimension/embedded/1p_1p/test_1p_1p.cc b/test/mixeddimension/embedded/1p_1p/test_1p_1p.cc deleted file mode 100644 index 0f377bc9e9e423097b93454de41fc528163a62be..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_1p/test_1p_1p.cc +++ /dev/null @@ -1,45 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief test for the 1d 3d cell-centered coupled model - */ -#include "config.h" -#include "1d3dtestproblem.hh" -#include <dumux/mixeddimension/embedded/start.hh> - -/*! - * \brief Provides an interface for customizing error messages associated with - * reading in parameters. - * - * \param progName The name of the program, that was tried to be started. - * \param errorMsg The error message that was issued by the start function. - * Comprises the thing that went wrong and a general help message. - */ -void usage(const char *progName, const std::string &errorMsg) -{ - // TODO -} - -int main(int argc, char** argv) -{ - using ProblemTypeTag = TTAG(TestOneDThreeDCCProblem); - return Dumux::start<ProblemTypeTag>(argc, argv, usage); -} diff --git a/test/mixeddimension/embedded/1p_1p/test_1p_1p.input b/test/mixeddimension/embedded/1p_1p/test_1p_1p.input deleted file mode 100644 index 97612af7e014414cb208e4c9951ddd25f1e475dd..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_1p/test_1p_1p.input +++ /dev/null @@ -1,52 +0,0 @@ -[MixedDimension] -UseIterativeSolver = false -NumCircleSegments = 100 - -[TimeManager] -DtInitial = 1 # [s] -TEnd = 1 # [s] -MaxTimeStepSize = 1 -DtInitialBulkProblem = 1 # [s] -DtInitialLowDimProblem = 1 # [s] -EpisodeTime = 1 # [s] - -[VesselGrid] -LowerLeft = 0 0 0 -UpperRight = 0 0 1 -Cells = 40 - -[TissueGrid] -#File = ./grids/cylinder.msh -#Refinement = 10 -LowerLeft = -1 -1 0 -UpperRight = 1 1 1 -Cells = 40 40 40 - -[Problem] -Name = test_1p1dstokes -NormIntegrationOrder = 1 -NormExcludeInnerBulk = true -IntegrationOrder = 2 -LiquidKinematicViscosity = 1 # [m^2/s] -LiquidDensity = 1 # [kg/m^3] - -[IterativeAlgorithm] -MaxIterations = 100 -Tolerance = 1.0e-5 -Verbose = 1 -IntegrationOrder = 1 - -[SpatialParams] -PermeabilityTissue = 1 # [m^2] -Radius = 0.33 # [m] - -[Vtk] -AddVelocity = 0 - -[BoundaryConditions1D] -PressureInput = 2.0 -DeltaPressure = 1.0 - -[Newton] -MaxRelativeShift = 1e-5 -MaxSteps = 60 diff --git a/test/mixeddimension/embedded/1p_1p/tissueproblem.hh b/test/mixeddimension/embedded/1p_1p/tissueproblem.hh deleted file mode 100644 index c097a58bc7b02e5ab932039ac05724ff745ccd11..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_1p/tissueproblem.hh +++ /dev/null @@ -1,360 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/** - * \file - * \brief Definition of a problem, for the 1p2c problem: - * Component transport of oxygen in interstitial fluid. - */ -#ifndef DUMUX_TISSUE_PROBLEM_HH -#define DUMUX_TISSUE_PROBLEM_HH - -#include <dune/geometry/quadraturerules.hh> -#include <dune/geometry/referenceelements.hh> -#include <dune/localfunctions/lagrange/pqkfactory.hh> - -#include <dumux/common/math.hh> -#include <dumux/implicit/cellcentered/tpfa/properties.hh> -#include <dumux/porousmediumflow/1p/model.hh> -#include <dumux/porousmediumflow/implicit/problem.hh> -#include <dumux/material/components/constant.hh> -#include <dumux/material/fluidsystems/liquidphase.hh> -#include <dumux/material/fluidsystems/1p.hh> - -#include <dumux/mixeddimension/subproblemproperties.hh> - -#include "tissuespatialparams.hh" - -namespace Dumux -{ - -template <class TypeTag> -class TissueProblem; - -namespace Properties -{ -NEW_TYPE_TAG(TissueProblem, INHERITS_FROM(OneP)); -NEW_TYPE_TAG(TissueCCProblem, INHERITS_FROM(CCTpfaModel, TissueProblem)); - -// Set the grid type -SET_TYPE_PROP(TissueProblem, Grid, Dune::YaspGrid<3, Dune::EquidistantOffsetCoordinates<typename GET_PROP_TYPE(TypeTag, Scalar), 3> >); - -SET_BOOL_PROP(TissueProblem, EnableFVGridGeometryCache, true); -SET_BOOL_PROP(TissueProblem, EnableGridVolumeVariablesCache, true); -SET_BOOL_PROP(TissueProblem, EnableGridFluxVariablesCache, true); -SET_BOOL_PROP(TissueProblem, SolutionDependentAdvection, false); -SET_BOOL_PROP(TissueProblem, SolutionDependentMolecularDiffusion, false); -SET_BOOL_PROP(TissueProblem, SolutionDependentHeatConduction, false); - -// Set the grid parameter group -SET_STRING_PROP(TissueProblem, GridParameterGroup, "TissueGrid"); - -// Set the problem property -SET_TYPE_PROP(TissueProblem, Problem, TissueProblem<TypeTag>); - -// the fluid system -SET_PROP(TissueProblem, FluidSystem) -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using type = FluidSystems::OneP<Scalar, FluidSystems::LiquidPhase<Scalar, Components::Constant<1, Scalar> > >; -}; - -// Set the spatial parameters -SET_TYPE_PROP(TissueProblem, SpatialParams, Dumux::TissueSpatialParams<TypeTag>); - - -// Enable velocity output -SET_BOOL_PROP(TissueProblem, VtkAddVelocity, false); - -// Disable gravity -SET_BOOL_PROP(TissueProblem, ProblemEnableGravity, false); -} - - -/*! - * \ingroup OnePTwoCModel - * \ingroup ImplicitTestProblems - */ -template <class TypeTag> -class TissueProblem : public ImplicitPorousMediaProblem<TypeTag> -{ - using ParentType = ImplicitPorousMediaProblem<TypeTag>; - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); - using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); - using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using PointSource = typename GET_PROP_TYPE(TypeTag, PointSource); - using Indices = typename GET_PROP_TYPE(TypeTag, Indices); - using VtkOutputModule = typename GET_PROP_TYPE(TypeTag, VtkOutputModule); - - // copy some indices for convenience - enum { - // world dimension - dim = GridView::dimension, - dimWorld = GridView::dimensionworld - }; - enum { pressureIdx = Indices::pressureIdx }; - enum { conti0EqIdx = Indices::conti0EqIdx }; - - enum { isBox = GET_PROP_VALUE(TypeTag, ImplicitIsBox) }; - enum { dofCodim = isBox ? dim : 0 }; - - using Element = typename GridView::template Codim<0>::Entity; - using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; - - using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); - using CouplingManager = typename GET_PROP_TYPE(GlobalProblemTypeTag, CouplingManager); - -public: - TissueProblem(TimeManager &timeManager, const GridView &gridView) - : ParentType(timeManager, gridView) - { - //read parameters from input file - name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name) + "_3d"; - } - - /*! - * \brief Called by the TimeManager in order to - * initialize the problem. - */ - void init() - { - ParentType::init(); - exactPressure_.resize(this->model().numDofs()); - for (const auto& element : elements(this->gridView())) - { - auto fvGeometry = localView(this->model().fvGridGeometry()); - fvGeometry.bindElement(element); - - for (auto&& scv : scvs(fvGeometry)) - exactPressure_[scv.dofIndex()] = exactSolution(scv.dofPosition()); - } - } - - /*! - * \brief Returns true if a restart file should be written to - * disk. - */ - bool shouldWriteRestartFile() const - { return false; } - - /*! - * \name Problem parameters - */ - // \{ - - /*! - * \brief The problem name. - * - * This is used as a prefix for files generated by the simulation. - */ - const std::string& name() const - { return name_; } - - /*! - * \brief Returns the temperature within the domain [K]. - * - * This problem assumes a temperature of 37 degrees Celsius. - */ - Scalar temperature() const - { return 273.15 + 37; } // in [K] - - // \} - - /*! - * \name Boundary conditions - */ - // \{ - - /*! - * \brief Specifies which kind of boundary condition should be - * used for which equation on a given boundary segment. - * - * \param globalPos The position for which the bc type should be evaluated - */ - BoundaryTypes boundaryTypesAtPos(const GlobalPosition &globalPos) const - { - BoundaryTypes values; - values.setAllDirichlet(); - return values; - } - - /*! - * \brief Evaluate the boundary conditions for a dirichlet - * boundary segment. - * - * \param globalPos The position for which the bc type should be evaluated - * - * For this method, the \a values parameter stores primary variables. - */ - PrimaryVariables dirichletAtPos(const GlobalPosition &globalPos) const - { - PrimaryVariables values; - values = exactSolution(globalPos); - return values; - } - - // \} - - /*! - * \name Volume terms - */ - // \{ - - /*! - * \brief Applies a vector of point sources. The point sources - * are possibly solution dependent. - * - * \param pointSources A vector of Dumux::PointSource s that contain - source values for all phases and space positions. - * - * For this method, the \a values method of the point source - * has to return the absolute mass rate in kg/s. Positive values mean - * that mass is created, negative ones mean that it vanishes. - */ - void addPointSources(std::vector<PointSource>& pointSources) const - { pointSources = this->couplingManager().bulkPointSources(); } - - /*! - * \brief Evaluate the point sources (added by addPointSources) - * for all phases within a given sub-control-volume. - * - * This is the method for the case where the point source is - * solution dependent and requires some quantities that - * are specific to the fully-implicit method. - * - * \param pointSource A single point source - * \param element The finite element - * \param fvGeometry The finite-volume geometry - * \param elemVolVars All volume variables for the element - * \param scv The sub-control volume within the element - * - * For this method, the \a values() method of the point sources returns - * the absolute rate mass generated or annihilate in kg/s. Positive values mean - * that mass is created, negative ones mean that it vanishes. - */ - void pointSource(PointSource& source, - const Element &element, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const SubControlVolume &scv) const - { - // compute source at every integration point - //const auto& bulkVolVars = elemVolVars[scv]; - const auto& bulkVolVars = this->couplingManager().bulkVolVars(source.id()); - const Scalar pressure1D = this->couplingManager().lowDimPriVars(source.id())[pressureIdx]; - - // calculate the source - const Scalar radius = this->couplingManager().radius(source.id()); - const Scalar beta = 2*M_PI/(2*M_PI + std::log(radius)); - const Scalar sourceValue = beta*(pressure1D - bulkVolVars.pressure())*bulkVolVars.density(); - source = sourceValue*source.quadratureWeight()*source.integrationElement(); - } - - /*! - * \brief Evaluate the initial value for a control volume. - * - * \param values The initial values for the primary variables - * \param globalPos The position for which the initial condition should be evaluated - * - * For this method, the \a values parameter stores primary - * variables. - */ - PrimaryVariables initialAtPos(const GlobalPosition &globalPos) const - { return PrimaryVariables(0.0); } - - //! The exact solution - Scalar exactSolution(const GlobalPosition &globalPos) const - { - Dune::FieldVector<double, 2> xy({globalPos[0], globalPos[1]}); - return -1.0*(1+globalPos[2])/(2*M_PI)*std::log(xy.two_norm()); - - // use this instead if you are using the coupling manager with circle sources - // auto R = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, Radius); - // if (xy.two_norm() > R) - // return -1.0*(1+globalPos[2])/(2*M_PI)*std::log(xy.two_norm()); - // else - // return -1.0*(1+globalPos[2])/(2*M_PI)*std::log(R); - } - - //! Called after every time step - //! Output the total global exchange term - void postTimeStep() - { - ParentType::postTimeStep(); - - PrimaryVariables source(0.0); - - if (!(this->timeManager().time() < 0.0)) - { - for (const auto& element : elements(this->gridView())) - { - auto fvGeometry = localView(this->model().fvGridGeometry()); - fvGeometry.bindElement(element); - - auto elemVolVars = localView(this->model().curGridVolVars()); - elemVolVars.bindElement(element, fvGeometry, this->model().curSol()); - - for (auto&& scv : scvs(fvGeometry)) - { - auto pointSources = this->scvPointSources(element, fvGeometry, elemVolVars, scv); - pointSources *= scv.volume()*elemVolVars[scv].extrusionFactor(); - source += pointSources; - } - } - } - - std::cout << "Global integrated source (3D): " << source << '\n'; - } - - /*! - * \brief Adds additional VTK output data to the VTKWriter. Function is called by the output module on every write. - */ - void addVtkOutputFields(VtkOutputModule& outputModule) const - { - auto& p = outputModule.createScalarField("exact pressure", dofCodim); - p = exactPressure_; - } - - //! Set the coupling manager - void setCouplingManager(std::shared_ptr<CouplingManager> cm) - { couplingManager_ = cm; } - - //! Get the coupling manager - const CouplingManager& couplingManager() const - { return *couplingManager_; } - - const std::vector<unsigned int>& getAdditionalDofDependencies(unsigned int dofGlobalIdx) const - { return couplingManager().getAdditionalDofDependencies(dofGlobalIdx); } - -private: - std::vector<Scalar> exactPressure_; - - static constexpr Scalar eps_ = 1.5e-7; - std::string name_; - - std::shared_ptr<CouplingManager> couplingManager_; -}; - -} //end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p_1p/tissuespatialparams.hh b/test/mixeddimension/embedded/1p_1p/tissuespatialparams.hh deleted file mode 100644 index 6b6366b2eac45abc514b42cd6443891c2b384930..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_1p/tissuespatialparams.hh +++ /dev/null @@ -1,102 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief Definition of the spatial parameters for the tissue problem - */ -#ifndef DUMUX_TISSUE_SPATIAL_PARAMS_HH -#define DUMUX_TISSUE_SPATIAL_PARAMS_HH - -#include <dumux/material/spatialparams/fv1p.hh> - -namespace Dumux -{ - -/*! - * \ingroup OnePModel - * \ingroup ImplicitTestProblems - * - * \brief Definition of the spatial parameters for the tissue problem - */ -template<class TypeTag> -class TissueSpatialParams : public FVSpatialParamsOneP<TypeTag> -{ - using ParentType = FVSpatialParamsOneP<TypeTag>; - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); - - enum { - // Grid and world dimension - dim = GridView::dimension, - dimworld = GridView::dimensionworld - }; - using GlobalPosition = Dune::FieldVector<Scalar, dimworld>; - -public: - // export permeability type - using PermeabilityType = Scalar; - - TissueSpatialParams(const Problem& problem, const GridView &gridView) - : ParentType(problem, gridView) - { - permeability_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, PermeabilityTissue); - porosity_ = 1.0; - } - - /*! - * \brief Define the intrinsic permeability \f$\mathrm{[m^2]}\f$. - * - * \param element The element - * \param scv The sub control volume - * \param elemSol the element solution vector - */ - Scalar permeability(const Element& element, - const SubControlVolume& scv, - const ElementSolutionVector& elemSol) const - { - return permeability_; - } - - /*! - * \brief Define the porosity \f$\mathrm{[-]}\f$. - * - * \param element The current finite element - * \param scv The sub control volume - * \param elemSol The current element solution vector - */ - Scalar porosity(const Element& element, - const SubControlVolume& scv, - const ElementSolutionVector& elemSol) const - { - return porosity_; - } - -private: - Scalar permeability_; - Scalar porosity_; -}; - -} // end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p_richards/CMakeLists.txt b/test/mixeddimension/embedded/1p_richards/CMakeLists.txt deleted file mode 100644 index 04b54796092ad8c3ac189683b66a5478521bde74..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_richards/CMakeLists.txt +++ /dev/null @@ -1,2 +0,0 @@ -dune_add_test(SOURCES test_rosi.cc) -dune_symlink_to_source_files(FILES "grids" "test_rosi.input") diff --git a/test/mixeddimension/embedded/1p_richards/grids/lupine.dgf b/test/mixeddimension/embedded/1p_richards/grids/lupine.dgf deleted file mode 100644 index a13c4d3956f94a0f7ae164f7de6ef87b8dc82e89..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_richards/grids/lupine.dgf +++ /dev/null @@ -1,3486 +0,0 @@ -DGF -Vertex -0.000389 0.000879 0.000800 # node 0 -0.000389 0.000879 -0.000294 # node 1 -0.000778 0.001758 -0.000589 # node 2 -0.001167 0.002638 -0.000883 # node 3 -0.001555 0.003517 -0.001178 # node 4 -0.001944 0.004396 -0.001472 # node 5 -0.002333 0.005275 -0.001767 # node 6 -0.002722 0.006154 -0.002061 # node 7 -0.003009 0.006712 -0.002838 # node 8 -0.003295 0.007269 -0.003615 # node 9 -0.003582 0.007826 -0.004392 # node 10 -0.003869 0.008384 -0.005169 # node 11 -0.003835 0.008394 -0.006178 # node 12 -0.003802 0.008404 -0.007186 # node 13 -0.003768 0.008415 -0.008195 # node 14 -0.003734 0.008425 -0.009203 # node 15 -0.003701 0.008435 -0.010211 # node 16 -0.003667 0.008446 -0.011220 # node 17 -0.003634 0.008456 -0.012228 # node 18 -0.003379 0.008194 -0.013152 # node 19 -0.003125 0.007931 -0.014077 # node 20 -0.002871 0.007669 -0.015001 # node 21 -0.002617 0.007406 -0.015924 # node 22 -0.002303 0.006929 -0.016611 # node 23 -0.001990 0.006453 -0.017298 # node 24 -0.001676 0.005977 -0.017983 # node 25 -0.001362 0.005500 -0.018670 # node 26 -0.001048 0.005024 -0.019357 # node 27 -0.000652 0.004517 -0.019932 # node 28 -0.000256 0.004010 -0.020508 # node 29 --0.000140 0.003502 -0.021084 # node 30 --0.000536 0.002995 -0.021660 # node 31 --0.001022 0.003569 -0.022299 # node 32 --0.001508 0.004143 -0.022938 # node 33 --0.001994 0.004718 -0.023577 # node 34 --0.002480 0.005292 -0.024217 # node 35 --0.002966 0.005866 -0.024856 # node 36 --0.003058 0.006804 -0.025014 # node 37 --0.003149 0.007742 -0.025174 # node 38 --0.003241 0.008681 -0.025334 # node 39 --0.003333 0.009619 -0.025494 # node 40 --0.003424 0.010557 -0.025654 # node 41 --0.003516 0.011496 -0.025814 # node 42 --0.003608 0.012434 -0.025974 # node 43 --0.003699 0.013373 -0.026133 # node 44 --0.003791 0.014311 -0.026293 # node 45 --0.003883 0.015249 -0.026453 # node 46 --0.003974 0.016188 -0.026613 # node 47 --0.004066 0.017126 -0.026773 # node 48 --0.004158 0.018064 -0.026933 # node 49 --0.004739 0.018185 -0.027691 # node 50 --0.005321 0.018305 -0.028450 # node 51 --0.005903 0.018425 -0.029208 # node 52 --0.006485 0.018546 -0.029967 # node 53 --0.007204 0.018230 -0.030649 # node 54 --0.007923 0.017914 -0.031331 # node 55 --0.008641 0.017599 -0.032014 # node 56 --0.009360 0.017283 -0.032697 # node 57 --0.010079 0.016968 -0.033379 # node 58 --0.010357 0.016663 -0.034164 # node 59 --0.010634 0.016358 -0.034950 # node 60 --0.010912 0.016052 -0.035736 # node 61 --0.011189 0.015747 -0.036521 # node 62 --0.010909 0.015791 -0.037468 # node 63 --0.010629 0.015834 -0.038413 # node 64 --0.010349 0.015877 -0.039360 # node 65 --0.010069 0.015921 -0.040306 # node 66 --0.009789 0.015964 -0.041252 # node 67 --0.009508 0.016008 -0.042198 # node 68 --0.009228 0.016051 -0.043144 # node 69 --0.008849 0.016040 -0.044108 # node 70 --0.008470 0.016030 -0.045071 # node 71 --0.008091 0.016019 -0.046033 # node 72 --0.007712 0.016009 -0.046997 # node 73 --0.007333 0.015998 -0.047960 # node 74 --0.006955 0.015988 -0.048923 # node 75 --0.006377 0.015992 -0.049798 # node 76 --0.005799 0.015997 -0.050672 # node 77 --0.005222 0.016002 -0.051547 # node 78 --0.004644 0.016006 -0.052422 # node 79 --0.003947 0.015928 -0.053168 # node 80 --0.003250 0.015851 -0.053913 # node 81 --0.002553 0.015773 -0.054659 # node 82 --0.001856 0.015695 -0.055404 # node 83 --0.001121 0.015925 -0.055700 # node 84 --0.000385 0.016155 -0.055996 # node 85 -0.000350 0.016385 -0.056291 # node 86 -0.001085 0.016615 -0.056587 # node 87 -0.001363 0.017132 -0.057363 # node 88 -0.001640 0.017649 -0.058139 # node 89 -0.001918 0.018166 -0.058916 # node 90 -0.002196 0.018683 -0.059692 # node 91 -0.002474 0.019199 -0.060468 # node 92 -0.002752 0.019716 -0.061244 # node 93 -0.002838 0.019743 -0.062281 # node 94 -0.002925 0.019769 -0.063318 # node 95 -0.003012 0.019795 -0.064356 # node 96 -0.003099 0.019822 -0.065392 # node 97 -0.003186 0.019848 -0.066429 # node 98 -0.003512 0.019897 -0.067379 # node 99 -0.003838 0.019946 -0.068328 # node 100 -0.004163 0.019995 -0.069278 # node 101 -0.004489 0.020044 -0.070227 # node 102 -0.004448 0.019865 -0.071091 # node 103 -0.004407 0.019687 -0.071956 # node 104 -0.004366 0.019509 -0.072820 # node 105 -0.004326 0.019331 -0.073683 # node 106 -0.004494 0.019245 -0.074766 # node 107 -0.004663 0.019158 -0.075847 # node 108 -0.004832 0.019072 -0.076928 # node 109 -0.005000 0.018986 -0.078009 # node 110 -0.005169 0.018900 -0.079091 # node 111 --0.003467 0.018531 -0.027004 # node 112 --0.002776 0.018997 -0.027077 # node 113 --0.002086 0.019464 -0.027149 # node 114 --0.001395 0.019930 -0.027221 # node 115 --0.000548 0.020022 -0.027549 # node 116 -0.000298 0.020115 -0.027877 # node 117 -0.001145 0.020207 -0.028203 # node 118 -0.001992 0.020299 -0.028531 # node 119 --0.003277 0.018464 -0.026658 # node 120 --0.002396 0.018864 -0.026383 # node 121 --0.001516 0.019264 -0.026108 # node 122 --0.000513 0.019296 -0.026131 # node 123 -0.000489 0.019328 -0.026153 # node 124 -0.001270 0.005523 -0.019851 # node 125 -0.001492 0.006021 -0.020347 # node 126 -0.001714 0.006520 -0.020841 # node 127 -0.002488 0.006843 -0.021176 # node 128 -0.003263 0.007166 -0.021511 # node 129 -0.004038 0.007489 -0.021846 # node 130 -0.004812 0.007812 -0.022180 # node 131 -0.005738 0.008029 -0.022481 # node 132 -0.006664 0.008245 -0.022782 # node 133 -0.007589 0.008462 -0.023083 # node 134 -0.008515 0.008679 -0.023384 # node 135 -0.009441 0.008896 -0.023686 # node 136 -0.010044 0.008824 -0.024267 # node 137 -0.010647 0.008752 -0.024849 # node 138 -0.011249 0.008680 -0.025430 # node 139 -0.012147 0.008597 -0.025799 # node 140 -0.013044 0.008515 -0.026168 # node 141 -0.013941 0.008432 -0.026537 # node 142 -0.014838 0.008349 -0.026904 # node 143 -0.015435 0.007968 -0.027519 # node 144 -0.016032 0.007587 -0.028133 # node 145 -0.016742 0.007504 -0.028620 # node 146 -0.017453 0.007422 -0.029106 # node 147 -0.018164 0.007339 -0.029591 # node 148 -0.018874 0.007256 -0.030077 # node 149 -0.018708 0.007520 -0.030891 # node 150 -0.018542 0.007783 -0.031707 # node 151 -0.018376 0.008046 -0.032521 # node 152 -0.017748 0.008417 -0.032940 # node 153 -0.017120 0.008789 -0.033358 # node 154 -0.016493 0.009161 -0.033776 # node 155 -0.015865 0.009533 -0.034193 # node 156 -0.015351 0.009881 -0.034916 # node 157 -0.014836 0.010229 -0.035639 # node 158 -0.014322 0.010577 -0.036361 # node 159 -0.013961 0.010666 -0.037306 # node 160 -0.013599 0.010755 -0.038249 # node 161 -0.013238 0.010844 -0.039193 # node 162 -0.012876 0.010934 -0.040137 # node 163 -0.012866 0.010814 -0.041064 # node 164 -0.012855 0.010695 -0.041992 # node 165 -0.012844 0.010576 -0.042920 # node 166 -0.012833 0.010457 -0.043847 # node 167 -0.012823 0.010338 -0.044774 # node 168 -0.012812 0.010219 -0.045702 # node 169 -0.000021 -0.000080 -0.000946 # node 170 -0.000042 -0.000159 -0.001892 # node 171 -0.000063 -0.000239 -0.002839 # node 172 -0.000084 -0.000319 -0.003785 # node 173 -0.000105 -0.000398 -0.004731 # node 174 --0.000098 -0.000611 -0.005684 # node 175 --0.000300 -0.000824 -0.006636 # node 176 --0.000503 -0.001037 -0.007589 # node 177 --0.000412 -0.001103 -0.008357 # node 178 --0.000320 -0.001169 -0.009125 # node 179 --0.000229 -0.001234 -0.009894 # node 180 --0.000378 -0.001898 -0.010650 # node 181 --0.000526 -0.002561 -0.011407 # node 182 --0.000675 -0.003225 -0.012162 # node 183 --0.000773 -0.003424 -0.013141 # node 184 --0.000870 -0.003623 -0.014120 # node 185 --0.000968 -0.003822 -0.015100 # node 186 --0.001065 -0.004021 -0.016079 # node 187 --0.001442 -0.004609 -0.016482 # node 188 --0.001820 -0.005198 -0.016884 # node 189 --0.002197 -0.005786 -0.017288 # node 190 --0.002575 -0.006374 -0.017691 # node 191 --0.002581 -0.006757 -0.018423 # node 192 --0.002587 -0.007139 -0.019154 # node 193 --0.002594 -0.007522 -0.019887 # node 194 --0.002524 -0.008048 -0.020388 # node 195 --0.002453 -0.008574 -0.020889 # node 196 --0.002383 -0.009101 -0.021391 # node 197 --0.002416 -0.009753 -0.021877 # node 198 --0.002450 -0.010406 -0.022363 # node 199 --0.002484 -0.011058 -0.022849 # node 200 --0.002517 -0.011711 -0.023336 # node 201 --0.002323 -0.012330 -0.023630 # node 202 --0.002128 -0.012949 -0.023923 # node 203 --0.001934 -0.013569 -0.024218 # node 204 --0.001750 -0.014357 -0.024323 # node 205 --0.001566 -0.015145 -0.024429 # node 206 --0.001382 -0.015933 -0.024534 # node 207 --0.001196 -0.016741 -0.024600 # node 208 --0.001009 -0.017549 -0.024667 # node 209 --0.000824 -0.018358 -0.024732 # node 210 --0.000492 -0.019206 -0.024828 # node 211 --0.000161 -0.020055 -0.024923 # node 212 -0.000170 -0.020903 -0.025019 # node 213 -0.000629 -0.021306 -0.025352 # node 214 -0.001087 -0.021709 -0.025687 # node 215 -0.001546 -0.022112 -0.026020 # node 216 -0.002043 -0.022749 -0.026477 # node 217 -0.002541 -0.023385 -0.026932 # node 218 -0.003038 -0.024022 -0.027389 # node 219 --0.000222 -0.003884 -0.012830 # node 220 -0.000231 -0.004543 -0.013498 # node 221 -0.000684 -0.005202 -0.014164 # node 222 -0.001137 -0.005860 -0.014832 # node 223 -0.001518 -0.006542 -0.015180 # node 224 -0.001899 -0.007224 -0.015527 # node 225 -0.002280 -0.007906 -0.015873 # node 226 -0.002661 -0.008588 -0.016221 # node 227 -0.003042 -0.009270 -0.016568 # node 228 -0.003352 -0.009919 -0.017172 # node 229 -0.003661 -0.010568 -0.017778 # node 230 -0.003971 -0.011217 -0.018382 # node 231 -0.004280 -0.011866 -0.018987 # node 232 -0.004590 -0.012515 -0.019591 # node 233 -0.004900 -0.013164 -0.020197 # node 234 -0.004914 -0.013234 -0.021160 # node 235 -0.004927 -0.013303 -0.022124 # node 236 -0.004941 -0.013373 -0.023089 # node 237 -0.004955 -0.013442 -0.024053 # node 238 -0.004969 -0.013512 -0.025018 # node 239 -0.004982 -0.013581 -0.025981 # node 240 -0.004996 -0.013650 -0.026946 # node 241 -0.004950 -0.013592 -0.027931 # node 242 -0.004903 -0.013533 -0.028917 # node 243 -0.004857 -0.013475 -0.029902 # node 244 -0.004811 -0.013417 -0.030889 # node 245 -0.004764 -0.013358 -0.031874 # node 246 -0.004718 -0.013300 -0.032860 # node 247 -0.004671 -0.013241 -0.033846 # node 248 -0.004625 -0.013183 -0.034831 # node 249 -0.004579 -0.013124 -0.035817 # node 250 -0.004453 -0.013037 -0.036722 # node 251 -0.004328 -0.012950 -0.037629 # node 252 -0.004203 -0.012864 -0.038534 # node 253 -0.004077 -0.012777 -0.039440 # node 254 -0.004033 -0.012694 -0.040417 # node 255 -0.003989 -0.012612 -0.041394 # node 256 -0.003945 -0.012530 -0.042371 # node 257 -0.003901 -0.012447 -0.043348 # node 258 -0.003857 -0.012365 -0.044326 # node 259 -0.003813 -0.012282 -0.045302 # node 260 -0.003770 -0.012200 -0.046279 # node 261 -0.003572 -0.012036 -0.047248 # node 262 -0.003375 -0.011872 -0.048217 # node 263 -0.003178 -0.011708 -0.049187 # node 264 -0.002980 -0.011543 -0.050156 # node 265 -0.002783 -0.011379 -0.051124 # node 266 -0.002586 -0.011215 -0.052093 # node 267 -0.002806 -0.011119 -0.052984 # node 268 -0.003026 -0.011024 -0.053877 # node 269 -0.003247 -0.010928 -0.054768 # node 270 -0.003467 -0.010832 -0.055659 # node 271 -0.003687 -0.010736 -0.056551 # node 272 -0.003794 -0.010703 -0.057563 # node 273 -0.003900 -0.010670 -0.058577 # node 274 -0.004007 -0.010637 -0.059589 # node 275 -0.004113 -0.010604 -0.060602 # node 276 -0.004220 -0.010571 -0.061614 # node 277 -0.004326 -0.010538 -0.062628 # node 278 -0.004432 -0.010505 -0.063640 # node 279 -0.004539 -0.010472 -0.064653 # node 280 -0.004646 -0.010439 -0.065667 # node 281 -0.004752 -0.010406 -0.066679 # node 282 -0.004858 -0.010373 -0.067692 # node 283 -0.004965 -0.010340 -0.068704 # node 284 -0.005062 -0.010486 -0.069662 # node 285 -0.005160 -0.010631 -0.070621 # node 286 -0.005257 -0.010777 -0.071579 # node 287 -0.005354 -0.010923 -0.072537 # node 288 -0.005452 -0.011068 -0.073494 # node 289 -0.005549 -0.011214 -0.074452 # node 290 -0.005646 -0.011360 -0.075410 # node 291 -0.005744 -0.011506 -0.076369 # node 292 -0.005779 -0.011476 -0.077382 # node 293 -0.005814 -0.011446 -0.078396 # node 294 -0.005850 -0.011415 -0.079409 # node 295 -0.005885 -0.011385 -0.080423 # node 296 -0.005920 -0.011355 -0.081437 # node 297 -0.005956 -0.011325 -0.082450 # node 298 -0.005991 -0.011295 -0.083464 # node 299 -0.005664 -0.011174 -0.084359 # node 300 -0.005336 -0.011054 -0.085254 # node 301 -0.005009 -0.010933 -0.086150 # node 302 -0.004681 -0.010812 -0.087046 # node 303 -0.004354 -0.010691 -0.087941 # node 304 -0.004027 -0.010570 -0.088837 # node 305 -0.004443 -0.010794 -0.056901 # node 306 -0.005199 -0.010852 -0.057250 # node 307 -0.005955 -0.010910 -0.057600 # node 308 -0.006648 -0.010527 -0.057952 # node 309 -0.007341 -0.010145 -0.058303 # node 310 -0.007216 -0.009755 -0.059136 # node 311 -0.007090 -0.009364 -0.059967 # node 312 -0.006965 -0.008974 -0.060798 # node 313 -0.006620 -0.008625 -0.061526 # node 314 -0.006275 -0.008276 -0.062253 # node 315 -0.005930 -0.007926 -0.062981 # node 316 -0.005572 -0.007782 -0.063772 # node 317 -0.005214 -0.007638 -0.064563 # node 318 -0.004855 -0.007493 -0.065353 # node 319 -0.004629 -0.007295 -0.066342 # node 320 -0.004402 -0.007097 -0.067332 # node 321 -0.004176 -0.006899 -0.068321 # node 322 -0.003730 -0.010095 -0.057103 # node 323 -0.003773 -0.009453 -0.057657 # node 324 -0.003816 -0.008811 -0.058210 # node 325 -0.003859 -0.008170 -0.058763 # node 326 -0.004345 -0.007610 -0.059489 # node 327 -0.004830 -0.007050 -0.060214 # node 328 -0.005315 -0.006491 -0.060941 # node 329 -0.005363 -0.006042 -0.061890 # node 330 -0.005412 -0.005593 -0.062840 # node 331 -0.005460 -0.005144 -0.063789 # node 332 -0.005508 -0.004695 -0.064739 # node 333 -0.005556 -0.004247 -0.065688 # node 334 -0.005604 -0.003798 -0.066638 # node 335 -0.005790 -0.003398 -0.067482 # node 336 -0.005977 -0.002999 -0.068327 # node 337 -0.006164 -0.002599 -0.069172 # node 338 -0.006350 -0.002200 -0.070017 # node 339 -0.006537 -0.001800 -0.070862 # node 340 -0.007458 -0.001535 -0.070929 # node 341 -0.008379 -0.001270 -0.070994 # node 342 -0.009301 -0.001005 -0.071061 # node 343 -0.010222 -0.000740 -0.071128 # node 344 -0.011143 -0.000475 -0.071194 # node 345 -0.011189 0.000010 -0.071974 # node 346 -0.011234 0.000496 -0.072753 # node 347 -0.011279 0.000981 -0.073533 # node 348 -0.011324 0.001467 -0.074313 # node 349 -0.010689 0.001664 -0.074888 # node 350 -0.010055 0.001860 -0.075462 # node 351 -0.009420 0.002057 -0.076037 # node 352 -0.008785 0.002254 -0.076611 # node 353 -0.008150 0.002450 -0.077186 # node 354 -0.007688 0.002729 -0.077892 # node 355 -0.007226 0.003007 -0.078599 # node 356 -0.006764 0.003285 -0.079306 # node 357 -0.006302 0.003563 -0.080012 # node 358 -0.005840 0.003841 -0.080719 # node 359 -0.005405 0.003969 -0.081608 # node 360 -0.004969 0.004097 -0.082498 # node 361 -0.004533 0.004226 -0.083388 # node 362 -0.004097 0.004354 -0.084277 # node 363 -0.004128 0.004881 -0.085154 # node 364 -0.004158 0.005409 -0.086031 # node 365 -0.004189 0.005936 -0.086909 # node 366 -0.011421 -0.000752 -0.071854 # node 367 -0.011698 -0.001030 -0.072514 # node 368 -0.011975 -0.001306 -0.073176 # node 369 -0.011950 -0.001186 -0.073976 # node 370 -0.011925 -0.001065 -0.074774 # node 371 -0.011900 -0.000945 -0.075574 # node 372 -0.012626 -0.000819 -0.075752 # node 373 -0.013351 -0.000694 -0.075931 # node 374 -0.014076 -0.000569 -0.076109 # node 375 -0.014801 -0.000443 -0.076288 # node 376 -0.015502 -0.000524 -0.075856 # node 377 -0.016204 -0.000605 -0.075424 # node 378 -0.016905 -0.000686 -0.074992 # node 379 -0.017606 -0.000766 -0.074561 # node 380 -0.001803 -0.011531 -0.052388 # node 381 -0.001020 -0.011848 -0.052682 # node 382 -0.000318 -0.011912 -0.052763 # node 383 --0.000384 -0.011976 -0.052846 # node 384 --0.001086 -0.012041 -0.052927 # node 385 --0.001646 -0.011504 -0.052940 # node 386 --0.002206 -0.010968 -0.052952 # node 387 --0.002765 -0.010431 -0.052966 # node 388 --0.002710 -0.009452 -0.053134 # node 389 --0.002655 -0.008474 -0.053303 # node 390 --0.002600 -0.007495 -0.053472 # node 391 --0.002958 -0.006610 -0.053263 # node 392 --0.003316 -0.005724 -0.053054 # node 393 --0.004008 -0.005411 -0.052924 # node 394 --0.004699 -0.005098 -0.052794 # node 395 --0.005390 -0.004784 -0.052664 # node 396 --0.006082 -0.004471 -0.052536 # node 397 --0.006594 -0.003993 -0.052906 # node 398 --0.007107 -0.003514 -0.053276 # node 399 --0.007302 -0.003659 -0.054238 # node 400 --0.007497 -0.003804 -0.055200 # node 401 --0.007693 -0.003949 -0.056161 # node 402 --0.008328 -0.003673 -0.056823 # node 403 --0.008964 -0.003396 -0.057487 # node 404 --0.009599 -0.003120 -0.058149 # node 405 --0.010235 -0.002844 -0.058811 # node 406 --0.010519 -0.002113 -0.058867 # node 407 --0.010803 -0.001383 -0.058922 # node 408 --0.011087 -0.000652 -0.058978 # node 409 --0.011327 0.000265 -0.059040 # node 410 --0.011568 0.001182 -0.059102 # node 411 --0.012309 0.001537 -0.059173 # node 412 --0.013051 0.001893 -0.059244 # node 413 --0.013792 0.002249 -0.059316 # node 414 --0.014534 0.002605 -0.059386 # node 415 --0.015275 0.002960 -0.059457 # node 416 --0.015817 0.003517 -0.060102 # node 417 --0.016359 0.004073 -0.060748 # node 418 --0.016901 0.004629 -0.061393 # node 419 --0.017501 0.004917 -0.062141 # node 420 --0.018101 0.005204 -0.062889 # node 421 --0.018701 0.005491 -0.063637 # node 422 --0.019301 0.005778 -0.064386 # node 423 --0.019900 0.006066 -0.065133 # node 424 --0.020197 0.006091 -0.066167 # node 425 --0.020494 0.006117 -0.067200 # node 426 --0.020791 0.006142 -0.068234 # node 427 --0.020892 0.006117 -0.069179 # node 428 --0.020994 0.006091 -0.070124 # node 429 --0.020802 0.005980 -0.071158 # node 430 --0.020610 0.005869 -0.072190 # node 431 --0.020418 0.005758 -0.073223 # node 432 --0.020226 0.005646 -0.074256 # node 433 --0.020302 0.005689 -0.075198 # node 434 --0.020377 0.005732 -0.076140 # node 435 --0.020453 0.005775 -0.077082 # node 436 --0.020528 0.005818 -0.078024 # node 437 --0.020604 0.005861 -0.078967 # node 438 --0.020510 0.005922 -0.079902 # node 439 --0.020415 0.005983 -0.080837 # node 440 --0.020321 0.006044 -0.081771 # node 441 --0.020227 0.006105 -0.082707 # node 442 --0.020163 0.006015 -0.083604 # node 443 --0.020099 0.005926 -0.084502 # node 444 --0.020035 0.005836 -0.085400 # node 445 --0.019972 0.005746 -0.086298 # node 446 --0.019908 0.005656 -0.087197 # node 447 --0.003470 -0.007322 -0.053616 # node 448 --0.004340 -0.007148 -0.053760 # node 449 --0.005210 -0.006975 -0.053903 # node 450 --0.006081 -0.006801 -0.054048 # node 451 --0.006767 -0.006315 -0.054277 # node 452 --0.007453 -0.005829 -0.054507 # node 453 --0.008240 -0.005770 -0.054681 # node 454 --0.009028 -0.005711 -0.054857 # node 455 --0.009815 -0.005653 -0.055031 # node 456 --0.010602 -0.005594 -0.055207 # node 457 --0.011389 -0.005535 -0.055382 # node 458 --0.011501 -0.006111 -0.055974 # node 459 --0.011613 -0.006688 -0.056568 # node 460 --0.011725 -0.007264 -0.057161 # node 461 --0.011837 -0.007840 -0.057754 # node 462 --0.011667 -0.008544 -0.058456 # node 463 --0.011497 -0.009247 -0.059157 # node 464 --0.011326 -0.009951 -0.059858 # node 465 --0.011550 -0.010437 -0.060724 # node 466 --0.011773 -0.010923 -0.061591 # node 467 --0.011996 -0.011410 -0.062458 # node 468 --0.012668 -0.011571 -0.063157 # node 469 --0.013340 -0.011732 -0.063854 # node 470 --0.014012 -0.011893 -0.064553 # node 471 --0.014258 -0.012199 -0.065304 # node 472 --0.014504 -0.012505 -0.066056 # node 473 --0.014750 -0.012811 -0.066807 # node 474 --0.014298 -0.013008 -0.067712 # node 475 --0.013847 -0.013205 -0.068618 # node 476 --0.013396 -0.013402 -0.069523 # node 477 --0.012944 -0.013599 -0.070429 # node 478 --0.012493 -0.013796 -0.071334 # node 479 --0.012042 -0.013993 -0.072240 # node 480 --0.012379 -0.014372 -0.072974 # node 481 --0.012717 -0.014751 -0.073710 # node 482 --0.013055 -0.015130 -0.074444 # node 483 --0.013392 -0.015509 -0.075179 # node 484 --0.013933 -0.015911 -0.075797 # node 485 --0.014473 -0.016314 -0.076414 # node 486 --0.015014 -0.016717 -0.077032 # node 487 --0.015554 -0.017119 -0.077650 # node 488 --0.015635 -0.017415 -0.078561 # node 489 --0.015716 -0.017711 -0.079471 # node 490 --0.015798 -0.018007 -0.080381 # node 491 --0.016407 -0.018346 -0.081099 # node 492 --0.017016 -0.018684 -0.081817 # node 493 --0.017625 -0.019023 -0.082536 # node 494 --0.018233 -0.019362 -0.083253 # node 495 --0.013128 -0.016006 -0.075833 # node 496 --0.012864 -0.016503 -0.076487 # node 497 --0.012599 -0.017000 -0.077141 # node 498 --0.012335 -0.017498 -0.077796 # node 499 --0.012513 -0.018129 -0.078340 # node 500 --0.012690 -0.018761 -0.078884 # node 501 --0.012868 -0.019392 -0.079428 # node 502 --0.013046 -0.020024 -0.079972 # node 503 --0.013224 -0.020656 -0.080517 # node 504 --0.013879 -0.021295 -0.080569 # node 505 --0.014534 -0.021935 -0.080620 # node 506 --0.015189 -0.022575 -0.080672 # node 507 --0.015843 -0.023215 -0.080723 # node 508 --0.016435 -0.022933 -0.081096 # node 509 --0.017027 -0.022652 -0.081468 # node 510 --0.017618 -0.022371 -0.081839 # node 511 --0.017624 -0.022368 -0.082792 # node 512 --0.017630 -0.022365 -0.083747 # node 513 --0.017636 -0.022363 -0.084700 # node 514 --0.017642 -0.022360 -0.085653 # node 515 --0.013520 -0.020961 -0.081127 # node 516 --0.013817 -0.021267 -0.081738 # node 517 --0.014114 -0.021572 -0.082348 # node 518 --0.014850 -0.021301 -0.083008 # node 519 --0.015586 -0.021031 -0.083667 # node 520 --0.016321 -0.020760 -0.084326 # node 521 --0.017057 -0.020489 -0.084986 # node 522 --0.017709 -0.020163 -0.085250 # node 523 --0.018361 -0.019837 -0.085514 # node 524 --0.019013 -0.019511 -0.085780 # node 525 --0.019665 -0.019184 -0.086044 # node 526 --0.019525 -0.018924 -0.086848 # node 527 --0.019385 -0.018664 -0.087651 # node 528 --0.011831 -0.017522 -0.078092 # node 529 --0.011326 -0.017546 -0.078390 # node 530 --0.011173 -0.017797 -0.079112 # node 531 --0.010734 -0.018222 -0.079716 # node 532 --0.010294 -0.018646 -0.080319 # node 533 --0.010664 -0.018725 -0.080932 # node 534 --0.011033 -0.018803 -0.081547 # node 535 --0.011113 -0.018048 -0.081939 # node 536 --0.011194 -0.017293 -0.082331 # node 537 --0.011274 -0.016537 -0.082724 # node 538 -0.003070 -0.012539 -0.046652 # node 539 -0.002370 -0.012878 -0.047027 # node 540 -0.001671 -0.013216 -0.047400 # node 541 -0.001074 -0.013742 -0.047703 # node 542 -0.000477 -0.014268 -0.048007 # node 543 --0.000119 -0.014794 -0.048310 # node 544 --0.000716 -0.015320 -0.048614 # node 545 --0.001313 -0.015846 -0.048918 # node 546 --0.001964 -0.016320 -0.049229 # node 547 --0.002616 -0.016793 -0.049541 # node 548 --0.003267 -0.017267 -0.049852 # node 549 --0.003314 -0.017752 -0.050671 # node 550 --0.003361 -0.018238 -0.051490 # node 551 --0.003407 -0.018724 -0.052309 # node 552 --0.003585 -0.019334 -0.053172 # node 553 --0.003763 -0.019943 -0.054036 # node 554 --0.004572 -0.020084 -0.054036 # node 555 --0.005381 -0.020225 -0.054036 # node 556 --0.006190 -0.020366 -0.054037 # node 557 --0.006998 -0.020506 -0.054037 # node 558 --0.003762 -0.020242 -0.055028 # node 559 --0.003760 -0.020540 -0.056019 # node 560 --0.003759 -0.020839 -0.057010 # node 561 --0.003757 -0.021137 -0.058002 # node 562 --0.003756 -0.021435 -0.058993 # node 563 --0.003755 -0.021734 -0.059984 # node 564 --0.003753 -0.022032 -0.060977 # node 565 --0.003752 -0.022331 -0.061968 # node 566 --0.003751 -0.022629 -0.062959 # node 567 -0.003917 -0.011278 -0.046354 # node 568 -0.004064 -0.010356 -0.046430 # node 569 -0.004211 -0.009434 -0.046506 # node 570 -0.004958 -0.008978 -0.046536 # node 571 -0.005704 -0.008521 -0.046566 # node 572 -0.006450 -0.008065 -0.046597 # node 573 -0.007196 -0.007608 -0.046627 # node 574 -0.007942 -0.007151 -0.046657 # node 575 -0.008228 -0.006423 -0.046657 # node 576 -0.008514 -0.005694 -0.046656 # node 577 -0.008800 -0.004966 -0.046654 # node 578 -0.009086 -0.004237 -0.046654 # node 579 -0.009727 -0.003601 -0.046978 # node 580 -0.010368 -0.002965 -0.047301 # node 581 -0.011008 -0.002329 -0.047624 # node 582 -0.011649 -0.001693 -0.047948 # node 583 -0.011714 -0.001802 -0.048843 # node 584 -0.011778 -0.001911 -0.049740 # node 585 -0.011053 -0.001914 -0.049786 # node 586 -0.010327 -0.001917 -0.049831 # node 587 -0.009602 -0.001920 -0.049877 # node 588 -0.012124 -0.001333 -0.049921 # node 589 -0.012469 -0.000755 -0.050101 # node 590 -0.012814 -0.000177 -0.050282 # node 591 -0.011966 0.000170 -0.050327 # node 592 -0.011118 0.000516 -0.050372 # node 593 -0.010269 0.000863 -0.050417 # node 594 -0.009421 0.001210 -0.050462 # node 595 -0.008594 0.001474 -0.050347 # node 596 -0.007768 0.001739 -0.050231 # node 597 -0.006941 0.002003 -0.050116 # node 598 -0.006115 0.002268 -0.050001 # node 599 -0.005288 0.002532 -0.049886 # node 600 -0.004462 0.002797 -0.049770 # node 601 -0.008365 -0.003942 -0.046349 # node 602 -0.007643 -0.003648 -0.046043 # node 603 -0.006921 -0.003353 -0.045739 # node 604 -0.006200 -0.003058 -0.045433 # node 605 -0.005478 -0.002764 -0.045128 # node 606 -0.005003 -0.012686 -0.039492 # node 607 -0.005928 -0.012595 -0.039544 # node 608 -0.006854 -0.012504 -0.039598 # node 609 -0.007574 -0.012294 -0.039599 # node 610 -0.008295 -0.012084 -0.039600 # node 611 -0.009016 -0.011875 -0.039601 # node 612 -0.009639 -0.011337 -0.039767 # node 613 -0.010263 -0.010799 -0.039932 # node 614 -0.010886 -0.010261 -0.040098 # node 615 -0.011510 -0.009723 -0.040263 # node 616 -0.012153 -0.009228 -0.040622 # node 617 -0.012796 -0.008734 -0.040980 # node 618 -0.013439 -0.008240 -0.041339 # node 619 -0.014082 -0.007746 -0.041697 # node 620 -0.014737 -0.007292 -0.042341 # node 621 -0.015391 -0.006837 -0.042984 # node 622 -0.016046 -0.006383 -0.043628 # node 623 -0.016700 -0.005929 -0.044272 # node 624 -0.017446 -0.005457 -0.044624 # node 625 -0.018192 -0.004986 -0.044978 # node 626 -0.018938 -0.004515 -0.045330 # node 627 -0.019684 -0.004043 -0.045683 # node 628 -0.020383 -0.003903 -0.046129 # node 629 -0.021082 -0.003762 -0.046574 # node 630 -0.021781 -0.003621 -0.047021 # node 631 -0.022480 -0.003480 -0.047467 # node 632 -0.023301 -0.003721 -0.047429 # node 633 -0.024122 -0.003963 -0.047391 # node 634 -0.024943 -0.004204 -0.047354 # node 635 -0.025764 -0.004445 -0.047317 # node 636 -0.003806 -0.013160 -0.036014 # node 637 -0.003034 -0.013197 -0.036211 # node 638 -0.002262 -0.013233 -0.036408 # node 639 -0.001490 -0.013269 -0.036606 # node 640 -0.000610 -0.013047 -0.036886 # node 641 --0.000270 -0.012825 -0.037164 # node 642 --0.001150 -0.012603 -0.037444 # node 643 --0.002030 -0.012745 -0.037571 # node 644 --0.002910 -0.012886 -0.037697 # node 645 --0.003790 -0.013028 -0.037822 # node 646 --0.004660 -0.012919 -0.037590 # node 647 --0.005529 -0.012810 -0.037357 # node 648 --0.006399 -0.012700 -0.037123 # node 649 --0.007268 -0.012591 -0.036891 # node 650 --0.008102 -0.012468 -0.036484 # node 651 --0.008936 -0.012344 -0.036079 # node 652 --0.009769 -0.012220 -0.035672 # node 653 --0.010603 -0.012097 -0.035267 # node 654 --0.011436 -0.011973 -0.034860 # node 655 --0.012270 -0.011849 -0.034453 # node 656 --0.013104 -0.011726 -0.034048 # node 657 --0.013937 -0.011602 -0.033641 # node 658 --0.014720 -0.011424 -0.033966 # node 659 --0.015503 -0.011246 -0.034290 # node 660 --0.016286 -0.011069 -0.034616 # node 661 --0.016876 -0.011538 -0.034874 # node 662 --0.017466 -0.012007 -0.035133 # node 663 --0.018056 -0.012476 -0.035392 # node 664 --0.018425 -0.012794 -0.036277 # node 665 --0.018795 -0.013112 -0.037161 # node 666 --0.019165 -0.013430 -0.038044 # node 667 --0.019534 -0.013748 -0.038929 # node 668 --0.019520 -0.014452 -0.039692 # node 669 --0.019506 -0.015157 -0.040454 # node 670 --0.019492 -0.015861 -0.041218 # node 671 --0.019478 -0.016566 -0.041980 # node 672 -0.004850 -0.012808 -0.027209 # node 673 -0.004705 -0.011965 -0.027473 # node 674 -0.004559 -0.011123 -0.027737 # node 675 -0.005190 -0.011218 -0.028589 # node 676 -0.005822 -0.011313 -0.029440 # node 677 -0.005666 -0.010427 -0.029783 # node 678 -0.005511 -0.009540 -0.030126 # node 679 -0.005356 -0.008654 -0.030468 # node 680 -0.005200 -0.007768 -0.030810 # node 681 -0.005045 -0.006882 -0.031153 # node 682 -0.004742 -0.006228 -0.031856 # node 683 -0.004440 -0.005574 -0.032559 # node 684 -0.004137 -0.004921 -0.033261 # node 685 -0.003834 -0.004267 -0.033964 # node 686 -0.003858 -0.003611 -0.034636 # node 687 -0.003882 -0.002955 -0.035307 # node 688 -0.003906 -0.002298 -0.035979 # node 689 -0.003930 -0.001642 -0.036650 # node 690 -0.003525 -0.000785 -0.036940 # node 691 -0.003120 0.000072 -0.037229 # node 692 -0.002715 0.000930 -0.037519 # node 693 -0.002310 0.001787 -0.037809 # node 694 -0.001905 0.002644 -0.038098 # node 695 -0.001500 0.003502 -0.038388 # node 696 -0.001095 0.004359 -0.038677 # node 697 -0.000811 0.005099 -0.039031 # node 698 -0.000526 0.005840 -0.039386 # node 699 -0.000241 0.006580 -0.039740 # node 700 --0.000043 0.007320 -0.040094 # node 701 --0.000490 0.007759 -0.040760 # node 702 --0.000937 0.008198 -0.041426 # node 703 --0.001383 0.008638 -0.042091 # node 704 --0.001830 0.009077 -0.042758 # node 705 --0.002277 0.009516 -0.043423 # node 706 --0.003024 0.009919 -0.043768 # node 707 --0.003771 0.010323 -0.044113 # node 708 --0.004518 0.010727 -0.044459 # node 709 --0.005265 0.011131 -0.044803 # node 710 --0.006012 0.011534 -0.045149 # node 711 --0.006759 0.011938 -0.045494 # node 712 --0.007506 0.012342 -0.045839 # node 713 --0.007203 0.013155 -0.046361 # node 714 --0.006900 0.013968 -0.046883 # node 715 --0.006597 0.014781 -0.047407 # node 716 --0.006060 0.015181 -0.048218 # node 717 --0.005523 0.015581 -0.049029 # node 718 --0.004986 0.015981 -0.049840 # node 719 --0.004045 0.016193 -0.050141 # node 720 --0.003105 0.016406 -0.050442 # node 721 --0.002887 0.017209 -0.051026 # node 722 --0.002670 0.018012 -0.051610 # node 723 --0.002452 0.018815 -0.052193 # node 724 --0.007033 0.011715 -0.046104 # node 725 --0.006561 0.011087 -0.046370 # node 726 --0.005602 0.011114 -0.046359 # node 727 --0.004644 0.011141 -0.046347 # node 728 --0.003686 0.011168 -0.046334 # node 729 --0.003323 0.012091 -0.046211 # node 730 --0.002959 0.013014 -0.046087 # node 731 --0.002596 0.013936 -0.045962 # node 732 --0.002233 0.014859 -0.045839 # node 733 --0.001870 0.015782 -0.045714 # node 734 --0.001506 0.016704 -0.045590 # node 735 --0.001143 0.017627 -0.045467 # node 736 --0.000780 0.018550 -0.045342 # node 737 -0.000098 0.018566 -0.045660 # node 738 -0.000975 0.018582 -0.045978 # node 739 -0.001852 0.018598 -0.046296 # node 740 --0.002777 0.010074 -0.043093 # node 741 --0.003276 0.010633 -0.042764 # node 742 --0.003776 0.011191 -0.042436 # node 743 --0.004276 0.011750 -0.042107 # node 744 --0.004776 0.012308 -0.041778 # node 745 --0.005644 0.012743 -0.041583 # node 746 --0.006513 0.013177 -0.041389 # node 747 --0.007381 0.013612 -0.041196 # node 748 --0.008250 0.014047 -0.041001 # node 749 --0.009212 0.014197 -0.041101 # node 750 --0.010173 0.014347 -0.041201 # node 751 --0.011135 0.014498 -0.041301 # node 752 --0.012097 0.014648 -0.041401 # node 753 --0.013058 0.014798 -0.041500 # node 754 --0.013838 0.014636 -0.041683 # node 755 --0.014617 0.014474 -0.041867 # node 756 --0.015396 0.014311 -0.042050 # node 757 --0.016175 0.014149 -0.042233 # node 758 --0.016954 0.013986 -0.042417 # node 759 --0.017333 0.013468 -0.043054 # node 760 --0.017713 0.012950 -0.043691 # node 761 --0.018092 0.012432 -0.044329 # node 762 --0.018269 0.012042 -0.045190 # node 763 --0.018446 0.011653 -0.046052 # node 764 --0.018623 0.011263 -0.046913 # node 765 --0.018800 0.010873 -0.047774 # node 766 -0.003926 -0.001583 -0.037582 # node 767 -0.003922 -0.001524 -0.038514 # node 768 -0.003919 -0.001464 -0.039447 # node 769 -0.003033 -0.001382 -0.039631 # node 770 -0.002148 -0.001299 -0.039816 # node 771 -0.001262 -0.001216 -0.040000 # node 772 -0.000377 -0.001134 -0.040183 # node 773 --0.000508 -0.001051 -0.040368 # node 774 --0.001394 -0.000968 -0.040552 # node 775 --0.002279 -0.000886 -0.040737 # node 776 --0.003164 -0.000803 -0.040921 # node 777 --0.003650 -0.000072 -0.041429 # node 778 --0.004136 0.000660 -0.041937 # node 779 --0.004622 0.001391 -0.042444 # node 780 --0.005108 0.002123 -0.042952 # node 781 --0.005849 0.002683 -0.042761 # node 782 --0.006589 0.003243 -0.042569 # node 783 --0.007330 0.003803 -0.042377 # node 784 --0.008071 0.004363 -0.042184 # node 785 --0.008812 0.004923 -0.041993 # node 786 --0.009784 0.004762 -0.042178 # node 787 --0.010756 0.004601 -0.042362 # node 788 --0.011728 0.004440 -0.042548 # node 789 --0.012038 0.003689 -0.043013 # node 790 --0.012349 0.002938 -0.043480 # node 791 --0.012659 0.002187 -0.043947 # node 792 --0.012969 0.001436 -0.044412 # node 793 --0.013279 0.000685 -0.044879 # node 794 --0.013576 -0.000114 -0.045320 # node 795 --0.013873 -0.000914 -0.045761 # node 796 --0.014151 -0.001498 -0.046430 # node 797 --0.014429 -0.002083 -0.047099 # node 798 --0.014707 -0.002667 -0.047768 # node 799 --0.014986 -0.003251 -0.048437 # node 800 --0.015030 -0.003936 -0.048874 # node 801 --0.015073 -0.004622 -0.049311 # node 802 --0.015117 -0.005307 -0.049748 # node 803 --0.015161 -0.005992 -0.050186 # node 804 --0.015840 -0.006284 -0.050638 # node 805 --0.016519 -0.006576 -0.051091 # node 806 --0.017198 -0.006868 -0.051543 # node 807 --0.017822 -0.006431 -0.051816 # node 808 --0.018445 -0.005995 -0.052088 # node 809 --0.019068 -0.005558 -0.052360 # node 810 --0.019692 -0.005121 -0.052632 # node 811 --0.020175 -0.004765 -0.053451 # node 812 --0.020658 -0.004410 -0.054270 # node 813 --0.021140 -0.004055 -0.055089 # node 814 --0.021623 -0.003700 -0.055908 # node 815 --0.022106 -0.003345 -0.056727 # node 816 --0.022589 -0.002989 -0.057546 # node 817 --0.023072 -0.002634 -0.058366 # node 818 --0.023555 -0.002279 -0.059184 # node 819 --0.024038 -0.001923 -0.060003 # node 820 --0.024521 -0.001568 -0.060822 # node 821 --0.024512 -0.001998 -0.061643 # node 822 --0.024504 -0.002428 -0.062463 # node 823 --0.024496 -0.002858 -0.063284 # node 824 --0.024488 -0.003287 -0.064106 # node 825 --0.024432 -0.003465 -0.065046 # node 826 --0.024377 -0.003642 -0.065987 # node 827 --0.024322 -0.003820 -0.066927 # node 828 --0.024267 -0.003997 -0.067868 # node 829 --0.024212 -0.004174 -0.068808 # node 830 --0.024193 -0.004365 -0.069714 # node 831 --0.024175 -0.004555 -0.070621 # node 832 --0.024157 -0.004745 -0.071528 # node 833 --0.024138 -0.004935 -0.072433 # node 834 --0.024120 -0.005125 -0.073340 # node 835 -0.005241 -0.014382 -0.026617 # node 836 -0.005486 -0.015114 -0.026288 # node 837 -0.005731 -0.015846 -0.025958 # node 838 -0.005976 -0.016578 -0.025629 # node 839 -0.005918 -0.017101 -0.025736 # node 840 -0.005860 -0.017625 -0.025842 # node 841 -0.005908 -0.018160 -0.025999 # node 842 -0.005956 -0.018694 -0.026154 # node 843 -0.005467 -0.019456 -0.026546 # node 844 -0.004978 -0.020217 -0.026937 # node 845 -0.004148 -0.020483 -0.026947 # node 846 -0.003317 -0.020748 -0.026957 # node 847 -0.002556 -0.020891 -0.027376 # node 848 -0.001796 -0.021033 -0.027793 # node 849 -0.001087 -0.020991 -0.028186 # node 850 -0.000379 -0.020949 -0.028579 # node 851 --0.000330 -0.020907 -0.028971 # node 852 --0.001089 -0.021010 -0.029217 # node 853 --0.001847 -0.021113 -0.029462 # node 854 --0.002605 -0.021217 -0.029708 # node 855 --0.003364 -0.021320 -0.029953 # node 856 --0.003673 -0.021714 -0.030501 # node 857 --0.003982 -0.022108 -0.031048 # node 858 --0.004291 -0.022502 -0.031596 # node 859 --0.004766 -0.023347 -0.031780 # node 860 --0.005242 -0.024192 -0.031966 # node 861 --0.005717 -0.025036 -0.032150 # node 862 --0.006379 -0.025499 -0.032331 # node 863 --0.007041 -0.025962 -0.032511 # node 864 --0.007703 -0.026425 -0.032692 # node 865 --0.008420 -0.026673 -0.033180 # node 866 --0.009137 -0.026920 -0.033669 # node 867 --0.009854 -0.027168 -0.034157 # node 868 --0.009838 -0.027387 -0.035120 # node 869 --0.009821 -0.027606 -0.036083 # node 870 --0.010652 -0.027566 -0.036483 # node 871 --0.011482 -0.027527 -0.036882 # node 872 --0.012312 -0.027487 -0.037281 # node 873 --0.013001 -0.027132 -0.037122 # node 874 --0.013691 -0.026777 -0.036963 # node 875 --0.014380 -0.026422 -0.036804 # node 876 --0.014810 -0.025944 -0.037060 # node 877 --0.015241 -0.025465 -0.037316 # node 878 --0.015586 -0.024876 -0.037696 # node 879 --0.015930 -0.024286 -0.038076 # node 880 --0.016487 -0.023804 -0.037736 # node 881 --0.017044 -0.023321 -0.037394 # node 882 --0.017600 -0.022839 -0.037053 # node 883 --0.004410 -0.021868 -0.032009 # node 884 --0.004530 -0.021235 -0.032422 # node 885 --0.004649 -0.020601 -0.032834 # node 886 --0.003925 -0.020190 -0.033390 # node 887 --0.003201 -0.019780 -0.033944 # node 888 --0.002478 -0.019369 -0.034499 # node 889 --0.001754 -0.018959 -0.035054 # node 890 --0.001031 -0.018548 -0.035609 # node 891 --0.000541 -0.017857 -0.036132 # node 892 --0.000051 -0.017165 -0.036656 # node 893 -0.000439 -0.016474 -0.037179 # node 894 -0.000829 -0.016014 -0.037698 # node 895 -0.001218 -0.015554 -0.038217 # node 896 -0.001607 -0.015094 -0.038736 # node 897 -0.001647 -0.014790 -0.039659 # node 898 -0.001687 -0.014485 -0.040583 # node 899 -0.001726 -0.014180 -0.041507 # node 900 -0.001009 -0.014057 -0.042027 # node 901 -0.000291 -0.013933 -0.042546 # node 902 --0.000427 -0.013810 -0.043066 # node 903 --0.001144 -0.013686 -0.043586 # node 904 --0.001752 -0.014122 -0.043866 # node 905 --0.002360 -0.014558 -0.044147 # node 906 --0.002967 -0.014993 -0.044428 # node 907 --0.003575 -0.015429 -0.044708 # node 908 --0.004308 -0.015677 -0.045010 # node 909 --0.005041 -0.015924 -0.045312 # node 910 --0.005825 -0.016202 -0.044931 # node 911 --0.006609 -0.016479 -0.044549 # node 912 --0.006680 -0.017106 -0.044020 # node 913 --0.006750 -0.017733 -0.043491 # node 914 --0.006821 -0.018360 -0.042963 # node 915 --0.006075 -0.018676 -0.043200 # node 916 --0.005330 -0.018992 -0.043437 # node 917 --0.004584 -0.019308 -0.043673 # node 918 --0.003838 -0.019623 -0.043910 # node 919 --0.003093 -0.019939 -0.044146 # node 920 --0.002446 -0.020417 -0.044381 # node 921 --0.001800 -0.020895 -0.044616 # node 922 --0.001154 -0.021372 -0.044850 # node 923 --0.000507 -0.021850 -0.045086 # node 924 --0.000348 -0.021800 -0.045938 # node 925 --0.000189 -0.021749 -0.046791 # node 926 --0.000030 -0.021698 -0.047643 # node 927 -0.000129 -0.021648 -0.048496 # node 928 --0.000630 -0.021778 -0.049140 # node 929 --0.001389 -0.021909 -0.049784 # node 930 --0.002149 -0.022040 -0.050429 # node 931 --0.002895 -0.022173 -0.050778 # node 932 --0.003642 -0.022307 -0.051126 # node 933 --0.004388 -0.022440 -0.051473 # node 934 --0.005135 -0.022573 -0.051822 # node 935 --0.006040 -0.022544 -0.052043 # node 936 --0.006945 -0.022515 -0.052266 # node 937 --0.007851 -0.022486 -0.052487 # node 938 --0.008756 -0.022457 -0.052709 # node 939 --0.009661 -0.022428 -0.052930 # node 940 --0.010567 -0.022399 -0.053152 # node 941 -0.005278 -0.014060 -0.027723 # node 942 -0.005560 -0.014469 -0.028502 # node 943 -0.005841 -0.014879 -0.029280 # node 944 -0.006123 -0.015288 -0.030058 # node 945 -0.006557 -0.015457 -0.030743 # node 946 -0.006991 -0.015625 -0.031430 # node 947 -0.007425 -0.015794 -0.032116 # node 948 -0.007962 -0.016105 -0.032781 # node 949 -0.008499 -0.016416 -0.033447 # node 950 -0.009035 -0.016727 -0.034112 # node 951 -0.009351 -0.016898 -0.034780 # node 952 -0.009666 -0.017068 -0.035449 # node 953 -0.009981 -0.017238 -0.036118 # node 954 -0.005419 -0.013746 -0.019752 # node 955 -0.005937 -0.014327 -0.019308 # node 956 -0.006456 -0.014909 -0.018863 # node 957 -0.006975 -0.015490 -0.018419 # node 958 -0.007494 -0.016071 -0.017974 # node 959 -0.007645 -0.016713 -0.018570 # node 960 -0.007797 -0.017354 -0.019167 # node 961 -0.007948 -0.017996 -0.019762 # node 962 -0.008100 -0.018637 -0.020358 # node 963 -0.008905 -0.019016 -0.020768 # node 964 -0.009711 -0.019395 -0.021179 # node 965 -0.010516 -0.019774 -0.021589 # node 966 -0.011322 -0.020153 -0.022000 # node 967 -0.012127 -0.020532 -0.022411 # node 968 -0.012933 -0.020910 -0.022821 # node 969 -0.013710 -0.020813 -0.023377 # node 970 -0.014488 -0.020715 -0.023932 # node 971 -0.015265 -0.020618 -0.024488 # node 972 -0.016043 -0.020520 -0.025044 # node 973 -0.016821 -0.020423 -0.025600 # node 974 -0.017598 -0.020325 -0.026156 # node 975 -0.018376 -0.020228 -0.026711 # node 976 -0.019071 -0.019628 -0.026941 # node 977 -0.019766 -0.019029 -0.027171 # node 978 -0.020461 -0.018429 -0.027401 # node 979 -0.021156 -0.017830 -0.027631 # node 980 -0.021852 -0.017231 -0.027861 # node 981 -0.022547 -0.016631 -0.028091 # node 982 -0.023242 -0.016032 -0.028321 # node 983 -0.023937 -0.015432 -0.028551 # node 984 -0.023547 -0.014944 -0.029140 # node 985 -0.023157 -0.014455 -0.029729 # node 986 -0.022768 -0.013966 -0.030318 # node 987 -0.022378 -0.013478 -0.030907 # node 988 -0.021647 -0.012998 -0.031149 # node 989 -0.020917 -0.012518 -0.031391 # node 990 -0.020186 -0.012038 -0.031633 # node 991 -0.019456 -0.011558 -0.031876 # node 992 -0.019835 -0.011120 -0.032654 # node 993 -0.020214 -0.010682 -0.033434 # node 994 -0.020594 -0.010244 -0.034213 # node 995 -0.020022 -0.010011 -0.034527 # node 996 -0.019451 -0.009779 -0.034840 # node 997 -0.018880 -0.009546 -0.035153 # node 998 -0.018045 -0.009777 -0.035137 # node 999 -0.017210 -0.010009 -0.035119 # node 1000 -0.016433 -0.010057 -0.035534 # node 1001 -0.015657 -0.010105 -0.035950 # node 1002 -0.014995 -0.010158 -0.036101 # node 1003 -0.014333 -0.010211 -0.036253 # node 1004 -0.013671 -0.010263 -0.036406 # node 1005 -0.013950 -0.009822 -0.036904 # node 1006 -0.014229 -0.009380 -0.037403 # node 1007 -0.014509 -0.008939 -0.037903 # node 1008 -0.015308 -0.009014 -0.038378 # node 1009 -0.016106 -0.009089 -0.038851 # node 1010 -0.016352 -0.009569 -0.039574 # node 1011 -0.016598 -0.010050 -0.040297 # node 1012 -0.016844 -0.010530 -0.041020 # node 1013 -0.017510 -0.010074 -0.041261 # node 1014 -0.018177 -0.009617 -0.041502 # node 1015 -0.018843 -0.009160 -0.041743 # node 1016 -0.019510 -0.008703 -0.041984 # node 1017 -0.017915 -0.020699 -0.026078 # node 1018 -0.017454 -0.021169 -0.025443 # node 1019 -0.016993 -0.021640 -0.024810 # node 1020 -0.016533 -0.022111 -0.024177 # node 1021 -0.015732 -0.022480 -0.023918 # node 1022 -0.014931 -0.022849 -0.023659 # node 1023 -0.014130 -0.023218 -0.023400 # node 1024 -0.013318 -0.023049 -0.023579 # node 1025 -0.012506 -0.022879 -0.023758 # node 1026 -0.011694 -0.022709 -0.023938 # node 1027 -0.010882 -0.022539 -0.024117 # node 1028 -0.010033 -0.022842 -0.023892 # node 1029 -0.009184 -0.023144 -0.023668 # node 1030 -0.008334 -0.023446 -0.023443 # node 1031 -0.008609 -0.023936 -0.024198 # node 1032 -0.008883 -0.024425 -0.024951 # node 1033 -0.009157 -0.024914 -0.025706 # node 1034 -0.009431 -0.025403 -0.026460 # node 1035 -0.009433 -0.026253 -0.026187 # node 1036 -0.007351 -0.016309 -0.018859 # node 1037 -0.007208 -0.016548 -0.019742 # node 1038 -0.007066 -0.016786 -0.020627 # node 1039 -0.007594 -0.017359 -0.021237 # node 1040 -0.008122 -0.017933 -0.021846 # node 1041 -0.008649 -0.018506 -0.022456 # node 1042 -0.009177 -0.019080 -0.023066 # node 1043 -0.009934 -0.018929 -0.023569 # node 1044 -0.010691 -0.018778 -0.024073 # node 1045 -0.011448 -0.018628 -0.024577 # node 1046 -0.011970 -0.018807 -0.025502 # node 1047 -0.012493 -0.018986 -0.026429 # node 1048 -0.013015 -0.019166 -0.027356 # node 1049 -0.013537 -0.019345 -0.028282 # node 1050 -0.014313 -0.019664 -0.028752 # node 1051 -0.015089 -0.019983 -0.029222 # node 1052 -0.015865 -0.020301 -0.029693 # node 1053 -0.016640 -0.020620 -0.030163 # node 1054 -0.017338 -0.020601 -0.030352 # node 1055 -0.018035 -0.020582 -0.030542 # node 1056 -0.018732 -0.020562 -0.030732 # node 1057 -0.019474 -0.020420 -0.031322 # node 1058 -0.020217 -0.020277 -0.031913 # node 1059 -0.020960 -0.020135 -0.032504 # node 1060 -0.021043 -0.020208 -0.033564 # node 1061 -0.021127 -0.020282 -0.034623 # node 1062 -0.002367 -0.009682 -0.016940 # node 1063 -0.001692 -0.010094 -0.017311 # node 1064 -0.001017 -0.010506 -0.017682 # node 1065 -0.000342 -0.010918 -0.018054 # node 1066 --0.000333 -0.011330 -0.018426 # node 1067 --0.001008 -0.011742 -0.018798 # node 1068 --0.001746 -0.012079 -0.018836 # node 1069 --0.002483 -0.012416 -0.018873 # node 1070 --0.003221 -0.012753 -0.018912 # node 1071 --0.003928 -0.012940 -0.018834 # node 1072 --0.004634 -0.013127 -0.018757 # node 1073 --0.005341 -0.013314 -0.018679 # node 1074 --0.005900 -0.013778 -0.018434 # node 1075 --0.006458 -0.014241 -0.018191 # node 1076 --0.007017 -0.014705 -0.017947 # node 1077 --0.007575 -0.015168 -0.017703 # node 1078 --0.008202 -0.015432 -0.017572 # node 1079 --0.008829 -0.015696 -0.017442 # node 1080 --0.009456 -0.015960 -0.017312 # node 1081 --0.010176 -0.016028 -0.017632 # node 1082 --0.010897 -0.016097 -0.017953 # node 1083 --0.011617 -0.016166 -0.018273 # node 1084 --0.011764 -0.016262 -0.019169 # node 1085 --0.011910 -0.016359 -0.020064 # node 1086 --0.012130 -0.016846 -0.020436 # node 1087 --0.012350 -0.017332 -0.020808 # node 1088 --0.012315 -0.017922 -0.021332 # node 1089 --0.012279 -0.018513 -0.021857 # node 1090 --0.012244 -0.019103 -0.022382 # node 1091 --0.012685 -0.019466 -0.023133 # node 1092 --0.013125 -0.019829 -0.023886 # node 1093 --0.013565 -0.020193 -0.024638 # node 1094 --0.014150 -0.020564 -0.025341 # node 1095 --0.014734 -0.020935 -0.026043 # node 1096 --0.015318 -0.021306 -0.026747 # node 1097 --0.016037 -0.021607 -0.026864 # node 1098 --0.016756 -0.021907 -0.026982 # node 1099 --0.017475 -0.022207 -0.027100 # node 1100 --0.017594 -0.022746 -0.027516 # node 1101 --0.017714 -0.023285 -0.027931 # node 1102 --0.017656 -0.023509 -0.028723 # node 1103 --0.017597 -0.023734 -0.029516 # node 1104 --0.017539 -0.023958 -0.030308 # node 1105 --0.016926 -0.024402 -0.030580 # node 1106 --0.016312 -0.024847 -0.030852 # node 1107 --0.015699 -0.025291 -0.031126 # node 1108 --0.015064 -0.025670 -0.031332 # node 1109 --0.014428 -0.026049 -0.031539 # node 1110 --0.013792 -0.026428 -0.031746 # node 1111 --0.013210 -0.026917 -0.031936 # node 1112 --0.012629 -0.027406 -0.032126 # node 1113 --0.012047 -0.027895 -0.032316 # node 1114 --0.011212 -0.028335 -0.032142 # node 1115 --0.010377 -0.028775 -0.031969 # node 1116 --0.009543 -0.029216 -0.031794 # node 1117 --0.008708 -0.029656 -0.031621 # node 1118 --0.008052 -0.029005 -0.031980 # node 1119 --0.007397 -0.028354 -0.032340 # node 1120 --0.006742 -0.027703 -0.032699 # node 1121 --0.006804 -0.028226 -0.033569 # node 1122 -0.002553 -0.009857 -0.017191 # node 1123 -0.002064 -0.010445 -0.017814 # node 1124 -0.001575 -0.011032 -0.018438 # node 1125 -0.001085 -0.011619 -0.019061 # node 1126 -0.000596 -0.012207 -0.019684 # node 1127 -0.000258 -0.012984 -0.019854 # node 1128 --0.000079 -0.013761 -0.020024 # node 1129 --0.000417 -0.014537 -0.020194 # node 1130 --0.000784 -0.015181 -0.020307 # node 1131 --0.001151 -0.015825 -0.020419 # node 1132 --0.001519 -0.016469 -0.020530 # node 1133 --0.001838 -0.017191 -0.020707 # node 1134 --0.002157 -0.017913 -0.020883 # node 1135 --0.002477 -0.018635 -0.021059 # node 1136 --0.003378 -0.018981 -0.021348 # node 1137 --0.004280 -0.019328 -0.021636 # node 1138 --0.005073 -0.019693 -0.021616 # node 1139 --0.005866 -0.020059 -0.021594 # node 1140 --0.006659 -0.020425 -0.021574 # node 1141 --0.007319 -0.020371 -0.021972 # node 1142 --0.007979 -0.020318 -0.022369 # node 1143 --0.008639 -0.020264 -0.022767 # node 1144 --0.009074 -0.020816 -0.022983 # node 1145 --0.009508 -0.021368 -0.023199 # node 1146 --0.010133 -0.021292 -0.023673 # node 1147 --0.010758 -0.021215 -0.024148 # node 1148 --0.011331 -0.021218 -0.024557 # node 1149 --0.011904 -0.021220 -0.024966 # node 1150 --0.012478 -0.021222 -0.025374 # node 1151 --0.013084 -0.021208 -0.025811 # node 1152 --0.013689 -0.021193 -0.026249 # node 1153 --0.014295 -0.021179 -0.026686 # node 1154 --0.014998 -0.021075 -0.026974 # node 1155 --0.015701 -0.020972 -0.027263 # node 1156 --0.016403 -0.020868 -0.027552 # node 1157 --0.017106 -0.020764 -0.027841 # node 1158 --0.017627 -0.021000 -0.028263 # node 1159 --0.018148 -0.021235 -0.028687 # node 1160 --0.018669 -0.021470 -0.029109 # node 1161 --0.018706 -0.021497 -0.029918 # node 1162 --0.018743 -0.021523 -0.030727 # node 1163 --0.019263 -0.021055 -0.031114 # node 1164 --0.019783 -0.020587 -0.031502 # node 1165 --0.020303 -0.020119 -0.031890 # node 1166 --0.020229 -0.019513 -0.032400 # node 1167 --0.020155 -0.018907 -0.032911 # node 1168 --0.020081 -0.018301 -0.033421 # node 1169 --0.019739 -0.017583 -0.033927 # node 1170 --0.019396 -0.016865 -0.034431 # node 1171 --0.019054 -0.016147 -0.034937 # node 1172 --0.018423 -0.015389 -0.035012 # node 1173 --0.017792 -0.014631 -0.035088 # node 1174 --0.017161 -0.013873 -0.035163 # node 1175 --0.016530 -0.013116 -0.035240 # node 1176 --0.015898 -0.012358 -0.035316 # node 1177 --0.015267 -0.011600 -0.035391 # node 1178 --0.014636 -0.010842 -0.035468 # node 1179 --0.013940 -0.010658 -0.034889 # node 1180 --0.013243 -0.010474 -0.034310 # node 1181 --0.012549 -0.010310 -0.034304 # node 1182 --0.011854 -0.010146 -0.034300 # node 1183 --0.011160 -0.009982 -0.034296 # node 1184 --0.010612 -0.009570 -0.034836 # node 1185 --0.010064 -0.009158 -0.035374 # node 1186 --0.010107 -0.008672 -0.036260 # node 1187 --0.010150 -0.008186 -0.037146 # node 1188 --0.010193 -0.007700 -0.038030 # node 1189 --0.010235 -0.007213 -0.038916 # node 1190 --0.010278 -0.006727 -0.039801 # node 1191 --0.009668 -0.021231 -0.023979 # node 1192 --0.009826 -0.021094 -0.024758 # node 1193 --0.009985 -0.020957 -0.025538 # node 1194 --0.009999 -0.021786 -0.025558 # node 1195 --0.010013 -0.022614 -0.025578 # node 1196 --0.010027 -0.023443 -0.025598 # node 1197 --0.009963 -0.023577 -0.026163 # node 1198 --0.009898 -0.023710 -0.026728 # node 1199 --0.009481 -0.023532 -0.027281 # node 1200 --0.009063 -0.023354 -0.027833 # node 1201 --0.008645 -0.023176 -0.028386 # node 1202 --0.008064 -0.023218 -0.028844 # node 1203 --0.007484 -0.023260 -0.029303 # node 1204 --0.006903 -0.023302 -0.029762 # node 1205 -0.003217 -0.008875 -0.015594 # node 1206 -0.003392 -0.008479 -0.014621 # node 1207 -0.003567 -0.008084 -0.013649 # node 1208 -0.003742 -0.007689 -0.012676 # node 1209 -0.004351 -0.007349 -0.012140 # node 1210 -0.004960 -0.007010 -0.011603 # node 1211 -0.005613 -0.006444 -0.011300 # node 1212 -0.006267 -0.005878 -0.010995 # node 1213 -0.006920 -0.005312 -0.010691 # node 1214 -0.007589 -0.004771 -0.010645 # node 1215 -0.008258 -0.004231 -0.010599 # node 1216 -0.008683 -0.003898 -0.010280 # node 1217 -0.009107 -0.003565 -0.009962 # node 1218 -0.009534 -0.003157 -0.009552 # node 1219 -0.009961 -0.002748 -0.009142 # node 1220 -0.010389 -0.002339 -0.008733 # node 1221 -0.011211 -0.002270 -0.009063 # node 1222 -0.012033 -0.002200 -0.009394 # node 1223 -0.012856 -0.002130 -0.009724 # node 1224 -0.013678 -0.002060 -0.010055 # node 1225 -0.014301 -0.001512 -0.010304 # node 1226 -0.014925 -0.000964 -0.010553 # node 1227 -0.015548 -0.000417 -0.010802 # node 1228 -0.016171 0.000131 -0.011050 # node 1229 -0.016795 0.000679 -0.011299 # node 1230 -0.017418 0.001227 -0.011549 # node 1231 -0.017621 0.001645 -0.012452 # node 1232 -0.017823 0.002063 -0.013356 # node 1233 -0.018026 0.002481 -0.014259 # node 1234 -0.018229 0.002899 -0.015163 # node 1235 -0.018431 0.003317 -0.016067 # node 1236 -0.018634 0.003735 -0.016970 # node 1237 -0.019142 0.004266 -0.017602 # node 1238 -0.019651 0.004798 -0.018234 # node 1239 -0.020159 0.005330 -0.018867 # node 1240 -0.020667 0.005861 -0.019500 # node 1241 -0.021175 0.006393 -0.020132 # node 1242 -0.021195 0.006536 -0.021079 # node 1243 -0.021216 0.006680 -0.022026 # node 1244 -0.021236 0.006823 -0.022972 # node 1245 -0.021257 0.006966 -0.023919 # node 1246 -0.021089 0.007063 -0.024742 # node 1247 -0.020922 0.007160 -0.025564 # node 1248 -0.020755 0.007257 -0.026388 # node 1249 -0.020492 0.007165 -0.027402 # node 1250 -0.020229 0.007073 -0.028417 # node 1251 -0.019966 0.006981 -0.029431 # node 1252 -0.018972 0.003341 -0.017843 # node 1253 -0.019310 0.002947 -0.018716 # node 1254 -0.019648 0.002553 -0.019589 # node 1255 -0.019985 0.002159 -0.020462 # node 1256 -0.020323 0.001765 -0.021336 # node 1257 -0.020661 0.001371 -0.022208 # node 1258 -0.020999 0.000977 -0.023081 # node 1259 -0.021337 0.000583 -0.023954 # node 1260 -0.020965 0.000191 -0.024813 # node 1261 -0.020594 -0.000202 -0.025672 # node 1262 -0.020222 -0.000594 -0.026532 # node 1263 -0.003282 -0.009398 -0.015540 # node 1264 -0.003523 -0.009526 -0.014512 # node 1265 -0.003763 -0.009654 -0.013486 # node 1266 -0.003183 -0.009313 -0.012801 # node 1267 -0.002603 -0.008973 -0.012117 # node 1268 -0.002023 -0.008632 -0.011433 # node 1269 -0.001466 -0.008377 -0.010929 # node 1270 -0.000909 -0.008121 -0.010425 # node 1271 -0.000353 -0.007865 -0.009921 # node 1272 --0.000204 -0.007610 -0.009417 # node 1273 --0.000936 -0.008013 -0.009419 # node 1274 --0.001668 -0.008417 -0.009422 # node 1275 --0.002400 -0.008820 -0.009424 # node 1276 --0.003133 -0.009224 -0.009426 # node 1277 --0.004001 -0.008973 -0.009872 # node 1278 --0.004870 -0.008723 -0.010318 # node 1279 --0.005149 -0.008465 -0.010882 # node 1280 --0.005428 -0.008206 -0.011447 # node 1281 --0.005971 -0.007963 -0.011554 # node 1282 --0.006513 -0.007719 -0.011662 # node 1283 --0.006138 -0.007363 -0.012327 # node 1284 --0.005764 -0.007007 -0.012992 # node 1285 --0.005389 -0.006651 -0.013657 # node 1286 --0.005639 -0.006286 -0.014461 # node 1287 --0.005890 -0.005922 -0.015264 # node 1288 --0.006643 -0.008088 -0.010929 # node 1289 --0.006773 -0.008457 -0.010196 # node 1290 --0.006785 -0.009145 -0.010277 # node 1291 --0.006798 -0.009834 -0.010358 # node 1292 --0.007258 -0.010179 -0.010862 # node 1293 --0.007718 -0.010525 -0.011366 # node 1294 --0.008178 -0.010870 -0.011869 # node 1295 --0.008157 -0.010666 -0.012726 # node 1296 --0.008136 -0.010462 -0.013582 # node 1297 --0.008115 -0.010257 -0.014439 # node 1298 --0.008806 -0.010073 -0.014634 # node 1299 --0.009497 -0.009888 -0.014830 # node 1300 --0.010188 -0.009703 -0.015026 # node 1301 -0.003252 -0.009864 -0.016042 # node 1302 -0.003463 -0.010458 -0.015516 # node 1303 -0.003673 -0.011052 -0.014989 # node 1304 -0.003883 -0.011646 -0.014463 # node 1305 -0.003342 -0.012283 -0.014304 # node 1306 -0.002800 -0.012919 -0.014146 # node 1307 -0.002258 -0.013555 -0.013987 # node 1308 -0.001716 -0.014192 -0.013827 # node 1309 -0.001366 -0.014998 -0.014066 # node 1310 -0.001016 -0.015805 -0.014304 # node 1311 -0.000665 -0.016611 -0.014543 # node 1312 -0.000315 -0.017417 -0.014782 # node 1313 -0.000561 -0.018280 -0.014831 # node 1314 -0.000806 -0.019142 -0.014880 # node 1315 -0.001052 -0.020005 -0.014930 # node 1316 -0.001298 -0.020867 -0.014979 # node 1317 -0.001544 -0.021729 -0.015028 # node 1318 -0.001565 -0.022543 -0.015348 # node 1319 -0.001586 -0.023357 -0.015667 # node 1320 -0.001607 -0.024170 -0.015986 # node 1321 -0.001628 -0.024984 -0.016306 # node 1322 -0.001650 -0.025798 -0.016624 # node 1323 -0.001671 -0.026611 -0.016944 # node 1324 -0.001692 -0.027425 -0.017263 # node 1325 -0.002174 -0.027931 -0.017971 # node 1326 -0.002655 -0.028438 -0.018680 # node 1327 -0.003137 -0.028944 -0.019388 # node 1328 -0.003619 -0.029451 -0.020096 # node 1329 -0.003671 -0.029680 -0.020947 # node 1330 -0.003722 -0.029909 -0.021798 # node 1331 -0.003774 -0.030139 -0.022649 # node 1332 -0.003826 -0.030368 -0.023500 # node 1333 -0.002997 -0.030398 -0.023992 # node 1334 -0.002167 -0.030429 -0.024486 # node 1335 -0.001338 -0.030459 -0.024978 # node 1336 -0.000518 -0.030420 -0.025176 # node 1337 --0.000302 -0.030381 -0.025373 # node 1338 --0.001122 -0.030342 -0.025572 # node 1339 -0.002225 -0.014818 -0.013688 # node 1340 -0.002733 -0.015443 -0.013548 # node 1341 -0.003242 -0.016069 -0.013409 # node 1342 -0.003750 -0.016695 -0.013269 # node 1343 -0.004280 -0.017205 -0.013013 # node 1344 -0.004811 -0.017714 -0.012758 # node 1345 -0.005342 -0.018224 -0.012502 # node 1346 -0.005872 -0.018734 -0.012247 # node 1347 -0.006491 -0.019397 -0.012003 # node 1348 -0.007109 -0.020059 -0.011759 # node 1349 -0.007727 -0.020722 -0.011514 # node 1350 -0.008245 -0.021328 -0.011471 # node 1351 -0.008762 -0.021934 -0.011429 # node 1352 -0.009280 -0.022540 -0.011386 # node 1353 -0.009797 -0.023145 -0.011343 # node 1354 -0.010668 -0.023327 -0.011636 # node 1355 -0.011539 -0.023509 -0.011927 # node 1356 -0.012410 -0.023692 -0.012219 # node 1357 -0.013281 -0.023874 -0.012511 # node 1358 -0.014152 -0.024056 -0.012802 # node 1359 -0.014689 -0.024035 -0.013464 # node 1360 -0.015225 -0.024014 -0.014126 # node 1361 -0.015762 -0.023993 -0.014787 # node 1362 -0.016299 -0.023973 -0.015448 # node 1363 -0.017143 -0.023849 -0.016003 # node 1364 -0.017987 -0.023726 -0.016559 # node 1365 -0.018831 -0.023602 -0.017114 # node 1366 -0.019233 -0.022775 -0.017309 # node 1367 -0.019636 -0.021948 -0.017503 # node 1368 -0.020039 -0.021121 -0.017698 # node 1369 -0.020441 -0.020294 -0.017892 # node 1370 -0.020844 -0.019467 -0.018087 # node 1371 -0.021105 -0.018939 -0.018914 # node 1372 -0.021367 -0.018411 -0.019743 # node 1373 -0.021628 -0.017883 -0.020571 # node 1374 -0.021890 -0.017355 -0.021399 # node 1375 -0.000381 -0.005699 -0.015153 # node 1376 --0.000375 -0.005537 -0.015474 # node 1377 --0.001131 -0.005376 -0.015797 # node 1378 --0.001887 -0.005214 -0.016118 # node 1379 --0.002718 -0.005092 -0.016043 # node 1380 --0.003549 -0.004969 -0.015968 # node 1381 --0.004380 -0.004847 -0.015893 # node 1382 --0.005211 -0.004724 -0.015819 # node 1383 --0.006023 -0.004828 -0.015900 # node 1384 --0.006835 -0.004931 -0.015981 # node 1385 --0.007647 -0.005034 -0.016062 # node 1386 --0.008393 -0.005468 -0.016162 # node 1387 --0.009140 -0.005901 -0.016262 # node 1388 --0.009887 -0.006334 -0.016361 # node 1389 --0.010713 -0.006613 -0.016762 # node 1390 --0.011539 -0.006892 -0.017162 # node 1391 --0.012365 -0.007171 -0.017563 # node 1392 --0.013191 -0.007450 -0.017963 # node 1393 --0.013968 -0.007976 -0.018079 # node 1394 --0.014746 -0.008503 -0.018193 # node 1395 --0.015523 -0.009029 -0.018309 # node 1396 --0.016087 -0.009159 -0.018793 # node 1397 --0.016651 -0.009289 -0.019279 # node 1398 --0.017215 -0.009419 -0.019764 # node 1399 --0.017911 -0.009764 -0.020063 # node 1400 --0.018607 -0.010109 -0.020361 # node 1401 --0.019303 -0.010454 -0.020659 # node 1402 --0.019935 -0.010541 -0.021166 # node 1403 --0.020566 -0.010627 -0.021672 # node 1404 --0.021198 -0.010713 -0.022179 # node 1405 --0.021829 -0.010799 -0.022686 # node 1406 --0.022312 -0.011260 -0.023293 # node 1407 --0.022795 -0.011721 -0.023902 # node 1408 --0.023277 -0.012181 -0.024510 # node 1409 --0.023760 -0.012642 -0.025119 # node 1410 --0.017413 -0.008938 -0.019978 # node 1411 --0.017610 -0.008456 -0.020191 # node 1412 --0.017363 -0.008911 -0.020917 # node 1413 --0.017116 -0.009366 -0.021642 # node 1414 --0.016869 -0.009821 -0.022369 # node 1415 --0.016622 -0.010276 -0.023094 # node 1416 --0.016375 -0.010731 -0.023820 # node 1417 -0.000182 -0.002975 -0.012363 # node 1418 -0.001040 -0.002726 -0.012566 # node 1419 -0.001047 -0.002250 -0.013363 # node 1420 -0.001751 -0.001902 -0.013967 # node 1421 -0.001781 -0.001563 -0.014792 # node 1422 -0.001810 -0.001224 -0.015618 # node 1423 -0.002389 -0.001373 -0.016413 # node 1424 -0.002967 -0.001521 -0.017209 # node 1425 -0.002980 -0.001801 -0.018248 # node 1426 -0.002994 -0.002081 -0.019286 # node 1427 -0.003007 -0.002360 -0.020324 # node 1428 -0.003378 -0.002432 -0.020823 # node 1429 -0.003749 -0.002503 -0.021322 # node 1430 -0.003896 -0.002582 -0.022391 # node 1431 -0.004043 -0.002660 -0.023460 # node 1432 -0.003786 -0.002932 -0.024286 # node 1433 -0.003529 -0.003204 -0.025112 # node 1434 -0.003272 -0.003476 -0.025939 # node 1435 -0.003014 -0.003748 -0.026766 # node 1436 -0.002383 -0.004142 -0.027402 # node 1437 -0.001752 -0.004536 -0.028039 # node 1438 --0.001339 -0.003044 -0.012376 # node 1439 --0.002002 -0.002864 -0.012589 # node 1440 --0.002665 -0.002684 -0.012801 # node 1441 --0.003125 -0.002607 -0.013486 # node 1442 --0.003780 -0.002773 -0.014183 # node 1443 --0.004436 -0.002939 -0.014880 # node 1444 --0.002779 -0.002498 -0.014309 # node 1445 --0.002433 -0.002388 -0.015131 # node 1446 --0.003031 -0.002507 -0.015506 # node 1447 --0.003629 -0.002626 -0.015880 # node 1448 --0.004227 -0.002745 -0.016254 # node 1449 --0.004645 -0.003167 -0.016447 # node 1450 --0.005063 -0.003590 -0.016640 # node 1451 --0.004922 -0.003620 -0.017466 # node 1452 --0.004074 -0.003807 -0.017728 # node 1453 --0.003227 -0.003994 -0.017990 # node 1454 --0.002791 -0.003606 -0.017601 # node 1455 --0.002354 -0.003217 -0.017213 # node 1456 --0.001941 -0.002814 -0.017398 # node 1457 --0.001529 -0.002410 -0.017583 # node 1458 --0.001534 -0.001604 -0.017930 # node 1459 --0.001539 -0.000798 -0.018276 # node 1460 --0.001544 0.000009 -0.018622 # node 1461 --0.001549 0.000815 -0.018968 # node 1462 --0.001519 0.001685 -0.019160 # node 1463 --0.001490 0.002554 -0.019352 # node 1464 --0.001460 0.003424 -0.019543 # node 1465 --0.005896 -0.003661 -0.016892 # node 1466 --0.006729 -0.003733 -0.017144 # node 1467 --0.007562 -0.003804 -0.017397 # node 1468 --0.008267 -0.003662 -0.017704 # node 1469 --0.008972 -0.003521 -0.018012 # node 1470 --0.009677 -0.003379 -0.018321 # node 1471 --0.010540 -0.003124 -0.018326 # node 1472 --0.011402 -0.002869 -0.018331 # node 1473 --0.012264 -0.002614 -0.018337 # node 1474 --0.012988 -0.002688 -0.018716 # node 1475 --0.013712 -0.002763 -0.019093 # node 1476 --0.014436 -0.002838 -0.019471 # node 1477 --0.015160 -0.002913 -0.019850 # node 1478 --0.015884 -0.002988 -0.020228 # node 1479 --0.016731 -0.003004 -0.020474 # node 1480 --0.017579 -0.003020 -0.020721 # node 1481 --0.018427 -0.003036 -0.020968 # node 1482 --0.019275 -0.003052 -0.021214 # node 1483 --0.020040 -0.002911 -0.021481 # node 1484 --0.020804 -0.002770 -0.021747 # node 1485 --0.021569 -0.002629 -0.022013 # node 1486 --0.022334 -0.002488 -0.022279 # node 1487 --0.023099 -0.002347 -0.022546 # node 1488 --0.023296 -0.001851 -0.023416 # node 1489 --0.023493 -0.001354 -0.024287 # node 1490 --0.023691 -0.000858 -0.025157 # node 1491 --0.023888 -0.000362 -0.026028 # node 1492 --0.024085 0.000135 -0.026899 # node 1493 --0.024283 0.000631 -0.027769 # node 1494 --0.019224 -0.002129 -0.021406 # node 1495 --0.019174 -0.001206 -0.021596 # node 1496 --0.019124 -0.000282 -0.021786 # node 1497 --0.019073 0.000641 -0.021977 # node 1498 --0.019023 0.001564 -0.022167 # node 1499 --0.018972 0.002487 -0.022357 # node 1500 --0.018922 0.003411 -0.022548 # node 1501 --0.018872 0.004334 -0.022738 # node 1502 --0.018264 0.004493 -0.023446 # node 1503 --0.017657 0.004652 -0.024153 # node 1504 --0.017050 0.004810 -0.024861 # node 1505 --0.016443 0.004969 -0.025569 # node 1506 --0.015836 0.005128 -0.026277 # node 1507 --0.016531 0.004850 -0.026786 # node 1508 --0.017227 0.004573 -0.027294 # node 1509 --0.017923 0.004295 -0.027803 # node 1510 --0.018618 0.004017 -0.028313 # node 1511 --0.019256 0.003445 -0.028472 # node 1512 --0.019894 0.002874 -0.028631 # node 1513 --0.019900 0.002042 -0.028957 # node 1514 --0.019906 0.001211 -0.029282 # node 1515 --0.019913 0.000379 -0.029608 # node 1516 --0.019919 -0.000453 -0.029933 # node 1517 --0.014876 0.005166 -0.026346 # node 1518 --0.013916 0.005203 -0.026414 # node 1519 --0.012956 0.005241 -0.026483 # node 1520 --0.011995 0.005278 -0.026552 # node 1521 --0.011035 0.005316 -0.026621 # node 1522 --0.012231 -0.001950 -0.018487 # node 1523 --0.012198 -0.001287 -0.018636 # node 1524 --0.012165 -0.000623 -0.018786 # node 1525 --0.012179 0.000191 -0.018580 # node 1526 --0.012193 0.001006 -0.018374 # node 1527 --0.012207 0.001820 -0.018169 # node 1528 --0.012221 0.002634 -0.017963 # node 1529 --0.012235 0.003449 -0.017758 # node 1530 --0.012249 0.004263 -0.017552 # node 1531 --0.001043 -0.000868 -0.010137 # node 1532 --0.001857 -0.000502 -0.010380 # node 1533 --0.002672 -0.000136 -0.010624 # node 1534 --0.003486 0.000229 -0.010867 # node 1535 --0.004300 0.000595 -0.011110 # node 1536 --0.005234 0.000763 -0.011397 # node 1537 --0.006168 0.000931 -0.011682 # node 1538 --0.006404 0.000929 -0.012206 # node 1539 --0.006640 0.000928 -0.012729 # node 1540 --0.007177 0.000713 -0.013241 # node 1541 --0.007715 0.000497 -0.013753 # node 1542 --0.008252 0.000282 -0.014266 # node 1543 --0.009106 0.000113 -0.014624 # node 1544 --0.010038 0.000087 -0.014563 # node 1545 --0.010969 0.000062 -0.014501 # node 1546 --0.011901 0.000036 -0.014440 # node 1547 --0.012833 0.000010 -0.014378 # node 1548 --0.013765 -0.000015 -0.014317 # node 1549 --0.014696 -0.000041 -0.014254 # node 1550 --0.015628 -0.000066 -0.014193 # node 1551 --0.009551 -0.000481 -0.014928 # node 1552 --0.009996 -0.001075 -0.015230 # node 1553 --0.010441 -0.001669 -0.015533 # node 1554 --0.010753 -0.002349 -0.015977 # node 1555 --0.011064 -0.003028 -0.016419 # node 1556 --0.011375 -0.003708 -0.016862 # node 1557 --0.006464 0.001504 -0.012158 # node 1558 --0.006759 0.002078 -0.012633 # node 1559 --0.007345 0.002428 -0.012829 # node 1560 --0.007930 0.002779 -0.013024 # node 1561 --0.008824 0.003120 -0.013278 # node 1562 --0.009719 0.003462 -0.013530 # node 1563 --0.010319 0.003835 -0.013720 # node 1564 --0.010920 0.004209 -0.013910 # node 1565 --0.011521 0.004582 -0.014101 # node 1566 --0.012339 0.004667 -0.014013 # node 1567 --0.013157 0.004753 -0.013926 # node 1568 --0.013975 0.004838 -0.013838 # node 1569 --0.014793 0.004923 -0.013751 # node 1570 --0.015610 0.005008 -0.013663 # node 1571 --0.004663 0.000643 -0.012006 # node 1572 --0.005025 0.000691 -0.012901 # node 1573 --0.005620 0.000639 -0.013792 # node 1574 --0.006214 0.000587 -0.014683 # node 1575 --0.006852 0.000452 -0.015193 # node 1576 --0.007489 0.000318 -0.015702 # node 1577 --0.008139 0.000167 -0.016108 # node 1578 --0.008789 0.000016 -0.016512 # node 1579 --0.009727 -0.000181 -0.016530 # node 1580 --0.010664 -0.000377 -0.016548 # node 1581 --0.011602 -0.000574 -0.016566 # node 1582 --0.012540 -0.000770 -0.016583 # node 1583 --0.012868 -0.000973 -0.017007 # node 1584 --0.013196 -0.001176 -0.017430 # node 1585 --0.014023 -0.001182 -0.017609 # node 1586 --0.014851 -0.001188 -0.017788 # node 1587 --0.015736 -0.001553 -0.017710 # node 1588 --0.016621 -0.001918 -0.017633 # node 1589 --0.016429 -0.002559 -0.018051 # node 1590 --0.016238 -0.003199 -0.018469 # node 1591 --0.016046 -0.003840 -0.018886 # node 1592 --0.015855 -0.004481 -0.019303 # node 1593 --0.016501 -0.004632 -0.019540 # node 1594 --0.017147 -0.004783 -0.019777 # node 1595 --0.017793 -0.004933 -0.020013 # node 1596 --0.000981 -0.001210 -0.010313 # node 1597 --0.001734 -0.001185 -0.010731 # node 1598 --0.002486 -0.001160 -0.011150 # node 1599 --0.003238 -0.001136 -0.011569 # node 1600 --0.003595 -0.000837 -0.012513 # node 1601 --0.004123 -0.000909 -0.013119 # node 1602 --0.004651 -0.000980 -0.013724 # node 1603 --0.004660 -0.001025 -0.014293 # node 1604 --0.004668 -0.001070 -0.014861 # node 1605 --0.005121 -0.001220 -0.015192 # node 1606 --0.005574 -0.001369 -0.015522 # node 1607 --0.005662 -0.001748 -0.016144 # node 1608 --0.005751 -0.002126 -0.016766 # node 1609 --0.006224 -0.002043 -0.017253 # node 1610 --0.006697 -0.001960 -0.017741 # node 1611 --0.007275 -0.001377 -0.018290 # node 1612 --0.007853 -0.000794 -0.018838 # node 1613 --0.008431 -0.000210 -0.019386 # node 1614 --0.009008 0.000373 -0.019933 # node 1615 --0.008480 0.000359 -0.020792 # node 1616 --0.007952 0.000344 -0.021651 # node 1617 --0.007657 0.001171 -0.021944 # node 1618 --0.007361 0.001997 -0.022237 # node 1619 --0.007066 0.002823 -0.022530 # node 1620 --0.006770 0.003650 -0.022822 # node 1621 --0.006109 0.003775 -0.023381 # node 1622 --0.005448 0.003900 -0.023941 # node 1623 --0.004880 0.004364 -0.024426 # node 1624 --0.004312 0.004828 -0.024911 # node 1625 --0.003744 0.005291 -0.025397 # node 1626 --0.003312 0.005825 -0.025843 # node 1627 --0.002880 0.006358 -0.026289 # node 1628 --0.002448 0.006891 -0.026736 # node 1629 --0.002428 0.007560 -0.026694 # node 1630 --0.002409 0.008228 -0.026653 # node 1631 --0.002389 0.008897 -0.026613 # node 1632 --0.001875 0.009574 -0.026720 # node 1633 --0.001361 0.010251 -0.026828 # node 1634 --0.001333 0.011073 -0.027101 # node 1635 --0.001306 0.011895 -0.027374 # node 1636 --0.000624 0.012205 -0.027857 # node 1637 -0.000058 0.012516 -0.028338 # node 1638 -0.000740 0.012826 -0.028819 # node 1639 -0.001439 0.012757 -0.029133 # node 1640 -0.002139 0.012688 -0.029448 # node 1641 -0.002838 0.012618 -0.029762 # node 1642 --0.005720 -0.001289 -0.016634 # node 1643 --0.005690 -0.000452 -0.016502 # node 1644 --0.005659 0.000385 -0.016370 # node 1645 --0.005629 0.001222 -0.016238 # node 1646 --0.005613 0.001971 -0.015987 # node 1647 --0.005597 0.002720 -0.015734 # node 1648 --0.004619 0.002701 -0.015964 # node 1649 --0.003641 0.002682 -0.016194 # node 1650 --0.002662 0.002663 -0.016424 # node 1651 --0.003153 0.002328 -0.017304 # node 1652 --0.003643 0.001993 -0.018184 # node 1653 -0.000119 -0.000484 -0.009879 # node 1654 -0.000468 0.000266 -0.009864 # node 1655 -0.000816 0.001016 -0.009849 # node 1656 -0.001164 0.001766 -0.009835 # node 1657 -0.001513 0.002516 -0.009820 # node 1658 -0.001917 0.003092 -0.010058 # node 1659 -0.002322 0.003667 -0.010297 # node 1660 -0.002726 0.004243 -0.010535 # node 1661 -0.002646 0.005052 -0.010949 # node 1662 -0.002567 0.005861 -0.011363 # node 1663 -0.002487 0.006670 -0.011778 # node 1664 -0.002407 0.007479 -0.012191 # node 1665 -0.002327 0.008288 -0.012606 # node 1666 -0.002247 0.009097 -0.013020 # node 1667 -0.003167 0.009357 -0.013336 # node 1668 -0.004088 0.009616 -0.013652 # node 1669 -0.005008 0.009876 -0.013969 # node 1670 -0.005929 0.010135 -0.014284 # node 1671 -0.006400 0.010521 -0.014638 # node 1672 -0.006871 0.010907 -0.014990 # node 1673 -0.007342 0.011293 -0.015342 # node 1674 -0.007820 0.012070 -0.015386 # node 1675 -0.008299 0.012847 -0.015428 # node 1676 -0.008778 0.013623 -0.015470 # node 1677 -0.009256 0.014400 -0.015512 # node 1678 -0.009735 0.015177 -0.015556 # node 1679 -0.010060 0.015759 -0.015721 # node 1680 -0.010384 0.016342 -0.015887 # node 1681 -0.010709 0.016924 -0.016053 # node 1682 -0.010275 0.017291 -0.016831 # node 1683 -0.009841 0.017657 -0.017609 # node 1684 -0.009408 0.018024 -0.018387 # node 1685 -0.008974 0.018391 -0.019166 # node 1686 -0.008541 0.018757 -0.019943 # node 1687 -0.007876 0.018954 -0.020510 # node 1688 -0.007210 0.019151 -0.021078 # node 1689 -0.006545 0.019347 -0.021646 # node 1690 -0.005880 0.019544 -0.022213 # node 1691 -0.005215 0.019741 -0.022780 # node 1692 -0.004493 0.019769 -0.022832 # node 1693 -0.003771 0.019798 -0.022884 # node 1694 -0.003050 0.019826 -0.022937 # node 1695 -0.003329 0.019868 -0.022200 # node 1696 -0.003608 0.019910 -0.021464 # node 1697 -0.003887 0.019951 -0.020728 # node 1698 -0.004574 0.019895 -0.020430 # node 1699 -0.005261 0.019838 -0.020132 # node 1700 -0.005948 0.019782 -0.019833 # node 1701 -0.006083 0.019201 -0.020598 # node 1702 -0.006218 0.018620 -0.021362 # node 1703 -0.006353 0.018040 -0.022127 # node 1704 -0.005718 0.018140 -0.022967 # node 1705 -0.005082 0.018240 -0.023806 # node 1706 -0.005675 0.018062 -0.024123 # node 1707 -0.006269 0.017884 -0.024441 # node 1708 -0.000651 -0.000048 -0.005390 # node 1709 -0.001197 0.000302 -0.006049 # node 1710 -0.001743 0.000652 -0.006707 # node 1711 -0.002439 0.000471 -0.007270 # node 1712 -0.003136 0.000290 -0.007833 # node 1713 -0.003481 -0.000049 -0.008439 # node 1714 -0.003827 -0.000387 -0.009045 # node 1715 -0.004172 -0.000725 -0.009651 # node 1716 -0.004953 -0.000882 -0.009938 # node 1717 -0.005734 -0.001039 -0.010226 # node 1718 -0.006515 -0.001195 -0.010513 # node 1719 -0.007296 -0.001352 -0.010800 # node 1720 -0.007942 -0.001486 -0.011316 # node 1721 -0.008588 -0.001621 -0.011831 # node 1722 -0.009235 -0.001756 -0.012347 # node 1723 -0.009806 -0.001378 -0.012734 # node 1724 -0.010377 -0.001001 -0.013123 # node 1725 -0.010949 -0.000624 -0.013511 # node 1726 -0.011791 -0.000592 -0.013601 # node 1727 -0.012634 -0.000559 -0.013690 # node 1728 -0.013477 -0.000527 -0.013780 # node 1729 -0.014320 -0.000495 -0.013870 # node 1730 -0.015163 -0.000463 -0.013959 # node 1731 -0.004141 -0.000602 -0.010389 # node 1732 -0.004110 -0.000479 -0.011127 # node 1733 -0.004932 -0.000424 -0.011389 # node 1734 -0.005753 -0.000369 -0.011651 # node 1735 -0.006575 -0.000313 -0.011913 # node 1736 -0.006845 -0.000408 -0.012651 # node 1737 -0.007115 -0.000503 -0.013388 # node 1738 -# -SIMPLEX -parameters 4 -0 1 1 1 1.789900e-05 9.298100e-03 # simplex 0 -1 2 1 1 9.789900e-06 7.298100e-03 # simplex 1 -2 3 1 1 9.789900e-06 7.298100e-03 # simplex 2 -3 4 1 1 8.642000e-06 5.687800e-03 # simplex 3 -4 5 1 1 7.492900e-06 4.278200e-03 # simplex 4 -5 6 1 1 6.344600e-06 3.069400e-03 # simplex 5 -6 7 1 1 5.158000e-06 2.061200e-03 # simplex 6 -7 8 1 1 4.516100e-06 1.529300e-03 # simplex 7 -8 9 1 1 4.516100e-06 1.529300e-03 # simplex 8 -9 10 1 1 4.515900e-06 1.529300e-03 # simplex 9 -10 11 1 1 4.564300e-06 1.529300e-03 # simplex 10 -11 12 1 1 4.564800e-06 1.479200e-03 # simplex 11 -12 13 1 1 4.564800e-06 1.479200e-03 # simplex 12 -13 14 1 1 4.564800e-06 1.479200e-03 # simplex 13 -14 15 1 1 4.564300e-06 1.479200e-03 # simplex 14 -15 16 1 1 4.565800e-06 1.479200e-03 # simplex 15 -16 17 1 1 4.561800e-06 1.479200e-03 # simplex 16 -17 18 1 1 4.496700e-06 1.479200e-03 # simplex 17 -18 19 1 1 4.496900e-06 1.479400e-03 # simplex 18 -19 20 1 1 4.496700e-06 1.479400e-03 # simplex 19 -20 21 1 1 4.492100e-06 1.479400e-03 # simplex 20 -21 22 1 1 4.038700e-06 1.479400e-03 # simplex 21 -22 23 1 1 4.038700e-06 1.369400e-03 # simplex 22 -23 24 1 1 4.035100e-06 1.369400e-03 # simplex 23 -24 25 1 1 4.038700e-06 1.369400e-03 # simplex 24 -25 26 1 1 4.038700e-06 1.369400e-03 # simplex 25 -26 27 1 1 3.905400e-06 1.369400e-03 # simplex 26 -27 28 1 1 3.905300e-06 1.345600e-03 # simplex 27 -28 29 1 1 3.908700e-06 1.345600e-03 # simplex 28 -29 30 1 1 3.905100e-06 1.345600e-03 # simplex 29 -30 31 1 1 4.464300e-06 1.345600e-03 # simplex 30 -31 32 1 1 4.464300e-06 1.541900e-03 # simplex 31 -32 33 1 1 4.464600e-06 1.541900e-03 # simplex 32 -33 34 1 1 4.467600e-06 1.541900e-03 # simplex 33 -34 35 1 1 4.464600e-06 1.541900e-03 # simplex 34 -35 36 1 1 4.325100e-06 1.541900e-03 # simplex 35 -36 37 1 1 4.326400e-06 1.553200e-03 # simplex 36 -37 38 1 1 4.326000e-06 1.553200e-03 # simplex 37 -38 39 1 1 4.326400e-06 1.553200e-03 # simplex 38 -39 40 1 1 4.324200e-06 1.553200e-03 # simplex 39 -40 41 1 1 4.329100e-06 1.553200e-03 # simplex 40 -41 42 1 1 4.324600e-06 1.553200e-03 # simplex 41 -42 43 1 1 4.328300e-06 1.553200e-03 # simplex 42 -43 44 1 1 4.324700e-06 1.553200e-03 # simplex 43 -44 45 1 1 4.324600e-06 1.553200e-03 # simplex 44 -45 46 1 1 4.329100e-06 1.553200e-03 # simplex 45 -46 47 1 1 4.324700e-06 1.553200e-03 # simplex 46 -47 48 1 1 4.324600e-06 1.553200e-03 # simplex 47 -48 49 1 1 4.356500e-06 1.553200e-03 # simplex 48 -49 50 1 1 4.359900e-06 1.473700e-03 # simplex 49 -50 51 1 1 4.355900e-06 1.473700e-03 # simplex 50 -51 52 1 1 4.360400e-06 1.473700e-03 # simplex 51 -52 53 1 1 4.705600e-06 1.473700e-03 # simplex 52 -53 54 1 1 4.705600e-06 1.623400e-03 # simplex 53 -54 55 1 1 4.707500e-06 1.623400e-03 # simplex 54 -55 56 1 1 4.705900e-06 1.623400e-03 # simplex 55 -56 57 1 1 4.704200e-06 1.623400e-03 # simplex 56 -57 58 1 1 4.014300e-06 1.623400e-03 # simplex 57 -58 59 1 1 4.012900e-06 1.333100e-03 # simplex 58 -59 60 1 1 4.015900e-06 1.333100e-03 # simplex 59 -60 61 1 1 4.012900e-06 1.333100e-03 # simplex 60 -61 62 1 1 4.470400e-06 1.333100e-03 # simplex 61 -62 63 1 1 4.465500e-06 1.461600e-03 # simplex 62 -63 64 1 1 4.470300e-06 1.461600e-03 # simplex 63 -64 65 1 1 4.465700e-06 1.461600e-03 # simplex 64 -65 66 1 1 4.470900e-06 1.461600e-03 # simplex 65 -66 67 1 1 4.465900e-06 1.461600e-03 # simplex 66 -67 68 1 1 4.470500e-06 1.461600e-03 # simplex 67 -68 69 1 1 4.683300e-06 1.461600e-03 # simplex 68 -69 70 1 1 4.683200e-06 1.540800e-03 # simplex 69 -70 71 1 1 4.678500e-06 1.540800e-03 # simplex 70 -71 72 1 1 4.683300e-06 1.540800e-03 # simplex 71 -72 73 1 1 4.683200e-06 1.540800e-03 # simplex 72 -73 74 1 1 4.683200e-06 1.540800e-03 # simplex 73 -74 75 1 1 4.741000e-06 1.540800e-03 # simplex 74 -75 76 1 1 4.740800e-06 1.590000e-03 # simplex 75 -76 77 1 1 4.740800e-06 1.590000e-03 # simplex 76 -77 78 1 1 4.745200e-06 1.590000e-03 # simplex 77 -78 79 1 1 4.630900e-06 1.590000e-03 # simplex 78 -79 80 1 1 4.630900e-06 1.581000e-03 # simplex 79 -80 81 1 1 4.631300e-06 1.581000e-03 # simplex 80 -81 82 1 1 4.631300e-06 1.581000e-03 # simplex 81 -82 83 1 1 3.732200e-06 1.581000e-03 # simplex 82 -83 84 1 1 3.732300e-06 1.327100e-03 # simplex 83 -84 85 1 1 3.732300e-06 1.327100e-03 # simplex 84 -85 86 1 1 3.732400e-06 1.327100e-03 # simplex 85 -86 87 1 1 4.403900e-06 1.327100e-03 # simplex 86 -87 88 1 1 4.400000e-06 1.485900e-03 # simplex 87 -88 89 1 1 4.403900e-06 1.485900e-03 # simplex 88 -89 90 1 1 4.403900e-06 1.485900e-03 # simplex 89 -90 91 1 1 4.397500e-06 1.485900e-03 # simplex 90 -91 92 1 1 4.403900e-06 1.485900e-03 # simplex 91 -92 93 1 1 4.707800e-06 1.485900e-03 # simplex 92 -93 94 1 1 4.707700e-06 1.527000e-03 # simplex 93 -94 95 1 1 4.712700e-06 1.527000e-03 # simplex 94 -95 96 1 1 4.707800e-06 1.527000e-03 # simplex 95 -96 97 1 1 4.707700e-06 1.527000e-03 # simplex 96 -97 98 1 1 4.548500e-06 1.527000e-03 # simplex 97 -98 99 1 1 4.543900e-06 1.491600e-03 # simplex 98 -99 100 1 1 4.548700e-06 1.491600e-03 # simplex 99 -100 101 1 1 4.543800e-06 1.491600e-03 # simplex 100 -101 102 1 1 3.997900e-06 1.491600e-03 # simplex 101 -102 103 1 1 3.997000e-06 1.301200e-03 # simplex 102 -103 104 1 1 3.997000e-06 1.301200e-03 # simplex 103 -104 105 1 1 3.992000e-06 1.301200e-03 # simplex 104 -105 106 1 1 4.970200e-06 1.301200e-03 # simplex 105 -106 107 1 1 4.965600e-06 1.614800e-03 # simplex 106 -107 108 1 1 4.965200e-06 1.614800e-03 # simplex 107 -108 109 1 1 4.965200e-06 1.614800e-03 # simplex 108 -109 110 1 1 4.970300e-06 1.614800e-03 # simplex 109 -110 111 1 1 4.485400e-06 1.614800e-03 # simplex 110 -49 112 2 2 3.629400e-06 1.246800e-03 # simplex 111 -112 113 2 2 3.302300e-06 1.031000e-03 # simplex 112 -113 114 2 2 2.970900e-06 8.356700e-04 # simplex 113 -114 115 2 2 2.882500e-06 6.608800e-04 # simplex 114 -115 116 2 2 2.655700e-06 6.071800e-04 # simplex 115 -116 117 2 2 2.573600e-06 5.709500e-04 # simplex 116 -117 118 2 2 2.494600e-06 5.358300e-04 # simplex 117 -118 119 2 2 2.384200e-06 5.018300e-04 # simplex 118 -49 120 2 3 4.353400e-06 1.484300e-03 # simplex 119 -120 121 2 3 3.945200e-06 1.218500e-03 # simplex 120 -121 122 2 3 3.526800e-06 9.788500e-04 # simplex 121 -122 123 2 3 3.229700e-06 8.269600e-04 # simplex 122 -123 124 2 3 3.055300e-06 7.401000e-04 # simplex 123 -27 125 2 4 3.198500e-06 1.047000e-03 # simplex 124 -125 126 2 4 2.892100e-06 8.579400e-04 # simplex 125 -126 127 2 4 3.174900e-06 6.877400e-04 # simplex 126 -127 128 2 4 2.988200e-06 7.756100e-04 # simplex 127 -128 129 2 4 3.007200e-06 7.862600e-04 # simplex 128 -129 130 2 4 3.027800e-06 7.969800e-04 # simplex 129 -130 131 2 4 3.365200e-06 8.077800e-04 # simplex 130 -131 132 2 4 3.436800e-06 9.338900e-04 # simplex 131 -132 133 2 4 3.555300e-06 9.995700e-04 # simplex 132 -133 134 2 4 3.674400e-06 1.067500e-03 # simplex 133 -134 135 2 4 3.792800e-06 1.137600e-03 # simplex 134 -135 136 2 4 3.297000e-06 1.210000e-03 # simplex 135 -136 137 2 4 3.210800e-06 9.253800e-04 # simplex 136 -137 138 2 4 2.913000e-06 7.644900e-04 # simplex 137 -138 139 2 4 3.040800e-06 6.189800e-04 # simplex 138 -139 140 2 4 2.830700e-06 6.460800e-04 # simplex 139 -140 141 2 4 2.768200e-06 6.178700e-04 # simplex 140 -141 142 2 4 2.704600e-06 5.903000e-04 # simplex 141 -142 143 2 4 2.546400e-06 5.633500e-04 # simplex 142 -143 144 2 4 2.457400e-06 4.908900e-04 # simplex 143 -144 145 2 4 2.156500e-06 4.445800e-04 # simplex 144 -145 146 2 4 2.088700e-06 3.890400e-04 # simplex 145 -146 147 2 4 2.062600e-06 3.794000e-04 # simplex 146 -147 148 2 4 2.034700e-06 3.698700e-04 # simplex 147 -148 149 2 4 2.026500e-06 3.604700e-04 # simplex 148 -149 150 2 4 2.018900e-06 3.391900e-04 # simplex 149 -150 151 2 4 2.022500e-06 3.412400e-04 # simplex 150 -151 152 2 4 1.958200e-06 3.433000e-04 # simplex 151 -152 153 2 4 1.964800e-06 3.565500e-04 # simplex 152 -153 154 2 4 1.972700e-06 3.601000e-04 # simplex 153 -154 155 2 4 1.984100e-06 3.636600e-04 # simplex 154 -155 156 2 4 2.257800e-06 3.672400e-04 # simplex 155 -156 157 2 4 2.327900e-06 4.262700e-04 # simplex 156 -157 158 2 4 2.445700e-06 4.718700e-04 # simplex 157 -158 159 2 4 2.735900e-06 5.197800e-04 # simplex 158 -159 160 2 4 2.787600e-06 5.573800e-04 # simplex 159 -160 161 2 4 2.768600e-06 5.490900e-04 # simplex 160 -161 162 2 4 2.746200e-06 5.408700e-04 # simplex 161 -162 163 2 4 2.513500e-06 5.327100e-04 # simplex 162 -163 164 2 4 2.469900e-06 4.678300e-04 # simplex 163 -164 165 2 4 2.402100e-06 4.424700e-04 # simplex 164 -165 166 2 4 2.331400e-06 4.178100e-04 # simplex 165 -166 167 2 4 2.266300e-06 3.938600e-04 # simplex 166 -167 168 2 4 2.198400e-06 3.706200e-04 # simplex 167 -168 169 2 4 1.920800e-06 3.480800e-04 # simplex 168 -1 170 1 6 1.164300e-05 1.019700e-02 # simplex 169 -170 171 1 6 1.134200e-05 9.676100e-03 # simplex 170 -171 172 1 6 1.104100e-05 9.168800e-03 # simplex 171 -172 173 1 6 1.074000e-05 8.675300e-03 # simplex 172 -173 174 1 6 1.095600e-05 8.195400e-03 # simplex 173 -174 175 1 6 1.079400e-05 8.456800e-03 # simplex 174 -175 176 1 6 1.082700e-05 8.506600e-03 # simplex 175 -176 177 1 6 8.459500e-06 8.556600e-03 # simplex 176 -177 178 1 6 8.444300e-06 6.591800e-03 # simplex 177 -178 179 1 6 8.391100e-06 6.507100e-03 # simplex 178 -179 180 1 6 1.091700e-05 6.422900e-03 # simplex 179 -180 181 1 6 1.069100e-05 8.415300e-03 # simplex 180 -181 182 1 6 1.024600e-05 7.741300e-03 # simplex 181 -182 183 1 6 9.685700e-06 7.095500e-03 # simplex 182 -183 184 2 5 8.982700e-06 5.408100e-03 # simplex 183 -184 185 2 5 7.378700e-06 3.646200e-03 # simplex 184 -185 186 2 5 5.759100e-06 2.231600e-03 # simplex 185 -186 187 2 5 3.335000e-06 1.164300e-03 # simplex 186 -187 188 2 5 2.533400e-06 6.180900e-04 # simplex 187 -188 189 2 5 2.417500e-06 5.620000e-04 # simplex 188 -189 190 2 5 2.299500e-06 5.085800e-04 # simplex 189 -190 191 2 5 2.233600e-06 4.578200e-04 # simplex 190 -191 192 2 5 2.262300e-06 4.549200e-04 # simplex 191 -192 193 2 5 2.445900e-06 5.304800e-04 # simplex 192 -193 194 2 5 2.322000e-06 6.118500e-04 # simplex 193 -194 195 2 5 2.298800e-06 5.475700e-04 # simplex 194 -195 196 2 5 2.088600e-06 4.511600e-04 # simplex 195 -196 197 2 5 2.089200e-06 3.640900e-04 # simplex 196 -197 198 2 5 1.921900e-06 3.480500e-04 # simplex 197 -198 199 2 5 1.825500e-06 3.148800e-04 # simplex 198 -199 200 2 5 1.734700e-06 2.833700e-04 # simplex 199 -200 201 2 5 1.434400e-06 2.535200e-04 # simplex 200 -201 202 2 5 1.418800e-06 2.214300e-04 # simplex 201 -202 203 2 5 1.474800e-06 2.383300e-04 # simplex 202 -203 204 2 5 1.747800e-06 2.558500e-04 # simplex 203 -204 205 2 5 1.826500e-06 3.247200e-04 # simplex 204 -205 206 2 5 1.922600e-06 3.597500e-04 # simplex 205 -206 207 2 5 2.057300e-06 3.965700e-04 # simplex 206 -207 208 2 5 2.056600e-06 4.043600e-04 # simplex 207 -208 209 2 5 1.959100e-06 3.661600e-04 # simplex 208 -209 210 2 5 2.044100e-06 3.298500e-04 # simplex 209 -210 211 2 5 2.017200e-06 3.528100e-04 # simplex 210 -211 212 2 5 2.067600e-06 3.714200e-04 # simplex 211 -212 213 2 5 1.610600e-06 3.905000e-04 # simplex 212 -213 214 2 5 1.656100e-06 3.064600e-04 # simplex 213 -214 215 2 5 1.703100e-06 3.245900e-04 # simplex 214 -215 216 2 5 2.338000e-06 3.432400e-04 # simplex 215 -216 217 2 5 2.319800e-06 4.513800e-04 # simplex 216 -217 218 2 5 2.228200e-06 4.153300e-04 # simplex 217 -218 219 2 5 2.082600e-06 3.807900e-04 # simplex 218 -183 220 1 6 9.732800e-06 6.942200e-03 # simplex 219 -220 221 1 6 9.573800e-06 6.727200e-03 # simplex 220 -221 222 1 6 9.428800e-06 6.515600e-03 # simplex 221 -222 223 1 6 7.614200e-06 6.307300e-03 # simplex 222 -223 224 1 6 7.793300e-06 5.519600e-03 # simplex 223 -224 225 1 6 8.222500e-06 6.144000e-03 # simplex 224 -225 226 1 6 8.656100e-06 6.801900e-03 # simplex 225 -226 227 1 6 9.081500e-06 7.493200e-03 # simplex 226 -227 228 1 6 1.045300e-05 8.218000e-03 # simplex 227 -228 229 1 6 1.073100e-05 9.345400e-03 # simplex 228 -229 230 1 6 1.088000e-05 9.619200e-03 # simplex 229 -230 231 1 6 1.103600e-05 9.897000e-03 # simplex 230 -231 232 1 6 1.119200e-05 1.017900e-02 # simplex 231 -232 233 1 6 1.135600e-05 1.046400e-02 # simplex 232 -233 234 1 6 1.182900e-05 1.075400e-02 # simplex 233 -234 235 1 6 1.176500e-05 1.021100e-02 # simplex 234 -235 236 1 6 1.140800e-05 9.597900e-03 # simplex 235 -236 237 1 6 1.104800e-05 9.004000e-03 # simplex 236 -237 238 1 6 1.069100e-05 8.429000e-03 # simplex 237 -238 239 1 6 1.031900e-05 7.873000e-03 # simplex 238 -239 240 1 6 9.972600e-06 7.336000e-03 # simplex 239 -240 241 1 6 9.826100e-06 6.818000e-03 # simplex 240 -241 242 1 6 9.627300e-06 6.720900e-03 # simplex 241 -242 243 1 6 9.638300e-06 6.737000e-03 # simplex 242 -243 244 1 6 9.660600e-06 6.753200e-03 # simplex 243 -244 245 1 6 9.661900e-06 6.769400e-03 # simplex 244 -245 246 1 6 9.672900e-06 6.785600e-03 # simplex 245 -246 247 1 6 9.685000e-06 6.801800e-03 # simplex 246 -247 248 1 6 9.696000e-06 6.818000e-03 # simplex 247 -248 249 1 6 9.708100e-06 6.834300e-03 # simplex 248 -249 250 1 6 9.030500e-06 6.850600e-03 # simplex 249 -250 251 1 6 9.158000e-06 6.536400e-03 # simplex 250 -251 252 1 6 9.352300e-06 6.834100e-03 # simplex 251 -252 253 1 6 9.559000e-06 7.138400e-03 # simplex 252 -253 254 1 6 1.043300e-05 7.449300e-03 # simplex 253 -254 255 1 6 1.043300e-05 7.923500e-03 # simplex 254 -255 256 1 6 1.017700e-05 7.556100e-03 # simplex 255 -256 257 1 6 9.932900e-06 7.197300e-03 # simplex 256 -257 258 1 6 9.698400e-06 6.847300e-03 # simplex 257 -258 259 1 6 9.443900e-06 6.506100e-03 # simplex 258 -259 260 1 6 9.198500e-06 6.173500e-03 # simplex 259 -260 261 1 6 9.147300e-06 5.849700e-03 # simplex 260 -261 262 1 6 8.891800e-06 5.682400e-03 # simplex 261 -262 263 1 6 8.639000e-06 5.352400e-03 # simplex 262 -263 264 1 6 8.368900e-06 5.032200e-03 # simplex 263 -264 265 1 6 8.105200e-06 4.721900e-03 # simplex 264 -265 266 1 6 7.843300e-06 4.421400e-03 # simplex 265 -266 267 1 6 6.980900e-06 4.130900e-03 # simplex 266 -267 268 1 6 6.913800e-06 3.730400e-03 # simplex 267 -268 269 1 6 7.010200e-06 3.843100e-03 # simplex 268 -269 270 1 6 7.113600e-06 3.957500e-03 # simplex 269 -270 271 1 6 7.225700e-06 4.073600e-03 # simplex 270 -271 272 1 6 8.077500e-06 4.191300e-03 # simplex 271 -272 273 1 6 8.084800e-06 4.594600e-03 # simplex 272 -273 274 1 6 7.959200e-06 4.462600e-03 # simplex 273 -274 275 1 6 7.850900e-06 4.332500e-03 # simplex 274 -275 276 1 6 7.725600e-06 4.204400e-03 # simplex 275 -276 277 1 6 7.617000e-06 4.078200e-03 # simplex 276 -277 278 1 6 7.491900e-06 3.954000e-03 # simplex 277 -278 279 1 6 7.383100e-06 3.831600e-03 # simplex 278 -279 280 1 6 7.266100e-06 3.711200e-03 # simplex 279 -280 281 1 6 7.141400e-06 3.592700e-03 # simplex 280 -281 282 1 6 7.032200e-06 3.476100e-03 # simplex 281 -282 283 1 6 6.907800e-06 3.361400e-03 # simplex 282 -283 284 1 6 6.493400e-06 3.248700e-03 # simplex 283 -284 285 1 6 6.387800e-06 3.006100e-03 # simplex 284 -285 286 1 6 6.269800e-06 2.901500e-03 # simplex 285 -286 287 1 6 6.157800e-06 2.798900e-03 # simplex 286 -287 288 1 6 6.044900e-06 2.698000e-03 # simplex 287 -288 289 1 6 5.933900e-06 2.599100e-03 # simplex 288 -289 290 1 6 5.821900e-06 2.501900e-03 # simplex 289 -290 291 1 6 5.716400e-06 2.406600e-03 # simplex 290 -291 292 1 6 5.831900e-06 2.313200e-03 # simplex 291 -292 293 1 6 5.690300e-06 2.285500e-03 # simplex 292 -293 294 1 6 5.521300e-06 2.151700e-03 # simplex 293 -294 295 1 6 5.357900e-06 2.021900e-03 # simplex 294 -295 296 1 6 5.182900e-06 1.896200e-03 # simplex 295 -296 297 1 6 5.013800e-06 1.774400e-03 # simplex 296 -297 298 1 6 4.850000e-06 1.656800e-03 # simplex 297 -298 299 1 6 4.425400e-06 1.543100e-03 # simplex 298 -299 300 1 6 4.347700e-06 1.430200e-03 # simplex 299 -300 301 1 6 4.348400e-06 1.430200e-03 # simplex 300 -301 302 1 6 4.348200e-06 1.430200e-03 # simplex 301 -302 303 1 6 4.348200e-06 1.430200e-03 # simplex 302 -303 304 1 6 4.348200e-06 1.430200e-03 # simplex 303 -304 305 1 6 3.972800e-06 1.430200e-03 # simplex 304 -272 306 2 7 6.336300e-06 3.593400e-03 # simplex 305 -306 307 2 7 5.351700e-06 2.563200e-03 # simplex 306 -307 308 2 7 4.530700e-06 1.707000e-03 # simplex 307 -308 309 2 7 3.743800e-06 1.261500e-03 # simplex 308 -309 310 2 7 3.614200e-06 1.024300e-03 # simplex 309 -310 311 2 7 3.538600e-06 9.875000e-04 # simplex 310 -311 312 2 7 3.802300e-06 1.140300e-03 # simplex 311 -312 313 2 7 3.851900e-06 1.304000e-03 # simplex 312 -313 314 2 7 3.978300e-06 1.337900e-03 # simplex 313 -314 315 2 7 3.992600e-06 1.347400e-03 # simplex 314 -315 316 2 7 4.018100e-06 1.356900e-03 # simplex 315 -316 317 2 7 3.865600e-06 1.236000e-03 # simplex 316 -317 318 2 7 3.519800e-06 1.027100e-03 # simplex 317 -318 319 2 7 3.735700e-06 8.375400e-04 # simplex 318 -319 320 2 7 3.323100e-06 7.684700e-04 # simplex 319 -320 321 2 7 2.892400e-06 5.836400e-04 # simplex 320 -321 322 2 7 2.240700e-06 4.242400e-04 # simplex 321 -272 323 2 8 6.430500e-06 3.512800e-03 # simplex 322 -323 324 2 8 5.331500e-06 2.418600e-03 # simplex 323 -324 325 2 8 4.234300e-06 1.528700e-03 # simplex 324 -325 326 2 8 3.833500e-06 8.428700e-04 # simplex 325 -326 327 2 8 3.118700e-06 7.108800e-04 # simplex 326 -327 328 2 8 3.213600e-06 7.537900e-04 # simplex 327 -328 329 2 8 3.348500e-06 7.979500e-04 # simplex 328 -329 330 2 8 3.384300e-06 7.962300e-04 # simplex 329 -330 331 2 8 3.353500e-06 7.832300e-04 # simplex 330 -331 332 2 8 3.328900e-06 7.703300e-04 # simplex 331 -332 333 2 8 3.298000e-06 7.575300e-04 # simplex 332 -333 334 2 8 3.273400e-06 7.448500e-04 # simplex 333 -334 335 2 8 2.939600e-06 7.322700e-04 # simplex 334 -335 336 2 8 2.892500e-06 6.448100e-04 # simplex 335 -336 337 2 8 2.825900e-06 6.141800e-04 # simplex 336 -337 338 2 8 2.753400e-06 5.842900e-04 # simplex 337 -338 339 2 8 2.686700e-06 5.551400e-04 # simplex 338 -339 340 2 8 2.637100e-06 5.267500e-04 # simplex 339 -340 341 2 8 2.617100e-06 5.670000e-04 # simplex 340 -341 342 2 8 2.648100e-06 5.804500e-04 # simplex 341 -342 343 2 8 2.678700e-06 5.940600e-04 # simplex 342 -343 344 2 8 2.709100e-06 6.078200e-04 # simplex 343 -344 345 2 8 2.623800e-06 6.217500e-04 # simplex 344 -345 346 2 8 2.700600e-06 5.870900e-04 # simplex 345 -346 347 2 8 2.831500e-06 6.440800e-04 # simplex 346 -347 348 2 8 2.959800e-06 7.037100e-04 # simplex 347 -348 349 2 8 2.949300e-06 7.659800e-04 # simplex 348 -349 350 2 8 3.019800e-06 7.928400e-04 # simplex 349 -350 351 2 8 3.048600e-06 8.061600e-04 # simplex 350 -351 352 2 8 3.072400e-06 8.196000e-04 # simplex 351 -352 353 2 8 3.097800e-06 8.331400e-04 # simplex 352 -353 354 2 8 3.159900e-06 8.468000e-04 # simplex 353 -354 355 2 8 3.069700e-06 7.900200e-04 # simplex 354 -355 356 2 8 2.857500e-06 6.845800e-04 # simplex 355 -356 357 2 8 2.645300e-06 5.866900e-04 # simplex 356 -357 358 2 8 2.432700e-06 4.963500e-04 # simplex 357 -358 359 2 8 2.493900e-06 4.135700e-04 # simplex 358 -359 360 2 8 2.374900e-06 4.138100e-04 # simplex 359 -360 361 2 8 2.375300e-06 4.140100e-04 # simplex 360 -361 362 2 8 2.373800e-06 4.142100e-04 # simplex 361 -362 363 2 8 2.437000e-06 4.144100e-04 # simplex 362 -363 364 2 8 2.255500e-06 3.666100e-04 # simplex 363 -364 365 2 8 1.890200e-06 2.571900e-04 # simplex 364 -365 366 2 8 1.411800e-06 1.671700e-04 # simplex 365 -345 367 2 9 2.166400e-06 4.512400e-04 # simplex 366 -367 368 2 9 2.098400e-06 4.222800e-04 # simplex 367 -368 369 2 9 2.135700e-06 3.942700e-04 # simplex 368 -369 370 2 9 2.119400e-06 3.994400e-04 # simplex 369 -370 371 2 9 2.170700e-06 4.178600e-04 # simplex 370 -371 372 2 9 2.077800e-06 4.366900e-04 # simplex 371 -372 373 2 9 2.053400e-06 4.405700e-04 # simplex 372 -373 374 2 9 1.961500e-06 4.022900e-04 # simplex 373 -374 375 2 9 1.870900e-06 3.657600e-04 # simplex 374 -375 376 2 9 1.944900e-06 3.309700e-04 # simplex 375 -376 377 2 9 1.872100e-06 3.279600e-04 # simplex 376 -377 378 2 9 1.825300e-06 3.119800e-04 # simplex 377 -378 379 2 9 1.777900e-06 2.964100e-04 # simplex 378 -379 380 2 9 1.687500e-06 2.812300e-04 # simplex 379 -267 381 2 10 6.067900e-06 2.777100e-03 # simplex 380 -381 382 2 10 2.990600e-06 1.091800e-03 # simplex 381 -382 383 2 10 1.959800e-06 4.297500e-04 # simplex 382 -383 384 2 10 2.050800e-06 4.707100e-04 # simplex 383 -384 385 2 10 2.341900e-06 5.135300e-04 # simplex 384 -385 386 2 10 2.301400e-06 5.431000e-04 # simplex 385 -386 387 2 10 2.123900e-06 4.617300e-04 # simplex 386 -387 388 2 10 2.492700e-06 3.869700e-04 # simplex 387 -388 389 2 10 2.552100e-06 5.189700e-04 # simplex 388 -389 390 2 10 2.900500e-06 6.699600e-04 # simplex 389 -390 391 2 10 3.194600e-06 8.402200e-04 # simplex 390 -391 392 2 10 3.117800e-06 7.835500e-04 # simplex 391 -392 393 2 10 2.053600e-06 5.488900e-04 # simplex 392 -393 394 2 10 1.813800e-06 3.390400e-04 # simplex 393 -394 395 2 10 1.748800e-06 3.151000e-04 # simplex 394 -395 396 2 10 1.683000e-06 2.920400e-04 # simplex 395 -396 397 2 10 1.666200e-06 2.698600e-04 # simplex 396 -397 398 2 10 1.918000e-06 3.571800e-04 # simplex 397 -398 399 2 10 3.078300e-06 5.853700e-04 # simplex 398 -399 400 2 10 3.348300e-06 8.143600e-04 # simplex 399 -400 401 2 10 3.272300e-06 7.795300e-04 # simplex 400 -401 402 2 10 3.093900e-06 7.454500e-04 # simplex 401 -402 403 2 10 3.040900e-06 7.309200e-04 # simplex 402 -403 404 2 10 2.997700e-06 7.114900e-04 # simplex 403 -404 405 2 10 2.957500e-06 6.923200e-04 # simplex 404 -405 406 2 10 2.391000e-06 6.734200e-04 # simplex 405 -406 407 2 10 2.355700e-06 5.616600e-04 # simplex 406 -407 408 2 10 2.318000e-06 5.439300e-04 # simplex 407 -408 409 2 10 2.756300e-06 5.264900e-04 # simplex 408 -409 410 2 10 2.716600e-06 6.178300e-04 # simplex 409 -410 411 2 10 2.328600e-06 6.018100e-04 # simplex 410 -411 412 2 10 2.282600e-06 5.013000e-04 # simplex 411 -412 413 2 10 2.213700e-06 4.724700e-04 # simplex 412 -413 414 2 10 2.149100e-06 4.444900e-04 # simplex 413 -414 415 2 10 2.080600e-06 4.173700e-04 # simplex 414 -415 416 2 10 2.465300e-06 3.911100e-04 # simplex 415 -416 417 2 10 2.404100e-06 4.373300e-04 # simplex 416 -417 418 2 10 2.363000e-06 4.225600e-04 # simplex 417 -418 419 2 10 2.301100e-06 4.080500e-04 # simplex 418 -419 420 2 10 2.338800e-06 4.110900e-04 # simplex 419 -420 421 2 10 2.453800e-06 4.525100e-04 # simplex 420 -421 422 2 10 2.570900e-06 4.959200e-04 # simplex 421 -422 423 2 10 2.682300e-06 5.413200e-04 # simplex 422 -423 424 2 10 3.007500e-06 5.887100e-04 # simplex 423 -424 425 2 10 3.096900e-06 6.446200e-04 # simplex 424 -425 426 2 10 3.155900e-06 6.681200e-04 # simplex 425 -426 427 2 10 2.835000e-06 6.920400e-04 # simplex 426 -427 428 2 10 2.995800e-06 6.749700e-04 # simplex 427 -428 429 2 10 3.614700e-06 7.961600e-04 # simplex 428 -429 430 2 10 3.651700e-06 9.090100e-04 # simplex 429 -430 431 2 10 3.455900e-06 8.125600e-04 # simplex 430 -431 432 2 10 3.253200e-06 7.215200e-04 # simplex 431 -432 433 2 10 2.737100e-06 6.358900e-04 # simplex 432 -433 434 2 10 2.688800e-06 5.476900e-04 # simplex 433 -434 435 2 10 2.773100e-06 5.825000e-04 # simplex 434 -435 436 2 10 2.857100e-06 6.183700e-04 # simplex 435 -436 437 2 10 2.941400e-06 6.553200e-04 # simplex 436 -437 438 2 10 3.012600e-06 6.933400e-04 # simplex 437 -438 439 2 10 3.094500e-06 7.299300e-04 # simplex 438 -439 440 2 10 3.180300e-06 7.711800e-04 # simplex 439 -440 441 2 10 3.270400e-06 8.135600e-04 # simplex 440 -441 442 2 10 3.222400e-06 8.570800e-04 # simplex 441 -442 443 2 10 3.072200e-06 7.441700e-04 # simplex 442 -443 444 2 10 2.664900e-06 5.602200e-04 # simplex 443 -444 445 2 10 2.257400e-06 4.023800e-04 # simplex 444 -445 446 2 10 1.852600e-06 2.706500e-04 # simplex 445 -446 447 2 10 1.301300e-06 1.650500e-04 # simplex 446 -391 448 2 11 3.051900e-06 8.220700e-04 # simplex 447 -448 449 2 11 2.975500e-06 7.818300e-04 # simplex 448 -449 450 2 11 2.900900e-06 7.426000e-04 # simplex 449 -450 451 2 11 2.738400e-06 7.043700e-04 # simplex 450 -451 452 2 11 2.861200e-06 7.397500e-04 # simplex 451 -452 453 2 11 2.936500e-06 9.064700e-04 # simplex 452 -453 454 2 11 3.086500e-06 9.332300e-04 # simplex 453 -454 455 2 11 3.112300e-06 9.494500e-04 # simplex 454 -455 456 2 11 3.140700e-06 9.658100e-04 # simplex 455 -456 457 2 11 3.166300e-06 9.823100e-04 # simplex 456 -457 458 2 11 3.293100e-06 9.989400e-04 # simplex 457 -458 459 2 11 3.369500e-06 1.028300e-03 # simplex 458 -459 460 2 11 3.486000e-06 1.100600e-03 # simplex 459 -460 461 2 11 3.602800e-06 1.175400e-03 # simplex 460 -461 462 2 11 4.490300e-06 1.252700e-03 # simplex 461 -462 463 2 11 4.558800e-06 1.564000e-03 # simplex 462 -463 464 2 11 4.559600e-06 1.564000e-03 # simplex 463 -464 465 2 11 4.608100e-06 1.564000e-03 # simplex 464 -465 466 2 11 4.606900e-06 1.540700e-03 # simplex 465 -466 467 2 11 4.609000e-06 1.540700e-03 # simplex 466 -467 468 2 11 4.446200e-06 1.540700e-03 # simplex 467 -468 469 2 11 4.442600e-06 1.521100e-03 # simplex 468 -469 470 2 11 4.446200e-06 1.521100e-03 # simplex 469 -470 471 2 11 3.834200e-06 1.521100e-03 # simplex 470 -471 472 2 11 3.834200e-06 1.273200e-03 # simplex 471 -472 473 2 11 3.834200e-06 1.273200e-03 # simplex 472 -473 474 2 11 4.664500e-06 1.273200e-03 # simplex 473 -474 475 2 11 4.662500e-06 1.550900e-03 # simplex 474 -475 476 2 11 4.662500e-06 1.550900e-03 # simplex 475 -476 477 2 11 4.664500e-06 1.550900e-03 # simplex 476 -477 478 2 11 4.662500e-06 1.550900e-03 # simplex 477 -478 479 2 11 4.662500e-06 1.550900e-03 # simplex 478 -479 480 2 11 4.037700e-06 1.550900e-03 # simplex 479 -480 481 2 11 4.043600e-06 1.357400e-03 # simplex 480 -481 482 2 11 4.039500e-06 1.357400e-03 # simplex 481 -482 483 2 11 4.037700e-06 1.357400e-03 # simplex 482 -483 484 2 11 4.136200e-06 1.357400e-03 # simplex 483 -484 485 2 11 4.082400e-06 1.386300e-03 # simplex 484 -485 486 2 11 3.976900e-06 1.313900e-03 # simplex 485 -486 487 2 11 3.864400e-06 1.243400e-03 # simplex 486 -487 488 2 11 3.952500e-06 1.174900e-03 # simplex 487 -488 489 2 11 3.834000e-06 1.109100e-03 # simplex 488 -489 490 2 11 3.719300e-06 1.043500e-03 # simplex 489 -490 491 2 11 3.754700e-06 9.800200e-04 # simplex 490 -491 492 2 11 3.603400e-06 9.809700e-04 # simplex 491 -492 493 2 11 3.425600e-06 8.845200e-04 # simplex 492 -493 494 2 11 3.239100e-06 7.930600e-04 # simplex 493 -494 495 2 11 2.905800e-06 7.065900e-04 # simplex 494 -484 496 2 12 3.766400e-06 1.232500e-03 # simplex 495 -496 497 2 12 3.485800e-06 1.052900e-03 # simplex 496 -497 498 2 12 3.201200e-06 8.875500e-04 # simplex 497 -498 499 2 12 2.876600e-06 7.362900e-04 # simplex 498 -499 500 2 12 2.678300e-06 6.424500e-04 # simplex 499 -500 501 2 12 2.566000e-06 5.914400e-04 # simplex 500 -501 502 2 12 2.461800e-06 5.425400e-04 # simplex 501 -502 503 2 12 2.353300e-06 4.957500e-04 # simplex 502 -503 504 2 12 2.412100e-06 4.510800e-04 # simplex 503 -504 505 2 12 2.300400e-06 4.587800e-04 # simplex 504 -505 506 2 12 2.190800e-06 4.160900e-04 # simplex 505 -506 507 2 12 2.079400e-06 3.754900e-04 # simplex 506 -507 508 2 12 1.620600e-06 3.369700e-04 # simplex 507 -508 509 2 12 1.516900e-06 2.369900e-04 # simplex 508 -509 510 2 12 1.397600e-06 2.018900e-04 # simplex 509 -510 511 2 12 1.623200e-06 1.696000e-04 # simplex 510 -511 512 2 12 1.471500e-06 1.623300e-04 # simplex 511 -512 513 2 12 1.311400e-06 1.292500e-04 # simplex 512 -513 514 2 12 1.153000e-06 9.993900e-05 # simplex 513 -514 515 2 12 8.951900e-07 7.439900e-05 # simplex 514 -504 516 2 13 1.931200e-06 3.714800e-04 # simplex 515 -516 517 2 13 1.963600e-06 3.854200e-04 # simplex 516 -517 518 2 13 2.755200e-06 3.996200e-04 # simplex 517 -518 519 2 13 2.824600e-06 5.952300e-04 # simplex 518 -519 520 2 13 2.917800e-06 6.357100e-04 # simplex 519 -520 521 2 13 3.016400e-06 6.775300e-04 # simplex 520 -521 522 2 13 2.353400e-06 7.206700e-04 # simplex 521 -522 523 2 13 2.335400e-06 5.532600e-04 # simplex 522 -523 524 2 13 2.227500e-06 5.028200e-04 # simplex 523 -524 525 2 13 2.118600e-06 4.548000e-04 # simplex 524 -525 526 2 13 2.216800e-06 4.091900e-04 # simplex 525 -526 527 2 13 1.793300e-06 2.681000e-04 # simplex 526 -527 528 2 13 9.071800e-07 8.535900e-05 # simplex 527 -499 529 2 14 1.823900e-06 4.380600e-04 # simplex 528 -529 530 2 14 2.268300e-06 3.836200e-04 # simplex 529 -530 531 2 14 2.281400e-06 3.995600e-04 # simplex 530 -531 532 2 14 2.051500e-06 3.707600e-04 # simplex 531 -532 533 2 14 1.563500e-06 3.058500e-04 # simplex 532 -533 534 2 14 1.449900e-06 2.152800e-04 # simplex 533 -534 535 2 14 1.637400e-06 1.954200e-04 # simplex 534 -535 536 2 14 1.522500e-06 2.114800e-04 # simplex 535 -536 537 2 14 1.374700e-06 1.719200e-04 # simplex 536 -537 538 2 14 1.198400e-06 1.364500e-04 # simplex 537 -261 539 2 15 7.368900e-06 4.371600e-03 # simplex 538 -539 540 2 15 5.606200e-06 2.544100e-03 # simplex 539 -540 541 2 15 3.803100e-06 1.211300e-03 # simplex 540 -541 542 2 15 2.653100e-06 6.488700e-04 # simplex 541 -542 543 2 15 2.427200e-06 5.431200e-04 # simplex 542 -543 544 2 15 2.202200e-06 4.467700e-04 # simplex 543 -544 545 2 15 1.975300e-06 3.598400e-04 # simplex 544 -545 546 2 15 1.775000e-06 2.823000e-04 # simplex 545 -546 547 2 15 1.911600e-06 3.307200e-04 # simplex 546 -547 548 2 15 2.401100e-06 5.205600e-04 # simplex 547 -548 549 2 15 3.188500e-06 7.534600e-04 # simplex 548 -549 550 2 15 3.220000e-06 7.973300e-04 # simplex 549 -550 551 2 15 2.750500e-06 5.821800e-04 # simplex 550 -551 552 2 15 2.564800e-06 4.008600e-04 # simplex 551 -552 553 2 15 2.446000e-06 4.160800e-04 # simplex 552 -553 554 2 15 2.109100e-06 5.265400e-04 # simplex 553 -554 555 2 15 2.108000e-06 4.298500e-04 # simplex 554 -555 556 2 15 1.869800e-06 3.381700e-04 # simplex 555 -556 557 2 15 1.630800e-06 2.574900e-04 # simplex 556 -557 558 2 15 1.392500e-06 1.878000e-04 # simplex 557 -554 559 2 16 2.749500e-06 5.283800e-04 # simplex 558 -559 560 2 16 2.641900e-06 4.875400e-04 # simplex 559 -560 561 2 16 2.535300e-06 4.483400e-04 # simplex 560 -561 562 2 16 2.424300e-06 4.107900e-04 # simplex 561 -562 563 2 16 2.316600e-06 3.748700e-04 # simplex 562 -563 564 2 16 2.209700e-06 3.406000e-04 # simplex 563 -564 565 2 16 2.099600e-06 3.079700e-04 # simplex 564 -565 566 2 16 1.990700e-06 2.769900e-04 # simplex 565 -566 567 2 16 1.711200e-06 2.476400e-04 # simplex 566 -261 568 2 17 7.900000e-06 4.720800e-03 # simplex 567 -568 569 2 17 5.797500e-06 2.556800e-03 # simplex 568 -569 570 2 17 3.456000e-06 1.056500e-03 # simplex 569 -570 571 2 17 2.329000e-06 4.932200e-04 # simplex 570 -571 572 2 17 2.329600e-06 4.933000e-04 # simplex 571 -572 573 2 17 2.329400e-06 4.933800e-04 # simplex 572 -573 574 2 17 2.329600e-06 4.934700e-04 # simplex 573 -574 575 2 17 2.083900e-06 4.935500e-04 # simplex 574 -575 576 2 17 2.078600e-06 4.392300e-04 # simplex 575 -576 577 2 17 2.067800e-06 4.346500e-04 # simplex 576 -577 578 2 17 2.056900e-06 4.301100e-04 # simplex 577 -578 579 2 17 2.506300e-06 4.255900e-04 # simplex 578 -579 580 2 17 2.480200e-06 5.047400e-04 # simplex 579 -580 581 2 17 2.438600e-06 4.885600e-04 # simplex 580 -581 582 2 17 2.400300e-06 4.726500e-04 # simplex 581 -582 583 2 17 2.225700e-06 4.570000e-04 # simplex 582 -583 584 2 17 2.135000e-06 3.610100e-04 # simplex 583 -584 585 2 17 1.591900e-06 3.118400e-04 # simplex 584 -585 586 2 17 1.490500e-06 2.426800e-04 # simplex 585 -586 587 2 17 1.403600e-06 2.156800e-04 # simplex 586 -587 588 2 17 1.318300e-06 1.902700e-04 # simplex 587 -585 589 2 18 1.458800e-06 2.416700e-04 # simplex 588 -589 590 2 18 1.441100e-06 2.355900e-04 # simplex 589 -590 591 2 18 1.871800e-06 2.295900e-04 # simplex 590 -591 592 2 18 1.914300e-06 3.179500e-04 # simplex 591 -592 593 2 18 2.024600e-06 3.549600e-04 # simplex 592 -593 594 2 18 2.131700e-06 3.940000e-04 # simplex 593 -594 595 2 18 2.137600e-06 4.350800e-04 # simplex 594 -595 596 2 18 2.155500e-06 4.215800e-04 # simplex 595 -596 597 2 18 2.088800e-06 3.959100e-04 # simplex 596 -597 598 2 18 2.021800e-06 3.710400e-04 # simplex 597 -598 599 2 18 1.955500e-06 3.469800e-04 # simplex 598 -599 600 2 18 1.888900e-06 3.237200e-04 # simplex 599 -600 601 2 18 1.819100e-06 3.012800e-04 # simplex 600 -579 602 2 19 2.126400e-06 4.240400e-04 # simplex 601 -602 603 2 19 2.011400e-06 3.797800e-04 # simplex 602 -603 604 2 19 1.898200e-06 3.379700e-04 # simplex 603 -604 605 2 19 1.784300e-06 2.985900e-04 # simplex 604 -605 606 2 19 1.648800e-06 2.616500e-04 # simplex 605 -254 607 2 20 9.616000e-06 6.649400e-03 # simplex 606 -607 608 2 20 6.984500e-06 3.527100e-03 # simplex 607 -608 609 2 20 3.507200e-06 1.394900e-03 # simplex 608 -609 610 2 20 2.240800e-06 5.321900e-04 # simplex 609 -610 611 2 20 2.245000e-06 5.345400e-04 # simplex 610 -611 612 2 20 2.518600e-06 5.369000e-04 # simplex 611 -612 613 2 20 2.544000e-06 6.105700e-04 # simplex 612 -613 614 2 20 2.585800e-06 6.317300e-04 # simplex 613 -614 615 2 20 2.632900e-06 6.532600e-04 # simplex 614 -615 616 2 20 2.823200e-06 6.751400e-04 # simplex 615 -616 617 2 20 2.819900e-06 7.028400e-04 # simplex 616 -617 618 2 20 2.771000e-06 6.780200e-04 # simplex 617 -618 619 2 20 2.719300e-06 6.536400e-04 # simplex 618 -619 620 2 20 3.087000e-06 6.297100e-04 # simplex 619 -620 621 2 20 3.061600e-06 7.011600e-04 # simplex 620 -621 622 2 20 3.078900e-06 7.082700e-04 # simplex 621 -622 623 2 20 3.094700e-06 7.154200e-04 # simplex 622 -623 624 2 20 2.884500e-06 7.226000e-04 # simplex 623 -624 625 2 20 2.860000e-06 6.753900e-04 # simplex 624 -625 626 2 20 2.792500e-06 6.444600e-04 # simplex 625 -626 627 2 20 2.727400e-06 6.142600e-04 # simplex 626 -627 628 2 20 2.354000e-06 5.847800e-04 # simplex 627 -628 629 2 20 2.252800e-06 4.671900e-04 # simplex 628 -629 630 2 20 2.108200e-06 4.085600e-04 # simplex 629 -630 631 2 20 1.960500e-06 3.538500e-04 # simplex 630 -631 632 2 20 1.848300e-06 3.030700e-04 # simplex 631 -632 633 2 20 1.757000e-06 2.867100e-04 # simplex 632 -633 634 2 20 1.725000e-06 2.764100e-04 # simplex 633 -634 635 2 20 1.693200e-06 2.663000e-04 # simplex 634 -635 636 2 20 1.661100e-06 2.563800e-04 # simplex 635 -250 637 2 21 7.573300e-06 5.172300e-03 # simplex 636 -637 638 2 21 6.235100e-06 3.510700e-03 # simplex 637 -638 639 2 21 4.898500e-06 2.171000e-03 # simplex 638 -639 640 2 21 4.238600e-06 1.153300e-03 # simplex 639 -640 641 2 21 3.115000e-06 8.047200e-04 # simplex 640 -641 642 2 21 2.781000e-06 6.411400e-04 # simplex 641 -642 643 2 21 2.318800e-06 4.961600e-04 # simplex 642 -643 644 2 21 2.102900e-06 3.902600e-04 # simplex 643 -644 645 2 21 1.997600e-06 3.519600e-04 # simplex 644 -645 646 2 21 1.904900e-06 3.156400e-04 # simplex 645 -646 647 2 21 1.924100e-06 3.227000e-04 # simplex 646 -647 648 2 21 2.067800e-06 3.725200e-04 # simplex 647 -648 649 2 21 2.209900e-06 4.259200e-04 # simplex 648 -649 650 2 21 2.428600e-06 4.828900e-04 # simplex 649 -650 651 2 21 2.519300e-06 5.303000e-04 # simplex 650 -651 652 2 21 2.557300e-06 5.459500e-04 # simplex 651 -652 653 2 21 2.592900e-06 5.618200e-04 # simplex 652 -653 654 2 21 2.629600e-06 5.779200e-04 # simplex 653 -654 655 2 21 2.669000e-06 5.942500e-04 # simplex 654 -655 656 2 21 2.704100e-06 6.108000e-04 # simplex 655 -656 657 2 21 2.740300e-06 6.275900e-04 # simplex 656 -657 658 2 21 2.571700e-06 6.446000e-04 # simplex 657 -658 659 2 21 2.552000e-06 5.903100e-04 # simplex 658 -659 660 2 21 2.478500e-06 5.565200e-04 # simplex 659 -660 661 2 21 2.211900e-06 5.237300e-04 # simplex 660 -661 662 2 21 2.198200e-06 4.775900e-04 # simplex 661 -662 663 2 21 2.239200e-06 4.955700e-04 # simplex 662 -663 664 2 21 2.889100e-06 5.138900e-04 # simplex 663 -664 665 2 21 2.965400e-06 6.399800e-04 # simplex 664 -665 666 2 21 3.060300e-06 6.829600e-04 # simplex 665 -666 667 2 21 3.160100e-06 7.273400e-04 # simplex 666 -667 668 2 21 3.350900e-06 7.731200e-04 # simplex 667 -668 669 2 21 3.315300e-06 7.976700e-04 # simplex 668 -669 670 2 21 3.143200e-06 7.168200e-04 # simplex 669 -670 671 2 21 2.970200e-06 6.402900e-04 # simplex 670 -671 672 2 21 2.650600e-06 5.680800e-04 # simplex 671 -241 673 2 22 8.315000e-06 5.568200e-03 # simplex 672 -673 674 2 22 6.676700e-06 3.606600e-03 # simplex 673 -674 675 2 22 6.013600e-06 2.071000e-03 # simplex 674 -675 676 2 22 4.797200e-06 1.614000e-03 # simplex 675 -676 677 2 22 4.312800e-06 1.592800e-03 # simplex 676 -677 678 2 22 4.268600e-06 1.487000e-03 # simplex 677 -678 679 2 22 4.205400e-06 1.444200e-03 # simplex 678 -679 680 2 22 4.143300e-06 1.402100e-03 # simplex 679 -680 681 2 22 4.083400e-06 1.360500e-03 # simplex 680 -681 682 2 22 4.200800e-06 1.319600e-03 # simplex 681 -682 683 2 22 4.073700e-06 1.247800e-03 # simplex 682 -683 684 2 22 3.870900e-06 1.128500e-03 # simplex 683 -684 685 2 22 3.674100e-06 1.015100e-03 # simplex 684 -685 686 2 22 3.240000e-06 9.077300e-04 # simplex 685 -686 687 2 22 3.122100e-06 7.851800e-04 # simplex 686 -687 688 2 22 3.077800e-06 7.618500e-04 # simplex 687 -688 689 2 22 3.028700e-06 7.388800e-04 # simplex 688 -689 690 2 22 3.148800e-06 7.162600e-04 # simplex 689 -690 691 2 22 3.042500e-06 7.369800e-04 # simplex 690 -691 692 2 22 2.880300e-06 6.600400e-04 # simplex 691 -692 693 2 22 2.716900e-06 5.873400e-04 # simplex 692 -693 694 2 22 2.552900e-06 5.188800e-04 # simplex 693 -694 695 2 22 2.390500e-06 4.546600e-04 # simplex 694 -695 696 2 22 2.226400e-06 3.946900e-04 # simplex 695 -696 697 2 22 1.808300e-06 3.389600e-04 # simplex 696 -697 698 2 22 1.846300e-06 3.069900e-04 # simplex 697 -698 699 2 22 2.062900e-06 3.832100e-04 # simplex 698 -699 700 2 22 2.279900e-06 4.678800e-04 # simplex 699 -700 701 2 22 2.626600e-06 5.610100e-04 # simplex 700 -701 702 2 22 2.720500e-06 6.111000e-04 # simplex 701 -702 703 2 22 2.686200e-06 5.957800e-04 # simplex 702 -703 704 2 22 2.654200e-06 5.806500e-04 # simplex 703 -704 705 2 22 2.617500e-06 5.657200e-04 # simplex 704 -705 706 2 22 2.590100e-06 5.509900e-04 # simplex 705 -706 707 2 22 2.565500e-06 5.635100e-04 # simplex 706 -707 708 2 22 2.548900e-06 5.561200e-04 # simplex 707 -708 709 2 22 2.531100e-06 5.487700e-04 # simplex 708 -709 710 2 22 2.514200e-06 5.414700e-04 # simplex 709 -710 711 2 22 2.498200e-06 5.342300e-04 # simplex 710 -711 712 2 22 2.480500e-06 5.270300e-04 # simplex 711 -712 713 2 22 2.722100e-06 5.198800e-04 # simplex 712 -713 714 2 22 2.763400e-06 5.847100e-04 # simplex 713 -714 715 2 22 2.865400e-06 6.279700e-04 # simplex 714 -715 716 2 22 3.078400e-06 6.727800e-04 # simplex 715 -716 717 2 22 3.278700e-06 7.650200e-04 # simplex 716 -717 718 2 22 3.569600e-06 9.067100e-04 # simplex 717 -718 719 2 22 3.708100e-06 1.060400e-03 # simplex 718 -719 720 2 22 3.622900e-06 1.020800e-03 # simplex 719 -720 721 2 22 3.176400e-06 7.763800e-04 # simplex 720 -721 722 2 22 2.824300e-06 6.037900e-04 # simplex 721 -722 723 2 22 2.592800e-06 5.095400e-04 # simplex 722 -723 724 2 22 2.288400e-06 4.232800e-04 # simplex 723 -713 725 2 23 2.326100e-06 5.127200e-04 # simplex 724 -725 726 2 23 2.921000e-06 6.056300e-04 # simplex 725 -726 727 2 23 3.059900e-06 7.771300e-04 # simplex 726 -727 728 2 23 3.110300e-06 8.030900e-04 # simplex 727 -728 729 2 23 3.296200e-06 8.294700e-04 # simplex 728 -729 730 2 23 3.257300e-06 8.428200e-04 # simplex 729 -730 731 2 23 3.121700e-06 7.755800e-04 # simplex 730 -731 732 2 23 2.991600e-06 7.111300e-04 # simplex 731 -732 733 2 23 2.859400e-06 6.494700e-04 # simplex 732 -733 734 2 23 2.724000e-06 5.906100e-04 # simplex 733 -734 735 2 23 2.593700e-06 5.345500e-04 # simplex 734 -735 736 2 23 2.461400e-06 4.812800e-04 # simplex 735 -736 737 2 23 2.174000e-06 4.308100e-04 # simplex 736 -737 738 2 23 2.032500e-06 3.482200e-04 # simplex 737 -738 739 2 23 1.872600e-06 2.955900e-04 # simplex 738 -739 740 2 23 1.693600e-06 2.472700e-04 # simplex 739 -706 741 2 24 2.406100e-06 5.526700e-04 # simplex 740 -741 742 2 24 2.612300e-06 6.525100e-04 # simplex 741 -742 743 2 24 2.823000e-06 7.606400e-04 # simplex 742 -743 744 2 24 3.028900e-06 8.770600e-04 # simplex 743 -744 745 2 24 3.919600e-06 1.001800e-03 # simplex 744 -745 746 2 24 3.963400e-06 1.257300e-03 # simplex 745 -746 747 2 24 3.810200e-06 1.161500e-03 # simplex 746 -747 748 2 24 3.656600e-06 1.069500e-03 # simplex 747 -748 749 2 24 3.459500e-06 9.812600e-04 # simplex 748 -749 750 2 24 3.487700e-06 9.880900e-04 # simplex 749 -750 751 2 24 3.699500e-06 1.109900e-03 # simplex 750 -751 752 2 24 3.907900e-06 1.238900e-03 # simplex 751 -752 753 2 24 4.112300e-06 1.374900e-03 # simplex 752 -753 754 2 24 3.613100e-06 1.518000e-03 # simplex 753 -754 755 2 24 3.693900e-06 1.323800e-03 # simplex 754 -755 756 2 24 3.694800e-06 1.323800e-03 # simplex 755 -756 757 2 24 3.693900e-06 1.323800e-03 # simplex 756 -757 758 2 24 3.694800e-06 1.323800e-03 # simplex 757 -758 759 2 24 4.093400e-06 1.323800e-03 # simplex 758 -759 760 2 24 4.091700e-06 1.402200e-03 # simplex 759 -760 761 2 24 4.093300e-06 1.402200e-03 # simplex 760 -761 762 2 24 4.350800e-06 1.402200e-03 # simplex 761 -762 763 2 24 4.248500e-06 1.371700e-03 # simplex 762 -763 764 2 24 4.028800e-06 1.235000e-03 # simplex 763 -764 765 2 24 3.811800e-06 1.105600e-03 # simplex 764 -765 766 2 24 3.310300e-06 9.833000e-04 # simplex 765 -690 767 2 25 2.926900e-06 6.570700e-04 # simplex 766 -767 768 2 25 2.893900e-06 6.423700e-04 # simplex 767 -768 769 2 25 2.781600e-06 6.278300e-04 # simplex 768 -769 770 2 25 2.734000e-06 6.524500e-04 # simplex 769 -770 771 2 25 2.671700e-06 6.228600e-04 # simplex 770 -771 772 2 25 2.608100e-06 5.939600e-04 # simplex 771 -772 773 2 25 2.546100e-06 5.657500e-04 # simplex 772 -773 774 2 25 2.483400e-06 5.382200e-04 # simplex 773 -774 775 2 25 2.420500e-06 5.113800e-04 # simplex 774 -775 776 2 25 2.358000e-06 4.852200e-04 # simplex 775 -776 777 2 25 2.563800e-06 4.597500e-04 # simplex 776 -777 778 2 25 2.511700e-06 4.830000e-04 # simplex 777 -778 779 2 25 2.477800e-06 4.700700e-04 # simplex 778 -779 780 2 25 2.443900e-06 4.573200e-04 # simplex 779 -780 781 2 25 2.252700e-06 4.447400e-04 # simplex 780 -781 782 2 25 2.342200e-06 4.582500e-04 # simplex 781 -782 783 2 25 2.549700e-06 5.428700e-04 # simplex 782 -783 784 2 25 2.756600e-06 6.346600e-04 # simplex 783 -784 785 2 25 2.963100e-06 7.336200e-04 # simplex 784 -785 786 2 25 3.352700e-06 8.397500e-04 # simplex 785 -786 787 2 25 3.428100e-06 9.297200e-04 # simplex 786 -787 788 2 25 3.363700e-06 8.951900e-04 # simplex 787 -788 789 2 25 3.081600e-06 8.613200e-04 # simplex 788 -789 790 2 25 3.048700e-06 7.700400e-04 # simplex 789 -790 791 2 25 3.036400e-06 7.644300e-04 # simplex 790 -791 792 2 25 3.023600e-06 7.588300e-04 # simplex 791 -792 793 2 25 3.014100e-06 7.532600e-04 # simplex 792 -793 794 2 25 3.078000e-06 7.477100e-04 # simplex 793 -794 795 2 25 3.020800e-06 7.407100e-04 # simplex 794 -795 796 2 25 2.827300e-06 6.907200e-04 # simplex 795 -796 797 2 25 2.788700e-06 6.315500e-04 # simplex 796 -797 798 2 25 2.812700e-06 6.424400e-04 # simplex 797 -798 799 2 25 2.837400e-06 6.534300e-04 # simplex 798 -799 800 2 25 2.502900e-06 6.645100e-04 # simplex 799 -800 801 2 25 2.513800e-06 6.010500e-04 # simplex 800 -801 802 2 25 2.519000e-06 6.034700e-04 # simplex 801 -802 803 2 25 2.526000e-06 6.059000e-04 # simplex 802 -803 804 2 25 2.693400e-06 6.083300e-04 # simplex 803 -804 805 2 25 2.694900e-06 6.488300e-04 # simplex 804 -805 806 2 25 2.687200e-06 6.460000e-04 # simplex 805 -806 807 2 25 2.503100e-06 6.431800e-04 # simplex 806 -807 808 2 25 2.549600e-06 6.330500e-04 # simplex 807 -808 809 2 25 2.651000e-06 6.845000e-04 # simplex 808 -809 810 2 25 2.755300e-06 7.379700e-04 # simplex 809 -810 811 2 25 3.584700e-06 7.934400e-04 # simplex 810 -811 812 2 25 3.630000e-06 9.672100e-04 # simplex 811 -812 813 2 25 3.594000e-06 9.489100e-04 # simplex 812 -813 814 2 25 3.561100e-06 9.308000e-04 # simplex 813 -814 815 2 25 3.526700e-06 9.128500e-04 # simplex 814 -815 816 2 25 3.492200e-06 8.950800e-04 # simplex 815 -816 817 2 25 3.460600e-06 8.774900e-04 # simplex 816 -817 818 2 25 3.423200e-06 8.600700e-04 # simplex 817 -818 819 2 25 3.388700e-06 8.428200e-04 # simplex 818 -819 820 2 25 3.354100e-06 8.257500e-04 # simplex 819 -820 821 2 25 3.031500e-06 8.088500e-04 # simplex 820 -821 822 2 25 3.051800e-06 7.389700e-04 # simplex 821 -822 823 2 25 3.133600e-06 7.773600e-04 # simplex 822 -823 824 2 25 3.212000e-06 8.167300e-04 # simplex 823 -824 825 2 25 3.401800e-06 8.570600e-04 # simplex 824 -825 826 2 25 3.365800e-06 8.483700e-04 # simplex 825 -826 827 2 25 3.199100e-06 7.681900e-04 # simplex 826 -827 828 2 25 3.039700e-06 6.919900e-04 # simplex 827 -828 829 2 25 2.873400e-06 6.197700e-04 # simplex 828 -829 830 2 25 2.621200e-06 5.515300e-04 # simplex 829 -830 831 2 25 2.535600e-06 4.993000e-04 # simplex 830 -831 832 2 25 2.524300e-06 4.948600e-04 # simplex 831 -832 833 2 25 2.510100e-06 4.904300e-04 # simplex 832 -833 834 2 25 2.501700e-06 4.860200e-04 # simplex 833 -834 835 2 25 2.251900e-06 4.816300e-04 # simplex 834 -241 836 2 26 7.856600e-06 5.436100e-03 # simplex 835 -836 837 2 26 6.733400e-06 3.991200e-03 # simplex 836 -837 838 2 26 5.603300e-06 2.769500e-03 # simplex 837 -838 839 2 26 2.864600e-06 1.771000e-03 # simplex 838 -839 840 2 26 2.433300e-06 8.725200e-04 # simplex 839 -840 841 2 26 2.531400e-06 8.725200e-04 # simplex 840 -841 842 2 26 2.474000e-06 8.642900e-04 # simplex 841 -842 843 2 26 4.173700e-06 7.882900e-04 # simplex 842 -843 844 2 26 3.680100e-06 1.061600e-03 # simplex 843 -844 845 2 26 2.505400e-06 6.296800e-04 # simplex 844 -845 846 2 26 1.976400e-06 3.559300e-04 # simplex 845 -846 847 2 26 1.722000e-06 2.656400e-04 # simplex 846 -847 848 2 26 1.886300e-06 3.129600e-04 # simplex 847 -848 849 2 26 2.279200e-06 5.350700e-04 # simplex 848 -849 850 2 26 2.389600e-06 5.447000e-04 # simplex 849 -850 851 2 26 2.090100e-06 4.174500e-04 # simplex 850 -851 852 2 26 1.775700e-06 3.071300e-04 # simplex 851 -852 853 2 26 1.644600e-06 2.654000e-04 # simplex 852 -853 854 2 26 1.685900e-06 2.788500e-04 # simplex 853 -854 855 2 26 1.727000e-06 2.926200e-04 # simplex 854 -855 856 2 26 1.632500e-06 3.067300e-04 # simplex 855 -856 857 2 26 1.746600e-06 3.096300e-04 # simplex 856 -857 858 2 26 1.937400e-06 3.800100e-04 # simplex 857 -858 859 2 26 2.827400e-06 4.576100e-04 # simplex 858 -859 860 2 26 2.970400e-06 7.085600e-04 # simplex 859 -860 861 2 26 3.010400e-06 7.294000e-04 # simplex 860 -861 862 2 26 2.564100e-06 7.505400e-04 # simplex 861 -862 863 2 26 2.543100e-06 6.189200e-04 # simplex 862 -863 864 2 26 2.467100e-06 5.820100e-04 # simplex 863 -864 865 2 26 2.603100e-06 5.462300e-04 # simplex 864 -865 866 2 26 2.721500e-06 6.330200e-04 # simplex 865 -866 867 2 26 3.030000e-06 7.850200e-04 # simplex 866 -867 868 2 26 3.658500e-06 9.533800e-04 # simplex 867 -868 869 2 26 3.931200e-06 1.125200e-03 # simplex 868 -869 870 2 26 3.873200e-06 1.251900e-03 # simplex 869 -870 871 2 26 3.693600e-06 1.145300e-03 # simplex 870 -871 872 2 26 3.099200e-06 8.069800e-04 # simplex 871 -872 873 2 26 2.149800e-06 5.278800e-04 # simplex 872 -873 874 2 26 1.823000e-06 3.321000e-04 # simplex 873 -874 875 2 26 1.695700e-06 2.879700e-04 # simplex 874 -875 876 2 26 1.373200e-06 2.469900e-04 # simplex 875 -876 877 2 26 1.469800e-06 2.430900e-04 # simplex 876 -877 878 2 26 1.980100e-06 3.469900e-04 # simplex 877 -878 879 2 26 2.075900e-06 4.284600e-04 # simplex 878 -879 880 2 26 2.034400e-06 3.819000e-04 # simplex 879 -880 881 2 26 2.025200e-06 3.945700e-04 # simplex 880 -881 882 2 26 2.119600e-06 4.335600e-04 # simplex 881 -882 883 2 26 2.181700e-06 4.743900e-04 # simplex 882 -859 884 2 27 2.262600e-06 5.176700e-04 # simplex 883 -884 885 2 27 2.216100e-06 4.963000e-04 # simplex 884 -885 886 2 27 2.834800e-06 4.753900e-04 # simplex 885 -886 887 2 27 2.833000e-06 6.201500e-04 # simplex 886 -887 888 2 27 2.897900e-06 6.484300e-04 # simplex 887 -888 889 2 27 2.962600e-06 6.773400e-04 # simplex 888 -889 890 2 27 3.025700e-06 7.068800e-04 # simplex 889 -890 891 2 27 3.076600e-06 7.370500e-04 # simplex 890 -891 892 2 27 3.198700e-06 7.947600e-04 # simplex 891 -892 893 2 27 3.370500e-06 8.836500e-04 # simplex 892 -893 894 2 27 2.830800e-06 9.772500e-04 # simplex 893 -894 895 2 27 2.869600e-06 7.896400e-04 # simplex 894 -895 896 2 27 2.809700e-06 7.570700e-04 # simplex 895 -896 897 2 27 3.364400e-06 7.251800e-04 # simplex 896 -897 898 2 27 3.298500e-06 8.082200e-04 # simplex 897 -898 899 2 27 3.227400e-06 7.754400e-04 # simplex 898 -899 900 2 27 2.905300e-06 7.433400e-04 # simplex 899 -900 901 2 27 2.885300e-06 7.170000e-04 # simplex 900 -901 902 2 27 2.912900e-06 7.299400e-04 # simplex 901 -902 903 2 27 2.939200e-06 7.429900e-04 # simplex 902 -903 904 2 27 2.646100e-06 7.561600e-04 # simplex 903 -904 905 2 27 2.681300e-06 7.071800e-04 # simplex 904 -905 906 2 27 2.723500e-06 7.307300e-04 # simplex 905 -906 907 2 27 2.768600e-06 7.546600e-04 # simplex 906 -907 908 2 27 2.926800e-06 7.789900e-04 # simplex 907 -908 909 2 27 2.999100e-06 8.507200e-04 # simplex 908 -909 910 2 27 3.413300e-06 9.082900e-04 # simplex 909 -910 911 2 27 3.546200e-06 1.074800e-03 # simplex 910 -911 912 2 27 3.329500e-06 1.170100e-03 # simplex 911 -912 913 2 27 3.433200e-06 1.093100e-03 # simplex 912 -913 914 2 27 3.501300e-06 1.138800e-03 # simplex 913 -914 915 2 27 3.664000e-06 1.185500e-03 # simplex 914 -915 916 2 27 3.591600e-06 1.204800e-03 # simplex 915 -916 917 2 27 3.366100e-06 1.058000e-03 # simplex 916 -917 918 2 27 3.138300e-06 9.207800e-04 # simplex 917 -918 919 2 27 2.912700e-06 7.930700e-04 # simplex 918 -919 920 2 27 2.668900e-06 6.749000e-04 # simplex 919 -920 921 2 27 2.535700e-06 6.064800e-04 # simplex 920 -921 922 2 27 2.501300e-06 5.907800e-04 # simplex 921 -922 923 2 27 2.470800e-06 5.752900e-04 # simplex 922 -923 924 2 27 2.527000e-06 5.600100e-04 # simplex 923 -924 925 2 27 2.588500e-06 5.533800e-04 # simplex 924 -925 926 2 27 2.733100e-06 6.184300e-04 # simplex 925 -926 927 2 27 2.880700e-06 6.871000e-04 # simplex 926 -927 928 2 27 3.502400e-06 7.593900e-04 # simplex 927 -928 929 2 27 3.589500e-06 9.800400e-04 # simplex 928 -929 930 2 27 3.596400e-06 9.837600e-04 # simplex 929 -930 931 2 27 2.994300e-06 9.875000e-04 # simplex 930 -931 932 2 27 2.971700e-06 8.282100e-04 # simplex 931 -932 933 2 27 2.922100e-06 8.010800e-04 # simplex 932 -933 934 2 27 2.874600e-06 7.744100e-04 # simplex 933 -934 935 2 27 3.156200e-06 7.481800e-04 # simplex 934 -935 936 2 27 3.041700e-06 7.845100e-04 # simplex 935 -936 937 2 27 2.862300e-06 6.949700e-04 # simplex 936 -937 938 2 27 2.684100e-06 6.108700e-04 # simplex 937 -938 939 2 27 2.504500e-06 5.321800e-04 # simplex 938 -939 940 2 27 2.327500e-06 4.589300e-04 # simplex 939 -940 941 2 27 2.135600e-06 3.910900e-04 # simplex 940 -241 942 2 28 8.602900e-06 5.357900e-03 # simplex 941 -942 943 2 28 6.857900e-06 3.415100e-03 # simplex 942 -943 944 2 28 5.115100e-06 1.909800e-03 # simplex 943 -944 945 2 28 3.032100e-06 8.420300e-04 # simplex 944 -945 946 2 28 2.161400e-06 4.175900e-04 # simplex 945 -946 947 2 28 2.205200e-06 4.354800e-04 # simplex 946 -947 948 2 28 2.470800e-06 4.537500e-04 # simplex 947 -948 949 2 28 2.433000e-06 4.905500e-04 # simplex 948 -949 950 2 28 2.306200e-06 4.407700e-04 # simplex 949 -950 951 2 28 1.816000e-06 3.936600e-04 # simplex 950 -951 952 2 28 1.722600e-06 2.871700e-04 # simplex 951 -952 953 2 28 1.638100e-06 2.596800e-04 # simplex 952 -953 954 2 28 1.434100e-06 2.335600e-04 # simplex 953 -234 955 2 29 1.076000e-05 9.302700e-03 # simplex 954 -955 956 2 29 9.313800e-06 6.961800e-03 # simplex 955 -956 957 2 29 7.852800e-06 4.960200e-03 # simplex 956 -957 958 2 29 6.398200e-06 3.297900e-03 # simplex 957 -958 959 2 29 4.899300e-06 1.974900e-03 # simplex 958 -959 960 2 29 4.020600e-06 1.383800e-03 # simplex 959 -960 961 2 29 4.020500e-06 1.383800e-03 # simplex 960 -961 962 2 29 4.017200e-06 1.383800e-03 # simplex 961 -962 963 2 29 4.433500e-06 1.383800e-03 # simplex 962 -963 964 2 29 4.435900e-06 1.569600e-03 # simplex 963 -964 965 2 29 4.432300e-06 1.569600e-03 # simplex 964 -965 966 2 29 4.437700e-06 1.569600e-03 # simplex 965 -966 967 2 29 4.434000e-06 1.569600e-03 # simplex 966 -967 968 2 29 4.433900e-06 1.569600e-03 # simplex 967 -968 969 2 29 4.343300e-06 1.569600e-03 # simplex 968 -969 970 2 29 4.344100e-06 1.511800e-03 # simplex 969 -970 971 2 29 4.333400e-06 1.507200e-03 # simplex 970 -971 972 2 29 4.333800e-06 1.502600e-03 # simplex 971 -972 973 2 29 4.323900e-06 1.498000e-03 # simplex 972 -973 974 2 29 4.314100e-06 1.493400e-03 # simplex 973 -974 975 2 29 4.310700e-06 1.488900e-03 # simplex 974 -975 976 2 29 4.239800e-06 1.484300e-03 # simplex 975 -976 977 2 29 4.236500e-06 1.502100e-03 # simplex 976 -977 978 2 29 4.245000e-06 1.506100e-03 # simplex 977 -978 979 2 29 4.247900e-06 1.510100e-03 # simplex 978 -979 980 2 29 4.256900e-06 1.514200e-03 # simplex 979 -980 981 2 29 4.262100e-06 1.518200e-03 # simplex 980 -981 982 2 29 4.264900e-06 1.522300e-03 # simplex 981 -982 983 2 29 4.273500e-06 1.526300e-03 # simplex 982 -983 984 2 29 3.881200e-06 1.530400e-03 # simplex 983 -984 985 2 29 3.811100e-06 1.282100e-03 # simplex 984 -985 986 2 29 3.653800e-06 1.179700e-03 # simplex 985 -986 987 2 29 3.498200e-06 1.081600e-03 # simplex 986 -987 988 2 29 3.533500e-06 9.877900e-04 # simplex 987 -988 989 2 29 3.530000e-06 1.085700e-03 # simplex 988 -989 990 2 29 3.697100e-06 1.188900e-03 # simplex 989 -990 991 2 29 3.857800e-06 1.296700e-03 # simplex 990 -991 992 2 29 4.305600e-06 1.409200e-03 # simplex 991 -992 993 2 29 4.237500e-06 1.373200e-03 # simplex 992 -993 994 2 29 3.904700e-06 1.167300e-03 # simplex 993 -994 995 2 29 2.549100e-06 9.781000e-04 # simplex 994 -995 996 2 29 2.355300e-06 6.249500e-04 # simplex 995 -996 997 2 29 2.214600e-06 5.523000e-04 # simplex 996 -997 998 2 29 2.598000e-06 4.841300e-04 # simplex 997 -998 999 2 29 2.488600e-06 5.684600e-04 # simplex 998 -999 1000 2 29 2.496700e-06 5.519000e-04 # simplex 999 -1000 1001 2 29 2.566100e-06 5.815200e-04 # simplex 1000 -1001 1002 2 29 2.119800e-06 6.647600e-04 # simplex 1001 -1002 1003 2 29 2.152800e-06 5.383400e-04 # simplex 1002 -1003 1004 2 29 2.081500e-06 5.033900e-04 # simplex 1003 -1004 1005 2 29 2.130700e-06 4.696300e-04 # simplex 1004 -1005 1006 2 29 2.100000e-06 4.636500e-04 # simplex 1005 -1006 1007 2 29 2.117400e-06 4.698000e-04 # simplex 1006 -1007 1008 2 29 2.746700e-06 4.759900e-04 # simplex 1007 -1008 1009 2 29 2.645700e-06 5.835900e-04 # simplex 1008 -1009 1010 2 29 2.356000e-06 4.922400e-04 # simplex 1009 -1010 1011 2 29 2.265200e-06 4.243400e-04 # simplex 1010 -1011 1012 2 29 2.301800e-06 4.376900e-04 # simplex 1011 -1012 1013 2 29 2.182000e-06 4.512400e-04 # simplex 1012 -1013 1014 2 29 2.124800e-06 4.217700e-04 # simplex 1013 -1014 1015 2 29 1.964700e-06 3.615200e-04 # simplex 1014 -1015 1016 2 29 1.808800e-06 3.059100e-04 # simplex 1015 -1016 1017 2 29 1.637600e-06 2.549400e-04 # simplex 1016 -976 1018 2 30 3.922800e-06 1.270800e-03 # simplex 1017 -1018 1019 2 30 3.561900e-06 1.048500e-03 # simplex 1018 -1019 1020 2 30 3.200500e-06 8.475700e-04 # simplex 1019 -1020 1021 2 30 2.858200e-06 6.680100e-04 # simplex 1020 -1021 1022 2 30 2.629300e-06 5.937800e-04 # simplex 1021 -1022 1023 2 30 2.546300e-06 5.568900e-04 # simplex 1022 -1023 1024 2 30 2.274000e-06 5.211800e-04 # simplex 1023 -1024 1025 2 30 2.210300e-06 4.561200e-04 # simplex 1024 -1025 1026 2 30 2.159200e-06 4.350700e-04 # simplex 1025 -1026 1027 2 30 2.107100e-06 4.145300e-04 # simplex 1026 -1027 1028 2 30 2.250000e-06 3.944800e-04 # simplex 1027 -1028 1029 2 30 2.176000e-06 4.033200e-04 # simplex 1028 -1029 1030 2 30 2.084400e-06 3.700900e-04 # simplex 1029 -1030 1031 2 30 2.017600e-06 3.382800e-04 # simplex 1030 -1031 1032 2 30 1.900500e-06 2.869200e-04 # simplex 1031 -1032 1033 2 30 1.765900e-06 2.472700e-04 # simplex 1032 -1033 1034 2 30 1.629600e-06 2.105700e-04 # simplex 1033 -1034 1035 2 30 1.418400e-06 1.768200e-04 # simplex 1034 -1035 1036 2 30 1.416000e-06 1.802500e-04 # simplex 1035 -959 1037 2 31 4.189800e-06 1.372200e-03 # simplex 1036 -1037 1038 2 31 4.193400e-06 1.372200e-03 # simplex 1037 -1038 1039 2 31 4.476400e-06 1.372200e-03 # simplex 1038 -1039 1040 2 31 4.475700e-06 1.552700e-03 # simplex 1039 -1040 1041 2 31 4.476400e-06 1.552700e-03 # simplex 1040 -1041 1042 2 31 4.479000e-06 1.552700e-03 # simplex 1041 -1042 1043 2 31 4.168500e-06 1.552700e-03 # simplex 1042 -1043 1044 2 31 4.170900e-06 1.457500e-03 # simplex 1043 -1044 1045 2 31 4.168200e-06 1.457500e-03 # simplex 1044 -1045 1046 2 31 4.874900e-06 1.457500e-03 # simplex 1045 -1046 1047 2 31 4.881100e-06 1.628700e-03 # simplex 1046 -1047 1048 2 31 4.879700e-06 1.628700e-03 # simplex 1047 -1048 1049 2 31 4.878900e-06 1.628700e-03 # simplex 1048 -1049 1050 2 31 4.350300e-06 1.628700e-03 # simplex 1049 -1050 1051 2 31 4.350500e-06 1.530100e-03 # simplex 1050 -1051 1052 2 31 4.351500e-06 1.530100e-03 # simplex 1051 -1052 1053 2 31 4.346900e-06 1.530100e-03 # simplex 1052 -1053 1054 2 31 3.272400e-06 1.530100e-03 # simplex 1053 -1054 1055 2 31 3.269300e-06 1.169300e-03 # simplex 1054 -1055 1056 2 31 3.269400e-06 1.169300e-03 # simplex 1055 -1056 1057 2 31 4.336400e-06 1.169300e-03 # simplex 1056 -1057 1058 2 31 4.343600e-06 1.505600e-03 # simplex 1057 -1058 1059 2 31 4.342900e-06 1.505600e-03 # simplex 1058 -1059 1060 2 31 4.821300e-06 1.505600e-03 # simplex 1059 -1060 1061 2 31 4.817000e-06 1.563500e-03 # simplex 1060 -1061 1062 2 31 4.343100e-06 1.563500e-03 # simplex 1061 -228 1063 2 32 9.590500e-06 7.714100e-03 # simplex 1062 -1063 1064 2 32 8.307100e-06 5.789300e-03 # simplex 1063 -1064 1065 2 32 7.026500e-06 4.140700e-03 # simplex 1064 -1065 1066 2 32 5.738200e-06 2.768400e-03 # simplex 1065 -1066 1067 2 32 4.456100e-06 1.672300e-03 # simplex 1066 -1067 1068 2 32 2.945400e-06 8.525300e-04 # simplex 1067 -1068 1069 2 32 2.243100e-06 4.929900e-04 # simplex 1068 -1069 1070 2 32 2.186900e-06 4.685400e-04 # simplex 1069 -1070 1071 2 32 1.929700e-06 4.447200e-04 # simplex 1070 -1071 1072 2 32 1.895200e-06 3.882800e-04 # simplex 1071 -1072 1073 2 32 1.877500e-06 3.810400e-04 # simplex 1072 -1073 1074 2 32 1.937400e-06 3.738800e-04 # simplex 1073 -1074 1075 2 32 1.986100e-06 4.063600e-04 # simplex 1074 -1075 1076 2 32 2.107900e-06 4.565100e-04 # simplex 1075 -1076 1077 2 32 2.224200e-06 5.095800e-04 # simplex 1076 -1077 1078 2 32 2.122100e-06 5.655700e-04 # simplex 1077 -1078 1079 2 32 2.100400e-06 5.041500e-04 # simplex 1078 -1079 1080 2 32 1.948100e-06 4.336100e-04 # simplex 1079 -1080 1081 2 32 2.050900e-06 3.683900e-04 # simplex 1080 -1081 1082 2 32 2.028700e-06 4.061700e-04 # simplex 1081 -1082 1083 2 32 2.152000e-06 4.586000e-04 # simplex 1082 -1083 1084 2 32 2.629400e-06 5.142100e-04 # simplex 1083 -1084 1085 2 32 2.587500e-06 5.270000e-04 # simplex 1084 -1085 1086 2 32 1.678500e-06 4.363200e-04 # simplex 1085 -1086 1087 2 32 1.646000e-06 3.206800e-04 # simplex 1086 -1087 1088 2 32 2.125000e-06 3.621600e-04 # simplex 1087 -1088 1089 2 32 2.218700e-06 4.737200e-04 # simplex 1088 -1089 1090 2 32 2.279200e-06 4.999900e-04 # simplex 1089 -1090 1091 2 32 2.791800e-06 5.269700e-04 # simplex 1090 -1091 1092 2 32 2.718400e-06 5.835200e-04 # simplex 1091 -1092 1093 2 32 2.493400e-06 4.905800e-04 # simplex 1092 -1093 1094 2 32 2.369900e-06 4.056900e-04 # simplex 1093 -1094 1095 2 32 2.180500e-06 3.649800e-04 # simplex 1094 -1095 1096 2 32 2.048600e-06 3.216800e-04 # simplex 1095 -1096 1097 2 32 1.530200e-06 2.811200e-04 # simplex 1096 -1097 1098 2 32 1.444400e-06 2.102500e-04 # simplex 1097 -1098 1099 2 32 1.381400e-06 1.923100e-04 # simplex 1098 -1099 1100 2 32 1.156100e-06 1.751800e-04 # simplex 1099 -1100 1101 2 32 1.149900e-06 1.468800e-04 # simplex 1100 -1101 1102 2 32 1.423600e-06 1.578600e-04 # simplex 1101 -1102 1103 2 32 1.587900e-06 2.201200e-04 # simplex 1102 -1103 1104 2 32 1.857600e-06 3.012600e-04 # simplex 1103 -1104 1105 2 32 2.073700e-06 3.951300e-04 # simplex 1104 -1105 1106 2 32 2.147000e-06 4.495600e-04 # simplex 1105 -1106 1107 2 32 2.029600e-06 4.026400e-04 # simplex 1106 -1107 1108 2 32 1.826700e-06 3.583100e-04 # simplex 1107 -1108 1109 2 32 1.798900e-06 3.326200e-04 # simplex 1108 -1109 1110 2 32 1.850300e-06 3.519100e-04 # simplex 1109 -1110 1111 2 32 1.938600e-06 3.717500e-04 # simplex 1110 -1111 1112 2 32 1.967700e-06 3.915300e-04 # simplex 1111 -1112 1113 2 32 1.979300e-06 3.954500e-04 # simplex 1112 -1113 1114 2 32 2.436200e-06 3.993800e-04 # simplex 1113 -1114 1115 2 32 2.473900e-06 5.059800e-04 # simplex 1114 -1115 1116 2 32 2.537700e-06 5.321400e-04 # simplex 1115 -1116 1117 2 32 2.600000e-06 5.589600e-04 # simplex 1116 -1117 1118 2 32 2.750200e-06 5.864400e-04 # simplex 1117 -1118 1119 2 32 2.595000e-06 5.326000e-04 # simplex 1118 -1119 1120 2 32 2.205700e-06 3.853400e-04 # simplex 1119 -1120 1121 2 32 1.865200e-06 2.619200e-04 # simplex 1120 -1121 1122 2 32 1.329300e-06 1.493900e-04 # simplex 1121 -228 1123 2 33 1.077300e-05 8.565400e-03 # simplex 1122 -1123 1124 2 33 9.394100e-06 6.518600e-03 # simplex 1123 -1124 1125 2 33 8.017100e-06 4.751300e-03 # simplex 1124 -1125 1126 2 33 6.644800e-06 3.263500e-03 # simplex 1125 -1126 1127 2 33 4.613200e-06 2.055100e-03 # simplex 1126 -1127 1128 2 33 3.909400e-06 1.402100e-03 # simplex 1127 -1128 1129 2 33 3.905300e-06 1.402100e-03 # simplex 1128 -1129 1130 2 33 3.391700e-06 1.402100e-03 # simplex 1129 -1130 1131 2 33 3.391800e-06 1.218100e-03 # simplex 1130 -1131 1132 2 33 3.390900e-06 1.218100e-03 # simplex 1131 -1132 1133 2 33 3.659700e-06 1.218100e-03 # simplex 1132 -1133 1134 2 33 3.637100e-06 1.295300e-03 # simplex 1133 -1134 1135 2 33 3.590000e-06 1.262700e-03 # simplex 1134 -1135 1136 2 33 4.416100e-06 1.230500e-03 # simplex 1135 -1136 1137 2 33 4.054400e-06 1.274600e-03 # simplex 1136 -1137 1138 2 33 2.888300e-06 8.622700e-04 # simplex 1137 -1138 1139 2 33 2.593800e-06 6.125900e-04 # simplex 1138 -1139 1140 2 33 2.661200e-06 6.446600e-04 # simplex 1139 -1140 1141 2 33 2.411300e-06 6.775500e-04 # simplex 1140 -1141 1142 2 33 2.514300e-06 6.346600e-04 # simplex 1141 -1142 1143 2 33 2.663400e-06 7.110400e-04 # simplex 1142 -1143 1144 2 33 2.675700e-06 7.917700e-04 # simplex 1143 -1144 1145 2 33 2.711400e-06 7.893700e-04 # simplex 1144 -1145 1146 2 33 2.840200e-06 7.534900e-04 # simplex 1145 -1146 1147 2 33 2.692700e-06 7.032700e-04 # simplex 1146 -1147 1148 2 33 2.187900e-06 5.825500e-04 # simplex 1147 -1148 1149 2 33 2.179900e-06 5.180300e-04 # simplex 1148 -1149 1150 2 33 2.382400e-06 6.172300e-04 # simplex 1149 -1150 1151 2 33 2.737500e-06 7.251300e-04 # simplex 1150 -1151 1152 2 33 2.800300e-06 8.077500e-04 # simplex 1151 -1152 1153 2 33 2.726800e-06 7.655800e-04 # simplex 1152 -1153 1154 2 33 2.723900e-06 7.245500e-04 # simplex 1153 -1154 1155 2 33 2.606900e-06 6.941200e-04 # simplex 1154 -1155 1156 2 33 2.443400e-06 6.110800e-04 # simplex 1155 -1156 1157 2 33 2.285400e-06 5.333300e-04 # simplex 1156 -1157 1158 2 33 1.968800e-06 4.608600e-04 # simplex 1157 -1158 1159 2 33 1.840000e-06 3.654000e-04 # simplex 1158 -1159 1160 2 33 1.729500e-06 3.234800e-04 # simplex 1159 -1160 1161 2 33 1.848000e-06 2.841100e-04 # simplex 1160 -1161 1162 2 33 1.860300e-06 3.056600e-04 # simplex 1161 -1162 1163 2 33 1.982600e-06 3.561500e-04 # simplex 1162 -1163 1164 2 33 2.061600e-06 4.132400e-04 # simplex 1163 -1164 1165 2 33 2.077100e-06 4.194300e-04 # simplex 1164 -1165 1166 2 33 2.081000e-06 4.256600e-04 # simplex 1165 -1166 1167 2 33 2.096900e-06 4.217200e-04 # simplex 1166 -1167 1168 2 33 2.107700e-06 4.268700e-04 # simplex 1167 -1168 1169 2 33 2.512100e-06 4.320400e-04 # simplex 1168 -1169 1170 2 33 2.487800e-06 5.082700e-04 # simplex 1169 -1170 1171 2 33 2.425600e-06 4.829800e-04 # simplex 1170 -1171 1172 2 33 2.480300e-06 4.583300e-04 # simplex 1171 -1172 1173 2 33 2.415900e-06 4.692800e-04 # simplex 1172 -1173 1174 2 33 2.353300e-06 4.452600e-04 # simplex 1173 -1174 1175 2 33 2.289100e-06 4.218700e-04 # simplex 1174 -1175 1176 2 33 2.229500e-06 3.991100e-04 # simplex 1175 -1176 1177 2 33 2.165400e-06 3.769800e-04 # simplex 1176 -1177 1178 2 33 2.102900e-06 3.554800e-04 # simplex 1177 -1178 1179 2 33 1.905300e-06 3.346200e-04 # simplex 1178 -1179 1180 2 33 1.788100e-06 2.645800e-04 # simplex 1179 -1180 1181 2 33 1.239900e-06 2.138400e-04 # simplex 1180 -1181 1182 2 33 1.178400e-06 1.546400e-04 # simplex 1181 -1182 1183 2 33 1.191400e-06 1.585100e-04 # simplex 1182 -1183 1184 2 33 1.476000e-06 1.624300e-04 # simplex 1183 -1184 1185 2 33 1.532300e-06 2.063900e-04 # simplex 1184 -1185 1186 2 33 1.888700e-06 2.331700e-04 # simplex 1185 -1186 1187 2 33 1.906700e-06 2.643600e-04 # simplex 1186 -1187 1188 2 33 1.829800e-06 2.439400e-04 # simplex 1187 -1188 1189 2 33 1.756400e-06 2.243400e-04 # simplex 1188 -1189 1190 2 33 1.681300e-06 2.055500e-04 # simplex 1189 -1190 1191 2 33 1.484100e-06 1.875900e-04 # simplex 1190 -1146 1192 2 34 2.725700e-06 6.613300e-04 # simplex 1191 -1192 1193 2 34 2.414100e-06 5.175500e-04 # simplex 1192 -1193 1194 2 34 2.155100e-06 3.914000e-04 # simplex 1193 -1194 1195 2 34 2.030000e-06 3.961600e-04 # simplex 1194 -1195 1196 2 34 2.124000e-06 4.326800e-04 # simplex 1195 -1196 1197 2 34 1.562200e-06 4.708100e-04 # simplex 1196 -1197 1198 2 34 1.455200e-06 2.568400e-04 # simplex 1197 -1198 1199 2 34 1.404700e-06 1.593700e-04 # simplex 1198 -1199 1200 2 34 1.173500e-06 1.443300e-04 # simplex 1199 -1200 1201 2 34 1.123700e-06 1.323500e-04 # simplex 1200 -1201 1202 2 34 1.113600e-06 1.209000e-04 # simplex 1201 -1202 1203 2 34 1.019200e-06 1.073600e-04 # simplex 1202 -1203 1204 2 34 8.805600e-07 8.016500e-05 # simplex 1203 -1204 1205 2 34 7.142900e-07 5.694000e-05 # simplex 1204 -228 1206 2 35 1.157400e-05 8.455600e-03 # simplex 1205 -1206 1207 2 35 9.538600e-06 5.761700e-03 # simplex 1206 -1207 1208 2 35 7.522400e-06 3.584500e-03 # simplex 1207 -1208 1209 2 35 4.537200e-06 1.924000e-03 # simplex 1208 -1209 1210 2 35 3.522100e-06 1.081000e-03 # simplex 1209 -1210 1211 2 35 3.608600e-06 1.046200e-03 # simplex 1210 -1211 1212 2 35 3.517500e-06 1.062100e-03 # simplex 1211 -1212 1213 2 35 3.389100e-06 9.864000e-04 # simplex 1212 -1213 1214 2 35 3.065000e-06 9.134700e-04 # simplex 1213 -1214 1215 2 35 2.868900e-06 7.581100e-04 # simplex 1214 -1215 1216 2 35 1.882500e-06 6.168400e-04 # simplex 1215 -1216 1217 2 35 1.746800e-06 3.778300e-04 # simplex 1216 -1217 1218 2 35 1.935700e-06 3.520700e-04 # simplex 1217 -1218 1219 2 35 1.926100e-06 3.975700e-04 # simplex 1218 -1219 1220 2 35 1.977800e-06 4.188900e-04 # simplex 1219 -1220 1221 2 35 2.506100e-06 4.407600e-04 # simplex 1220 -1221 1222 2 35 2.538800e-06 5.697200e-04 # simplex 1221 -1222 1223 2 35 2.544100e-06 5.709600e-04 # simplex 1222 -1223 1224 2 35 2.544200e-06 5.722000e-04 # simplex 1223 -1224 1225 2 35 2.482600e-06 5.734400e-04 # simplex 1224 -1225 1226 2 35 2.428000e-06 5.363300e-04 # simplex 1225 -1226 1227 2 35 2.308500e-06 4.856700e-04 # simplex 1226 -1227 1228 2 35 2.191000e-06 4.375300e-04 # simplex 1227 -1228 1229 2 35 2.075100e-06 3.919000e-04 # simplex 1228 -1229 1230 2 35 1.956800e-06 3.487800e-04 # simplex 1229 -1230 1231 2 35 2.156500e-06 3.081700e-04 # simplex 1230 -1231 1232 2 35 2.301100e-06 3.817900e-04 # simplex 1231 -1232 1233 2 35 2.720600e-06 5.330700e-04 # simplex 1232 -1233 1234 2 35 3.142900e-06 7.096100e-04 # simplex 1233 -1234 1235 2 35 3.558100e-06 9.114000e-04 # simplex 1234 -1235 1236 2 35 3.977900e-06 1.138400e-03 # simplex 1235 -1236 1237 2 35 4.197600e-06 1.390700e-03 # simplex 1236 -1237 1238 2 35 4.263000e-06 1.426000e-03 # simplex 1237 -1238 1239 2 35 3.999200e-06 1.256300e-03 # simplex 1238 -1239 1240 2 35 3.740400e-06 1.097400e-03 # simplex 1239 -1240 1241 2 35 3.475900e-06 9.491800e-04 # simplex 1240 -1241 1242 2 35 3.174300e-06 8.117300e-04 # simplex 1241 -1242 1243 2 35 3.171800e-06 7.530300e-04 # simplex 1242 -1243 1244 2 35 3.424200e-06 8.776400e-04 # simplex 1243 -1244 1245 2 35 3.676900e-06 1.011800e-03 # simplex 1244 -1245 1246 2 35 3.470500e-06 1.155500e-03 # simplex 1245 -1246 1247 2 35 3.461600e-06 1.020300e-03 # simplex 1246 -1247 1248 2 35 3.232500e-06 8.874300e-04 # simplex 1247 -1248 1249 2 35 3.730600e-06 7.638600e-04 # simplex 1248 -1249 1250 2 35 3.461700e-06 8.216600e-04 # simplex 1249 -1250 1251 2 35 3.221000e-06 7.114100e-04 # simplex 1250 -1251 1252 2 35 2.704300e-06 6.091000e-04 # simplex 1251 -1237 1253 2 36 4.528800e-06 1.491300e-03 # simplex 1252 -1253 1254 2 36 4.405300e-06 1.408300e-03 # simplex 1253 -1254 1255 2 36 4.276000e-06 1.327700e-03 # simplex 1254 -1255 1256 2 36 4.149400e-06 1.249500e-03 # simplex 1255 -1256 1257 2 36 4.017600e-06 1.173600e-03 # simplex 1256 -1257 1258 2 36 3.893500e-06 1.100100e-03 # simplex 1257 -1258 1259 2 36 3.765600e-06 1.029000e-03 # simplex 1258 -1259 1260 2 36 3.633800e-06 9.603100e-04 # simplex 1259 -1260 1261 2 36 3.575800e-06 9.325300e-04 # simplex 1260 -1261 1262 2 36 3.596500e-06 9.409300e-04 # simplex 1261 -1262 1263 2 36 3.354600e-06 9.493700e-04 # simplex 1262 -228 1264 2 37 1.157300e-05 8.005500e-03 # simplex 1263 -1264 1265 2 37 8.989500e-06 4.852400e-03 # simplex 1264 -1265 1266 2 37 5.797500e-06 2.488800e-03 # simplex 1265 -1266 1267 2 37 4.114800e-06 1.325600e-03 # simplex 1266 -1267 1268 2 37 3.625900e-06 1.031200e-03 # simplex 1267 -1268 1269 2 37 2.598600e-06 7.738400e-04 # simplex 1268 -1269 1270 2 37 2.396300e-06 5.534600e-04 # simplex 1269 -1270 1271 2 37 2.412900e-06 5.613700e-04 # simplex 1270 -1271 1272 2 37 2.430100e-06 5.693200e-04 # simplex 1271 -1272 1273 2 37 2.579200e-06 5.773400e-04 # simplex 1272 -1273 1274 2 37 2.504500e-06 5.964400e-04 # simplex 1273 -1274 1275 2 37 2.333300e-06 5.176900e-04 # simplex 1274 -1275 1276 2 37 2.162100e-06 4.445200e-04 # simplex 1275 -1276 1277 2 37 2.400100e-06 3.769200e-04 # simplex 1276 -1277 1278 2 37 2.472700e-06 4.730300e-04 # simplex 1277 -1278 1279 2 37 1.905800e-06 6.154000e-04 # simplex 1278 -1279 1280 2 37 2.004700e-06 4.383700e-04 # simplex 1279 -1280 1281 2 37 1.755400e-06 4.257600e-04 # simplex 1280 -1281 1282 2 37 1.778300e-06 4.146200e-04 # simplex 1281 -1282 1283 2 37 2.574600e-06 4.481200e-04 # simplex 1282 -1283 1284 2 37 2.595200e-06 5.965900e-04 # simplex 1283 -1284 1285 2 37 2.531900e-06 5.690800e-04 # simplex 1284 -1285 1286 2 37 2.694300e-06 5.422300e-04 # simplex 1285 -1286 1287 2 37 2.416400e-06 4.653500e-04 # simplex 1286 -1287 1288 2 37 1.760700e-06 2.895700e-04 # simplex 1287 -1283 1289 2 38 2.511500e-06 5.569200e-04 # simplex 1288 -1289 1290 2 38 1.965400e-06 4.896600e-04 # simplex 1289 -1290 1291 2 38 1.874000e-06 4.023900e-04 # simplex 1290 -1291 1292 2 38 2.011300e-06 3.812900e-04 # simplex 1291 -1292 1293 2 38 1.892300e-06 3.560200e-04 # simplex 1292 -1293 1294 2 38 1.700500e-06 2.881200e-04 # simplex 1293 -1294 1295 2 38 1.741200e-06 2.274000e-04 # simplex 1294 -1295 1296 2 38 1.635200e-06 2.187900e-04 # simplex 1295 -1296 1297 2 38 1.647500e-06 2.219500e-04 # simplex 1296 -1297 1298 2 38 1.396300e-06 2.251400e-04 # simplex 1297 -1298 1299 2 38 1.370300e-06 2.000500e-04 # simplex 1298 -1299 1300 2 38 1.306000e-06 1.819900e-04 # simplex 1299 -1300 1301 2 38 1.235100e-06 1.647800e-04 # simplex 1300 -228 1302 2 39 9.097000e-06 6.901700e-03 # simplex 1301 -1302 1303 2 39 7.621100e-06 4.847100e-03 # simplex 1302 -1303 1304 2 39 6.138700e-06 3.155500e-03 # simplex 1303 -1304 1305 2 39 4.837100e-06 1.827000e-03 # simplex 1304 -1305 1306 2 39 3.751500e-06 1.310800e-03 # simplex 1305 -1306 1307 2 39 3.552600e-06 1.175500e-03 # simplex 1306 -1307 1308 2 39 3.357200e-06 1.047500e-03 # simplex 1307 -1308 1309 2 39 3.378000e-06 9.268300e-04 # simplex 1308 -1309 1310 2 39 3.240000e-06 9.096400e-04 # simplex 1309 -1310 1311 2 39 3.173400e-06 8.743100e-04 # simplex 1310 -1311 1312 2 39 3.109900e-06 8.396800e-04 # simplex 1311 -1312 1313 2 39 3.006000e-06 8.057500e-04 # simplex 1312 -1313 1314 2 39 3.001700e-06 7.987700e-04 # simplex 1313 -1314 1315 2 39 3.065800e-06 8.313000e-04 # simplex 1314 -1315 1316 2 39 3.122800e-06 8.644800e-04 # simplex 1315 -1316 1317 2 39 3.183200e-06 8.983100e-04 # simplex 1316 -1317 1318 2 39 3.161400e-06 9.327900e-04 # simplex 1317 -1318 1319 2 39 3.244800e-06 9.452400e-04 # simplex 1318 -1319 1320 2 39 3.350800e-06 1.010200e-03 # simplex 1319 -1320 1321 2 39 3.465500e-06 1.077200e-03 # simplex 1320 -1321 1322 2 39 3.573500e-06 1.146500e-03 # simplex 1321 -1322 1323 2 39 3.680900e-06 1.217900e-03 # simplex 1322 -1323 1324 2 39 3.792800e-06 1.291400e-03 # simplex 1323 -1324 1325 2 39 4.438000e-06 1.367100e-03 # simplex 1324 -1325 1326 2 39 4.406800e-06 1.472500e-03 # simplex 1325 -1326 1327 2 39 4.199000e-06 1.340600e-03 # simplex 1326 -1327 1328 2 39 3.999500e-06 1.214900e-03 # simplex 1327 -1328 1329 2 39 3.369700e-06 1.095400e-03 # simplex 1328 -1329 1330 2 39 3.209700e-06 8.419900e-04 # simplex 1329 -1330 1331 2 39 3.070200e-06 7.699700e-04 # simplex 1330 -1331 1332 2 39 2.928900e-06 7.011700e-04 # simplex 1331 -1332 1333 2 39 3.047100e-06 6.355800e-04 # simplex 1332 -1333 1334 2 39 3.051800e-06 7.478000e-04 # simplex 1333 -1334 1335 2 39 3.210200e-06 8.283500e-04 # simplex 1334 -1335 1336 2 39 2.950000e-06 9.130100e-04 # simplex 1335 -1336 1337 2 39 2.995400e-06 8.410800e-04 # simplex 1336 -1337 1338 2 39 2.948900e-06 8.147400e-04 # simplex 1337 -1338 1339 2 39 2.885800e-06 7.888200e-04 # simplex 1338 -1309 1340 2 40 3.033200e-06 8.918400e-04 # simplex 1339 -1340 1341 2 40 3.226900e-06 1.007900e-03 # simplex 1340 -1341 1342 2 40 3.419000e-06 1.131100e-03 # simplex 1341 -1342 1343 2 40 3.436900e-06 1.261300e-03 # simplex 1342 -1343 1344 2 40 3.521400e-06 1.255500e-03 # simplex 1343 -1344 1345 2 40 3.524400e-06 1.255500e-03 # simplex 1344 -1345 1346 2 40 3.524400e-06 1.255500e-03 # simplex 1345 -1346 1347 2 40 4.246400e-06 1.255500e-03 # simplex 1346 -1347 1348 2 40 4.244200e-06 1.518800e-03 # simplex 1347 -1348 1349 2 40 4.247400e-06 1.518800e-03 # simplex 1348 -1349 1350 2 40 3.610700e-06 1.518800e-03 # simplex 1349 -1350 1351 2 40 3.560400e-06 1.262900e-03 # simplex 1350 -1351 1352 2 40 3.459200e-06 1.191700e-03 # simplex 1351 -1352 1353 2 40 3.353600e-06 1.122600e-03 # simplex 1352 -1353 1354 2 40 3.819800e-06 1.055600e-03 # simplex 1353 -1354 1355 2 40 3.664200e-06 1.129800e-03 # simplex 1354 -1355 1356 2 40 3.474200e-06 1.014500e-03 # simplex 1355 -1356 1357 2 40 3.281400e-06 9.054900e-04 # simplex 1356 -1357 1358 2 40 3.088200e-06 8.026300e-04 # simplex 1357 -1358 1359 2 40 2.638300e-06 7.059700e-04 # simplex 1358 -1359 1360 2 40 2.635800e-06 6.106600e-04 # simplex 1359 -1360 1361 2 40 2.815300e-06 6.956200e-04 # simplex 1360 -1361 1362 2 40 2.992800e-06 7.861000e-04 # simplex 1361 -1362 1363 2 40 3.788200e-06 8.821200e-04 # simplex 1362 -1363 1364 2 40 3.860600e-06 1.131800e-03 # simplex 1363 -1364 1365 2 40 3.801100e-06 1.096800e-03 # simplex 1364 -1365 1366 2 40 3.453800e-06 1.062500e-03 # simplex 1365 -1366 1367 2 40 3.377600e-06 9.612500e-04 # simplex 1366 -1367 1368 2 40 3.276700e-06 9.046600e-04 # simplex 1367 -1368 1369 2 40 3.174200e-06 8.497800e-04 # simplex 1368 -1369 1370 2 40 3.074800e-06 7.966300e-04 # simplex 1369 -1370 1371 2 40 3.213000e-06 7.451900e-04 # simplex 1370 -1371 1372 2 40 3.033400e-06 6.715500e-04 # simplex 1371 -1372 1373 2 40 2.768000e-06 5.605300e-04 # simplex 1372 -1373 1374 2 40 2.506800e-06 4.595500e-04 # simplex 1373 -1374 1375 2 40 2.098300e-06 3.685900e-04 # simplex 1374 -223 1376 2 41 7.053100e-06 4.375500e-03 # simplex 1375 -1376 1377 2 41 5.885400e-06 3.046800e-03 # simplex 1376 -1377 1378 2 41 4.712100e-06 1.958500e-03 # simplex 1377 -1378 1379 2 41 3.568000e-06 1.110800e-03 # simplex 1378 -1379 1380 2 41 2.847700e-06 7.642800e-04 # simplex 1379 -1380 1381 2 41 2.777600e-06 7.271700e-04 # simplex 1380 -1381 1382 2 41 2.707400e-06 6.909800e-04 # simplex 1381 -1382 1383 2 41 2.571700e-06 6.557200e-04 # simplex 1382 -1383 1384 2 41 2.568700e-06 6.378100e-04 # simplex 1383 -1384 1385 2 41 2.631200e-06 6.692100e-04 # simplex 1384 -1385 1386 2 41 2.846500e-06 7.013700e-04 # simplex 1385 -1386 1387 2 41 2.827700e-06 7.309000e-04 # simplex 1386 -1387 1388 2 41 2.722400e-06 6.777000e-04 # simplex 1387 -1388 1389 2 41 2.891400e-06 6.265100e-04 # simplex 1388 -1389 1390 2 41 2.822600e-06 6.500100e-04 # simplex 1389 -1390 1391 2 41 2.807100e-06 6.422900e-04 # simplex 1390 -1391 1392 2 41 2.788900e-06 6.346200e-04 # simplex 1391 -1392 1393 2 41 2.732500e-06 6.269900e-04 # simplex 1392 -1393 1394 2 41 2.721700e-06 6.220600e-04 # simplex 1393 -1394 1395 2 41 2.711600e-06 6.182300e-04 # simplex 1394 -1395 1396 2 41 2.158000e-06 6.144200e-04 # simplex 1395 -1396 1397 2 41 2.124800e-06 4.562300e-04 # simplex 1396 -1397 1398 2 41 2.060400e-06 4.290000e-04 # simplex 1397 -1398 1399 2 41 2.199200e-06 4.026100e-04 # simplex 1398 -1399 1400 2 41 2.185600e-06 4.515800e-04 # simplex 1399 -1400 1401 2 41 2.233300e-06 4.713600e-04 # simplex 1400 -1401 1402 2 41 2.233400e-06 4.915600e-04 # simplex 1401 -1402 1403 2 41 2.261400e-06 4.814700e-04 # simplex 1402 -1403 1404 2 41 2.278200e-06 4.877100e-04 # simplex 1403 -1404 1405 2 41 2.290600e-06 4.939900e-04 # simplex 1404 -1405 1406 2 41 2.557600e-06 5.003200e-04 # simplex 1405 -1406 1407 2 41 2.496400e-06 5.239400e-04 # simplex 1406 -1407 1408 2 41 2.346800e-06 4.648800e-04 # simplex 1407 -1408 1409 2 41 2.206600e-06 4.093600e-04 # simplex 1408 -1409 1410 2 41 1.969300e-06 3.573700e-04 # simplex 1409 -1399 1411 2 42 1.354400e-06 2.531900e-04 # simplex 1410 -1411 1412 2 42 1.774700e-06 1.732100e-04 # simplex 1411 -1412 1413 2 42 1.535600e-06 1.968900e-04 # simplex 1412 -1413 1414 2 42 1.453100e-06 1.759400e-04 # simplex 1413 -1414 1415 2 42 1.367800e-06 1.561800e-04 # simplex 1414 -1415 1416 2 42 1.283700e-06 1.375900e-04 # simplex 1415 -1416 1417 2 42 1.122000e-06 1.201800e-04 # simplex 1416 -183 1418 2 43 8.154300e-06 4.900300e-03 # simplex 1417 -1418 1419 2 43 5.800800e-06 2.430300e-03 # simplex 1418 -1419 1420 2 43 4.237100e-06 1.242400e-03 # simplex 1419 -1420 1421 2 43 3.923400e-06 1.449600e-03 # simplex 1420 -1421 1422 2 43 4.113800e-06 1.377100e-03 # simplex 1421 -1422 1423 2 43 4.320700e-06 1.224000e-03 # simplex 1422 -1423 1424 2 43 3.985600e-06 1.185900e-03 # simplex 1423 -1424 1425 2 43 3.859700e-06 9.506600e-04 # simplex 1424 -1425 1426 2 43 3.667200e-06 9.035700e-04 # simplex 1425 -1426 1427 2 43 3.762800e-06 9.493700e-04 # simplex 1426 -1427 1428 2 43 2.241800e-06 9.963000e-04 # simplex 1427 -1428 1429 2 43 2.274800e-06 6.170500e-04 # simplex 1428 -1429 1430 2 43 3.953600e-06 6.237800e-04 # simplex 1429 -1430 1431 2 43 4.138200e-06 1.134200e-03 # simplex 1430 -1431 1432 2 43 3.750000e-06 1.326600e-03 # simplex 1431 -1432 1433 2 43 3.850500e-06 1.192800e-03 # simplex 1432 -1433 1434 2 43 3.769000e-06 1.142800e-03 # simplex 1433 -1434 1435 2 43 3.687600e-06 1.094000e-03 # simplex 1434 -1435 1436 2 43 3.892000e-06 1.046200e-03 # simplex 1435 -1436 1437 2 43 3.525300e-06 9.575900e-04 # simplex 1436 -1437 1438 2 43 2.709300e-06 6.162700e-04 # simplex 1437 -183 1439 2 44 6.584000e-06 4.210000e-03 # simplex 1438 -1439 1440 2 44 5.333600e-06 2.769700e-03 # simplex 1439 -1440 1441 2 44 4.703500e-06 1.631100e-03 # simplex 1440 -1441 1442 2 44 4.010000e-06 1.012900e-03 # simplex 1441 -1442 1443 2 44 3.459100e-06 9.316200e-04 # simplex 1442 -1443 1444 2 44 3.260000e-06 9.167400e-04 # simplex 1443 -1442 1445 2 45 3.417900e-06 9.436000e-04 # simplex 1444 -1445 1446 2 45 3.028300e-06 1.168200e-03 # simplex 1445 -1446 1447 2 45 2.987700e-06 9.513100e-04 # simplex 1446 -1447 1448 2 45 2.566000e-06 7.019500e-04 # simplex 1447 -1448 1449 2 45 1.871100e-06 4.904900e-04 # simplex 1448 -1449 1450 2 45 1.768500e-06 3.928100e-04 # simplex 1449 -1450 1451 2 45 2.616400e-06 4.777000e-04 # simplex 1450 -1451 1452 2 45 2.602200e-06 4.843300e-04 # simplex 1451 -1452 1453 2 45 2.074700e-06 3.746300e-04 # simplex 1452 -1453 1454 2 45 1.461700e-06 3.101200e-04 # simplex 1453 -1454 1455 2 45 1.379600e-06 2.097000e-04 # simplex 1454 -1455 1456 2 45 1.179300e-06 2.051800e-04 # simplex 1455 -1456 1457 2 45 1.231300e-06 1.968400e-04 # simplex 1456 -1457 1458 2 45 1.945800e-06 2.346300e-04 # simplex 1457 -1458 1459 2 45 1.972500e-06 3.477900e-04 # simplex 1458 -1459 1460 2 45 1.869400e-06 3.120600e-04 # simplex 1459 -1460 1461 2 45 1.764400e-06 2.782500e-04 # simplex 1460 -1461 1462 2 45 1.686800e-06 2.463900e-04 # simplex 1461 -1462 1463 2 45 1.610800e-06 2.306300e-04 # simplex 1462 -1463 1464 2 45 1.564800e-06 2.177400e-04 # simplex 1463 -1464 1465 2 45 1.512500e-06 2.052100e-04 # simplex 1464 -1451 1466 2 46 2.774500e-06 6.953800e-04 # simplex 1465 -1466 1467 2 46 2.630100e-06 6.248000e-04 # simplex 1466 -1467 1468 2 46 2.226100e-06 5.580000e-04 # simplex 1467 -1468 1469 2 46 2.165600e-06 4.701000e-04 # simplex 1468 -1469 1470 2 46 2.177200e-06 4.746600e-04 # simplex 1469 -1470 1471 2 46 2.515300e-06 4.792400e-04 # simplex 1470 -1471 1472 2 46 2.519800e-06 5.623500e-04 # simplex 1471 -1472 1473 2 46 2.521700e-06 5.631800e-04 # simplex 1472 -1473 1474 2 46 2.303500e-06 5.640100e-04 # simplex 1473 -1474 1475 2 46 2.323000e-06 5.129700e-04 # simplex 1474 -1475 1476 2 46 2.362900e-06 5.307800e-04 # simplex 1475 -1476 1477 2 46 2.404500e-06 5.488900e-04 # simplex 1476 -1477 1478 2 46 2.442900e-06 5.673000e-04 # simplex 1477 -1478 1479 2 46 2.671400e-06 5.860200e-04 # simplex 1478 -1479 1480 2 46 2.720900e-06 6.618300e-04 # simplex 1479 -1480 1481 2 46 2.770900e-06 6.863800e-04 # simplex 1480 -1481 1482 2 46 2.821000e-06 7.113900e-04 # simplex 1481 -1482 1483 2 46 2.672900e-06 7.368300e-04 # simplex 1482 -1483 1484 2 46 2.644600e-06 6.715200e-04 # simplex 1483 -1484 1485 2 46 2.553000e-06 6.238400e-04 # simplex 1484 -1485 1486 2 46 2.456200e-06 5.779200e-04 # simplex 1485 -1486 1487 2 46 2.361500e-06 5.337500e-04 # simplex 1486 -1487 1488 2 46 2.812400e-06 4.913400e-04 # simplex 1487 -1488 1489 2 46 2.705500e-06 5.290200e-04 # simplex 1488 -1489 1490 2 46 2.604200e-06 4.908300e-04 # simplex 1489 -1490 1491 2 46 2.506500e-06 4.540800e-04 # simplex 1490 -1491 1492 2 46 2.407100e-06 4.187500e-04 # simplex 1491 -1492 1493 2 46 2.305900e-06 3.848600e-04 # simplex 1492 -1493 1494 2 46 2.049300e-06 3.523900e-04 # simplex 1493 -1483 1495 2 47 3.067500e-06 7.902900e-04 # simplex 1494 -1495 1496 2 47 3.013400e-06 7.625900e-04 # simplex 1495 -1496 1497 2 47 2.960000e-06 7.353800e-04 # simplex 1496 -1497 1498 2 47 2.905000e-06 7.086600e-04 # simplex 1497 -1498 1499 2 47 2.850600e-06 6.824400e-04 # simplex 1498 -1499 1500 2 47 2.797100e-06 6.567100e-04 # simplex 1499 -1500 1501 2 47 2.742000e-06 6.314800e-04 # simplex 1500 -1501 1502 2 47 2.695200e-06 6.067400e-04 # simplex 1501 -1502 1503 2 47 2.714800e-06 5.861100e-04 # simplex 1502 -1503 1504 2 47 2.811600e-06 6.286100e-04 # simplex 1503 -1504 1505 2 47 2.908300e-06 6.726000e-04 # simplex 1504 -1505 1506 2 47 3.005000e-06 7.180700e-04 # simplex 1505 -1506 1507 2 47 2.968100e-06 7.650300e-04 # simplex 1506 -1507 1508 2 47 2.867500e-06 6.982200e-04 # simplex 1507 -1508 1509 2 47 2.558100e-06 5.558300e-04 # simplex 1508 -1509 1510 2 47 2.248400e-06 4.296800e-04 # simplex 1509 -1510 1511 2 47 1.865000e-06 3.197700e-04 # simplex 1510 -1511 1512 2 47 1.731300e-06 2.729000e-04 # simplex 1511 -1512 1513 2 47 1.812700e-06 2.845900e-04 # simplex 1512 -1513 1514 2 47 1.813800e-06 2.894300e-04 # simplex 1513 -1514 1515 2 47 1.778300e-06 2.782200e-04 # simplex 1514 -1515 1516 2 47 1.742800e-06 2.672300e-04 # simplex 1515 -1516 1517 2 47 1.685800e-06 2.564600e-04 # simplex 1516 -1507 1518 2 48 3.069600e-06 7.768800e-04 # simplex 1517 -1518 1519 2 48 2.786800e-06 6.404000e-04 # simplex 1518 -1519 1520 2 48 2.506600e-06 5.171100e-04 # simplex 1519 -1520 1521 2 48 2.221100e-06 4.070000e-04 # simplex 1520 -1521 1522 2 48 1.937400e-06 3.100700e-04 # simplex 1521 -1474 1523 2 49 1.864900e-06 4.044800e-04 # simplex 1522 -1523 1524 2 49 1.770300e-06 3.642000e-04 # simplex 1523 -1524 1525 2 49 2.066300e-06 3.260300e-04 # simplex 1524 -1525 1526 2 49 1.936800e-06 3.530900e-04 # simplex 1525 -1526 1527 2 49 1.795300e-06 3.034500e-04 # simplex 1526 -1527 1528 2 49 1.654000e-06 2.575700e-04 # simplex 1527 -1528 1529 2 49 1.512600e-06 2.154500e-04 # simplex 1528 -1529 1530 2 49 1.371500e-06 1.770900e-04 # simplex 1529 -1530 1531 2 49 1.222900e-06 1.424900e-04 # simplex 1530 -180 1532 2 50 9.520700e-06 7.339100e-03 # simplex 1531 -1532 1533 2 50 8.210000e-06 5.460000e-03 # simplex 1532 -1533 1534 2 50 6.898700e-06 3.858900e-03 # simplex 1533 -1534 1535 2 50 5.588500e-06 2.535600e-03 # simplex 1534 -1535 1536 2 50 4.580800e-06 1.490100e-03 # simplex 1535 -1536 1537 2 50 3.725700e-06 1.105900e-03 # simplex 1536 -1537 1538 2 50 2.104600e-06 1.051200e-03 # simplex 1537 -1538 1539 2 50 2.139600e-06 5.802000e-04 # simplex 1538 -1539 1540 2 50 3.038700e-06 6.453300e-04 # simplex 1539 -1540 1541 2 50 3.053900e-06 9.184800e-04 # simplex 1540 -1541 1542 2 50 2.935700e-06 8.486600e-04 # simplex 1541 -1542 1543 2 50 3.430300e-06 7.816100e-04 # simplex 1542 -1543 1544 2 50 3.449100e-06 1.004800e-03 # simplex 1543 -1544 1545 2 50 3.510500e-06 1.050800e-03 # simplex 1544 -1545 1546 2 50 3.422700e-06 9.969300e-04 # simplex 1545 -1546 1547 2 50 3.331800e-06 9.445200e-04 # simplex 1546 -1547 1548 2 50 3.240300e-06 8.935200e-04 # simplex 1547 -1548 1549 2 50 3.146000e-06 8.439400e-04 # simplex 1548 -1549 1550 2 50 3.058000e-06 7.957800e-04 # simplex 1549 -1550 1551 2 50 2.964900e-06 7.490200e-04 # simplex 1550 -1544 1552 2 51 2.895000e-06 8.162400e-04 # simplex 1551 -1552 1553 2 51 2.559100e-06 6.376300e-04 # simplex 1552 -1553 1554 2 51 2.410300e-06 4.810700e-04 # simplex 1553 -1554 1555 2 51 2.161600e-06 4.174200e-04 # simplex 1554 -1555 1556 2 51 2.049300e-06 3.747500e-04 # simplex 1555 -1556 1557 2 51 1.887100e-06 3.343800e-04 # simplex 1556 -1538 1558 2 52 2.675300e-06 6.777400e-04 # simplex 1557 -1558 1559 2 52 1.930400e-06 4.505300e-04 # simplex 1558 -1559 1560 2 52 1.634600e-06 2.970400e-04 # simplex 1559 -1560 1561 2 52 2.100900e-06 2.521800e-04 # simplex 1560 -1561 1562 2 52 1.971300e-06 3.105000e-04 # simplex 1561 -1562 1563 2 52 1.402300e-06 2.871500e-04 # simplex 1562 -1563 1564 2 52 1.367200e-06 2.017200e-04 # simplex 1563 -1564 1565 2 52 1.352200e-06 1.971400e-04 # simplex 1564 -1565 1566 2 52 1.508300e-06 1.926100e-04 # simplex 1565 -1566 1567 2 52 1.571400e-06 2.372100e-04 # simplex 1566 -1567 1568 2 52 1.713800e-06 2.821000e-04 # simplex 1567 -1568 1569 2 52 1.855900e-06 3.308900e-04 # simplex 1568 -1569 1570 2 52 1.996200e-06 3.835600e-04 # simplex 1569 -1570 1571 2 52 2.138300e-06 4.401200e-04 # simplex 1570 -1536 1572 2 53 3.714100e-06 1.038100e-03 # simplex 1571 -1572 1573 2 53 4.188700e-06 1.073700e-03 # simplex 1572 -1573 1574 2 53 4.026900e-06 1.118400e-03 # simplex 1573 -1574 1575 2 53 2.790400e-06 9.032800e-04 # simplex 1574 -1575 1576 2 53 2.667000e-06 6.598400e-04 # simplex 1575 -1576 1577 2 53 2.598600e-06 7.008000e-04 # simplex 1576 -1577 1578 2 53 2.656600e-06 7.010600e-04 # simplex 1577 -1578 1579 2 53 3.314300e-06 7.244300e-04 # simplex 1578 -1579 1580 2 53 3.221700e-06 8.617100e-04 # simplex 1579 -1580 1581 2 53 2.982500e-06 7.372400e-04 # simplex 1580 -1581 1582 2 53 2.740400e-06 6.224700e-04 # simplex 1581 -1582 1583 2 53 1.492700e-06 5.174200e-04 # simplex 1582 -1583 1584 2 53 1.477100e-06 2.862500e-04 # simplex 1583 -1584 1585 2 53 2.346600e-06 3.309800e-04 # simplex 1584 -1585 1586 2 53 2.336700e-06 5.098200e-04 # simplex 1585 -1586 1587 2 53 2.438300e-06 4.318200e-04 # simplex 1586 -1587 1588 2 53 2.248800e-06 4.185600e-04 # simplex 1587 -1588 1589 2 53 1.710700e-06 3.593100e-04 # simplex 1588 -1589 1590 2 53 1.640400e-06 2.643000e-04 # simplex 1589 -1590 1591 2 53 1.637100e-06 2.634800e-04 # simplex 1590 -1591 1592 2 53 1.635300e-06 2.626600e-04 # simplex 1591 -1592 1593 2 53 1.458700e-06 2.618300e-04 # simplex 1592 -1593 1594 2 53 1.413200e-06 2.230800e-04 # simplex 1593 -1594 1595 2 53 1.323100e-06 1.955700e-04 # simplex 1594 -1595 1596 2 53 1.219800e-06 1.698600e-04 # simplex 1595 -180 1597 2 54 8.914200e-06 6.453800e-03 # simplex 1596 -1597 1598 2 54 7.285000e-06 4.315300e-03 # simplex 1597 -1598 1599 2 54 5.655100e-06 2.607200e-03 # simplex 1598 -1599 1600 2 54 4.918900e-06 1.329500e-03 # simplex 1599 -1600 1601 2 54 3.290000e-06 1.257100e-03 # simplex 1600 -1601 1602 2 54 3.648300e-06 1.241000e-03 # simplex 1601 -1602 1603 2 54 2.581900e-06 1.241000e-03 # simplex 1602 -1603 1604 2 54 2.576900e-06 8.365400e-04 # simplex 1603 -1604 1605 2 54 2.625500e-06 8.365400e-04 # simplex 1604 -1605 1606 2 54 2.623200e-06 9.150700e-04 # simplex 1605 -1606 1607 2 54 3.319100e-06 9.150700e-04 # simplex 1606 -1607 1608 2 54 3.314700e-06 1.109600e-03 # simplex 1607 -1608 1609 2 54 3.097500e-06 1.109600e-03 # simplex 1608 -1609 1610 2 54 2.916900e-06 9.202600e-04 # simplex 1609 -1610 1611 2 54 3.582900e-06 6.677800e-04 # simplex 1610 -1611 1612 2 54 3.277900e-06 8.405500e-04 # simplex 1611 -1612 1613 2 54 3.371100e-06 8.889600e-04 # simplex 1612 -1613 1614 2 54 3.464000e-06 9.387200e-04 # simplex 1613 -1614 1615 2 54 3.634300e-06 9.898400e-04 # simplex 1614 -1615 1616 2 54 3.750800e-06 1.030300e-03 # simplex 1615 -1616 1617 2 54 3.567300e-06 1.106800e-03 # simplex 1616 -1617 1618 2 54 3.507900e-06 1.046800e-03 # simplex 1617 -1618 1619 2 54 3.262000e-06 9.045800e-04 # simplex 1618 -1619 1620 2 54 3.013400e-06 7.727100e-04 # simplex 1619 -1620 1621 2 54 2.615500e-06 6.512200e-04 # simplex 1620 -1621 1622 2 54 2.525800e-06 5.566800e-04 # simplex 1621 -1622 1623 2 54 2.592200e-06 5.813800e-04 # simplex 1622 -1623 1624 2 54 2.573900e-06 5.815700e-04 # simplex 1623 -1624 1625 2 54 2.477100e-06 5.387100e-04 # simplex 1624 -1625 1626 2 54 2.216600e-06 4.974900e-04 # simplex 1625 -1626 1627 2 54 2.153500e-06 4.382400e-04 # simplex 1626 -1627 1628 2 54 2.123400e-06 4.254000e-04 # simplex 1627 -1628 1629 2 54 1.711500e-06 4.127500e-04 # simplex 1628 -1629 1630 2 54 1.683300e-06 3.363000e-04 # simplex 1629 -1630 1631 2 54 1.652400e-06 3.242000e-04 # simplex 1630 -1631 1632 2 54 2.073600e-06 3.123200e-04 # simplex 1631 -1632 1633 2 54 2.219900e-06 4.552500e-04 # simplex 1632 -1633 1634 2 54 2.568200e-06 5.956800e-04 # simplex 1633 -1634 1635 2 54 2.647100e-06 6.369300e-04 # simplex 1634 -1635 1636 2 54 2.561200e-06 5.642400e-04 # simplex 1635 -1636 1637 2 54 2.559600e-06 5.684900e-04 # simplex 1636 -1637 1638 2 54 2.717100e-06 6.410800e-04 # simplex 1637 -1638 1639 2 54 2.487100e-06 7.180400e-04 # simplex 1638 -1639 1640 2 54 2.487600e-06 6.285300e-04 # simplex 1639 -1640 1641 2 54 2.350600e-06 5.612300e-04 # simplex 1640 -1641 1642 2 54 2.178100e-06 4.977500e-04 # simplex 1641 -1609 1643 2 55 3.683300e-06 1.264500e-03 # simplex 1642 -1643 1644 2 55 3.358200e-06 1.051200e-03 # simplex 1643 -1644 1645 2 55 3.032900e-06 8.576200e-04 # simplex 1644 -1645 1646 2 55 2.522200e-06 6.837200e-04 # simplex 1645 -1646 1647 2 55 2.337700e-06 5.447200e-04 # simplex 1646 -1647 1648 2 55 2.900200e-06 5.185900e-04 # simplex 1647 -1648 1649 2 55 2.793600e-06 6.146900e-04 # simplex 1648 -1649 1650 2 55 2.650800e-06 5.535500e-04 # simplex 1649 -1650 1651 2 55 2.650100e-06 4.956300e-04 # simplex 1650 -1651 1652 2 55 2.340700e-06 3.822000e-04 # simplex 1651 -1652 1653 2 55 1.734500e-06 2.419200e-04 # simplex 1652 -180 1654 2 56 8.569700e-06 6.696400e-03 # simplex 1653 -1654 1655 2 56 7.520100e-06 5.158300e-03 # simplex 1654 -1655 1656 2 56 6.470000e-06 3.820800e-03 # simplex 1655 -1656 1657 2 56 5.421200e-06 2.684100e-03 # simplex 1656 -1657 1658 2 56 3.925700e-06 1.748100e-03 # simplex 1657 -1658 1659 2 56 3.360600e-06 1.197900e-03 # simplex 1658 -1659 1660 2 56 3.360600e-06 1.197900e-03 # simplex 1659 -1660 1661 2 56 4.127000e-06 1.197900e-03 # simplex 1660 -1661 1662 2 56 4.127300e-06 1.456400e-03 # simplex 1661 -1662 1663 2 56 4.128000e-06 1.456400e-03 # simplex 1662 -1663 1664 2 56 4.125700e-06 1.456400e-03 # simplex 1663 -1664 1665 2 56 4.128000e-06 1.456400e-03 # simplex 1664 -1665 1666 2 56 4.128000e-06 1.456400e-03 # simplex 1665 -1666 1667 2 56 4.556400e-06 1.456400e-03 # simplex 1666 -1667 1668 2 56 4.557600e-06 1.625100e-03 # simplex 1667 -1668 1669 2 56 4.557700e-06 1.625100e-03 # simplex 1668 -1669 1670 2 56 4.555900e-06 1.625100e-03 # simplex 1669 -1670 1671 2 56 3.184700e-06 1.625100e-03 # simplex 1670 -1671 1672 2 56 3.181900e-06 1.118200e-03 # simplex 1671 -1672 1673 2 56 3.182200e-06 1.118200e-03 # simplex 1672 -1673 1674 2 56 4.133200e-06 1.118200e-03 # simplex 1673 -1674 1675 2 56 4.132800e-06 1.487200e-03 # simplex 1674 -1675 1676 2 56 4.129200e-06 1.487200e-03 # simplex 1675 -1676 1677 2 56 4.133000e-06 1.487200e-03 # simplex 1676 -1677 1678 2 56 4.133200e-06 1.487200e-03 # simplex 1677 -1678 1679 2 56 3.107200e-06 1.487200e-03 # simplex 1678 -1679 1680 2 56 3.108900e-06 1.112700e-03 # simplex 1679 -1680 1681 2 56 3.108400e-06 1.112700e-03 # simplex 1680 -1681 1682 2 56 4.357900e-06 1.112700e-03 # simplex 1681 -1682 1683 2 56 4.355200e-06 1.468100e-03 # simplex 1682 -1683 1684 2 56 4.356900e-06 1.468100e-03 # simplex 1683 -1684 1685 2 56 4.361200e-06 1.468100e-03 # simplex 1684 -1685 1686 2 56 4.355200e-06 1.468100e-03 # simplex 1685 -1686 1687 2 56 4.052700e-06 1.468100e-03 # simplex 1686 -1687 1688 2 56 3.935400e-06 1.318000e-03 # simplex 1687 -1688 1689 2 56 3.683600e-06 1.155200e-03 # simplex 1688 -1689 1690 2 56 3.433100e-06 1.003100e-03 # simplex 1689 -1690 1691 2 56 3.179700e-06 8.617500e-04 # simplex 1690 -1691 1692 2 56 2.367200e-06 7.311400e-04 # simplex 1691 -1692 1693 2 56 2.216500e-06 5.392100e-04 # simplex 1692 -1693 1694 2 56 2.121600e-06 4.940900e-04 # simplex 1693 -1694 1695 2 56 2.208100e-06 4.509500e-04 # simplex 1694 -1695 1696 2 56 2.105300e-06 4.090000e-04 # simplex 1695 -1696 1697 2 56 2.011700e-06 3.724600e-04 # simplex 1696 -1697 1698 2 56 1.823500e-06 3.376300e-04 # simplex 1697 -1698 1699 2 56 1.792900e-06 3.354600e-04 # simplex 1698 -1699 1700 2 56 1.825300e-06 3.473200e-04 # simplex 1699 -1700 1701 2 56 2.395600e-06 3.593900e-04 # simplex 1700 -1701 1702 2 56 2.357900e-06 4.283200e-04 # simplex 1701 -1702 1703 2 56 2.239500e-06 3.868800e-04 # simplex 1702 -1703 1704 2 56 2.317800e-06 3.475400e-04 # simplex 1703 -1704 1705 2 56 2.185000e-06 3.372300e-04 # simplex 1704 -1705 1706 2 56 1.350500e-06 2.971600e-04 # simplex 1705 -1706 1707 2 56 1.218700e-06 1.661400e-04 # simplex 1706 -1707 1708 2 56 1.018700e-06 1.209000e-04 # simplex 1707 -174 1709 2 57 9.716600e-06 6.376400e-03 # simplex 1708 -1709 1710 2 57 7.079600e-06 3.402600e-03 # simplex 1709 -1710 1711 2 57 4.389600e-06 1.362900e-03 # simplex 1710 -1711 1712 2 57 2.752000e-06 6.352600e-04 # simplex 1711 -1712 1713 2 57 2.260900e-06 5.957000e-04 # simplex 1712 -1713 1714 2 57 2.243700e-06 4.857800e-04 # simplex 1713 -1714 1715 2 57 2.283100e-06 5.029500e-04 # simplex 1714 -1715 1716 2 57 2.536600e-06 5.204200e-04 # simplex 1715 -1716 1717 2 57 2.648000e-06 6.509300e-04 # simplex 1716 -1717 1718 2 57 2.823700e-06 7.403600e-04 # simplex 1717 -1718 1719 2 57 3.000300e-06 8.355400e-04 # simplex 1718 -1719 1720 2 57 3.141500e-06 9.364900e-04 # simplex 1719 -1720 1721 2 57 3.180900e-06 9.256100e-04 # simplex 1720 -1721 1722 2 57 3.087900e-06 8.722700e-04 # simplex 1721 -1722 1723 2 57 2.813100e-06 8.205100e-04 # simplex 1722 -1723 1724 2 57 2.711100e-06 7.248600e-04 # simplex 1723 -1724 1725 2 57 2.590700e-06 6.616900e-04 # simplex 1724 -1725 1726 2 57 2.658400e-06 6.014000e-04 # simplex 1725 -1726 1727 2 57 2.510300e-06 5.898200e-04 # simplex 1726 -1727 1728 2 57 2.337900e-06 5.115200e-04 # simplex 1727 -1728 1729 2 57 2.165300e-06 4.388000e-04 # simplex 1728 -1729 1730 2 57 1.992400e-06 3.716500e-04 # simplex 1729 -1730 1731 2 57 1.817700e-06 3.100700e-04 # simplex 1730 -1716 1732 2 58 2.178800e-06 4.542400e-04 # simplex 1731 -1732 1733 2 58 2.315300e-06 3.849500e-04 # simplex 1732 -1733 1734 2 58 2.181400e-06 4.342000e-04 # simplex 1733 -1734 1735 2 58 2.119500e-06 4.099300e-04 # simplex 1734 -1735 1736 2 58 1.883500e-06 3.863700e-04 # simplex 1735 -1736 1737 2 58 1.625400e-06 2.406400e-04 # simplex 1736 -1737 1738 2 58 1.039600e-06 1.187300e-04 # simplex 1737 -# -BOUNDARYDOMAIN -default 1 -# diff --git a/test/mixeddimension/embedded/1p_richards/richardstestproblem.hh b/test/mixeddimension/embedded/1p_richards/richardstestproblem.hh deleted file mode 100644 index c4c16856889c77c474f843a29b41ee995d3c4dc5..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_richards/richardstestproblem.hh +++ /dev/null @@ -1,332 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief A sub problem for the richards problem - */ -#ifndef DUMUX_RICHARDS_TEST_PROBLEM_HH -#define DUMUX_RICHARDS_TEST_PROBLEM_HH - -#include <cmath> - -#include <dumux/implicit/cellcentered/tpfa/properties.hh> -#include <dumux/porousmediumflow/implicit/problem.hh> -#include <dumux/porousmediumflow/richards/model.hh> -#include <dumux/material/components/simpleh2o.hh> -#include <dumux/material/fluidsystems/liquidphase.hh> - -//! get the properties needed for subproblems -#include <dumux/mixeddimension/subproblemproperties.hh> - -#include "richardstestspatialparams.hh" - -namespace Dumux -{ -template <class TypeTag> -class RichardsTestProblem; - -namespace Properties -{ -NEW_TYPE_TAG(RichardsTestProblem, INHERITS_FROM(Richards, RichardsTestSpatialParams)); -NEW_TYPE_TAG(RichardsTestBoxProblem, INHERITS_FROM(BoxModel, RichardsTestProblem)); -NEW_TYPE_TAG(RichardsTestCCProblem, INHERITS_FROM(CCTpfaModel, RichardsTestProblem)); - -// Set the grid type -SET_TYPE_PROP(RichardsTestProblem, Grid, Dune::YaspGrid<3, Dune::EquidistantOffsetCoordinates<double, 3> >); -//SET_TYPE_PROP(RichardsTestProblem, Grid, Dune::UGGrid<3>); -//SET_TYPE_PROP(RichardsTestProblem, Grid, Dune::ALUGrid<3, 3, Dune::cube, Dune::conforming>); - -SET_BOOL_PROP(RichardsTestProblem, EnableFVGridGeometryCache, true); -SET_BOOL_PROP(RichardsTestProblem, EnableGridVolumeVariablesCache, true); -SET_BOOL_PROP(RichardsTestProblem, EnableGridFluxVariablesCache, true); -SET_BOOL_PROP(RichardsTestProblem, SolutionDependentAdvection, false); -SET_BOOL_PROP(RichardsTestProblem, SolutionDependentMolecularDiffusion, false); -SET_BOOL_PROP(RichardsTestProblem, SolutionDependentHeatConduction, false); - -// Set the problem property -SET_TYPE_PROP(RichardsTestProblem, Problem, RichardsTestProblem<TypeTag>); - -// Set the spatial parameters -SET_TYPE_PROP(RichardsTestProblem, SpatialParams, RichardsTestSpatialParams<TypeTag>); - -// Enable gravity -SET_BOOL_PROP(RichardsTestProblem, ProblemEnableGravity, false); - -// Enable velocity output -SET_BOOL_PROP(RichardsTestProblem, VtkAddVelocity, true); - -// Set the grid parameter group -SET_STRING_PROP(RichardsTestProblem, GridParameterGroup, "SoilGrid"); -} - -/*! - * \ingroup OnePBoxModel - * \ingroup ImplicitTestProblems - * \brief Test problem for the one-phase model: - * water is flowing from bottom to top through and around a low permeable lens. - * - * The domain is box shaped. All sides are closed (Neumann 0 boundary) - * except the top and bottom boundaries (Dirichlet), where water is - * flowing from bottom to top. - * - * In the middle of the domain, a lens with low permeability (\f$K=10e-12\f$) - * compared to the surrounding material (\f$ K=10e-10\f$) is defined. - * - * To run the simulation execute the following line in shell: - * <tt>./test_box1p -parameterFile test_box1p.input</tt> or - * <tt>./test_cc1p -parameterFile test_cc1p.input</tt> - * - * The same parameter file can be also used for 3d simulation but you need to change line - * <tt>using type = Dune::SGrid<2, 2>;</tt> to - * <tt>using type = Dune::SGrid<3, 3>;</tt> in the problem file - * and use <tt>1p_3d.dgf</tt> in the parameter file. - */ -template <class TypeTag> -class RichardsTestProblem : public ImplicitPorousMediaProblem<TypeTag> -{ - using ParentType = ImplicitPorousMediaProblem<TypeTag>; - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); - using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); - using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using PointSource = typename GET_PROP_TYPE(TypeTag, PointSource); - using Indices = typename GET_PROP_TYPE(TypeTag, Indices); - - enum { - // Grid and world dimension - dim = GridView::dimension, - dimWorld = GridView::dimensionworld - }; - enum { conti0EqIdx = Indices::conti0EqIdx }; - enum { pressureIdx = Indices::pressureIdx }; - enum { wPhaseIdx = Indices::wPhaseIdx }; - - enum { isBox = GET_PROP_VALUE(TypeTag, ImplicitIsBox) }; - enum { dofCodim = isBox ? dim : 0 }; - - using Element = typename GridView::template Codim<0>::Entity; - using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; - - using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); - using CouplingManager = typename GET_PROP_TYPE(GlobalProblemTypeTag, CouplingManager); - - -public: - RichardsTestProblem(TimeManager &timeManager, const GridView &gridView) - : ParentType(timeManager, gridView) - { - name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name) + "-soil"; - } - - /*! - * \name Problem parameters - */ - // \{ - - /*! - * \brief The problem name. - * - * This is used as a prefix for files generated by the simulation. - */ - const std::string& name() const - { - return name_; - } - - /*! - * \brief Return the temperature within the domain. - * - * This problem assumes a temperature of 10 degrees Celsius. - */ - Scalar temperature() const - { return 273.15 + 10; } // 10C - /* - * \brief Returns the reference pressure [Pa] of the non-wetting - * fluid phase within a finite volume - * - * This problem assumes a constant reference pressure of 1 bar. - */ - Scalar nonWettingReferencePressure() const - { return 1.0e5; } - - /*! - * \brief Applies a vector of point sources. The point sources - * are possibly solution dependent. - * - * \param pointSources A vector of PointSource s that contain - source values for all phases and space positions. - * - * For this method, the \a values method of the point source - * has to return the absolute mass rate in kg/s. Positive values mean - * that mass is created, negative ones mean that it vanishes. - */ - void addPointSources(std::vector<PointSource>& pointSources) const - { pointSources = this->couplingManager().bulkPointSources(); } - - /*! - * \brief Evaluate the point sources (added by addPointSources) - * for all phases within a given sub-control-volume. - * - * This is the method for the case where the point source is - * solution dependent and requires some quantities that - * are specific to the fully-implicit method. - * - * \param pointSource A single point source - * \param element The finite element - * \param fvGeometry The finite-volume geometry - * \param elemVolVars All volume variables for the element - * \param scv The sub-control volume within the element - * - * For this method, the \a values() method of the point sources returns - * the absolute rate mass generated or annihilate in kg/s. Positive values mean - * that mass is created, negative ones mean that it vanishes. - */ - void pointSource(PointSource& source, - const Element &element, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const SubControlVolume &scv) const - { - // compute source at every integration point - const auto& bulkVolVars = this->couplingManager().bulkVolVars(source.id()); - const Scalar pressure1D = this->couplingManager().lowDimPriVars(source.id())[pressureIdx]; - - const auto& spatialParams = this->couplingManager().lowDimProblem().spatialParams(); - const unsigned int lowDimElementIdx = this->couplingManager().pointSourceData(source.id()).lowDimElementIdx(); - const Scalar Kr = spatialParams.Kr(lowDimElementIdx); - const Scalar rootRadius = spatialParams.radius(lowDimElementIdx); - - // sink defined as radial flow Jr * density [m^2 s-1]* [kg m-3] - const Scalar sourceValue = 2* M_PI *rootRadius * Kr *(pressure1D - bulkVolVars.pressure(wPhaseIdx)) - *bulkVolVars.density(wPhaseIdx); - source = sourceValue*source.quadratureWeight()*source.integrationElement(); - } - - //! Called after every time step - //! Output the total global exchange term - void postTimeStep() - { - ParentType::postTimeStep(); - - PrimaryVariables source(0.0); - - if (!(this->timeManager().time() < 0.0)) - { - for (const auto& element : elements(this->gridView())) - { - auto fvGeometry = localView(this->model().fvGridGeometry()); - fvGeometry.bindElement(element); - - auto elemVolVars = localView(this->model().curGridVolVars()); - elemVolVars.bindElement(element, fvGeometry, this->model().curSol()); - - for (auto&& scv : scvs(fvGeometry)) - { - auto pointSources = this->scvPointSources(element, fvGeometry, elemVolVars, scv); - pointSources *= scv.volume()*elemVolVars[scv].extrusionFactor(); - source += pointSources; - } - } - } - - std::cout << "Global integrated source (soil): " << source << " (kg/s) / " - << source*3600*24*1000 << " (g/day)" << '\n'; - } - - // \} - /*! - * \name Boundary conditions - */ - // \{ - - /*! - * \brief Specifies which kind of boundary condition should be - * used for which equation on a given boundary control volume. - * - * \param globalPos The position of the center of the finite volume - */ - BoundaryTypes boundaryTypesAtPos(const GlobalPosition &globalPos) const - { - BoundaryTypes bcTypes; - bcTypes.setAllDirichlet(); - return bcTypes; - } - - /*! - * \brief Evaluate the boundary conditions for a dirichlet - * control volume. - * - * \param globalPos The center of the finite volume which ought to be set. - * - * For this method, the \a values parameter stores primary variables. - */ - PrimaryVariables dirichletAtPos(const GlobalPosition &globalPos) const - { return initialAtPos(globalPos); } - - // \} - - /*! - * \name Volume terms - */ - // \{ - - /*! - * \brief Evaluate the initial values for a control volume. - * - * For this method, the \a values parameter stores primary - * variables. - * - * \param globalPos The position for which the boundary type is set - */ - PrimaryVariables initialAtPos(const GlobalPosition &globalPos) const - { - PrimaryVariables values(0.0); - values[pressureIdx] = GET_RUNTIME_PARAM(TypeTag, - Scalar, - BoundaryConditions.InitialSoilPressure); - return values; - - } - - bool shouldWriteRestartFile() const - { - return false; - } - - //! Set the coupling manager - void setCouplingManager(std::shared_ptr<CouplingManager> cm) - { couplingManager_ = cm; } - - //! Get the coupling manager - const CouplingManager& couplingManager() const - { return *couplingManager_; } - -private: - std::string name_; - std::shared_ptr<CouplingManager> couplingManager_; -}; - -} //end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p_richards/richardstestspatialparams.hh b/test/mixeddimension/embedded/1p_richards/richardstestspatialparams.hh deleted file mode 100644 index 6d437f9c6d26af0f5edcab913e48f6c7d98625bd..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_richards/richardstestspatialparams.hh +++ /dev/null @@ -1,139 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief spatial parameters for the RichardsTestProblem - */ -#ifndef DUMUX_RICHARDS_TEST_SPATIAL_PARAMETERS_HH -#define DUMUX_RICHARDS_TEST_SPATIAL_PARAMETERS_HH - -#include <dumux/material/spatialparams/fv.hh> -#include <dumux/material/fluidmatrixinteractions/2p/regularizedvangenuchten.hh> -#include <dumux/material/fluidmatrixinteractions/2p/linearmaterial.hh> -#include <dumux/material/fluidmatrixinteractions/2p/efftoabslaw.hh> - -namespace Dumux -{ -template<class TypeTag> -class RichardsTestSpatialParams; - -namespace Properties -{ -// The spatial parameters TypeTag -NEW_TYPE_TAG(RichardsTestSpatialParams); - -// Set the spatial parameters -SET_TYPE_PROP(RichardsTestSpatialParams, SpatialParams, RichardsTestSpatialParams<TypeTag>); - -// Set the material law -SET_PROP(RichardsTestSpatialParams, MaterialLaw) -{ -private: - // define the material law which is parameterized by effective - // saturations - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); -public: - // define the material law parameterized by absolute saturations - using type = EffToAbsLaw<RegularizedVanGenuchten<Scalar>>; -}; -} // end namespace Properties - -/*! - * \ingroup RichardsModel - * \ingroup ImplicitTestProblems - * \brief The spatial parameters for the RichardsTestProblem - */ -template<class TypeTag> -class RichardsTestSpatialParams : public FVSpatialParams<TypeTag> -{ - using ParentType = FVSpatialParams<TypeTag>; - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - - enum { - dim=GridView::dimension, - dimWorld=GridView::dimensionworld - }; - - using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; - using MaterialLaw = typename GET_PROP_TYPE(TypeTag, MaterialLaw); - using MaterialLawParams = typename MaterialLaw::Params; - -public: - // export permeability type - using PermeabilityType = Scalar; - - /*! - * \brief Constructor - * - * \param gridView The DUNE GridView representing the spatial - * domain of the problem. - */ - RichardsTestSpatialParams(const Problem& problem, const GridView& gridView) - : ParentType(problem, gridView) - { - // residual saturations - materialParams_.setSwr(0.05); - materialParams_.setSnr(0.0); - - // parameters for the Van Genuchten law - // alpha and n - materialParams_.setVgAlpha(2.956e-4); - materialParams_.setVgn(1.5); - - permeability_ = GET_RUNTIME_PARAM(TypeTag, Scalar, SpatialParams.Permeability); - } - - /*! - * \brief Returns the intrinsic permeability tensor [m^2] at a given location - * - * \param globalPos The global position where we evaluate - */ - PermeabilityType permeabilityAtPos(const GlobalPosition& globalPos) const - { return permeability_; } - - /*! - * \brief Returns the porosity [] at a given location - * - * \param globalPos The global position where we evaluate - */ - Scalar porosityAtPos(const GlobalPosition& globalPos) const - { return 0.4; } - - /*! - * \brief Returns the parameters for the material law at a given location - * - * This method is not actually required by the Richards model, but provided - * for the convenience of the RichardsLensProblem - * - * \param globalPos A global coordinate vector - */ - const MaterialLawParams& materialLawParamsAtPos(const GlobalPosition &globalPos) const - { return materialParams_; } - -private: - MaterialLawParams materialParams_; - Scalar permeability_; -}; - -} // end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p_richards/rootsystemtestproblem.hh b/test/mixeddimension/embedded/1p_richards/rootsystemtestproblem.hh deleted file mode 100644 index 579349c3e0e69bd1bde015dfb535d4b5b2072dbc..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_richards/rootsystemtestproblem.hh +++ /dev/null @@ -1,360 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief A sub problem for the rootsystem - */ -#ifndef DUMUX_ROOTSYSTEM_TEST_PROBLEM_HH -#define DUMUX_ROOTSYSTEM_TEST_PROBLEM_HH - -#include <cmath> - -#include <dumux/discretization/cellcentered/tpfa/properties.hh> -#include <dumux/porousmediumflow/implicit/problem.hh> -#include <dumux/porousmediumflow/1p/model.hh> -#include <dumux/material/components/simpleh2o.hh> -#include <dumux/material/fluidsystems/liquidphase.hh> -#include <dumux/material/fluidsystems/1p.hh> - -//! get the properties needed for subproblems -#include <dumux/mixeddimension/subproblemproperties.hh> - -#include "rootsystemtestspatialparams.hh" - -namespace Dumux -{ -template <class TypeTag> -class RootsystemTestProblem; - -namespace Properties -{ -NEW_TYPE_TAG(RootsystemTestProblem, INHERITS_FROM(OneP)); -NEW_TYPE_TAG(RootsystemTestBoxProblem, INHERITS_FROM(BoxModel, RootsystemTestProblem)); -NEW_TYPE_TAG(RootsystemTestCCProblem, INHERITS_FROM(CCTpfaModel, RootsystemTestProblem)); - -// the fluid system -SET_PROP(RootsystemTestProblem, FluidSystem) -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using type = FluidSystems::OneP<Scalar, FluidSystems::LiquidPhase<Scalar, SimpleH2O<Scalar> > >; -}; - -// Set the grid type -SET_TYPE_PROP(RootsystemTestProblem, Grid, Dune::FoamGrid<1, 3>); - -SET_BOOL_PROP(RootsystemTestProblem, EnableFVGridGeometryCache, true); -SET_BOOL_PROP(RootsystemTestProblem, EnableGridVolumeVariablesCache, true); -SET_BOOL_PROP(RootsystemTestProblem, EnableGridFluxVariablesCache, true); -SET_BOOL_PROP(RootsystemTestProblem, SolutionDependentAdvection, false); -SET_BOOL_PROP(RootsystemTestProblem, SolutionDependentMolecularDiffusion, false); -SET_BOOL_PROP(RootsystemTestProblem, SolutionDependentHeatConduction, false); - -// Set the problem property -SET_TYPE_PROP(RootsystemTestProblem, Problem, RootsystemTestProblem<TypeTag>); - -// Set the spatial parameters -SET_TYPE_PROP(RootsystemTestProblem, SpatialParams, RootsystemTestSpatialParams<TypeTag>); - -// Enable gravity -SET_BOOL_PROP(RootsystemTestProblem, ProblemEnableGravity, true); - -// Enable velocity output -SET_BOOL_PROP(RootsystemTestProblem, VtkAddVelocity, true); -} - -/*! - * \ingroup OneDRootSystem - * \ingroup ImplicitTestProblems - * \brief TODO - */ -template <class TypeTag> -class RootsystemTestProblem : public ImplicitPorousMediaProblem<TypeTag> -{ - using ParentType = ImplicitPorousMediaProblem<TypeTag>; - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); - using PointSource = typename GET_PROP_TYPE(TypeTag, PointSource); - using Indices = typename GET_PROP_TYPE(TypeTag, Indices); - // copy some indices for convenience - enum { - // Grid and world dimension - dim = GridView::dimension, - dimworld = GridView::dimensionworld - }; - enum { - // indices of the primary variables - conti0EqIdx = Indices::conti0EqIdx, - pressureIdx = Indices::pressureIdx - }; - enum { isBox = GET_PROP_VALUE(TypeTag, ImplicitIsBox) }; - enum { dofCodim = isBox ? dim : 0 }; - - using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); - using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); - using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); - using Element = typename GridView::template Codim<0>::Entity; - using GlobalPosition = Dune::FieldVector<Scalar, dimworld>; - - using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); - using CouplingManager = typename GET_PROP_TYPE(GlobalProblemTypeTag, CouplingManager); - -public: - RootsystemTestProblem(TimeManager &timeManager, const GridView &gridView) - : ParentType(timeManager, gridView) - { - name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name) + "-root"; - } - /*! - * \name Problem parameters - */ - // \{ - - /*! - * \brief Return how much the domain is extruded at a given sub-control volume. - * - * The extrusion factor here makes extrudes the 1d line to a circular tube with - * cross-section area pi*r^2. - */ - Scalar extrusionFactor(const Element &element, - const SubControlVolume &scv, - const ElementSolutionVector& elemSol) const - { - const auto eIdx = this->gridView().indexSet().index(element); - const auto radius = this->spatialParams().radius(eIdx); - return M_PI*radius*radius; - } - - /*! - * \brief The problem name. - * - * This is used as a prefix for files generated by the simulation. - */ - const std::string& name() const - { - return name_; - } - - /*! - * \brief Return the temperature within the domain. - * - * This problem assumes a temperature of 10 degrees Celsius. - */ - Scalar temperature() const - { return 273.15 + 10; } // 10C - - - // \} - /*! - * \name Boundary conditions - */ - // \{ - - BoundaryTypes boundaryTypesAtPos (const GlobalPosition &globalPos ) const - { - BoundaryTypes bcTypes; - bcTypes.setAllNeumann(); - return bcTypes; - } - - - /*! - * \brief Specifies which kind of boundary condition should be - * used for which equation on a given boundary control volume. - * - * \param values The boundary types for the conservation equations - * \param globalPos The position of the center of the finite volume - */ - - /*! - * \brief Evaluate the boundary conditions for a dirichlet - * control volume. - * - * \param values The dirichlet values for the primary variables - * \param globalPos The center of the finite volume which ought to be set. - * - * For this method, the \a values parameter stores primary variables. - */ - PrimaryVariables dirichletAtPos(const GlobalPosition& globalPos) const - { - PrimaryVariables values(0.0); - if (globalPos[2] + eps_ > this->bBoxMax()[2] ) - values[pressureIdx] = GET_RUNTIME_PARAM(TypeTag, - Scalar, - BoundaryConditions.CriticalCollarPressure); - return values; - } - - /*! - * \brief Evaluate the boundary conditions for a neumann - * boundary segment. - * - * For this method, the \a priVars parameter stores the mass flux - * in normal direction of each component. Negative values mean - * influx. - */ - PrimaryVariables neumann(const Element& element, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolvars, - const SubControlVolumeFace& scvf) const - { - PrimaryVariables values(0.0); - if (scvf.center()[2] + eps_ > this->bBoxMax()[2]) - { - const auto r = this->spatialParams().radius(this->gridView().indexSet().index(element)); - values[conti0EqIdx] = GET_RUNTIME_PARAM(TypeTag, - Scalar, - BoundaryConditions.TranspirationRate)/(M_PI*r*r)/scvf.area(); - } - return values; - - } - - // \} - - /*! - * \name Volume terms - */ - // \{ - - /*! - * \brief Evaluate the initial value for a control volume. - * - * For this method, the \a priVars parameter stores primary - * variables. - */ - PrimaryVariables initialAtPos(const GlobalPosition& globalPos) const - { - PrimaryVariables values(0.0); - values[pressureIdx] = GET_RUNTIME_PARAM(TypeTag, - Scalar, - BoundaryConditions.InitialRootPressure); - return values; - } - - /*! - * \brief Applies a vector of point sources. The point sources - * are possibly solution dependent. - * - * \param pointSources A vector of PointSource s that contain - source values for all phases and space positions. - * - * For this method, the \a values method of the point source - * has to return the absolute mass rate in kg/s. Positive values mean - * that mass is created, negative ones mean that it vanishes. - */ - void addPointSources(std::vector<PointSource>& pointSources) const - { pointSources = this->couplingManager().lowDimPointSources(); } - - /*! - * \brief Evaluate the point sources (added by addPointSources) - * for all phases within a given sub-control-volume. - * - * This is the method for the case where the point source is - * solution dependent and requires some quantities that - * are specific to the fully-implicit method. - * - * \param pointSource A single point source - * \param element The finite element - * \param fvGeometry The finite-volume geometry - * \param elemVolVars All volume variables for the element - * \param scv The sub-control volume within the element - * - * For this method, the \a values() method of the point sources returns - * the absolute rate mass generated or annihilate in kg/s. Positive values mean - * that mass is created, negative ones mean that it vanishes. - */ - void pointSource(PointSource& source, - const Element &element, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const SubControlVolume &scv) const - { - // compute source at every integration point - const auto& bulkVolVars = this->couplingManager().bulkVolVars(source.id()); - const Scalar pressure1D = this->couplingManager().lowDimPriVars(source.id())[pressureIdx]; - - const unsigned int lowDimElementIdx = this->couplingManager().pointSourceData(source.id()).lowDimElementIdx(); - const Scalar Kr = this->spatialParams().Kr(lowDimElementIdx); - const Scalar rootRadius = this->spatialParams().radius(lowDimElementIdx); - - // sink defined as radial flow Jr * density [m^2 s-1]* [kg m-3] - const Scalar sourceValue = 2* M_PI *rootRadius * Kr *(bulkVolVars.pressure(0) - pressure1D) - *bulkVolVars.density(0); - source = sourceValue*source.quadratureWeight()*source.integrationElement(); - } - - //! Called after every time step - //! Output the total global exchange term - void postTimeStep() - { - ParentType::postTimeStep(); - - PrimaryVariables source(0.0); - - if (!(this->timeManager().time() < 0.0)) - { - for (const auto& element : elements(this->gridView())) - { - auto fvGeometry = localView(this->model().fvGridGeometry()); - fvGeometry.bindElement(element); - - auto elemVolVars = localView(this->model().curGridVolVars()); - elemVolVars.bindElement(element, fvGeometry, this->model().curSol()); - - for (auto&& scv : scvs(fvGeometry)) - { - auto pointSources = this->scvPointSources(element, fvGeometry, elemVolVars, scv); - pointSources *= scv.volume()*elemVolVars[scv].extrusionFactor(); - source += pointSources; - } - } - } - - std::cout << "Global integrated source (root): " << source << " (kg/s) / " - << source*3600*24*1000 << " (g/day)" << '\n'; - } - - bool shouldWriteRestartFile() const - { - return false; - } - - //! Set the coupling manager - void setCouplingManager(std::shared_ptr<CouplingManager> cm) - { couplingManager_ = cm; } - - //! Get the coupling manager - const CouplingManager& couplingManager() const - { return *couplingManager_; } - -private: - std::string name_; - const Scalar eps_ = 1e-9; - std::shared_ptr<CouplingManager> couplingManager_; -}; - -} //end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p_richards/rootsystemtestspatialparams.hh b/test/mixeddimension/embedded/1p_richards/rootsystemtestspatialparams.hh deleted file mode 100644 index 59871212e03fd8ac0d197821fd471bb641bf1021..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_richards/rootsystemtestspatialparams.hh +++ /dev/null @@ -1,197 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief The spatial parameters class for the root system test problem - */ -#ifndef DUMUX_ROOTSYSTEM_TEST_SPATIALPARAMS_HH -#define DUMUX_ROOTSYSTEM_TEST_SPATIALPARAMS_HH - -#include <dumux/material/spatialparams/fv1p.hh> -#include <dumux/material/components/simpleh2o.hh> - -namespace Dumux -{ - -/*! - * \ingroup OnePModel - * \ingroup ImplicitTestProblems - * - * \brief Definition of the spatial parameters for the root system test problem - */ -template<class TypeTag> -class RootsystemTestSpatialParams: public FVSpatialParamsOneP<TypeTag> -{ - using ParentType = FVSpatialParamsOneP<TypeTag>; - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using GridCreator = typename GET_PROP_TYPE(TypeTag, GridCreator); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem); - using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); - using Indices = typename GET_PROP_TYPE(TypeTag, Indices); - enum { - // Grid and world dimension - dim = GridView::dimension, - dimworld = GridView::dimensionworld - }; - using GlobalPosition = Dune::FieldVector<Scalar, dimworld>; - - struct RootParams - { - Scalar radius; - Scalar surface; - Scalar axialPerm; - Scalar radialPerm; - int order; - int branchId; - Scalar mass; - }; - -public: - // export permeability type - using PermeabilityType = Scalar; - - RootsystemTestSpatialParams(const Problem& problem, const GridView& gridView) - : ParentType(problem, gridView), gridView_(gridView) - { - Kx_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, Kx); - Kr_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, Kr); - - rootParams_.resize(problem.gridView().size(0)); - for (const auto& element : elements(problem.gridView())) - { - auto eIdx = problem.gridView().indexSet().index(element); - auto level0element = element; - for(auto levelIdx = element.level(); levelIdx != 0; levelIdx--) - level0element = level0element.father(); - Scalar rootLength = element.geometry().volume(); - Scalar rootSurface = GridCreator::parameters(level0element)[2]/(1 << element.level()); - - rootParams_[eIdx].radius = rootSurface / rootLength / 2.0 / M_PI; - rootParams_[eIdx].order = GridCreator::parameters(level0element)[0]; - // root branch -> count from 0!! - rootParams_[eIdx].branchId = GridCreator::parameters(level0element)[1] -1; - rootParams_[eIdx].surface = rootSurface; - rootParams_[eIdx].mass = GridCreator::parameters(level0element)[3]; - - if ((int)rootParams_[eIdx].order == 1) - { - rootParams_[eIdx].axialPerm = Kx_; //Kx - rootParams_[eIdx].radialPerm = Kr_; //Kr - } - else if ((int)rootParams_[eIdx].order == 2) - { - rootParams_[eIdx].axialPerm = Kx_; //Kx - rootParams_[eIdx].radialPerm = Kr_; //Kr - } - else //order >= 3 - { - rootParams_[eIdx].axialPerm = Kx_; //Kx - rootParams_[eIdx].radialPerm = Kr_; //Kr - } - } - } - - /*! - * \brief Return the intrinsic permeability for the current sub-control volume in [m^2]. - * - * \param ipGlobal The integration point - * \note Kx has units [m^4/(Pa*s)] so we have to divide by the cross-section area - * and multiply with a characteristic viscosity - */ - PermeabilityType permeability(const Element& element, - const SubControlVolume& scv, - const ElementSolutionVector& elemSol) const - { - const Scalar r = rootParams(element).radius; - return Kx_ / (M_PI*r*r) * SimpleH2O<Scalar>::liquidViscosity(285.15, elemSol[0][Indices::pressureIdx]); - } - - /*! - * \brief Return the radius of the circular pipe for the current sub-control volume in [m]. - * - * \param the index of the element - */ - Scalar radius(unsigned int eIdxGlobal) const - { - return rootParams_[eIdxGlobal].radius; - } - - Scalar rootSurface(unsigned int eIdxGlobal) const - { - return rootParams_[eIdxGlobal].surface; - } - - Scalar Kr(unsigned int eIdxGlobal) const - { - return rootParams_[eIdxGlobal].radialPerm; - } - - Scalar rootOrder(unsigned int eIdxGlobal) const - { - return rootParams_[eIdxGlobal].order; - } - - Scalar rootBranch(unsigned int eIdxGlobal) const - { - return rootParams_[eIdxGlobal].branchId; - } - - Scalar rootMass(unsigned int eIdxGlobal) const - { - return rootParams_[eIdxGlobal].mass; - } - - RootParams& rootParams(const Element &element) - { - auto eIdx = gridView_.indexSet().index(element); - return rootParams_[eIdx]; - } - const RootParams& rootParams(const Element &element) const - { - auto eIdx = gridView_.indexSet().index(element); - return rootParams_[eIdx]; - } - - /*! - * \brief Returns the porosity \f$[-]\f$ - * - * \param element The element - * \param scv The sub control volume - * \param elemSol The element solution vector - * \return the porosity - */ - Scalar porosity(const Element& element, - const SubControlVolume& scv, - const ElementSolutionVector& elemSol) const - { return 0.4; } - -private: - std::vector<RootParams> rootParams_; - Scalar Kx_, Kr_; - GridView gridView_; -}; - -} // end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p_richards/rositestproblem.hh b/test/mixeddimension/embedded/1p_richards/rositestproblem.hh deleted file mode 100644 index 4789371b44fd035d54aac44efa251f9fd2e836c9..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_richards/rositestproblem.hh +++ /dev/null @@ -1,99 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief A test problem the rootsystem coupled with richards in the bulk - */ -#ifndef DUMUX_ROSI_TEST_PROBLEM_HH -#define DUMUX_ROSI_TEST_PROBLEM_HH - -#include "rootsystemtestproblem.hh" -#include "richardstestproblem.hh" - -#include <dumux/mixeddimension/problem.hh> -#include <dumux/mixeddimension/embedded/cellcentered/bboxtreecouplingmanager.hh> -#include <dumux/mixeddimension/embedded/cellcentered/bboxtreecouplingmanagersimple.hh> -#include <dumux/mixeddimension/integrationpointsource.hh> - -namespace Dumux -{ -template <class TypeTag> -class RosiTestProblem; - -namespace Properties -{ -NEW_TYPE_TAG(RosiTestProblem, INHERITS_FROM(MixedDimension)); - -// Set the problem property -SET_TYPE_PROP(RosiTestProblem, Problem, Dumux::RosiTestProblem<TypeTag>); - -// Set the coupling manager -//SET_TYPE_PROP(RosiTestProblem, CouplingManager, Dumux::CCBBoxTreeEmbeddedCouplingManager<TypeTag>); -SET_TYPE_PROP(RosiTestProblem, CouplingManager, Dumux::CCBBoxTreeEmbeddedCouplingManagerSimple<TypeTag>); - -// Set the two sub-problems of the global problem -SET_TYPE_PROP(RosiTestProblem, LowDimProblemTypeTag, TTAG(RootsystemTestCCProblem)); -SET_TYPE_PROP(RosiTestProblem, BulkProblemTypeTag, TTAG(RichardsTestCCProblem)); - -// publish this problem in the sub problems -SET_TYPE_PROP(RootsystemTestCCProblem, GlobalProblemTypeTag, TTAG(RosiTestProblem)); -SET_TYPE_PROP(RichardsTestCCProblem, GlobalProblemTypeTag, TTAG(RosiTestProblem)); - -// The subproblems inherit the parameter tree from this problem -SET_PROP(RootsystemTestCCProblem, ParameterTree) : GET_PROP(TTAG(RosiTestProblem), ParameterTree) {}; -SET_PROP(RichardsTestCCProblem, ParameterTree) : GET_PROP(TTAG(RosiTestProblem), ParameterTree) {}; - -// Set the point source type of the subproblems to an integration point source -SET_TYPE_PROP(RootsystemTestCCProblem, PointSource, Dumux::IntegrationPointSource<TTAG(RootsystemTestCCProblem), unsigned int>); -SET_TYPE_PROP(RootsystemTestCCProblem, PointSourceHelper, Dumux::IntegrationPointSourceHelper<TTAG(RootsystemTestCCProblem)>); -SET_TYPE_PROP(RichardsTestCCProblem, PointSource, Dumux::IntegrationPointSource<TTAG(RichardsTestCCProblem), unsigned int>); -SET_TYPE_PROP(RichardsTestCCProblem, PointSourceHelper, Dumux::IntegrationPointSourceHelper<TTAG(RichardsTestCCProblem)>); - -SET_TYPE_PROP(RosiTestProblem, LinearSolver, ILU0BiCGSTABBackend<TypeTag>); - -}//end namespace properties - -template <class TypeTag> -class RosiTestProblem : public MixedDimensionProblem<TypeTag> -{ - using ParentType = MixedDimensionProblem<TypeTag>; - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - - // obtain the type tags of the sub problems - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - // obtain types from the sub problem type tags - using BulkProblem = typename GET_PROP_TYPE(BulkProblemTypeTag, Problem); - using LowDimProblem = typename GET_PROP_TYPE(LowDimProblemTypeTag, Problem); - - using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); - using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); - -public: - RosiTestProblem(TimeManager &timeManager, const BulkGridView &bulkGridView, const LowDimGridView &lowDimgridView) - : ParentType(timeManager, bulkGridView, lowDimgridView) - {} -}; - -} // end namespace Dumux - -#endif diff --git a/test/mixeddimension/embedded/1p_richards/test_rosi.cc b/test/mixeddimension/embedded/1p_richards/test_rosi.cc deleted file mode 100644 index c6afa3a50ac985df1685c89414c0801b0a7bf48e..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_richards/test_rosi.cc +++ /dev/null @@ -1,45 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief test for the rootsystem coupled model - */ -#include "config.h" -#include "rositestproblem.hh" -#include <dumux/mixeddimension/embedded/start.hh> - -/*! - * \brief Provides an interface for customizing error messages associated with - * reading in parameters. - * - * \param progName The name of the program, that was tried to be started. - * \param errorMsg The error message that was issued by the start function. - * Comprises the thing that went wrong and a general help message. - */ -void usage(const char *progName, const std::string &errorMsg) -{ - // TODO -} - -int main(int argc, char** argv) -{ - using ProblemTypeTag = TTAG(RosiTestProblem); - return Dumux::start<ProblemTypeTag>(argc, argv, usage); -} diff --git a/test/mixeddimension/embedded/1p_richards/test_rosi.input b/test/mixeddimension/embedded/1p_richards/test_rosi.input deleted file mode 100644 index 4835a18d195c2e0489138defcce7ab6a2e331c7c..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/1p_richards/test_rosi.input +++ /dev/null @@ -1,40 +0,0 @@ -[MixedDimension] -UseIterativeSolver = false -NumCircleSegments = 10 - -[TimeManager] -DtInitial = 8640 # [s] -TEnd = 864000 # [s] -EpisodeTime = 21700 # [s] - -[Grid] -File = ./grids/lupine.dgf -Refinement = 0 - -[SoilGrid] -LowerLeft = -0.05 -0.05 -0.1 -UpperRight = 0.05 0.05 0 -Cells = 20 20 20 - -[Problem] -Name = rosi - -[SpatialParams] -Permeability = 2.57e-12 # [m^2] -### root parameters ### -Kx = 5.0968e-17 -Kr = 2.04e-13 - -[BoundaryConditions] -InitialSoilPressure = -0.9429e4 # [Pa] used as Dirichlet BC and IC -InitialRootPressure = -1.2e6 # [Pa] -TranspirationRate = 2.15e-8 # [kg / s] -CriticalCollarPressure = -1.5e6 # [Pa] - -[IterativeAlgorithm] -MaxIterations = 100 -Tolerance = 1.0e-5 -Verbose = 1 -IntegrationOrder = 1 - - diff --git a/test/mixeddimension/embedded/CMakeLists.txt b/test/mixeddimension/embedded/CMakeLists.txt deleted file mode 100644 index 37a1ca10ddf17061ff3e2c798aca82a5a956a509..0000000000000000000000000000000000000000 --- a/test/mixeddimension/embedded/CMakeLists.txt +++ /dev/null @@ -1,3 +0,0 @@ -add_subdirectory("1p_1p") -add_subdirectory("1p_richards") -add_subdirectory("1p2c_richards2c") diff --git a/test/mixeddimension/facet/1p2c_1p2c/1d2dtestproblem.hh b/test/mixeddimension/facet/1p2c_1p2c/1d2dtestproblem.hh deleted file mode 100644 index 37ce2a4242ff898a64d862dbec6421451ce01d1b..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p2c_1p2c/1d2dtestproblem.hh +++ /dev/null @@ -1,107 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief A test problem for the 1d2d coupled problem: - * 1d fractures living on the element facets of a 2d matrix - */ -#ifndef DUMUX_1D2D_FACET_TEST_PROBLEM_HH -#define DUMUX_1D2D_FACET_TEST_PROBLEM_HH - -#include "fractureproblem.hh" -#include "matrixproblem.hh" - -#include <dumux/mixeddimension/problem.hh> -#include <dumux/mixeddimension/facet/gmshdualfacetgridcreator.hh> -#include <dumux/mixeddimension/facet/mpfa/couplingmanager.hh> - -namespace Dumux -{ -template <class TypeTag> -class OnePTwoCFacetCouplingProblem; - -namespace Properties -{ -// Type tag of the isothermal and non-isotherman global Problem -NEW_TYPE_TAG(OnePTwoCFacetCoupling, INHERITS_FROM(MixedDimension)); -NEW_TYPE_TAG(OnePTwoCIFacetCoupling, INHERITS_FROM(OnePTwoCFacetCoupling)); -NEW_TYPE_TAG(OnePTwoCNIFacetCoupling, INHERITS_FROM(OnePTwoCFacetCoupling)); - -// Set the problem property -SET_TYPE_PROP(OnePTwoCFacetCoupling, Problem, Dumux::OnePTwoCFacetCouplingProblem<TypeTag>); - -// Set the grid creator -SET_TYPE_PROP(OnePTwoCFacetCoupling, GridCreator, Dumux::GmshDualFacetGridCreator<TypeTag>); - -// Set the two sub-problems of the global problem -SET_TYPE_PROP(OnePTwoCIFacetCoupling, BulkProblemTypeTag, TTAG(OnePTwoCICCMpfaMatrixProblem)); -SET_TYPE_PROP(OnePTwoCIFacetCoupling, LowDimProblemTypeTag, TTAG(OnePTwoCICCFractureProblem)); -SET_TYPE_PROP(OnePTwoCNIFacetCoupling, BulkProblemTypeTag, TTAG(OnePTwoCNICCMpfaMatrixProblem)); -SET_TYPE_PROP(OnePTwoCNIFacetCoupling, LowDimProblemTypeTag, TTAG(OnePTwoCNICCFractureProblem)); - -// The coupling manager -SET_TYPE_PROP(OnePTwoCFacetCoupling, CouplingManager, CCMpfaFacetCouplingManager<TypeTag>); - -// The linear solver to be used -SET_TYPE_PROP(OnePTwoCFacetCoupling, LinearSolver, ILU0BiCGSTABBackend<TypeTag>); - -// The sub-problems need to know the global problem's type tag -SET_TYPE_PROP(OnePTwoCICCMpfaMatrixProblem, GlobalProblemTypeTag, TTAG(OnePTwoCIFacetCoupling)); -SET_TYPE_PROP(OnePTwoCICCFractureProblem, GlobalProblemTypeTag, TTAG(OnePTwoCIFacetCoupling)); -SET_TYPE_PROP(OnePTwoCNICCMpfaMatrixProblem, GlobalProblemTypeTag, TTAG(OnePTwoCNIFacetCoupling)); -SET_TYPE_PROP(OnePTwoCNICCFractureProblem, GlobalProblemTypeTag, TTAG(OnePTwoCNIFacetCoupling)); - -// The subproblems inherit the parameter tree from this problem -SET_PROP(OnePTwoCICCMpfaMatrixProblem, ParameterTree) : GET_PROP(TTAG(OnePTwoCIFacetCoupling), ParameterTree) {}; -SET_PROP(OnePTwoCICCFractureProblem, ParameterTree) : GET_PROP(TTAG(OnePTwoCIFacetCoupling), ParameterTree) {}; -SET_PROP(OnePTwoCNICCMpfaMatrixProblem, ParameterTree) : GET_PROP(TTAG(OnePTwoCNIFacetCoupling), ParameterTree) {}; -SET_PROP(OnePTwoCNICCFractureProblem, ParameterTree) : GET_PROP(TTAG(OnePTwoCNIFacetCoupling), ParameterTree) {}; - -// Set the grids for the two sub-problems -SET_TYPE_PROP(OnePTwoCICCMpfaMatrixProblem, Grid, Dune::ALUGrid<2, 2, Dune::simplex, Dune::nonconforming>); -SET_TYPE_PROP(OnePTwoCICCFractureProblem, Grid, Dune::FoamGrid<1,2>); -SET_TYPE_PROP(OnePTwoCNICCMpfaMatrixProblem, Grid, Dune::ALUGrid<2, 2, Dune::simplex, Dune::nonconforming>); -SET_TYPE_PROP(OnePTwoCNICCFractureProblem, Grid, Dune::FoamGrid<1,2>); - -} - -template <class TypeTag> -class OnePTwoCFacetCouplingProblem : public MixedDimensionProblem<TypeTag> -{ - using ParentType = MixedDimensionProblem<TypeTag>; - - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); - using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); - -public: - - OnePTwoCFacetCouplingProblem(TimeManager &timeManager, const BulkGridView &bulkGridView, const LowDimGridView &lowDimGridView) - : ParentType(timeManager, bulkGridView, lowDimGridView) - {} -}; - -} //end namespace - -#endif diff --git a/test/mixeddimension/facet/1p2c_1p2c/CMakeLists.txt b/test/mixeddimension/facet/1p2c_1p2c/CMakeLists.txt deleted file mode 100644 index 8e7d474239fecdc5628bc92dde40556ae0e1e2dc..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p2c_1p2c/CMakeLists.txt +++ /dev/null @@ -1,4 +0,0 @@ -dune_add_test(SOURCES test_fracture_1p2c_1p2c.cc) -dune_add_test(SOURCES test_fracture_1p2cni_1p2cni.cc) -dune_symlink_to_source_files(FILES "grids" "test_fracture_1p2c_1p2c.input" "test_fracture_1p2cni_1p2cni.input") -set(CMAKE_BUILD_TYPE Release) diff --git a/test/mixeddimension/facet/1p2c_1p2c/fractureproblem.hh b/test/mixeddimension/facet/1p2c_1p2c/fractureproblem.hh deleted file mode 100644 index 509833e1d98cae240c86b25e28f391cca590aecc..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p2c_1p2c/fractureproblem.hh +++ /dev/null @@ -1,252 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief A test problem for the one-dimensional single-phase fracture model - */ -#ifndef DUMUX_1P2C_FRACTURE_PROBLEM_HH -#define DUMUX_1P2C_FRACTURE_PROBLEM_HH - -#include <dumux/implicit/cellcentered/tpfa/properties.hh> -#include <dumux/mixeddimension/subproblemproperties.hh> - -#include <dumux/porousmediumflow/1p2c/implicit/model.hh> -#include <dumux/porousmediumflow/implicit/problem.hh> - -#include <dumux/material/fluidsystems/h2on2.hh> -#include "fracturespatialparams.hh" - -namespace Dumux -{ - -//! Forward declaration of the problem class -template <class TypeTag> -class OnePTwoCFractureProblem; - -namespace Properties -{ -NEW_TYPE_TAG(OnePTwoCIFractureProblem, INHERITS_FROM(OnePTwoC)); -NEW_TYPE_TAG(OnePTwoCNIFractureProblem, INHERITS_FROM(OnePTwoCNI)); -NEW_TYPE_TAG(OnePTwoCICCFractureProblem, INHERITS_FROM(CCTpfaModel, OnePTwoCIFractureProblem)); -NEW_TYPE_TAG(OnePTwoCNICCFractureProblem, INHERITS_FROM(CCTpfaModel, OnePTwoCNIFractureProblem)); - -// Set fluid configuration -SET_TYPE_PROP(OnePTwoCIFractureProblem, FluidSystem, FluidSystems::H2ON2<typename GET_PROP_TYPE(TypeTag, Scalar), false>); -SET_TYPE_PROP(OnePTwoCNIFractureProblem, FluidSystem, FluidSystems::H2ON2<typename GET_PROP_TYPE(TypeTag, Scalar), false>); - -// Set the problem property -SET_TYPE_PROP(OnePTwoCIFractureProblem, Problem, OnePTwoCFractureProblem<TypeTag>); -SET_TYPE_PROP(OnePTwoCNIFractureProblem, Problem, OnePTwoCFractureProblem<TypeTag>); - -// Set the spatial parameters -SET_TYPE_PROP(OnePTwoCIFractureProblem, SpatialParams, OnePFractureSpatialParams<TypeTag>); -SET_TYPE_PROP(OnePTwoCNIFractureProblem, SpatialParams, OnePFractureSpatialParams<TypeTag>); - -// Define whether mole(true) or mass (false) fractions are used -SET_BOOL_PROP(OnePTwoCIFractureProblem, UseMoles, true); -SET_BOOL_PROP(OnePTwoCNIFractureProblem, UseMoles, true); - -// Linear solver settings -SET_TYPE_PROP(OnePTwoCIFractureProblem, LinearSolver, SuperLUBackend<TypeTag>); -SET_TYPE_PROP(OnePTwoCNIFractureProblem, LinearSolver, SuperLUBackend<TypeTag>); - -// Enable gravity -SET_BOOL_PROP(OnePTwoCIFractureProblem, ProblemEnableGravity, false); -SET_BOOL_PROP(OnePTwoCNIFractureProblem, ProblemEnableGravity, false); - -// Solution-independent permeability tensor -SET_BOOL_PROP(OnePTwoCICCFractureProblem, SolutionDependentAdvection, false); -SET_BOOL_PROP(OnePTwoCNICCFractureProblem, SolutionDependentAdvection, false); -} - -/*! - * \ingroup OnePModel - * \ingroup ImplicitTestProblems - * \brief Test problem for the one-phase model: - */ -template <class TypeTag> -class OnePTwoCFractureProblem : public ImplicitPorousMediaProblem<TypeTag> -{ - using ParentType = ImplicitPorousMediaProblem<TypeTag>; - - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using Indices = typename GET_PROP_TYPE(TypeTag, Indices); - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem); - using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); - using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); - using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); - - using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); - using CouplingManager = typename GET_PROP_TYPE(GlobalProblemTypeTag, CouplingManager); - - // copy some indices for convenience - enum - { - // indices of the primary variables - pressureIdx = Indices::pressureIdx, - massOrMoleFracIdx = Indices::massOrMoleFracIdx, - - // indices of the equations - conti0EqIdx = Indices::conti0EqIdx, - transportEqIdx = Indices::transportEqIdx - }; - - //! property that defines whether mole or mass fractions are used - static const bool useMoles = GET_PROP_VALUE(TypeTag, UseMoles); - - static constexpr int numEq = GET_PROP_VALUE(TypeTag, NumEq); - static constexpr int dim = GridView::dimension; - static constexpr int dimWorld = GridView::dimensionworld; - - using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; - -public: - OnePTwoCFractureProblem(TimeManager &timeManager, const GridView &gridView) - : ParentType(timeManager, gridView) - { - //initialize fluid system - FluidSystem::init(); - - name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name) + "_fracture"; - eps_ = 1e-6; - - // stating in the console whether mole or mass fractions are used - if(useMoles) - std::cout<<"problem uses mole fractions"<<std::endl; - else - std::cout<<"problem uses mass fractions"<<std::endl; - } - - /*! - * \brief The problem name. - * This is used as a prefix for files generated by the simulation. - */ - const std::string& name() const - { return name_; } - - /*! - * \brief Return the temperature within the domain in [K]. - * - * This problem assumes a temperature of 10 degrees Celsius. - */ - Scalar temperature() const - { return 273.15 + 50; } // 50C - - /*! - * \brief Return how much the domain is extruded at a given sub-control volume. - */ - Scalar extrusionFactorAtPos(const GlobalPosition &globalPos) const - { - //! return the user-specified fracture aperture - static const Scalar a = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, FractureAperture); - return a; - } - - - /*! - * \brief Return the sources within the domain. - */ - PrimaryVariables source(const Element& element, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const SubControlVolume& scv) const - { - // we have only sources coming from the bulk domain - return couplingManager().evalSourcesFromBulk(element, fvGeometry, elemVolVars, scv); - } - - /*! - * \brief Specifies which kind of boundary condition should be used. - */ - BoundaryTypes boundaryTypesAtPos(const GlobalPosition& globalPos) const - { - BoundaryTypes values; - if (globalPos[0] < eps_) - values.setAllDirichlet(); - else - values.setAllNeumann(); - return values; - } - - /*! - * \brief Evaluate the boundary conditions for a dirichlet - * control volume. - */ - PrimaryVariables dirichletAtPos(const GlobalPosition& globalPos) const - { - auto values = initialAtPos(globalPos); - if (globalPos[0] < eps_) - { - values[pressureIdx] += 1e5; - values[massOrMoleFracIdx] = 2.0e-5; - } - return values; - } - - PrimaryVariables neumannAtPos(const GlobalPosition& globalPos) const - { return PrimaryVariables(0.0); } - - /*! - * \brief Evaluate the initial value for a control volume (isothermal case) - */ - template<class T = TypeTag> - typename std::enable_if<std::is_same<T, TTAG(OnePTwoCICCFractureProblem)>::value, PrimaryVariables>::type - initialAtPos(const GlobalPosition& globalPos) const - { - PrimaryVariables values(0.0); - values[pressureIdx] = 1.0e5; - return values; - } - - /*! - * \brief Evaluate the initial value for a control volume (non-isothermal case) - */ - template<class T = TypeTag> - typename std::enable_if<std::is_same<T, TTAG(OnePTwoCNICCFractureProblem)>::value, PrimaryVariables>::type - initialAtPos(const GlobalPosition& globalPos) const - { - PrimaryVariables values(0.0); - values[pressureIdx] = 1.0e5; - values[Indices::temperatureIdx] = temperature(); - return values; - } - - //! Set the coupling manager - void setCouplingManager(std::shared_ptr<CouplingManager> cm) - { couplingManager_ = cm; } - - //! Get the coupling manager - const CouplingManager& couplingManager() const - { return *couplingManager_; } - -private: - std::string name_; - Scalar eps_; - std::shared_ptr<CouplingManager> couplingManager_; -}; -} //end namespace - -#endif diff --git a/test/mixeddimension/facet/1p2c_1p2c/fracturespatialparams.hh b/test/mixeddimension/facet/1p2c_1p2c/fracturespatialparams.hh deleted file mode 100644 index 87403af26656dbbce3930f511e2f49186118534a..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p2c_1p2c/fracturespatialparams.hh +++ /dev/null @@ -1,132 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief The spatial parameters class for the fracture problem - */ -#ifndef DUMUX_1P_FRACTURE_SPATIALPARAMS_HH -#define DUMUX_1P_FRACTURE_SPATIALPARAMS_HH - -#include <dumux/material/spatialparams/fv1p.hh> - -namespace Dumux -{ - -/*! - * \ingroup OnePModel - * \ingroup ImplicitTestProblems - * - * \brief The spatial parameters class for the fracture problem - */ -template<class TypeTag> -class OnePFractureSpatialParams : public FVSpatialParamsOneP<TypeTag> -{ - using ParentType = FVSpatialParamsOneP<TypeTag>; - - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); - - static constexpr int dimWorld = GridView::dimensionworld; - using GlobalPosition = Dune::FieldVector<Scalar,dimWorld>; - -public: - using PermeabilityType = Scalar; - - OnePFractureSpatialParams(const Problem& problem, const GridView& gridView) - : ParentType(problem, gridView) - { - permeability_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, FracturePermeability); - } - - /*! - * \brief Return the intrinsic permeability for a given position in [m^2]. - */ - Scalar permeabilityAtPos(const GlobalPosition& globalPos) const - { return permeability_; } - - /*! - * \brief Define the dispersivity. - * - * \param element The finite element - * \param scv The sub-control volume - * \param elemSol The solution for all dofs of the element - */ - Scalar dispersivity(const Element &element, - const SubControlVolume& scv, - const ElementSolutionVector& elemSol) const - { return 0; } - - /*! - * \brief Define the porosity in [-]. - */ - Scalar porosityAtPos(const GlobalPosition& globalPos) const - { return 0.8; } - - /*! - * \brief Returns the heat capacity \f$[J / (kg K)]\f$ of the rock matrix. - * - * This is only required for non-isothermal models. - * - * \param element The element - * \param scv The sub control volume - * \param elemSol The element solution vector - */ - Scalar solidHeatCapacity(const Element &element, - const SubControlVolume& scv, - const ElementSolutionVector& elemSol) const - { return 790; /*specific heat capacity of granite [J / (kg K)]*/ } - - /*! - * \brief Returns the mass density \f$[kg / m^3]\f$ of the rock matrix. - * - * This is only required for non-isothermal models. - * - * \param element The element - * \param scv The sub control volume - * \param elemSol The element solution vector - */ - Scalar solidDensity(const Element &element, - const SubControlVolume& scv, - const ElementSolutionVector& elemSol) const - { return 2700; /*density of granite [kg/m^3]*/ } - - /*! - * \brief Returns the thermal conductivity \f$\mathrm{[W/(m K)]}\f$ of the porous material. - * - * \param element The element - * \param scv The sub control volume - * \param elemSol The element solution vector - */ - Scalar solidThermalConductivity(const Element &element, - const SubControlVolume& scv, - const ElementSolutionVector& elemSol) const - { return 2.8; } - -private: - Scalar permeability_; -}; -} //end namespace - -#endif diff --git a/test/mixeddimension/facet/1p2c_1p2c/grids/simplefracture.msh b/test/mixeddimension/facet/1p2c_1p2c/grids/simplefracture.msh deleted file mode 100644 index b899844381caa80952fb6c4bfa1265bb00bf3013..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p2c_1p2c/grids/simplefracture.msh +++ /dev/null @@ -1,769 +0,0 @@ -$MeshFormat -2.2 0 8 -$EndMeshFormat -$Nodes -270 -1 0 0 0 -2 1 0 0 -3 1 1 0 -4 0 1 0 -5 0 0.5 0 -6 0.5 0.5 0 -7 0.5 1 0 -8 0.5 0 0 -9 0 0.9285714285714287 0 -10 0 0.8571428571428574 0 -11 0 0.785714285714286 0 -12 0 0.7142857142857145 0 -13 0 0.642857142857143 0 -14 0 0.5714285714285714 0 -15 0.07142857142843365 0.5 0 -16 0.1428571428567969 0.5 0 -17 0.2142857142851601 0.5 0 -18 0.2857142857137215 0.5 0 -19 0.357142857142481 0.5 0 -20 0.4285714285712405 0.5 0 -21 0.5 0.5714285714285713 0 -22 0.5 0.6428571428571426 0 -23 0.5 0.714285714285714 0 -24 0.5 0.7857142857142855 0 -25 0.5 0.857142857142857 0 -26 0.5 0.9285714285714286 0 -27 0.4285714285712302 1 0 -28 0.3571428571431544 1 0 -29 0.2857142857150783 1 0 -30 0.214285714286606 1 0 -31 0.1428571428577374 1 0 -32 0.07142857142886866 1 0 -33 0.5714285714285713 1 0 -34 0.6428571428571426 1 0 -35 0.714285714285714 1 0 -36 0.7857142857142855 1 0 -37 0.857142857142857 1 0 -38 0.9285714285714286 1 0 -39 1 0.0769230769229268 0 -40 1 0.1538461538458463 0 -41 1 0.230769230768699 0 -42 1 0.3076923076915516 0 -43 1 0.3846153846144044 0 -44 1 0.4615384615372571 0 -45 1 0.5384615384603233 0 -46 1 0.6153846153836027 0 -47 1 0.6923076923068823 0 -48 1 0.7692307692301616 0 -49 1 0.8461538461534411 0 -50 1 0.9230769230767206 0 -51 0.9285714285714287 0 0 -52 0.8571428571428574 0 0 -53 0.785714285714286 0 0 -54 0.7142857142857145 0 0 -55 0.642857142857143 0 0 -56 0.5714285714285714 0 0 -57 0.5 0.07142857142843365 0 -58 0.5 0.1428571428567969 0 -59 0.5 0.2142857142851601 0 -60 0.5 0.2857142857137215 0 -61 0.5 0.357142857142481 0 -62 0.5 0.4285714285712405 0 -63 0 0.4285714285712302 0 -64 0 0.3571428571431544 0 -65 0 0.2857142857150783 0 -66 0 0.214285714286606 0 -67 0 0.1428571428577374 0 -68 0 0.07142857142886866 0 -69 0.07142857142843365 0 0 -70 0.1428571428567969 0 0 -71 0.2142857142851601 0 0 -72 0.2857142857137215 0 0 -73 0.357142857142481 0 0 -74 0.4285714285712405 0 0 -75 0.2500000000001029 0.7499999999999913 0 -76 0.3663991502258305 0.8607636833337764 0 -77 0.1336008497742085 0.6392363166662469 0 -78 0.360553815138555 0.6339296306297841 0 -79 0.1394461848614766 0.866070369370183 0 -80 0.3945121951219374 0.7500000000000056 0 -81 0.2500000000000117 0.894512195121736 0 -82 0.1054878048780371 0.7499999999999888 0 -83 0.2500000000000231 0.6054878048781932 0 -84 0.4099468700328296 0.9085380033098094 0 -85 0.09005312996718502 0.5914619966902129 0 -86 0.4084855362610006 0.5901353251810584 0 -87 0.09151446373902193 0.9098646748189356 0 -88 0.3163323093059868 0.9277968884482115 0 -89 0.1836676906940536 0.5722031115517863 0 -90 0.4308805885555369 0.816978152530935 0 -91 0.06911941144447076 0.6830218474690508 0 -92 0.4276102709568276 0.6839600468485355 0 -93 0.07238972904317516 0.8160399531514779 0 -94 0.3169628560151079 0.569143375063738 0 -95 0.1830371439849851 0.930856624936212 0 -96 0.1777439024390704 0.7186846689895942 0 -97 0.3222560975610171 0.7813153310105113 0 -98 0.2186846689894849 0.8222560975608439 0 -99 0.281315331010573 0.6777439024390751 0 -100 0.2127212956530052 0.6605593007541477 0 -101 0.2872787043470723 0.8394406992458452 0 -102 0.3376991852564805 0.7146605345345609 0 -103 0.1623008147434993 0.7853394654654904 0 -104 0.2499671727043229 0.9526071769956799 0 -105 0.2500328272959247 0.5473928230042734 0 -106 0.452598708968294 0.7500488441992643 0 -107 0.04740129103169477 0.7499511558007352 0 -108 0.3785120078660805 0.802264291718807 0 -109 0.1214879921339467 0.6977357082812201 0 -110 0.3022080005410647 0.6215761782526976 0 -111 0.1977919994589895 0.8784238217472436 0 -112 0.3726477103858178 0.9483944902732477 0 -113 0.1273522896142005 0.5516055097267425 0 -114 0.448394490273324 0.8726477103858009 0 -115 0.0516055097266785 0.6273522896141636 0 -116 0.3726477103857807 0.5516055097266543 0 -117 0.1273522896142536 0.9483944902733571 0 -118 0.448394490273319 0.6273522896142062 0 -119 0.05160550972666995 0.8726477103857907 0 -120 0.4458560963636229 0.9456883741347235 0 -121 0.05414390363634093 0.5543116258653055 0 -122 0.4456821280574496 0.5541536887808458 0 -123 0.05431787194257909 0.9458463112191549 0 -124 0.249999999999118 0.2500000000008422 0 -125 0.3607636833334462 0.1336008497744994 0 -126 0.139236316665904 0.3663991502261119 0 -127 0.1339296306297288 0.1394461848614341 0 -128 0.3660703693701051 0.3605538151384909 0 -129 0.1054878048783477 0.2500000000001412 0 -130 0.2499999999998437 0.3945121951217477 0 -131 0.2499999999998601 0.1054878048780462 0 -132 0.394512195121891 0.2500000000001529 0 -133 0.4085380033096497 0.09005312996729152 0 -134 0.09146199669005958 0.4099468700329305 0 -135 0.09013532518102976 0.09151446373903099 0 -136 0.409864674818892 0.408485536261001 0 -137 0.07220311155165929 0.3163323093060347 0 -138 0.4277968884480938 0.1836676906940996 0 -139 0.1830218474689369 0.430880588555647 0 -140 0.1839600468482993 0.07238972904310831 0 -141 0.3169781525307869 0.06911941144460924 0 -142 0.3160399531511913 0.4276102709567171 0 -143 0.06914337506379396 0.1830371439850628 0 -144 0.4308566249362663 0.3169628560151838 0 -145 0.2813153310096828 0.177743902439605 0 -146 0.3222560975606539 0.2813153310103989 0 -147 0.1777439024388848 0.218684668989311 0 -148 0.2186846689886664 0.3222560975614522 0 -149 0.3394406992454809 0.2127212956532663 0 -150 0.2853394654648746 0.3376991852562275 0 -151 0.214660534534055 0.1623008147433966 0 -152 0.1605593007537633 0.2872787043473155 0 -153 0.04739282300435266 0.2499671727043362 0 -154 0.2499511558002347 0.4525987089682048 0 -155 0.4526071769957596 0.2500328272959378 0 -156 0.2500488441987652 0.04740129103170386 0 -157 0.1977357082808378 0.3785120078662397 0 -158 0.1215761782526888 0.1977919994589873 0 -159 0.302264291718444 0.12148799213419 0 -160 0.378423821747229 0.3022080005410566 0 -161 0.05160550972677423 0.3726477103858412 0 -162 0.1273522896141813 0.4483944902732597 0 -163 0.05160550972669813 0.1273522896143134 0 -164 0.4483944902732815 0.1273522896142276 0 -165 0.372647710385782 0.0516055097266369 0 -166 0.3726477103856819 0.4483944902732985 0 -167 0.1273522896141326 0.05160550972667206 0 -168 0.4483944902734028 0.3726477103858364 0 -169 0.05431162586518547 0.4458560963636766 0 -170 0.4456883741345915 0.05414390363639463 0 -171 0.05415368878081393 0.05431787194259233 0 -172 0.4458463112191101 0.4456821280574623 0 -173 0.7498431921410134 0.2487046863407722 0 -174 0.7498431921410897 0.7512953136588922 0 -175 0.7525498326979938 0.489795902069563 0 -176 0.6554176502954461 0.3753416306762046 0 -177 0.6395003573620394 0.61934160369765 0 -178 0.8332951699684495 0.3705710002033599 0 -179 0.8437776866959014 0.6253419913534776 0 -180 0.6377123923533041 0.1345486935119893 0 -181 0.6377123923534093 0.8654513064878782 0 -182 0.8644783099631453 0.1410779857953755 0 -183 0.86447830996305 0.8589220142045064 0 -184 0.6164788426234363 0.4978523146597794 0 -185 0.8733696797873758 0.4913268547662911 0 -186 0.617163703372188 0.7378884884693416 0 -187 0.6171637033720544 0.2621115115303286 0 -188 0.8845854179155426 0.2622127029493508 0 -189 0.8845854179152219 0.737787297050333 0 -190 0.7468034059002393 0.1067790051518364 0 -191 0.7468034059002689 0.8932209948481977 0 -192 0.7476678283701303 0.3459061063271456 0 -193 0.7597491426970167 0.6572501345798423 0 -194 0.5925754143221191 0.09250622909350696 0 -195 0.5925754143221645 0.907493770906413 0 -196 0.5888010805804065 0.5709232513918482 0 -197 0.9185790323033378 0.5733679724612935 0 -198 0.5867280017874821 0.4212234529604718 0 -199 0.9087504456288682 0.09391559987654818 0 -200 0.9087504456288441 0.9060844001233475 0 -201 0.9339979673486936 0.4334881196926209 0 -202 0.5732802687163325 0.6755651731864952 0 -203 0.5810889370627905 0.3373760650648218 0 -204 0.5806550589575552 0.1953210627556767 0 -205 0.5806550589576397 0.8046789372440413 0 -206 0.9200089374853018 0.6613042259036606 0 -207 0.6849422343081517 0.06800798003259537 0 -208 0.684942234308151 0.9319920199673914 0 -209 0.8147865560334546 0.07182704290704299 0 -210 0.8147865560334642 0.9281729570929758 0 -211 0.6861157335818396 0.549738623876491 0 -212 0.9277132169078599 0.1940735781471218 0 -213 0.9277132169076956 0.805926421852418 0 -214 0.7134285206255796 0.4238622322347174 0 -215 0.9178980623117714 0.3440630760452438 0 -216 0.7725794782858478 0.5703651086523948 0 -217 0.8158410556529518 0.2956349806067627 0 -218 0.8129982621751185 0.7012738427708129 0 -219 0.8148054367488373 0.4489044384673637 0 -220 0.6851693097191054 0.3022132914018171 0 -221 0.6845212179055167 0.6912799254512429 0 -222 0.7080945660659917 0.1744400475073995 0 -223 0.7080945660661757 0.8255599524924307 0 -224 0.8203089810297554 0.2176190194685191 0 -225 0.8203089810295483 0.78238098053133 0 -226 0.6786239605719111 0.7609548413729557 0 -227 0.6787535789345132 0.2377438019974254 0 -228 0.8440606253062124 0.555994565310866 0 -229 0.7840525018555998 0.1600746311951576 0 -230 0.7840525018555994 0.8399253688047221 0 -231 0.5533497285731628 0.7499999999999996 0 -232 0.5533497285728947 0.2499999999994408 0 -233 0.5493592367545799 0.4766722963811555 0 -234 0.6526043516138412 0.4416707458833477 0 -235 0.9448263474858816 0.4999999999987902 0 -236 0.9484879256308776 0.2692307692301253 0 -237 0.9479604341768698 0.7314309473710232 0 -238 0.7096019754744769 0.6137813175917091 0 -239 0.7497472446240415 0.04764051534444557 0 -240 0.7497472446240437 0.9523594846555778 0 -241 0.6869983774241895 0.4905722704698197 0 -242 0.5576863323234944 0.1363078466926431 0 -243 0.557686332323548 0.8636921533072193 0 -244 0.7734887124513243 0.411777125412964 0 -245 0.8103091287759028 0.5101482995734545 0 -246 0.5435893393619812 0.5357142857142858 0 -247 0.5494676598785529 0.6161350998999454 0 -248 0.6390852932162585 0.7988302096604518 0 -249 0.6390985195796475 0.2010369988464801 0 -250 0.9442758793742078 0.1303033674217557 0 -251 0.9442758793741841 0.8696966325780009 0 -252 0.6952732326765333 0.1218982709551163 0 -253 0.6952732326766027 0.8781017290448434 0 -254 0.8629049264621789 0.3181204399511793 0 -255 0.865356039461941 0.6805353949828806 0 -256 0.6347099001123491 0.319260624668293 0 -257 0.6294734650159235 0.6820658927009351 0 -258 0.5487969283455508 0.3811133708252797 0 -259 0.6273590798434561 0.05162452340121975 0 -260 0.6273590798434484 0.9483754765988067 0 -261 0.5551374576858777 0.05547290681659822 0 -262 0.5551374576858974 0.9445270931833407 0 -263 0.8717596981566804 0.05179946313872448 0 -264 0.8717596981566577 0.9482005368612918 0 -265 0.8715991253783384 0.4202472558948991 0 -266 0.9455475391184203 0.05577430851899132 0 -267 0.9455475391184232 0.9442256914809001 0 -268 0.8742714814540758 0.2037458215900918 0 -269 0.8742714814538789 0.7962541784096469 0 -270 0.6331198429606767 0.5490074303379234 0 -$EndNodes -$Elements -490 -1 1 2 14 2 5 15 -2 1 2 14 2 15 16 -3 1 2 14 2 16 17 -4 1 2 14 2 17 18 -5 1 2 14 2 18 19 -6 1 2 14 2 19 20 -7 1 2 14 2 20 6 -8 2 2 12 12 78 92 102 -9 2 2 12 12 79 93 103 -10 2 2 12 12 80 102 92 -11 2 2 12 12 82 103 93 -12 2 2 12 12 75 101 98 -13 2 2 12 12 75 100 99 -14 2 2 12 12 75 97 101 -15 2 2 12 12 75 96 100 -16 2 2 12 12 76 84 112 -17 2 2 12 12 76 114 84 -18 2 2 12 12 77 115 85 -19 2 2 12 12 77 85 113 -20 2 2 12 12 79 87 119 -21 2 2 12 12 79 117 87 -22 2 2 12 12 78 86 118 -23 2 2 12 12 78 116 86 -24 2 2 12 12 76 112 88 -25 2 2 12 12 77 113 89 -26 2 2 12 12 76 90 114 -27 2 2 12 12 77 91 115 -28 2 2 12 12 79 119 93 -29 2 2 12 12 78 118 92 -30 2 2 12 12 79 95 117 -31 2 2 12 12 78 94 116 -32 2 2 12 12 76 88 101 -33 2 2 12 12 81 101 88 -34 2 2 12 12 77 89 100 -35 2 2 12 12 83 100 89 -36 2 2 12 12 75 103 96 -37 2 2 12 12 75 98 103 -38 2 2 12 12 75 102 97 -39 2 2 12 12 75 99 102 -40 2 2 12 12 28 29 88 -41 2 2 12 12 30 31 95 -42 2 2 12 12 18 19 94 -43 2 2 12 12 16 17 89 -44 2 2 12 12 24 25 90 -45 2 2 12 12 12 13 91 -46 2 2 12 12 10 11 93 -47 2 2 12 12 22 23 92 -48 2 2 12 12 30 95 104 -49 2 2 12 12 18 94 105 -50 2 2 12 12 12 91 107 -51 2 2 12 12 24 90 106 -52 2 2 12 12 11 107 93 -53 2 2 12 12 23 106 92 -54 2 2 12 12 29 104 88 -55 2 2 12 12 17 105 89 -56 2 2 12 12 81 104 95 -57 2 2 12 12 83 105 94 -58 2 2 12 12 80 106 90 -59 2 2 12 12 82 107 91 -60 2 2 12 12 80 92 106 -61 2 2 12 12 82 93 107 -62 2 2 12 12 81 88 104 -63 2 2 12 12 83 89 105 -64 2 2 12 12 81 98 101 -65 2 2 12 12 83 99 100 -66 2 2 12 12 78 102 99 -67 2 2 12 12 79 103 98 -68 2 2 12 12 27 112 120 -69 2 2 12 12 15 113 121 -70 2 2 12 12 26 120 114 -71 2 2 12 12 21 118 122 -72 2 2 12 12 14 121 115 -73 2 2 12 12 9 119 123 -74 2 2 12 12 20 122 116 -75 2 2 12 12 32 123 117 -76 2 2 12 12 77 100 96 -77 2 2 12 12 76 101 97 -78 2 2 12 12 82 96 103 -79 2 2 12 12 80 97 102 -80 2 2 12 12 28 88 112 -81 2 2 12 12 16 89 113 -82 2 2 12 12 25 114 90 -83 2 2 12 12 13 115 91 -84 2 2 12 12 22 92 118 -85 2 2 12 12 10 93 119 -86 2 2 12 12 19 116 94 -87 2 2 12 12 31 117 95 -88 2 2 12 12 84 114 120 -89 2 2 12 12 84 120 112 -90 2 2 12 12 85 121 113 -91 2 2 12 12 86 122 118 -92 2 2 12 12 85 115 121 -93 2 2 12 12 87 123 119 -94 2 2 12 12 86 116 122 -95 2 2 12 12 87 117 123 -96 2 2 12 12 76 108 90 -97 2 2 12 12 80 90 108 -98 2 2 12 12 77 109 91 -99 2 2 12 12 82 91 109 -100 2 2 12 12 83 94 110 -101 2 2 12 12 81 95 111 -102 2 2 12 12 78 110 94 -103 2 2 12 12 79 111 95 -104 2 2 12 12 27 28 112 -105 2 2 12 12 15 16 113 -106 2 2 12 12 25 26 114 -107 2 2 12 12 13 14 115 -108 2 2 12 12 21 22 118 -109 2 2 12 12 9 10 119 -110 2 2 12 12 19 20 116 -111 2 2 12 12 31 32 117 -112 2 2 12 12 76 97 108 -113 2 2 12 12 77 96 109 -114 2 2 12 12 82 109 96 -115 2 2 12 12 80 108 97 -116 2 2 12 12 81 111 98 -117 2 2 12 12 83 110 99 -118 2 2 12 12 78 99 110 -119 2 2 12 12 79 98 111 -120 2 2 12 12 7 27 120 -121 2 2 12 12 5 15 121 -122 2 2 12 12 5 121 14 -123 2 2 12 12 7 120 26 -124 2 2 12 12 4 123 32 -125 2 2 12 12 6 122 20 -126 2 2 12 12 6 21 122 -127 2 2 12 12 4 9 123 -128 2 2 12 12 29 30 104 -129 2 2 12 12 17 18 105 -130 2 2 12 12 23 24 106 -131 2 2 12 12 11 12 107 -132 2 2 12 14 128 142 150 -133 2 2 12 14 127 140 151 -134 2 2 12 14 130 150 142 -135 2 2 12 14 131 151 140 -136 2 2 12 14 124 149 146 -137 2 2 12 14 124 152 147 -138 2 2 12 14 124 145 149 -139 2 2 12 14 124 148 152 -140 2 2 12 14 125 165 133 -141 2 2 12 14 125 133 164 -142 2 2 12 14 127 135 167 -143 2 2 12 14 128 168 136 -144 2 2 12 14 127 163 135 -145 2 2 12 14 128 136 166 -146 2 2 12 14 126 134 161 -147 2 2 12 14 126 162 134 -148 2 2 12 14 125 164 138 -149 2 2 12 14 125 141 165 -150 2 2 12 14 127 167 140 -151 2 2 12 14 128 144 168 -152 2 2 12 14 127 143 163 -153 2 2 12 14 128 166 142 -154 2 2 12 14 126 161 137 -155 2 2 12 14 126 139 162 -156 2 2 12 14 125 138 149 -157 2 2 12 14 132 149 138 -158 2 2 12 14 126 137 152 -159 2 2 12 14 129 152 137 -160 2 2 12 14 124 151 145 -161 2 2 12 14 124 147 151 -162 2 2 12 14 124 146 150 -163 2 2 12 14 124 150 148 -164 2 2 12 14 72 73 141 -165 2 2 12 14 58 59 138 -166 2 2 12 14 66 67 143 -167 2 2 12 14 64 65 137 -168 2 2 12 14 60 61 144 -169 2 2 12 14 18 142 19 -170 2 2 12 14 70 71 140 -171 2 2 12 14 16 139 17 -172 2 2 12 14 66 143 153 -173 2 2 12 14 72 141 156 -174 2 2 12 14 60 144 155 -175 2 2 12 14 18 154 142 -176 2 2 12 14 59 155 138 -177 2 2 12 14 71 156 140 -178 2 2 12 14 65 153 137 -179 2 2 12 14 17 139 154 -180 2 2 12 14 129 153 143 -181 2 2 12 14 131 156 141 -182 2 2 12 14 130 142 154 -183 2 2 12 14 132 155 144 -184 2 2 12 14 132 138 155 -185 2 2 12 14 131 140 156 -186 2 2 12 14 129 137 153 -187 2 2 12 14 130 154 139 -188 2 2 12 14 128 150 146 -189 2 2 12 14 129 147 152 -190 2 2 12 14 132 146 149 -191 2 2 12 14 127 151 147 -192 2 2 12 14 63 161 169 -193 2 2 12 14 15 169 162 -194 2 2 12 14 69 167 171 -195 2 2 12 14 57 164 170 -196 2 2 12 14 20 166 172 -197 2 2 12 14 68 171 163 -198 2 2 12 14 74 170 165 -199 2 2 12 14 62 172 168 -200 2 2 12 14 125 149 145 -201 2 2 12 14 131 145 151 -202 2 2 12 14 130 148 150 -203 2 2 12 14 126 152 148 -204 2 2 12 14 64 137 161 -205 2 2 12 14 58 138 164 -206 2 2 12 14 16 162 139 -207 2 2 12 14 70 140 167 -208 2 2 12 14 73 165 141 -209 2 2 12 14 19 142 166 -210 2 2 12 14 67 163 143 -211 2 2 12 14 61 168 144 -212 2 2 12 14 134 162 169 -213 2 2 12 14 134 169 161 -214 2 2 12 14 135 171 167 -215 2 2 12 14 136 172 166 -216 2 2 12 14 135 163 171 -217 2 2 12 14 133 170 164 -218 2 2 12 14 136 168 172 -219 2 2 12 14 133 165 170 -220 2 2 12 14 126 157 139 -221 2 2 12 14 130 139 157 -222 2 2 12 14 125 159 141 -223 2 2 12 14 131 141 159 -224 2 2 12 14 129 143 158 -225 2 2 12 14 127 158 143 -226 2 2 12 14 132 144 160 -227 2 2 12 14 128 160 144 -228 2 2 12 14 63 64 161 -229 2 2 12 14 15 162 16 -230 2 2 12 14 57 58 164 -231 2 2 12 14 69 70 167 -232 2 2 12 14 19 166 20 -233 2 2 12 14 73 74 165 -234 2 2 12 14 67 68 163 -235 2 2 12 14 61 62 168 -236 2 2 12 14 125 145 159 -237 2 2 12 14 131 159 145 -238 2 2 12 14 132 160 146 -239 2 2 12 14 128 146 160 -240 2 2 12 14 126 148 157 -241 2 2 12 14 129 158 147 -242 2 2 12 14 127 147 158 -243 2 2 12 14 130 157 148 -244 2 2 12 14 5 63 169 -245 2 2 12 14 8 170 74 -246 2 2 12 14 8 57 170 -247 2 2 12 14 1 171 68 -248 2 2 12 14 5 169 15 -249 2 2 12 14 1 69 171 -250 2 2 12 14 6 20 172 -251 2 2 12 14 6 172 62 -252 2 2 12 14 65 66 153 -253 2 2 12 14 17 154 18 -254 2 2 12 14 59 60 155 -255 2 2 12 14 71 72 156 -256 2 2 12 16 202 247 177 -257 2 2 12 16 247 196 177 -258 2 2 12 16 201 265 215 -259 2 2 12 16 265 178 215 -260 2 2 12 16 60 232 203 -261 2 2 12 16 23 202 231 -262 2 2 12 16 176 192 214 -263 2 2 12 16 22 202 23 -264 2 2 12 16 60 203 61 -265 2 2 12 16 182 229 209 -266 2 2 12 16 183 210 230 -267 2 2 12 16 173 192 220 -268 2 2 12 16 174 221 193 -269 2 2 12 16 244 175 214 -270 2 2 12 16 190 209 229 -271 2 2 12 16 191 230 210 -272 2 2 12 16 176 220 192 -273 2 2 12 16 219 175 244 -274 2 2 12 16 179 193 216 -275 2 2 12 16 243 25 24 -276 2 2 12 16 58 242 59 -277 2 2 12 16 173 217 192 -278 2 2 12 16 174 193 218 -279 2 2 12 16 175 216 211 -280 2 2 12 16 178 192 217 -281 2 2 12 16 179 218 193 -282 2 2 12 16 205 243 24 -283 2 2 12 16 242 204 59 -284 2 2 12 16 181 260 195 -285 2 2 12 16 180 194 259 -286 2 2 12 16 46 206 197 -287 2 2 12 16 176 198 203 -288 2 2 12 16 181 208 260 -289 2 2 12 16 180 259 207 -290 2 2 12 16 43 201 215 -291 2 2 12 16 177 238 221 -292 2 2 12 16 183 264 210 -293 2 2 12 16 182 209 263 -294 2 2 12 16 193 221 238 -295 2 2 12 16 182 263 199 -296 2 2 12 16 183 200 264 -297 2 2 12 16 178 244 192 -298 2 2 12 16 179 197 206 -299 2 2 12 16 187 203 232 -300 2 2 12 16 186 231 202 -301 2 2 12 16 211 216 238 -302 2 2 12 16 194 242 261 -303 2 2 12 16 195 262 243 -304 2 2 12 16 45 46 197 -305 2 2 12 16 43 44 201 -306 2 2 12 16 46 47 206 -307 2 2 12 16 261 242 57 -308 2 2 12 16 262 26 243 -309 2 2 12 16 184 196 246 -310 2 2 12 16 180 242 194 -311 2 2 12 16 181 195 243 -312 2 2 12 16 174 230 223 -313 2 2 12 16 173 222 229 -314 2 2 12 16 174 225 230 -315 2 2 12 16 173 229 224 -316 2 2 12 16 42 43 215 -317 2 2 12 16 182 199 250 -318 2 2 12 16 183 251 200 -319 2 2 12 16 180 204 242 -320 2 2 12 16 181 243 205 -321 2 2 12 16 62 198 233 -322 2 2 12 16 184 246 233 -323 2 2 12 16 54 207 55 -324 2 2 12 16 34 208 35 -325 2 2 12 16 182 250 212 -326 2 2 12 16 183 213 251 -327 2 2 12 16 184 270 196 -328 2 2 12 16 44 235 201 -329 2 2 12 16 173 224 217 -330 2 2 12 16 174 218 225 -331 2 2 12 16 40 41 212 -332 2 2 12 16 48 49 213 -333 2 2 12 16 52 209 53 -334 2 2 12 16 36 210 37 -335 2 2 12 16 188 217 224 -336 2 2 12 16 189 225 218 -337 2 2 12 16 185 201 235 -338 2 2 12 16 180 222 249 -339 2 2 12 16 181 248 223 -340 2 2 12 16 185 235 197 -341 2 2 12 16 179 228 197 -342 2 2 12 16 45 197 235 -343 2 2 12 16 185 197 228 -344 2 2 12 16 57 242 58 -345 2 2 12 16 25 243 26 -346 2 2 12 16 184 198 234 -347 2 2 12 16 176 234 198 -348 2 2 12 16 222 227 249 -349 2 2 12 16 223 248 226 -350 2 2 12 16 177 196 270 -351 2 2 12 16 198 258 203 -352 2 2 12 16 48 213 237 -353 2 2 12 16 41 236 212 -354 2 2 12 16 6 62 233 -355 2 2 12 16 189 237 213 -356 2 2 12 16 188 212 236 -357 2 2 12 16 35 208 240 -358 2 2 12 16 54 239 207 -359 2 2 12 16 199 266 250 -360 2 2 12 16 200 251 267 -361 2 2 12 16 184 233 198 -362 2 2 12 16 62 258 198 -363 2 2 12 16 61 203 258 -364 2 2 12 16 173 220 227 -365 2 2 12 16 174 226 221 -366 2 2 12 16 39 250 266 -367 2 2 12 16 50 267 251 -368 2 2 12 16 190 207 239 -369 2 2 12 16 191 240 208 -370 2 2 12 16 185 265 201 -371 2 2 12 16 22 247 202 -372 2 2 12 16 51 266 263 -373 2 2 12 16 38 264 267 -374 2 2 12 16 53 209 239 -375 2 2 12 16 36 240 210 -376 2 2 12 16 186 202 257 -377 2 2 12 16 187 256 203 -378 2 2 12 16 56 259 261 -379 2 2 12 16 33 262 260 -380 2 2 12 16 47 237 206 -381 2 2 12 16 178 254 215 -382 2 2 12 16 177 270 211 -383 2 2 12 16 189 206 237 -384 2 2 12 16 24 231 205 -385 2 2 12 16 59 204 232 -386 2 2 12 16 190 239 209 -387 2 2 12 16 191 210 240 -388 2 2 12 16 187 232 204 -389 2 2 12 16 186 205 231 -390 2 2 12 16 173 227 222 -391 2 2 12 16 174 223 226 -392 2 2 12 16 177 257 202 -393 2 2 12 16 176 203 256 -394 2 2 12 16 187 227 220 -395 2 2 12 16 186 221 226 -396 2 2 12 16 188 236 215 -397 2 2 12 16 175 241 214 -398 2 2 12 16 193 238 216 -399 2 2 12 16 176 214 234 -400 2 2 12 16 21 246 247 -401 2 2 12 16 175 245 216 -402 2 2 12 16 182 224 229 -403 2 2 12 16 183 230 225 -404 2 2 12 16 179 216 228 -405 2 2 12 16 241 270 184 -406 2 2 12 16 42 215 236 -407 2 2 12 16 211 270 241 -408 2 2 12 16 199 263 266 -409 2 2 12 16 200 267 264 -410 2 2 12 16 187 204 249 -411 2 2 12 16 186 248 205 -412 2 2 12 16 182 212 268 -413 2 2 12 16 183 269 213 -414 2 2 12 16 180 249 204 -415 2 2 12 16 181 205 248 -416 2 2 12 16 190 229 222 -417 2 2 12 16 191 223 230 -418 2 2 12 16 179 206 255 -419 2 2 12 16 178 219 244 -420 2 2 12 16 194 261 259 -421 2 2 12 16 195 260 262 -422 2 2 12 16 55 207 259 -423 2 2 12 16 34 260 208 -424 2 2 12 16 196 247 246 -425 2 2 12 16 189 255 206 -426 2 2 12 16 51 263 52 -427 2 2 12 16 37 264 38 -428 2 2 12 16 55 259 56 -429 2 2 12 16 33 260 34 -430 2 2 12 16 177 211 238 -431 2 2 12 16 188 268 212 -432 2 2 12 16 189 213 269 -433 2 2 12 16 39 40 250 -434 2 2 12 16 49 50 251 -435 2 2 12 16 188 215 254 -436 2 2 12 16 180 207 252 -437 2 2 12 16 181 253 208 -438 2 2 12 16 185 245 219 -439 2 2 12 16 190 252 207 -440 2 2 12 16 191 208 253 -441 2 2 12 16 52 263 209 -442 2 2 12 16 37 210 264 -443 2 2 12 16 175 211 241 -444 2 2 12 16 185 219 265 -445 2 2 12 16 192 244 214 -446 2 2 12 16 40 212 250 -447 2 2 12 16 49 251 213 -448 2 2 12 16 179 255 218 -449 2 2 12 16 178 217 254 -450 2 2 12 16 176 256 220 -451 2 2 12 16 177 221 257 -452 2 2 12 16 175 219 245 -453 2 2 12 16 187 220 256 -454 2 2 12 16 186 257 221 -455 2 2 12 16 180 252 222 -456 2 2 12 16 181 223 253 -457 2 2 12 16 23 231 24 -458 2 2 12 16 59 232 60 -459 2 2 12 16 190 222 252 -460 2 2 12 16 191 253 223 -461 2 2 12 16 178 265 219 -462 2 2 12 16 189 218 255 -463 2 2 12 16 188 254 217 -464 2 2 12 16 44 45 235 -465 2 2 12 16 3 267 50 -466 2 2 12 16 2 39 266 -467 2 2 12 16 61 258 62 -468 2 2 12 16 21 247 22 -469 2 2 12 16 188 224 268 -470 2 2 12 16 189 269 225 -471 2 2 12 16 8 261 57 -472 2 2 12 16 8 56 261 -473 2 2 12 16 7 26 262 -474 2 2 12 16 7 262 33 -475 2 2 12 16 182 268 224 -476 2 2 12 16 183 225 269 -477 2 2 12 16 216 245 228 -478 2 2 12 16 41 42 236 -479 2 2 12 16 47 48 237 -480 2 2 12 16 214 241 234 -481 2 2 12 16 2 266 51 -482 2 2 12 16 3 38 267 -483 2 2 12 16 53 239 54 -484 2 2 12 16 35 240 36 -485 2 2 12 16 6 246 21 -486 2 2 12 16 185 228 245 -487 2 2 12 16 184 234 241 -488 2 2 12 16 187 249 227 -489 2 2 12 16 186 226 248 -490 2 2 12 16 6 233 246 -$EndElements diff --git a/test/mixeddimension/facet/1p2c_1p2c/matrixproblem.hh b/test/mixeddimension/facet/1p2c_1p2c/matrixproblem.hh deleted file mode 100644 index 0fb63cf390612620453ccb95a008ff31b3597835..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p2c_1p2c/matrixproblem.hh +++ /dev/null @@ -1,252 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief A test problem for the one-phase model: - * water is flowing from bottom to top through and around a low permeable lens. - */ -#ifndef DUMUX_1P2C_MATRIX_PROBLEM_HH -#define DUMUX_1P2C_MATRIX_PROBLEM_HH - -#include <dumux/mixeddimension/facet/mpfa/properties.hh> -#include <dumux/mixeddimension/subproblemproperties.hh> - -#include <dumux/porousmediumflow/1p2c/implicit/model.hh> -#include <dumux/porousmediumflow/implicit/problem.hh> - -#include <dumux/material/fluidsystems/h2on2.hh> -#include "matrixspatialparams.hh" - -namespace Dumux -{ -template <class TypeTag> -class OnePTwoCMpfaMatrixProblem; - -namespace Properties -{ -NEW_TYPE_TAG(OnePTwoCIMatrixProblem, INHERITS_FROM(OnePTwoC)); -NEW_TYPE_TAG(OnePTwoCNIMatrixProblem, INHERITS_FROM(OnePTwoCNI)); -NEW_TYPE_TAG(OnePTwoCICCMpfaMatrixProblem, INHERITS_FROM(FacetCouplingBulkMpfaModel, OnePTwoCIMatrixProblem)); -NEW_TYPE_TAG(OnePTwoCNICCMpfaMatrixProblem, INHERITS_FROM(FacetCouplingBulkMpfaModel, OnePTwoCNIMatrixProblem)); - -// Set fluid configuration -SET_TYPE_PROP(OnePTwoCIMatrixProblem, FluidSystem, FluidSystems::H2ON2<typename GET_PROP_TYPE(TypeTag, Scalar), false>); -SET_TYPE_PROP(OnePTwoCNIMatrixProblem, FluidSystem, FluidSystems::H2ON2<typename GET_PROP_TYPE(TypeTag, Scalar), false>); - -// Set the problem property -SET_TYPE_PROP(OnePTwoCIMatrixProblem, Problem, OnePTwoCMpfaMatrixProblem<TypeTag>); -SET_TYPE_PROP(OnePTwoCNIMatrixProblem, Problem, OnePTwoCMpfaMatrixProblem<TypeTag>); - -// Define whether mole(true) or mass (false) fractions are used -SET_BOOL_PROP(OnePTwoCIMatrixProblem, UseMoles, true); -SET_BOOL_PROP(OnePTwoCNIMatrixProblem, UseMoles, true); - -// Set the spatial parameters -SET_TYPE_PROP(OnePTwoCIMatrixProblem, SpatialParams, OnePMatrixSpatialParams<TypeTag>); -SET_TYPE_PROP(OnePTwoCNIMatrixProblem, SpatialParams, OnePMatrixSpatialParams<TypeTag>); - -// Linear solver settings -SET_TYPE_PROP(OnePTwoCIMatrixProblem, LinearSolver, SuperLUBackend<TypeTag>); -SET_TYPE_PROP(OnePTwoCNIMatrixProblem, LinearSolver, SuperLUBackend<TypeTag>); - -// Enable gravity -SET_BOOL_PROP(OnePTwoCIMatrixProblem, ProblemEnableGravity, false); -SET_BOOL_PROP(OnePTwoCNIMatrixProblem, ProblemEnableGravity, false); - -// Solution-independent tensor -SET_BOOL_PROP(OnePTwoCICCMpfaMatrixProblem, SolutionDependentAdvection, false); -SET_BOOL_PROP(OnePTwoCNICCMpfaMatrixProblem, SolutionDependentAdvection, false); - -// change mpfa method -//SET_PROP(OnePMatrixProblem, MpfaMethod) { static const MpfaMethods value = MpfaMethods::lMethod; }; -} - -/*! - * \ingroup OnePModel - * \ingroup ImplicitTestProblems - * \brief Test problem for the one-phase model - */ - -template <class TypeTag> -class OnePTwoCMpfaMatrixProblem : public ImplicitPorousMediaProblem<TypeTag> -{ - using ParentType = ImplicitPorousMediaProblem<TypeTag>; - - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using Intersection = typename GridView::Intersection; - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using Indices = typename GET_PROP_TYPE(TypeTag, Indices); - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using FluidSystem = typename GET_PROP_TYPE(TypeTag, FluidSystem); - using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); - using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); - using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); - - using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); - using CouplingManager = typename GET_PROP_TYPE(GlobalProblemTypeTag, CouplingManager); - - // copy some indices for convenience - enum - { - // indices of the primary variables - pressureIdx = Indices::pressureIdx, - massOrMoleFracIdx = Indices::massOrMoleFracIdx, - - // indices of the equations - conti0EqIdx = Indices::conti0EqIdx, - transportEqIdx = Indices::transportEqIdx - }; - - //! property that defines whether mole or mass fractions are used - static const bool useMoles = GET_PROP_VALUE(TypeTag, UseMoles); - - static constexpr int numEq = GET_PROP_VALUE(TypeTag, NumEq); - static constexpr int dim = GridView::dimension; - static constexpr int dimWorld = GridView::dimensionworld; - - using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; - - -public: - OnePTwoCMpfaMatrixProblem(TimeManager &timeManager, const GridView &gridView) - : ParentType(timeManager, gridView) - { - //initialize fluid system - FluidSystem::init(); - - name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name) + "_matrix"; - eps_ = 1e-6; - - // stating in the console whether mole or mass fractions are used - if(useMoles) - std::cout<<"problem uses mole fractions"<<std::endl; - else - std::cout<<"problem uses mass fractions"<<std::endl; - } - - /*! - * \brief The problem name. - * - * This is used as a prefix for files generated by the simulation. - */ - const std::string& name() const - { return name_; } - - /*! - * \brief Return the temperature within the domain in [K]. - * - * This problem assumes a temperature of 10 degrees Celsius. - */ - Scalar temperature() const - { return 273.15 + 40; } - - /*! - * \brief Return the sources within the domain. - */ - PrimaryVariables sourceAtPos(const GlobalPosition& globalPos) const - { return PrimaryVariables(0.0); } - - /*! - * \brief Specifies which kind of boundary condition should be - * used for which equation on a given boundary control volume. - */ - BoundaryTypes boundaryTypes(const Element& element, const SubControlVolumeFace& scvf) const - { - BoundaryTypes values; - const auto globalPos = scvf.ipGlobal(); - - values.setAllNeumann(); - if (globalPos[0] > this->bBoxMax()[0] - eps_) - values.setAllDirichlet(); - - if (couplingManager().isInteriorBoundary(element, scvf)) - values.setAllNeumann(); - - return values; - } - - /*! - * \brief Specifies if a given intersection is on an interior boundary - */ - bool isInteriorBoundary(const Element& element, const Intersection& is) const - { return couplingManager().isInteriorBoundary(element, is); } - - /*! - * \brief Evaluate the boundary conditions for a dirichlet - * control volume. - */ - PrimaryVariables dirichletAtPos(const GlobalPosition& globalPos) const - { - PrimaryVariables values = initialAtPos(globalPos); - return values; - } - - /*! - * \brief Evaluate the boundary conditions for a neumann - * boundary segment. - */ - PrimaryVariables neumannAtPos(const GlobalPosition& globalPos) const - { return PrimaryVariables(0.0); } - - /*! - * \brief Evaluate the initial value for a control volume (isothermal case) - */ - template<class T = TypeTag> - typename std::enable_if<std::is_same<T, TTAG(OnePTwoCICCMpfaMatrixProblem)>::value, PrimaryVariables>::type - initialAtPos(const GlobalPosition& globalPos) const - { - PrimaryVariables values(0.0); - values[pressureIdx] = 1.0e5; - return values; - } - - /*! - * \brief Evaluate the initial value for a control volume (non-isothermal case) - */ - template<class T = TypeTag> - typename std::enable_if<std::is_same<T, TTAG(OnePTwoCNICCMpfaMatrixProblem)>::value, PrimaryVariables>::type - initialAtPos(const GlobalPosition& globalPos) const - { - PrimaryVariables values(0.0); - values[pressureIdx] = 1.0e5; - values[Indices::temperatureIdx] = temperature(); - return values; - } - - //! Set the coupling manager - void setCouplingManager(std::shared_ptr<CouplingManager> cm) - { couplingManager_ = cm; } - - //! Get the coupling manager - const CouplingManager& couplingManager() const - { return *couplingManager_; } - -private: - std::string name_; - Scalar eps_; - std::shared_ptr<CouplingManager> couplingManager_; -}; -} //end namespace - -#endif diff --git a/test/mixeddimension/facet/1p2c_1p2c/matrixspatialparams.hh b/test/mixeddimension/facet/1p2c_1p2c/matrixspatialparams.hh deleted file mode 100644 index e4f72fcc1891cc4382faf35951d5af200209ab11..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p2c_1p2c/matrixspatialparams.hh +++ /dev/null @@ -1,139 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief The spatial parameters class for the matrix problem - */ -#ifndef DUMUX_1P_MATRIX_SPATIALPARAMS_HH -#define DUMUX_1P_MATRIX_SPATIALPARAMS_HH - -#include <dumux/material/spatialparams/fv1p.hh> - -namespace Dumux -{ - -/*! - * \ingroup OnePModel - * \ingroup ImplicitTestProblems - * - * \brief The spatial parameters class for the matrix problem - */ -template<class TypeTag> -class OnePMatrixSpatialParams : public FVSpatialParamsOneP<TypeTag> -{ - using ParentType = FVSpatialParamsOneP<TypeTag>; - - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using ElementSolutionVector = typename GET_PROP_TYPE(TypeTag, ElementSolutionVector); - - static constexpr int dimWorld = GridView::dimensionworld; - using GlobalPosition = Dune::FieldVector<Scalar,dimWorld>; - - using Tensor = Dune::FieldMatrix<Scalar, dimWorld, dimWorld>; - -public: - using PermeabilityType = Tensor; - - OnePMatrixSpatialParams(const Problem& problem, const GridView& gridView) - : ParentType(problem, gridView) - { - Scalar permeability = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, MatrixPermeability); - - K_[0][0] = permeability; - K_[1][1] = permeability; - K_[0][1] = 0.; - K_[1][0] = 0.; - } - - /*! - * \brief Return the intrinsic permeability for the given position in [m^2]. - */ - Tensor permeabilityAtPos(const GlobalPosition& globalPos) const - { return K_; } - - /*! - * \brief Define the dispersivity. - * - * \param element The finite element - * \param scv The sub-control volume - * \param elemSol The solution for all dofs of the element - */ - Scalar dispersivity(const Element &element, - const SubControlVolume& scv, - const ElementSolutionVector& elemSol) const - { return 0; } - - /*! - * \brief Define the porosity in [-]. - */ - Scalar porosityAtPos(const GlobalPosition& globalPos) const - { return 0.2; } - - /*! - * \brief Returns the heat capacity \f$[J / (kg K)]\f$ of the rock matrix. - * - * This is only required for non-isothermal models. - * - * \param element The element - * \param scv The sub control volume - * \param elemSol The element solution vector - */ - Scalar solidHeatCapacity(const Element &element, - const SubControlVolume& scv, - const ElementSolutionVector& elemSol) const - { return 790; /*specific heat capacity of granite [J / (kg K)]*/ } - - /*! - * \brief Returns the mass density \f$[kg / m^3]\f$ of the rock matrix. - * - * This is only required for non-isothermal models. - * - * \param element The element - * \param scv The sub control volume - * \param elemSol The element solution vector - */ - Scalar solidDensity(const Element &element, - const SubControlVolume& scv, - const ElementSolutionVector& elemSol) const - { return 2700; /*density of granite [kg/m^3]*/ } - - /*! - * \brief Returns the thermal conductivity \f$\mathrm{[W/(m K)]}\f$ of the porous material. - * - * \param element The element - * \param scv The sub control volume - * \param elemSol The element solution vector - */ - Scalar solidThermalConductivity(const Element &element, - const SubControlVolume& scv, - const ElementSolutionVector& elemSol) const - { return 2.8; } - -private: - Tensor K_; -}; -} //end namespace - -#endif diff --git a/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2c_1p2c.cc b/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2c_1p2c.cc deleted file mode 100644 index 2cb680427e7a3e9b0fb367f32b1956940b1002b8..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2c_1p2c.cc +++ /dev/null @@ -1,45 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief test for the 1d 3d cell-centered coupled model - */ -#include "config.h" -#include "1d2dtestproblem.hh" -#include <dumux/mixeddimension/facet/start.hh> - -/*! - * \brief Provides an interface for customizing error messages associated with - * reading in parameters. - * - * \param progName The name of the program, that was tried to be started. - * \param errorMsg The error message that was issued by the start function. - * Comprises the thing that went wrong and a general help message. - */ -void usage(const char *progName, const std::string &errorMsg) -{ - // TODO -} - -int main(int argc, char** argv) -{ - using ProblemTypeTag = TTAG(OnePTwoCIFacetCoupling); - return Dumux::start<ProblemTypeTag>(argc, argv, usage); -} diff --git a/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2c_1p2c.input b/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2c_1p2c.input deleted file mode 100644 index 37b52c000a5d73fff0ac51f25018199c05ea10de..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2c_1p2c.input +++ /dev/null @@ -1,32 +0,0 @@ -[TimeManager] -DtInitial = 1 # [s] -TEnd = 100000 # [s] -DtInitialBulkProblem = 1 # [s] -DtInitialLowDimProblem = 1 # [s] -EpisodeTime = 1000 # [s] - -[Grid] -File = ./grids/simplefracture.msh - -[Problem] -Name = test_1dfracture - -[MixedDimension] -UseIterativeSolver = False - -[IterativeAlgorithm] -MaxIterations = 100 -Tolerance = 1.0e-8 -Verbose = 1 - -[SpatialParams] -FractureAperture = 1e-1 # [m] -FracturePermeability = 1e-15 # [m^2] -MatrixPermeability = 1e-14 # [m^2] - -[Vtk] -AddVelocity = False - -[Newton] -MaxRelativeShift = 1e-5 -MaxSteps = 20 diff --git a/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2cni_1p2cni.cc b/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2cni_1p2cni.cc deleted file mode 100644 index 26ca7726421b0e965e6faae72ad4987df9d26aea..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2cni_1p2cni.cc +++ /dev/null @@ -1,45 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief test for the 1d 3d cell-centered coupled model - */ -#include "config.h" -#include "1d2dtestproblem.hh" -#include <dumux/mixeddimension/facet/start.hh> - -/*! - * \brief Provides an interface for customizing error messages associated with - * reading in parameters. - * - * \param progName The name of the program, that was tried to be started. - * \param errorMsg The error message that was issued by the start function. - * Comprises the thing that went wrong and a general help message. - */ -void usage(const char *progName, const std::string &errorMsg) -{ - // TODO -} - -int main(int argc, char** argv) -{ - using ProblemTypeTag = TTAG(OnePTwoCNIFacetCoupling); - return Dumux::start<ProblemTypeTag>(argc, argv, usage); -} diff --git a/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2cni_1p2cni.input b/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2cni_1p2cni.input deleted file mode 100644 index 893638de22f9ecc670e4beebc6b40965d64cf010..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p2c_1p2c/test_fracture_1p2cni_1p2cni.input +++ /dev/null @@ -1,32 +0,0 @@ -[TimeManager] -DtInitial = 1 # [s] -TEnd = 100000 # [s] -DtInitialBulkProblem = 1 # [s] -DtInitialLowDimProblem = 1 # [s] -EpisodeTime = 1000 # [s] - -[Grid] -File = ./grids/simplefracture.msh - -[Problem] -Name = test_1dfracture_ni - -[MixedDimension] -UseIterativeSolver = False - -[IterativeAlgorithm] -MaxIterations = 100 -Tolerance = 1.0e-8 -Verbose = 1 - -[SpatialParams] -FractureAperture = 1e-1 # [m] -FracturePermeability = 1e-12 # [m^2] -MatrixPermeability = 1e-14 # [m^2] - -[Vtk] -AddVelocity = False - -[Newton] -MaxRelativeShift = 1e-5 -MaxSteps = 20 diff --git a/test/mixeddimension/facet/1p_1p/1d2dtestproblem.hh b/test/mixeddimension/facet/1p_1p/1d2dtestproblem.hh deleted file mode 100644 index 18e8312ed39f7e8df8aebeb6e997b2deeb5a53f5..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p_1p/1d2dtestproblem.hh +++ /dev/null @@ -1,97 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief A test problem for the 1d2d coupled problem: - * 1d fractures living on the element facets of a 2d matrix - */ -#ifndef DUMUX_1D2D_FACET_TEST_PROBLEM_HH -#define DUMUX_1D2D_FACET_TEST_PROBLEM_HH - -#include "fractureproblem.hh" -#include "matrixproblem.hh" - -#include <dumux/mixeddimension/problem.hh> -#include <dumux/mixeddimension/facet/gmshdualfacetgridcreator.hh> -#include <dumux/mixeddimension/facet/mpfa/couplingmanager.hh> - -namespace Dumux -{ -template <class TypeTag> -class OnePFacetCouplingProblem; - -namespace Properties -{ -// Type tag of the global Problem and the two sub problems -NEW_TYPE_TAG(OnePFacetCoupling, INHERITS_FROM(MixedDimension)); - -// Set the problem property -SET_TYPE_PROP(OnePFacetCoupling, Problem, Dumux::OnePFacetCouplingProblem<TypeTag>); - -// Set the grid creator -SET_TYPE_PROP(OnePFacetCoupling, GridCreator, Dumux::GmshDualFacetGridCreator<TypeTag>); - -// Set the two sub-problems of the global problem -SET_TYPE_PROP(OnePFacetCoupling, BulkProblemTypeTag, TTAG(OnePCCMpfaMatrixProblem)); -SET_TYPE_PROP(OnePFacetCoupling, LowDimProblemTypeTag, TTAG(OnePCCFractureProblem)); - -// The coupling manager -SET_TYPE_PROP(OnePFacetCoupling, CouplingManager, CCMpfaFacetCouplingManager<TypeTag>); - -// The linear solver to be used -SET_TYPE_PROP(OnePFacetCoupling, LinearSolver, ILU0BiCGSTABBackend<TypeTag>); - -// The sub-problems need to know the global problem's type tag -SET_TYPE_PROP(OnePCCMpfaMatrixProblem, GlobalProblemTypeTag, TTAG(OnePFacetCoupling)); -SET_TYPE_PROP(OnePCCFractureProblem, GlobalProblemTypeTag, TTAG(OnePFacetCoupling)); - -// The subproblems inherit the parameter tree from this problem -SET_PROP(OnePCCMpfaMatrixProblem, ParameterTree) : GET_PROP(TTAG(OnePFacetCoupling), ParameterTree) {}; -SET_PROP(OnePCCFractureProblem, ParameterTree) : GET_PROP(TTAG(OnePFacetCoupling), ParameterTree) {}; - -// Set the grids for the two sub-problems -SET_TYPE_PROP(OnePCCMpfaMatrixProblem, Grid, Dune::ALUGrid<2, 2, Dune::simplex, Dune::nonconforming>); -SET_TYPE_PROP(OnePCCFractureProblem, Grid, Dune::FoamGrid<1,2>); - -} - -template <class TypeTag> -class OnePFacetCouplingProblem : public MixedDimensionProblem<TypeTag> -{ - using ParentType = MixedDimensionProblem<TypeTag>; - - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - - using BulkProblemTypeTag = typename GET_PROP_TYPE(TypeTag, BulkProblemTypeTag); - using LowDimProblemTypeTag = typename GET_PROP_TYPE(TypeTag, LowDimProblemTypeTag); - - using BulkGridView = typename GET_PROP_TYPE(BulkProblemTypeTag, GridView); - using LowDimGridView = typename GET_PROP_TYPE(LowDimProblemTypeTag, GridView); - -public: - - OnePFacetCouplingProblem(TimeManager &timeManager, const BulkGridView &bulkGridView, const LowDimGridView &lowDimGridView) - : ParentType(timeManager, bulkGridView, lowDimGridView) - {} -}; - -} //end namespace - -#endif diff --git a/test/mixeddimension/facet/1p_1p/CMakeLists.txt b/test/mixeddimension/facet/1p_1p/CMakeLists.txt deleted file mode 100644 index 9c66a8c1eb500828a2933e5d35fa18cf60b8bc4a..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p_1p/CMakeLists.txt +++ /dev/null @@ -1,3 +0,0 @@ -dune_add_test(SOURCES test_fracture_1p_1p.cc) -dune_symlink_to_source_files(FILES "grids" "test_fracture_1p_1p.input") -set(CMAKE_BUILD_TYPE Release) diff --git a/test/mixeddimension/facet/1p_1p/fractureproblem.hh b/test/mixeddimension/facet/1p_1p/fractureproblem.hh deleted file mode 100644 index fe15cabc4bda070c42e8a757a9e4e6d0e0ccf51e..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p_1p/fractureproblem.hh +++ /dev/null @@ -1,209 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief A test problem for the one-dimensional single-phase fracture model - */ -#ifndef DUMUX_1P_FRACTURE_PROBLEM_HH -#define DUMUX_1P_FRACTURE_PROBLEM_HH - -#include <dumux/implicit/cellcentered/tpfa/properties.hh> -#include <dumux/mixeddimension/subproblemproperties.hh> - -#include <dumux/porousmediumflow/1p/model.hh> -#include <dumux/porousmediumflow/implicit/problem.hh> - -#include <dumux/material/components/constant.hh> -#include <dumux/material/fluidsystems/liquidphase.hh> -#include <dumux/material/fluidsystems/1p.hh> - -#include "fracturespatialparams.hh" - -namespace Dumux -{ - -//! Forward declaration of the problem class -template <class TypeTag> -class OnePFractureProblem; - -namespace Properties -{ -NEW_TYPE_TAG(OnePFractureProblem, INHERITS_FROM(OneP)); -NEW_TYPE_TAG(OnePCCFractureProblem, INHERITS_FROM(CCTpfaModel, OnePFractureProblem)); - -// the fluid system -SET_PROP(OnePFractureProblem, FluidSystem) -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using type = FluidSystems::OneP<Scalar, FluidSystems::LiquidPhase<Scalar, Components::Constant<1, Scalar> > >; -}; - -// Set the problem property -SET_TYPE_PROP(OnePFractureProblem, Problem, OnePFractureProblem<TypeTag>); - -// Set the spatial parameters -SET_TYPE_PROP(OnePFractureProblem, SpatialParams, OnePFractureSpatialParams<TypeTag>); - -// Linear solver settings -SET_TYPE_PROP(OnePFractureProblem, LinearSolver, SuperLUBackend<TypeTag>); - -// Enable gravity -SET_BOOL_PROP(OnePFractureProblem, ProblemEnableGravity, false); -} - -/*! - * \ingroup OnePModel - * \ingroup ImplicitTestProblems - * \brief Test problem for the one-phase model: - */ -template <class TypeTag> -class OnePFractureProblem : public ImplicitPorousMediaProblem<TypeTag> -{ - using ParentType = ImplicitPorousMediaProblem<TypeTag>; - - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using Indices = typename GET_PROP_TYPE(TypeTag, Indices); - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); - using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); - using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); - - using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); - using CouplingManager = typename GET_PROP_TYPE(GlobalProblemTypeTag, CouplingManager); - - enum - { - conti0EqIdx = Indices::conti0EqIdx, - pressureIdx = Indices::pressureIdx - }; - - static constexpr int numEq = GET_PROP_VALUE(TypeTag, NumEq); - static constexpr int dim = GridView::dimension; - static constexpr int dimWorld = GridView::dimensionworld; - - using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; - -public: - OnePFractureProblem(TimeManager &timeManager, const GridView &gridView) - : ParentType(timeManager, gridView) - { - name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name) + "_fracture"; - eps_ = 1e-6; - } - - /*! - * \brief The problem name. - * This is used as a prefix for files generated by the simulation. - */ - const std::string& name() const - { return name_; } - - /*! - * \brief Return the temperature within the domain in [K]. - * - * This problem assumes a temperature of 10 degrees Celsius. - */ - Scalar temperature() const - { return 273.15 + 10; } // 10C - - /*! - * \brief Return how much the domain is extruded at a given sub-control volume. - */ - Scalar extrusionFactorAtPos(const GlobalPosition &globalPos) const - { - //! return the user-specified fracture aperture - static const Scalar a = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, FractureAperture); - return a; - } - - - /*! - * \brief Return the sources within the domain. - */ - PrimaryVariables source(const Element& element, - const FVElementGeometry& fvGeometry, - const ElementVolumeVariables& elemVolVars, - const SubControlVolume& scv) const - { - // we have only sources coming from the bulk domain - return couplingManager().evalSourcesFromBulk(element, fvGeometry, elemVolVars, scv); - } - - /*! - * \brief Specifies which kind of boundary condition should be used. - */ - BoundaryTypes boundaryTypesAtPos(const GlobalPosition& globalPos) const - { - BoundaryTypes values; - if (globalPos[0] < eps_ || globalPos[0] > this->bBoxMax()[0] - eps_) - values.setAllDirichlet(); - else - values.setAllNeumann(); - return values; - } - - /*! - * \brief Evaluate the boundary conditions for a dirichlet - * control volume. - */ - PrimaryVariables dirichletAtPos(const GlobalPosition& globalPos) const - { - PrimaryVariables values; - values[pressureIdx] = 2.0 - globalPos[0]/this->bBoxMax()[0]; - return values; - } - - PrimaryVariables neumannAtPos(const GlobalPosition& globalPos) const - { return PrimaryVariables(0.0); } - - /*! - * \brief Evaluate the initial value for a control volume. - * - * For this method, the \a priVars parameter stores primary - * variables. - */ - PrimaryVariables initialAtPos(const GlobalPosition& globalPos) const - { - PrimaryVariables priVars; - priVars[pressureIdx] = 2.0 - globalPos[0]/this->bBoxMax()[0]; - return priVars; - }; - - //! Set the coupling manager - void setCouplingManager(std::shared_ptr<CouplingManager> cm) - { couplingManager_ = cm; } - - //! Get the coupling manager - const CouplingManager& couplingManager() const - { return *couplingManager_; } - -private: - std::string name_; - Scalar eps_; - std::shared_ptr<CouplingManager> couplingManager_; -}; -} //end namespace - -#endif diff --git a/test/mixeddimension/facet/1p_1p/fracturespatialparams.hh b/test/mixeddimension/facet/1p_1p/fracturespatialparams.hh deleted file mode 100644 index 5d7957bb026b670cb0ef5047839dcf8f95ffbc1c..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p_1p/fracturespatialparams.hh +++ /dev/null @@ -1,78 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief The spatial parameters class for the fracture problem - */ -#ifndef DUMUX_1P_FRACTURE_SPATIALPARAMS_HH -#define DUMUX_1P_FRACTURE_SPATIALPARAMS_HH - -#include <dumux/material/spatialparams/fv1p.hh> - -namespace Dumux -{ - -/*! - * \ingroup OnePModel - * \ingroup ImplicitTestProblems - * - * \brief The spatial parameters class for the fracture problem - */ -template<class TypeTag> -class OnePFractureSpatialParams : public FVSpatialParamsOneP<TypeTag> -{ - using ParentType = FVSpatialParamsOneP<TypeTag>; - - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - - static constexpr int dimWorld = GridView::dimensionworld; - using GlobalPosition = Dune::FieldVector<Scalar,dimWorld>; - -public: - using PermeabilityType = Scalar; - - OnePFractureSpatialParams(const Problem& problem, const GridView& gridView) - : ParentType(problem, gridView) - { - permeability_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, FracturePermeability); - } - - /*! - * \brief Return the intrinsic permeability for a given position in [m^2]. - */ - Scalar permeabilityAtPos(const GlobalPosition& globalPos) const - { return permeability_; } - - /*! - * \brief Define the porosity in [-]. - */ - Scalar porosityAtPos(const GlobalPosition& globalPos) const - { return 0.8; } - -private: - Scalar permeability_; -}; -} //end namespace - -#endif diff --git a/test/mixeddimension/facet/1p_1p/grids/simplefracture_long.msh b/test/mixeddimension/facet/1p_1p/grids/simplefracture_long.msh deleted file mode 100644 index 97d57ee2faf29cac9cffb972184496b3cbce3f46..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p_1p/grids/simplefracture_long.msh +++ /dev/null @@ -1,20728 +0,0 @@ -$MeshFormat -2.2 0 8 -$EndMeshFormat -$Nodes -6953 -1 0 0 0 -2 1 0 0 -3 1 1 0 -4 0 1 0 -5 0 2 0 -6 1 2 0 -7 0 1.961246838739447 0 -8 0 1.923620027356419 0 -9 0 1.887086839128796 0 -10 0 1.851615478578754 0 -11 0 1.817175089469696 0 -12 0 1.783735707587069 0 -13 0 1.751268236839613 0 -14 0 1.719744426337889 0 -15 0 1.689136857907859 0 -16 0 1.659418885121227 0 -17 0 1.630564671287283 0 -18 0 1.602549093390542 0 -19 0 1.57534779490678 0 -20 0 1.548937093166071 0 -21 0 1.523294014611084 0 -22 0 1.498396249203548 0 -23 0 1.474222134050282 0 -24 0 1.450750629754289 0 -25 0 1.42796132677119 0 -26 0 1.405834394400535 0 -27 0 1.384350577400349 0 -28 0 1.363491184451146 0 -29 0 1.343238067032042 0 -30 0 1.323573604946558 0 -31 0 1.304480687581044 0 -32 0 1.285942703790913 0 -33 0 1.267943520816152 0 -34 0 1.250467486362735 0 -35 0 1.233499389066202 0 -36 0 1.217024467022857 0 -37 0 1.201028387241073 0 -38 0 1.185497232544095 0 -39 0 1.170417484876865 0 -40 0 1.155776031483197 0 -41 0 1.141560131320103 0 -42 0 1.127757413025329 0 -43 0 1.114355867344446 0 -44 0 1.101343837356743 0 -45 0 1.088710000985292 0 -46 0 1.076443364265634 0 -47 0 1.064533257314828 0 -48 0 1.052969311414612 0 -49 0 1.041741473455155 0 -50 0 1.030839971892862 0 -51 0 1.020255320150878 0 -52 0 1.009978311119173 0 -53 0 0.9900216888807783 0 -54 0 0.9797446798490225 0 -55 0 0.9691600281069848 0 -56 0 0.9582585265446345 0 -57 0 0.9470306885851157 0 -58 0 0.9354667426848361 0 -59 0 0.9235566357339615 0 -60 0 0.9112899990142319 0 -61 0 0.8986561626427046 0 -62 0 0.8856441326549224 0 -63 0 0.8722425869739866 0 -64 0 0.8584398686792792 0 -65 0 0.844223968516258 0 -66 0 0.8295825151226676 0 -67 0 0.8145027674555209 0 -68 0 0.7989716127586306 0 -69 0 0.7829755329769404 0 -70 0 0.7665006109336951 0 -71 0 0.7495325136372667 0 -72 0 0.7320564791839617 0 -73 0 0.7140572962093195 0 -74 0 0.6955193124193149 0 -75 0 0.6764263950539335 0 -76 0 0.6567619329685902 0 -77 0 0.6365088155496345 0 -78 0 0.6156494226005882 0 -79 0 0.5941656056005681 0 -80 0 0.5720386732300877 0 -81 0 0.5492493702471728 0 -82 0 0.5257778659513737 0 -83 0 0.5016037507983127 0 -84 0 0.4767059853907288 0 -85 0 0.4510629068356712 0 -86 0 0.4246522050948855 0 -87 0 0.3974509066110418 0 -88 0 0.3694353287142109 0 -89 0 0.3405811148801705 0 -90 0 0.3108631420934366 0 -91 0 0.280255573663297 0 -92 0 0.2487317631614541 0 -93 0 0.2162642924138732 0 -94 0 0.1828249105311132 0 -95 0 0.1483845214219136 0 -96 0 0.1129131608717201 0 -97 0 0.07637997264393659 0 -98 0 0.03875316126073414 0 -99 0.03999999999992186 0 0 -100 0.07999999999984518 0 0 -101 0.1199999999997832 0 0 -102 0.1599999999996745 0 0 -103 0.1999999999995579 0 0 -104 0.2399999999994413 0 0 -105 0.2799999999993247 0 0 -106 0.3199999999992081 0 0 -107 0.3599999999990915 0 0 -108 0.3999999999989749 0 0 -109 0.4399999999988584 0 0 -110 0.4799999999987418 0 0 -111 0.5199999999987361 0 0 -112 0.5599999999988415 0 0 -113 0.5999999999989468 0 0 -114 0.6399999999990521 0 0 -115 0.6799999999991574 0 0 -116 0.7199999999992628 0 0 -117 0.7599999999993681 0 0 -118 0.7999999999994734 0 0 -119 0.8399999999995788 0 0 -120 0.8799999999996841 0 0 -121 0.9199999999997894 0 0 -122 0.9599999999998947 0 0 -123 1 0.03875316126044642 0 -124 1 0.07637997264337447 0 -125 1 0.1129131608709185 0 -126 1 0.148384521420854 0 -127 1 0.1828249105297957 0 -128 1 0.2162642924123149 0 -129 1 0.2487317631596681 0 -130 1 0.2802555736612968 0 -131 1 0.310863142091238 0 -132 1 0.3405811148777859 0 -133 1 0.3694353287116517 0 -134 1 0.3974509066083207 0 -135 1 0.4246522050920155 0 -136 1 0.4510629068326624 0 -137 1 0.4767059853875909 0 -138 1 0.5016037507950835 0 -139 1 0.5257778659484318 0 -140 1 0.5492493702445046 0 -141 1 0.5720386732276799 0 -142 1 0.5941656055984066 0 -143 1 0.6156494225986616 0 -144 1 0.6365088155479306 0 -145 1 0.656761932967097 0 -146 1 0.6764263950526404 0 -147 1 0.6955193124182117 0 -148 1 0.7140572962083968 0 -149 1 0.7320564791832096 0 -150 1 0.7495325136366761 0 -151 1 0.7665006109332575 0 -152 1 0.782975532976647 0 -153 1 0.7989716127584735 0 -154 1 0.8145027674554923 0 -155 1 0.8295825151227607 0 -156 1 0.8442239685164651 0 -157 1 0.8584398686795944 0 -158 1 0.8722425869744029 0 -159 1 0.8856441326553172 0 -160 1 0.8986561626430498 0 -161 1 0.9112899990145296 0 -162 1 0.9235566357342145 0 -163 1 0.9354667426850464 0 -164 1 0.9470306885852854 0 -165 1 0.9582585265447658 0 -166 1 0.9691600281070806 0 -167 1 0.9797446798490843 0 -168 1 0.9900216888808085 0 -169 1 1.009978311119173 0 -170 1 1.020255320150877 0 -171 1 1.030839971892861 0 -172 1 1.041741473455154 0 -173 1 1.052969311414611 0 -174 1 1.064533257314827 0 -175 1 1.076443364265633 0 -176 1 1.088710000985291 0 -177 1 1.101343837356743 0 -178 1 1.114355867344445 0 -179 1 1.127757413025327 0 -180 1 1.141560131320103 0 -181 1 1.155776031483196 0 -182 1 1.170417484876864 0 -183 1 1.185497232544094 0 -184 1 1.201028387241072 0 -185 1 1.217024467022855 0 -186 1 1.2334993890662 0 -187 1 1.250467486362734 0 -188 1 1.267943520816151 0 -189 1 1.285942703790912 0 -190 1 1.304480687581042 0 -191 1 1.323573604946557 0 -192 1 1.34323806703204 0 -193 1 1.363491184451145 0 -194 1 1.384350577400348 0 -195 1 1.405834394400534 0 -196 1 1.427961326771189 0 -197 1 1.450750629754288 0 -198 1 1.474222134050281 0 -199 1 1.498396249203547 0 -200 1 1.523294014611084 0 -201 1 1.548937093166071 0 -202 1 1.57534779490678 0 -203 1 1.602549093390542 0 -204 1 1.630564671287284 0 -205 1 1.659418885121229 0 -206 1 1.689136857907859 0 -207 1 1.719744426337889 0 -208 1 1.751268236839613 0 -209 1 1.783735707587067 0 -210 1 1.817175089469695 0 -211 1 1.851615478578753 0 -212 1 1.887086839128794 0 -213 1 1.923620027356417 0 -214 1 1.961246838739447 0 -215 0.9599999999998334 2 0 -216 0.9199999999996669 2 0 -217 0.879999999999508 2 0 -218 0.8399999999997222 2 0 -219 0.7999999999999997 2 0 -220 0.7600000000002772 2 0 -221 0.7200000000005549 2 0 -222 0.6800000000008324 2 0 -223 0.6400000000011098 2 0 -224 0.6000000000013872 2 0 -225 0.5600000000016645 2 0 -226 0.5200000000019419 2 0 -227 0.4800000000019974 2 0 -228 0.4400000000018309 2 0 -229 0.4000000000016645 2 0 -230 0.360000000001498 2 0 -231 0.3200000000013316 2 0 -232 0.2800000000011651 2 0 -233 0.2400000000009987 2 0 -234 0.2000000000008322 2 0 -235 0.1600000000006658 2 0 -236 0.1200000000004994 2 0 -237 0.08000000000033292 2 0 -238 0.04000000000016646 2 0 -239 0.009999999999981104 1 0 -240 0.01999999999996237 1 0 -241 0.02999999999994307 1 0 -242 0.03999999999992186 1 0 -243 0.04999999999989966 1 0 -244 0.05999999999987837 1 0 -245 0.06999999999986051 1 0 -246 0.07999999999984518 1 0 -247 0.0899999999998299 1 0 -248 0.09999999999981463 1 0 -249 0.1099999999997994 1 0 -250 0.1199999999997832 1 0 -251 0.1299999999997609 1 0 -252 0.1399999999997328 1 0 -253 0.1499999999997036 1 0 -254 0.1599999999996745 1 0 -255 0.1699999999996453 1 0 -256 0.1799999999996162 1 0 -257 0.189999999999587 1 0 -258 0.1999999999995579 1 0 -259 0.2099999999995288 1 0 -260 0.2199999999994996 1 0 -261 0.2299999999994704 1 0 -262 0.2399999999994413 1 0 -263 0.2499999999994121 1 0 -264 0.259999999999383 1 0 -265 0.2699999999993538 1 0 -266 0.2799999999993247 1 0 -267 0.2899999999992955 1 0 -268 0.2999999999992664 1 0 -269 0.3099999999992372 1 0 -270 0.3199999999992081 1 0 -271 0.329999999999179 1 0 -272 0.3399999999991498 1 0 -273 0.3499999999991207 1 0 -274 0.3599999999990915 1 0 -275 0.3699999999990624 1 0 -276 0.3799999999990332 1 0 -277 0.3899999999990041 1 0 -278 0.3999999999989749 1 0 -279 0.4099999999989458 1 0 -280 0.4199999999989167 1 0 -281 0.4299999999988875 1 0 -282 0.4399999999988584 1 0 -283 0.4499999999988292 1 0 -284 0.4599999999988 1 0 -285 0.4699999999987708 1 0 -286 0.4799999999987418 1 0 -287 0.4899999999987126 1 0 -288 0.4999999999986943 1 0 -289 0.5099999999987098 1 0 -290 0.5199999999987361 1 0 -291 0.5299999999987626 1 0 -292 0.5399999999987888 1 0 -293 0.5499999999988152 1 0 -294 0.5599999999988415 1 0 -295 0.5699999999988679 1 0 -296 0.5799999999988942 1 0 -297 0.5899999999989205 1 0 -298 0.5999999999989468 1 0 -299 0.6099999999989731 1 0 -300 0.6199999999989995 1 0 -301 0.6299999999990258 1 0 -302 0.6399999999990521 1 0 -303 0.6499999999990784 1 0 -304 0.6599999999991049 1 0 -305 0.6699999999991312 1 0 -306 0.6799999999991574 1 0 -307 0.6899999999991837 1 0 -308 0.6999999999992101 1 0 -309 0.7099999999992365 1 0 -310 0.7199999999992628 1 0 -311 0.7299999999992892 1 0 -312 0.7399999999993154 1 0 -313 0.7499999999993417 1 0 -314 0.7599999999993681 1 0 -315 0.7699999999993945 1 0 -316 0.7799999999994207 1 0 -317 0.789999999999447 1 0 -318 0.7999999999994734 1 0 -319 0.8099999999994998 1 0 -320 0.8199999999995261 1 0 -321 0.8299999999995523 1 0 -322 0.8399999999995788 1 0 -323 0.8499999999996051 1 0 -324 0.8599999999996314 1 0 -325 0.8699999999996577 1 0 -326 0.8799999999996841 1 0 -327 0.8899999999997104 1 0 -328 0.8999999999997367 1 0 -329 0.9099999999997631 1 0 -330 0.9199999999997894 1 0 -331 0.9299999999998156 1 0 -332 0.939999999999842 1 0 -333 0.9499999999998684 1 0 -334 0.9599999999998947 1 0 -335 0.969999999999921 1 0 -336 0.9799999999999475 1 0 -337 0.9899999999999737 1 0 -338 0.5048683847089982 1.496966078704385 0 -339 0.7113755267421392 1.28439929627209 0 -340 0.2870897505559813 1.285911559479631 0 -341 0.4971637719999193 1.219543611537615 0 -342 0.8349999999995662 1.165012760259128 0 -343 0.16499999999966 1.16501276025838 0 -344 0.3051755485833004 1.141833156394544 0 -345 0.6978641611449509 1.141179812287203 0 -346 0.2541598676914442 1.537498841875233 0 -347 0.7516074000513059 1.530214991369846 0 -348 0.5749999999988812 1.121590436419565 0 -349 0.4249999999989025 1.120996334876456 0 -350 0.5886825120497132 1.742395246458429 0 -351 0.9049999999997509 1.095075210653423 0 -352 0.09499999999982227 1.095075210653024 0 -353 0.14379076891955 1.308427229581727 0 -354 0.8544707740310964 1.305664085757452 0 -355 0.2249252111609139 1.095412579796293 0 -356 0.7750747888379796 1.095412579796752 0 -357 0.4250637377962498 1.359847963402365 0 -358 0.5768274368598336 1.35129270071606 0 -359 0.232351283641529 1.768503569817728 0 -360 0.3802897055841284 1.226198321611149 0 -361 0.6192760303371638 1.22479805545081 0 -362 0.4025305533449121 1.669262073403616 0 -363 0.504999999998701 1.080842025111615 0 -364 0.3540355588524646 1.075474426616115 0 -365 0.644999999999064 1.079635838679168 0 -366 0.7990645241381551 1.730231666731534 0 -367 0.2316891351137946 1.404742804797436 0 -368 0.7694331512231478 1.402730452017867 0 -369 0.1545042280176006 1.063593299286463 0 -370 0.8454957719816769 1.063593299286772 0 -371 0.2849999999993101 1.065820086360372 0 -372 0.7149999999992496 1.065820086360718 0 -373 0.09377905012273467 1.225368003754102 0 -374 0.9062209498772704 1.225368003754103 0 -375 0.6373218323081091 1.468198342147499 0 -376 0.2437488911468461 1.206227823557092 0 -377 0.7563457096313686 1.204448828360671 0 -378 0.3742987035237452 1.48152301108111 0 -379 0.130120956628325 1.488144491727632 0 -380 0.8842018299350152 1.417708531946811 0 -381 0.4454026484076493 1.061978585006698 0 -382 0.1436146135644482 1.629187449451359 0 -383 0.5629536743808899 1.06080313266998 0 -384 0.9452464482995113 1.054556622190714 0 -385 0.05475355170023977 1.054556622190453 0 -386 0.5950547835237185 1.600890719371526 0 -387 0.8740072178815945 1.542984157925946 0 -388 0.5108757413372551 1.148615146531299 0 -389 0.4502909068163569 1.82938502013177 0 -390 0.320959186607418 1.382362774719732 0 -391 0.6740927104205064 1.374617160813473 0 -392 0.07186653785835088 1.159868242939921 0 -393 0.928133462141609 1.159868242940092 0 -394 0.4959118282364381 1.309385292052621 0 -395 0.3643843179845154 1.13888859794135 0 -396 0.394999999998989 1.049706683155523 0 -397 0.09900920945088526 1.394612170649323 0 -398 0.6342119551505342 1.139828098776277 0 -399 0.1761403003962369 1.239746873375074 0 -400 0.8274952264771659 1.237723114919311 0 -401 0.3119424735119836 1.211680323591548 0 -402 0.6870211765169325 1.211624423530248 0 -403 0.204572779491465 1.049475474480661 0 -404 0.7954272205075397 1.049475474480903 0 -405 0.5641251270693396 1.188701642478922 0 -406 0.6938995237861791 1.848342835421058 0 -407 0.55453485340953 1.256873385419238 0 -408 0.1048764334162882 1.047448610287509 0 -409 0.8951235665832384 1.047448610287716 0 -410 0.5026335410681588 1.395655529701533 0 -411 0.3643240580771657 1.304695217186724 0 -412 0.7096536221770959 1.648333690533706 0 -413 0.4363994351997544 1.18712353107406 0 -414 0.6368321661548365 1.299017190009066 0 -415 0.324999999999193 1.044874475977855 0 -416 0.6751442204991802 1.045403814441373 0 -417 0.6149999999989879 1.045311677015255 0 -418 0.2834057122870183 1.65669529178889 0 -419 0.4424341595009901 1.267051502655688 0 -420 0.2469301178973238 1.14826630595116 0 -421 0.7530698821014439 1.14826630595191 0 -422 0.07143472313351716 1.295821946784376 0 -423 0.9276346844210719 1.295049584115116 0 -424 0.2224279297201235 1.324104723781493 0 -425 0.8633971649281783 1.864639346706618 0 -426 0.1425930199360525 1.117439720643538 0 -427 0.8574069800633141 1.11743972064408 0 -428 0.4313365006717135 1.567463047102743 0 -429 0.7841807853234315 1.299559681794741 0 -430 0.4843312226870911 1.043718999612552 0 -431 0.8835672430108014 1.654316002243618 0 -432 0.2472488140342124 1.041119926334183 0 -433 0.7527511859645566 1.041119926334408 0 -434 0.0475989151197406 1.100213359190462 0 -435 0.9524010848800448 1.100213359190834 0 -436 0.5262244164522624 1.039972999530269 0 -437 0.1387448480122291 1.868075170033056 0 -438 0.8182179157022071 1.47531658027092 0 -439 0.1198586083418926 1.735554942864486 0 -440 0.5782092546423236 1.861628818245807 0 -441 0.3227958499757315 1.86550086858886 0 -442 0.2963443339199617 1.45414217456952 0 -443 0.4760358061261165 1.11884223216365 0 -444 0.3360668310449968 1.561700003484749 0 -445 0.5203473837657192 1.669521313702595 0 -446 0.6005435161090046 1.085506457923628 0 -447 0.4362003367629996 1.432232531259177 0 -448 0.1651436870037796 1.373609734503185 0 -449 0.8062768600613532 1.603678045390721 0 -450 0.5721601540390162 1.422483920265093 0 -451 0.2705835837177517 1.108619809700702 0 -452 0.7294164162809211 1.108619809701243 0 -453 0.929392206389964 1.365084835705914 0 -454 0.1864718869718126 1.126018362677127 0 -455 0.8135281130272991 1.126018362677697 0 -456 0.3344082486261599 1.748186264316926 0 -457 0.2329460877155683 1.261831202934324 0 -458 0.3127434919582956 1.098227407216015 0 -459 0.6871248470305197 1.098025283728294 0 -460 0.6666634367468084 1.548678585712974 0 -461 0.7059985982824595 1.443645413628561 0 -462 0.0880348923487676 1.564160737256966 0 -463 0.8962248988273027 1.756537303899436 0 -464 0.1174095429570162 1.156001542818463 0 -465 0.8825904570426577 1.156001542819261 0 -466 0.3945727958490747 1.090005009089835 0 -467 0.8324775331093248 1.372361299807416 0 -468 0.3614282206818003 1.03507407938755 0 -469 0.7403340088783437 1.342877523132671 0 -470 0.5428783977445191 1.096307691144361 0 -471 0.2059344475222542 1.476256816378896 0 -472 0.425738149301633 1.033524767413993 0 -473 0.9246321199467035 1.484420615646103 0 -474 0.1744882687329351 1.553141965653251 0 -475 0.1751514215878712 1.033583309557956 0 -476 0.8248485784112987 1.03358330955813 0 -477 0.6986772632360908 1.744352652800111 0 -478 0.1354786227014112 1.031764002975215 0 -479 0.8645213772979718 1.031764002975363 0 -480 0.515371287911105 1.575021930415143 0 -481 0.04985701529613179 1.20381835688959 0 -482 0.9501429847039704 1.203818356889792 0 -483 0.1356191196138404 1.203391819878145 0 -484 0.8644361939104058 1.203133908868517 0 -485 0.5771546382616788 1.524403817864126 0 -486 0.1902710231370598 1.082273511389928 0 -487 0.8097289768620298 1.082273511390346 0 -488 0.5844780350137612 1.031919667260371 0 -489 0.2949999999992809 1.03218665545763 0 -490 0.6447839974194614 1.032526177169373 0 -491 0.7049999999992214 1.032186655457807 0 -492 0.3386417500680102 1.257812188029089 0 -493 0.3549062890939554 1.18732522773497 0 -494 0.2097435177636035 1.174326610202922 0 -495 0.7902564822353856 1.174326610203758 0 -496 0.6459079348747186 1.186828513620802 0 -497 0.2797423306870386 1.180649839711299 0 -498 0.7212555455889628 1.179591474007765 0 -499 0.2739284282698835 1.343376949108817 0 -500 0.6619618549268813 1.25470389556274 0 -501 0.06974372727177681 1.455592152671457 0 -502 0.03216403228629063 1.032116530624794 0 -503 0.9678359677135613 1.032116530624944 0 -504 0.3828333561213982 1.405700943887016 0 -505 0.4048784758487263 1.158511166190438 0 -506 0.07499999999985285 1.030822819132027 0 -507 0.9249999999997995 1.030822819132173 0 -508 0.4714467339244875 1.164260216518812 0 -509 0.05638110927802219 1.348365021899717 0 -510 0.4553259913329818 1.030077482502192 0 -511 0.5958623226376665 1.157873110951488 0 -512 0.5547414348476822 1.029868773340605 0 -513 0.760452995118204 1.257428995447735 0 -514 0.1319722170854474 1.256878163711136 0 -515 0.8696324864519224 1.258573757825914 0 -516 0.4572442991479824 1.741561175628193 0 -517 0.04814828103691974 1.252553517768934 0 -518 0.9518517189628571 1.252553517769338 0 -519 0.1229207587044873 1.076365566024789 0 -520 0.8770792412949471 1.076365566025116 0 -521 0.203855458945367 1.688748245649081 0 -522 0.2239627504718836 1.609684914668316 0 -523 0.2763901191838297 1.239297140096479 0 -524 0.5862732550271118 1.299917186960195 0 -525 0.2533910647130193 1.076071473630957 0 -526 0.746608935285705 1.076071473631355 0 -527 0.03898608645145495 1.138715992232082 0 -528 0.9610139135485798 1.138715992232449 0 -529 0.4726850006227989 1.083854564865381 0 -530 0.1879677589347564 1.286596558441257 0 -531 0.6179323802290941 1.392486538899737 0 -532 0.5246136467267515 1.189403168958926 0 -533 0.438622568151799 1.505122055911884 0 -534 0.4164012791981738 1.311632414995821 0 -535 0.5138519793785878 1.113764797232734 0 -536 0.5505558842535986 1.152296101333632 0 -537 0.2286319907358996 1.867417555706223 0 -538 0.1453868199239883 1.431983459051211 0 -539 0.9467566053090382 1.421237450062602 0 -540 0.6319082750988454 1.671469534242648 0 -541 0.9268512964147272 1.59618598493076 0 -542 0.6836219048474306 1.325605431183472 0 -543 0.0752100818455609 1.12468940322967 0 -544 0.9247899181541184 1.124689403229922 0 -545 0.0769102984955212 1.67216964801866 0 -546 0.2266702183242972 1.027164454102343 0 -547 0.7733297816745925 1.027164454102493 0 -548 0.5094674813310797 1.264196899877203 0 -549 0.3460718419089456 1.112652257447309 0 -550 0.6539609433060007 1.112582868665854 0 -551 0.03095925860294166 1.075253881247921 0 -552 0.9690407413969335 1.075253881248284 0 -553 0.3723806536000443 1.354835804846698 0 -554 0.5273551167236247 1.790846882407766 0 -555 0.7225962044601031 1.23378066830778 0 -556 0.3950173176655707 1.26871462402894 0 -557 0.8828755332595645 1.351456441184084 0 -558 0.7653573584609243 1.464506585398373 0 -559 0.4535664057216711 1.225202082826928 0 -560 0.7808572111062158 1.813954609853594 0 -561 0.7736518006864613 1.908899104393791 0 -562 0.07958294756056862 1.066870977253348 0 -563 0.1081572010676713 1.343581737917401 0 -564 0.9204170524390723 1.066870977253651 0 -565 0.4272240465958173 1.08888385026421 0 -566 0.3180579033420357 1.319725536656434 0 -567 0.7883947112036476 1.349437668616844 0 -568 0.5256144948566308 1.350578018113227 0 -569 0.8140267334883057 1.536180092638261 0 -570 0.3168980447747105 1.501858811864778 0 -571 0.4738100646241676 1.353989244197258 0 -572 0.1817751161976196 1.199514735523571 0 -573 0.8191202158725644 1.199992414668096 0 -574 0.1094412303760258 1.123859586718336 0 -575 0.890558769623521 1.123859586718911 0 -576 0.6072316071079984 1.115182507181506 0 -577 0.5407759365081095 1.300398237819001 0 -578 0.2687145685562897 1.028267818260896 0 -579 0.7312854314423486 1.028267818261052 0 -580 0.3848499011084606 1.026220027758316 0 -581 0.09438381662255753 1.187827283366739 0 -582 0.9056161833777533 1.187827283366877 0 -583 0.5381752219618656 1.067269536279207 0 -584 0.4035860052508178 1.9085339591121 0 -585 0.4933266463598208 1.906876434721966 0 -586 0.5791726680740346 1.224396131825406 0 -587 0.2236307030788081 1.127656637560064 0 -588 0.776369296920125 1.127656637560704 0 -589 0.7240101678577586 1.39005283925881 0 -590 0.5071306834769315 1.02625513141825 0 -591 0.3193444349961477 1.175643043238262 0 -592 0.2788484115801563 1.39277161430332 0 -593 0.2291431614987724 1.063034403560922 0 -594 0.7708568385000947 1.063034403561262 0 -595 0.7004693288541993 1.501744798367538 0 -596 0.6808691982410278 1.175490553125656 0 -597 0.8187947105819663 1.419523644513117 0 -598 0.3453210823463811 1.634395215945646 0 -599 0.05572254946890599 1.510845131907316 0 -600 0.3962669583047747 1.123996924313109 0 -601 0.1610911214063988 1.094851142463035 0 -602 0.8389088785928496 1.094851142463484 0 -603 0.4655126411242813 1.6215263669657 0 -604 0.5984505789434684 1.26008984836154 0 -605 0.5276125684044863 1.45335230450441 0 -606 0.4012227660695611 1.192196291299601 0 -607 0.5732641923368413 1.090592014021488 0 -608 0.6017031352219305 1.192719313123014 0 -609 0.5915857119596174 1.05822828647841 0 -610 0.3131646032185611 1.070868119354563 0 -611 0.6868059079327227 1.070880372134253 0 -612 0.04687169832595089 1.398384554542657 0 -613 0.4373238795439551 1.150317819767526 0 -614 0.03245394526644756 1.174104559919675 0 -615 0.9675460547336536 1.174104559919884 0 -616 0.718550209908918 1.582842817849688 0 -617 0.8749173617249391 1.470681398428636 0 -618 0.8230523744243365 1.281352424224439 0 -619 0.07895518036043786 1.811813076251157 0 -620 0.2082028320168079 1.223734683991199 0 -621 0.7896444750335313 1.223404834676072 0 -622 0.6467635294185026 1.801653110195687 0 -623 0.6469062969066819 1.91420798254675 0 -624 0.104999999999807 1.023705229002148 0 -625 0.8949999999997217 1.023705229002247 0 -626 0.7711757512590844 1.66515641734804 0 -627 0.9548380205133138 1.331633358682849 0 -628 0.5299936044782878 1.225084057652564 0 -629 0.6574620269413445 1.42070492433435 0 -630 0.1981889624062577 1.024890894031797 0 -631 0.8018110375928029 1.024890894031918 0 -632 0.6209181603243408 1.346268299270745 0 -633 0.3391650416318992 1.024665133074319 0 -634 0.2844836266571301 1.589577585708552 0 -635 0.9415188663418799 1.538229576488797 0 -636 0.4192758564183099 1.057652982670849 0 -637 0.6517914139308951 1.608816183609679 0 -638 0.9423647441389441 1.705967568047342 0 -639 0.4555037721575113 1.304048527328971 0 -640 0.379452767186408 1.814361250475803 0 -641 0.3357722291285306 1.141650135089167 0 -642 0.4173464661051023 1.226707887981034 0 -643 0.9223024049908609 1.906069030610277 0 -644 0.6651635023958936 1.141772030982669 0 -645 0.4673525941927508 1.196043115007613 0 -646 0.9298954366245888 1.821874496146171 0 -647 0.1834429980742782 1.058380130575113 0 -648 0.8165570019248389 1.058380130575404 0 -649 0.3759462771784473 1.061302503952137 0 -650 0.1549999999996889 1.02221252282042 0 -651 0.8449999999995867 1.022212522820531 0 -652 0.2475564184779633 1.299889332127325 0 -653 0.2504710027680291 1.453151165689995 0 -654 0.2745060729982198 1.1382096137547 0 -655 0.7254939270004104 1.138209613755408 0 -656 0.6146826352280125 1.023768448068067 0 -657 0.3480876393771392 1.218320149655876 0 -658 0.3353900204201292 1.422177612590626 0 -659 0.164744018633862 1.79898400239591 0 -660 0.06136688115016602 1.616576484513275 0 -661 0.3151488066220225 1.022604313855231 0 -662 0.8180341197256054 1.317837195040082 0 -663 0.05081468179599744 1.02043497625855 0 -664 0.9491853182037735 1.020434976258642 0 -665 0.6535555701545785 1.219810214182851 0 -666 0.09621011880110795 1.263978198508291 0 -667 0.9086652393369654 1.262947028991559 0 -668 0.6846135277903629 1.020786696508784 0 -669 0.5614276279877052 1.475012107783639 0 -670 0.3859848290187913 1.543251293990811 0 -671 0.1801337726086816 1.336234406647904 0 -672 0.450690562024449 1.10375028210227 0 -673 0.6525579664355614 1.053661542809959 0 -674 0.4518420797877518 1.390859658623436 0 -675 0.863194229940893 1.602393221548905 0 -676 0.5072419189512092 1.055580801080491 0 -677 0.7996397202508009 1.258535168113664 0 -678 0.6208534869099951 1.070467992210701 0 -679 0.6214819367662816 1.093820312696573 0 -680 0.5504476470798463 1.384313375717408 0 -681 0.5385801555017435 1.123675515015415 0 -682 0.3461661413192844 1.056636093517496 0 -683 0.08312641484563575 1.918454894790681 0 -684 0.5736752371555937 1.656200270238859 0 -685 0.4749529830694161 1.535501085771155 0 -686 0.474999999998756 1.02119976559362 0 -687 0.06116647035632453 1.080027491555228 0 -688 0.9388335296434021 1.080027491555599 0 -689 0.2902609242367211 1.092466405302242 0 -690 0.7097390757618164 1.092466405302733 0 -691 0.1921143744799669 1.439214249394353 0 -692 0.3688173944349879 1.101172545697751 0 -693 0.4708959074629217 1.255796333059937 0 -694 0.2104642353092421 1.366605532913096 0 -695 0.4956770080563517 1.176708192573298 0 -696 0.03544579990692806 1.31261815245473 0 -697 0.2906181420916345 1.800169314422933 0 -698 0.1826874667777417 1.923689544068806 0 -699 0.2788079446919697 1.723487117810183 0 -700 0.8954983700176242 1.316352287984157 0 -701 0.4065983848656299 1.021686330095798 0 -702 0.7469595602463371 1.307263741791362 0 -703 0.5350061574492293 1.019802261500719 0 -704 0.2732209111343161 1.923784880056412 0 -705 0.1642993460496607 1.139158603729777 0 -706 0.8357006539495735 1.139158603730439 0 -707 0.2450618270813173 1.020151332089083 0 -708 0.7549381729174609 1.020151332089197 0 -709 0.6778664241681795 1.288727433175952 0 -710 0.02321986608265446 1.053552581468502 0 -711 0.9767801339172393 1.053552581468754 0 -712 0.6637800237508615 1.019673250132107 0 -713 0.9648920616781493 1.285360057838596 0 -714 0.4700428252082163 1.061348707599324 0 -715 0.6959664684676375 1.25596411311435 0 -716 0.274336154868959 1.486857053664732 0 -717 0.859555809988204 1.70710620490268 0 -718 0.3948773504896747 1.729793310929485 0 -719 0.375459424328313 1.166833218046657 0 -720 0.6259729348091094 1.517232753959606 0 -721 0.1051207993864324 1.293982979665758 0 -722 0.1489963915488253 1.685718413104741 0 -723 0.12197099217751 1.102971434274687 0 -724 0.8780290078219228 1.102971434275165 0 -725 0.6224034537111914 1.168741878062297 0 -726 0.4782346811296834 1.457195269046559 0 -727 0.1916588275864359 1.153305401110045 0 -728 0.808341172412639 1.15330540111074 0 -729 0.8290715396551643 1.659912084697822 0 -730 0.2695777097337912 1.04623887496122 0 -731 0.7304222902648487 1.04623887496146 0 -732 0.3832988932168223 1.594890512279816 0 -733 0.23940255049482 1.176184851616829 0 -734 0.7605974495040165 1.17618485161771 0 -735 0.2997606355031102 1.114700265991839 0 -736 0.7002458984271072 1.114693200965817 0 -737 0.1350437084035231 1.054480564031925 0 -738 0.8649562915958616 1.054480564032177 0 -739 0.1535489845508016 1.042207986976496 0 -740 0.8464510154484944 1.042207986976704 0 -741 0.30901978967761 1.243605663149359 0 -742 0.3253416060451962 1.690207729830557 0 -743 0.5346068490343162 1.727438836572012 0 -744 0.02573684457220856 1.114825325769857 0 -745 0.9742631554277377 1.114825325770101 0 -746 0.8344175404560306 1.774396056578362 0 -747 0.1295299807760892 1.535211494863679 0 -748 0.9447800288308483 1.650953644708485 0 -749 0.0528581554567815 1.72193971791524 0 -750 0.0920474170988192 1.145470529203618 0 -751 0.9079525829010122 1.145470529204047 0 -752 0.2423443279418369 1.111699486614291 0 -753 0.7576556720569906 1.111699486614849 0 -754 0.6176178344116282 1.426428827483588 0 -755 0.4909462759205802 1.099217897989591 0 -756 0.2025650979701836 1.100066226241647 0 -757 0.7974349020288216 1.100066226242132 0 -758 0.2847081921562871 1.21287736086785 0 -759 0.8582753181417773 1.931742848137956 0 -760 0.07350146430712444 1.098180701794621 0 -761 0.9264985356925344 1.098180701795035 0 -762 0.2504804308953618 1.366429950529226 0 -763 0.1758405404669717 1.737825380517377 0 -764 0.4492771293794934 1.129927817775632 0 -765 0.3199551262486476 1.280932793007847 0 -766 0.6306615739083007 1.268997354379919 0 -767 0.1695619102620896 1.507805457993693 0 -768 0.206817653132825 1.068672067828947 0 -769 0.7931823468661675 1.068672067829293 0 -770 0.1388865773955359 1.141595002649761 0 -771 0.8611134226038619 1.141595002650475 0 -772 0.7264377386871367 1.698569524523234 0 -773 0.1462190433959284 1.23264913638115 0 -774 0.8539250492147981 1.232272956556789 0 -775 0.5327335382141311 1.53149462873611 0 -776 0.3312608165783479 1.080865103700489 0 -777 0.6709377155380395 1.081180031413402 0 -778 0.1038223262446245 1.434252626593483 0 -779 0.3957141263811421 1.446312390112534 0 -780 0.5423518164594813 1.045766800746079 0 -781 0.7656825601534485 1.576956265475083 0 -782 0.457771578467531 1.673756860525292 0 -783 0.1386052984819073 1.177774628988324 0 -784 0.8613947015174809 1.177774628989154 0 -785 0.03064047675698196 1.228422238228792 0 -786 0.9692984182498403 1.228560049614654 0 -787 0.3052929899393282 1.049468038574465 0 -788 0.6946611523550207 1.049539835347877 0 -789 0.9594770046973375 1.458433612853462 0 -790 0.1621524829917373 1.265857814480317 0 -791 0.9601012575361855 1.386569755895768 0 -792 0.2469316846177428 1.237495906239972 0 -793 0.4874058124764199 1.141762884680299 0 -794 0.4381852144054595 1.017579803230586 0 -795 0.7038379148887731 1.356190112030703 0 -796 0.1643546501515032 1.465369649396486 0 -797 0.3209782524407079 1.122529743021743 0 -798 0.03140041854011572 1.280975321460325 0 -799 0.6796548079837164 1.122455612933911 0 -800 0.8479028893300604 1.508397242784909 0 -801 0.781461123383506 1.500275373296001 0 -802 0.4017251044733837 1.069185231670215 0 -803 0.3639894499329577 1.0175308856422 0 -804 0.2110236677891623 1.52267675785457 0 -805 0.3352150220181531 1.932190367522508 0 -806 0.2215733283575031 1.151701975123256 0 -807 0.7784266716413957 1.151701975124007 0 -808 0.01732335881401268 1.017288754910273 0 -809 0.9826766411859112 1.017288754910306 0 -810 0.584113732952564 1.93468825658745 0 -811 0.1451124223790181 1.34394987548412 0 -812 0.5732117507522227 1.017266357000999 0 -813 0.1320485497884978 1.581379616183636 0 -814 0.7142250957385593 1.93436460746508 0 -815 0.1397577237023708 1.091389127401331 0 -816 0.86024227629698 1.091389127401738 0 -817 0.5477097286139612 1.613511529721244 0 -818 0.8964405404792415 1.384421660303715 0 -819 0.7592515402809309 1.766580445021483 0 -820 0.1027690986309362 1.06762285053724 0 -821 0.8972309013685922 1.067622850537532 0 -822 0.3379618690102277 1.460519758985365 0 -823 0.1230826102563555 1.01854899165203 0 -824 0.8769173897430907 1.018548991652111 0 -825 0.6184121476452416 1.561174626292751 0 -826 0.8475726314166462 1.33967925933898 0 -827 0.3686254642033712 1.251233838531329 0 -828 0.1266919706459415 1.375311365833281 0 -829 0.06703733796428706 1.230791447389639 0 -830 0.9329626620356544 1.230791447389813 0 -831 0.8873821998342596 1.285140734274467 0 -832 0.6492956341968291 1.724042238840412 0 -833 0.2634519459183526 1.265702117636851 0 -834 0.7149503558518808 1.317866633526652 0 -835 0.5648971388353405 1.56484162942942 0 -836 0.4920220431073269 1.066416542844554 0 -837 0.518743848235153 1.845046013291716 0 -838 0.4182798098737909 1.398915959212635 0 -839 0.7135276344933216 1.20471154674194 0 -840 0.08511963209959281 1.048630554699387 0 -841 0.9148803679000121 1.048630554699599 0 -842 0.598838162057048 1.016857355008949 0 -843 0.3518912447391224 1.158855316424406 0 -844 0.632848718998555 1.018019237482506 0 -845 0.6483547785703244 1.158869785269719 0 -846 0.5737288210390995 1.144659941374075 0 -847 0.02101200697820348 1.094540536350213 0 -848 0.9789879930218649 1.09454053635045 0 -849 0.2029274742840555 1.251949239728037 0 -850 0.3760438501018435 1.081615701034624 0 -851 0.914322897332451 1.444424363886258 0 -852 0.06805100739912706 1.186189790708724 0 -853 0.9319489926010983 1.186189790708768 0 -854 0.5855332095051125 1.794305260711012 0 -855 0.6343591332954933 1.048712883120502 0 -856 0.2849999999993101 1.017258406842087 0 -857 0.7149999999992493 1.017258406842185 0 -858 0.7383434752987191 1.424839730307673 0 -859 0.6752192673054986 1.470065968157034 0 -860 0.08779985109549458 1.017990595009571 0 -861 0.9122001489041109 1.017990595009649 0 -862 0.6528235302694242 1.344019306307661 0 -863 0.1779401265167148 1.599949870808794 0 -864 0.5546530607412045 1.211785712977279 0 -865 0.8513820751604271 1.406981107082139 0 -866 0.04382015169950791 1.551087075978233 0 -867 0.2181650277570157 1.29378777502682 0 -868 0.7974166745205853 1.378995107201303 0 -869 0.07988593648935285 1.323748565666345 0 -870 0.7524694856701515 1.620488599703033 0 -871 0.2962581360430431 1.547569635686735 0 -872 0.4498213345046592 1.082629396880051 0 -873 0.5196297092657058 1.093376025421895 0 -874 0.4419498980022703 1.043150271056709 0 -875 0.568994607856848 1.042535902853124 0 -876 0.3469588125728622 1.331561977430853 0 -877 0.5876260298347696 1.104478412772627 0 -878 0.6878392734148544 1.410049720542555 0 -879 0.5542603151278055 1.078691599257077 0 -880 0.03575722722513339 1.432550694825774 0 -881 0.4467439492385682 1.337612930504251 0 -882 0.5303350227773364 1.166447905910315 0 -883 0.6308753008142262 1.117392401627417 0 -884 0.9232142663124301 1.330128687280605 0 -885 0.05933028558700117 1.864080619328858 0 -886 0.08881770639590164 1.488004959293343 0 -887 0.3882498810844109 1.32456290900526 0 -888 0.8511990058120416 1.441908160647442 0 -889 0.9605570188934992 1.500063951422074 0 -890 0.1822317739143025 1.017639627022243 0 -891 0.8177682260848371 1.017639627022332 0 -892 0.9498142671274913 1.766645879759187 0 -893 0.1207035052929326 1.227768548161322 0 -894 0.8789687249328717 1.224221887760149 0 -895 0.4787621746340503 1.284659820698208 0 -896 0.6006810476486413 1.490735659225033 0 -897 0.3784552070524573 1.044138450055919 0 -898 0.218210089388379 1.566507426468412 0 -899 0.6790669877403435 1.685472310170668 0 -900 0.7391730172755183 1.492899891210004 0 -901 0.02334128481750834 1.201376189411586 0 -902 0.976658715182473 1.201376189411772 0 -903 0.4743238962420662 1.421210505449406 0 -904 0.1821973871908495 1.100805185223681 0 -905 0.8178026128082696 1.100805185224179 0 -906 0.4123510836380153 1.103987037352426 0 -907 0.7645780670357591 1.369536194853452 0 -908 0.8911502033818453 1.507417584351576 0 -909 0.7109396949484268 1.542688014463661 0 -910 0.5652829731956515 1.32051839191376 0 -911 0.05366620553673269 1.121810002453433 0 -912 0.9463337944630141 1.121810002453881 0 -913 0.421846259883653 1.780271626685188 0 -914 0.7282050099572057 1.259413370524345 0 -915 0.2214162017745438 1.197461024401772 0 -916 0.7809827444424337 1.199195793668273 0 -917 0.3750142522908606 1.199544322151415 0 -918 0.1845971709676333 1.177493123268267 0 -919 0.8154028290314971 1.17749312326909 0 -920 0.6333763331752649 1.857707707142758 0 -921 0.1915540986612671 1.398402789430784 0 -922 0.4225921849734932 1.624419298665114 0 -923 0.03387348846111227 1.015899485282361 0 -924 0.9661265115387395 1.01589948528242 0 -925 0.2231574639843962 1.045758009434277 0 -926 0.776842536014497 1.045758009434528 0 -927 0.2725398215141116 1.081257498476481 0 -928 0.7274601784845115 1.081257498476921 0 -929 0.287696081212362 1.156423926965742 0 -930 0.7108249566319291 1.158764699719963 0 -931 0.5916223512374552 1.133720606337292 0 -932 0.2350442647952174 1.652908866044909 0 -933 0.5855938306501858 1.380325120392519 0 -934 0.4715681724035449 1.581028291492537 0 -935 0.8418141408456581 1.259485989507131 0 -936 0.7643817999237927 1.231469244239164 0 -937 0.669995403316218 1.062889432440023 0 -938 0.1595310920820351 1.1885728417315 0 -939 0.8404689079172745 1.188572841732376 0 -940 0.625094108830086 1.199782092796714 0 -941 0.2717971273760793 1.314405739853056 0 -942 0.1871682298225736 1.645354373732688 0 -943 0.1173818456212346 1.034334607369009 0 -944 0.8826181543782377 1.034334607369173 0 -945 0.03189877589768881 1.371201856949706 0 -946 0.03770714788182898 1.477552960024035 0 -947 0.3072870723780685 1.349554356499209 0 -948 0.5608941264376373 1.108136705438094 0 -949 0.6127843368407898 1.314293660968488 0 -950 0.1669286053797976 1.116491127132817 0 -951 0.8330713946194106 1.116491127133367 0 -952 0.841011785908762 1.56825334772903 0 -953 0.1390729585363194 1.015384365982212 0 -954 0.8609270414630409 1.015384365982283 0 -955 0.408610396098658 1.136637931759814 0 -956 0.2727474957353982 1.427683775905435 0 -957 0.4222229175893341 1.016357806279581 0 -958 0.4671424346748636 1.042922357705219 0 -959 0.2126965781286911 1.016632798978344 0 -960 0.7873034218702811 1.016632798978436 0 -961 0.3558393601930892 1.386767720482331 0 -962 0.3005643706533258 1.19031282187702 0 -963 0.8773524753151363 1.812451963402752 0 -964 0.1715393775150516 1.07516201995467 0 -965 0.8284606224841315 1.07516201995504 0 -966 0.7848484138806036 1.434094363967352 0 -967 0.4896467260301543 1.016490847720485 0 -968 0.4090374695796062 1.039661421460267 0 -969 0.04785293513927573 1.039160660371534 0 -970 0.9521470648605014 1.039160660371717 0 -971 0.5192042285394238 1.01639104763949 0 -972 0.7107068551454572 1.796180889260681 0 -973 0.1162135326283688 1.181877349784169 0 -974 0.8837864673713693 1.18187734978523 0 -975 0.2499651433316649 1.329733935364252 0 -976 0.101530015081079 1.611563645251985 0 -977 0.3879863847654005 1.144518011207138 0 -978 0.2876017521159563 1.048751556567512 0 -979 0.7123982478825878 1.048751556567772 0 -980 0.6748264625287863 1.235425032416492 0 -981 0.30128234277826 1.01662504845527 0 -982 0.7676963624331639 1.328675880426054 0 -983 0.3293061123404644 1.062557840500174 0 -984 0.3319474162443696 1.195782095947593 0 -985 0.6676191774403487 1.196414102658601 0 -986 0.01603076109681405 1.037232906096547 0 -987 0.9839692389031077 1.037232906096625 0 -988 0.0237728167223666 1.155397808673102 0 -989 0.9762271832776999 1.15539780867335 0 -990 0.5796953554051784 1.072633604815174 0 -991 0.6023934233408159 1.033792643958504 0 -992 0.2636670648221204 1.162890432890539 0 -993 0.7363329351765793 1.162890432891376 0 -994 0.6393174594094391 1.242479804508066 0 -995 0.2577196191555046 1.125801657172263 0 -996 0.7422803808432327 1.125801657172915 0 -997 0.06925318001422347 1.015416076919484 0 -998 0.9307468199854646 1.015416076919555 0 -999 0.9693398153186322 1.357454839924715 0 -1000 0.4164151595852283 1.253874359707409 0 -1001 0.4278048029939758 1.468498876034178 0 -1002 0.3591906099290338 1.278158869810226 0 -1003 0.530204894573735 1.412213562155625 0 -1004 0.1906068062079785 1.039816657255773 0 -1005 0.8093931937911105 1.039816657255976 0 -1006 0.6614890112017699 1.503569819347941 0 -1007 0.08728436784372604 1.365199104903088 0 -1008 0.6285051988883447 1.034436664346815 0 -1009 0.6127499493739298 1.144056294141511 0 -1010 0.5630892057169667 1.283066295016315 0 -1011 0.420061208438303 1.282443376695496 0 -1012 0.6486233908940694 1.015782496410471 0 -1013 0.2392160293569889 1.496598062407582 0 -1014 0.7636850866090904 1.284514689735623 0 -1015 0.09280397515413977 1.11444210765936 0 -1016 0.9071960248453916 1.114442107659803 0 -1017 0.3908298290229613 1.296473534928996 0 -1018 0.3570969256837546 1.513787243780693 0 -1019 0.4937145947038362 1.119776222429542 0 -1020 0.3011417699143227 1.417335682079365 0 -1021 0.535852822695271 1.274640122608464 0 -1022 0.6994729783965448 1.187941200321058 0 -1023 0.6992454682576172 1.016634976191159 0 -1024 0.7543715370226114 1.859974057558124 0 -1025 0.52213598020332 1.32102277528815 0 -1026 0.4984882904558169 1.338154690025477 0 -1027 0.453042611509742 1.941634900706103 0 -1028 0.5317434507261012 1.14349089166425 0 -1029 0.07576651641425737 1.417638095801315 0 -1030 0.9610217559471596 1.574479236630343 0 -1031 0.1604917762563934 1.213202960246828 0 -1032 0.8393358742972696 1.213012715060642 0 -1033 0.2533043276454702 1.095272315543577 0 -1034 0.7466956723533112 1.095272315544064 0 -1035 0.2051791141809452 1.137452636653062 0 -1036 0.7948208858180859 1.137452636653693 0 -1037 0.4764212749072455 1.788568293079991 0 -1038 0.5183443969227232 1.068965302220556 0 -1039 0.2588864111108916 1.189057439459088 0 -1040 0.7411135888878539 1.189057439460056 0 -1041 0.6092676172239896 1.285168890166481 0 -1042 0.6605249056169841 1.037289440931298 0 -1043 0.08002756883388029 1.206142615735062 0 -1044 0.9199724311664677 1.206142615735259 0 -1045 0.09255756052184733 1.033764991064498 0 -1046 0.9074424394777344 1.033764991064648 0 -1047 0.2554401950341439 1.058463570059767 0 -1048 0.744559804964575 1.058463570060075 0 -1049 0.9092071797876939 1.560598448136613 0 -1050 0.1311875568177489 1.944127962111655 0 -1051 0.4552236224512686 1.014850753853796 0 -1052 0.0292818724631451 1.342011367700425 0 -1053 0.3729537025080666 1.121835884452202 0 -1054 0.4240391690753835 1.169071485835996 0 -1055 0.4908120604233604 1.709691052377504 0 -1056 0.0950333449551794 1.168642583115016 0 -1057 0.9049666550448063 1.168642583115446 0 -1058 0.2160518152260851 1.814661904713744 0 -1059 0.55567518745793 1.014397568857115 0 -1060 0.344624197812278 1.040238710609723 0 -1061 0.04697726977973533 1.157456826726417 0 -1062 0.5101785563923218 1.239416087560102 0 -1063 0.9530227302203623 1.157456826726629 0 -1064 0.5774768754272473 1.16841610755576 0 -1065 0.4496231757060124 1.17040906319534 0 -1066 0.1104091998713541 1.205009845943742 0 -1067 0.8895908001287585 1.205009845944253 0 -1068 0.4699642066362467 1.491426532187457 0 -1069 0.4069941249805112 1.852659895008483 0 -1070 0.4351062845121629 1.21024686095713 0 -1071 0.8078474282445104 1.86196677252668 0 -1072 0.3962311796043581 1.373538074038283 0 -1073 0.6426834915883372 1.373191361642871 0 -1074 0.3206507348510015 1.603280990226957 0 -1075 0.589945325313159 1.456824413013083 0 -1076 0.9751811035022794 1.259113773789341 0 -1077 0.1176502788948742 1.059261450855904 0 -1078 0.882349721104576 1.059261450856158 0 -1079 0.08960154393460185 1.5247868019029 0 -1080 0.3617487314489472 1.43706916597798 0 -1081 0.01672564688097562 1.134098993152536 0 -1082 0.9832743531190394 1.134098993152721 0 -1083 0.1964018427018784 1.310704454554017 0 -1084 0.03864703065873284 1.059921518824767 0 -1085 0.9613529693410905 1.059921518825047 0 -1086 0.4534559287543344 1.884793343662517 0 -1087 0.04698705756953726 1.778070073464848 0 -1088 0.06237605580063066 1.141360655307879 0 -1089 0.9376239441990379 1.141360655308076 0 -1090 0.06891141872568582 1.04683203206937 0 -1091 0.9310885812739933 1.04683203206959 0 -1092 0.4736314826835565 1.32540770122966 0 -1093 0.06703082981185354 1.27105185563872 0 -1094 0.9327811214695709 1.269073793312503 0 -1095 0.6021373889833467 1.699828213200178 0 -1096 0.5584707826822748 1.132469266243076 0 -1097 0.863488528217939 1.378352110216156 0 -1098 0.2902117698043898 1.26033299790055 0 -1099 0.5011931542425805 1.040130698839658 0 -1100 0.2365098776918482 1.080115166220042 0 -1101 0.7634901223069654 1.080115166220452 0 -1102 0.04440309113455441 1.656832720451006 0 -1103 0.9264789138049752 1.394642416693109 0 -1104 0.2591182893134713 1.015108001587667 0 -1105 0.7408817106852218 1.015108001587754 0 -1106 0.6532594277221753 1.278453077011473 0 -1107 0.7006787139208592 1.230088738061946 0 -1108 0.4307488462440198 1.071913306297576 0 -1109 0.5038756623246924 1.199140274258191 0 -1110 0.5144832785213653 1.288881941804271 0 -1111 0.8570624818758337 1.280462041411847 0 -1112 0.2622766136635372 1.219335751676736 0 -1113 0.5059361000286065 1.616606751512862 0 -1114 0.02435229388447152 1.260437274686242 0 -1115 0.1514987515658174 1.399072558371672 0 -1116 0.6435069330559549 1.09827329187248 0 -1117 0.4013790429946008 1.50429808815484 0 -1118 0.5448537626758532 1.182577725348483 0 -1119 0.3502748759863072 1.014715868918223 0 -1120 0.2271625550769119 1.723464227730544 0 -1121 0.1680780570161887 1.014768798196081 0 -1122 0.8319219429830211 1.014768798196153 0 -1123 0.01612157377241585 1.068583287858511 0 -1124 0.9838784262275513 1.068583287858851 0 -1125 0.2107888131967949 1.03422457922024 0 -1126 0.7892111868021889 1.034224579220399 0 -1127 0.170077575570412 1.306890007245519 0 -1128 0.96446725914928 1.61489265528045 0 -1129 0.6171282442080105 1.633952939785105 0 -1130 0.1392455552605454 1.072264392394617 0 -1131 0.860754444738809 1.072264392394939 0 -1132 0.4673730393193751 1.141346674094104 0 -1133 0.08037730913511788 1.08525360001454 0 -1134 0.9196226908645516 1.085253600014918 0 -1135 0.5392374691044528 1.499917124911838 0 -1136 0.500507661967947 1.366415948825976 0 -1137 0.1310993912053274 1.284183979150925 0 -1138 0.6081506402700735 1.0603398946826 0 -1139 0.3450952957259867 1.094396680620111 0 -1140 0.2632140217185417 1.622803503307088 0 -1141 0.3206098558574353 1.156322140155059 0 -1142 0.6795105079739993 1.154868186584574 0 -1143 0.8164463568610144 1.349341624818541 0 -1144 0.5816697939685267 1.202504989059667 0 -1145 0.1070712199643722 1.244307087377708 0 -1146 0.8946770858769926 1.244995448867616 0 -1147 0.1188463134212067 1.789037814288943 0 -1148 0.9752126980741912 1.312250835241471 0 -1149 0.3279377418496755 1.014324132417214 0 -1150 0.118332750746222 1.322568619377422 0 -1151 0.1142640479385176 1.655496233638815 0 -1152 0.3940631572554494 1.014085361485176 0 -1153 0.6362795954503547 1.064890646902633 0 -1154 0.5781750259494849 1.248757073254238 0 -1155 0.6899237412610107 1.037639851017039 0 -1156 0.9692231032428993 1.418428702300109 0 -1157 0.2304244292351013 1.01636421293752 0 -1158 0.7695755707637636 1.01636421293761 0 -1159 0.1689714021005658 1.047917782443216 0 -1160 0.8310285978986405 1.047917782443464 0 -1161 0.2767735740689962 1.850697146275869 0 -1162 0.6662215974524117 1.307727800873085 0 -1163 0.5989350359323878 1.236912426522421 0 -1164 0.6676365819098316 1.102130322639346 0 -1165 0.6798484832125943 1.583346017391035 0 -1166 0.9547485371468434 1.871469203552564 0 -1167 0.2970493465702064 1.081238828120493 0 -1168 0.7029506534282867 1.081238828120929 0 -1169 0.4225415884448154 1.534920512767768 0 -1170 0.2227219391655229 1.436259376331281 0 -1171 0.3725541286571634 1.705262112799084 0 -1172 0.03446271388088232 1.588527085831263 0 -1173 0.3951821133074684 1.245125964478851 0 -1174 0.7350046788939972 1.21459751859619 0 -1175 0.4366236914300083 1.241875069126993 0 -1176 0.3336053944597156 1.307315401918199 0 -1177 0.3101880276316399 1.037617782732386 0 -1178 0.3366855792099399 1.795581428929004 0 -1179 0.1084216317660207 1.084916405064285 0 -1180 0.8915783682334816 1.084916405064652 0 -1181 0.4343910849675152 1.69991290490074 0 -1182 0.4759932499312994 1.232707875168285 0 -1183 0.4119728001697494 1.082816303704818 0 -1184 0.5581381923059603 1.233668049754009 0 -1185 0.1827695075909666 1.855632524965281 0 -1186 0.4115711164955508 1.339620902518397 0 -1187 0.8997870444010682 1.622090952459767 0 -1188 0.1298202732700994 1.452968090907417 0 -1189 0.5303625628932096 1.250765945842498 0 -1190 0.3262307633193099 1.229225940268823 0 -1191 0.4686630715451836 1.101432200957633 0 -1192 0.4781386790132462 1.381890160445526 0 -1193 0.8025475828857709 1.571731018726347 0 -1194 0.5982484843677046 1.214893986131703 0 -1195 0.5071280938487064 1.134522290227878 0 -1196 0.9521967649206859 1.945125779974887 0 -1197 0.208946054927438 1.087734952362177 0 -1198 0.7910539450715237 1.0877349523626 0 -1199 0.5454445087416474 1.693807004503302 0 -1200 0.04425590105703177 1.087112571068343 0 -1201 0.9557440989427626 1.08711257106872 0 -1202 0.4348713832640062 1.105130020306964 0 -1203 0.1212387324129834 1.410725387443975 0 -1204 0.8748081708171568 1.332494210010687 0 -1205 0.531701500824432 1.949440570608314 0 -1206 0.1905644263512034 1.220225003028779 0 -1207 0.8114543953925862 1.221038415210947 0 -1208 0.5838233149909822 1.01346723817484 0 -1209 0.8948030020751232 1.697460265348612 0 -1210 0.3854086562146177 1.062799568064158 0 -1211 0.1058513327249278 1.703989972331406 0 -1212 0.2378974128992069 1.129832306194317 0 -1213 0.7621025870996405 1.129832306194978 0 -1214 0.3508166508861011 1.130810142089118 0 -1215 0.223501475636426 1.241876441706235 0 -1216 0.03990967374134053 1.694053066877621 0 -1217 0.1285763858643799 1.129429057654668 0 -1218 0.8714236141350802 1.129429057655287 0 -1219 0.6470098631159311 1.131224790135127 0 -1220 0.3869221786982499 1.107016953422077 0 -1221 0.5338857487059122 1.107989197217155 0 -1222 0.594259816424455 1.412340834705424 0 -1223 0.08097562939594526 1.244007189079537 0 -1224 0.9203040709736917 1.242973931036239 0 -1225 0.7312975847315546 1.466502539877618 0 -1226 0.3768371532388788 1.771926153656685 0 -1227 0.3851744991021436 1.63534160915883 0 -1228 0.6672818104517914 1.646693033572066 0 -1229 0.06844028229426127 1.065025969133274 0 -1230 0.9315597177054284 1.065025969133579 0 -1231 0.2976136708814533 1.225253262659552 0 -1232 0.2324365785646558 1.956645751796542 0 -1233 0.8076261185975664 1.949514482014995 0 -1234 0.5272970932159979 1.054967731944338 0 -1235 0.7398596297786042 1.281761775878691 0 -1236 0.6749558891658085 1.013560677437725 0 -1237 0.6088770878552974 1.102815819193598 0 -1238 0.5475695392382699 1.345764172627341 0 -1239 0.3315603475102415 1.104054958468724 0 -1240 0.2576233010837896 1.68680344282223 0 -1241 0.1974623474063127 1.195582362239602 0 -1242 0.8026290130081681 1.195631105010289 0 -1243 0.4485117697187572 1.370204681587779 0 -1244 0.3974036243935294 1.17528784972531 0 -1245 0.6180052055277383 1.248862935485071 0 -1246 0.3781005450341657 1.013278222746576 0 -1247 0.8932980850819866 1.94991634803484 0 -1248 0.2551066866345831 1.030786767446896 0 -1249 0.7448933133641282 1.030786767447065 0 -1250 0.2950093327238816 1.763759658062241 0 -1251 0.9077064765402743 1.354067237478569 0 -1252 0.4864383754210707 1.08646762422074 0 -1253 0.2811006527517921 1.034299794402836 0 -1254 0.7189062356839639 1.034315781362493 0 -1255 0.5325855615335903 1.083191867795916 0 -1256 0.5968207119303641 1.359082961686952 0 -1257 0.5855577491076152 1.327815823573339 0 -1258 0.4920234116599588 1.157294782650777 0 -1259 0.7968434960206228 1.77173407237564 0 -1260 0.2697006728666986 1.064555284921215 0 -1261 0.7302993271319501 1.064555284921558 0 -1262 0.2638894904382683 1.579297994558265 0 -1263 0.285125205610623 1.367059530435991 0 -1264 0.8080681840712355 1.686980391860552 0 -1265 0.1988360824370556 1.346371187157398 0 -1266 0.2210868364101463 1.107660533742082 0 -1267 0.7789131635887757 1.107660533742606 0 -1268 0.3477480826867645 1.358460883125359 0 -1269 0.5441630848075065 1.034228557501702 0 -1270 0.2957062757016458 1.301996665259004 0 -1271 0.2373735526417196 1.033470287641567 0 -1272 0.7626264473571078 1.033470287641752 0 -1273 0.7432849730992642 1.238466666660619 0 -1274 0.7655354323486602 1.705088640507602 0 -1275 0.3104792744560319 1.481964609942909 0 -1276 0.552275115096119 1.448808372931466 0 -1277 0.5414872493534836 1.900237630178375 0 -1278 0.561876305326539 1.763381288632418 0 -1279 0.6745564396241781 1.03143545053497 0 -1280 0.5296842038708257 1.380796159560034 0 -1281 0.7811289864350623 1.543394073796156 0 -1282 0.5514227985736257 1.830867943066162 0 -1283 0.499092151846725 1.751543856082354 0 -1284 0.698926949137658 1.304106306903707 0 -1285 0.4540711508408158 1.049815452939203 0 -1286 0.1824119709117939 1.260697355657497 0 -1287 0.1964425640817918 1.060976065928913 0 -1288 0.803557435917259 1.060976065929218 0 -1289 0.9462244609740303 1.303789785276324 0 -1290 0.6424553026566601 1.328161558121473 0 -1291 0.6064799172631002 1.176318138502318 0 -1292 0.7980359198812659 1.281264115151046 0 -1293 0.4019039525756251 1.215844002663783 0 -1294 0.799990899530184 1.324653649285214 0 -1295 0.3018041839316535 1.1703078363915 0 -1296 0.2749849291949251 1.014037084654936 0 -1297 0.7250150708036864 1.014037084655016 0 -1298 0.9205823767806327 1.513861697064001 0 -1299 0.03558660959702013 1.045698919450772 0 -1300 0.9644133904028299 1.045698919450992 0 -1301 0.1538317161502786 1.082755103213785 0 -1302 0.8461682838489977 1.082755103214174 0 -1303 0.3416340672056184 1.072936402756499 0 -1304 0.5570794333549717 1.167023806777678 0 -1305 0.8111935379353494 1.505449894896943 0 -1306 0.3368801009114792 1.173285988831283 0 -1307 0.8159573031906487 1.260186624811216 0 -1308 0.3664748224067241 1.879783841642942 0 -1309 0.6632549853008139 1.173048695517503 0 -1310 0.5809876230090266 1.045135940485993 0 -1311 0.3835712702538189 1.953552580776986 0 -1312 0.2266364801947291 1.354192187973581 0 -1313 0.2788015096627693 1.117916702394729 0 -1314 0.721198490335866 1.117916702395343 0 -1315 0.5208465880537497 1.212421849634813 0 -1316 0.837463829767092 1.626479860315993 0 -1317 0.5493451930918662 1.062889936150788 0 -1318 0.06232682554474273 1.033603828122874 0 -1319 0.9376731744549724 1.033603828123033 0 -1320 0.8303159237440187 1.823404142090441 0 -1321 0.6290557105190713 1.756878716622504 0 -1322 0.1954167111353211 1.010625940397088 0 -1323 0.8045832888637392 1.01062594039714 0 -1324 0.2055804492321563 1.119950622236444 0 -1325 0.7944195507668509 1.119950622237036 0 -1326 0.7881231338227134 1.458995167237009 0 -1327 0.06627932221822729 1.380967099540743 0 -1328 0.6766623623309993 1.442153706001752 0 -1329 0.4919175654574046 1.030281002704754 0 -1330 0.8343708105342499 1.304370391104469 0 -1331 0.9121450963689021 1.419349345451634 0 -1332 0.5105999368907171 1.423504044893142 0 -1333 0.6569057044723534 1.070379030552191 0 -1334 0.802338556606096 1.238211395778497 0 -1335 0.6970671169175946 1.163463418671204 0 -1336 0.231187807851162 1.224460978449169 0 -1337 0.3262454577867037 1.032784405252578 0 -1338 0.7326059697824412 1.371109073786136 0 -1339 0.393536995428678 1.034289729464825 0 -1340 0.3601191962050916 1.050639404155833 0 -1341 0.5058124497111409 1.097299906122886 0 -1342 0.6874166110571479 1.891601714653192 0 -1343 0.05567537089012627 1.178618114630763 0 -1344 0.9443246291099983 1.178618114630873 0 -1345 0.1484757769158896 1.158041713811067 0 -1346 0.8515242230834029 1.158041713811824 0 -1347 0.428213491074337 1.0468994561553 0 -1348 0.7573304234267674 1.951734240410933 0 -1349 0.5145540346942643 1.170119558743787 0 -1350 0.9011775312106528 1.866074137513676 0 -1351 0.9636567588267799 1.681512133762253 0 -1352 0.3170323106081283 1.262907739964797 0 -1353 0.9592273235099233 1.736967063163039 0 -1354 0.6563831445931259 1.39682051025599 0 -1355 0.4186121358867979 1.199876470381781 0 -1356 0.4135217584530143 1.424818262948549 0 -1357 0.2390356803107166 1.057348146646894 0 -1358 0.760964319688089 1.057348146647204 0 -1359 0.4577019289232521 1.279764572910742 0 -1360 0.504994865789132 1.008730706005746 0 -1361 0.8235213169400097 1.39483121054813 0 -1362 0.1091560533704775 1.143778124737088 0 -1363 0.8908439466292198 1.143778124737719 0 -1364 0.1122239274870524 1.271353930843264 0 -1365 0.5980269648593466 1.072577695503483 0 -1366 0.3721695815631691 1.0296019928432 0 -1367 0.1782870773589796 1.138113414804288 0 -1368 0.8217129226401865 1.138113414804914 0 -1369 0.9077045412438723 1.285342661599792 0 -1370 0.3547587411296007 1.242734551226264 0 -1371 0.781309978768695 1.633019535872545 0 -1372 0.3756458429560244 1.566089563723524 0 -1373 0.1622245164869955 1.416091382791415 0 -1374 0.6787206475367338 1.349663720382962 0 -1375 0.4480193009228002 1.197839780311325 0 -1376 0.2211602872128621 1.07827693169737 0 -1377 0.7788397127860359 1.078276931697751 0 -1378 0.4277147122316601 1.140120387918699 0 -1379 0.3125054059005411 1.63616681540862 0 -1380 0.4520191600589123 1.462413316353598 0 -1381 0.4780912759175534 1.176399487714507 0 -1382 0.4552471842362025 1.070927048475333 0 -1383 0.09948904966319957 1.467316327520788 0 -1384 0.01673059310966755 1.17795735871048 0 -1385 0.983269406890404 1.177957358710483 0 -1386 0.5245238935145241 1.472368380963238 0 -1387 0.04931199799953665 1.069359224603661 0 -1388 0.9506880020002355 1.069359224603994 0 -1389 0.6981477076797283 1.611153637015575 0 -1390 0.6160160546197366 1.96334948232346 0 -1391 0.1116460558047521 1.012727116874489 0 -1392 0.8883539441947464 1.012727116874542 0 -1393 0.7136699046471631 1.417797386501919 0 -1394 0.460621788231202 1.247883901503063 0 -1395 0.7911884271444105 1.40758209260233 0 -1396 0.206014605607537 1.276440389924756 0 -1397 0.7789529625096036 1.240532917965696 0 -1398 0.963963837467823 1.8119075273891 0 -1399 0.6963203486421858 1.477910174755796 0 -1400 0.3578535292272713 1.065855914913647 0 -1401 0.8825475330044039 1.449269539741745 0 -1402 0.3332063783061395 1.539846641249134 0 -1403 0.4468155443447985 1.601477710782173 0 -1404 0.6977993447283805 1.378783191223039 0 -1405 0.6321611182588698 1.083026541081841 0 -1406 0.08475757031901335 1.7655707381442 0 -1407 0.2162733233479228 1.056705987473216 0 -1408 0.7837266766510161 1.056705987473511 0 -1409 0.5923200487370578 1.556282133788927 0 -1410 0.5024140405504284 1.523825017410743 0 -1411 0.6755367480429364 1.95500418874565 0 -1412 0.585302376318118 1.275309169700233 0 -1413 0.04611372998506449 1.953669509922682 0 -1414 0.04166467767575872 1.834625112014256 0 -1415 0.09841948698576948 1.013789090993405 0 -1416 0.9015805130137871 1.013789090993464 0 -1417 0.5855988532257326 1.184214798487958 0 -1418 0.6138771557322263 1.084598032433125 0 -1419 0.07961535751714653 1.173717697897167 0 -1420 0.9203846424829583 1.173717697897389 0 -1421 0.09388964622270515 1.848787072349182 0 -1422 0.681362068123701 1.269051519939747 0 -1423 0.02428973759383199 1.392908134080392 0 -1424 0.682753430852495 1.054979335546691 0 -1425 0.7398588050883511 1.567982920576331 0 -1426 0.2970532175716006 1.333045997602025 0 -1427 0.1284600707858684 1.046254798064075 0 -1428 0.8715399292135432 1.046254798064293 0 -1429 0.5168568859220658 1.027008046865808 0 -1430 0.9633930985562648 1.53005178443705 0 -1431 0.6231848415916569 1.132747412065687 0 -1432 0.9788476593800917 1.330724498042673 0 -1433 0.06073211795988133 1.314268968512277 0 -1434 0.6260720988444692 1.591183241630014 0 -1435 0.04695621898392609 1.012111627343555 0 -1436 0.9530437810158643 1.012111627343613 0 -1437 0.1616284138052639 1.034884911568204 0 -1438 0.83837158619398 1.034884911568383 0 -1439 0.09580254503612032 1.056461271427961 0 -1440 0.9041974549634397 1.056461271428206 0 -1441 0.2552362926413267 1.395397171510955 0 -1442 0.4096927472559348 1.119063817267025 0 -1443 0.293202913333349 1.135091014830442 0 -1444 0.7069751894164503 1.133220292464311 0 -1445 0.8331008013979837 1.741656084893487 0 -1446 0.8840985947546303 1.579137515525924 0 -1447 0.1576505431476743 1.286866874756793 0 -1448 0.2493636691849785 1.801397597213157 0 -1449 0.3007747224298952 1.388205626986782 0 -1450 0.6249126720443516 1.055228272493474 0 -1451 0.5245831136724286 1.127530746859052 0 -1452 0.4319722470154369 1.299030650305157 0 -1453 0.8152025288711811 1.298194439240769 0 -1454 0.6020275023164409 1.050632415683287 0 -1455 0.2930272818319186 1.519316926125008 0 -1456 0.2736462654256175 1.46293010667262 0 -1457 0.7477661082389266 1.396276428289809 0 -1458 0.6293339109123771 1.409732051951666 0 -1459 0.1467675717146781 1.103209049996413 0 -1460 0.8532324282846437 1.103209049996887 0 -1461 0.2279519509102736 1.900101356531651 0 -1462 0.04971231698788624 1.294674114228781 0 -1463 0.8161323101772073 1.894134978752443 0 -1464 0.02824321091941144 1.90522157223009 0 -1465 0.01251764000915863 1.081167122030712 0 -1466 0.9874823599908519 1.08116712203088 0 -1467 0.3573514508105886 1.204735398097151 0 -1468 0.6101994844752797 1.89158484380946 0 -1469 0.02986421501269721 1.526034951228734 0 -1470 0.6076933337046221 1.011758288400327 0 -1471 0.9022480465060874 1.47545467282981 0 -1472 0.09287835819600113 1.082004656801049 0 -1473 0.9071216418036011 1.082004656801392 0 -1474 0.3535865235252714 1.028554080739409 0 -1475 0.6227919001725752 1.012184237444334 0 -1476 0.7365937730613684 1.665025878513171 0 -1477 0.4546934202816162 1.150771076749163 0 -1478 0.6756512914733921 1.783768614804902 0 -1479 0.2995477013510898 1.691341743643306 0 -1480 0.4906731792194428 1.054580577395268 0 -1481 0.3095531183278268 1.083342866075611 0 -1482 0.6904308071550952 1.083323417675065 0 -1483 0.5857933833087164 1.08597193751518 0 -1484 0.4646630736744242 1.010345349191253 0 -1485 0.5408537266307083 1.201325656457649 0 -1486 0.533757626623247 1.648506234262048 0 -1487 0.9158391628949125 1.670876411698502 0 -1488 0.3565174970297745 1.598200949584769 0 -1489 0.08676635959908342 1.287654277814599 0 -1490 0.8459888141912867 1.466384825762305 0 -1491 0.6815667369032885 1.529040007280133 0 -1492 0.8244923932627786 1.448254199395507 0 -1493 0.318299252717366 1.054956464260293 0 -1494 0.1750115020139588 1.089024224567609 0 -1495 0.8249884979852232 1.089024224568065 0 -1496 0.1584066713738506 1.247562575349788 0 -1497 0.2422549531785792 1.281505114043959 0 -1498 0.1052260249087069 1.106327016353782 0 -1499 0.8947739750907995 1.106327016354175 0 -1500 0.3067763933482186 1.965264441618542 0 -1501 0.4765787160756468 1.2132007322945 0 -1502 0.1452540563411426 1.03493550768675 0 -1503 0.8547459436581925 1.034935507686917 0 -1504 0.02129122218746901 1.300114597018594 0 -1505 0.844164891391566 1.539297346778372 0 -1506 0.5464941772426861 1.011559249884041 0 -1507 0.5610535925381057 1.047895282995608 0 -1508 0.3010489353222427 1.102809645112322 0 -1509 0.6989320759405568 1.102767654274176 0 -1510 0.2986789950316274 1.063395561756023 0 -1511 0.7013210049668441 1.063395561756364 0 -1512 0.5924087500491066 1.118954460060622 0 -1513 0.7733382975903708 1.269950097542087 0 -1514 0.2468921135568173 1.427056266792553 0 -1515 0.3420236529420274 1.495810115680273 0 -1516 0.1465881506996409 1.764077409919087 0 -1517 0.9121270534322363 1.787919698068142 0 -1518 0.7433335745915791 1.82197183028254 0 -1519 0.1389339345907782 1.04300552206283 0 -1520 0.8610660654085909 1.043005522063034 0 -1521 0.3150593586492489 1.008025813751174 0 -1522 0.26301933091577 1.284528564474793 0 -1523 0.3647286479433904 1.663821609469348 0 -1524 0.3368200573122268 1.124412750615158 0 -1525 0.6656711582090921 1.124262857336009 0 -1526 0.07877081781676794 1.594231130553396 0 -1527 0.1354666642572639 1.825087714741606 0 -1528 0.1663598598539948 1.064867497559414 0 -1529 0.8336401401452118 1.064867497559731 0 -1530 0.08942809212583332 1.306601178871015 0 -1531 0.857529908056945 1.675565889334949 0 -1532 0.6418563263599547 1.203914341741455 0 -1533 0.01338650830518007 1.106972349329796 0 -1534 0.9866134916948553 1.106972349330005 0 -1535 0.1145807784841902 1.512353564030207 0 -1536 0.4887479985797444 1.240943879353358 0 -1537 0.3260686785797539 1.403099614383736 0 -1538 0.5561096398262423 1.091555582118914 0 -1539 0.6037040757391626 1.836589673903682 0 -1540 0.1581552711497942 1.323760706166316 0 -1541 0.01874304569024386 1.215191332205178 0 -1542 0.9811862769201648 1.21527031952507 0 -1543 0.4862117371378305 1.65516333561732 0 -1544 0.3112587971947582 1.720065956844191 0 -1545 0.637742300624771 1.444157149739842 0 -1546 0.1943459229343064 1.77441466636252 0 -1547 0.2810458619562471 1.101621369583768 0 -1548 0.7189541380423613 1.101621369584299 0 -1549 0.620528336291272 1.184452816143784 0 -1550 0.2356672419650671 1.160371051731645 0 -1551 0.7643327580337528 1.160371051732442 0 -1552 0.4058204976661204 1.057702585100289 0 -1553 0.7618680228798127 1.345883004305126 0 -1554 0.650999941311504 1.089969448461361 0 -1555 0.9502317721536241 1.352935894378699 0 -1556 0.5797844335601458 1.059177608524496 0 -1557 0.7303688500399934 1.73446820373542 0 -1558 0.3144191658558659 1.573557051281711 0 -1559 0.7207015213764739 1.514469598376777 0 -1560 0.1346307090920045 1.106201605560626 0 -1561 0.8653692909073718 1.106201605561103 0 -1562 0.6609267440178047 1.834666613928059 0 -1563 0.1181883349000979 1.903641729580386 0 -1564 0.9289275397207835 1.74102793980628 0 -1565 0.0330669587709776 1.102980605319288 0 -1566 0.9669330412289224 1.102980605319444 0 -1567 0.1418840339251989 1.511189420830781 0 -1568 0.6568629905312598 1.586363776375571 0 -1569 0.4759795406325346 1.033836516011811 0 -1570 0.07816277938700485 1.643354779596752 0 -1571 0.4559955475236971 1.116184535124403 0 -1572 0.4115001443294869 1.181050078636877 0 -1573 0.3789893566625959 1.279840405446548 0 -1574 0.06075176103110969 1.108632952307608 0 -1575 0.939248238968586 1.108632952308025 0 -1576 0.5111988585487603 1.045834148294043 0 -1577 0.4026722094848387 1.561434685963921 0 -1578 0.3562307443188961 1.407866265365277 0 -1579 0.4191721287984816 1.153675025368597 0 -1580 0.9792444659793228 1.438593033278843 0 -1581 0.4323219589611959 1.41351019326556 0 -1582 0.08792983002350216 1.131181013004555 0 -1583 0.91207016997618 1.131181013004916 0 -1584 0.1783258219317796 1.356963783664116 0 -1585 0.04324426086459452 1.185776142796404 0 -1586 0.9567557391355163 1.18577614279659 0 -1587 0.154740114872336 1.008021161127617 0 -1588 0.8452598851269455 1.008021161127652 0 -1589 0.6987464304884959 1.272977936042692 0 -1590 0.9148005468749716 1.312045861390605 0 -1591 0.8787694624623098 1.394168887995288 0 -1592 0.3201483001244542 1.137872298075531 0 -1593 0.4936174623866023 1.269627265360317 0 -1594 0.4826470803606446 1.190158823603414 0 -1595 0.6801416026413017 1.138541929336917 0 -1596 0.4168781002614067 1.817699461124223 0 -1597 0.4155725014209651 1.074248816966523 0 -1598 0.0117552071147949 1.048466678824575 0 -1599 0.9882447928851199 1.048466678824712 0 -1600 0.2385352210663191 1.092793607233794 0 -1601 0.7614647789325154 1.092793607234259 0 -1602 0.3444341586977429 1.828757709742545 0 -1603 0.7730650107450523 1.214810497588176 0 -1604 0.731060578609976 1.893701218237031 0 -1605 0.2258311664530152 1.382944693234825 0 -1606 0.1495767527455916 1.131431570479477 0 -1607 0.8504232472537612 1.131431570480128 0 -1608 0.4446825211947514 1.033119963312767 0 -1609 0.04954565825564744 1.220770452212206 0 -1610 0.9504441575788505 1.220793420776711 0 -1611 0.3609770846955486 1.113104704290984 0 -1612 0.5606282635731242 1.361501975399593 0 -1613 0.2079996040968948 1.411386678035299 0 -1614 0.1618416820970086 1.578071432803962 0 -1615 0.04062386767576311 1.115679418172515 0 -1616 0.9593761323240534 1.115679418172818 0 -1617 0.4435244708936735 1.11650327031105 0 -1618 0.175534804777607 1.704895030586384 0 -1619 0.5729504416268045 1.398315542564204 0 -1620 0.2290228098683907 1.308873262282221 0 -1621 0.3259464329783126 1.337244115632636 0 -1622 0.2064978002433709 1.159152844078602 0 -1623 0.793502199755626 1.159152844079351 0 -1624 0.4382413881497792 1.646680487263044 0 -1625 0.06089959888436646 1.096296802371878 0 -1626 0.9391004011153534 1.096296802372278 0 -1627 0.06425719973477335 1.47811437172569 0 -1628 0.3710676634156111 1.183766791295809 0 -1629 0.3363422712871743 1.157778222641568 0 -1630 0.1610069459156927 1.651374550326023 0 -1631 0.4478908755373141 1.528303722517505 0 -1632 0.9839231783189639 1.243276898733598 0 -1633 0.6453982566274626 1.044479911447842 0 -1634 0.9385967721430639 1.445651244910694 0 -1635 0.4049999999989607 1.010325669332425 0 -1636 0.1473492238489656 1.054027230884211 0 -1637 0.8526507761503666 1.054027230884472 0 -1638 0.3940102133418256 1.351778383582751 0 -1639 0.4760247380804355 1.072194522047131 0 -1640 0.8852028059929484 1.266529568120554 0 -1641 0.4416203057786958 1.093516402057662 0 -1642 0.6636782758597186 1.157563453717568 0 -1643 0.9614976357608271 1.907767582905676 0 -1644 0.5760875050384048 1.62603232124672 0 -1645 0.8773866561344099 1.305139728250962 0 -1646 0.9826090494749027 1.275987708963745 0 -1647 0.3403614053517528 1.011517601636396 0 -1648 0.5477421929065333 1.112128814973993 0 -1649 0.5663653936319523 1.073750528243041 0 -1650 0.1083900479288564 1.364805882705171 0 -1651 0.02987665745149662 1.614416037580508 0 -1652 0.3391315209494828 1.27624315923744 0 -1653 0.1493400074749239 1.72255288215618 0 -1654 0.04246079629601342 1.028053921286899 0 -1655 0.9575392037037957 1.028053921287022 0 -1656 0.5664840037456682 1.031470476004189 0 -1657 0.3873002757682726 1.081246655985661 0 -1658 0.07568757025257022 1.054997260558172 0 -1659 0.9243124297470806 1.054997260558419 0 -1660 0.07932143985782369 1.011673816469576 0 -1661 0.920678560141821 1.011673816469627 0 -1662 0.1879403487172224 1.028375997008667 0 -1663 0.8120596512818856 1.028375997008808 0 -1664 0.2291810379992018 1.459215296149387 0 -1665 0.3219486276012629 1.443440418391772 0 -1666 0.6199585669476186 1.109077260294253 0 -1667 0.1021199732966851 1.03491419026822 0 -1668 0.8978800267028566 1.034914190268374 0 -1669 0.7185416726362968 1.339484131299576 0 -1670 0.3023369799534296 1.274879158863818 0 -1671 0.6636110242490182 1.047796247356454 0 -1672 0.01596239100049949 1.243393822479002 0 -1673 0.7141721551714876 1.249119212650614 0 -1674 0.5032942195011828 1.4596582193332 0 -1675 0.9497587152274398 1.270916397068575 0 -1676 0.5380266210029309 1.316610217892344 0 -1677 0.8734803688066715 1.894713121260277 0 -1678 0.3615147625178329 1.093324921907372 0 -1679 0.2635268253303262 1.036544177860199 0 -1680 0.7364731746683402 1.036544177860393 0 -1681 0.3108839341183536 1.904413000187354 0 -1682 0.4962528747428769 1.961032716164873 0 -1683 0.2590993993591028 1.885302552045916 0 -1684 0.4153848228197968 1.592578696140905 0 -1685 0.5643077910258467 1.717451905003975 0 -1686 0.4342278299860741 1.320773040629483 0 -1687 0.6709619065651022 1.212217460684311 0 -1688 0.3991613327593835 1.470540322840005 0 -1689 0.1650556980539425 1.884492126577331 0 -1690 0.4976139725229419 1.553004764708679 0 -1691 0.7296038013271215 1.29786690671069 0 -1692 0.1868074093375889 1.459137669500813 0 -1693 0.8702726182204868 1.627551034319364 0 -1694 0.223689984529217 1.182484164540328 0 -1695 0.7756114334631499 1.185650017080701 0 -1696 0.2612784195375845 1.140051981112966 0 -1697 0.7387215804611251 1.140051981113688 0 -1698 0.1261511812497802 1.089691626141032 0 -1699 0.8738488187496458 1.08969162614144 0 -1700 0.2359484217714043 1.045443145223011 0 -1701 0.7640515782274224 1.045443145223259 0 -1702 0.1686268695969757 1.441026054663444 0 -1703 0.6844186657385044 1.009174928573805 0 -1704 0.131924221922249 1.239018105148526 0 -1705 0.8705361523540117 1.237814505868862 0 -1706 0.4797977074956976 1.054205962947559 0 -1707 0.4811330023484638 1.012009632641965 0 -1708 0.07795727497581416 1.139337367599855 0 -1709 0.9220427250239228 1.139337367599872 0 -1710 0.05821383211572706 1.011759534039748 0 -1711 0.941786167884012 1.011759534039806 0 -1712 0.04917293455488167 1.331799577707842 0 -1713 0.4601970602426647 1.440229817929107 0 -1714 0.04893286990602787 1.271637590800177 0 -1715 0.6359324003533627 1.219892476233232 0 -1716 0.2738614356296792 1.095130728617688 0 -1717 0.7261385643689789 1.095130728618176 0 -1718 0.3105539960236046 1.112797113469678 0 -1719 0.5016014819810687 1.070136473007622 0 -1720 0.02322850060454679 1.457495002737063 0 -1721 0.0109972683052967 1.01099945954156 0 -1722 0.9890027316946527 1.010999459541614 0 -1723 0.7374134245399585 1.321824765953971 0 -1724 0.3820898034075261 1.095570020516798 0 -1725 0.1867452764643828 1.069925629010018 0 -1726 0.8132547235347162 1.069925629010368 0 -1727 0.475593715474494 1.306540168075893 0 -1728 0.6217384907478309 1.36509156942236 0 -1729 0.3373347310416704 1.049338378076901 0 -1730 0.3642837198023857 1.22141463529862 0 -1731 0.1920885756700064 1.57418041362173 0 -1732 0.6893300349513557 1.112544882634943 0 -1733 0.4449999999988435 1.009834419939386 0 -1734 0.1700748860643287 1.150526006389004 0 -1735 0.8299251139348781 1.150526006389683 0 -1736 0.09186582962255053 1.95800540296326 0 -1737 0.5643355014725605 1.009824024904067 0 -1738 0.5289478002885146 1.011402601026616 0 -1739 0.3621653283032414 1.728327737854277 0 -1740 0.6584726955161372 1.237271700011114 0 -1741 0.5427278046878793 1.584458579189472 0 -1742 0.7623183775324321 1.425712092514215 0 -1743 0.02547551206921448 1.009775380546244 0 -1744 0.9745244879306694 1.009775380546281 0 -1745 0.3529412992202863 1.144496753813938 0 -1746 0.4326110221304705 1.059377340742407 0 -1747 0.3662418250752965 1.153629626053834 0 -1748 0.517871980599294 1.080816405729828 0 -1749 0.4319676729204253 1.380808248127539 0 -1750 0.5738926691441627 1.103111176288461 0 -1751 0.6465563042508211 1.144647387878987 0 -1752 0.09859489244969388 1.32544165797598 0 -1753 0.6375339010817939 1.495050913683121 0 -1754 0.6967396601894161 1.71341023553605 0 -1755 0.6593756972627105 1.010935180684107 0 -1756 0.8331184471826958 1.596006363544031 0 -1757 0.8850499853871938 1.722776790980374 0 -1758 0.8961148323183634 1.534881439365525 0 -1759 0.2739818134134839 1.195999635730333 0 -1760 0.6335438316870903 1.155708931309635 0 -1761 0.229037582356828 1.139197728608386 0 -1762 0.7709624176420738 1.139197728609073 0 -1763 0.6039636780548822 1.658153438395696 0 -1764 0.188095597482738 1.377453523538903 0 -1765 0.2555521166439686 1.346933687821055 0 -1766 0.009912930490979698 1.025902423376436 0 -1767 0.9900870695089976 1.025902423376437 0 -1768 0.3623373094897565 1.457841755368865 0 -1769 0.1176242862198361 1.559822930795623 0 -1770 0.5766003665395085 1.498111411997358 0 -1771 0.4571938465119326 1.18471022988318 0 -1772 0.1581275826813519 1.532229576198945 0 -1773 0.5008660600062748 1.815906300647446 0 -1774 0.1854294366842165 1.527509909607555 0 -1775 0.1205315829907918 1.117590990323308 0 -1776 0.8794684170086939 1.117590990323865 0 -1777 0.194964504568624 1.502411683511218 0 -1778 0.4590965769170281 1.092726363822945 0 -1779 0.6381587890015873 1.538042603638914 0 -1780 0.3668236354042959 1.324419947246179 0 -1781 0.6140980181279748 1.454734385857907 0 -1782 0.2595902921870787 1.250432270327945 0 -1783 0.9757327494972733 1.483092236877727 0 -1784 0.2649060638665572 1.748481407340416 0 -1785 0.3055293456664271 1.126873017774059 0 -1786 0.2449999999994267 1.009670990913548 0 -1787 0.7549999999993507 1.009670990913599 0 -1788 0.695046560129568 1.12656046617977 0 -1789 0.5449886796055228 1.024320193064386 0 -1790 0.0649842999542521 1.53495259832372 0 -1791 0.4634572586411065 1.022760819917886 0 -1792 0.03181169190327937 1.503840213539674 0 -1793 0.2425835267004245 1.069599974389253 0 -1794 0.757416473298351 1.069599974389621 0 -1795 0.3320533437947311 1.21349743691756 0 -1796 0.1323338408924918 1.155457519955617 0 -1797 0.8676661591069742 1.155457519956403 0 -1798 0.2565343694781148 1.176225775491501 0 -1799 0.7435126815472837 1.176198523079507 0 -1800 0.01247696085086004 1.122589760942111 0 -1801 0.987523039149141 1.122589760942236 0 -1802 0.06556473889338765 1.213741341722324 0 -1803 0.9344335637458251 1.213745169816564 0 -1804 0.9271478158824468 1.625694674762937 0 -1805 0.4309311121363045 1.011517013271308 0 -1806 0.08109472075434772 1.399353605119127 0 -1807 0.06147971307893951 1.573710923104925 0 -1808 0.6841545248269346 1.189144133171135 0 -1809 0.7657227375403499 1.302215220964341 0 -1810 0.8624439206485932 1.758791645065031 0 -1811 0.155072236528789 1.487716895119892 0 -1812 0.6949704476117879 1.026648443108347 0 -1813 0.1457363513377697 1.364128303971519 0 -1814 0.8403013925211991 1.321032545269435 0 -1815 0.356820763560079 1.542906462989085 0 -1816 0.08550830360346379 1.105011540413705 0 -1817 0.9144916963961174 1.10501154041412 0 -1818 0.02053398411607882 1.324646479081549 0 -1819 0.1240368264947708 1.143213243553162 0 -1820 0.8759631735047608 1.143213243553859 0 -1821 0.6127367096328877 1.03300909492778 0 -1822 0.8934747587653146 1.336047976327256 0 -1823 0.7270739513648025 1.193762448046446 0 -1824 0.1752184368776151 1.126283605545843 0 -1825 0.8247815631215744 1.12628360554642 0 -1826 0.8102041703435074 1.637111916870119 0 -1827 0.6103800280238214 1.158534652353839 0 -1828 0.7500234758731192 1.222111658292078 0 -1829 0.08717097594833297 1.158387265680563 0 -1830 0.9128290240516461 1.158387265680887 0 -1831 0.9797871248523023 1.376468907498227 0 -1832 0.3166170696317585 1.190975006797362 0 -1833 0.2146148845766929 1.636298158682441 0 -1834 0.01861447673173511 1.41752576251523 0 -1835 0.3897512578210214 1.159579887361764 0 -1836 0.1266112422386982 1.354737419547293 0 -1837 0.3391692139302137 1.659592054851591 0 -1838 0.2016845130700723 1.210250763781453 0 -1839 0.7992031568300352 1.211166790635472 0 -1840 0.792664126268221 1.524898389460468 0 -1841 0.5573820430114038 1.540049571428264 0 -1842 0.6380740774390484 1.172789027114497 0 -1843 0.2232376464142119 1.00958411914316 0 -1844 0.7767623535846921 1.009584119143212 0 -1845 0.6024686209170629 1.514565844696254 0 -1846 0.2849423695736947 1.078531667484422 0 -1847 0.7150576304248637 1.078531667484845 0 -1848 0.1456100583826198 1.556642836083183 0 -1849 0.4180501201640903 1.026176979778029 0 -1850 0.1936412762776413 1.235186419658842 0 -1851 0.3041497694467667 1.156792131505723 0 -1852 0.1639696274917743 1.957393468776791 0 -1853 0.9737822816262725 1.638971398278397 0 -1854 0.1303393100494752 1.012339003492229 0 -1855 0.8696606899499348 1.012339003492284 0 -1856 0.2563550932659178 1.514428140544755 0 -1857 0.0318659543103559 1.087988973767038 0 -1858 0.968134045689499 1.087988973767478 0 -1859 0.4564654773622829 1.557390433553833 0 -1860 0.2512570647326824 1.476789328142382 0 -1861 0.1792869961406473 1.045135879016064 0 -1862 0.820713003858498 1.045135879016294 0 -1863 0.8415989605671719 1.242962806964758 0 -1864 0.1631740024733374 1.227677131980952 0 -1865 0.5450945626466963 1.137843101241501 0 -1866 0.7781476330352186 1.603777668355222 0 -1867 0.5558912131262865 1.119787333810297 0 -1868 0.204999999999543 1.009149411772196 0 -1869 0.7949999999994576 1.009149411772257 0 -1870 0.4582273797523627 1.262244493653419 0 -1871 0.4254445428999811 1.746596752175994 0 -1872 0.5378374929183676 1.559574970150986 0 -1873 0.03457720511724604 1.212296950800446 0 -1874 0.9654227948826942 1.21229695080066 0 -1875 0.8700209059850211 1.496518551380331 0 -1876 0.5675945355170743 1.3003120461337 0 -1877 0.8496440468217714 1.360526511650975 0 -1878 0.7841465124683823 1.368253165614996 0 -1879 0.2909482692433644 1.612229037726445 0 -1880 0.4141127735951107 1.048124555826303 0 -1881 0.1434679067885991 1.27101494884259 0 -1882 0.3863293159074262 1.188760731051833 0 -1883 0.7618849372965923 1.48607523020365 0 -1884 0.1520930466446257 1.145016989540456 0 -1885 0.8479069533546686 1.145016989541159 0 -1886 0.4001232215111544 1.10958575853212 0 -1887 0.4606722793665414 1.708346148464479 0 -1888 0.1945939971618717 1.111928456343726 0 -1889 0.8054060028371891 1.111928456344265 0 -1890 0.2227624038922636 1.16737024954893 0 -1891 0.777121165772221 1.167897891639661 0 -1892 0.2331825557006087 1.104649197274569 0 -1893 0.7668174442982576 1.10464919727508 0 -1894 0.6575666862515637 1.45527827592039 0 -1895 0.1794842438232933 1.162229785601425 0 -1896 0.82051575617585 1.162229785602169 0 -1897 0.1169971873452828 1.046686485382433 0 -1898 0.8830028126541825 1.04668648538265 0 -1899 0.3053040956980385 1.026769250485196 0 -1900 0.06392993616871255 1.24585270171517 0 -1901 0.936070063831129 1.245852701715393 0 -1902 0.06013750131700139 1.432045095227549 0 -1903 0.3958226291316718 1.023505652321041 0 -1904 0.1924508227629811 1.095149888689246 0 -1905 0.8075491772361134 1.095149888689733 0 -1906 0.377148226163243 1.384683121915274 0 -1907 0.3673738420170892 1.071010433513946 0 -1908 0.2674039214137685 1.378029728527427 0 -1909 0.1344414996845994 1.222108759905904 0 -1910 0.02744647986399516 1.735506331588752 0 -1911 0.8659803798364015 1.221093141281715 0 -1912 0.0876569881871975 1.343636705461433 0 -1913 0.6538996920355378 1.026097605344896 0 -1914 0.6933701665226202 1.563787524063246 0 -1915 0.7123807038560013 1.266110315202807 0 -1916 0.5095885034584053 1.184820151560342 0 -1917 0.2933597579722765 1.010368072803908 0 -1918 0.5939928235128039 1.040269355732589 0 -1919 0.5696269032516708 1.266516651681863 0 -1920 0.8619498806529748 1.422974738371203 0 -1921 0.2367565364115237 1.192976067184187 0 -1922 0.7627325250576875 1.192078160427286 0 -1923 0.7441097986637095 1.593083500344335 0 -1924 0.07171557645244529 1.076598344915446 0 -1925 0.9282844235472408 1.076598344915794 0 -1926 0.9347120007217984 1.567878552007669 0 -1927 0.8233423111854732 1.710581195280778 0 -1928 0.2618309309568392 1.204429643427829 0 -1929 0.3828665712359585 1.131614629498487 0 -1930 0.306063105488766 1.834469317280389 0 -1931 0.07397811590968398 1.695754684989576 0 -1932 0.551829080481935 1.427418097095619 0 -1933 0.6271692125494556 1.286971920848768 0 -1934 0.8265006754485748 1.223679790649367 0 -1935 0.2579098681207076 1.047262021849317 0 -1936 0.7420901318780004 1.04726202184957 0 -1937 0.5178858147592814 1.700687013220689 0 -1938 0.3279855027971465 1.247727616175733 0 -1939 0.7669991237691466 1.734910024566651 0 -1940 0.6274613154507542 1.699365570343305 0 -1941 0.09577685086407008 1.209376818520836 0 -1942 0.9042231491367253 1.209376818521126 0 -1943 0.2060120022232498 1.746963032947698 0 -1944 0.4787036845354107 1.852040693945571 0 -1945 0.1704541376211083 1.177970402666852 0 -1946 0.8295458623781076 1.177970402667681 0 -1947 0.14416662426055 1.189927231182806 0 -1948 0.85583337573882 1.189927231183569 0 -1949 0.4803838477741659 1.514226289217374 0 -1950 0.0156776004375533 1.274148142540154 0 -1951 0.2981240476860536 1.206007844677198 0 -1952 0.3239839727924476 1.071426663218374 0 -1953 0.08785474620680163 1.884523387382669 0 -1954 0.675580106770746 1.073304072611617 0 -1955 0.2444933799370497 1.253169245062978 0 -1956 0.2084240140641045 1.39119473368074 0 -1957 0.706720130807567 1.677584372371792 0 -1958 0.4985630721814919 1.286583697951079 0 -1959 0.5272648367935169 1.030309746661296 0 -1960 0.1794491930618081 1.483116361983499 0 -1961 0.612466595261273 1.537821890578596 0 -1962 0.9487159971720964 1.371233950340879 0 -1963 0.6423907119281544 1.010599178919727 0 -1964 0.9653928597467655 1.24668944924121 0 -1965 0.645245503128506 1.260030604115 0 -1966 0.7082398288968355 1.174555644289763 0 -1967 0.02736770568715491 1.064256349414609 0 -1968 0.9726322943127153 1.064256349414922 0 -1969 0.5680345081402352 1.594095559129904 0 -1970 0.362563884902023 1.171575296280291 0 -1971 0.4157620768697803 1.008619152368975 0 -1972 0.2681937934565681 1.957420060780857 0 -1973 0.9743938418550899 1.553111234286536 0 -1974 0.6791418009711589 1.250053136850562 0 -1975 0.2784198226526192 1.05637801625902 0 -1976 0.7215801773459838 1.056378016259317 0 -1977 0.02753429274848121 1.041934772296269 0 -1978 0.972465707251381 1.041934772296453 0 -1979 0.1256376071734777 1.302219577829865 0 -1980 0.2609838056415137 1.086317206399151 0 -1981 0.7390161943571902 1.086317206399599 0 -1982 0.3676316620391438 1.234919150069465 0 -1983 0.5019209186998863 1.109358723710899 0 -1984 0.6677218717434913 1.753575097246623 0 -1985 0.479680976008357 1.095710771767852 0 -1986 0.4825622058110138 1.127951198384719 0 -1987 0.6637594993211857 1.328674258715477 0 -1988 0.03463095676034268 1.24747100852619 0 -1989 0.9371262009871737 1.317695419714111 0 -1990 0.4627619036874025 1.210014839253461 0 -1991 0.5113398094517708 1.224128721267505 0 -1992 0.1704701232449447 1.394540156805218 0 -1993 0.9013876922001541 1.596167525349352 0 -1994 0.5760617612020729 1.007735744418398 0 -1995 0.4520236835492349 1.413634959189053 0 -1996 0.3843314276994749 1.052785872645919 0 -1997 0.2560238928644291 1.110215166345754 0 -1998 0.7064606446168739 1.010452047779177 0 -1999 0.5436292608078989 1.242121071362822 0 -2000 0.7439761071343243 1.110215166346311 0 -2001 0.128203013834791 1.06604649451107 0 -2002 0.8717969861646158 1.066046494511361 0 -2003 0.1638231026155551 1.344567036383962 0 -2004 0.2278375117322295 1.541199029141715 0 -2005 0.437097361665723 1.128646281741983 0 -2006 0.1522173451869736 1.174608683707464 0 -2007 0.847782654812319 1.174608683708255 0 -2008 0.292348746218609 1.242220508949792 0 -2009 0.950141997089236 1.481209888463451 0 -2010 0.8030541759907543 1.362004030032993 0 -2011 0.1260362702479695 1.16985254498585 0 -2012 0.8739637297516609 1.169852544986847 0 -2013 0.758891510663338 1.508405134173101 0 -2014 0.9459306581138512 1.28912645618923 0 -2015 0.70079256369617 1.215690352383343 0 -2016 0.1608953896414062 1.053151652143149 0 -2017 0.8391046103578392 1.05315165214341 0 -2018 0.8673264847469432 1.520896980552137 0 -2019 0.4217217054647685 1.967189886739287 0 -2020 0.5670290114423467 1.158265665607041 0 -2021 0.8806414424851595 1.372527903961492 0 -2022 0.8404250379701619 1.277474672985963 0 -2023 0.1921012955458994 1.049549523920727 0 -2024 0.8078987044531749 1.049549523920973 0 -2025 0.1667596275776418 1.025704905452568 0 -2026 0.833240372421572 1.025704905452702 0 -2027 0.699469288966292 1.335437285881577 0 -2028 0.447163015802219 1.79955888093813 0 -2029 0.2015129249994881 1.547535917057872 0 -2030 0.2956382843634384 1.043318504715491 0 -2031 0.7043328220147673 1.043326308630081 0 -2032 0.149815425092113 1.452000026728363 0 -2033 0.03322219127291086 1.1276583390886 0 -2034 0.9667778087270498 1.127658339088923 0 -2035 0.6024721618403006 1.341253534719694 0 -2036 0.7165605180680079 1.370507799258252 0 -2037 0.08211482328749958 1.436591101799652 0 -2038 0.6775270146101005 1.107470769230827 0 -2039 0.5324294510389613 1.047176526105539 0 -2040 0.05834643421919659 1.043557151751575 0 -2041 0.9416535657805349 1.04355715175178 0 -2042 0.4373309311078256 1.081646688323138 0 -2043 0.1757150562566806 1.009333843141428 0 -2044 0.8242849437424866 1.009333843141474 0 -2045 0.606435889235086 1.129939411271857 0 -2046 0.5674075782240189 1.200250734669209 0 -2047 0.2002405263313292 1.035252963107884 0 -2048 0.7997594736677088 1.035252963108054 0 -2049 0.5523157243353665 1.040903584941117 0 -2050 0.2513120474041305 1.600223033278485 0 -2051 0.008869757682282854 1.06090774539327 0 -2052 0.991130242317674 1.060907745393404 0 -2053 0.428572337150359 1.021999380817825 0 -2054 0.9798449062744337 1.3988480892044 0 -2055 0.8560898397849038 1.249100717623396 0 -2056 0.379906043111042 1.504713625053354 0 -2057 0.272532818139513 1.151381550821801 0 -2058 0.7272559015513816 1.151715946930214 0 -2059 0.356745541492913 1.009917679246867 0 -2060 0.6846557308686028 1.305860243175372 0 -2061 0.08714079832757156 1.734909779511169 0 -2062 0.8400150590438813 1.424156279737596 0 -2063 0.5933383741432143 1.008958334910085 0 -2064 0.2705136801267467 1.553460155605202 0 -2065 0.965385333701911 1.843014132114027 0 -2066 0.6386966745422131 1.355488786214845 0 -2067 0.8665252251706854 1.971809501410483 0 -2068 0.9820949512587762 1.297096437138225 0 -2069 0.03615638995613647 1.150604770057545 0 -2070 0.9638436100439778 1.150604770057832 0 -2071 0.4895994311900977 1.437839367573432 0 -2072 0.1514131063759163 1.603336188169901 0 -2073 0.4177696222708859 1.448159842847469 0 -2074 0.6103923412652905 1.208648684626435 0 -2075 0.3442076737687241 1.442134370437397 0 -2076 0.3404386207122936 1.969127580425501 0 -2077 0.5444207867287427 1.168506061880991 0 -2078 0.4795481514829413 1.10794642130366 0 -2079 0.2009848388279936 1.886086828398841 0 -2080 0.6148075888515304 1.265721875828371 0 -2081 0.09658846249911561 1.414472733446401 0 -2082 0.02353660305992512 1.028593042207709 0 -2083 0.9764633969399723 1.028593042207789 0 -2084 0.04681438408732135 1.454884805392139 0 -2085 0.451175577132779 1.039110595021683 0 -2086 0.5797938481339602 1.134012273139594 0 -2087 0.609934940545047 1.072246520391785 0 -2088 0.1449656292904127 1.008223463394859 0 -2089 0.8550343707089234 1.008223463394896 0 -2090 0.590460099736939 1.170984208737595 0 -2091 0.5292696632865045 1.759059703937938 0 -2092 0.4883221154853772 1.479002461273176 0 -2093 0.5806648813343145 1.022275255686573 0 -2094 0.05129973305321583 1.134712957097158 0 -2095 0.9487002669466476 1.134712957097605 0 -2096 0.04426282461234832 1.049400337207207 0 -2097 0.955737175387451 1.049400337207442 0 -2098 0.8099763954840026 1.798573898416366 0 -2099 0.4661317279311475 1.127806744688285 0 -2100 0.7483715743899884 1.448137144407937 0 -2101 0.09502051656371546 1.043905955397741 0 -2102 0.9049794834358547 1.043905955397932 0 -2103 0.2318473580149737 1.117791116100699 0 -2104 0.7681526419839296 1.117791116101271 0 -2105 0.4482731064374137 1.022160747257612 0 -2106 0.3904237451632521 1.424236798817851 0 -2107 0.7217970621698427 1.76667148339369 0 -2108 0.3961510664141517 1.230308961788109 0 -2109 0.6064958462041103 1.023120951699352 0 -2110 0.07827044573813537 1.221524332051237 0 -2111 0.9217295542618398 1.221524332051461 0 -2112 0.9430398101745519 1.399891910807088 0 -2113 0.5465874879587067 1.869794292935753 0 -2114 0.3214036490763777 1.088510236500664 0 -2115 0.6786623141279533 1.088426701333874 0 -2116 0.5520376257110979 1.193525564168789 0 -2117 0.1299015217104029 1.186260615674174 0 -2118 0.8701076972099632 1.186217630506735 0 -2119 0.5929184663678062 1.434598570127111 0 -2120 0.2017401129760921 1.079678988950125 0 -2121 0.7982598870229237 1.079678988950528 0 -2122 0.1151957459583702 1.024969933208169 0 -2123 0.884804254041114 1.02496993320828 0 -2124 0.2746327014355624 1.255510554686107 0 -2125 0.2472826508168402 1.220350543469557 0 -2126 0.01273565874639171 1.163923468083115 0 -2127 0.9872643412536666 1.163923468083227 0 -2128 0.4712512329975019 1.399596369631081 0 -2129 0.132111284008946 1.022647928026197 0 -2130 0.8678887159904536 1.0226479280263 0 -2131 0.1807586128299933 1.672997320175485 0 -2132 0.136101380073499 1.322928893301953 0 -2133 0.3437952484083727 1.082829196403842 0 -2134 0.5868410512445059 1.145284134045907 0 -2135 0.438603114066438 1.28215724617847 0 -2136 0.6853938462836076 1.045800050598333 0 -2137 0.07561781945562387 1.112309247825873 0 -2138 0.9243821805439293 1.112309247826226 0 -2139 0.5560095425502198 1.516250594280434 0 -2140 0.01871380242351933 1.355514239171304 0 -2141 0.4959481301902377 1.592706067739345 0 -2142 0.07797514699932538 1.021065725418745 0 -2143 0.9220248530003248 1.021065725418842 0 -2144 0.6637545542748219 1.863511076446011 0 -2145 0.3353636582360394 1.038373684102795 0 -2146 0.1645229955356057 1.083357920346921 0 -2147 0.4875327168789771 1.682941262859293 0 -2148 0.8354770044636202 1.083357920347322 0 -2149 0.3761083345513266 1.84687142048503 0 -2150 0.2741008468502953 1.224925449319769 0 -2151 0.6333181207285565 1.105407244731822 0 -2152 0.1755858547231468 1.213850074413578 0 -2153 0.0261757603801651 1.80159747629283 0 -2154 0.6007160861068624 1.576760455524258 0 -2155 0.1793214923670735 1.114422410292022 0 -2156 0.8206785076320341 1.114422410292585 0 -2157 0.6365350515204296 1.0384250866456 0 -2158 0.1693255843156125 1.624881200064417 0 -2159 0.02164870612970708 1.565387712577066 0 -2160 0.6354508407273606 1.028215418302689 0 -2161 0.08270077109235817 1.037857516254943 0 -2162 0.9172992289072571 1.037857516255114 0 -2163 0.5998321287691302 1.769364797826695 0 -2164 0.8298178491891557 1.336571357819605 0 -2165 0.7527859353988637 1.330997162859243 0 -2166 0.5258435291239074 1.303178670179201 0 -2167 0.5116849957764512 1.642206686824897 0 -2168 0.4776052058869856 1.151412640668384 0 -2169 0.01242659049893313 1.145731527548932 0 -2170 0.9875734095011103 1.14573152754917 0 -2171 0.8994886050807953 1.300374556985441 0 -2172 0.2496617762402528 1.161951873983885 0 -2173 0.7503422246961428 1.161949556602649 0 -2174 0.5623022331621876 1.021829685663601 0 -2175 0.7985830155877583 1.662256342634103 0 -2176 0.4468485119230721 1.143439840939882 0 -2177 0.4995799472483723 1.145753470585167 0 -2178 0.5385558254411901 1.36449961192785 0 -2179 0.3152725617578118 1.301914044049464 0 -2180 0.2019650834310384 1.716905711027309 0 -2181 0.8709055538433237 1.274553834352554 0 -2182 0.352717671148069 1.259891628720189 0 -2183 0.4137835368403202 1.212724644096485 0 -2184 0.7829125414814452 1.283070722091011 0 -2185 0.8345090748393948 1.491459210364769 0 -2186 0.4647665742582281 1.032948237937426 0 -2187 0.6572127978963609 1.479948171438262 0 -2188 0.10687252195885 1.586323961651251 0 -2189 0.5421004732268 1.076863751249264 0 -2190 0.1173760866278616 1.390861612958324 0 -2191 0.9448717414548565 1.51610757247957 0 -2192 0.3974005433439814 1.135590000617764 0 -2193 0.7974348103751557 1.482895490993941 0 -2194 0.3148713400133976 1.045500140778384 0 -2195 0.06797456480814938 1.087495973976509 0 -2196 0.9320254351915567 1.087495973976895 0 -2197 0.5219576539716246 1.154555784792072 0 -2198 0.3904272688864535 1.204473783123806 0 -2199 0.3977708065818873 1.392026131897953 0 -2200 0.5945803455850158 1.027906802244898 0 -2201 0.4019486570923889 1.284101626938114 0 -2202 0.2765171062125843 1.025066889101606 0 -2203 0.7234887981607393 1.025080592209863 0 -2204 0.1758557526560303 1.27775460757229 0 -2205 0.9136518823238828 1.375396452990999 0 -2206 0.7443960407730932 1.266873315075178 0 -2207 0.12459080310233 1.431662300570973 0 -2208 0.4480100586917132 1.484851401399625 0 -2209 0.2944378100425409 1.496329730399626 0 -2210 0.8044837195806125 1.440617180702402 0 -2211 0.6399006031828921 1.391510323739811 0 -2212 0.3690439829379977 1.009642632848299 0 -2213 0.170060425218992 1.104164627670242 0 -2214 0.8299395747802024 1.104164627670734 0 -2215 0.2286028152215735 1.037350276990135 0 -2216 0.7713971847772998 1.037350276990342 0 -2217 0.2934789486989772 1.0223920844985 0 -2218 0.6240986683788222 1.024477051803363 0 -2219 0.1067063187395025 1.058628892594812 0 -2220 0.8932936812599981 1.058628892595063 0 -2221 0.1019544830037276 1.156168329210506 0 -2222 0.898045516996135 1.156168329211049 0 -2223 0.1949932944472074 1.167360191180254 0 -2224 0.8050067055518592 1.167360191181032 0 -2225 0.6603777903850399 1.525662481711951 0 -2226 0.245391803708043 1.839016074433248 0 -2227 0.3536320252392992 1.100940444907367 0 -2228 0.430124478536677 1.339336612917217 0 -2229 0.8981725405470772 1.404937256092329 0 -2230 0.7056960397471062 1.966866997920286 0 -2231 0.7065906866764419 1.022438731214329 0 -2232 0.2012001018747546 1.296400206811763 0 -2233 0.5382723984422578 1.056627237162958 0 -2234 0.3798666203494291 1.310251258741632 0 -2235 0.3990227367746531 1.310108703462735 0 -2236 0.9117525192661133 1.64479300902244 0 -2237 0.4951810597463845 1.008451206003383 0 -2238 0.3856346040606316 1.008168370836947 0 -2239 0.2087041922933102 1.662087307904705 0 -2240 0.3500211561285503 1.315240935638154 0 -2241 0.3672262886427102 1.043981484963431 0 -2242 0.1857050544428206 1.00959084544459 0 -2243 0.8142949455562938 1.009590845444634 0 -2244 0.5509801862589658 1.272620855548112 0 -2245 0.2140945244988742 1.098129765853059 0 -2246 0.7859054755000723 1.098129765853532 0 -2247 0.4021674146340235 1.696762127597667 0 -2248 0.5147155367269787 1.008293638884416 0 -2249 0.4369845258039767 1.165050585233715 0 -2250 0.5206700377111164 1.138172889735004 0 -2251 0.546795981103024 1.224721312396716 0 -2252 0.3025089281790439 1.368300007658468 0 -2253 0.2341126445558551 1.518265510477182 0 -2254 0.4356367600180777 1.226413554981793 0 -2255 0.2369969387214383 1.023583745817155 0 -2256 0.7630030612773915 1.023583745817285 0 -2257 0.4559812611581235 1.320533350905662 0 -2258 0.2335734519951339 1.681423422958383 0 -2259 0.4292872480628778 1.671242647141369 0 -2260 0.264472788858505 1.410511893550946 0 -2261 0.2571714983681211 1.31441854883512 0 -2262 0.6033216968307413 1.300647053559742 0 -2263 0.370079851951482 1.91253016377385 0 -2264 0.6794529692814966 1.490715166827631 0 -2265 0.647840151516906 1.635057466727348 0 -2266 0.06135947373672783 1.023243990569141 0 -2267 0.9386405262629929 1.02324399056925 0 -2268 0.6248662932447063 1.044861339047427 0 -2269 0.5986620587730942 1.107755736277664 0 -2270 0.7548265455407078 1.644886179436472 0 -2271 0.009383231058508435 1.094546769210551 0 -2272 0.9906167689415144 1.094546769210673 0 -2273 0.1134398551864522 1.071915810670201 0 -2274 0.8865601448130263 1.071915810670512 0 -2275 0.1205171102691512 1.009444704192922 0 -2276 0.879482889730312 1.00944470419296 0 -2277 0.0489887744904819 1.237643560973488 0 -2278 0.9510033134008493 1.237540097751186 0 -2279 0.2688866197010794 1.778305656566948 0 -2280 0.2957130783744299 1.432191137037003 0 -2281 0.08170306107622252 1.190003637189627 0 -2282 0.9182969389240309 1.190003637189772 0 -2283 0.0265612515232721 1.669183113035363 0 -2284 0.2774339130464847 1.271072567261085 0 -2285 0.3620069931151046 1.125667785784697 0 -2286 0.9586595902743323 1.436468808681142 0 -2287 0.7583855466338468 1.795021702291691 0 -2288 0.109669217838644 1.168406388612293 0 -2289 0.8903307821612053 1.168406388612989 0 -2290 0.4257808632309708 1.267606317903767 0 -2291 0.5692392034793637 1.965073394678322 0 -2292 0.717005996876628 1.485352536021845 0 -2293 0.3842787205213968 1.257130098686424 0 -2294 0.9770491638045107 1.593205418819539 0 -2295 0.7237512723442916 1.609343430199297 0 -2296 0.6523260756385681 1.692825755796842 0 -2297 0.6415398522969602 1.055835752825549 0 -2298 0.6473866148370341 1.06562704554478 0 -2299 0.1439734553980161 1.24702207557063 0 -2300 0.9215455716191034 1.462096544002173 0 -2301 0.1546656494557317 1.118004125443832 0 -2302 0.8453343505435619 1.118004125444394 0 -2303 0.8450882357943197 1.38766758924316 0 -2304 0.09526390365603181 1.024926589485136 0 -2305 0.9047360963435404 1.024926589485246 0 -2306 0.9751489074892264 1.71003651193841 0 -2307 0.483382295349191 1.024440346686145 0 -2308 0.5201125974092214 1.51138207790068 0 -2309 0.6924461965592059 1.429243527648868 0 -2310 0.4642437143912083 1.339026206342744 0 -2311 0.3049183415756433 1.008461664762768 0 -2312 0.3118390138473546 1.225711787092636 0 -2313 0.2648776171657372 1.074498456311161 0 -2314 0.735122382832928 1.074498456311559 0 -2315 0.8951581107698734 1.836584734264075 0 -2316 0.1217895541052448 1.211672378617253 0 -2317 0.8782282343793661 1.211098546470539 0 -2318 0.06641206891134892 1.172700183373423 0 -2319 0.9335879310887987 1.17270018337351 0 -2320 0.1073717434058908 1.218946756730697 0 -2321 0.8913038602959973 1.217798449821929 0 -2322 0.2846807038366894 1.143647967582996 0 -2323 0.713041527093548 1.143860802479325 0 -2324 0.1268629993010217 1.337553309125638 0 -2325 0.05709561234444471 1.190760650216339 0 -2326 0.9429043876557501 1.190760650216474 0 -2327 0.5520622519351621 1.406305628507964 0 -2328 0.5842457084275658 1.475504564103277 0 -2329 0.3505918093717602 1.293557554188062 0 -2330 0.1916210558857136 1.140032387424628 0 -2331 0.8083789441133791 1.140032387425264 0 -2332 0.2077155698757716 1.025156481557727 0 -2333 0.7922844301232447 1.025156481557845 0 -2334 0.3637298281476182 1.083497409541887 0 -2335 0.5218386483709547 1.395909361987244 0 -2336 0.2463899594886432 1.084139678373507 0 -2337 0.7536100405101218 1.08413967837395 0 -2338 0.5087632245543942 1.034503281659485 0 -2339 0.802096146906212 1.339519855560701 0 -2340 0.4450712517349534 1.072739927785263 0 -2341 0.344292075680827 1.201122594483379 0 -2342 0.2245335632221269 1.278277771774352 0 -2343 0.4981555014409521 1.088601459809012 0 -2344 0.4236870496346242 1.099704839301133 0 -2345 0.7268906318502145 1.356444381904256 0 -2346 0.6580110871678138 1.363469687951121 0 -2347 0.6444483296814207 1.120136138480627 0 -2348 0.206500046888421 1.59263244337669 0 -2349 0.4636924260648623 1.173488488079738 0 -2350 0.2654646572918291 1.008445754448973 0 -2351 0.7345353427068364 1.008445754449022 0 -2352 0.3265014877061418 1.359338834767213 0 -2353 0.6762687079588712 1.393569658200308 0 -2354 0.9811095987413255 1.511835631740009 0 -2355 0.01315927290548044 1.192460494600644 0 -2356 0.9868407270945394 1.192460494600732 0 -2357 0.6952476703046778 1.008855766010172 0 -2358 0.2661990976369464 1.32899360584412 0 -2359 0.4606967727407756 1.080262989742472 0 -2360 0.4179054261309286 1.490960253609345 0 -2361 0.4497968842408223 1.769685215744619 0 -2362 0.3389250621454352 1.388762446921705 0 -2363 0.3814697860675392 1.035982892395799 0 -2364 0.3013584124700316 1.091348106485285 0 -2365 0.6986245748487731 1.091321212329855 0 -2366 0.2767236146962959 1.165620086925194 0 -2367 0.7226534770979616 1.166520336546416 0 -2368 0.5337444050254593 1.33397028841418 0 -2369 0.5959306874797072 1.096252333343265 0 -2370 0.6836804341957428 1.813088233286651 0 -2371 0.8287839974984158 1.519635857113617 0 -2372 0.5998863768721036 1.145069322781776 0 -2373 0.0406490703173942 1.077659850433175 0 -2374 0.9593509296824165 1.077659850433543 0 -2375 0.2190098595493452 1.069222901724268 0 -2376 0.7809901404495685 1.069222901724616 0 -2377 0.08733254541050008 1.008803615701622 0 -2378 0.9126674545891079 1.008803615701655 0 -2379 0.2173543957771154 1.49837315237014 0 -2380 0.6330061775108567 1.188287088854407 0 -2381 0.6308747319545311 1.008514558289734 0 -2382 0.09206982873417487 1.069350357251731 0 -2383 0.9079301712654164 1.069350357252031 0 -2384 0.1516569801493239 1.202556509649534 0 -2385 0.01552004091228306 1.437256683320709 0 -2386 0.8483528092033974 1.20241870995643 0 -2387 0.02977943533127755 1.867048694239952 0 -2388 0.1327707255350447 1.081032376661927 0 -2389 0.8672292744643423 1.081032376662292 0 -2390 0.6143544677023551 1.723287235189883 0 -2391 0.2828958165869668 1.007954474588847 0 -2392 0.7170742505100419 1.007968470418093 0 -2393 0.6816327337084717 1.630045117136917 0 -2394 0.4347966875263482 1.036496886568068 0 -2395 0.6212887283138765 1.301964830951968 0 -2396 0.1470557202360741 1.917220080289103 0 -2397 0.5750963357773513 1.901911764417661 0 -2398 0.5751126276669639 1.035450141720274 0 -2399 0.9868815746977937 1.227526224792475 0 -2400 0.3158062981237815 1.529930065561749 0 -2401 0.5373512268506833 1.153856641137126 0 -2402 0.07488271101506541 1.506248703292401 0 -2403 0.3628903642233461 1.025794691740807 0 -2404 0.1443088065002906 1.024777956481689 0 -2405 0.8556911934990445 1.024777956481807 0 -2406 0.0607819156414147 1.282940049343619 0 -2407 0.6513752964619469 1.294492809119977 0 -2408 0.5128246276479598 1.88282551548083 0 -2409 0.2115606447741488 1.310436033681391 0 -2410 0.1105575221893233 1.095556962196495 0 -2411 0.8894424778101364 1.095556962196898 0 -2412 0.8668423050189283 1.290685897985153 0 -2413 0.8477850056084667 1.291328515433773 0 -2414 0.6576014023897282 1.205460001679072 0 -2415 0.5174404449227227 1.057377587203173 0 -2416 0.5796255608677263 1.313062082509097 0 -2417 0.2297736655304172 1.208372092822526 0 -2418 0.4127515621233034 1.377753413080143 0 -2419 0.7256206039629089 1.439936279134227 0 -2420 0.6556605726084838 1.102288907934563 0 -2421 0.7175689562404489 1.220932072636383 0 -2422 0.697421629061731 1.201172393001228 0 -2423 0.5346853865425205 1.213530776419037 0 -2424 0.4042946220073286 1.094608865799074 0 -2425 0.3802200732768813 1.071136532231312 0 -2426 0.698927220805335 1.318634077608448 0 -2427 0.8963414791753435 1.435000473311314 0 -2428 0.04060830863109199 1.355708508230532 0 -2429 0.483009615102541 1.165931114740444 0 -2430 0.7819834862331816 1.387428856356128 0 -2431 0.4946713975984484 1.077556774412957 0 -2432 0.43579161692004 1.910885478095247 0 -2433 0.3664873227226103 1.618284690680676 0 -2434 0.2660920317846424 1.118521323051379 0 -2435 0.733907968214054 1.118521323051987 0 -2436 0.7333017283096598 1.407803041538581 0 -2437 0.5434344444458639 1.466586446096726 0 -2438 0.1084641515809967 1.488886667711622 0 -2439 0.8333726130297561 1.685906100322729 0 -2440 0.06426240905092909 1.129424987982342 0 -2441 0.935737590948744 1.129424987982568 0 -2442 0.5227111313346383 1.177624183859562 0 -2443 0.288205862710769 1.195401811311246 0 -2444 0.691180416808395 1.455751973782095 0 -2445 0.5137808638311128 1.103952643389808 0 -2446 0.9669772807958988 1.271286970488561 0 -2447 0.1011827234355184 1.133950863803468 0 -2448 0.8988172765641812 1.133950863804081 0 -2449 0.06432379583407943 1.054920096304593 0 -2450 0.9356762041656257 1.054920096304852 0 -2451 0.1671352718783606 1.201382908862429 0 -2452 0.8333496878351739 1.200910990898491 0 -2453 0.8334431353372178 1.353752967968184 0 -2454 0.9826961612826518 1.460882419695907 0 -2455 0.3347234962956788 1.322537733508801 0 -2456 0.1888835345691721 1.247136318413714 0 -2457 0.201199918520275 1.327515173994747 0 -2458 0.047608747939825 1.418705795349814 0 -2459 0.1421131389231776 1.469891553039637 0 -2460 0.4736451880142024 1.26955045356819 0 -2461 0.1864848443756276 1.82580443035625 0 -2462 0.8635862349904041 1.344291048158857 0 -2463 0.607858238172303 1.378161770341 0 -2464 0.2134684806521862 1.043611974452363 0 -2465 0.7865315193467725 1.043611974452588 0 -2466 0.2170697885937288 1.261972679641198 0 -2467 0.6653327885673148 1.112583618089412 0 -2468 0.4028480559693264 1.031980948436563 0 -2469 0.01306918268954506 1.227506249800406 0 -2470 0.5706896709283737 1.051529441131618 0 -2471 0.2940544974538614 1.473889395584197 0 -2472 0.1103949300739344 1.816076851287972 0 -2473 0.4004694185305982 1.081362101846985 0 -2474 0.6116894790062615 1.809535577550265 0 -2475 0.7125372984926814 1.189879436968841 0 -2476 0.4950925463465343 1.131563329329821 0 -2477 0.673600724589354 1.424745730861811 0 -2478 0.7679311319821593 1.245427047958923 0 -2479 0.5278155936671252 1.073725558412694 0 -2480 0.5647537920816906 1.22235090384175 0 -2481 0.3182142201352389 1.038267744136485 0 -2482 0.7307105340819755 1.24460143968555 0 -2483 0.5052220355286432 1.322112889385458 0 -2484 0.2080602466202005 1.449930318978343 0 -2485 0.1223013727918149 1.679223472738413 0 -2486 0.2297431815266326 1.053327412069824 0 -2487 0.7702568184722273 1.053327412070121 0 -2488 0.2914727956908776 1.877361294072467 0 -2489 0.1128295332170542 1.257829635235314 0 -2490 0.5572526768897683 1.068871194445014 0 -2491 0.6886563521083723 1.365225127920008 0 -2492 0.9201258078599812 1.541350921646632 0 -2493 0.7477565761416181 1.920518225563881 0 -2494 0.4592102675916969 1.060675288033551 0 -2495 0.06685791667303886 1.335875473456547 0 -2496 0.6189873652577433 1.481370800431678 0 -2497 0.8561392263921054 1.265784804462159 0 -2498 0.9778842768414369 1.764106022422698 0 -2499 0.9077682474679726 1.326766493657349 0 -2500 0.2400966280348704 1.628466649581014 0 -2501 0.4004307598922787 1.759126097460738 0 -2502 0.2169448201779346 1.13870751439649 0 -2503 0.7830551798210181 1.138707514397156 0 -2504 0.3223386752368323 1.109626179197909 0 -2505 0.5310420778216919 1.096229406795321 0 -2506 0.3066886690121686 1.667638168593698 0 -2507 0.4047946604028866 1.048093302673197 0 -2508 0.02638778293257049 1.139666719507557 0 -2509 0.9736122170674596 1.139666719507826 0 -2510 0.3191513618747654 1.550520679452815 0 -2511 0.1486540545378149 1.381354277263337 0 -2512 0.2658860648783699 1.444301894815109 0 -2513 0.2344685259676118 1.337595098368086 0 -2514 0.3548672646901477 1.042681314115025 0 -2515 0.2549999999993979 1.007287926784018 0 -2516 0.7449999999993338 1.007287926784064 0 -2517 0.5550215240543818 1.792579410126008 0 -2518 0.1259407089873475 1.607450016704592 0 -2519 0.5154191742448895 1.336516639615168 0 -2520 0.3424096883067851 1.892405460799233 0 -2521 0.9105603993720903 1.719417359195687 0 -2522 0.491454738942629 1.20617921794475 0 -2523 0.6732263419553889 1.022299263980984 0 -2524 0.7430580752959772 1.20260102690801 0 -2525 0.1039099014739094 1.193661257526501 0 -2526 0.896090098526272 1.193661257527041 0 -2527 0.6846852872809485 1.224446181225649 0 -2528 0.8207689912389049 1.558269157343574 0 -2529 0.9392746459407867 1.335927085252018 0 -2530 0.379367471238798 1.153223991895915 0 -2531 0.5720940361450669 1.443410919372026 0 -2532 0.7013456790211355 1.152270471296674 0 -2533 0.5298620938251043 1.288745818290119 0 -2534 0.6363029879174498 1.128476598153378 0 -2535 0.6672184715967526 1.008419341751467 0 -2536 0.196585270431983 1.618133493555558 0 -2537 0.5804299184411017 1.686271262535574 0 -2538 0.6931899798368829 1.17652197360088 0 -2539 0.2346353876000118 1.583881108971837 0 -2540 0.08521620556081834 1.027738039394153 0 -2541 0.9147837944387944 1.027738039394278 0 -2542 0.6246996730273499 1.146432601727515 0 -2543 0.4599707566434424 1.5099051811675 0 -2544 0.2792751343594291 1.043557490500691 0 -2545 0.7207256856912051 1.04355939371038 0 -2546 0.3400363126671407 1.23289961771773 0 -2547 0.1499176889434355 1.092036808942738 0 -2548 0.8500823110558688 1.092036808943163 0 -2549 0.855581027742098 1.648764974182349 0 -2550 0.1053949332094417 1.53955918550553 0 -2551 0.8282007383357128 1.252590037115486 0 -2552 0.3099346299457577 1.062399834998713 0 -2553 0.08138930525559313 1.469273180661253 0 -2554 0.07858807124297797 1.258722840546687 0 -2555 0.9235162067448727 1.25774658665901 0 -2556 0.6704309120100591 1.710057776059305 0 -2557 0.2058741041496006 1.058717842698004 0 -2558 0.7941258958493975 1.058717842698295 0 -2559 0.02688037153822537 1.019263096542427 0 -2560 0.973119628461658 1.019263096542486 0 -2561 0.81468299209774 1.376795747251186 0 -2562 0.4034166702609964 1.147140839771551 0 -2563 0.7801865265424012 1.844426025993615 0 -2564 0.6150339681149277 1.00736353804205 0 -2565 0.294938978290965 1.052502766958926 0 -2566 0.7050460714426577 1.052518687096704 0 -2567 0.7319287368217113 1.63574421567549 0 -2568 0.3340946506599562 1.093147791460886 0 -2569 0.4404316102494155 1.052949799364807 0 -2570 0.9047938223845702 1.491835355842626 0 -2571 0.4256619298075464 1.184401828401098 0 -2572 0.6211206450997407 1.330267389266602 0 -2573 0.1250073282127057 1.028011614476925 0 -2574 0.8749926717867289 1.028011614477054 0 -2575 0.3200190013282347 1.781414700543657 0 -2576 0.9189731193720814 1.275265309291993 0 -2577 0.6901067559151041 1.062467578741231 0 -2578 0.304055937200396 1.289722891444562 0 -2579 0.9860693992169491 1.353364625741588 0 -2580 0.3593263150821457 1.342773246238401 0 -2581 0.05944852326034498 1.152965412381895 0 -2582 0.9405514767395645 1.152965412382083 0 -2583 0.7843952779556428 1.882808212907494 0 -2584 0.6324906271196172 1.828195344923558 0 -2585 0.7032001696686101 1.398133290621532 0 -2586 0.06652196976942409 1.835355425494591 0 -2587 0.2097049418753495 1.188455123909301 0 -2588 0.7905936788947983 1.189280018006007 0 -2589 0.5225412693386131 1.600025226039479 0 -2590 0.6798486513412809 1.038107170495391 0 -2591 0.02387478382974286 1.08249634857144 0 -2592 0.9761252161701999 1.082496348571754 0 -2593 0.2779597660864515 1.300678141243776 0 -2594 0.2591217727801293 1.643836903572349 0 -2595 0.7598104551748428 1.551387239951554 0 -2596 0.2889307224182623 1.409949581561286 0 -2597 0.8659438368155949 1.452599915930364 0 -2598 0.4907876541050186 1.352792237830689 0 -2599 0.01498046318300802 1.37349319841058 0 -2600 0.03763922292149573 1.008690344082199 0 -2601 0.9623607770783348 1.008690344082235 0 -2602 0.876632603190035 1.78641928485738 0 -2603 0.8630308744054651 1.562389319726338 0 -2604 0.2933484794348677 1.18082329088673 0 -2605 0.2767919312146016 1.071942282721758 0 -2606 0.3386817151504491 1.716255984530099 0 -2607 0.7232080687840086 1.071942282722145 0 -2608 0.5890315869114644 1.067771595000768 0 -2609 0.7348014888143021 1.228514209363373 0 -2610 0.2496449407004006 1.134574501694504 0 -2611 0.7503550592983742 1.134574501695211 0 -2612 0.6132807059574744 1.924574955876986 0 -2613 0.5201440961598349 1.275999181418699 0 -2614 0.2326648371431266 1.293406394049293 0 -2615 0.1991458628670774 1.96671147504198 0 -2616 0.4374489440809444 1.857404545720575 0 -2617 0.3998859097555322 1.615600570843229 0 -2618 0.02763755847059179 1.188612713552259 0 -2619 0.9723624415294598 1.188612713552409 0 -2620 0.8948036635915393 1.918358328030976 0 -2621 0.6430969430320795 1.022257488351416 0 -2622 0.4219382215270147 1.882488030584234 0 -2623 0.3037267957583709 1.257293440284194 0 -2624 0.576076272208203 1.366954312861611 0 -2625 0.8404191490518897 1.227458673558944 0 -2626 0.2218862152882494 1.019309457166607 0 -2627 0.7781137847106706 1.019309457166717 0 -2628 0.9276243651134165 1.34694280496324 0 -2629 0.06823376491010882 1.199151441126167 0 -2630 0.9317661614507545 1.19915160720702 0 -2631 0.676697511644481 1.923780393053954 0 -2632 0.3950165720325161 1.059971105785633 0 -2633 0.9484162675011533 1.600159769019392 0 -2634 0.698359853853734 1.523096517748169 0 -2635 0.9271563152895147 1.430112539820764 0 -2636 0.4212115752165234 1.110605771996282 0 -2637 0.481729067655641 1.339322306190931 0 -2638 0.410299444455764 1.268669934134591 0 -2639 0.1313749050839675 1.116432713163102 0 -2640 0.8686250949154555 1.116432713163635 0 -2641 0.08552080732061212 1.058498278524766 0 -2642 0.9144791926789948 1.058498278525015 0 -2643 0.3685818410387591 1.266012443924983 0 -2644 0.5024870819690308 1.777413477316763 0 -2645 0.1851803169822588 1.302073384235638 0 -2646 0.5403604092217136 1.260183869263166 0 -2647 0.4093020974519384 1.645491930749867 0 -2648 0.4311431729614566 1.254213630021399 0 -2649 0.2677819516394609 1.173699374978892 0 -2650 0.7322180483592285 1.173699374979808 0 -2651 0.06609118493186687 1.00771389030964 0 -2652 0.9339088150678417 1.007713890309675 0 -2653 0.886333600527577 1.486856373894653 0 -2654 0.1870477402856157 1.189235924520833 0 -2655 0.8129884766171266 1.189430282651496 0 -2656 0.4473228753812691 1.213683908573492 0 -2657 0.2746457085800106 1.531820895213034 0 -2658 0.8504795284220902 1.803595370621843 0 -2659 0.6411313163706881 1.089385539461865 0 -2660 0.1915064933455573 1.019017877247363 0 -2661 0.8084935066535319 1.019017877247449 0 -2662 0.8298899189533036 1.266217949728847 0 -2663 0.670943415912441 1.182607191556009 0 -2664 0.7709272669960461 1.526429200341188 0 -2665 0.785584344950767 1.970392710009836 0 -2666 0.1972581687909536 1.182075555886863 0 -2667 0.8028128642231392 1.182253555053612 0 -2668 0.3821202536900856 1.459636329343728 0 -2669 0.3292816911051026 1.183302337965912 0 -2670 0.3762046127783428 1.110092919710277 0 -2671 0.02490035216207662 1.643795677999869 0 -2672 0.3939766203587988 1.789561675407629 0 -2673 0.6733241855370542 1.166082174356053 0 -2674 0.4237832213186445 1.007298794383973 0 -2675 0.4425854805748365 1.352237802952996 0 -2676 0.6117750087707944 1.406932243873857 0 -2677 0.1492977266574467 1.016045059769873 0 -2678 0.8507022733418605 1.016045059769946 0 -2679 0.7459081625918377 1.360701508648281 0 -2680 0.1202013868247774 1.632031624687146 0 -2681 0.04435793157129748 1.381730065024117 0 -2682 0.4924779926680551 1.411668049949156 0 -2683 0.5455868774917915 1.085322098313106 0 -2684 0.4226062835544963 1.2404640922895 0 -2685 0.03762297543597007 1.262544401207915 0 -2686 0.3414063147641791 1.187075258547122 0 -2687 0.4888055337200645 1.323491481494812 0 -2688 0.2140062695843855 1.007290760395776 0 -2689 0.785993730414567 1.007290760395818 0 -2690 0.0952717258761891 1.238162577061232 0 -2691 0.9059949101832974 1.238901118740743 0 -2692 0.1599095202371173 1.073871276751049 0 -2693 0.8400904797621289 1.073871276751405 0 -2694 0.01854946807793103 1.48230131191092 0 -2695 0.2894496678610404 1.569945309058891 0 -2696 0.3244282302742709 1.007632226875165 0 -2697 0.3267767272415669 1.165379983947205 0 -2698 0.5804611360294702 1.114339465561189 0 -2699 0.7346634671933665 1.540063909171378 0 -2700 0.4787860365311311 1.560280106802425 0 -2701 0.6436781235358668 1.108897743654242 0 -2702 0.1777570062389003 1.02557585838108 0 -2703 0.8222429937602531 1.025575858381215 0 -2704 0.7541539702357625 1.686233058625092 0 -2705 0.4203058672629181 1.514379946323455 0 -2706 0.02534809005594198 1.763874793561482 0 -2707 0.7258186323090416 1.274787962612752 0 -2708 0.4610870895891317 1.973586381790231 0 -2709 0.5006408496116438 1.250595077759769 0 -2710 0.1252708518528679 1.054545958569082 0 -2711 0.8747291481465558 1.054545958569328 0 -2712 0.03938391277717404 1.094740966249867 0 -2713 0.9606160872226537 1.094740966250186 0 -2714 0.5675715044348002 1.338982802992977 0 -2715 0.6642131036752703 1.270936836965853 0 -2716 0.4653577351625374 1.293180948359519 0 -2717 0.5607178726647342 1.038534804026929 0 -2718 0.1413952707015503 1.062774869411188 0 -2719 0.8586047292978228 1.06277486941148 0 -2720 0.2629514090997688 1.099111045321375 0 -2721 0.7370485908989451 1.099111045321879 0 -2722 0.5533474158556826 1.309003220629826 0 -2723 0.4117313843256126 1.168740002490928 0 -2724 0.4460962096700886 1.625092662968165 0 -2725 0.4367187179516349 1.547886036725576 0 -2726 0.4657287356498001 1.052263821581162 0 -2727 0.6582638640048655 1.184514126378541 0 -2728 0.2530147486726955 1.022407860094514 0 -2729 0.7469852513260371 1.022407860094647 0 -2730 0.6286855802512056 1.236472307303276 0 -2731 0.2346870324814782 1.008455640612283 0 -2732 0.7653129675173608 1.008455640612327 0 -2733 0.3623299169758621 1.371269289813307 0 -2734 0.2889156923740188 1.350197530891613 0 -2735 0.2628842651513345 1.233686474352008 0 -2736 0.5827308655895163 1.095931231145731 0 -2737 0.2198562118521974 1.035376208241158 0 -2738 0.7801437881467311 1.035376208241353 0 -2739 0.1649439339150396 1.007097116786803 0 -2740 0.8350560660841868 1.007097116786832 0 -2741 0.4674294458929631 1.368531629431262 0 -2742 0.7510718586353879 1.411701651929033 0 -2743 0.02401251706849928 1.166794279087094 0 -2744 0.9759874829315841 1.166794279087261 0 -2745 0.2466205164482834 1.029667639778234 0 -2746 0.7533794835504892 1.029667639778406 0 -2747 0.8339034125695897 1.874604190131635 0 -2748 0.4670232220185516 1.474249282569385 0 -2749 0.5818996969213007 1.157580528045311 0 -2750 0.4755516073958432 1.045532826559348 0 -2751 0.18185811625555 1.31786302214069 0 -2752 0.3660827041517126 1.290387914974962 0 -2753 0.761347650185163 1.387356050377003 0 -2754 0.1593215058851385 1.10703142280523 0 -2755 0.840678494114118 1.107031422805699 0 -2756 0.3262456057269053 1.023485044590965 0 -2757 0.7503422027858173 1.291267892963433 0 -2758 0.05337380909562552 1.031553237302947 0 -2759 0.9466261909041291 1.031553237303092 0 -2760 0.057469119032688 1.164891440853474 0 -2761 0.9425308809673754 1.164891440853636 0 -2762 0.2172854963499038 1.213468036424039 0 -2763 0.00753977974051773 1.036836690729115 0 -2764 0.992460220259445 1.036836690729158 0 -2765 0.4665512416283742 1.910537931454778 0 -2766 0.3105813620514997 1.333884865997126 0 -2767 0.3083359811803948 1.180650605104522 0 -2768 0.4999545142939948 1.020019218895563 0 -2769 0.375454053643587 1.213565494941158 0 -2770 0.2882740691481924 1.038693200068688 0 -2771 0.7117270581509294 1.03870218211657 0 -2772 0.3734965725812673 1.020574356973204 0 -2773 0.8584488564777401 1.831526508145217 0 -2774 0.6063722870080076 1.861877760775427 0 -2775 0.1048732388192985 1.006396257793335 0 -2776 0.8951267611802314 1.006396257793362 0 -2777 0.7698037716173323 1.446289070704977 0 -2778 0.3150259190505175 1.464130264978701 0 -2779 0.3511073643217986 1.478357842447523 0 -2780 0.2017540524818569 1.017578900664085 0 -2781 0.7982459475171761 1.017578900664174 0 -2782 0.1432206599035693 1.081823017383028 0 -2783 0.8567793400957614 1.081823017383404 0 -2784 0.2467573028157113 1.121479810277247 0 -2785 0.598982477813105 1.623493347318789 0 -2786 0.7532426971830887 1.121479810277866 0 -2787 0.5104761191247543 1.017782964951546 0 -2788 0.08352842493676289 1.272942110041936 0 -2789 0.5079278233240452 1.351475738625013 0 -2790 0.05448194057721629 1.674196219511389 0 -2791 0.2702342992012707 1.358671229552355 0 -2792 0.2584473023736181 1.152693716025776 0 -2793 0.7822432403505836 1.337056146754361 0 -2794 0.741523086286513 1.152741155844497 0 -2795 0.5237021034766426 1.238858713450787 0 -2796 0.5854356284949629 1.236655533432351 0 -2797 0.1964365575924616 1.071869859051953 0 -2798 0.8035634424065857 1.071869859052315 0 -2799 0.5488965021084053 1.288599088065097 0 -2800 0.06948497133683337 1.356538680878103 0 -2801 0.2949810032824935 1.146757639455889 0 -2802 0.5626405882755808 1.144069798178987 0 -2803 0.6883271313792545 1.239393636035811 0 -2804 0.7993223259900448 1.308268471045901 0 -2805 0.5892871855207226 1.020230775547619 0 -2806 0.3801831290786846 1.339837230304242 0 -2807 0.9358442976149552 1.38139197208213 0 -2808 0.2870536564611025 1.028405294063754 0 -2809 0.6590110032183223 1.081164115065105 0 -2810 0.7134521297784242 1.028330391533875 0 -2811 0.7191171460095185 1.561002005161688 0 -2812 0.4157424834940389 1.13143596515865 0 -2813 0.3715396502219074 1.051957329785141 0 -2814 0.5046557810415299 1.122178850554884 0 -2815 0.3162331814826231 1.422801759355729 0 -2816 0.1016589318909385 1.179710114147281 0 -2817 0.8983410681090872 1.17971011414779 0 -2818 0.1596154694115436 1.153170892600329 0 -2819 0.8403845305876794 1.153170892601049 0 -2820 0.6485752951168573 1.312109092438454 0 -2821 0.6717524080245076 1.053674909909382 0 -2822 0.1713853371459996 1.252240846138065 0 -2823 0.4005658952386686 1.409139619352801 0 -2824 0.9294775333219978 1.854771955760222 0 -2825 0.1908950826018478 1.272409381268901 0 -2826 0.6607329680707571 1.061338263785553 0 -2827 0.1334046027866478 1.971905366770341 0 -2828 0.4231755304273396 1.079893895547409 0 -2829 0.1941488857526259 1.36150428900243 0 -2830 0.7796964269440891 1.316692330375459 0 -2831 0.598269665166175 1.273501324314886 0 -2832 0.1026720586457845 1.11481619593721 0 -2833 0.516708826836367 1.25163639701923 0 -2834 0.8973279413537272 1.114816195937673 0 -2835 0.881305893337626 1.249602066224565 0 -2836 0.3331660648725014 1.112853667476421 0 -2837 0.7492168944309157 1.471624278219516 0 -2838 0.3505935001593734 1.172894141054609 0 -2839 0.03900599805737198 1.037871362443797 0 -2840 0.9609940019424514 1.037871362443979 0 -2841 0.1858260091508975 1.41871928032299 0 -2842 0.5687647776811359 1.379257755082687 0 -2843 0.9220580040000598 1.765583076378356 0 -2844 0.9396285639384199 1.498903633006723 0 -2845 0.7769942119766137 1.22737775318183 0 -2846 0.9396922731971658 1.675581473106377 0 -2847 0.9313277656060316 1.968385325334156 0 -2848 0.4195426418798375 1.936359361085945 0 -2849 0.6312927660414346 1.252861168828801 0 -2850 0.3643805930657786 1.193896051494866 0 -2851 0.059393463003176 1.755021404206746 0 -2852 0.2101047399856204 1.147495561611076 0 -2853 0.7898952600133502 1.147495561611751 0 -2854 0.5241869105064323 1.116714258927648 0 -2855 0.4135266998975591 1.016633187570962 0 -2856 0.68641570903661 1.659613183656362 0 -2857 0.9658890197184886 1.342925348269771 0 -2858 0.07115646171733639 1.148546398648356 0 -2859 0.9288435382823026 1.148546398648545 0 -2860 0.2897663234243298 1.168553349863917 0 -2861 0.417534666429404 1.038737586897918 0 -2862 0.2349622537745057 1.148338909913371 0 -2863 0.665876260568999 1.029166616203806 0 -2864 0.7650377462243316 1.148338909914103 0 -2865 0.385957841209587 1.017321545648354 0 -2866 0.8628091854317986 1.323777363883258 0 -2867 0.5951057499927664 1.313800449733704 0 -2868 0.1172413439426848 1.132745435918073 0 -2869 0.8827586560568293 1.132745435918698 0 -2870 0.3820264553449433 1.240819389194221 0 -2871 0.2095753723637706 1.846389486602504 0 -2872 0.7863461830261411 1.210930870721902 0 -2873 0.5715966479904148 1.235382524467846 0 -2874 0.5640454308261659 1.084685283169291 0 -2875 0.1387499972860813 1.127663899273432 0 -2876 0.8612500027133079 1.127663899274012 0 -2877 0.7806620493699954 1.418064635420868 0 -2878 0.629543135234943 1.072551734643087 0 -2879 0.4898458320442233 1.297211485431618 0 -2880 0.08725613884094617 1.383529712448756 0 -2881 0.3384580962492686 1.062041420669449 0 -2882 0.7126536059243005 1.299634188443179 0 -2883 0.7233477148870193 1.860586748210058 0 -2884 0.4751101182558506 1.761839760251274 0 -2885 0.2166022677776669 1.02631066321107 0 -2886 0.7833977322212846 1.026310663211207 0 -2887 0.1074970413413924 1.310477656487091 0 -2888 0.6468514855092317 1.88415519239545 0 -2889 0.6550209969728054 1.044297712223042 0 -2890 0.3096126098389106 1.017393289262932 0 -2891 0.2274158805659109 1.481145629555492 0 -2892 0.5533783639811831 1.101075512822319 0 -2893 0.03606418746939674 1.19884048931426 0 -2894 0.9639358125306372 1.198840489314458 0 -2895 0.05443254946452088 1.805787267380786 0 -2896 0.2498648128212545 1.713725657657329 0 -2897 0.7438871139722667 1.25125253349348 0 -2898 0.07521216225540725 1.309841488193657 0 -2899 0.8064582494878244 1.27344700810216 0 -2900 0.2804391005947892 1.087997788968355 0 -2901 0.7195608994037967 1.087997788968832 0 -2902 0.4849116177332676 1.630282341215658 0 -2903 0.3469888981154782 1.007442197267729 0 -2904 0.5259416593806885 1.02096153025492 0 -2905 0.388925130057464 1.043003179875413 0 -2906 0.03488622832058046 1.296534486954882 0 -2907 0.4986002351729686 1.232704500037788 0 -2908 0.4109275730836957 1.296051242434567 0 -2909 0.8670153686548974 1.361326715179295 0 -2910 0.5693816089716413 1.112654299399059 0 -2911 0.5560366374406496 1.494031332844624 0 -2912 0.7122331619793438 1.826896612592065 0 -2913 0.4074619807988046 1.361064730636741 0 -2914 0.5858001539050828 1.261261927787994 0 -2915 0.1486309772180805 1.217977558481729 0 -2916 0.3803059278206488 1.36928802292461 0 -2917 0.5940556946732789 1.202868739008952 0 -2918 0.7788522726677783 1.478549569425795 0 -2919 0.209847347480915 1.236418908838099 0 -2920 0.06618227292412564 1.119043338400828 0 -2921 0.9338177270755058 1.119043338401132 0 -2922 0.383779909482824 1.118516391900252 0 -2923 0.5906078230829918 1.077531643665177 0 -2924 0.3716903728307409 1.091473085898907 0 -2925 0.3138181900313047 1.166162775024738 0 -2926 0.4503177597531201 1.578903177925705 0 -2927 0.5085934567209156 1.727568685387252 0 -2928 0.4821527048223911 1.064040821624142 0 -2929 0.04920734305025304 1.145969435633829 0 -2930 0.9507926569496949 1.145969435634112 0 -2931 0.5012906419242744 1.030662086614818 0 -2932 0.4549941012133137 1.006546547005247 0 -2933 0.3506546844418877 1.772543853306129 0 -2934 0.6661777840374016 1.22553799261101 0 -2935 0.3982190405345465 1.524002023824426 0 -2936 0.1770758229450258 1.066838406138642 0 -2937 0.8229241770541227 1.066838406138972 0 -2938 0.2647528471061499 1.05679086312177 0 -2939 0.7352471528925172 1.056790863122069 0 -2940 0.3608865379164736 1.494838367608591 0 -2941 0.5298535542892503 1.434262773301899 0 -2942 0.2292489860649035 1.073780207557802 0 -2943 0.7707510139339485 1.073780207558179 0 -2944 0.4926666647029472 1.042995680778128 0 -2945 0.6305094123637933 1.314302286959342 0 -2946 0.6122929134138689 1.236795882378532 0 -2947 0.8568907864384894 1.581635953614845 0 -2948 0.410290126613798 1.066724166509226 0 -2949 0.05499994271878899 1.594983681837827 0 -2950 0.3281937312021035 1.053462741328787 0 -2951 0.7690209952057978 1.202910363052015 0 -2952 0.6498722532733835 1.172450426166187 0 -2953 0.5361555651470896 1.008187105178369 0 -2954 0.02295216849368465 1.711554885079298 0 -2955 0.8095376807231148 1.750902471522841 0 -2956 0.9705954622239099 1.970402740307113 0 -2957 0.04889102228269866 1.493021452578355 0 -2958 0.8048512964483469 1.831204286715235 0 -2959 0.5552149808812128 1.006924991414495 0 -2960 0.08332480401566156 1.076015587247223 0 -2961 0.9166751959839765 1.076015587247557 0 -2962 0.6445181409311241 1.231796750078932 0 -2963 0.1562423358189068 1.8432869454409 0 -2964 0.139783290293122 1.413377267398353 0 -2965 0.5059168037108632 1.210966574162367 0 -2966 0.9627188401443481 1.300879784144581 0 -2967 0.6256103969305474 1.212577837401355 0 -2968 0.6396092692040855 1.280062400062568 0 -2969 0.5108549774949193 1.380762807316125 0 -2970 0.4754842164347899 1.603860222672949 0 -2971 0.5865312105343015 1.213780047669135 0 -2972 0.5197036992944831 1.550057860136427 0 -2973 0.7565197816282374 1.273245964088608 0 -2974 0.669441119550221 1.038203411750297 0 -2975 0.3540322828027791 1.684665699136207 0 -2976 0.6517581883220046 1.008492155829824 0 -2977 0.5691847589677379 1.131926591328444 0 -2978 0.8520749092523603 1.216565017547173 0 -2979 0.245041177210246 1.102009041037153 0 -2980 0.7549588227885721 1.10200904103767 0 -2981 0.1687457570057113 1.038890074445489 0 -2982 0.8312542429934928 1.038890074445692 0 -2983 0.2150117449697836 1.343560298824328 0 -2984 0.5727369439349044 1.212434662436378 0 -2985 0.1486844917117769 1.072846993073355 0 -2986 0.8513155082875328 1.072846993073695 0 -2987 0.05066018734083652 1.111583933031004 0 -2988 0.9493398126589245 1.111583933031389 0 -2989 0.4738127501998672 1.007777170474894 0 -2990 0.4638867003580509 1.23482263867288 0 -2991 0.08509556623336824 1.094025068364532 0 -2992 0.914904433766248 1.094025068364932 0 -2993 0.4083790916147616 1.241960094296454 0 -2994 0.023126928441822 1.10434887292641 0 -2995 0.9768730715581555 1.104348872926719 0 -2996 0.7585948900196794 1.316973963537439 0 -2997 0.5277256008226907 1.817768339721885 0 -2998 0.05277075708106999 1.638569102353637 0 -2999 0.4722958244960483 1.815883283342398 0 -3000 0.5919748108151146 1.248655678130806 0 -3001 0.563904581036356 1.24646745469932 0 -3002 0.5721997142445416 1.066591218563173 0 -3003 0.2411852616459803 1.317872777849692 0 -3004 0.4656511314133543 1.071543853460532 0 -3005 0.8536572713768893 1.485734191864946 0 -3006 0.04386648853438674 1.128024996133643 0 -3007 0.9561335114654953 1.128024996134196 0 -3008 0.6656225556681139 1.072308396739774 0 -3009 0.5346942907787386 1.037653085450848 0 -3010 0.8996766960574626 1.273519081010038 0 -3011 0.3760461421166644 1.14203785168324 0 -3012 0.5923730281933391 1.225773671479444 0 -3013 0.6950838193504395 1.289250989136105 0 -3014 0.9277301935827389 1.410727321862892 0 -3015 0.01425619637161279 1.337993856531098 0 -3016 0.1268847150106371 1.036729374781617 0 -3017 0.8731152849887862 1.03672937478179 0 -3018 0.007184981342944966 1.070446308651112 0 -3019 0.9928150186570717 1.070446308651146 0 -3020 0.08301135678927161 1.619174077059818 0 -3021 0.1350641264306794 1.655505290657749 0 -3022 0.343649248194673 1.031519522871835 0 -3023 0.6561529096541532 1.664717783008989 0 -3024 0.2153408786467667 1.789060710940457 0 -3025 0.5283355554849416 1.626030870171568 0 -3026 0.8086506427207933 1.459174070375985 0 -3027 0.4325026230958671 1.197699402322915 0 -3028 0.3196200499000456 1.064656542761854 0 -3029 0.4766397570759809 1.13736176667146 0 -3030 0.8962631750176243 1.367573939183772 0 -3031 0.5646001166653036 1.09699861929293 0 -3032 0.8283473967654937 1.968756677361399 0 -3033 0.2488027758056946 1.052120662120708 0 -3034 0.7511972241930638 1.052120662120992 0 -3035 0.03449560440918616 1.409590061744054 0 -3036 0.03234385620274027 1.053648608877618 0 -3037 0.9676561437971113 1.053648608877871 0 -3038 0.8243671588058238 1.211170154749401 0 -3039 0.6063319893559447 1.041302717781211 0 -3040 0.7326631503079906 1.971443705262739 0 -3041 0.2448743378295132 1.560307426103444 0 -3042 0.01031025244203183 1.259205503589445 0 -3043 0.2732763841695959 1.824579650613156 0 -3044 0.3949999999989889 1.006186390128424 0 -3045 0.06992465491520286 1.038178687399459 0 -3046 0.9300753450844766 1.038178687399638 0 -3047 0.5691927449047119 1.176963720889049 0 -3048 0.9137031986228519 1.298220106732654 0 -3049 0.5188574978259263 1.365754714061371 0 -3050 0.1808549052854008 1.078985605576947 0 -3051 0.8191450947137375 1.078985605577343 0 -3052 0.4817543709022503 1.886620100613878 0 -3053 0.1430618692927851 1.292639888679988 0 -3054 0.4896555122344977 1.110549679469188 0 -3055 0.4167122512742489 1.092077549886636 0 -3056 0.2477681380125178 1.185940834102218 0 -3057 0.7516176761805692 1.188855558619292 0 -3058 0.525159797985966 1.262896680099059 0 -3059 0.5108484182387665 1.088651374499793 0 -3060 0.09519057953687871 1.105174788481823 0 -3061 0.9048094204626493 1.105174788482245 0 -3062 0.6084193557325153 1.092149451475219 0 -3063 0.1744439120200208 1.189798286279298 0 -3064 0.8256765393983146 1.189815303228186 0 -3065 0.5333200847319234 1.133223623703243 0 -3066 0.1625126094875615 1.126211184181588 0 -3067 0.8374873905116891 1.12621118418218 0 -3068 0.9778092512520943 1.663863982149331 0 -3069 0.9890259381809722 1.259283245499479 0 -3070 0.2483610069204623 1.409895736065413 0 -3071 0.7757032537319577 1.354718911044039 0 -3072 0.5051685427161808 1.160262277088137 0 -3073 0.6015914929550168 1.471833964526196 0 -3074 0.6792252844697816 1.064084293976676 0 -3075 0.9884326960502201 1.313922519630678 0 -3076 0.0139118243533851 1.288121636845902 0 -3077 0.1342071476805902 1.39511707821149 0 -3078 0.3560261102775857 1.019788252760427 0 -3079 0.7806453492297647 1.255856604395591 0 -3080 0.5769885878843717 1.287508155013099 0 -3081 0.1173874186482801 1.084274523900702 0 -3082 0.882612581351178 1.084274523901069 0 -3083 0.00806496745244023 1.134658772172711 0 -3084 0.9919350325475937 1.134658772172714 0 -3085 0.527251628600046 1.064497557856977 0 -3086 0.4389524981478167 1.724078550811674 0 -3087 0.2673056920737841 1.01916137998082 0 -3088 0.7326950108266191 1.019163011303326 0 -3089 0.1196404715671867 1.196978877903997 0 -3090 0.8803732485876892 1.196833089850386 0 -3091 0.3402262158203494 1.613381801607067 0 -3092 0.6327965722852348 1.057805386184732 0 -3093 0.1082870743162082 1.232545634267622 0 -3094 0.8903241465952066 1.232584625306276 0 -3095 0.5160854486318447 1.199201570735223 0 -3096 0.4935952205291088 1.381116981666005 0 -3097 0.4580611159534282 1.354146572321462 0 -3098 0.3203927006214325 1.205041968754728 0 -3099 0.3369285798395966 1.51983270192779 0 -3100 0.5738957072541291 1.080892664656557 0 -3101 0.02564675784061751 1.940935266982317 0 -3102 0.5563469206617435 1.180255253164846 0 -3103 0.5342318724930822 1.177959414086585 0 -3104 0.977851952651616 1.942433433047928 0 -3105 0.9548156334290567 1.555163419917335 0 -3106 0.4935088971581665 1.573002079157671 0 -3107 0.4819207276268959 1.733425113031843 0 -3108 0.3407816120832692 1.103247199885626 0 -3109 0.6916026094480439 1.016549442489436 0 -3110 0.6786146719856003 1.201983593413454 0 -3111 0.3397275553349474 1.405309652147826 0 -3112 0.1168482866720272 1.283593747167385 0 -3113 0.5522251618207119 1.668398118713792 0 -3114 0.01866911726931404 1.541357935534568 0 -3115 0.6571871406462103 1.38011885104343 0 -3116 0.04503158955520244 1.170572547495972 0 -3117 0.9549684104449003 1.170572547496162 0 -3118 0.2557078616171862 1.039402252270771 0 -3119 0.7442921383815413 1.039402252270988 0 -3120 0.5102501236251781 1.072924854548012 0 -3121 0.1830505217902794 1.035977421339592 0 -3122 0.8169494782088537 1.035977421339776 0 -3123 0.7864855977004328 1.584813853419071 0 -3124 0.3836099480954295 1.17658714223066 0 -3125 0.9247170673415271 1.934275735722023 0 -3126 0.8216804848988943 1.579023426114137 0 -3127 0.5375476215549428 1.395942193947957 0 -3128 0.983894979504826 1.616556882338917 0 -3129 0.01361459294112605 1.312162164333579 0 -3130 0.5901184300976519 1.05033213873507 0 -3131 0.3319390836597085 1.291497935268903 0 -3132 0.2692598039677995 1.128877634537583 0 -3133 0.7307401960308807 1.128877634538257 0 -3134 0.4387981964658876 1.450306876884706 0 -3135 0.7807862651967983 1.687060803211409 0 -3136 0.811921678756286 1.246976682626123 0 -3137 0.3082237111666897 1.199540952657979 0 -3138 0.129221549014606 1.707246115945004 0 -3139 0.05753608738565197 1.062546543703425 0 -3140 0.9424639126140871 1.062546543703724 0 -3141 0.6056269987996351 1.224889647719344 0 -3142 0.6171287739428702 1.499791194399139 0 -3143 0.3908909555231866 1.489171294372845 0 -3144 0.6899962074720175 1.151597858236175 0 -3145 0.6519255697344501 1.03693816942329 0 -3146 0.5074293651199127 1.304053821727486 0 -3147 0.5215234172640134 1.047804460135949 0 -3148 0.3328287390886212 1.007314251533086 0 -3149 0.04732195063439883 1.060414287106749 0 -3150 0.9526780493653854 1.06041428710704 0 -3151 0.8867525443896362 1.556301636063413 0 -3152 0.06093920632468015 1.259535880913286 0 -3153 0.9400277719465432 1.258466329961994 0 -3154 0.2727400831869887 1.035021932662409 0 -3155 0.7272610743680831 1.035024619165739 0 -3156 0.8000458441502241 1.552048167523651 0 -3157 0.2626018840923422 1.301730190049869 0 -3158 0.5938962921612817 1.287343204782929 0 -3159 0.6144647121034461 1.054176326377833 0 -3160 0.7109935583627558 1.236642448408669 0 -3161 0.6503770169861024 1.776238969636014 0 -3162 0.3689970102233768 1.419232408619065 0 -3163 0.1991368022996508 1.128158094087197 0 -3164 0.8008631976994559 1.128158094087744 0 -3165 0.4461234879444902 1.251654153102093 0 -3166 0.3488661277688836 1.065419082809585 0 -3167 0.1084650573628514 1.929370864879122 0 -3168 0.5968960135416668 1.182282884876324 0 -3169 0.05138321987055499 1.078420724844972 0 -3170 0.9486167801292066 1.07842072484534 0 -3171 0.0768551969104051 1.044900551095555 0 -3172 0.9231448030892382 1.044900551095754 0 -3173 0.2570569366579989 1.066492380718779 0 -3174 0.7429430633407019 1.066492380719129 0 -3175 0.4462224994270425 1.180969742895069 0 -3176 0.09529286085030653 1.00589644543045 0 -3177 0.9047071391492654 1.005896445430478 0 -3178 0.7456350106586379 1.713519378105063 0 -3179 0.6324965072722788 1.616098206620357 0 -3180 0.0629597511616016 1.4078490409302 0 -3181 0.4833184993769563 1.367211055954118 0 -3182 0.1255715808812676 1.271148283596247 0 -3183 0.6057443555806847 1.24950644111779 0 -3184 0.8357602795041208 1.406631966224829 0 -3185 0.5550842866693007 1.636435289785549 0 -3186 0.09414434791989254 1.790702000193611 0 -3187 0.5157281617783732 1.923307188108359 0 -3188 0.6720638557582501 1.130779821161272 0 -3189 0.328192256142683 1.130808552033188 0 -3190 0.3517434032218137 1.424249783418309 0 -3191 0.3527477330069914 1.120507780423974 0 -3192 0.4872485957573031 1.007282680270751 0 -3193 0.03409965238293022 1.328100681348105 0 -3194 0.0954292114452118 1.504738095527319 0 -3195 0.9603647236363801 1.315972961010941 0 -3196 0.1504729406623461 1.258654812487545 0 -3197 0.1812196332426186 1.149884495876465 0 -3198 0.8187803667565179 1.149884495877156 0 -3199 0.387402898774831 1.655896828773865 0 -3200 0.0833702224214898 1.118761363533847 0 -3201 0.9166297775780697 1.118761363534233 0 -3202 0.4570467116506835 1.13890331288479 0 -3203 0.1798211720443132 1.227337100491445 0 -3204 0.2330543235285779 1.368262934601518 0 -3205 0.6684354299502232 1.244558505905119 0 -3206 0.9630821497747226 1.370609234330091 0 -3207 0.2231974482046011 1.703892597686964 0 -3208 0.3638086633157411 1.79243002479231 0 -3209 0.5144021826391417 1.125798696890056 0 -3210 0.5744828690993622 1.190910489983869 0 -3211 0.3375001410928807 1.587886584278393 0 -3212 0.1987350984166321 1.04293738526427 0 -3213 0.8012649015824096 1.042937385264484 0 -3214 0.2280888770562281 1.084588852068885 0 -3215 0.7719111229426404 1.0845888520693 0 -3216 0.4054739274688711 1.324755863999675 0 -3217 0.06792047649371237 1.554097630831343 0 -3218 0.007535419928601936 1.018047378716409 0 -3219 0.9924645800714075 1.018047378716426 0 -3220 0.3673819377160927 1.398266056710684 0 -3221 0.7818576873512124 1.936563062155973 0 -3222 0.5528943640275946 1.92910980076308 0 -3223 0.5849999999989093 1.005856846430483 0 -3224 0.3943527091754409 1.880650961906487 0 -3225 0.4015953078583649 1.255912512555445 0 -3226 0.1373548290263226 1.007265818576075 0 -3227 0.8626451709730468 1.007265818576111 0 -3228 0.09116023977412796 1.197402322467753 0 -3229 0.9088397602262499 1.197402322468015 0 -3230 0.8808737026395025 1.679065208580525 0 -3231 0.9818451098120242 1.570174690384008 0 -3232 0.6452701898085627 1.512733594267466 0 -3233 0.2109842094649221 1.128432967414724 0 -3234 0.7890157905340743 1.128432967415335 0 -3235 0.599792891143665 1.063632734623389 0 -3236 0.6484123132631934 1.971605866385381 0 -3237 0.2447919070273138 1.926088229783505 0 -3238 0.450307194806208 1.093155611215732 0 -3239 0.6100404642133814 1.681903352546578 0 -3240 0.2514389730132617 1.014925222293766 0 -3241 0.7485610269854809 1.014925222293852 0 -3242 0.100116319480411 1.278917540673539 0 -3243 0.01772922761894232 1.007325404425178 0 -3244 0.982270772380972 1.007325404425215 0 -3245 0.5228728054664999 1.490253936602415 0 -3246 0.9631620618938812 1.259157658753812 0 -3247 0.2884806280357811 1.316593915072292 0 -3248 0.108555964838203 1.763308780820249 0 -3249 0.9110456767109114 1.39566361124855 0 -3250 0.8609988706993663 1.39449186391711 0 -3251 0.6834128035072389 1.02967843855267 0 -3252 0.3942242479494591 1.100336880972016 0 -3253 0.8672750832498555 1.737373605948202 0 -3254 0.3747562945077673 1.525148240497036 0 -3255 0.5800814497723821 1.820990227185569 0 -3256 0.512191942055147 1.441723341921217 0 -3257 0.4685658406491702 1.223155864668977 0 -3258 0.3035246264202507 1.071847717736612 0 -3259 0.6964746773281726 1.071857809090415 0 -3260 0.4082320930339532 1.075297362325028 0 -3261 0.02688986498945056 1.973803112790762 0 -3262 0.6851172043158067 1.164691335073097 0 -3263 0.5173652678789619 1.037638953672481 0 -3264 0.3911657977937508 1.57747666268882 0 -3265 0.437226486899446 1.398532019878076 0 -3266 0.6655516511764876 1.091787882046644 0 -3267 0.6167967266508756 1.062772820990088 0 -3268 0.5115510027143241 1.40779010973734 0 -3269 0.4846200438021683 1.034624527229878 0 -3270 0.5225735131104832 1.007217457510104 0 -3271 0.7365809388968274 1.78872584446839 0 -3272 0.7264550942049537 1.206031009138789 0 -3273 0.3504445707876621 1.862663860251722 0 -3274 0.3176281866336297 1.078751181522546 0 -3275 0.9020423040412049 1.810672121032276 0 -3276 0.5367419398648408 1.975933810218964 0 -3277 0.6817970649120719 1.079050214642001 0 -3278 0.2818390363859189 1.634346310360678 0 -3279 0.1993363667631902 1.089043558599542 0 -3280 0.8006636332358396 1.089043558599996 0 -3281 0.08216408759383684 1.543447877111605 0 -3282 0.4876193332552141 1.39398541827866 0 -3283 0.3021254111464436 1.591664995638674 0 -3284 0.4332148415046728 1.115380684815047 0 -3285 0.8011616831837557 1.227864360594381 0 -3286 0.05150173648886018 1.365751872087153 0 -3287 0.05496532722173433 1.087790175814136 0 -3288 0.9450346727780148 1.087790175814522 0 -3289 0.8046681234373696 1.398158704725539 0 -3290 0.3716515453920619 1.132008949871995 0 -3291 0.4436253645251734 1.308932810813298 0 -3292 0.1567249985220825 1.303126721918028 0 -3293 0.2119612090454667 1.078862919788726 0 -3294 0.788038790953479 1.078862919789108 0 -3295 0.5287483998655658 1.201133640701046 0 -3296 0.1953934959633296 1.800585142953776 0 -3297 0.3329286130332294 1.069965486168997 0 -3298 0.1890305360675689 1.208790671736525 0 -3299 0.9863232835077604 1.417637323875256 0 -3300 0.8111045693236416 1.209109535736351 0 -3301 0.2952620017437567 1.73795060515094 0 -3302 0.5844577581782607 1.125248008426799 0 -3303 0.06699969367602422 1.973950957333384 0 -3304 0.6996120227799911 1.592213307705401 0 -3305 0.2710897475875159 1.212576065116549 0 -3306 0.3405034597220026 1.345869520149519 0 -3307 0.1108030029593558 1.451988335699398 0 -3308 0.500799891083604 1.049420773155815 0 -3309 0.2906510912121534 1.108637813366452 0 -3310 0.7093474260716455 1.108631973383058 0 -3311 0.2010123075764172 1.147487766175482 0 -3312 0.798987692422616 1.14748776617616 0 -3313 0.826688336333459 1.92888481794781 0 -3314 0.9795673785300706 1.87009030098262 0 -3315 0.7905473666463739 1.27220986997835 0 -3316 0.2357693226741448 1.244876444268079 0 -3317 0.2611451541911151 1.025096393635785 0 -3318 0.7388549055781257 1.025096532353825 0 -3319 0.1598032433397236 1.01564159402556 0 -3320 0.8401967566595286 1.015641594025636 0 -3321 0.5482267760596211 1.07091720347627 0 -3322 0.4603265623720626 1.10566782343086 0 -3323 0.8128238314900005 1.233334246915742 0 -3324 0.06918292525897446 1.024830488032454 0 -3325 0.9308170747407107 1.02483048803257 0 -3326 0.4891905190310432 1.501089275758627 0 -3327 0.2088923788488783 1.109401317328674 0 -3328 0.7911076211501032 1.109401317329208 0 -3329 0.4476907357909223 1.236656321651996 0 -3330 0.2384340455037524 1.015645184473918 0 -3331 0.7615659544950655 1.015645184474004 0 -3332 0.1717029994476514 1.76308633455751 0 -3333 0.09878093785477732 1.671811964238785 0 -3334 0.05852527067152707 1.893830306377398 0 -3335 0.2154333678200377 1.118672299555085 0 -3336 0.7845666321789101 1.118672299555677 0 -3337 0.7826168377499634 1.563388436481977 0 -3338 0.2399148794890117 1.139849865553041 0 -3339 0.760085120509796 1.139849865553748 0 -3340 0.3197387254935056 1.015577470125447 0 -3341 0.02290988530190512 1.127767827692133 0 -3342 0.9770901146980855 1.127767827692361 0 -3343 0.9144884833438447 1.580630296320076 0 -3344 0.7582471540832618 1.893180163732064 0 -3345 0.3958976534938686 1.336111057882065 0 -3346 0.2504290210198446 1.19685920954506 0 -3347 0.5972281283801204 1.393815674192034 0 -3348 0.3243972542043328 1.098375867099081 0 -3349 0.4364884558366192 1.176171039439213 0 -3350 0.5491557813727068 1.125180806256856 0 -3351 0.4485899667673183 1.292994584986844 0 -3352 0.4966485986285446 1.191401331987999 0 -3353 0.6769786063985447 1.602502563725125 0 -3354 0.01590092057013676 1.589100026142832 0 -3355 0.6663630627943343 1.40889341389736 0 -3356 0.4465789624835255 1.158041621658539 0 -3357 0.01096305085370147 1.204978893887839 0 -3358 0.9890332695653414 1.204983006097456 0 -3359 0.2181960273169638 1.087167666927751 0 -3360 0.7818039726819552 1.087167666928174 0 -3361 0.3819039224720535 1.678858935696413 0 -3362 0.4240970366724922 1.215193883679644 0 -3363 0.6175372411393172 1.120867798488144 0 -3364 0.4232289133408755 1.067042764364448 0 -3365 0.3552072740681218 1.229404329850605 0 -3366 0.8964261094839023 1.258096658286262 0 -3367 0.2410668958067194 1.35511889244404 0 -3368 0.7410073833120006 1.517210704860221 0 -3369 0.1015642853061831 1.077215086769173 0 -3370 0.8984357146933604 1.077215086769501 0 -3371 0.87423075168225 1.435663082966889 0 -3372 0.2180049918670429 1.227991809881748 0 -3373 0.3454827963716899 1.021250461549208 0 -3374 0.3405572513913834 1.373580185585569 0 -3375 0.9497330244707272 1.627431129941743 0 -3376 0.4843557358232279 1.075498616911013 0 -3377 0.1104334301987898 1.038999631064801 0 -3378 0.8895665698007126 1.038999631064975 0 -3379 0.5371184194812646 1.190643155657833 0 -3380 0.8674604237820186 1.40726502586251 0 -3381 0.9333976026334944 1.282300546644999 0 -3382 0.6635002694408094 1.288088041356226 0 -3383 0.3698955874986868 1.751650569587373 0 -3384 0.2478470676590287 1.266601140011721 0 -3385 0.2885465939407976 1.058533238226147 0 -3386 0.7114521347767127 1.058534591979638 0 -3387 0.6408881521849427 1.425101619183517 0 -3388 0.6205418457006967 1.784662738757029 0 -3389 0.9597931365074216 1.404995181653994 0 -3390 0.3479137315077679 1.048741248520458 0 -3391 0.6281021459750666 1.177526093208538 0 -3392 0.5087762837353165 1.479649815375283 0 -3393 0.6129725745998538 1.192891460410892 0 -3394 0.4843032540716811 1.117013150750152 0 -3395 0.5894942450144165 1.717213425674467 0 -3396 0.2811007451854533 1.328687873866109 0 -3397 0.0481970082316495 1.527638884897945 0 -3398 0.3041919914100624 1.317860170772724 0 -3399 0.465052269653499 1.151583245073708 0 -3400 0.659062180797968 1.436698428999367 0 -3401 0.4047826830865794 1.542762183560312 0 -3402 0.5811751294515943 1.578003582966232 0 -3403 0.2576136794541315 1.495479737346622 0 -3404 0.3261839495667986 1.147107492901612 0 -3405 0.2376404095466362 1.743486228457745 0 -3406 0.3144749045067853 1.146986360641986 0 -3407 0.6721234722177283 1.148186400155432 0 -3408 0.7112372582173553 1.461516486200024 0 -3409 0.5547495100789241 1.740228009198139 0 -3410 0.7014254649630004 1.242934715824348 0 -3411 0.6034081285762425 1.325486171652366 0 -3412 0.6023628438069728 1.00711733848612 0 -3413 0.0174668220678606 1.059153328591893 0 -3414 0.98253317793206 1.059153328592128 0 -3415 0.1001622034396336 1.638145707490015 0 -3416 0.5934395717344421 1.534295943842678 0 -3417 0.3514196151484461 1.035787680836533 0 -3418 0.3353368883367572 1.017092770800198 0 -3419 0.7558068228073598 1.240838779012502 0 -3420 0.3762179157166683 1.006366397263434 0 -3421 0.09814012677165353 1.354464798106319 0 -3422 0.1166734194565906 1.873407271153148 0 -3423 0.2775222016458004 1.67775024304368 0 -3424 0.5090701820652053 1.064101013467267 0 -3425 0.4380390029231114 1.068670241233897 0 -3426 0.2692417742604845 1.18480014255584 0 -3427 0.938878693099089 1.466362381175177 0 -3428 0.3289160207592189 1.480440233983258 0 -3429 0.5233518900161606 1.104746243006703 0 -3430 0.6786716270195868 1.730439760606658 0 -3431 0.4997809480034809 1.060097429096916 0 -3432 0.3429920094868641 1.148653447083821 0 -3433 0.2988580108151219 1.936614550033135 0 -3434 0.5719975625939232 1.459912075440698 0 -3435 0.4051865417124261 1.129081687748491 0 -3436 0.3800172913440857 1.439297311671019 0 -3437 0.5901655016968097 1.642448469414646 0 -3438 0.6150361718738336 1.015579681456306 0 -3439 0.7902205990961959 1.707646183607716 0 -3440 0.2227549278958273 1.42021165067592 0 -3441 0.4847904019058026 1.223755863520104 0 -3442 0.7738480593455063 1.292288261325042 0 -3443 0.2928362794077691 1.069860564226422 0 -3444 0.7071636010856959 1.069861259386334 0 -3445 0.3916900167160449 1.070950199263994 0 -3446 0.03749464110598471 1.068231659119322 0 -3447 0.9625053588938317 1.068231659119643 0 -3448 0.7480293253519303 1.378655208441889 0 -3449 0.4196103399279165 1.550893293224064 0 -3450 0.653602791360656 1.195514677654681 0 -3451 0.6473361992378349 1.408969452274825 0 -3452 0.6268843430737454 1.064253542939533 0 -3453 0.3571204019552967 1.577198709485106 0 -3454 0.1844864296369261 1.090689842400813 0 -3455 0.8155135703622025 1.09068984240127 0 -3456 0.8321671514816793 1.290544088597883 0 -3457 0.7863394973346897 1.749100410726242 0 -3458 0.6571961095490539 1.14874754959908 0 -3459 0.6680400151237824 1.569072758798816 0 -3460 0.4588826252608314 1.039093390957258 0 -3461 0.09515771641627446 1.251167921301461 0 -3462 0.08306683781945828 1.23197070986715 0 -3463 0.9174424294663507 1.231911766594472 0 -3464 0.6973989846567398 1.770303600056921 0 -3465 0.8981056792986919 1.978069544004005 0 -3466 0.01963503176068615 1.045296734671473 0 -3467 0.9803649682392119 1.045296734671636 0 -3468 0.6343198850360702 1.093982585968916 0 -3469 0.846123505726555 1.899741734412523 0 -3470 0.5875650233043492 1.34227845560329 0 -3471 0.1722428243022023 1.293884692361587 0 -3472 0.6558854873807516 1.018190495697559 0 -3473 0.1401014349488895 1.801094660770332 0 -3474 0.3149848617711298 1.808422376880731 0 -3475 0.2709654909876248 1.602613614919684 0 -3476 0.4698008433826563 1.027686334865186 0 -3477 0.4555699947156926 1.022462450882871 0 -3478 0.6501996604148074 1.247416108036392 0 -3479 0.4587301615698488 1.161785863613254 0 -3480 0.8843798766461722 1.606556369100036 0 -3481 0.9206519163356471 1.693860615479304 0 -3482 0.1395514983175823 1.890076788006392 0 -3483 0.1007648067561446 1.087211677028428 0 -3484 0.8992351932434027 1.087211677028789 0 -3485 0.5766536371225803 1.542787593440706 0 -3486 0.9425902390686477 1.790813820424234 0 -3487 0.484412341942826 1.254974000759067 0 -3488 0.5537950841653287 1.021998433999045 0 -3489 0.6753004817709786 1.097568191795797 0 -3490 0.08003973351973072 1.150321960814463 0 -3491 0.9199602664800985 1.150321960814688 0 -3492 0.437772577021237 1.007316262550134 0 -3493 0.1102449168148291 1.031450302135144 0 -3494 0.8897550831846768 1.031450302135283 0 -3495 0.6982254137443059 1.036468820878717 0 -3496 0.9049789089191164 1.893557602454206 0 -3497 0.983779307830536 1.53344595164815 0 -3498 0.3411356427147726 1.245941926817336 0 -3499 0.4380519751604537 1.138637371239702 0 -3500 0.4293840250942337 1.158378521754898 0 -3501 0.2095107000952364 1.201043462151233 0 -3502 0.7919509552403152 1.201240915608389 0 -3503 0.6352028625784758 1.340841067836265 0 -3504 0.2146664341625092 1.92655386427022 0 -3505 0.2069260770694621 1.429597418627997 0 -3506 0.7611595662710799 1.216502897994214 0 -3507 0.4776534665566543 1.202389080691948 0 -3508 0.2902820172938113 1.122729420392723 0 -3509 0.7085040987738541 1.121827602812405 0 -3510 0.3530871567915889 1.088317763317803 0 -3511 0.3349201889869245 1.031312343878436 0 -3512 0.6751625537240049 1.005798773826823 0 -3513 0.7914802485291386 1.235296651115997 0 -3514 0.3168910356000915 1.03025475684214 0 -3515 0.6441582404671261 1.564583774303305 0 -3516 0.8331273470687306 1.847890874385971 0 -3517 0.399519045865631 1.041120517708164 0 -3518 0.03473408805806461 1.162488465326634 0 -3519 0.9652659119420296 1.162488465326853 0 -3520 0.2753178141746124 1.699300463141148 0 -3521 0.7996705151115917 1.42162684192093 0 -3522 0.3948583317449131 1.832898006773385 0 -3523 0.4051899320517516 1.205023038313091 0 -3524 0.1730289932302166 1.055646907007213 0 -3525 0.8269710067689444 1.055646907007487 0 -3526 0.4167386967774511 1.142383814385919 0 -3527 0.2534335141841533 1.211534759049977 0 -3528 0.2892681033400714 1.273049070876271 0 -3529 0.6559020630407286 1.122323379276284 0 -3530 0.6461416050724172 1.94208714482203 0 -3531 0.5653779597327737 1.121405787662119 0 -3532 0.3411153733126749 1.134187790291718 0 -3533 0.8811593514390166 1.320498651465222 0 -3534 0.1627579894207498 1.043410481515311 0 -3535 0.8372420105784895 1.04341048151553 0 -3536 0.3296517228892288 1.26599735329134 0 -3537 0.2377892474125629 1.442383921569851 0 -3538 0.388485899419214 1.217082993152809 0 -3539 0.8140333817965677 1.333993414816485 0 -3540 0.1062417413395645 1.381117748752468 0 -3541 0.2058515616040358 1.040851576815887 0 -3542 0.7941484383949681 1.040851576816092 0 -3543 0.6588642651974014 1.133585379420104 0 -3544 0.2815704390999333 1.444724017359413 0 -3545 0.7317971967093438 1.183826750392547 0 -3546 0.977682835759688 1.790952244804448 0 -3547 0.3646057498401418 1.059750338621733 0 -3548 0.1140906556321777 1.10923611967774 0 -3549 0.8859093443673214 1.109236119678237 0 -3550 0.5737089219458529 1.026701930556001 0 -3551 0.01593804205633383 1.516922257314523 0 -3552 0.3542540793114067 1.057840347089792 0 -3553 0.2854878263631779 1.229561060961588 0 -3554 0.6282629366364416 1.379396311457203 0 -3555 0.9090289363014198 1.25098675650324 0 -3556 0.1741083042007428 1.01860460643868 0 -3557 0.825891695798434 1.018604606438775 0 -3558 0.03370804538886642 1.023953741796655 0 -3559 0.9662919546109878 1.023953741796745 0 -3560 0.6836072807357017 1.508910911481828 0 -3561 0.2817889717361773 1.129942981485395 0 -3562 0.7176589047751682 1.130652108074175 0 -3563 0.4677834778301914 1.112979992944748 0 -3564 0.05558686898080113 1.928352825544404 0 -3565 0.04126891334462752 1.018097398399427 0 -3566 0.9587310866551901 1.018097398399501 0 -3567 0.09700619895850418 1.123835039323161 0 -3568 0.9029938010410837 1.123835039323633 0 -3569 0.5412554796599491 1.483028221533746 0 -3570 0.06977836143942963 1.784494093273558 0 -3571 0.2482739808787649 1.061052950192396 0 -3572 0.7517260191199873 1.061052950192721 0 -3573 0.3016470822365043 1.036493794165518 0 -3574 0.4367080026693275 1.027480258100142 0 -3575 0.2427753571367029 1.383832058237941 0 -3576 0.4697954446095487 1.18416002885769 0 -3577 0.418550494264734 1.72072788459907 0 -3578 0.3767074276250206 1.297085635051434 0 -3579 0.5523045785179248 1.328583603308685 0 -3580 0.7090228145462598 1.626924018112197 0 -3581 0.7928103222533652 1.247212174813187 0 -3582 0.1201350955041923 1.469865911101082 0 -3583 0.4740929977510073 1.244521438086098 0 -3584 0.630647737843554 1.649600152279288 0 -3585 0.5068463572759233 1.276651265597622 0 -3586 0.3721498168015352 1.03775577992918 0 -3587 0.401066927702555 1.016671804325887 0 -3588 0.005923383227509598 1.005914545855086 0 -3589 0.9940766167724477 1.00591454585511 0 -3590 0.6210413740287497 1.036419165428128 0 -3591 0.1238625823073719 1.845542783648374 0 -3592 0.6380740927560531 1.073146361370302 0 -3593 0.09122703911367487 1.452502287491005 0 -3594 0.6139468223323165 1.613123690945158 0 -3595 0.4110692920437905 1.031638099411708 0 -3596 0.1330582078797185 1.097553478406364 0 -3597 0.8669417921196629 1.097553478406802 0 -3598 0.04249420581981359 1.571526887013898 0 -3599 0.983424162642857 1.7359747604416 0 -3600 0.5510487332079945 1.052480995777755 0 -3601 0.2750692880072463 1.507372080548963 0 -3602 0.05207715141902639 1.006663833637992 0 -3603 0.9479228485807419 1.00666383363803 0 -3604 0.1603978431610944 1.359059036118489 0 -3605 0.7981532595091231 1.293389720552514 0 -3606 0.2741965150060367 1.006069577356058 0 -3607 0.7258019266366019 1.006070306001924 0 -3608 0.1544166481291382 1.030787298497688 0 -3609 0.845583351870145 1.030787298497841 0 -3610 0.04499999999991076 1.005181727692826 0 -3611 0.9549999999998793 1.005181727692858 0 -3612 0.255261213941851 1.666555804920243 0 -3613 0.9320632731088294 1.882758610376341 0 -3614 0.8214165569659956 1.362972306855893 0 -3615 0.8098145951361866 1.286315323436256 0 -3616 0.1189674645655133 1.244611184042298 0 -3617 0.8000997346482217 1.917995364246386 0 -3618 0.02216819238028278 1.074351397824639 0 -3619 0.9778318076196503 1.074351397824938 0 -3620 0.06057652630742353 1.071310610022351 0 -3621 0.9394234736923081 1.071310610022691 0 -3622 0.114173890125833 1.005930176213363 0 -3623 0.8858261098736577 1.005930176213386 0 -3624 0.0168750995561915 1.834395284024228 0 -3625 0.8986538148937213 1.456154498699989 0 -3626 0.4321410576495865 1.096459156163836 0 -3627 0.3662009872095671 1.642313958192046 0 -3628 0.4840319615930496 1.929826164855367 0 -3629 0.4198440208489874 1.326853272864602 0 -3630 0.6209757878940695 1.156061567100777 0 -3631 0.4634346414820441 1.382216499943817 0 -3632 0.5372234098869028 1.02926276883579 0 -3633 0.2883335895161532 1.380955355336657 0 -3634 0.07390845062452635 1.28208204792465 0 -3635 0.06134577333507334 1.657024493986289 0 -3636 0.4638553569109516 1.642497218435722 0 -3637 0.07318727077568837 1.006462358097645 0 -3638 0.9268127292239882 1.006462358097674 0 -3639 0.1394636436600802 1.166522500867852 0 -3640 0.8605363563392858 1.166522500868656 0 -3641 0.9118112497793394 1.339165287757585 0 -3642 0.3090180435720458 1.403959173181105 0 -3643 0.6217168144006515 1.079251694787047 0 -3644 0.09064724888580444 1.178623679863882 0 -3645 0.9093527511143016 1.178623679864107 0 -3646 0.3208003819789911 1.217529921408278 0 -3647 0.6928745603043144 1.541725776519078 0 -3648 0.781538321844969 1.790851151988544 0 -3649 0.4951316152892133 0.5030339212978533 0 -3650 0.2886244732561847 0.7156007037294506 0 -3651 0.7129102494425932 0.7140884405189462 0 -3652 0.5028362279978159 0.7804563884614171 0 -3653 0.1649999999996596 0.8349872397416043 0 -3654 0.8349999999995654 0.8349872397408593 0 -3655 0.6948244514151484 0.8581668436046905 0 -3656 0.3021358388535229 0.8588201877135516 0 -3657 0.7458401323067352 0.4625011581215406 0 -3658 0.2483925999474326 0.4697850086330241 0 -3659 0.4263903316078463 0.8798418401842896 0 -3660 0.5749999999988813 0.8790036651228942 0 -3661 0.4113174879493973 0.2576047535418504 0 -3662 0.9049999999997512 0.9049247893465643 0 -3663 0.09499999999982121 0.9049247893469401 0 -3664 0.856209231079759 0.6915727704167853 0 -3665 0.1455292259684953 0.6943359142438685 0 -3666 0.7750747888379776 0.904587420203242 0 -3667 0.2249252111609158 0.9045874202037003 0 -3668 0.5749362622023186 0.6401520365981953 0 -3669 0.4231725631377143 0.6487072992818387 0 -3670 0.7676487163587822 0.231496430181216 0 -3671 0.6197102944137767 0.7738016783877293 0 -3672 0.3807239696609022 0.7752019445502463 0 -3673 0.5974694466505568 0.3307379265962302 0 -3674 0.4949999999987035 0.919157974888827 0 -3675 0.6459644411457188 0.9245255733834724 0 -3676 0.3549645649669458 0.9214844607321835 0 -3677 0.2009354758611708 0.2697683332719191 0 -3678 0.7683108648850818 0.5952571952002692 0 -3679 0.2305668487757493 0.597269547984191 0 -3680 0.845495771981678 0.9364067007132244 0 -3681 0.1545042280175968 0.9364067007135293 0 -3682 0.7149999999992493 0.9341799136392807 0 -3683 0.28499999999931 0.9341799136396252 0 -3684 0.9062209498770519 0.774631996245378 0 -3685 0.09377905012280031 0.7746319962457424 0 -3686 0.3626781676901021 0.5318016578512994 0 -3687 0.7562511088519948 0.793772176441861 0 -3688 0.2436542903674698 0.795551171640378 0 -3689 0.6257012964749211 0.5184769889189909 0 -3690 0.8698790433716355 0.5118555082708378 0 -3691 0.1157981700644633 0.5822914680550753 0 -3692 0.5545973515899792 0.9380214149930235 0 -3693 0.8563853864353832 0.3708125505471475 0 -3694 0.4149999999989309 0.9388963693766798 0 -3695 0.94524644829951 0.9454433778092888 0 -3696 0.05475355170023821 0.9454433778095569 0 -3697 0.4049452164765799 0.3991092806290063 0 -3698 0.1259927821177929 0.4570158420766265 0 -3699 0.4896666308908597 0.8493391618230737 0 -3700 0.5497090931758539 0.1706149798645513 0 -3701 0.6790408133911712 0.6176372252783328 0 -3702 0.3259072895759921 0.625382839186143 0 -3703 0.9281334621414647 0.8401317570596278 0 -3704 0.07186653785839381 0.8401317570599841 0 -3705 0.5040881717607384 0.6906147079459702 0 -3706 0.6356156820135995 0.8611114020578882 0 -3707 0.6049999999989599 0.9502933168442059 0 -3708 0.9009907905490346 0.6053878293494258 0 -3709 0.3659374286579278 0.860716479819049 0 -3710 0.8238596996029721 0.760253126623778 0 -3711 0.1725047735221046 0.762276885081815 0 -3712 0.6880575264864723 0.7883196764072731 0 -3713 0.3129788234815334 0.7883755764708607 0 -3714 0.7954272205075399 0.9505245255190962 0 -3715 0.2045727794914657 0.9505245255193356 0 -3716 0.4358748729283511 0.8112983575217714 0 -3717 0.3061004762108279 0.1516571645800894 0 -3718 0.4454651465872002 0.7431266145830052 0 -3719 0.8951235665832378 0.952551389712281 0 -3720 0.104876433416288 0.9525513897124754 0 -3721 0.4973664589306666 0.6043444702960334 0 -3722 0.635675941920802 0.6953047828117335 0 -3723 0.2903463778211808 0.3516663094691181 0 -3724 0.5636005647979639 0.8128764689249354 0 -3725 0.3631678338440074 0.7009828099912561 0 -3726 0.4650087993149511 0.9552018865863339 0 -3727 0.6749999999991446 0.9551255240219025 0 -3728 0.324999999999193 0.9551255240221453 0 -3729 0.7165942877072025 0.3433047082078004 0 -3730 0.5575658404965225 0.7329484973429717 0 -3731 0.7530698821014418 0.8517336940480875 0 -3732 0.2469301178973254 0.8517336940488369 0 -3733 0.9285652768661607 0.7041780532146942 0 -3734 0.07236531557862763 0.7049504158853144 0 -3735 0.7775720702787963 0.6758952762168193 0 -3736 0.1366028350729405 0.135360653295327 0 -3737 0.8574069800633093 0.8825602793559132 0 -3738 0.1425930199360604 0.8825602793564479 0 -3739 0.5686634993247253 0.4325369528954985 0 -3740 0.2158192146755186 0.700440318206603 0 -3741 0.5155514434375249 0.957428998120037 0 -3742 0.1164327569888408 0.3456839977593948 0 -3743 0.3758001142500348 0.9566022503131829 0 -3744 0.7527511859645537 0.9588800736655889 0 -3745 0.2472488140342155 0.9588800736658142 0 -3746 0.9524010848800437 0.8997866408091254 0 -3747 0.04759891511973552 0.8997866408095306 0 -3748 0.8612551519889815 0.1319248299662935 0 -3749 0.181782084296993 0.5246834197315848 0 -3750 0.8801413916575318 0.2644450571349767 0 -3751 0.421790745351459 0.1383711817579202 0 -3752 0.6772041500205526 0.1344991314131296 0 -3753 0.7036556660790018 0.5458578254283518 0 -3754 0.5283585586688625 0.8798219657305826 0 -3755 0.6639331689519016 0.438299996512328 0 -3756 0.4796526162310633 0.3304786862977649 0 -3757 0.5637996632371463 0.5677674687415111 0 -3758 0.8348563129955622 0.6263902654949128 0 -3759 0.4508393998825335 0.9149167069854778 0 -3760 0.1937231399367003 0.3963219546118056 0 -3761 0.4278398459595389 0.577516079733129 0 -3762 0.7294164162809222 0.8913801902987554 0 -3763 0.2705835837177522 0.8913801902992954 0 -3764 0.07060779360940994 0.6349151642951704 0 -3765 0.8135281130272947 0.8739816373222906 0 -3766 0.1864718869718131 0.8739816373228619 0 -3767 0.665591751369725 0.2518137356741437 0 -3768 0.7670539122833595 0.7381687970643054 0 -3769 0.6872565080401121 0.90177259278346 0 -3770 0.3128751529678904 0.901974716272226 0 -3771 0.3333365632516667 0.4513214142859323 0 -3772 0.2940014017147823 0.5563545863694396 0 -3773 0.9119651076512172 0.4358392627416694 0 -3774 0.1037751011725982 0.2434626961035677 0 -3775 0.8825904570425558 0.8439984571807619 0 -3776 0.1174095429570416 0.8439984571815344 0 -3777 0.6054272041488761 0.9099949909096751 0 -3778 0.1675224668898134 0.6276387001943534 0 -3779 0.6385717793163356 0.9649259206122556 0 -3780 0.2596659911204697 0.6571224768690813 0 -3781 0.3928648897728227 0.9041668459325827 0 -3782 0.7940655524770115 0.5237431836180173 0 -3783 0.5742618506961469 0.9664752325858235 0 -3784 0.07536788005301508 0.515579384356057 0 -3785 0.8255117312674655 0.4468580343445921 0 -3786 0.8248485784112995 0.9664166904418687 0 -3787 0.1751514215878712 0.966416690442044 0 -3788 0.3013227367640799 0.2556473472019965 0 -3789 0.8645213772979725 0.9682359970246354 0 -3790 0.1354786227014135 0.9682359970247754 0 -3791 0.4846287120861147 0.4249780695895251 0 -3792 0.9501429847038053 0.79618164310984 0 -3793 0.04985701529619381 0.796181643110295 0 -3794 0.8643808803855763 0.7966081801209282 0 -3795 0.1355638060890303 0.7968660911323436 0 -3796 0.4228453617372052 0.4755961821361328 0 -3797 0.8097289768620304 0.9177264886096514 0 -3798 0.1902710231370594 0.9177264886100629 0 -3799 0.4344943926561243 0.9679991229802747 0 -3800 0.7049999999992214 0.9678133445421923 0 -3801 0.294999999999281 0.9678133445423693 0 -3802 0.6613582499302223 0.7421878119695458 0 -3803 0.6450937109042678 0.8126747722640224 0 -3804 0.7902564822353814 0.8256733897962364 0 -3805 0.2097435177636063 0.8256733897970749 0 -3806 0.3540920651235021 0.8131714863801713 0 -3807 0.720257669311593 0.8193501602877338 0 -3808 0.278744454409672 0.8204085259931641 0 -3809 0.7260715717287158 0.65662305088958 0 -3810 0.3380381450712668 0.7452961044377397 0 -3811 0.9302562727283465 0.5444078473272418 0 -3812 0.9678359677135614 0.9678834693750559 0 -3813 0.03216403228629287 0.9678834693752107 0 -3814 0.6171666438772465 0.5942990561145115 0 -3815 0.5951215241491643 0.841488833808709 0 -3816 0.9249999999997995 0.9691771808678272 0 -3817 0.07499999999985285 0.9691771808679772 0 -3818 0.4763493687147465 0.885348305559029 0 -3819 0.5285532660738312 0.8357397834812883 0 -3820 0.9436188907219221 0.6516349780992643 0 -3821 0.5447918303283066 0.9699846568893785 0 -3822 0.4043557480384705 0.8417591077774624 0 -3823 0.4049999999989607 0.9702917063411154 0 -3824 0.2395470048806064 0.7425710045535132 0 -3825 0.8680277829141924 0.7431218362877513 0 -3826 0.1303675135481172 0.7414262421750296 0 -3827 0.5427557008437534 0.2584388243689164 0 -3828 0.951851718962846 0.7474464822302712 0 -3829 0.04814828103691262 0.7474464822309445 0 -3830 0.8770792412949472 0.9236344339748748 0 -3831 0.1229207587044854 0.9236344339751844 0 -3832 0.7961445410523822 0.311251754350556 0 -3833 0.7760372495275611 0.3903150853269405 0 -3834 0.7236098808148653 0.7607028599022946 0 -3835 0.4137267449730414 0.7000828130392076 0 -3836 0.7466089352857045 0.9239285263686412 0 -3837 0.2533910647130155 0.9239285263690413 0 -3838 0.9610139135484708 0.8612840077674176 0 -3839 0.0389860864514746 0.8612840077678749 0 -3840 0.5291657478040362 0.9167650420553539 0 -3841 0.8120322410643368 0.7134034415574153 0 -3842 0.3820676197677851 0.6075134610974431 0 -3843 0.4753863532713057 0.8105968310407812 0 -3844 0.5613774318451397 0.49487794408774 0 -3845 0.5835987208003524 0.6883675850041264 0 -3846 0.4496620124782539 0.848215513731984 0 -3847 0.771368009263711 0.1325824442908582 0 -3848 0.854613180076208 0.5680165409472484 0 -3849 0.05324339469079318 0.5787625499386186 0 -3850 0.3680917249003124 0.3285304657587159 0 -3851 0.07314870358487699 0.4038140150719662 0 -3852 0.4896801683500572 0.9716773319678798 0 -3853 0.3163780951507726 0.6743945688169285 0 -3854 0.9247899181541059 0.8753105967699204 0 -3855 0.07521008184553703 0.8753105967702725 0 -3856 0.9230897015045263 0.3278303519808334 0 -3857 0.7733297816745903 0.9728355458975075 0 -3858 0.2266702183242967 0.9728355458976559 0 -3859 0.4905325186655494 0.7358031001216199 0 -3860 0.3491814661591301 0.9719082358767021 0 -3861 0.6539281580892802 0.8873477425520724 0 -3862 0.3460390566922257 0.8874171313347612 0 -3863 0.9690407413969251 0.924746118751727 0 -3864 0.03095925860296628 0.9247461187520987 0 -3865 0.6276193463987503 0.6451641951516576 0 -3866 0.4726448832694249 0.2091531175878388 0 -3867 0.2774037955385593 0.7662193316932696 0 -3868 0.6049826823315074 0.7312853759709507 0 -3869 0.1171244667396665 0.6485435588172355 0 -3870 0.2346426415369918 0.5354934146053882 0 -3871 0.5464335942759053 0.7747979171718952 0 -3872 0.2191427888927727 0.186045390150349 0 -3873 0.226348199313372 0.09110089560914636 0 -3874 0.9204170524390722 0.9331290227463437 0 -3875 0.8918427989320958 0.6564182620814207 0 -3876 0.07958294756057027 0.9331290227466396 0 -3877 0.5727759534019614 0.9111161497353149 0 -3878 0.6819420966563542 0.6802744633419884 0 -3879 0.2116052887953869 0.6505623313846898 0 -3880 0.4743855051414581 0.6494219818844299 0 -3881 0.1859732665107253 0.4638199073645261 0 -3882 0.6831019552237937 0.4981411881327831 0 -3883 0.5261899353738885 0.6460107558012543 0 -3884 0.8182248838015395 0.8004852644754825 0 -3885 0.1808797841266093 0.8000075853328212 0 -3886 0.8905587696235082 0.8761404132810806 0 -3887 0.1094412303760334 0.8761404132816502 0 -3888 0.4592240634908111 0.6996017621850765 0 -3889 0.7312854314423527 0.9717321817389465 0 -3890 0.2687145685562919 0.9717321817391034 0 -3891 0.6151500988895461 0.9737799722415401 0 -3892 0.9056161833773897 0.8121727166327566 0 -3893 0.0943838166226756 0.8121727166331457 0 -3894 0.5964139947465555 0.09146604088779577 0 -3895 0.506673353631782 0.0931235652748683 0 -3896 0.4208273319235493 0.7756038681763548 0 -3897 0.7763692969201188 0.8723433624392942 0 -3898 0.2236307030788141 0.8723433624399329 0 -3899 0.275989832139486 0.6099471607436453 0 -3900 0.6806555650022809 0.824356956760762 0 -3901 0.7211515884186711 0.6072283856949062 0 -3902 0.770856838500092 0.9369655964387337 0 -3903 0.2291431614987754 0.9369655964390768 0 -3904 0.2995306711455051 0.4982552016311874 0 -3905 0.3191308017574142 0.8245094468753111 0 -3906 0.1812052894171816 0.5804763554889556 0 -3907 0.3876430579365246 0.9322186937839707 0 -3908 0.6546789176470527 0.365604784051565 0 -3909 0.9442774505310696 0.4891548680913375 0 -3910 0.6037330416931657 0.8760030756862187 0 -3911 0.8389088785928506 0.9051488575365128 0 -3912 0.161091121406404 0.9051488575369526 0 -3913 0.5344873588691672 0.3784736330348054 0 -3914 0.4015494210549199 0.7399101516384153 0 -3915 0.4723874315943569 0.546647695495009 0 -3916 0.5987772339283716 0.8078037086993788 0 -3917 0.3982968647758967 0.8072806868780432 0 -3918 0.4210818059296881 0.9104668226621264 0 -3919 0.6868353967798447 0.9291318806450595 0 -3920 0.3133716125063806 0.9297010548540732 0 -3921 0.9531283016740071 0.601615445456265 0 -3922 0.5626761204542309 0.8496821802324226 0 -3923 0.4414708587792049 0.9417158736919977 0 -3924 0.9675460547335292 0.8258954400798246 0 -3925 0.0324539452665415 0.8258954400801936 0 -3926 0.2814497900878374 0.417157182152149 0 -3927 0.1250826382746296 0.5293186015734948 0 -3928 0.1769476255748152 0.7186475757768602 0 -3929 0.9210448196398369 0.1881869237486085 0 -3930 0.7917971679822369 0.7762653160077295 0 -3931 0.2103555249655211 0.7765951653249676 0 -3932 0.3532364705802262 0.1983468898055183 0 -3933 0.3530937030899848 0.08579201745327555 0 -3934 0.8949999999997217 0.976294770997749 0 -3935 0.104999999999807 0.9762947709978431 0 -3936 0.2288242487404349 0.3348435826550285 0 -3937 0.3929760491960678 0.8749422514622009 0 -3938 0.04516197948641304 0.668366641318048 0 -3939 0.4700063955197665 0.7749159423477995 0 -3940 0.3425379730539151 0.5792950756644065 0 -3941 0.8018110375928003 0.9751091059680805 0 -3942 0.1981889624062582 0.9751091059682028 0 -3943 0.3790818396725328 0.6537317007277476 0 -3944 0.660834958366359 0.9753348669255453 0 -3945 0.715516373340834 0.4104224142853757 0 -3946 0.05848113365782839 0.4617704235136489 0 -3947 0.5807241435795072 0.9423470173288349 0 -3948 0.3482085860694553 0.391183816390297 0 -3949 0.4903088707995424 0.9436571391010395 0 -3950 0.05763525586117547 0.2940324319541971 0 -3951 0.5444962278403366 0.6959514726691052 0 -3952 0.3490441535762759 0.9425860230813619 0 -3953 0.620547232805049 0.1856387495193579 0 -3954 0.6642277708697455 0.8583498649100529 0 -3955 0.5826535338927147 0.7732921120177205 0 -3956 0.07769759500999719 0.09393096939028349 0 -3957 0.3348364976023889 0.8582279690181107 0 -3958 0.5326474058044592 0.80395688499181 0 -3959 0.0701045633760735 0.1781255038555453 0 -3960 0.8165570019248398 0.9416198694245954 0 -3961 0.1834429980742726 0.9416198694248805 0 -3962 0.4649999999987859 0.9773563295480949 0 -3963 0.624053722819608 0.9386974960475305 0 -3964 0.8449999999995869 0.9777874771794672 0 -3965 0.1549999999996889 0.9777874771795785 0 -3966 0.7524435815208094 0.7001106678710701 0 -3967 0.749528997230915 0.5468488343074716 0 -3968 0.7254939270004099 0.8617903862445928 0 -3969 0.27450607299822 0.8617903862453002 0 -3970 0.6519123606210981 0.7816798503429209 0 -3971 0.66460997957715 0.5778223874071722 0 -3972 0.8352559813665218 0.2010159976029955 0 -3973 0.9386331188501114 0.3834235154859676 0 -3974 0.6848511933763669 0.9773956861446451 0 -3975 0.1819658802735272 0.6821628049613305 0 -3976 0.9491853182037719 0.9795650237413575 0 -3977 0.05081468179599716 0.9795650237414519 0 -3978 0.3464444298436914 0.7801897858183069 0 -3979 0.9037898811988192 0.7360218014908835 0 -3980 0.09133476066318519 0.7370529710083176 0 -3981 0.3148300438636647 0.9785922770944113 0 -3982 0.4385723720112795 0.5249878922157225 0 -3983 0.6140151709784849 0.4567487060084635 0 -3984 0.8198662273904778 0.663765593350356 0 -3985 0.5493094379728428 0.8962497178983865 0 -3986 0.5481579202118432 0.6091403413767789 0 -3987 0.136805770058462 0.3976067784538805 0 -3988 0.2003602797483222 0.741464831887564 0 -3989 0.449552352917812 0.6156866242806219 0 -3990 0.6538338586789421 0.9433639064821979 0 -3991 0.4724454130763751 0.930181302231268 0 -3992 0.9168735851548003 0.08154510520896407 0 -3993 0.4263247628428187 0.3437997297618366 0 -3994 0.5250470169266888 0.4644989142298308 0 -3995 0.5241988755829053 0.9788953096104701 0 -3996 0.9388335296434006 0.9199725084444028 0 -3997 0.06116647035632636 0.9199725084447776 0 -3998 0.3836865411847476 0.978418578355855 0 -3999 0.7097390757618174 0.9075335946972667 0 -4000 0.2902609242367218 0.9075335946977523 0 -4001 0.8078856255198641 0.560785750602893 0 -4002 0.6311826055631086 0.8988274543016862 0 -4003 0.5291040925343674 0.7442036669385633 0 -4004 0.7895357646898007 0.6333944670848419 0 -4005 0.5043229919422062 0.8232918074274702 0 -4006 0.9645542000929698 0.6873818475444158 0 -4007 0.7093818579090103 0.1998306855753584 0 -4008 0.817312533223256 0.0763104559294886 0 -4009 0.7211920553034565 0.2765128821850641 0 -4010 0.1045016299822327 0.6836477120168121 0 -4011 0.5934016151322565 0.9783136699040823 0 -4012 0.2530404397524282 0.6927362582101269 0 -4013 0.5020192269822026 0.8932369018502502 0 -4014 0.7267790888599116 0.07621511994400353 0 -4015 0.8357006539495749 0.8608413962695657 0 -4016 0.1642993460496671 0.8608413962702156 0 -4017 0.7549381729174602 0.9798486679108018 0 -4018 0.2450618270813166 0.9798486679109171 0 -4019 0.3221335758301973 0.71127256682436 0 -4020 0.9767801339172379 0.9464474185312483 0 -4021 0.02321986608265552 0.9464474185315113 0 -4022 0.03510793832173042 0.7146399421618292 0 -4023 0.5310201529988398 0.9398343821624919 0 -4024 0.3040335315306726 0.7440358868866173 0 -4025 0.7256638451292878 0.5131429463324011 0 -4026 0.450884069495847 0.887880672280936 0 -4027 0.1404441900112984 0.292893795100662 0 -4028 0.6051226495039908 0.2702066890632027 0 -4029 0.6245405756697463 0.8331667819524549 0 -4030 0.3740270651896885 0.482767246039739 0 -4031 0.8948792006130712 0.7060170203332713 0 -4032 0.8510036084490654 0.3142815868935936 0 -4033 0.8780290078219277 0.8970285657248318 0 -4034 0.1219709921775037 0.897028565725295 0 -4035 0.3776920384400134 0.8312978100422318 0 -4036 0.5217653188690962 0.5428047309558556 0 -4037 0.8083411724126399 0.8466945988892474 0 -4038 0.1916588275864309 0.8466945988899407 0 -4039 0.3710933166086729 0.8865426419426667 0 -4040 0.1709284603443829 0.3400879153048332 0 -4041 0.7304222902648517 0.9537611250385332 0 -4042 0.2695777097337914 0.9537611250387831 0 -4043 0.616701106779838 0.4051094877200854 0 -4044 0.760597449504012 0.823815148382288 0 -4045 0.2394025504948221 0.8238151483831697 0 -4046 0.70023936449538 0.885299734007549 0 -4047 0.2997541015713867 0.8853067990347929 0 -4048 0.8649562915958634 0.9455194359678181 0 -4049 0.13504370840352 0.9455194359680623 0 -4050 0.8464510154484939 0.9577920130232931 0 -4051 0.153548984550803 0.9577920130234968 0 -4052 0.6909802103208807 0.7563943368492488 0 -4053 0.6746583939477759 0.3097922701641638 0 -4054 0.4653931509652491 0.2725611634256091 0 -4055 0.9742631554277045 0.8851746742297567 0 -4056 0.02573684457225862 0.8851746742301216 0 -4057 0.1655824595434258 0.2256039434254096 0 -4058 0.8704700192242447 0.4647885051350603 0 -4059 0.05521997116950423 0.3490463552934598 0 -4060 0.9471418445432391 0.2780602820843013 0 -4061 0.9079525829009025 0.8545294707958382 0 -4062 0.09204741709884703 0.8545294707963534 0 -4063 0.7576556720569849 0.8883005133851498 0 -4064 0.2423443279418391 0.8883005133857096 0 -4065 0.3823821655854145 0.5735711725136273 0 -4066 0.7974349020288207 0.8999337737578619 0 -4067 0.2025650979701839 0.8999337737583413 0 -4068 0.7152918078423299 0.7871226391309929 0 -4069 0.1417246818594895 0.06825715186294318 0 -4070 0.9264985356925385 0.9018192982049517 0 -4071 0.07350146430712162 0.9018192982053652 0 -4072 0.749519569103445 0.6335700494691513 0 -4073 0.8241594595282118 0.2621746194822492 0 -4074 0.5507871165470715 0.8700512602225086 0 -4075 0.5092414204691827 0.9357249608961486 0 -4076 0.680044873749719 0.7190672069907369 0 -4077 0.3693384260898727 0.7310026456206432 0 -4078 0.8304380897379404 0.4921945420040005 0 -4079 0.7931823468661678 0.9313279321707053 0 -4080 0.2068176531328262 0.9313279321710427 0 -4081 0.8611134226038442 0.8584049973495407 0 -4082 0.1388865773955487 0.8584049973502361 0 -4083 0.2735622613126485 0.3014304754792097 0 -4084 0.8537809566034509 0.7673508636177419 0 -4085 0.1460749507846286 0.7677270434442931 0 -4086 0.4672664617845406 0.468505371266777 0 -4087 0.6687391834199609 0.9191348962990784 0 -4088 0.3295286953357598 0.9189494977259469 0 -4089 0.896177673755532 0.565747373405344 0 -4090 0.5041050539021672 0.9822450425579017 0 -4091 0.6042858736192473 0.553687609888421 0 -4092 0.3951448024543263 0.9516765628852387 0 -4093 0.234317439844356 0.4230437345274692 0 -4094 0.5422284215259245 0.3262431394770985 0 -4095 0.8613947015174612 0.8222253710108369 0 -4096 0.1386052984819151 0.8222253710116627 0 -4097 0.9693595232429085 0.771577761770567 0 -4098 0.0307015817501409 0.7714399503855089 0 -4099 0.6947070100591117 0.9505319614252726 0 -4100 0.3053496473777573 0.9504187208782864 0 -4101 0.04052299530249664 0.5415663871479356 0 -4102 0.837847517007542 0.7341421855185098 0 -4103 0.3629267507178361 0.9818631538622864 0 -4104 0.03989874246352883 0.6134302441052675 0 -4105 0.7530683153811095 0.7625040937587992 0 -4106 0.5129499351880757 0.8581812192630389 0 -4107 0.5618147855922505 0.9824201967693187 0 -4108 0.2961620851092936 0.643809887970449 0 -4109 0.8356453498485782 0.5346303506010788 0 -4110 0.6790217475576487 0.877470256977592 0 -4111 0.9685995814597967 0.7190246785389344 0 -4112 0.3203451920146463 0.8775443870667532 0 -4113 0.152097110669405 0.4916027572177032 0 -4114 0.2185388766157459 0.4997246267070515 0 -4115 0.5982748955245324 0.9308147683294072 0 -4116 0.6360105500651638 0.9824691143577043 0 -4117 0.7889763322100682 0.4773232421416736 0 -4118 0.664784977976852 0.0678096324797476 0 -4119 0.7784266716413926 0.8482980248759897 0 -4120 0.2215733283575073 0.8482980248767409 0 -4121 0.9826766411859073 0.9827112450896717 0 -4122 0.01732335881401648 0.9827112450896797 0 -4123 0.4158862670462219 0.06531174341464539 0 -4124 0.8548875776205234 0.6560501245142085 0 -4125 0.4232485507790545 0.9827133671899215 0 -4126 0.8679514502116198 0.4186203838149137 0 -4127 0.2857749042594009 0.06563539253413279 0 -4128 0.8602422762969811 0.9086108725982511 0 -4129 0.1397577237023721 0.9086108725986387 0 -4130 0.4735233156227197 0.9073993299340167 0 -4131 0.3336823060364046 0.9821394160542336 0 -4132 0.452290271387019 0.3864884702798327 0 -4133 0.1035594595201337 0.6155783396978679 0 -4134 0.2407484597185398 0.2334195549816942 0 -4135 0.897230901368592 0.9323771494624625 0 -4136 0.1027690986309371 0.9323771494627427 0 -4137 0.6620381309879446 0.5394802410139503 0 -4138 0.8769173897430906 0.9814510083478871 0 -4139 0.1230826102563553 0.9814510083479681 0 -4140 0.3815878523538027 0.4388253737063962 0 -4141 0.1524273685825279 0.6603207406625053 0 -4142 0.6313745357945908 0.7487661614674604 0 -4143 0.8733080293537445 0.6246886341650479 0 -4144 0.9329626620355295 0.7692085526097406 0 -4145 0.06703733796432974 0.7692085526102221 0 -4146 0.1126178001660977 0.7148592657260624 0 -4147 0.3507043658025388 0.2759577611615795 0 -4148 0.7365480540803954 0.7342978823617738 0 -4149 0.2850496441467325 0.6821333664749 0 -4150 0.4351028611644084 0.4351583705713032 0 -4151 0.4812561517566297 0.1549539867072043 0 -4152 0.5817201901258277 0.6010840407883881 0 -4153 0.4488700650611264 0.9830852143403759 0 -4154 0.3664458188078803 0.938801628714077 0 -4155 0.2864723655052417 0.7952884532590866 0 -4156 0.9148803679000146 0.9513694453003954 0 -4157 0.08511963209958326 0.9513694453006001 0 -4158 0.6481087552590663 0.8411446835747254 0 -4159 0.3516452214278706 0.8411302147311492 0 -4160 0.4261539156132824 0.8539506870707509 0 -4161 0.9789879930217859 0.9054594636494556 0 -4162 0.02101200697831327 0.9054594636497532 0 -4163 0.7970725257150095 0.7480507602707177 0 -4164 0.6239561498962085 0.9183842989649225 0 -4165 0.08567710266744501 0.5555756361155488 0 -4166 0.9319489926008352 0.8138102092908305 0 -4167 0.06805100739921652 0.8138102092911406 0 -4168 0.4144667904904701 0.2056947392925472 0 -4169 0.7149999999992495 0.9827415931578174 0 -4170 0.2849999999993101 0.982741593157912 0 -4171 0.2616565246991721 0.5751602696945131 0 -4172 0.3247807326931682 0.5299340318428443 0 -4173 0.9122001489041095 0.9820094049903503 0 -4174 0.08779985109549929 0.9820094049904297 0 -4175 0.347176469727653 0.6559806936917936 0 -4176 0.8220598734827319 0.4000501291896271 0 -4177 0.4453469392568887 0.788214287023689 0 -4178 0.1486179248388603 0.5930188929197613 0 -4179 0.9561798483004957 0.4489129240204565 0 -4180 0.7818349722419444 0.7062122249717073 0 -4181 0.2025833254783888 0.6210048928004108 0 -4182 0.9201140635103675 0.676251434332563 0 -4183 0.2475305143277344 0.3795114002983948 0 -4184 0.7037418639541988 0.4524303643089364 0 -4185 0.5501786654921997 0.9173706031202171 0 -4186 0.4697420949965335 0.8636983115383005 0 -4187 0.5580501019953795 0.9568497289430657 0 -4188 0.653041187425465 0.6684380225676578 0 -4189 0.4189470857173174 0.9574438514246758 0 -4190 0.3121607265807631 0.5899502794574656 0 -4191 0.4954205747884621 0.8719822753036138 0 -4192 0.3746001987168552 0.9138713197218982 0 -4193 0.9642427727747984 0.567449305173046 0 -4194 0.3308461375764 0.9368270220730066 0 -4195 0.5532560507595492 0.6623870694946646 0 -4196 0.46947858533257 0.8358417473975678 0 -4197 0.07678573368741082 0.6698713127203624 0 -4198 0.9406697144130838 0.135919380670786 0 -4199 0.9111822936040488 0.5119950407053048 0 -4200 0.6117501189139222 0.6754370909944122 0 -4201 0.148800994187358 0.5580918393546355 0 -4202 0.03944298110645466 0.4999360485796459 0 -4203 0.4043861484784972 0.9219950972566929 0 -4204 0.8177682260848396 0.9823603729776671 0 -4205 0.1822317739143021 0.9823603729777572 0 -4206 0.05018573287253508 0.2333541202418692 0 -4207 0.8792964947067313 0.7722314518378967 0 -4208 0.1210312750670137 0.7757781122401488 0 -4209 0.5212378253639011 0.7153401793001432 0 -4210 0.3993189523506581 0.5092643407741604 0 -4211 0.6215447929455843 0.9558615499438374 0 -4212 0.7817899106112969 0.4334925735279735 0 -4213 0.3209330122588003 0.3145276898322378 0 -4214 0.2608269827239185 0.5071001087932713 0 -4215 0.9766587151824272 0.7986238105878593 0 -4216 0.02334128481753584 0.7986238105882302 0 -4217 0.5256761037587305 0.5787894945510511 0 -4218 0.8178026128082712 0.899194814775815 0 -4219 0.1821973871908463 0.8991948147763119 0 -4220 0.5876489163598397 0.8960129626470158 0 -4221 0.2354219329630357 0.6304638051482453 0 -4222 0.1088497966177338 0.4925824156507881 0 -4223 0.2890603050486202 0.4573119855372815 0 -4224 0.4347170268060512 0.6794816080849942 0 -4225 0.9463337944630184 0.8781899975460656 0 -4226 0.05366620553670987 0.8781899975465519 0 -4227 0.5781537401078798 0.2197283733095203 0 -4228 0.2717949900413541 0.7405866294768793 0 -4229 0.7785837982243997 0.8025389755972611 0 -4230 0.2190172555565114 0.8008042063326757 0 -4231 0.6249857477072267 0.8004556778475509 0 -4232 0.8154028290314947 0.8225068767308984 0 -4233 0.1845971709676346 0.822506876731719 0 -4234 0.3666236668192 0.1422922928571595 0 -4235 0.8084459013379517 0.6015972105669998 0 -4236 0.5774078150218241 0.375580701333 0 -4237 0.9661265115387374 0.9841005147175761 0 -4238 0.0338734884611159 0.9841005147176254 0 -4239 0.7768425360144945 0.9542419905654701 0 -4240 0.2231574639844001 0.9542419905657221 0 -4241 0.7274601784845142 0.9187425015230839 0 -4242 0.272539821514108 0.9187425015235092 0 -4243 0.7123039187862135 0.843576073033442 0 -4244 0.2891750433666406 0.8412353002808484 0 -4245 0.7649557352010862 0.3470911339511453 0 -4246 0.4144061693469608 0.6196748796052526 0 -4247 0.5284318275921717 0.4189717085079954 0 -4248 0.1581858591539055 0.7405140104941563 0 -4249 0.2356182000751463 0.7685307557620108 0 -4250 0.8404689079172426 0.8114271582676238 0 -4251 0.1595310920820464 0.8114271582684899 0 -4252 0.3749058911679697 0.800217907204281 0 -4253 0.4101036052345142 0.8923386518629746 0 -4254 0.7282028726225347 0.6855942601453904 0 -4255 0.8128317701772946 0.3546456262646864 0 -4256 0.8826181543782359 0.9656653926308252 0 -4257 0.1173818456212346 0.9656653926309833 0 -4258 0.9681012241022898 0.6287981430492779 0 -4259 0.9622928521181487 0.5224470399746449 0 -4260 0.6927129276204577 0.6504456434991349 0 -4261 0.3872156631590173 0.6857063390311052 0 -4262 0.8330713946194136 0.8835088728666287 0 -4263 0.1669286053798003 0.8835088728671758 0 -4264 0.1589882140904168 0.4317466522737323 0 -4265 0.8609270414630412 0.9846156340177163 0 -4266 0.1390729585363213 0.984615634017788 0 -4267 0.5913896038992233 0.8633620682394447 0 -4268 0.72725250426397 0.5723162240926558 0 -4269 0.5777770824084649 0.9836421937203268 0 -4270 0.5328575653224693 0.9570776422950392 0 -4271 0.7873034218702757 0.9833672010215657 0 -4272 0.2126965781286913 0.9833672010216515 0 -4273 0.6441606398056978 0.6132322795170921 0 -4274 0.6994356293452143 0.8096871781219145 0 -4275 0.1226475246850834 0.1875480366001286 0 -4276 0.8284606224841331 0.9248379800449589 0 -4277 0.1715393775150499 0.9248379800453225 0 -4278 0.215151586117989 0.5659056360359447 0 -4279 0.5909625304182651 0.9603385785395139 0 -4280 0.952147064860504 0.9608393396282813 0 -4281 0.04785293513927594 0.9608393396284717 0 -4282 0.2892931448533498 0.203819110741244 0 -4283 0.8837864673712319 0.8181226502148615 0 -4284 0.1162135326284134 0.818122650215849 0 -4285 0.4524714056928162 0.9660606611347801 0 -4286 0.7500348566670829 0.6702660646340582 0 -4287 0.8984699849189154 0.3884363547467543 0 -4288 0.6120136152325861 0.855481988792079 0 -4289 0.7123982478825868 0.9512484434322225 0 -4290 0.2876017521159564 0.95124844343249 0 -4291 0.3251735374695774 0.7645749675843103 0 -4292 0.6987176572202061 0.9833749515446357 0 -4293 0.2323036375657582 0.6713241195754749 0 -4294 0.6706938876578555 0.9374421594994932 0 -4295 0.6680525837539829 0.8042179040513306 0 -4296 0.3323808225580119 0.8035858973424583 0 -4297 0.4296280512866321 0.9272315192418585 0 -4298 0.9839692389031088 0.9627670939033381 0 -4299 0.01603076109681119 0.9627670939033469 0 -4300 0.9762271832776135 0.844602191326422 0 -4301 0.02377281672242474 0.8446021913268096 0 -4302 0.7363329351765777 0.8371095671086237 0 -4303 0.2636670648221165 0.8371095671094548 0 -4304 0.3606825405886664 0.7575201954927218 0 -4305 0.7422803808432308 0.8741983428270844 0 -4306 0.2577196191555026 0.8741983428277326 0 -4307 0.9307468199854612 0.9845839230804445 0 -4308 0.06925318001422211 0.9845839230805181 0 -4309 0.03066018468121775 0.6425451600761815 0 -4310 0.583584840411836 0.746125640291881 0 -4311 0.572195197005028 0.5315011239661203 0 -4312 0.6408093900688562 0.7218411301887434 0 -4313 0.4697951054252912 0.5877864378428547 0 -4314 0.8093931937911109 0.9601833427440208 0 -4315 0.1906068062079767 0.9601833427442276 0 -4316 0.4788135554551597 0.984507925044958 0 -4317 0.3385109887976677 0.4964301806522455 0 -4318 0.9127156321561187 0.6348008950957074 0 -4319 0.4369107942813762 0.7169337049851341 0 -4320 0.579938791559432 0.7175566233038171 0 -4321 0.7607839706411667 0.5034019375886101 0 -4322 0.2363149133897059 0.715485310265731 0 -4323 0.9071960248454136 0.8855578923401635 0 -4324 0.09280397515411964 0.8855578923406052 0 -4325 0.6091701709748906 0.7035264650707285 0 -4326 0.6429030743141277 0.4862127562180408 0 -4327 0.6988582300841595 0.5826643179188586 0 -4328 0.464147177301004 0.7253598773937149 0 -4329 0.3005270216020079 0.8120587996798611 0 -4330 0.300607789766402 0.9843239788964718 0 -4331 0.2456284629751048 0.140025942446175 0 -4332 0.4778640197923424 0.6789772247115572 0 -4333 0.5015117095401601 0.6618453099726923 0 -4334 0.5469573884852025 0.05836509929272661 0 -4335 0.9242334835857872 0.5823619041976059 0 -4336 0.4427068940723775 0.8678953605069092 0 -4337 0.03897824405264215 0.4255207633722623 0 -4338 0.839508223742877 0.7867970397521789 0 -4339 0.1606641257020042 0.7869872849403499 0 -4340 0.746695672353308 0.9047276844559351 0 -4341 0.2533043276454708 0.9047276844564223 0 -4342 0.7948208858180777 0.8625473633462948 0 -4343 0.2051791141809537 0.8625473633469221 0 -4344 0.5235787250849806 0.2114317069170367 0 -4345 0.38655707458157 0.8532201153420796 0 -4346 0.7411135888878527 0.8109425605399417 0 -4347 0.258886411110892 0.8109425605409118 0 -4348 0.3907323827744286 0.7148311098325104 0 -4349 0.5115005885700075 0.9112587614801924 0 -4350 0.3591099259743124 0.9015542273498706 0 -4351 0.9199724311661232 0.7938573842643601 0 -4352 0.08002756883399992 0.7938573842648261 0 -4353 0.9074424394777332 0.9662350089353547 0 -4354 0.09255756052184506 0.9662350089354927 0 -4355 0.7445598049645732 0.9415364299399196 0 -4356 0.2554401950341465 0.9415364299402307 0 -4357 0.09079282021182447 0.4394015518659876 0 -4358 0.8688124431831207 0.05587203788803644 0 -4359 0.5449999999988019 0.9855055569334812 0 -4360 0.970718127536738 0.6579886322986841 0 -4361 0.6270462974900015 0.8781641155471279 0 -4362 0.5759608309224681 0.8309285141630248 0 -4363 0.5091879395726132 0.2903089476269688 0 -4364 0.9049666550446075 0.831357416884376 0 -4365 0.09503334495522955 0.8313574168849251 0 -4366 0.4047605200544121 0.9852089478933519 0 -4367 0.7839481847743417 0.1853380952839349 0 -4368 0.6553758021859476 0.95976128939006 0 -4369 0.9530227302202041 0.8425431732731207 0 -4370 0.4898214436049057 0.7605839124387881 0 -4371 0.04697726977979349 0.8425431732735029 0 -4372 0.4226325673020617 0.8315699086329623 0 -4373 0.5503768242921083 0.8295909368041694 0 -4374 0.8895908001284538 0.7949901540555262 0 -4375 0.1104091998714518 0.7949901540561788 0 -4376 0.5300357933614327 0.5085734678144831 0 -4377 0.5930058750112064 0.1473401049883523 0 -4378 0.5648937154855328 0.789753139041754 0 -4379 0.1921525717553448 0.1380332274773228 0 -4380 0.6037688203934459 0.6264619259630432 0 -4381 0.3573165084085756 0.6268086383554263 0 -4382 0.6793492651449903 0.3967190097693571 0 -4383 0.4100546746864584 0.543175586984796 0 -4384 0.02481889649770756 0.7408862262109449 0 -4385 0.8823497211045771 0.9407385491438378 0 -4386 0.1176502788948721 0.9407385491440795 0 -4387 0.910398456065494 0.4752131980958018 0 -4388 0.6382512685484949 0.5629308340229312 0 -4389 0.983274353118995 0.8659010068470642 0 -4390 0.01672564688104667 0.8659010068473254 0 -4391 0.80359815729717 0.6892955454444958 0 -4392 0.9613529693410883 0.9400784811749527 0 -4393 0.03864703065873431 0.9400784811752438 0 -4394 0.5465440712398143 0.1152066563339837 0 -4395 0.9530129424304521 0.2219299265352334 0 -4396 0.9376239441990601 0.8586393446916988 0 -4397 0.06237605580059076 0.858639344692042 0 -4398 0.9310885812739986 0.953167967930412 0 -4399 0.06891141872568041 0.953167967930638 0 -4400 0.4368637400556633 0.900440676107684 0 -4401 0.5263685173136283 0.6745922987678168 0 -4402 0.932969170187985 0.7289481443605363 0 -4403 0.06721887853042244 0.730926206687617 0 -4404 0.3978626110153731 0.3001717868011036 0 -4405 0.1365114717813342 0.6216478897856069 0 -4406 0.7097882301942846 0.7396670020981297 0 -4407 0.7634901223069601 0.9198848337795423 0 -4408 0.2365098776918438 0.9198848337799556 0 -4409 0.9555969088656413 0.343167279548561 0 -4410 0.073521086194719 0.6053575833081043 0 -4411 0.7408817106852263 0.9848919984122476 0 -4412 0.259118289313472 0.9848919984123321 0 -4413 0.3467405722761419 0.7215469229889513 0 -4414 0.4991594070126318 0.9562564100269246 0 -4415 0.2993212860776926 0.7699112619390476 0 -4416 0.5692511537537276 0.9280866937020332 0 -4417 0.4961243376742727 0.8008597257421526 0 -4418 0.3591880362722107 0.9569904603465522 0 -4419 0.4855167214747754 0.7111180581948667 0 -4420 0.1429375181241524 0.7195379585894548 0 -4421 0.7377233863352015 0.7806642483221269 0 -4422 0.4940638999692694 0.3833932484941977 0 -4423 0.9756477061154386 0.7395627253130794 0 -4424 0.848501248433761 0.6009274416264685 0 -4425 0.5986209570029333 0.4957019118453793 0 -4426 0.4551462373220299 0.8174222746511651 0 -4427 0.6497251240118871 0.9852841310816947 0 -4428 0.772837444919662 0.2765357722692596 0 -4429 0.8319219429830258 0.9852312018038476 0 -4430 0.1680780570161887 0.9852312018039197 0 -4431 0.9838784262275327 0.9314167121411563 0 -4432 0.01612157377246597 0.9314167121415271 0 -4433 0.7892111868021847 0.9657754207795983 0 -4434 0.2107888131967959 0.9657754207797598 0 -4435 0.8299224244287199 0.6931099927529414 0 -4436 0.03553274085104305 0.3851073447217034 0 -4437 0.3828717557928699 0.3660470602145655 0 -4438 0.8607544447388072 0.9277356076050532 0 -4439 0.1392455552605421 0.9277356076053742 0 -4440 0.5320184694095568 0.8610594270077749 0 -4441 0.9196226908645392 0.9147463999850767 0 -4442 0.0803773091351562 0.9147463999854427 0 -4443 0.4607625308949944 0.5000828750898957 0 -4444 0.4994923380289608 0.6335840511710834 0 -4445 0.8689006087936391 0.715816020847875 0 -4446 0.6549047042722501 0.9056033193793724 0 -4447 0.7367859782813511 0.3771964966871399 0 -4448 0.6793901441409342 0.8436778598440744 0 -4449 0.3204894920243718 0.845131813416279 0 -4450 0.1835536431381338 0.6506583751830796 0 -4451 0.4183302060291356 0.7974950109419057 0 -4452 0.8929287800356238 0.7556929126216591 0 -4453 0.1053229141234123 0.7550045511323797 0 -4454 0.8811536865799884 0.2109621857113673 0 -4455 0.02478730192561753 0.6877491647591362 0 -4456 0.6720622581486468 0.985675867582708 0 -4457 0.881667249253515 0.6774313806213659 0 -4458 0.885735952061109 0.3445037663599173 0 -4459 0.4819246219540796 0.9569915920145833 0 -4460 0.6059368427425051 0.9859146385147458 0 -4461 0.4218249740480245 0.7512429267474314 0 -4462 0.347991275404802 0.9852700731640898 0 -4463 0.3100790472046395 0.9623724181092579 0 -4464 0.03077689675695584 0.5815712977010579 0 -4465 0.7695755707637613 0.9836357870623891 0 -4466 0.2304244292351001 0.983635787062479 0 -4467 0.8310285978986405 0.9520822175565333 0 -4468 0.1689714021005676 0.9520822175567816 0 -4469 0.7232264259265574 0.1493028537238696 0 -4470 0.3337784025460912 0.6922721991271411 0 -4471 0.4010649640659603 0.7630875734780288 0 -4472 0.3335750069720571 0.8977851369565717 0 -4473 0.320151516785479 0.4166539826071847 0 -4474 0.04525146285377688 0.1285307964486906 0 -4475 0.7029506534282881 0.9187611718790711 0 -4476 0.2970493465702106 0.9187611718794991 0 -4477 0.577458411552247 0.4650794872317074 0 -4478 0.7772780608337554 0.5637406236661064 0 -4479 0.6274458713373718 0.294737887195841 0 -4480 0.3402308032768444 0.9583271934154453 0 -4481 0.9655372861193436 0.4114729141677723 0 -4482 0.6048178866894602 0.754874035520825 0 -4483 0.2649953211046795 0.7854024814047691 0 -4484 0.5633763085672839 0.7581249308719005 0 -4485 0.6663946055386091 0.692684598080342 0 -4486 0.6898119723667749 0.9623822172674116 0 -4487 0.6633144207879084 0.2044185710599025 0 -4488 0.8915783682334831 0.9150835949353375 0 -4489 0.1084216317660134 0.9150835949356887 0 -4490 0.5656089150251524 0.3000870950981298 0 -4491 0.5240067500661805 0.7672921248304236 0 -4492 0.5880271998280873 0.9171836962947247 0 -4493 0.4418618076910997 0.766331950247692 0 -4494 0.8172304924097237 0.1443674750316388 0 -4495 0.5884288835025486 0.6603790974821879 0 -4496 0.1002129555984499 0.3779090475430751 0 -4497 0.4575145703654934 0.9403124906981405 0 -4498 0.870179726730081 0.5470319090912135 0 -4499 0.4696374371038621 0.7492340541591153 0 -4500 0.673769236679059 0.7707740597298745 0 -4501 0.5318576114014157 0.8986761314127332 0 -4502 0.5218613209853941 0.6181098395527759 0 -4503 0.1974524171120151 0.4282689812763747 0 -4504 0.4017515156303268 0.7851060138691734 0 -4505 0.04780323507972768 0.05487422002550797 0 -4506 0.4114716683571265 0.8655213683461609 0 -4507 0.7910539450715225 0.912265047637396 0 -4508 0.2089460549274409 0.9122650476378141 0 -4509 0.45455549125573 0.3061929954949973 0 -4510 0.955744098942764 0.9128874289312698 0 -4511 0.04425590105702777 0.9128874289316753 0 -4512 0.5651286167332699 0.8948699796928105 0 -4513 0.878761267586768 0.5892746125547498 0 -4514 0.1251918291821691 0.6675057899906389 0 -4515 0.4682984991708331 0.05055942938849233 0 -4516 0.8094355736479262 0.7797749969701746 0 -4517 0.1885456046065702 0.7789615847900669 0 -4518 0.4338480018221658 0.986550330973456 0 -4519 0.1051969979247443 0.3025397346545027 0 -4520 0.6145913437833852 0.937200431935502 0 -4521 0.8941486672735088 0.2960100276686933 0 -4522 0.7621025870996359 0.8701676938050237 0 -4523 0.2378974128992097 0.8701676938056849 0 -4524 0.6491833491120912 0.8691898579101669 0 -4525 0.7764985243626041 0.7581235582925057 0 -4526 0.9600903262589857 0.3059469331223119 0 -4527 0.8714236141350642 0.8705709423447079 0 -4528 0.1285763858643948 0.8705709423453192 0 -4529 0.3549997451643404 0.8687730289245701 0 -4530 0.6130778212997431 0.8929830465773411 0 -4531 0.4057401835730334 0.5876591652920559 0 -4532 0.9190243706037935 0.7559928109199173 0 -4533 0.07969592902632916 0.7570260689636483 0 -4534 0.268702415266308 0.5334974601228191 0 -4535 0.6231628467544305 0.2280738463357483 0 -4536 0.6148255008929835 0.3646583908409751 0 -4537 0.3327181895470448 0.3533069664297089 0 -4538 0.9315597177054287 0.9349740308664207 0 -4539 0.06844028229425707 0.9349740308667263 0 -4540 0.7023863291171075 0.7747467373391873 0 -4541 0.767563421434027 0.04335424820394286 0 -4542 0.1923738814054475 0.05048551798667247 0 -4543 0.2601403702200449 0.718238224122644 0 -4544 0.4524304607593893 0.6542358273700979 0 -4545 0.6684396524880638 0.8959450415307103 0 -4546 0.7423766989101752 0.3131965571740003 0 -4547 0.8025376525927528 0.8044176377594576 0 -4548 0.1973709869909074 0.8043688949906381 0 -4549 0.5514882302802985 0.6297953184120207 0 -4550 0.6025963756044175 0.8247121502737602 0 -4551 0.3928311769916887 0.9655965867857617 0 -4552 0.3819947944702387 0.7511370645146794 0 -4553 0.6218994549638804 0.9867217772533503 0 -4554 0.1067019149185636 0.05008365196551715 0 -4555 0.7448933133641312 0.9692132325529367 0 -4556 0.2551066866345851 0.9692132325531059 0 -4557 0.7049906672730077 0.2362403419329754 0 -4558 0.09229352345904224 0.6459327625225481 0 -4559 0.7188993472467858 0.9657002055969738 0 -4560 0.281093764314615 0.9656842186376928 0 -4561 0.4031792880669763 0.6409170383114769 0 -4562 0.4606803108629366 0.8998680736464936 0 -4563 0.4144422508924542 0.6721841764260461 0 -4564 0.5072947509921949 0.8396711887019627 0 -4565 0.2031565039787224 0.2282659276279122 0 -4566 0.730299327131943 0.9354447150784463 0 -4567 0.2697006728666984 0.9354447150787927 0 -4568 0.736110509560569 0.4207020054368987 0 -4569 0.714874794388057 0.6329404695623139 0 -4570 0.1919318159283765 0.3130196081427881 0 -4571 0.8011639175620224 0.6536288128406776 0 -4572 0.7789131635887725 0.8923394662573898 0 -4573 0.2210868364101498 0.8923394662579125 0 -4574 0.6522519173120341 0.6415391168732191 0 -4575 0.3256457593821224 0.9687195795588424 0 -4576 0.704293724296881 0.6980033347395105 0 -4577 0.7626264473571067 0.9665297123582485 0 -4578 0.2373735526417199 0.9665297123584335 0 -4579 0.2567150268995104 0.7615333333404951 0 -4580 0.2344645676509308 0.2949113594955596 0 -4581 0.6895207255428494 0.5180353900545109 0 -4582 0.4477248849025197 0.5511916270674926 0 -4583 0.458512750639854 0.09976236982341606 0 -4584 0.4381236946706226 0.2366187113686198 0 -4585 0.4703157961268539 0.6192038404373763 0 -4586 0.2188710135633744 0.4566059262066102 0 -4587 0.4485772014173951 0.1691320569358384 0 -4588 0.5009078481490166 0.2484561439201259 0 -4589 0.3010730508605822 0.695893693097698 0 -4590 0.5461573224448751 0.9512366431236191 0 -4591 0.817588029087444 0.7393026443411698 0 -4592 0.8035574359172624 0.9390239340707808 0 -4593 0.1964425640817874 0.9390239340710785 0 -4594 0.05377553902574608 0.6962102147243189 0 -4595 0.3575446973412431 0.6718384418780827 0 -4596 0.3936506552509297 0.8234267869553715 0 -4597 0.2019640801178211 0.7187358848503024 0 -4598 0.5980960474222152 0.7841559973351409 0 -4599 0.2000091004688817 0.6753463507162136 0 -4600 0.4946847496913059 0.9864622573437717 0 -4601 0.6981958160668515 0.8296921636075698 0 -4602 0.7250150708036874 0.9859629153449846 0 -4603 0.2749849291949257 0.9859629153450645 0 -4604 0.07941762321906853 0.4861383029383231 0 -4605 0.9644133904028225 0.9543010805490126 0 -4606 0.03558660959703946 0.9543010805492369 0 -4607 0.8461682838489979 0.9172448967858231 0 -4608 0.1538317161502788 0.9172448967862012 0 -4609 0.6583659327926346 0.9270635972431075 0 -4610 0.4429428010036467 0.8330283988417559 0 -4611 0.1888064620639478 0.4945501051057486 0 -4612 0.6631198990868146 0.8267140111677714 0 -4613 0.1840426968084858 0.7398133751899683 0 -4614 0.6335251775883236 0.1202161583586886 0 -4615 0.3367450146974876 0.826951304483424 0 -4616 0.616428729744779 0.04644741922359286 0 -4617 0.7733635198042366 0.6458078120245725 0 -4618 0.7211984903358652 0.8820832976046572 0 -4619 0.2788015096627712 0.8820832976052714 0 -4620 0.4791534119443885 0.787578150364989 0 -4621 0.162536170231705 0.3735201396869742 0 -4622 0.4309681104357922 0.9548491726490913 0 -4623 0.9376731744549708 0.966396171876972 0 -4624 0.06232682554474425 0.9663961718771367 0 -4625 0.1696840762533181 0.176595857913435 0 -4626 0.3709442894793484 0.2431212833787154 0 -4627 0.8045832888637388 0.989374059602862 0 -4628 0.1954167111353216 0.9893740596029115 0 -4629 0.7944195507668462 0.8800493777629592 0 -4630 0.2055804492321648 0.8800493777635386 0 -4631 0.2118768661757405 0.541004832766492 0 -4632 0.9337206777816904 0.6190329004581647 0 -4633 0.3233376376651838 0.5578462939970079 0 -4634 0.5139802863288074 0.9694212852097804 0 -4635 0.1656291894651775 0.6956296088971279 0 -4636 0.4871582255075413 0.9260467105996614 0 -4637 0.08785490363086111 0.5806506545499504 0 -4638 0.4894000631092195 0.5764959551055086 0 -4639 0.1976614433930418 0.7617886042226099 0 -4640 0.3029328830809087 0.8365365813296465 0 -4641 0.7688121921477635 0.7755390215497001 0 -4642 0.6737545422116287 0.9672155947472447 0 -4643 0.267394030215762 0.6288909262158033 0 -4644 0.6064630045692776 0.9657102705349869 0 -4645 0.6398808037930525 0.9493605958438921 0 -4646 0.3125833889387641 0.10839828534683 0 -4647 0.9443246291098051 0.8213818853687735 0 -4648 0.0556753708902047 0.8213818853691165 0 -4649 0.8515242230834098 0.8419582861881788 0 -4650 0.1484757769158916 0.841958286188924 0 -4651 0.5717865089234286 0.9531005438444464 0 -4652 0.2426695765718246 0.04826575958911149 0 -4653 0.4734524130993858 0.9418956252865138 0 -4654 0.4897820688570365 0.8280755129462247 0 -4655 0.09882246878988105 0.1339258624876183 0 -4656 0.03634324117345915 0.3184878662393518 0 -4657 0.3737585788213664 0.9700197811360203 0 -4658 0.6829676893902019 0.7370922600338261 0 -4659 0.04077267648994397 0.2630329368382108 0 -4660 0.343616855403062 0.6031794897426037 0 -4661 0.5813878641110238 0.8001235296171295 0 -4662 0.5864782415471743 0.5751817370522 0 -4663 0.7609643196880868 0.9426518533527931 0 -4664 0.239035680310721 0.9426518533531025 0 -4665 0.5422980710746017 0.7202354270875634 0 -4666 0.1764786830590726 0.6051687894537738 0 -4667 0.890843946629132 0.8562218752622501 0 -4668 0.1091560533704969 0.8562218752628983 0 -4669 0.8877760725127395 0.728646069155289 0 -4670 0.4479592964604158 0.9277338408656963 0 -4671 0.6278304184349093 0.9703980071566377 0 -4672 0.8217129226401849 0.861886585195078 0 -4673 0.1782870773589861 0.8618865851957012 0 -4674 0.0922954587565132 0.7146573383997523 0 -4675 0.6452412588685267 0.7572654487724414 0 -4676 0.2186900212288417 0.3669804641294163 0 -4677 0.6243541570411193 0.4339104362760116 0 -4678 0.83777548351273 0.5839086172065586 0 -4679 0.3455099528682801 0.9091510094998272 0 -4680 0.383703095754286 0.9451462378648988 0 -4681 0.3212793524608306 0.6503362796174167 0 -4682 0.4004672814002893 0.9384855423848155 0 -4683 0.5519806990747315 0.8021602196877113 0 -4684 0.7788397127860316 0.9217230683022447 0 -4685 0.221160287212863 0.9217230683026205 0 -4686 0.3457546923314817 0.9310873864003271 0 -4687 0.5722852877663713 0.8598796120811396 0 -4688 0.6874945940947382 0.3638331845871921 0 -4689 0.5090506451233625 0.8784735388166433 0 -4690 0.5479808399402115 0.5375866836472826 0 -4691 0.5219087240804288 0.8236005122856793 0 -4692 0.5425099358730595 0.9300225465712653 0 -4693 0.4907260774864399 0.9040897167538066 0 -4694 0.9005109503369915 0.5326836724779357 0 -4695 0.983269406890333 0.8220426412891244 0 -4696 0.01673059310975603 0.8220426412890948 0 -4697 0.4754761064838336 0.5276316190376414 0 -4698 0.3903250466780014 0.889951621884964 0 -4699 0.9506880020002371 0.9306407753960131 0 -4700 0.04931199799953104 0.9306407753963561 0 -4701 0.3018522923177177 0.3888463629861081 0 -4702 0.3839839453798468 0.03665051767711594 0 -4703 0.8883539441947487 0.9872728831254562 0 -4704 0.1116460558047455 0.9872728831255082 0 -4705 0.286330095349761 0.5822026134988346 0 -4706 0.5393782117661581 0.7521160984954444 0 -4707 0.208811572854605 0.5924179073997022 0 -4708 0.7939853943914685 0.7235596100738861 0 -4709 0.2210470374894082 0.7594670820354784 0 -4710 0.03603616253243968 0.1880924726119536 0 -4711 0.3036796513565139 0.5220898252418664 0 -4712 0.5154613282918912 0.9883354811796519 0 -4713 0.6421464707708889 0.9341440850859943 0 -4714 0.117452466995229 0.5507304602602908 0 -4715 0.6667936216912146 0.4601533587484602 0 -4716 0.5531844556502952 0.3985222892166186 0 -4717 0.3168893924154402 0.9428790527534245 0 -4718 0.5204551633336221 0.9264992532641136 0 -4719 0.3022006552686977 0.6212168087779859 0 -4720 0.9152424296816811 0.2344292618557473 0 -4721 0.3760773062836893 0.9878999879005104 0 -4722 0.7837266766510144 0.9432940125264874 0 -4723 0.2162733233479274 0.9432940125267799 0 -4724 0.4076799512619956 0.4437178662111513 0 -4725 0.4975859594470461 0.4761749825917119 0 -4726 0.324463251956238 0.04499581125375135 0 -4727 0.4146976236798355 0.7246908303003929 0 -4728 0.9538862700152066 0.04633049007705144 0 -4729 0.3774636998957664 0.8716225704949093 0 -4730 0.9583353223241859 0.1653748879855031 0 -4731 0.9015805130137894 0.9862109090065347 0 -4732 0.09841948698576823 0.9862109090065951 0 -4733 0.414401146771723 0.8157852015133236 0 -4734 0.9203846424827297 0.8262823021023205 0 -4735 0.07961535751721931 0.8262823021027366 0 -4736 0.9061103537776959 0.1512129276506391 0 -4737 0.318637931874537 0.7309484800611064 0 -4738 0.9757102624061534 0.6070918659185583 0 -4739 0.2601411949091204 0.4320170794257248 0 -4740 0.7029467824269312 0.666954002396377 0 -4741 0.8715399292135444 0.9537452019357051 0 -4742 0.1284600707858677 0.9537452019359143 0 -4743 0.03660690144360458 0.4699482155651072 0 -4744 0.02115234061974883 0.6692755019580447 0 -4745 0.9392678820399233 0.6857310314867427 0 -4746 0.3739279011555624 0.4088167583692774 0 -4747 0.9530437810158608 0.9878883726563873 0 -4748 0.04695621898392399 0.987888372656445 0 -4749 0.8383715861939796 0.9651150884316164 0 -4750 0.1616284138052659 0.9651150884317923 0 -4751 0.9041974549634386 0.9435387285717887 0 -4752 0.09580254503611618 0.9435387285720216 0 -4753 0.4729540853753477 0.9707305604282104 0 -4754 0.7447637073575042 0.6046028284871913 0 -4755 0.5903072527419406 0.8809361827323285 0 -4756 0.7067970866651814 0.8649089851688362 0 -4757 0.2930248105820971 0.8667797075364094 0 -4758 0.1668991986014853 0.2583439151100742 0 -4759 0.1159014052448029 0.4208624844767714 0 -4760 0.8423494568515422 0.7131331252418645 0 -4761 0.7506363308139662 0.1986024027847505 0 -4762 0.6992252775687888 0.6117943730113155 0 -4763 0.5680277529825999 0.7009693496938558 0 -4764 0.1847974711280001 0.7018055607606748 0 -4765 0.4586745832089438 0.9857874070075663 0 -4766 0.7069727181665433 0.4806830738716628 0 -4767 0.3229818500318972 0.9870453585554235 0 -4768 0.7263537345733269 0.5370698933246615 0 -4769 0.2522338917591772 0.6037235717123212 0 -4770 0.3706660890842341 0.590267948045446 0 -4771 0.8532324282846449 0.8967909500031076 0 -4772 0.1467675717146815 0.8967909500035701 0 -4773 0.7720480490902275 0.09989864346685573 0 -4774 0.9502876830119171 0.705325885770417 0 -4775 0.462039299277943 0.8767269808360537 0 -4776 0.1838676898238972 0.1058650212504526 0 -4777 0.9717567890806549 0.09477842776969694 0 -4778 0.9874823599908193 0.918832877969032 0 -4779 0.01251764000922085 0.918832877969071 0 -4780 0.6426485491875844 0.7952646019017354 0 -4781 0.3898005155208747 0.1084151561917851 0 -4782 0.9701357849872999 0.4739650487699505 0 -4783 0.0977519534936709 0.5245453271723145 0 -4784 0.9071216418035936 0.917995343198596 0 -4785 0.09287835819602877 0.917995343198915 0 -4786 0.6464134764729039 0.9714459192604341 0 -4787 0.2634062269380283 0.3349741214895251 0 -4788 0.5453065797168508 0.849228923250815 0 -4789 0.3243487085257435 0.2162313851964586 0 -4790 0.7004522986424968 0.3086582563520808 0 -4791 0.6904468816706001 0.9166571339239435 0 -4792 0.3094264538322506 0.9173364158356385 0 -4793 0.5351297449746113 0.9897865846011558 0 -4794 0.4591462733673363 0.7986743435425099 0 -4795 0.46624237337618 0.3514937657393399 0 -4796 0.4498796212907062 0.9491382590605051 0 -4797 0.3948725543899022 0.9894898432300012 0 -4798 0.08416083710533308 0.3291235883042632 0 -4799 0.6434825029665128 0.4017990504140753 0 -4800 0.9132336404005781 0.712345722184566 0 -4801 0.154011185808148 0.5336151742399392 0 -4802 0.3184332630961052 0.4709599927192966 0 -4803 0.1755076067365019 0.5517458006067848 0 -4804 0.6817007472810082 0.9450435357394182 0 -4805 0.8249884979852271 0.9109757754319345 0 -4806 0.1750115020139618 0.9109757754323851 0 -4807 0.8415933286254386 0.7524374246490647 0 -4808 0.7577450468202758 0.7184948859545455 0 -4809 0.8947739750908076 0.8936729836457905 0 -4810 0.1052260249087004 0.8936729836461729 0 -4811 0.6932236066475181 0.03473555838166742 0 -4812 0.5234212839220425 0.7867992677044451 0 -4813 0.8547459436581936 0.9650644923130818 0 -4814 0.1452540563411435 0.9650644923132412 0 -4815 0.97870877781248 0.6998854029806129 0 -4816 0.1558351086076337 0.4607026532243549 0 -4817 0.6989510646762392 0.8971903548871293 0 -4818 0.3010679240579274 0.8972323457263673 0 -4819 0.7013210049668487 0.9366044382436403 0 -4820 0.2986789950316359 0.9366044382439699 0 -4821 0.2266617024085076 0.7300499024592004 0 -4822 0.753107886442509 0.5729437332047816 0 -4823 0.6579763470566573 0.5041898843185321 0 -4824 0.8534118492987305 0.2359225900825024 0 -4825 0.08787294656800879 0.2120803019339342 0 -4826 0.2566664254068449 0.1780281697207023 0 -4827 0.8610660654085907 0.9569944779369624 0 -4828 0.1389339345907797 0.9569944779371602 0 -4829 0.5168416413228664 0.8957043087359037 0 -4830 0.6849406413491419 0.9919741862487816 0 -4831 0.7369806690829535 0.7154714355237344 0 -4832 0.6352713520513373 0.3361783905295457 0 -4833 0.6631799426860425 0.8755872493841583 0 -4834 0.3343288417891963 0.8757371426646688 0 -4835 0.9212291821833167 0.4057688694454099 0 -4836 0.864533335745074 0.1749122852578967 0 -4837 0.8336401401452128 0.9351325024402659 0 -4838 0.1663598598539914 0.9351325024405801 0 -4839 0.9105719078738415 0.6933988211279581 0 -4840 0.1424700919425121 0.3244341106681659 0 -4841 0.3581436736382321 0.796085658259623 0 -4842 0.9866134916948113 0.8930276506698603 0 -4843 0.01338650830528441 0.8930276506700876 0 -4844 0.8854192215159641 0.4876464359684089 0 -4845 0.5112520014175465 0.7590561206453793 0 -4846 0.6739313214184883 0.5969003856142566 0 -4847 0.3962959242549647 0.1634103260995631 0 -4848 0.8418447288494723 0.6762392938320727 0 -4849 0.9812569543096901 0.7848086677942459 0 -4850 0.01881372307979026 0.784729680474942 0 -4851 0.5137882628568271 0.3448366643845642 0 -4852 0.6887412027995981 0.2799340431496175 0 -4853 0.3622576993715632 0.5558428502585545 0 -4854 0.8056540770659428 0.2255853336345931 0 -4855 0.7189541380423627 0.8983786304157029 0 -4856 0.2810458619562458 0.8983786304162266 0 -4857 0.4071422309509173 0.9066984365929293 0 -4858 0.3794908868929149 0.815528868683733 0 -4859 0.3906917424510144 0.9182645475537514 0 -4860 0.7643327580337487 0.8396289482675536 0 -4861 0.2356672419650704 0.8396289482683506 0 -4862 0.594179502331774 0.9422974148993919 0 -4863 0.2381319771190976 0.6541169956965004 0 -4864 0.04976822784603793 0.6470641056222776 0 -4865 0.2696311499596786 0.2655317962671416 0 -4866 0.6855808341411013 0.4264429487141561 0 -4867 0.2792984786222473 0.4855304016234051 0 -4868 0.8653692909073772 0.8937983944388876 0 -4869 0.1346307090919995 0.8937983944393508 0 -4870 0.4646445080823403 0.9171635523180393 0 -4871 0.3390732559792228 0.1653333860733532 0 -4872 0.8818116651006314 0.09635827041908013 0 -4873 0.0710724602790857 0.2589720601952441 0 -4874 0.9669330412288966 0.8970193946804021 0 -4875 0.03306695877102058 0.897019394680634 0 -4876 0.8581159660750072 0.4888105791675406 0 -4877 0.343137009468495 0.4136362236236475 0 -4878 0.4300069976316885 0.9407615544179262 0 -4879 0.92183722061317 0.3566452204022475 0 -4880 0.5411570884081236 0.8832889544571457 0 -4881 0.3804137415704192 0.8985971720481861 0 -4882 0.5884998556684197 0.8189499213621407 0 -4883 0.6210106433351182 0.7201595945534632 0 -4884 0.9392482389685999 0.8913670476919378 0 -4885 0.06075176103109051 0.8913670476923846 0 -4886 0.5973277905118165 0.4385653140347797 0 -4887 0.6437692556791206 0.5921337346343518 0 -4888 0.580827871199326 0.8463249746306249 0 -4889 0.0207555340205806 0.5614069667224633 0 -4890 0.5676780410388665 0.5864898067351718 0 -4891 0.409165948070006 0.9508379929917182 0 -4892 0.9120701699761391 0.8688189869949596 0 -4893 0.0879298300234842 0.8688189869954061 0 -4894 0.8216741780674429 0.6430362163340165 0 -4895 0.9567557391353608 0.8142238572030772 0 -4896 0.04324426086468629 0.814223857203475 0 -4897 0.8452598851269453 0.9919788388723468 0 -4898 0.1547401148723363 0.9919788388723856 0 -4899 0.3012535695097676 0.7270220639585969 0 -4900 0.08519945312496757 0.6879541386102408 0 -4901 0.1212305375370554 0.6058311120064905 0 -4902 0.6798516998739077 0.8621277019237192 0 -4903 0.5063825376103249 0.7303727346379085 0 -4904 0.5173529196371808 0.8098411763964857 0 -4905 0.319858397357064 0.8614580706638379 0 -4906 0.5831218997312944 0.1823005388706544 0 -4907 0.5844274985768679 0.9257511830330689 0 -4908 0.4329034356593415 0.9135254494244904 0 -4909 0.9882447928851326 0.9515333211752529 0 -4910 0.01175520711475586 0.9515333211753346 0 -4911 0.7614647789325117 0.9072063927657334 0 -4912 0.2385352210663179 0.9072063927662035 0 -4913 0.6555658412948502 0.1712422902539469 0 -4914 0.2269349892538937 0.7851895024128966 0 -4915 0.2689394213876476 0.1062987817639553 0 -4916 0.7741688335458601 0.6170553067630911 0 -4917 0.8504232472537413 0.868568429519886 0 -4918 0.1495767527456071 0.8685684295205204 0 -4919 0.5553371157468618 0.9668903932523448 0 -4920 0.9504543417442475 0.7792295477871676 0 -4921 0.04955584242121347 0.7792065792234086 0 -4922 0.6390229153025938 0.8868952957083898 0 -4923 0.4393717364242948 0.6384980245982943 0 -4924 0.792000395902256 0.5886133219622913 0 -4925 0.8381583179030774 0.4219285671945029 0 -4926 0.9593761323240499 0.8843205818270767 0 -4927 0.04062386767575279 0.8843205818274329 0 -4928 0.5562683127146044 0.8834025456384866 0 -4929 0.8244651952184097 0.29510496941279 0 -4930 0.4270495583709386 0.6016844574337572 0 -4931 0.7709771901304896 0.691126737716119 0 -4932 0.6740535670200983 0.6627558843658486 0 -4933 0.7935021997556228 0.8408471559206453 0 -4934 0.2064978002433695 0.8408471559214012 0 -4935 0.5016369650488244 0.9700546122985526 0 -4936 0.5181429392166683 0.9452174919567924 0 -4937 0.5617586118445117 0.3533195127368686 0 -4938 0.9391004011153563 0.9037031976277033 0 -4939 0.06089959888436425 0.903703197628116 0 -4940 0.3612740057620218 0.9704312148077653 0 -4941 0.9357428002652518 0.5218856282729798 0 -4942 0.6289323365825634 0.8162332087032099 0 -4943 0.6636577287111055 0.8422217773575574 0 -4944 0.8389930540837744 0.3486254496723106 0 -4945 0.5521091244585765 0.4716962774820758 0 -4946 0.0160768216810224 0.7567231012665407 0 -4947 0.5327758515931108 0.9693305123988698 0 -4948 0.06140322785685506 0.55434875509074 0 -4949 0.5949999999989318 0.9896743306675176 0 -4950 0.8526507761503672 0.9459727691155227 0 -4951 0.1473492238489647 0.9459727691157815 0 -4952 0.6059897866569937 0.648221616418463 0 -4953 0.1147971940073089 0.7334704318800198 0 -4954 0.5583796942184404 0.9064835979423049 0 -4955 0.3363217241385607 0.842436546283304 0 -4956 0.03850236423959316 0.09223241709515365 0 -4957 0.423912494962583 0.3739676787543106 0 -4958 0.122613343865234 0.6948602717497976 0 -4959 0.01739095052503276 0.7240122910365234 0 -4960 0.6596385946464987 0.9884823983635385 0 -4961 0.891609952070811 0.6351941172933716 0 -4962 0.9701233425486937 0.3855839624186008 0 -4963 0.6608684790487522 0.7237568407611457 0 -4964 0.8506599925225098 0.2774471178430595 0 -4965 0.9575392037037951 0.9719460787129743 0 -4966 0.04246079629601784 0.9719460787131006 0 -4967 0.4165234454691434 0.9685284732413898 0 -4968 0.6126997242297176 0.918753344013894 0 -4969 0.9243124297470835 0.9450027394415761 0 -4970 0.07568757025256428 0.9450027394418223 0 -4971 0.469412428443719 0.9873305421820943 0 -4972 0.9206785601418177 0.9883261835303713 0 -4973 0.07932143985782412 0.9883261835304251 0 -4974 0.8120596512818863 0.9716240029911875 0 -4975 0.1879403487172224 0.9716240029913346 0 -4976 0.770818961999802 0.5407847038476805 0 -4977 0.6780513723973082 0.556559581606751 0 -4978 0.8978800267028546 0.9650858097316245 0 -4979 0.1021199732966838 0.9650858097317708 0 -4980 0.2814583273623882 0.6605158687020138 0 -4981 0.6976630200450493 0.7251208411348475 0 -4982 0.9840376089994251 0.7566061775203701 0 -4983 0.2858278448269874 0.7508807873504714 0 -4984 0.4967057804983742 0.5403417806675415 0 -4985 0.0502412847724172 0.7290836029317831 0 -4986 0.4619733789950513 0.6833897821083876 0 -4987 0.1265196311941812 0.1052868787407596 0 -4988 0.5078650324906274 0.920853151620471 0 -4989 0.6384852374803074 0.9066750780921067 0 -4990 0.7364731746683442 0.9634558221396033 0 -4991 0.26352682533033 0.9634558221398006 0 -4992 0.6891160658765612 0.095586999814881 0 -4993 0.5037471252528016 0.03896728383413605 0 -4994 0.7409006006397647 0.1146974479522675 0 -4995 0.5846151771762893 0.4074213038568516 0 -4996 0.4356922089734407 0.2825480949955279 0 -4997 0.5657721700122448 0.6792269593696305 0 -4998 0.3290380934332648 0.7877825393167952 0 -4999 0.6008386672399046 0.5294596771608022 0 -5000 0.8349443019474909 0.1155078734206416 0 -5001 0.5023860274722214 0.4469952352949974 0 -5002 0.2703961986714706 0.7021330932908022 0 -5003 0.8131925906621872 0.5408623304963612 0 -5004 0.1297273817789141 0.3724489656835632 0 -5005 0.4246599612086099 0.892802538746626 0 -5006 0.7763100154696981 0.8175158354587705 0 -5007 0.224388566535772 0.8143499829202114 0 -5008 0.7387215804611236 0.8599480188863123 0 -5009 0.2612784195375815 0.8599480188870301 0 -5010 0.8738488187496469 0.9103083738585536 0 -5011 0.1261511812497844 0.9103083738589435 0 -5012 0.7640515782274189 0.9545568547767385 0 -5013 0.2359484217714112 0.9545568547769883 0 -5014 0.831373130403257 0.558973945333673 0 -5015 0.8680757780772883 0.7609818948504242 0 -5016 0.1294638476459006 0.7621854941318609 0 -5017 0.3110613243373024 0.9887124541688382 0 -5018 0.9220427250238703 0.8606626323998143 0 -5019 0.07795727497578882 0.8606626324000337 0 -5020 0.9417861678840085 0.9882404659601929 0 -5021 0.05821383211572397 0.9882404659602515 0 -5022 0.9508270654451244 0.6682004222911797 0 -5023 0.3576787744724399 0.880599975592869 0 -5024 0.539802939757584 0.559770182072023 0 -5025 0.9510671300938625 0.7283624091990097 0 -5026 0.3640675996448079 0.7801075237679895 0 -5027 0.7261385643689831 0.9048692713818269 0 -5028 0.2738614356296784 0.904869271382306 0 -5029 0.6894460039748181 0.8872028865297157 0 -5030 0.9767714993954091 0.5425049972617094 0 -5031 0.9890027316946549 0.989000540458386 0 -5032 0.01099726830529886 0.9890005404584415 0 -5033 0.2625865754587793 0.6781752340475971 0 -5034 0.6179101965904941 0.9044299794826774 0 -5035 0.8132547235347167 0.9300743709896309 0 -5036 0.1867452764643688 0.9300743709899744 0 -5037 0.524406284522958 0.6934598319220648 0 -5038 0.3782615092491156 0.6349084305757908 0 -5039 0.6626652689566008 0.9506616219228358 0 -5040 0.6357162801957256 0.7785853647002019 0 -5041 0.8079114243299492 0.4258195863764619 0 -5042 0.310669965047068 0.8874551173656591 0 -5043 0.5549999999988277 0.9901655800605581 0 -5044 0.4959856217483723 0.9347314385464558 0 -5045 0.8299251139348738 0.8494739936103051 0 -5046 0.1700748860643388 0.8494739936109762 0 -5047 0.9081341703779142 0.04199459703658354 0 -5048 0.4142142758511766 0.9901135727327277 0 -5049 0.6378346716925686 0.2716722621385447 0 -5050 0.3673172576599544 0.9254441912547576 0 -5051 0.341527304482369 0.7627282999896445 0 -5052 0.4572721953121752 0.4155414208131247 0 -5053 0.5079572227263804 0.9500590199160572 0 -5054 0.2376816224658554 0.5742879074884594 0 -5055 0.9745244879306684 0.9902246194537165 0 -5056 0.02547551206921556 0.9902246194537441 0 -5057 0.6470587007778921 0.8555032461852675 0 -5058 0.5673889778672723 0.9406226592572706 0 -5059 0.6337581749228091 0.8463703739453378 0 -5060 0.5680323270783914 0.619191751873434 0 -5061 0.3538035277627635 0.8554430117307273 0 -5062 0.9014051075500746 0.6745583420229271 0 -5063 0.362466098917026 0.5049490863164018 0 -5064 0.3032603398106136 0.2865897644662442 0 -5065 0.1668815528163587 0.4039936364586142 0 -5066 0.1149500146128309 0.2772232090223813 0 -5067 0.1038851676812076 0.4651185606369614 0 -5068 0.4167324326882833 0.9260644692142805 0 -5069 0.7260181865851827 0.8040003642686325 0 -5070 0.3667160608091209 0.8457082816651672 0 -5071 0.3375061969047695 0.9705560191777511 0 -5072 0.7709624176420664 0.860802271390925 0 -5073 0.2290375823568365 0.8608022713916104 0 -5074 0.3960363219438788 0.3418465616041335 0 -5075 0.8119044025164397 0.6225464764590295 0 -5076 0.7444478833547234 0.6530663121773012 0 -5077 0.9900870695089854 0.9740975766235083 0 -5078 0.009912930491006593 0.9740975766234434 0 -5079 0.6376626905082672 0.5421582446319432 0 -5080 0.882375713780329 0.4401770692029364 0 -5081 0.4233996334594649 0.501888588002483 0 -5082 0.5428061534853096 0.81528977011626 0 -5083 0.8418724173188554 0.4677704237995647 0 -5084 0.4991339399869228 0.1840936993494534 0 -5085 0.8145705633159045 0.4724900903893299 0 -5086 0.8794684170086874 0.8824090096761323 0 -5087 0.1205315829908034 0.882409009676679 0 -5088 0.8050354954308878 0.4975883164856864 0 -5089 0.539473507225385 0.9071666360462252 0 -5090 0.361841210997004 0.4619573963603034 0 -5091 0.6331763645938775 0.6755800527522283 0 -5092 0.3859019818705427 0.5452656141405366 0 -5093 0.7404097078117062 0.749567729670761 0 -5094 0.02426725050262713 0.5169077631239762 0 -5095 0.7350939361304537 0.2515185926560914 0 -5096 0.6944706543320254 0.8731269822252588 0 -5097 0.7549999999993506 0.9903290090863985 0 -5098 0.2449999999994267 0.9903290090864517 0 -5099 0.3049534398688937 0.8734395338209101 0 -5100 0.935015700045758 0.4650474016749379 0 -5101 0.9681883080967127 0.496159786458995 0 -5102 0.7574164732983483 0.9304000256103756 0 -5103 0.2425835267004221 0.9304000256107443 0 -5104 0.6679466562036168 0.7865025630812479 0 -5105 0.8676661591069351 0.8445424800436135 0 -5106 0.1323338408925055 0.8445424800443757 0 -5107 0.3965123040782078 0.9774344107467947 0 -5108 0.4633280914129501 0.9659574602560177 0 -5109 0.7434656305206264 0.8237742245075967 0 -5110 0.2564873184514615 0.8238014769213915 0 -5111 0.9875230391491112 0.877410239057554 0 -5112 0.01247696085091714 0.8774102390575679 0 -5113 0.9344352611065331 0.7862586582770836 0 -5114 0.06556643625437983 0.7862548301835087 0 -5115 0.07285218411704038 0.3743053252397239 0 -5116 0.5690688878614443 0.9884829867286287 0 -5117 0.918905279245612 0.6006463948797403 0 -5118 0.4884531609779322 0.8842874628335226 0 -5119 0.9385202869210686 0.426289076893779 0 -5120 0.3158454751715092 0.8108558668298599 0 -5121 0.2342772624585029 0.6977847790370839 0 -5122 0.1375560793509955 0.2412083549386412 0 -5123 0.8449277634710357 0.5122831048780057 0 -5124 0.3046490019366623 0.9736185977841556 0 -5125 0.4752514563070881 0.8493880381711767 0 -5126 0.8542636486616962 0.6358716960267065 0 -5127 0.159698607478097 0.6789674547320546 0 -5128 0.643179236437199 0.4570935370095192 0 -5129 0.9144916963961325 0.894988459585855 0 -5130 0.08550830360344575 0.8949884595862676 0 -5131 0.9794660158838493 0.6753535209176129 0 -5132 0.8759631735047175 0.8567867564461413 0 -5133 0.1240368264947878 0.8567867564468286 0 -5134 0.1065252412336773 0.6639520236739958 0 -5135 0.2729260486338548 0.8062375519545395 0 -5136 0.8247815631215808 0.873716394453576 0 -5137 0.1752184368776253 0.8737163944541487 0 -5138 0.1897958296536132 0.3628880831336247 0 -5139 0.2499765241256236 0.7778883417090875 0 -5140 0.4071588647271394 0.8786305850592516 0 -5141 0.9128290240514687 0.841612734318911 0 -5142 0.08717097594838139 0.8416127343193748 0 -5143 0.02021287514756727 0.6235310925027717 0 -5144 0.6833829303666863 0.809024993201573 0 -5145 0.7853851154229555 0.3637018413143718 0 -5146 0.9813855232682474 0.5824742374836429 0 -5147 0.6102487421769622 0.8404201126373591 0 -5148 0.8733887577610135 0.6452625804511727 0 -5149 0.6608307860632888 0.3404079451449157 0 -5150 0.7983154869289883 0.789749236217539 0 -5151 0.2007968431690567 0.788833209365527 0 -5152 0.2073358737309552 0.4751016105422445 0 -5153 0.4803674957188557 0.8717115947124536 0 -5154 0.4426179569882082 0.4599504285728154 0 -5155 0.3619259225591073 0.8272109728864515 0 -5156 0.3554589461253074 0.9900837727039768 0 -5157 0.7767623535846901 0.990415880856788 0 -5158 0.223237646414211 0.9904158808568384 0 -5159 0.3975313790813489 0.4854341553029497 0 -5160 0.7150576304248653 0.9214683325151571 0 -5161 0.2849423695736952 0.9214683325155684 0 -5162 0.8543899416175985 0.4433571639152616 0 -5163 0.5819498798337325 0.9738230202218257 0 -5164 0.8063587237214788 0.7648135803400234 0 -5165 0.6958502305517058 0.8432078684934278 0 -5166 0.8360303725091969 0.04260653122301998 0 -5167 0.02621771837397401 0.3610286017234519 0 -5168 0.8696606899499334 0.9876609965077148 0 -5169 0.1303393100494757 0.9876609965077693 0 -5170 0.3341959893916868 0.9486358002402255 0 -5171 0.7436449067316085 0.4855718594521251 0 -5172 0.3569968154737739 0.9340834567269148 0 -5173 0.9681340456894977 0.9120110262325437 0 -5174 0.03186595431037328 0.9120110262330162 0 -5175 0.5435345226335198 0.4426095664459463 0 -5176 0.7487429352657344 0.5232106718544247 0 -5177 0.8207130038585 0.9548641209837042 0 -5178 0.179286996140646 0.9548641209839337 0 -5179 0.1584010394322435 0.7570371930364312 0 -5180 0.836825997525934 0.7723228680179753 0 -5181 0.2218523669649008 0.3962223316466019 0 -5182 0.7949999999994575 0.9908505882277465 0 -5183 0.204999999999543 0.9908505882277991 0 -5184 0.5417726202450382 0.7377555063450446 0 -5185 0.4383769047755908 0.8865817051417482 0 -5186 0.574555457092024 0.253403247818946 0 -5187 0.4621625070830343 0.440425029850484 0 -5188 0.9654227948826408 0.7877030491989589 0 -5189 0.03457720511725808 0.7877030491994333 0 -5190 0.1299790940145652 0.5034814486219871 0 -5191 0.4324054644828936 0.6996879538674258 0 -5192 0.1503559531774301 0.6394734883506403 0 -5193 0.2158534875305875 0.631746834386633 0 -5194 0.7090517307547576 0.3877709622683964 0 -5195 0.5858872264027336 0.9518754441734321 0 -5196 0.8565320932108919 0.7289850511565991 0 -5197 0.6136706840905868 0.8112392689471736 0 -5198 0.238115062702037 0.5139247698001013 0 -5199 0.8479069533546687 0.8549830104588492 0 -5200 0.1520930466446317 0.8549830104595373 0 -5201 0.5998767784867676 0.8904142414672902 0 -5202 0.5393277206267002 0.2916538515410138 0 -5203 0.805406002837185 0.8880715436557264 0 -5204 0.1945939971618714 0.8880715436562626 0 -5205 0.7772375961066424 0.8326297504502471 0 -5206 0.2228788342266912 0.8321021083611582 0 -5207 0.7668174442982527 0.8953508027249155 0 -5208 0.2331825557006116 0.8953508027254293 0 -5209 0.3424333137446891 0.5447217240797586 0 -5210 0.8205157561758523 0.837770214397819 0 -5211 0.1794842438232944 0.8377702143985475 0 -5212 0.8830028126541827 0.9533135146173488 0 -5213 0.1169971873452824 0.953313514617556 0 -5214 0.6946959043004026 0.9732307495146565 0 -5215 0.9360700638310563 0.7541472982841549 0 -5216 0.06392993616873585 0.7541472982846772 0 -5217 0.9398624986830005 0.5679549047713051 0 -5218 0.604177370866272 0.9764943476788297 0 -5219 0.8075491772361133 0.9048501113102634 0 -5220 0.1924508227629801 0.904850111310748 0 -5221 0.6228517738349927 0.6153168780852104 0 -5222 0.6326261579810137 0.928989566485664 0 -5223 0.7325960785849788 0.6219702714708674 0 -5224 0.8655585003149177 0.7778912400931604 0 -5225 0.9725535201360531 0.2644936684104823 0 -5226 0.1340196201633001 0.7789068587190143 0 -5227 0.9123430118126139 0.6563632945374235 0 -5228 0.3066298334747891 0.4362124759365882 0 -5229 0.2876192961424149 0.7338896847984326 0 -5230 0.4899992370050863 0.8142186915778594 0 -5231 0.706640242026236 0.9896319271960345 0 -5232 0.4303730967458493 0.7334833483198295 0 -5233 0.4767325465510325 0.9188784391144473 0 -5234 0.1380501193463946 0.5770252616307264 0 -5235 0.7632434635873423 0.8070239328148443 0 -5236 0.2372674749412016 0.80792183957368 0 -5237 0.255890201332829 0.4069164996566152 0 -5238 0.9282844235472367 0.9234016550842052 0 -5239 0.07171557645245262 0.9234016550845409 0 -5240 0.06528799927785493 0.4321214479949496 0 -5241 0.1766576888140433 0.289418804722693 0 -5242 0.7381690690418989 0.7955703565711139 0 -5243 0.617133428762052 0.8683853705007987 0 -5244 0.6939368945041369 0.1655306827226897 0 -5245 0.9260218840901469 0.3042453150095754 0 -5246 0.4481709195167204 0.5725819029032552 0 -5247 0.3728307874487243 0.7130280791519489 0 -5248 0.3897098822756728 0.839463962290024 0 -5249 0.3997821941353723 0.8555453845629071 0 -5250 0.1734993245506493 0.7763202093516812 0 -5251 0.742090131877999 0.9527379781504277 0 -5252 0.2579098681207102 0.9527379781506824 0 -5253 0.4821141852373999 0.2993129867789612 0 -5254 0.6720144972011768 0.7522723838228981 0 -5255 0.2330008762300516 0.2650899754366022 0 -5256 0.3725386845480658 0.3006344296584365 0 -5257 0.9042231491361261 0.7906231814785331 0 -5258 0.09577685086426178 0.7906231814790546 0 -5259 0.7939879977744374 0.2530369670517942 0 -5260 0.4536162473940435 0.8629012401679013 0 -5261 0.5212963154573466 0.1479593060513403 0 -5262 0.3246227488556793 0.926806955121945 0 -5263 0.8295458623780985 0.822029597332318 0 -5264 0.1704541376211094 0.8220295973331414 0 -5265 0.8558333757387951 0.8100727688163639 0 -5266 0.1441666242605573 0.8100727688171691 0 -5267 0.5196161522255479 0.4857737107830746 0 -5268 0.9843223995624026 0.7258518574591921 0 -5269 0.7018759523124585 0.7939921553216581 0 -5270 0.676016027205901 0.9285733367812452 0 -5271 0.9121452537933256 0.1154766126173065 0 -5272 0.755506620061819 0.7468307549357028 0 -5273 0.791575985934839 0.6088052663168417 0 -5274 0.2932798691915852 0.3224156276309679 0 -5275 0.5014369278155451 0.7134163020473379 0 -5276 0.82055080693794 0.5168836380138582 0 -5277 0.387533404737324 0.4621781094202846 0 -5278 0.05128400282736953 0.6287660496602137 0 -5279 0.03460714025316028 0.7533105507590314 0 -5280 0.3547544968696508 0.7399693958856419 0 -5281 0.2917601711017395 0.8254443557111342 0 -5282 0.9726322943127157 0.9357436505850862 0 -5283 0.02736770568715017 0.9357436505854155 0 -5284 0.4319654918597311 0.4059044408715901 0 -5285 0.6374361150961025 0.8284247037188236 0 -5286 0.5842379231280559 0.9913808476309784 0 -5287 0.7318062065405314 0.04257993922016536 0 -5288 0.02560615814477491 0.4468887657156778 0 -5289 0.4986757965944968 0.8595530560050555 0 -5290 0.3208581990273301 0.7499468631500931 0 -5291 0.3667655241511759 0.9508356120394291 0 -5292 0.4438340101402932 0.9597111088665262 0 -5293 0.7215801773459848 0.9436219837406786 0 -5294 0.2784198226526156 0.9436219837409818 0 -5295 0.9724657072513837 0.9580652277035442 0 -5296 0.02753429274847044 0.9580652277037225 0 -5297 0.8743623928258926 0.6977804221688909 0 -5298 0.7390161943571905 0.9136827936003996 0 -5299 0.2609838056415124 0.913682793600846 0 -5300 0.6323683379588645 0.7650808499292807 0 -5301 0.5235770841298011 0.9644236794299238 0 -5302 0.3322781282562632 0.246424902754788 0 -5303 0.3362405006770613 0.6713257412845458 0 -5304 0.9653690432395339 0.752528991473117 0 -5305 0.06287379901263582 0.6823045802867499 0 -5306 0.5372380963099356 0.7899851607455221 0 -5307 0.488660190545861 0.7758712787315541 0 -5308 0.8295298767544619 0.6054598431927647 0 -5309 0.09861230779935171 0.4038324746533998 0 -5310 0.4260518047415123 0.9922554152506118 0 -5311 0.5479763164510143 0.5863650408115094 0 -5312 0.6156685722985329 0.9472141273537935 0 -5313 0.7439761071343213 0.8897848336536878 0 -5314 0.2932919100414421 0.989676164650255 0 -5315 0.4563707391893222 0.7578789286387759 0 -5316 0.2560238928644302 0.8897848336542448 0 -5317 0.8717969861646168 0.9339535054886334 0 -5318 0.1282030138347887 0.9339535054889141 0 -5319 0.8361768973837429 0.6554329636143147 0 -5320 0.7721624882666293 0.4588009708542097 0 -5321 0.5629026383329533 0.8713537182590174 0 -5322 0.8477826548123145 0.8253913162917281 0 -5323 0.1522173451869763 0.8253913162925205 0 -5324 0.7076512537799944 0.7577794910488506 0 -5325 0.04985800291065232 0.5187901115382257 0 -5326 0.1969458240082952 0.6379959699686648 0 -5327 0.8739637297515515 0.8301474550132382 0 -5328 0.1260362702480043 0.8301474550141574 0 -5329 0.2411084893359467 0.4915948658299173 0 -5330 0.05406934188593593 0.710873543811207 0 -5331 0.5205186921204459 0.8697505543382205 0 -5332 0.2992074363023617 0.7843096476177206 0 -5333 0.8391046103578389 0.9468483478565857 0 -5334 0.1608953896414053 0.9468483478568449 0 -5335 0.1326735152528321 0.4791030194502448 0 -5336 0.5782782945324014 0.03281011326078123 0 -5337 0.4331656003184197 0.8416986674405361 0 -5338 0.1193585575141014 0.627472096040024 0 -5339 0.1595749620294631 0.7225253270156037 0 -5340 0.5389371993396629 0.9785569788626045 0 -5341 0.8078987044531767 0.950450476079024 0 -5342 0.1921012955458976 0.9504504760792704 0 -5343 0.8332403724215742 0.9742950945472981 0 -5344 0.1667596275776417 0.9742950945474309 0 -5345 0.3005307110320618 0.6645627141193889 0 -5346 0.5528369841890404 0.200441119057688 0 -5347 0.333818693788437 0.9918800823870025 0 -5348 0.7984870750002189 0.4524640829390401 0 -5349 0.7043617156350563 0.9566814952842739 0 -5350 0.2956689779394535 0.9566667840744669 0 -5351 0.8501845749080758 0.5479999732698959 0 -5352 0.9667778087269882 0.8723416609109442 0 -5353 0.03322219127293674 0.8723416609113666 0 -5354 0.397527838157975 0.6587464652802268 0 -5355 0.2834394819298297 0.6294922007435116 0 -5356 0.9178851767126699 0.5634088981991857 0 -5357 0.3226749168688524 0.8925151407023098 0 -5358 0.4027322168879597 0.9595759795357398 0 -5359 0.9416535657805366 0.9564428482482203 0 -5360 0.05834643421919553 0.956442848248432 0 -5361 0.5626690688892846 0.9183533116767988 0 -5362 0.5040859806015298 0.9916483304279144 0 -5363 0.8242849437424929 0.9906661568585273 0 -5364 0.1757150562566803 0.990666156858572 0 -5365 0.4325924217735703 0.7997492653317997 0 -5366 0.7997594736677044 0.9647470368919362 0 -5367 0.2002405263313317 0.9647470368921155 0 -5368 0.748687952595754 0.3997769667168176 0 -5369 0.9911302423176741 0.9390922546065326 0 -5370 0.008869757682275665 0.9390922546065725 0 -5371 0.5714276628474043 0.9780006191820558 0 -5372 0.4433513220044225 0.9910327184680642 0 -5373 0.02015509372546234 0.6011519107966657 0 -5374 0.1439101602146169 0.7508992823778862 0 -5375 0.6200939568871903 0.495286374946537 0 -5376 0.7274671818591365 0.848618449177415 0 -5377 0.2727440984472645 0.8482840530705651 0 -5378 0.6432544585052481 0.9900823207530784 0 -5379 0.3153442691296976 0.694139756825239 0 -5380 0.9128592016723825 0.2650902204886492 0 -5381 0.159984940955406 0.5758437202644342 0 -5382 0.7294863198714179 0.4465398443906924 0 -5383 0.03461466629849055 0.1569858678871573 0 -5384 0.3613033254546371 0.6445112137838246 0 -5385 0.1334747748295909 0.02819049858993528 0 -5386 0.01790504874113764 0.702903562862193 0 -5387 0.9638436100438381 0.8493952299419711 0 -5388 0.03615638995619053 0.8493952299423869 0 -5389 0.5104005688117166 0.5621606324279075 0 -5390 0.8485868936240687 0.3966638118287534 0 -5391 0.5822303777291926 0.551840157152456 0 -5392 0.3896076587326887 0.7913513153744456 0 -5393 0.6557923262270001 0.5578656295603011 0 -5394 0.6595613792812094 0.03087241957436808 0 -5395 0.455504869897236 0.832624089615408 0 -5396 0.430714586001322 0.9776977862790156 0 -5397 0.799015161172609 0.1139131715989302 0 -5398 0.3851924111465771 0.7342781241716263 0 -5399 0.9034115375009615 0.5855272665524046 0 -5400 0.9764633969399683 0.9714069577921862 0 -5401 0.02353660305993209 0.9714069577922384 0 -5402 0.9531856159126337 0.5451151946066675 0 -5403 0.5487345072633101 0.961641795492898 0 -5404 0.8550343707089232 0.991776536605103 0 -5405 0.1449656292904133 0.991776536605143 0 -5406 0.4095949693588038 0.8289658212092419 0 -5407 0.4707303367122314 0.2409402960610944 0 -5408 0.5116778845128261 0.5209975387284586 0 -5409 0.948700266946599 0.8652870429023096 0 -5410 0.05129973305320887 0.865287042902818 0 -5411 0.9557371753874487 0.9505996627925604 0 -5412 0.04426282461235116 0.9505996627928017 0 -5413 0.1900236045152789 0.2014261015874716 0 -5414 0.2516284256076846 0.5518628555944721 0 -5415 0.9049794834358502 0.956094044602073 0 -5416 0.0950205165637143 0.9560940446022459 0 -5417 0.7681526419839217 0.8822088838987264 0 -5418 0.2318473580149775 0.882208883899302 0 -5419 0.5517268935602417 0.9778392527422712 0 -5420 0.6095762548360281 0.5757632011835339 0 -5421 0.2782029378296607 0.2333285166087189 0 -5422 0.6038489335833827 0.7696910382109408 0 -5423 0.4554255657372077 0.9750238720835673 0 -5424 0.9217295542616711 0.7784756679481339 0 -5425 0.07827044573818411 0.7784756679486401 0 -5426 0.0569601898251524 0.6001080891940431 0 -5427 0.4534125120337798 0.1302057070658049 0 -5428 0.6785963509219842 0.9114897634988686 0 -5429 0.3214061824293293 0.9117030942611279 0 -5430 0.4479623742868082 0.8064744358316329 0 -5431 0.8700984782890788 0.8137393843248892 0 -5432 0.1298923027896278 0.8137823694942454 0 -5433 0.4070815336303174 0.5654014298713061 0 -5434 0.7982598870229242 0.920321011049468 0 -5435 0.2017401129760916 0.9203210110498637 0 -5436 0.3857889824962508 0.9568775252875303 0 -5437 0.8848042540411134 0.9750300667917142 0 -5438 0.1151957459583681 0.9750300667918295 0 -5439 0.7253672985631581 0.7444894453126124 0 -5440 0.7527173491819946 0.7796494565293146 0 -5441 0.9872643412536091 0.8360765319164613 0 -5442 0.0127356587464564 0.8360765319165909 0 -5443 0.5287487670019972 0.6004036303680786 0 -5444 0.4808491252312598 0.8967814592917207 0 -5445 0.8678887159904536 0.9773520719736983 0 -5446 0.1321112840089478 0.9773520719737979 0 -5447 0.8192413871692132 0.3270026798228309 0 -5448 0.8638986199260621 0.6770711066966006 0 -5449 0.656204751589869 0.9171708035957218 0 -5450 0.5613968859314671 0.7178427538203647 0 -5451 0.3162860952187156 0.9534833546138048 0 -5452 0.9243821805439771 0.8876907521736959 0 -5453 0.07561781945555764 0.8876907521741054 0 -5454 0.4439904574488259 0.4837494057208029 0 -5455 0.9812861975764479 0.6444857608277688 0 -5456 0.5040518698055525 0.4072939322662622 0 -5457 0.9220248530003212 0.9789342745811602 0 -5458 0.07797514699932542 0.9789342745812564 0 -5459 0.3362454457205817 0.1364889235546019 0 -5460 0.6646363417622405 0.9616263158970001 0 -5461 0.8354770044636219 0.916642079652676 0 -5462 0.5124672831166733 0.3170587371434307 0 -5463 0.1645229955356069 0.9166420796530689 0 -5464 0.6238916654382763 0.1531285795124489 0 -5465 0.7258991531483955 0.7750745506790402 0 -5466 0.3547141826196981 0.9792354562160113 0 -5467 0.8244141452760534 0.786149925585413 0 -5468 0.973824239619818 0.1984025237068864 0 -5469 0.5355102918854342 0.8715862303386365 0 -5470 0.3992839138922143 0.423239544475723 0 -5471 0.8206785076320313 0.8855775897074072 0 -5472 0.179321492367065 0.8855775897079745 0 -5473 0.8306744156839141 0.3751187999339283 0 -5474 0.9783512938703238 0.4346122874217232 0 -5475 0.9172992289072569 0.9621424837448881 0 -5476 0.08270077109235154 0.9621424837450498 0 -5477 0.4001678712280089 0.230635202175927 0 -5478 0.4292998355157529 0.8671609473071182 0 -5479 0.1701821508099538 0.6634286421819208 0 -5480 0.247214064599999 0.6690028371423605 0 -5481 0.474156470872927 0.6968213298219663 0 -5482 0.4883150042224449 0.3577933131781256 0 -5483 0.412271820788034 0.978136483673458 0 -5484 0.5185841181777961 0.8460022047843235 0 -5485 0.3637151209785919 0.912414423065845 0 -5486 0.9875734095010726 0.8542684724506094 0 -5487 0.01242659049910741 0.8542684724511194 0 -5488 0.100511394919102 0.6996254430150955 0 -5489 0.7503382237584979 0.8380481260152999 0 -5490 0.2496577753026152 0.8380504433981615 0 -5491 0.2014169844112082 0.3377436573696709 0 -5492 0.5531569511646668 0.8565583799784826 0 -5493 0.4447277549192254 0.9718957447137397 0 -5494 0.4614441745561382 0.6355003880692289 0 -5495 0.6847274382406103 0.6980859559490433 0 -5496 0.7980349165654693 0.2830942889728254 0 -5497 0.1290944461567794 0.7254461656483194 0 -5498 0.6472823288500297 0.7401083712785121 0 -5499 0.5862164631575041 0.7872753559023691 0 -5500 0.2170874585175655 0.716929277910235 0 -5501 0.1654909251600364 0.5085407896377312 0 -5502 0.3427872021021098 0.5200518285611331 0 -5503 0.8931274780412557 0.4136760383474667 0 -5504 0.8826239133720408 0.6091383870402014 0 -5505 0.05512825854499203 0.4838924275225751 0 -5506 0.6025994566539512 0.8644099993815014 0 -5507 0.2025651896243367 0.517104509009425 0 -5508 0.6851286599849921 0.9544998592213767 0 -5509 0.9320254351915518 0.9125040260230997 0 -5510 0.06797456480816653 0.9125040260234771 0 -5511 0.6095727311115193 0.7955262168751213 0 -5512 0.6022291934170609 0.6079738681031719 0 -5513 0.5980513429054879 0.7158983730613524 0 -5514 0.7234828937860174 0.9749331108982547 0 -5515 0.2765112018378619 0.9749194077902736 0 -5516 0.8241442473431402 0.7222453924264128 0 -5517 0.08634811767546006 0.6246035470102169 0 -5518 0.2556039592254978 0.7331266849260504 0 -5519 0.8754091968977979 0.5683376994277278 0 -5520 0.5519899413063067 0.5151485986008262 0 -5521 0.3430120655897429 0.9180536178825442 0 -5522 0.7055621899557852 0.5036702695973312 0 -5523 0.1955162804181866 0.5593828193001724 0 -5524 0.3600993968138387 0.6084896762581748 0 -5525 0.6309560170600991 0.9903573671516475 0 -5526 0.4488138620908716 0.9019382044842005 0 -5527 0.8299395747802094 0.8958353723292591 0 -5528 0.1700604252189947 0.895835372329749 0 -5529 0.771397184777298 0.9626497230096579 0 -5530 0.228602815221576 0.9626497230098636 0 -5531 0.7065210512995371 0.9776079155013749 0 -5532 0.8932936812599979 0.9413711074049326 0 -5533 0.1067063187395054 0.941371107405171 0 -5534 0.8980455169959847 0.843831670788858 0 -5535 0.1019544830037617 0.8438316707894635 0 -5536 0.8050067055518557 0.8326398088189563 0 -5537 0.1949932944472085 0.832639808819734 0 -5538 0.3396222096135629 0.4743375182876715 0 -5539 0.7546081962905744 0.1609839255644582 0 -5540 0.646367974758885 0.8990595550920751 0 -5541 0.5698755214619183 0.6606633870827534 0 -5542 0.1018274594523262 0.5950627439094738 0 -5543 0.2943039602534593 0.03313300207850058 0 -5544 0.2936310974782322 0.9777487270260797 0 -5545 0.4138212484669979 0.853749800033322 0 -5546 0.7987998981243964 0.7035997931868684 0 -5547 0.6201333796481213 0.6897487412572012 0 -5548 0.6009772632235473 0.6898912965369468 0 -5549 0.0882474807336209 0.3552069909803561 0 -5550 0.6143653959373696 0.9918316291630067 0 -5551 0.7912958077068686 0.3379126920930478 0 -5552 0.6499788438696997 0.6847590643604184 0 -5553 0.6327737113553942 0.956018515036325 0 -5554 0.8142949455562949 0.990409154555366 0 -5555 0.1857050544428209 0.990409154555411 0 -5556 0.4490198137376751 0.7273791444548212 0 -5557 0.7859054755000703 0.9018702341464622 0 -5558 0.2140945244988759 0.9018702341469291 0 -5559 0.3662989776733219 0.9899456238814075 0 -5560 0.5978325853579562 0.3032378723962288 0 -5561 0.5630154741940725 0.834949414765835 0 -5562 0.4532040188948471 0.775278687603895 0 -5563 0.697491071819567 0.6316999923397607 0 -5564 0.765887355442626 0.4817344895192572 0 -5565 0.5643632399795069 0.7735864450170581 0 -5566 0.7630030612773886 0.9764162541827136 0 -5567 0.2369969387214363 0.9764162541828451 0 -5568 0.4861044648225901 0.9910605548669137 0 -5569 0.5440187388397529 0.679466649092621 0 -5570 0.7664265480015803 0.3185765770388265 0 -5571 0.5707127519308206 0.3287573528605409 0 -5572 0.735527211140387 0.5894881064469477 0 -5573 0.4652586864521719 0.8879547084384811 0 -5574 0.7428285016305737 0.6855814511632351 0 -5575 0.3767599687823334 0.9349228122196115 0 -5576 0.3966783031688147 0.6993529464389833 0 -5577 0.6299201480454028 0.08746983622959485 0 -5578 0.3205470307177469 0.509284833171848 0 -5579 0.3521598484829305 0.3649425332737182 0 -5580 0.9386405262629913 0.9767560094307524 0 -5581 0.06135947373672658 0.9767560094308649 0 -5582 0.2451734544584768 0.3551138205655557 0 -5583 0.9906167689414833 0.9054532307891855 0 -5584 0.009383231058563705 0.9054532307891696 0 -5585 0.8865601448130269 0.9280841893294803 0 -5586 0.1134398551864527 0.9280841893297784 0 -5587 0.5225160948168954 0.9051365041407811 0 -5588 0.8794828897303075 0.9905552958070397 0 -5589 0.1205171102691472 0.9905552958070787 0 -5590 0.9510112255093535 0.7623564390258363 0 -5591 0.04899668659908214 0.7624599022489653 0 -5592 0.731113380295755 0.2216943434317518 0 -5593 0.7042869216244008 0.5678088629612119 0 -5594 0.918296938923728 0.80999636280986 0 -5595 0.08170306107631969 0.8099963628102523 0 -5596 0.9734387484768483 0.330816886964073 0 -5597 0.7225660869521737 0.7289274327375396 0 -5598 0.6379930068830233 0.8743322142146083 0 -5599 0.04134040972553626 0.563531191320163 0 -5600 0.2416144533652757 0.2049782977121427 0 -5601 0.8903307821610366 0.83159361138696 0 -5602 0.1096692178386882 0.8315936113876854 0 -5603 0.5742191367664858 0.7323936820953709 0 -5604 0.4307607965198856 0.03492660532162211 0 -5605 0.2829940031220662 0.5146474639777092 0 -5606 0.6157212794759834 0.742869901313584 0 -5607 0.02295083619549485 0.4067945811825622 0 -5608 0.2762487276516506 0.3906565698017028 0 -5609 0.3476739243606682 0.3071742442054349 0 -5610 0.8560265446014178 0.7529779244282659 0 -5611 0.078454428380867 0.5379034559996492 0 -5612 0.8453343505435607 0.8819958745556085 0 -5613 0.154665649455739 0.8819958745561592 0 -5614 0.1549117642048917 0.6123324107586591 0 -5615 0.9047360963435397 0.9750734105147547 0 -5616 0.0952639036560315 0.9750734105148575 0 -5617 0.02485109251083974 0.2899634880629488 0 -5618 0.4798874025895896 0.4886179221020566 0 -5619 0.307553803437068 0.5707564723501792 0 -5620 0.5244685195060483 0.9918272270684152 0 -5621 0.5357562856066952 0.6609737936555258 0 -5622 0.6950816584228044 0.991538335237184 0 -5623 0.6881609861511118 0.774288212906092 0 -5624 0.7351223828329303 0.9255015436884411 0 -5625 0.2648776171657347 0.925501543688836 0 -5626 0.3844940081412865 0.9918572373248629 0 -5627 0.104841889231163 0.1634152657378594 0 -5628 0.8782104458943975 0.7883276213819681 0 -5629 0.1217717656205278 0.7889014535299383 0 -5630 0.9335879310885734 0.8272998166261402 0 -5631 0.06641206891143331 0.8272998166264541 0 -5632 0.4584009204248881 0.9282631364137195 0 -5633 0.4960860681864642 0.9778873734090581 0 -5634 0.8926282565937668 0.7810532432688617 0 -5635 0.1086961397042765 0.7822015501782453 0 -5636 0.715319296161902 0.8563520324162497 0 -5637 0.2869584729050301 0.8561391975214327 0 -5638 0.8731370006986421 0.6624466908729536 0 -5639 0.9429043876555258 0.8092393497831563 0 -5640 0.05709561234453187 0.8092393497835376 0 -5641 0.4479377480630258 0.593694371490467 0 -5642 0.4848540082160493 0.8609454062589457 0 -5643 0.415754291572059 0.524495435895465 0 -5644 0.6494081906263591 0.7064424458104452 0 -5645 0.8083789441133744 0.8599676125747259 0 -5646 0.1916210558857173 0.8599676125753584 0 -5647 0.792284430123237 0.97484351844215 0 -5648 0.2077155698757742 0.9748435184422732 0 -5649 0.636270171850507 0.91650259045765 0 -5650 0.478161351628365 0.6040906380114676 0 -5651 0.7536100405101145 0.9158603216260431 0 -5652 0.2463899594886387 0.9158603216264947 0 -5653 0.1979038530928969 0.6604801444407856 0 -5654 0.5544801722847624 0.9274499912239706 0 -5655 0.6557079243174428 0.7988774055155315 0 -5656 0.775466436776811 0.7217222282242217 0 -5657 0.5763129503630114 0.9002951606983298 0 -5658 0.2731093681482079 0.6435556180974022 0 -5659 0.5309213678141723 0.9280610103125875 0 -5660 0.3419889128291569 0.6365303120478183 0 -5661 0.7934999531109665 0.4073675566198928 0 -5662 0.5363075739331393 0.8265115119200217 0 -5663 0.7345353427068382 0.9915542455509796 0 -5664 0.2654646572918293 0.9915542455510284 0 -5665 0.673498512292387 0.640661165231164 0 -5666 0.3237312920371785 0.6064303417992554 0 -5667 0.0188904012586162 0.4881643682618284 0 -5668 0.986840727094501 0.8075395053988763 0 -5669 0.01315927290552379 0.8075395053990693 0 -5670 0.733800902361639 0.6710063941543147 0 -5671 0.5820945738670994 0.5090397463907573 0 -5672 0.5502031157503957 0.2303147842513927 0 -5673 0.6610749378533124 0.6112375530763443 0 -5674 0.6185302139304856 0.9640171076040016 0 -5675 0.6986415875284411 0.9086518935142287 0 -5676 0.3013608599444918 0.9087461176206528 0 -5677 0.7232763853023411 0.8343799130739408 0 -5678 0.2773465229006703 0.8334796634544416 0 -5679 0.4662555949707989 0.6660297115845553 0 -5680 0.316319565802419 0.1869117667150414 0 -5681 0.1712160025009183 0.4803641428891834 0 -5682 0.9593509296824188 0.9223401495664639 0 -5683 0.04064907031739734 0.9223401495668508 0 -5684 0.7809901404495652 0.9307770982753808 0 -5685 0.2190098595493483 0.930777098275726 0 -5686 0.9126674545891106 0.9911963842983404 0 -5687 0.08733254541049518 0.9911963842983812 0 -5688 0.7826456042217502 0.5016268476264603 0 -5689 0.3669954571119478 0.8117113537338474 0 -5690 0.9079301712654129 0.9306496427479585 0 -5691 0.09206982873418536 0.9306496427482477 0 -5692 0.848343019849975 0.797443490349548 0 -5693 0.984479959087691 0.5627433166781165 0 -5694 0.1516471907959069 0.7975812900444379 0 -5695 0.9702205646687428 0.1329513057597193 0 -5696 0.3994118808700374 0.8950313412379606 0 -5697 0.8672292744643417 0.9189676233377002 0 -5698 0.1327707255350525 0.9189676233380514 0 -5699 0.3856455322968532 0.2767127648113841 0 -5700 0.7171041834116039 0.9920455254111091 0 -5701 0.2828845085984948 0.9920528983201806 0 -5702 0.3183672662906253 0.3699548828646443 0 -5703 0.5652047437355159 0.9635038682834358 0 -5704 0.3787112716857889 0.6980351690481456 0 -5705 0.8529442797658244 0.08277991971001927 0 -5706 0.4249036642187699 0.09808823558435482 0 -5707 0.425113256323624 0.9645103179311729 0 -5708 0.01311842530219071 0.7724737752075255 0 -5709 0.6841937018737366 0.4700699344350898 0 -5710 0.9251172889849526 0.4937512967062907 0 -5711 0.6371096357747819 0.9742053082590525 0 -5712 0.8556911934990434 0.9752220435181923 0 -5713 0.1443088065002922 0.9752220435183079 0 -5714 0.9392180843585147 0.7170599506555986 0 -5715 0.3245709269867547 0.9785831457316732 0 -5716 0.3486247035365549 0.7055071908804142 0 -5717 0.4871753723415304 0.1171744845165799 0 -5718 0.7884393552248558 0.6895639663170379 0 -5719 0.8894424778101472 0.9044430378030883 0 -5720 0.1105575221893087 0.9044430378034706 0 -5721 0.1331576949810652 0.7093141020158765 0 -5722 0.152214994391188 0.7086714845677322 0 -5723 0.3423985976085572 0.7945399983220308 0 -5724 0.4203744391332991 0.6869379174903053 0 -5725 0.7702263344684953 0.7916279071764292 0 -5726 0.5872484378754894 0.6222465869208643 0 -5727 0.2743793960346719 0.5600637208659758 0 -5728 0.2824310437581604 0.7790679273646406 0 -5729 0.3025783709367531 0.7988276069997851 0 -5730 0.4653146134565291 0.7864692235816284 0 -5731 0.5957053779905515 0.9053911342004082 0 -5732 0.6197799267211501 0.9288634677683001 0 -5733 0.3010727791933318 0.6813659223930525 0 -5734 0.1036585208243812 0.5649995266905909 0 -5735 0.9593916913688569 0.6442914917684753 0 -5736 0.5163656339564909 0.8335644992680263 0 -5737 0.2180165137655565 0.6125711436457545 0 -5738 0.5642083830749228 0.08911452190210944 0 -5739 0.6335126772728986 0.3817153093189032 0 -5740 0.733907968214052 0.8814786769480133 0 -5741 0.2660920317846421 0.881478676948618 0 -5742 0.2666982716877803 0.5921969584636639 0 -5743 0.4565655555525419 0.5334135539030858 0 -5744 0.8915358484190428 0.5111133322870078 0 -5745 0.1666273869692737 0.3140938996803629 0 -5746 0.9357375909487601 0.8705750120172491 0 -5747 0.06426240905089375 0.870575012017592 0 -5748 0.477726833745713 0.8235813610470327 0 -5749 0.3821138342579893 0.9654638141507843 0 -5750 0.7117941372878264 0.8045981886876605 0 -5751 0.3496566335994697 0.9618524638623698 0 -5752 0.3088195831889372 0.5442480262142994 0 -5753 0.03302271920423716 0.7287130295118605 0 -5754 0.8988172765641084 0.8660491361958964 0 -5755 0.1011827234355179 0.8660491361965285 0 -5756 0.9356762041656268 0.9450799036951482 0 -5757 0.06432379583407653 0.9450799036954112 0 -5758 0.8328647281208765 0.7986170911366302 0 -5759 0.1666503121640761 0.7990890091024248 0 -5760 0.1665568646619832 0.6462470320333548 0 -5761 0.01730383871726389 0.5391175803055884 0 -5762 0.4911781353708693 0.9622231139097221 0 -5763 0.6652765037026522 0.6774622664899423 0 -5764 0.8111164654299874 0.7528636815850559 0 -5765 0.798800081478778 0.6724848260035462 0 -5766 0.9523912520600085 0.5812942046490402 0 -5767 0.85788686107659 0.5301084469586086 0 -5768 0.5263548119830593 0.730449546430344 0 -5769 0.8135151556243996 0.1741955696415289 0 -5770 0.1364137650088493 0.6557089518425971 0 -5771 0.3921417618247485 0.6218382296567389 0 -5772 0.7865315193467698 0.9563880255474124 0 -5773 0.2134684806521884 0.956388025547636 0 -5774 0.7829302114052632 0.7380273203574916 0 -5775 0.3343248874522498 0.8869320910840024 0 -5776 0.5971519440285791 0.9680190515632603 0 -5777 0.9869308173104048 0.7724937501990174 0 -5778 0.7059455025447856 0.5261106044132892 0 -5779 0.4207333508141078 0.9482312270342557 0 -5780 0.8896050699271094 0.1839231487121193 0 -5781 0.5995305814673159 0.9186378981525803 0 -5782 0.3883105209905833 0.1904644224526155 0 -5783 0.287462701505919 0.8101205630321379 0 -5784 0.3263992754062334 0.5752542691373633 0 -5785 0.2320688680167728 0.7545729520423226 0 -5786 0.5184837287018034 0.9172160245785843 0 -5787 0.4352462079156247 0.7776490961601032 0 -5788 0.681785779863135 0.9617322558633097 0 -5789 0.2692894659167162 0.7553985603155705 0 -5790 0.4947779644675904 0.6778871106131925 0 -5791 0.7919397533795589 0.5500696810187932 0 -5792 0.8776986272069293 0.3207765272598251 0 -5793 0.7702568184722193 0.9466725879298774 0 -5794 0.2297431815266432 0.9466725879301743 0 -5795 0.7085272043045806 0.1226387059284735 0 -5796 0.8871704667827915 0.7421703647636975 0 -5797 0.3113436478892448 0.6347748720807382 0 -5798 0.50020612946761 0.908944852134233 0 -5799 0.07987419213962249 0.4586490783559408 0 -5800 0.2522434238575103 0.07948177443351009 0 -5801 0.5415786053037565 0.9407960622614164 0 -5802 0.9331420833268562 0.6641245265424456 0 -5803 0.3810126347414035 0.5186291995675811 0 -5804 0.1438607736078048 0.7342151955389079 0 -5805 0.3355149208449427 0.9277555878076584 0 -5806 0.02211572315856301 0.2358939775783405 0 -5807 0.09223175253205791 0.6732335063434889 0 -5808 0.7599033719639825 0.3715333504150437 0 -5809 0.5995692400997168 0.2408739025300914 0 -5810 0.7830551798210126 0.8612924856028388 0 -5811 0.2169448201779424 0.8612924856035027 0 -5812 0.6776613247615246 0.890373820801498 0 -5813 0.6933113309810272 0.3323618314027602 0 -5814 0.5952053395950058 0.9519066973265372 0 -5815 0.9736122170673833 0.8603332804919868 0 -5816 0.02638778293263773 0.8603332804923969 0 -5817 0.6808486381224306 0.4494793205437941 0 -5818 0.8513459454615592 0.6186457227348777 0 -5819 0.7341139351207745 0.5556981051826374 0 -5820 0.7655314740312021 0.6624049016300149 0 -5821 0.6451327353080236 0.9573186858847409 0 -5822 0.7449999999993338 0.9927120732159392 0 -5823 0.2549999999993979 0.9927120732159823 0 -5824 0.4449784759399323 0.2074205898756936 0 -5825 0.8740592910126415 0.3925499832940853 0 -5826 0.484580825750938 0.6634833603835271 0 -5827 0.6575903116893793 0.1075945392018394 0 -5828 0.4391007508986882 0.8569704027041999 0 -5829 0.08943960062781542 0.2805826408067499 0 -5830 0.5085452610560132 0.7938207820548214 0 -5831 0.2569419247028543 0.7973989730929767 0 -5832 0.8960900985259521 0.8063387424727755 0 -5833 0.1039099014740091 0.8063387424734364 0 -5834 0.3153147127174971 0.7755538187753493 0 -5835 0.1792310087597208 0.4417308426595597 0 -5836 0.06072535405899064 0.6640729147489484 0 -5837 0.6206325287592378 0.8467760081032563 0 -5838 0.4622092110676207 0.8487781567703898 0 -5839 0.4279059638538463 0.556589080626524 0 -5840 0.2986543209773786 0.847729528704124 0 -5841 0.4701379061707204 0.7112541817151093 0 -5842 0.8034147295675705 0.3818665064415744 0 -5843 0.4195700815575562 0.31372873746437 0 -5844 0.3068100201616368 0.8234780264000474 0 -5845 0.76536461239919 0.4161188910239795 0 -5846 0.9147837944387931 0.9722619606057226 0 -5847 0.0852162055608176 0.9722619606058439 0 -5848 0.5400292433539486 0.490094818833005 0 -5849 0.7207248656391616 0.9564425094990727 0 -5850 0.2792743143073836 0.9564406062898528 0 -5851 0.6599636873311245 0.7671003822809508 0 -5852 0.8500823110558664 0.9079631910568343 0 -5853 0.1499176889434395 0.9079631910572471 0 -5854 0.144418972257271 0.3512350258205863 0 -5855 0.8946050667908398 0.4604408144929691 0 -5856 0.1717992616636571 0.7474099628857297 0 -5857 0.6900653700526629 0.9376001650009549 0 -5858 0.9186106947445905 0.5307268193373686 0 -5859 0.921411928757037 0.7412771594526796 0 -5860 0.07648379325506376 0.7422534133409329 0 -5861 0.3295690879899254 0.2899422239441532 0 -5862 0.7941258958493993 0.9412821573017069 0 -5863 0.2058741041496009 0.9412821573019844 0 -5864 0.9731196284616547 0.9807369034574984 0 -5865 0.02688037153823319 0.9807369034575448 0 -5866 0.1853170079013104 0.6232042527506025 0 -5867 0.5965833297369094 0.852859160227655 0 -5868 0.2198134734566503 0.1555739740111867 0 -5869 0.7050610217075344 0.9474972330407966 0 -5870 0.2949564484938552 0.947471642689616 0 -5871 0.2680712631760345 0.3642557843263953 0 -5872 0.6659053493383351 0.906852208538613 0 -5873 0.559582504054297 0.9472262052749172 0 -5874 0.3202374067131224 0.96212631921998 0 -5875 0.09520617761490985 0.5081646441595635 0 -5876 0.5743380701902594 0.8155981715978979 0 -5877 0.3788793548987375 0.6697326107327828 0 -5878 0.8749926717867279 0.9719883855229426 0 -5879 0.125007328212707 0.9719883855230687 0 -5880 0.6799809986706793 0.2185852994509519 0 -5881 0.08102688062798041 0.7247346907080441 0 -5882 0.6959440627980849 0.7102771085540105 0 -5883 0.01393060078296705 0.6466353742591123 0 -5884 0.6406736849166699 0.6572267537602462 0 -5885 0.9405514767394725 0.8470345876176629 0 -5886 0.0594485232603594 0.8470345876180176 0 -5887 0.2156047220440743 0.1171917870968121 0 -5888 0.3675093728813748 0.1718046550766263 0 -5889 0.2967998303279936 0.6018667093799732 0 -5890 0.3081716571855894 0.9397050566521117 0 -5891 0.9334780302306691 0.1646445745051381 0 -5892 0.3657940250776894 0.8727138066672783 0 -5893 0.7902950581236463 0.8115448760897821 0 -5894 0.2094063211042025 0.8107199819949026 0 -5895 0.4858912704661862 0.9136013004892511 0 -5896 0.477458730661367 0.3999747739663564 0 -5897 0.976125216170173 0.91750365142822 0 -5898 0.02387478382978671 0.9175036514285241 0 -5899 0.7220402339121654 0.6993218587547123 0 -5900 0.7408782272172971 0.3561630964232372 0 -5901 0.240189544823903 0.4486127600517274 0 -5902 0.7110692775805528 0.5900504184368129 0 -5903 0.1340561631839129 0.5474000840717419 0 -5904 0.4077354001266836 0.9312696471709843 0 -5905 0.525464565562591 0.9523664692890907 0 -5906 0.5092123458915061 0.6472077621671612 0 -5907 0.9850195368169783 0.6265068015884395 0 -5908 0.3969208562913407 0.9286027602275783 0 -5909 0.9623607770783329 0.991309655917764 0 -5910 0.03763922292149697 0.991309655917797 0 -5911 0.1233673968097447 0.2135807151456949 0 -5912 0.1369691255938854 0.4376106802763087 0 -5913 0.7066515205636987 0.8191767091122729 0 -5914 0.723208068784003 0.9280577172778528 0 -5915 0.6613182848443586 0.2837440154635884 0 -5916 0.2767919312145935 0.9280577172782347 0 -5917 0.265198511184416 0.7714857906376555 0 -5918 0.750355059298372 0.8654254983047884 0 -5919 0.2496449407003984 0.8654254983054921 0 -5920 0.439053657320135 0.9322964016033675 0 -5921 0.3917395593863565 0.9418817592297308 0 -5922 0.3867192940402129 0.075425044124037 0 -5923 0.4798559038361584 0.7240008185817973 0 -5924 0.4490751758047421 0.8759868703503105 0 -5925 0.7673351628557599 0.7065936059491414 0 -5926 0.8008541371329791 0.03328852495823897 0 -5927 0.5625510559105686 0.1425954542760814 0 -5928 0.6001140902385795 0.3843994291584766 0 -5929 0.3484151502694347 0.8994812124838365 0 -5930 0.97236244152937 0.8113872864472376 0 -5931 0.02763755847065458 0.8113872864475333 0 -5932 0.1051963364094066 0.08164167196955435 0 -5933 0.5780617784668967 0.1175119694131741 0 -5934 0.5072176073548792 0.9619091011785712 0 -5935 0.6962732042401358 0.7427065597143415 0 -5936 0.4239237277882271 0.6330456871361846 0 -5937 0.3404190062889704 0.9401052355688574 0 -5938 0.1595808509474345 0.7725413264421446 0 -5939 0.7781137847106661 0.9806905428332851 0 -5940 0.2218862152882485 0.9806905428333886 0 -5941 0.07237563488626353 0.6530571950377947 0 -5942 0.9317662350899292 0.8008485588733055 0 -5943 0.06823383854971179 0.8008483927929941 0 -5944 0.3233024883520073 0.07621960694554006 0 -5945 0.6049834279654349 0.940028894214041 0 -5946 0.05158373249865376 0.3998402309829594 0 -5947 0.3016401461451921 0.4769034822517369 0 -5948 0.3420058071031243 0.9785473060589752 0 -5949 0.07284368471032507 0.5698874601806692 0 -5950 0.578788424781387 0.8893942280030481 0 -5951 0.5182709323407245 0.6606776938068708 0 -5952 0.589700555541551 0.7313300658649046 0 -5953 0.8686250949154513 0.8835672868363571 0 -5954 0.1313749050839766 0.8835672868368744 0 -5955 0.9144791926789964 0.9415017214749696 0 -5956 0.08552080732060202 0.9415017214752124 0 -5957 0.6314181589591346 0.7339875560741045 0 -5958 0.4975129180236609 0.2225865226868212 0 -5959 0.8148196830168506 0.6979266157629154 0 -5960 0.4596395907747728 0.7398161307389599 0 -5961 0.5906979025430606 0.3545080692510018 0 -5962 0.5688568270355644 0.745786369977856 0 -5963 0.5394530512486402 0.9188565391701985 0 -5964 0.7322180483592269 0.8263006250201956 0 -5965 0.2677819516394559 0.8263006250210895 0 -5966 0.9339088150678342 0.9922861096903196 0 -5967 0.06609118493186165 0.9922861096903597 0 -5968 0.1136663994720509 0.5131436261076319 0 -5969 0.4732608652174386 0.9610678497214648 0 -5970 0.8129522597134929 0.8107640754782732 0 -5971 0.1870115233819858 0.81056971734937 0 -5972 0.5526771246162976 0.7863160914254096 0 -5973 0.725354291418228 0.4681791047836801 0 -5974 0.1495204715769518 0.1964046293829141 0 -5975 0.8084935066535299 0.9809821227525511 0 -5976 0.1915064933455585 0.9809821227526392 0 -5977 0.1701100810460653 0.7337820502724637 0 -5978 0.3290565840859141 0.8173928084449686 0 -5979 0.2290727330028929 0.4735707996617625 0 -5980 0.2144156550494219 0.02960728998999813 0 -5981 0.8027418312081038 0.8179244441122672 0 -5982 0.1971871357759242 0.8177464449472398 0 -5983 0.6178797463087852 0.5403636706571301 0 -5984 0.670718308893248 0.8166976620330939 0 -5985 0.623795387219708 0.8899070802891178 0 -5986 0.9750996478380473 0.3562043219994103 0 -5987 0.6060233796328509 0.2104383245883918 0 -5988 0.3266758144612943 0.8339178256448804 0 -5989 0.5762167786791453 0.9927012056159867 0 -5990 0.5574145194242478 0.6477621970465243 0 -5991 0.3882249912262127 0.593067756123303 0 -5992 0.8507022733418599 0.9839549402300524 0 -5993 0.1492977266574481 0.9839549402301297 0 -5994 0.379590257427455 0.8458689080427849 0 -5995 0.2540918374068041 0.6392984913533328 0 -5996 0.8797986131751181 0.3679683753114548 0 -5997 0.9556420684286639 0.6182699349748231 0 -5998 0.507522007331726 0.5883319500496261 0 -5999 0.3669615586924611 0.9625121653156957 0 -6000 0.5773937164428997 0.7595359077096012 0 -6001 0.9623770245639214 0.7374555987913516 0 -6002 0.6585936852341076 0.8129247414519322 0 -6003 0.5111944662766876 0.6765085185032176 0 -6004 0.7859937304145656 0.9927092396041839 0 -6005 0.2140062695843854 0.9927092396042214 0 -6006 0.9047282741236936 0.7618374229382117 0 -6007 0.09400508981689661 0.7610988812589408 0 -6008 0.4877051489401004 0.981257921883385 0 -6009 0.8400904797621292 0.9261287232485922 0 -6010 0.1599095202371158 0.926128723248941 0 -6011 0.9814505319220542 0.5176986880877729 0 -6012 0.3315676704501845 0.9617105671580536 0 -6013 0.7105503321369375 0.4300546909360749 0 -6014 0.6755717697240684 0.992367773124794 0 -6015 0.6732232727567716 0.8346200160518531 0 -6016 0.2653365328047783 0.4599360908307733 0 -6017 0.3842604141680298 0.9100568192953374 0 -6018 0.5212139634614129 0.4397198931965354 0 -6019 0.8222429937602591 0.9744241416187831 0 -6020 0.1777570062389003 0.9744241416189194 0 -6021 0.2458460297637566 0.3137669413778819 0 -6022 0.579694132734485 0.485620053675856 0 -6023 0.3583942299401184 0.9460742529461267 0 -6024 0.9746519099441702 0.2361252064380428 0 -6025 0.2741813676895234 0.7252120373885802 0 -6026 0.5389129104064975 0.02641361821164382 0 -6027 0.499359150385416 0.7494049222389207 0 -6028 0.8747291481465567 0.9454540414306687 0 -6029 0.1252708518528662 0.9454540414309053 0 -6030 0.9606160872226495 0.9052590337497591 0 -6031 0.03938391277717437 0.9052590337501273 0 -6032 0.4324284955643811 0.6610171970054517 0 -6033 0.3357868963228318 0.7290631630345411 0 -6034 0.534642264835455 0.706819051638236 0 -6035 0.8586047292978233 0.9372251305885142 0 -6036 0.1413952707015403 0.9372251305888047 0 -6037 0.737048590898945 0.9008889546781209 0 -6038 0.2629514090997688 0.900888954678623 0 -6039 0.4466525841454734 0.6909967793747119 0 -6040 0.5882686156722914 0.8312599975081422 0 -6041 0.5539037903242234 0.3749073370304704 0 -6042 0.5632812820447248 0.452113963273801 0 -6043 0.5354172468099235 0.9478317280038863 0 -6044 0.3417361359934372 0.8154858736224386 0 -6045 0.7469852513260367 0.9775921399053573 0 -6046 0.2530147486726942 0.9775921399054848 0 -6047 0.5069849080877348 0.8676018051971637 0 -6048 0.3713144197467877 0.7635276926974567 0 -6049 0.7653129675173599 0.9915443593876709 0 -6050 0.2346870324814776 0.9915443593877172 0 -6051 0.6376700830224332 0.6287307101860051 0 -6052 0.7110843076245685 0.6498024691067386 0 -6053 0.7371157348474366 0.7663135256467741 0 -6054 0.7801437881467291 0.9646237917586475 0 -6055 0.2198562118521989 0.9646237917588385 0 -6056 0.8350560660841873 0.9929028832131668 0 -6057 0.1649439339150396 0.992902883213197 0 -6058 0.5325705541058079 0.6314683705676722 0 -6059 0.2489281413638863 0.588298348073478 0 -6060 0.9759874829314902 0.8332057209124479 0 -6061 0.02401251706857941 0.833205720912702 0 -6062 0.7533794835504859 0.9703323602215927 0 -6063 0.3811624496743616 0.9227509386027708 0 -6064 0.2466205164482812 0.9703323602217651 0 -6065 0.1660965874313645 0.1253958098709973 0 -6066 0.5329767779797843 0.5257507174322078 0 -6067 0.8181418837435779 0.6821369778577213 0 -6068 0.6339172958458963 0.7096120850238526 0 -6069 0.2386523498123639 0.6126439496252499 0 -6070 0.840678494114118 0.8929685771942868 0 -6071 0.1593215058851523 0.8929685771947551 0 -6072 0.6737543942714278 0.9765149554089092 0 -6073 0.249657797212896 0.7087321070379677 0 -6074 0.946626190904131 0.9684467626969058 0 -6075 0.05337380909562391 0.9684467626970573 0 -6076 0.94253088096721 0.8351085591460683 0 -6077 0.05746911903274707 0.8351085591464276 0 -6078 0.7827145036490796 0.7865319635749157 0 -6079 0.9924602202594454 0.9631633092707892 0 -6080 0.007539779740514728 0.9631633092707489 0 -6081 0.5334487583651037 0.08946206854258755 0 -6082 0.6894186379469862 0.6661151340012738 0 -6083 0.6916640188181041 0.8193493948944759 0 -6084 0.6245459463545125 0.7864345050577258 0 -6085 0.7117259308503492 0.9613067999310975 0 -6086 0.2882730949050722 0.9612972305285632 0 -6087 0.6265034274168045 0.9794256430266859 0 -6088 0.1415511435222283 0.1684734918578223 0 -6089 0.3936277129866246 0.138122239226607 0 -6090 0.3035191994010185 0.991871606663514 0 -6091 0.8951267611802318 0.9936037422066379 0 -6092 0.1048732388192967 0.9936037422066649 0 -6093 0.2301962283808523 0.5537109292981514 0 -6094 0.6849740809481368 0.53586973501941 0 -6095 0.648892635677049 0.5216421575519716 0 -6096 0.7982459475171733 0.982421099335826 0 -6097 0.2017540524818577 0.9824210993359128 0 -6098 0.85677934009576 0.9181769826165878 0 -6099 0.1432206599035732 0.9181769826169642 0 -6100 0.753242697183084 0.878520189722136 0 -6101 0.4010175221881389 0.3765066526817589 0 -6102 0.2467573028157132 0.878520189722755 0 -6103 0.4175406268011867 0.9006141271660033 0 -6104 0.9164715750631049 0.7270578899573277 0 -6105 0.4920721766717148 0.6485242613722678 0 -6106 0.9455180594229355 0.3258037804881802 0 -6107 0.5126553370038303 0.9786720747303744 0 -6108 0.7297657007974148 0.641328770445992 0 -6109 0.7415526976250986 0.8473062839734422 0 -6110 0.2177567596484214 0.6629438532471479 0 -6111 0.2584769137122045 0.8472588441562796 0 -6112 0.4762978965207471 0.7611412865492767 0 -6113 0.4145643715031359 0.7633444665688245 0 -6114 0.8035634424065891 0.9281301409476823 0 -6115 0.1964365575924535 0.9281301409480363 0 -6116 0.4511034978896756 0.7114009119380598 0 -6117 0.9305150286630632 0.6434613191208091 0 -6118 0.7050189967160302 0.8532423605433292 0 -6119 0.3116728686190677 0.7606063639647452 0 -6120 0.2006776740089859 0.6917315289554939 0 -6121 0.4123890621395721 0.9164689045175711 0 -6122 0.6198168709202319 0.6601627696951616 0 -6123 0.06415570238450652 0.6186080279189353 0 -6124 0.7129463435374412 0.9715947059360859 0 -6125 0.2865848597557287 0.9717007536138151 0 -6126 0.2808828539877822 0.4389979948397529 0 -6127 0.5842575165038532 0.8685640348407331 0 -6128 0.4109017492923664 0.9618436270439571 0 -6129 0.6284603497761718 0.9480426702145747 0 -6130 0.6837668185152687 0.5771982406426943 0 -6131 0.8983410681088493 0.8202898858520401 0 -6132 0.101658931891008 0.8202898858526577 0 -6133 0.8403845305876942 0.8468291073989506 0 -6134 0.1596154694115428 0.8468291073996581 0 -6135 0.3514247048817024 0.6878909075615158 0 -6136 0.8286146628532224 0.74775915386074 0 -6137 0.5994341047606676 0.590860380648361 0 -6138 0.0705224666787935 0.1452280442414606 0 -6139 0.8091049173971572 0.7275906187298408 0 -6140 0.866595397213899 0.02809463322952799 0 -6141 0.5768244695703487 0.9201061044522033 0 -6142 0.8058511142465226 0.6384957109955478 0 -6143 0.2203035730548622 0.6833076696259877 0 -6144 0.4017303348316094 0.7264986756852039 0 -6145 0.388543626409067 0.8639597222088391 0 -6146 0.5410634153904144 0.9618542500399609 0 -6147 0.3447734367147904 0.9927855543965766 0 -6148 0.8973279413537358 0.8851838040622987 0 -6149 0.4832911731607651 0.7483636029796277 0 -6150 0.102672058645772 0.8851838040627591 0 -6151 0.1186941066627285 0.7503979337760223 0 -6152 0.6668339351257925 0.8871463325229625 0 -6153 0.250783105567388 0.5283757217832104 0 -6154 0.4768660897437963 0.9925798044187932 0 -6155 0.6494064998388401 0.8271058589444203 0 -6156 0.960994001942449 0.9621286375560276 0 -6157 0.03900599805737477 0.9621286375562085 0 -6158 0.8141739908486749 0.5812807196745918 0 -6159 0.4312352223162026 0.6207422449152583 0 -6160 0.07794199600031501 0.2344169236235391 0 -6161 0.4393343537440644 0.9797101529591542 0 -6162 0.3610023733517941 0.8920735867844714 0 -6163 0.06037143606145581 0.5010963669953038 0 -6164 0.2230057880223868 0.7726222468193082 0 -6165 0.06030772680310362 0.3244185268954665 0 -6166 0.06867223439416163 0.03161467466601323 0 -6167 0.5804573581167721 0.06364063891340119 0 -6168 0.3687072339564204 0.7471388311721157 0 -6169 0.6356194069323952 0.8061039485041007 0 -6170 0.4654783357601118 0.9455406282670094 0 -6171 0.9406065369970951 0.2449785957933524 0 -6172 0.7898952600133466 0.8525044383882412 0 -6173 0.2101047399856279 0.8525044383889124 0 -6174 0.5864733001002883 0.9833668124289462 0 -6175 0.3135842909621652 0.3403868163461301 0 -6176 0.4182873415163392 0.841948998694046 0 -6177 0.03411098028126403 0.6570746517310893 0 -6178 0.9288435382823192 0.8514536013512092 0 -6179 0.07115646171729698 0.8514536013515622 0 -6180 0.7102336765742419 0.8314466501351953 0 -6181 0.5824653335684215 0.9612624131018678 0 -6182 0.7650377462243295 0.8516610900858951 0 -6183 0.2349622537745091 0.8516610900866263 0 -6184 0.6140421587884111 0.9826784543515501 0 -6185 0.1371908145675958 0.6762226361180055 0 -6186 0.4048942500074748 0.686199550265696 0 -6187 0.8827586560568216 0.8672545640812841 0 -6188 0.1172413439426994 0.8672545640819133 0 -6189 0.4711417240742283 0.8963930030879652 0 -6190 0.6179735446526763 0.75918061080497 0 -6191 0.7904246276360621 0.1536105133948216 0 -6192 0.2136538169728937 0.7890691292790731 0 -6193 0.4284033520069242 0.7646174755338483 0 -6194 0.8612500027132991 0.8723361007259691 0 -6195 0.1387499972860968 0.8723361007265521 0 -6196 0.2193379506288386 0.5819353645816845 0 -6197 0.510154167953475 0.7027885145667746 0 -6198 0.9127438611589369 0.6164702875500475 0 -6199 0.6615419037490012 0.937958579330215 0 -6200 0.2873463940740646 0.7003658115585099 0 -6201 0.276652285110633 0.1394132517902294 0 -6202 0.5248898817347779 0.2381602397455254 0 -6203 0.7833977322212805 0.9736893367887923 0 -6204 0.2166022677776676 0.9736893367889278 0 -6205 0.8925029586583025 0.6895223435118569 0 -6206 0.353148514485599 0.1158448076049724 0 -6207 0.6903873901595079 0.9826067107369563 0 -6208 0.772584119432536 0.518854370441254 0 -6209 0.372361291908708 0.9798035882369907 0 -6210 0.9639358125305347 0.8011595106851861 0 -6211 0.03606418746944241 0.8011595106856063 0 -6212 0.9455674505354765 0.1942127326192239 0 -6213 0.7501351871750819 0.2862743423399968 0 -6214 0.2561128860264494 0.7487474665077173 0 -6215 0.9247878377442644 0.690158511805293 0 -6216 0.1935417505113115 0.7265529918991327 0 -6217 0.7195608994038013 0.912002211031175 0 -6218 0.2804391005947867 0.9120022110316345 0 -6219 0.5150883822618911 0.3697176587867824 0 -6220 0.6530111018827388 0.9925578027322287 0 -6221 0.611074869940518 0.9569968201243511 0 -6222 0.9651137716792937 0.7034655130443146 0 -6223 0.5013997648243036 0.767295499961054 0 -6224 0.5890724269142634 0.7039487575651426 0 -6225 0.132984631344333 0.638673284822342 0 -6226 0.4989462369416074 0.9449186878146298 0 -6227 0.4439633625583302 0.5059686671553132 0 -6228 0.2877668380187623 0.1731033874096143 0 -6229 0.5925380191999835 0.6389352693642592 0 -6230 0.4141998460928692 0.7387380722134986 0 -6231 0.8513690227812767 0.7820224415172572 0 -6232 0.6196940721760775 0.6307119770762134 0 -6233 0.4059443053244709 0.7971312609922974 0 -6234 0.2211477273309704 0.5214504305776917 0 -6235 0.790152652518135 0.763581091160737 0 -6236 0.9338177270755383 0.8809566615987512 0 -6237 0.06618227292408516 0.8809566615991293 0 -6238 0.6162200905151866 0.8814836080990938 0 -6239 0.6283096271673346 0.9085269141005804 0 -6240 0.6861818099671169 0.8338372249743476 0 -6241 0.5496822402421278 0.4210968220732841 0 -6242 0.4914065432757073 0.2724313146183496 0 -6243 0.9507926569496075 0.8540305643656967 0 -6244 0.04920734305026959 0.8540305643661071 0 -6245 0.5450067547351533 0.9934788718087424 0 -6246 0.6493453155538043 0.2274561466850132 0 -6247 0.3338222159608659 0.7744620073899825 0 -6248 0.6017809594629139 0.4759979761751326 0 -6249 0.8229241770541235 0.9331615938610278 0 -6250 0.1770758229450199 0.9331615938613506 0 -6251 0.7352471528925193 0.9432091368779265 0 -6252 0.2647528471061498 0.9432091368782309 0 -6253 0.6391134620819892 0.5051616323908145 0 -6254 0.4701464457101454 0.5657372266963648 0 -6255 0.7707510139339434 0.9262197924418167 0 -6256 0.2292489860649021 0.9262197924421942 0 -6257 0.3694905876350827 0.6856977130404813 0 -6258 0.3877070865836759 0.7632041176218606 0 -6259 0.1431092135607851 0.4183640463878613 0 -6260 0.5897098733840711 0.9332758334904041 0 -6261 0.9450000572816862 0.4050163181612534 0 -6262 0.6718062687962219 0.9465372586709312 0 -6263 0.2309790047931109 0.7970896369490053 0 -6264 0.473434190590788 0.978672327047075 0 -6265 0.3501277467248544 0.8275495738347486 0 -6266 0.9770478315062525 0.2884451149200871 0 -6267 0.1904623192762926 0.2490975284805339 0 -6268 0.0294045377762178 0.02959725969311588 0 -6269 0.4048353357559047 0.9931587242713624 0 -6270 0.9511089777172913 0.5069785474203021 0 -6271 0.1951487035500393 0.1687957132889462 0 -6272 0.916675195983971 0.9239844127524361 0 -6273 0.08332480401567864 0.9239844127527572 0 -6274 0.3554818590671066 0.7682032499220097 0 -6275 0.843757664182059 0.1567130545575639 0 -6276 0.860216709706748 0.5866227325999558 0 -6277 0.4940831962869077 0.7890334258373437 0 -6278 0.03728115985546097 0.6991202158559817 0 -6279 0.3743896030675613 0.7874221625997162 0 -6280 0.3603907307941058 0.7199375999380527 0 -6281 0.4891450225028585 0.6192371926809567 0 -6282 0.5245157835587241 0.3961397773281161 0 -6283 0.4134687894635406 0.7862199523321439 0 -6284 0.4802963007022407 0.4499421398691045 0 -6285 0.2434802183704529 0.7267540359127134 0 -6286 0.6459677171914076 0.3153343008603139 0 -6287 0.1479250907470507 0.7834349824537639 0 -6288 0.7549588227885647 0.8979909589623255 0 -6289 0.245041177210246 0.8979909589628448 0 -6290 0.8312542429934946 0.9611099255543043 0 -6291 0.1687457570057134 0.9611099255545085 0 -6292 0.3684933305390807 0.9016874772868441 0 -6293 0.7849882550292935 0.6564397011738609 0 -6294 0.399255992864848 0.913475677939648 0 -6295 0.4272630560626632 0.7875653375651045 0 -6296 0.399995089341152 0.8861788903014705 0 -6297 0.4554863310926411 0.9575322777794214 0 -6298 0.8513155082875326 0.927153006926299 0 -6299 0.1486844917117745 0.9271530069266358 0 -6300 0.9493398126589279 0.8884160669685514 0 -6301 0.05066018734082217 0.888416066968975 0 -6302 0.5361132996394085 0.7651773613257943 0 -6303 0.914904433766243 0.9059749316350647 0 -6304 0.0850955662333738 0.9059749316354354 0 -6305 0.5916209083824751 0.7580399057028374 0 -6306 0.9768730715581154 0.8956511270731936 0 -6307 0.02312692844191717 0.8956511270736178 0 -6308 0.2414051099791601 0.683026036464064 0 -6309 0.4722743991700892 0.1822316602731825 0 -6310 0.9472292429192057 0.3614308976457151 0 -6311 0.5277041754965801 0.1841167166542531 0 -6312 0.4080251891830439 0.7513443218698448 0 -6313 0.4360954189601112 0.7535325453026841 0 -6314 0.7588147383528037 0.6821272221486563 0 -6315 0.1463427286226025 0.514265808137232 0 -6316 0.9561335114654507 0.8719750038657822 0 -6317 0.0438664885343836 0.8719750038663552 0 -6318 0.4168631266204208 0.883584590695379 0 -6319 0.100323303942943 0.7264809189898758 0 -6320 0.6239538578813865 0.8579621483159885 0 -6321 0.4076269718054026 0.7742263285210982 0 -6322 0.3049161806478616 0.7107490108649943 0 -6323 0.0722698064169819 0.5892726781384632 0 -6324 0.9857438036283286 0.6620061434680213 0 -6325 0.8731152849887825 0.9632706252182064 0 -6326 0.1268847150106414 0.9632706252183723 0 -6327 0.9928150186570481 0.9295536913487324 0 -6328 0.007184981342997674 0.9295536913485567 0 -6329 0.9169886432108587 0.3808259229389908 0 -6330 0.8649358735685633 0.3444947093407081 0 -6331 0.6563507518035588 0.968480477127994 0 -6332 0.3438470903451125 0.3352822169930034 0 -6333 0.7846591213531124 0.2109392890570578 0 -6334 0.4716644445157288 0.3739691298315787 0 -6335 0.4228418704013837 0.9332384780626863 0 -6336 0.1913493572774412 0.5408259296261344 0 -6337 0.567497376901861 0.8023005976760258 0 -6338 0.6803799500983272 0.9353434572378061 0 -6339 0.1037368249816808 0.6324260608175785 0 -6340 0.1716526032355223 0.03124332263960176 0 -6341 0.7511972241930672 0.947879337879003 0 -6342 0.439231919655537 0.9492351937372094 0 -6343 0.2488027758056975 0.9478793378792872 0 -6344 0.965504395590802 0.5904099382547773 0 -6345 0.967656143797107 0.9463513911221308 0 -6346 0.03234385620274456 0.9463513911223895 0 -6347 0.1756328411933805 0.7888298452515716 0 -6348 0.2673368496914528 0.02855629473711189 0 -6349 0.7551256621693062 0.4396925738925491 0 -6350 0.9896897475579267 0.7407944964099441 0 -6351 0.7267236158279676 0.1754203493847873 0 -6352 0.60499999999896 0.9938136098715409 0 -6353 0.9300753450844781 0.9618213126003649 0 -6354 0.06992465491520206 0.9618213126005473 0 -6355 0.4308538677866365 0.823036644090902 0 -6356 0.08629680137655263 0.7017798932678577 0 -6357 0.4811425021713306 0.6342452859358905 0 -6358 0.8191450947137391 0.9210143944226546 0 -6359 0.1808549052853985 0.9210143944230458 0 -6360 0.4358754931824698 0.8754198430916027 0 -6361 0.5182456290933604 0.1133798993822902 0 -6362 0.4825766282604916 0.838280330421889 0 -6363 0.8569381307064738 0.7073601113187453 0 -6364 0.5832877487235149 0.9079224501128582 0 -6365 0.752231861986284 0.8140591658968384 0 -6366 0.2483823238182461 0.8111444413816651 0 -6367 0.4748402020100503 0.73710331990127 0 -6368 0.9048094204626707 0.894825211517737 0 -6369 0.09519057953687157 0.8948252115181392 0 -6370 0.8255560879791803 0.8102017137198089 0 -6371 0.1743234606008982 0.810184696772691 0 -6372 0.8374873905116903 0.8737888158178195 0 -6373 0.1625126094875677 0.873788815818403 0 -6374 0.02219074874827395 0.3361360178525911 0 -6375 0.01097406181900513 0.7407167545006317 0 -6376 0.7516389930781849 0.590104263932285 0 -6377 0.2242967462670181 0.6452810889575507 0 -6378 0.4950459221766449 0.8392376099085417 0 -6379 0.3984085070442243 0.5281660354725078 0 -6380 0.01156730394974344 0.6860774803697711 0 -6381 0.986088175646557 0.7118783631533852 0 -6382 0.8657928523191034 0.6048829217868834 0 -6383 0.6439738897205766 0.9802117472394645 0 -6384 0.2193546507692148 0.7441433956056558 0 -6385 0.4230114121143904 0.7124918449873375 0 -6386 0.8826125813511808 0.9157254760989224 0 -6387 0.1173874186482778 0.915725476099269 0 -6388 0.991935032547563 0.8653412278269981 0 -6389 0.008064967452546848 0.8653412278266347 0 -6390 0.5610475018447693 0.2759214491862425 0 -6391 0.7326943079248691 0.9808386200190709 0 -6392 0.2673049891720315 0.9808369886967832 0 -6393 0.8803595284324484 0.803021122095158 0 -6394 0.1196267514121767 0.803166910150332 0 -6395 0.6597737841749968 0.3866181983904248 0 -6396 0.8917129256836749 0.7674543657317815 0 -6397 0.1096758534052287 0.7674153746936733 0 -6398 0.4839145513669044 0.8007984292649675 0 -6399 0.5064047794691722 0.6188830183316061 0 -6400 0.3774680246301512 0.8568493462621382 0 -6401 0.4233496355085098 0.9193483215721483 0 -6402 0.5419388840466115 0.6458534276784453 0 -6403 0.4734843705643608 0.9516200192284684 0 -6404 0.6796072993769848 0.7949580312441312 0 -6405 0.6630714201582779 0.4801672980704125 0 -6406 0.4269094953232503 0.9031369541496919 0 -6407 0.9743532421595236 0.05906473301752724 0 -6408 0.443653079336315 0.8197447468355771 0 -6409 0.4657093661322229 0.8224210496016053 0 -6410 0.02214804734856063 0.05756656695233538 0 -6411 0.04518436657069848 0.4448365800852037 0 -6412 0.4405349621675056 0.9212857727421284 0 -6413 0.5064911028343402 0.4269979208493212 0 -6414 0.5180792723670946 0.26657488697015 0 -6415 0.6592183879149851 0.8967528001138083 0 -6416 0.3213853280128152 0.7980164065876637 0 -6417 0.6602724446633699 0.5946903478502504 0 -6418 0.8831517133273188 0.7164062528314563 0 -6419 0.4477748381769112 0.3316018812847127 0 -6420 0.9813308827307092 0.4586420644641646 0 -6421 0.3428128593505421 0.6198811489552538 0 -6422 0.9549684104447458 0.829427452503545 0 -6423 0.0450315895552819 0.8294274525039227 0 -6424 0.7442921383815286 0.9605977477290166 0 -6425 0.255707861617196 0.9605977477292245 0 -6426 0.8169494782088523 0.9640225786602186 0 -6427 0.1830505217902751 0.9640225786604086 0 -6428 0.2135144022972898 0.4151861465824672 0 -6429 0.6163900519025433 0.8234128577684396 0 -6430 0.07528293265938624 0.06572426427804209 0 -6431 0.4974849890435264 0.884518857940666 0 -6432 0.1783195150987345 0.4209765738893247 0 -6433 0.4624523784436013 0.6040578060504072 0 -6434 0.01610502049553615 0.3834431176626261 0 -6435 0.9863854070588522 0.687837835665606 0 -6436 0.668060916338608 0.7085020647296366 0 -6437 0.7307401960308779 0.8711223654617439 0 -6438 0.2692598039678006 0.8711223654624148 0 -6439 0.5612018035338324 0.5496931231158786 0 -6440 0.2192137348029672 0.3129391967918615 0 -6441 0.1880783212429075 0.7530233173750209 0 -6442 0.6917762888318028 0.8004590473409308 0 -6443 0.8707784509831099 0.2927538840522453 0 -6444 0.9424639126140864 0.9374534562962801 0 -6445 0.0575360873856474 0.9374534562965848 0 -6446 0.3943730011985056 0.7751103522812213 0 -6447 0.382871226056025 0.5002088056001663 0 -6448 0.6091090444747299 0.5108287056275148 0 -6449 0.3100037925264222 0.8484021417646592 0 -6450 0.3252183999055006 0.9459716334558994 0 -6451 0.4925706348767705 0.6959461782716664 0 -6452 0.6671712609096726 0.9926857484668705 0 -6453 0.9526780493653846 0.9395857128929652 0 -6454 0.0473219506343954 0.9395857128932652 0 -6455 0.1132474556098102 0.4436983639391849 0 -6456 0.3222277501958591 0.9351453518882539 0 -6457 0.9390607936751252 0.7404641190859708 0 -6458 0.05997222805311914 0.7415336700381997 0 -6459 0.7272599168116305 0.9649780673374029 0 -6460 0.2727389256305353 0.9649753808344428 0 -6461 0.1999541558485375 0.4479518324789303 0 -6462 0.7373981159063427 0.698269809948557 0 -6463 0.4061037078376427 0.7126567952167566 0 -6464 0.2890064416359076 0.7633575515923605 0 -6465 0.3816596342374201 0.8830867314211348 0 -6466 0.3496229830130909 0.2237610303636746 0 -6467 0.6310029897735626 0.5807675913836314 0 -6468 0.8008631976994398 0.8718419059122373 0 -6469 0.199136802299661 0.8718419059127852 0 -6470 0.5538765120528422 0.7483458468966543 0 -6471 0.6511338722293347 0.9345809171900535 0 -6472 0.8915349426378543 0.0706291351205115 0 -6473 0.4031160674648214 0.8176972637217608 0 -6474 0.948616780129208 0.9215792751546641 0 -6475 0.05138321987055019 0.9215792751550497 0 -6476 0.9231448030892424 0.9550994489042466 0 -6477 0.07685519691040049 0.955099448904446 0 -6478 0.7429430633407066 0.9335076192808667 0 -6479 0.2570569366579983 0.9335076192812193 0 -6480 0.5537775005705127 0.8190302571040196 0 -6481 0.9047071391492656 0.9941035545695236 0 -6482 0.0952928608503061 0.9941035545695517 0 -6483 0.2543649893409036 0.2864806218974359 0 -6484 0.367503492728272 0.3839017933794195 0 -6485 0.937040248838351 0.5921509590686868 0 -6486 0.5166815006210972 0.6327889440440619 0 -6487 0.4822659178825715 0.947641572415893 0 -6488 0.8744284191183327 0.7288517164025466 0 -6489 0.3942556444174026 0.7504935588824091 0 -6490 0.1642397204950825 0.5933680337771168 0 -6491 0.44491571333083 0.3635647102158801 0 -6492 0.9058556520810827 0.2092979998065003 0 -6493 0.484271838214974 0.07669281189071092 0 -6494 0.3279361442400701 0.8692201788394408 0 -6495 0.6718077438556329 0.8691914479660977 0 -6496 0.6482565967760561 0.5757502165820171 0 -6497 0.6472522669911857 0.8794922195753708 0 -6498 0.9659003476169516 0.6718993186510462 0 -6499 0.904570788554885 0.4952619044713598 0 -6500 0.3543321397630168 0.9108800353864378 0 -6501 0.039635276363372 0.684027038989784 0 -6502 0.8495270593370046 0.7413451875113606 0 -6503 0.818780366756519 0.8501155041228401 0 -6504 0.181219633242622 0.8501155041235309 0 -6505 0.6125971012221488 0.3441031712309218 0 -6506 0.9166297775781016 0.8812386364656923 0 -6507 0.08337022242144665 0.881238636466144 0 -6508 0.5419545231780555 0.85948349595415 0 -6509 0.820178827954873 0.7726628995074729 0 -6510 0.5169352583644371 0.8853409982614923 0 -6511 0.7669456764703165 0.6317370653967171 0 -6512 0.3315645700482455 0.755441494095845 0 -6513 0.03691785022490375 0.6293907656708468 0 -6514 0.7768025517928405 0.2961074023118325 0 -6515 0.6361913366756571 0.2075699752013102 0 -6516 0.4255237898544705 0.8090895621572111 0 -6517 0.6624998589034812 0.4121134157190283 0 -6518 0.8012649015824076 0.957062614735515 0 -6519 0.1987350984166322 0.95706261473573 0 -6520 0.7719111229426365 0.9154111479306939 0 -6521 0.2280888770562273 0.9154111479311084 0 -6522 0.5945260725293604 0.6752441360005569 0 -6523 0.932079523506292 0.4459023691673281 0 -6524 0.9924645800713839 0.981952621283539 0 -6525 0.007535419928645174 0.9819526212835147 0 -6526 0.6326180622816568 0.6017339432895102 0 -6527 0.2181423126502171 0.06343693784746979 0 -6528 0.447105635968423 0.07089019923720694 0 -6529 0.4836027436856314 0.9373589646968054 0 -6530 0.6056472908183124 0.1193490380907222 0 -6531 0.5984046921388022 0.7440874874441638 0 -6532 0.8626451709730444 0.9927341814238891 0 -6533 0.1373548290263262 0.9927341814239249 0 -6534 0.9088397602258639 0.8025976775316572 0 -6535 0.09116023977425322 0.8025976775321431 0 -6536 0.1191262973600911 0.3209347914226852 0 -6537 0.4349999999988727 0.9941552206075657 0 -6538 0.01815489018788463 0.4298253096181582 0 -6539 0.3547298101904591 0.4872664057324401 0 -6540 0.7890157905340676 0.8715670325846575 0 -6541 0.2109842094649293 0.8715670325852649 0 -6542 0.3515876867366073 0.02839413361440976 0 -6543 0.7552080929691375 0.07391177022056089 0 -6544 0.5493353262272169 0.9068176387517832 0 -6545 0.3899595357852842 0.3180966474541168 0 -6546 0.7485610269854814 0.9850747777061489 0 -6547 0.2514389730132615 0.9850747777062335 0 -6548 0.8998836805192718 0.7210824593254657 0 -6549 0.9822707723809743 0.9926745955747883 0 -6550 0.01772922761894392 0.992674595574826 0 -6551 0.4771271945320248 0.509746063399322 0 -6552 0.03683793810592608 0.7408423412466355 0 -6553 0.7115193719627968 0.6834060849261692 0 -6554 0.8914440351618993 0.2366912191799572 0 -6555 0.08895432328866296 0.6043363887531636 0 -6556 0.1390011292999405 0.6055081360847195 0 -6557 0.318309354538049 0.9211087202726524 0 -6558 0.6057757520484961 0.8996631190274398 0 -6559 0.4909907908416776 0.9521901396904053 0 -6560 0.1327249167498417 0.2626263940550653 0 -6561 0.6252437054897088 0.474851759502124 0 -6562 0.4199185502209736 0.179009772817637 0 -6563 0.4878080579447625 0.5582766580784662 0 -6564 0.4949999999987035 0.9942153735171784 0 -6565 0.5314341593483533 0.7768441353297862 0 -6566 0.696475373578205 0.9281522822630039 0 -6567 0.3032441884255999 0.9287111735585016 0 -6568 0.5917679069639291 0.9247026376745592 0 -6569 0.9731101350107194 0.02619688720905929 0 -6570 0.3148827956826251 0.835308664927797 0 -6571 0.3157021579034817 0.9701536603195067 0 -6572 0.6088342022035876 0.4225233373108579 0 -6573 0.5627735131002845 0.6014679801226143 0 -6574 0.4884489972850536 0.592209890261098 0 -6575 0.3355135004633637 0.9080559978255061 0 -6576 0.2634190611023387 0.2112741555344346 0 -6577 0.2735449057935789 0.7939689908622549 0 -6578 0.6495554292062764 0.1373361397480107 0 -6579 0.6823718133647538 0.9212488184770301 0 -6580 0.09795769595890089 0.1893278789693392 0 -6581 0.463258060134103 0.0240661897796562 0 -6582 0.7181609636110693 0.3656536896347532 0 -6583 0.8006636332358388 0.9109564413999995 0 -6584 0.1993363667631913 0.9109564414004461 0 -6585 0.9178359124061537 0.4565521228870605 0 -6586 0.5123806667437912 0.6060145817196241 0 -6587 0.6978745888510598 0.4083350043559402 0 -6588 0.5667851584924556 0.8846193151840043 0 -6589 0.1988383168153688 0.7721356394067485 0 -6590 0.9484982635110809 0.6342481279118024 0 -6591 0.9450346727780163 0.9122098241854697 0 -6592 0.05496532722173066 0.9122098241858743 0 -6593 0.1953318765616371 0.6018412952763572 0 -6594 0.307937130920569 0.981509796236226 0 -6595 0.6283484546060126 0.8679910501272823 0 -6596 0.5563746354730387 0.6910671891851237 0 -6597 0.8432750014771186 0.6968732780804576 0 -6598 0.788038790953478 0.9211370802108884 0 -6599 0.2119612090454656 0.9211370802112625 0 -6600 0.5106167362319163 0.902856265668272 0 -6601 0.4712516001327157 0.7988663592987729 0 -6602 0.8046065040368635 0.1994148570440221 0 -6603 0.6670713869650707 0.9300345138306279 0 -6604 0.810969463931562 0.791209328262486 0 -6605 0.01367671649217349 0.5823626761259285 0 -6606 0.1888954306755098 0.79089046426461 0 -6607 0.7047379982519035 0.262049394844344 0 -6608 0.9330003063243931 0.0260490426663518 0 -6609 0.4490464874401406 0.9365766670555711 0 -6610 0.300387977216402 0.4077866922967438 0 -6611 0.7289102524111556 0.787423934882345 0 -6612 0.6594965402763332 0.6541304798492144 0 -6613 0.8891969970408153 0.5480116642992943 0 -6614 0.7093489087864021 0.8913621866329743 0 -6615 0.2906525739269096 0.8913680266175124 0 -6616 0.5224110482582377 0.9363101409879142 0 -6617 0.7989876924226123 0.8525122338238309 0 -6618 0.2010123075764199 0.8525122338245069 0 -6619 0.3504096282457654 0.9528293085959256 0 -6620 0.1733116636687725 0.07111518205423216 0 -6621 0.02043262147040368 0.129909699018045 0 -6622 0.2094526333527911 0.7277901300230397 0 -6623 0.4816432939004696 0.9664404227849315 0 -6624 0.7642306773248015 0.7551235557306384 0 -6625 0.7388548458075705 0.974903606364071 0 -6626 0.2611450944205587 0.9749034676463211 0 -6627 0.8401967566595296 0.9843584059743631 0 -6628 0.1598032433397239 0.9843584059744401 0 -6629 0.5391350882055082 0.893797280458878 0 -6630 0.1871761685091415 0.7666657530853439 0 -6631 0.9308170747407088 0.9751695119674313 0 -6632 0.06918292525897424 0.9751695119675508 0 -6633 0.5108094809672132 0.4989107242431162 0 -6634 0.7911076211501007 0.8905986826707868 0 -6635 0.2088923788488809 0.8905986826713153 0 -6636 0.5523092642064863 0.7633436783467096 0 -6637 0.7615659544950641 0.9843548155259948 0 -6638 0.2384340455037515 0.9843548155260819 0 -6639 0.8282970005507495 0.2369136654426892 0 -6640 0.9012190621443177 0.3281880357583806 0 -6641 0.9414747293286048 0.1061696936223508 0 -6642 0.7845666321789095 0.8813277004443212 0 -6643 0.2154333678200397 0.8813277004449072 0 -6644 0.2173831622482459 0.4366115635205965 0 -6645 0.7600851205097953 0.860150134446251 0 -6646 0.2399148794890137 0.8601501344469591 0 -6647 0.6802612745048597 0.9844225298744657 0 -6648 0.9770901146980364 0.8722321723074611 0 -6649 0.02290988530195938 0.8722321723077556 0 -6650 0.08551151665569097 0.4193697036825962 0 -6651 0.2417528459155418 0.1068198362699198 0 -6652 0.6041023465046114 0.6638889421181564 0 -6653 0.749570978978953 0.8031407904539349 0 -6654 0.4027718716169566 0.6061843258053174 0 -6655 0.6756027457940095 0.901624132900392 0 -6656 0.5635115441612308 0.8238289605599803 0 -6657 0.5514100332309702 0.7070054150113123 0 -6658 0.5032689494629519 0.8084064366397579 0 -6659 0.3230213936014273 0.3974974362755433 0 -6660 0.9840990794299644 0.4108999738560447 0 -6661 0.3336369372013982 0.5911065861016576 0 -6662 0.5534215020630087 0.8419582270587656 0 -6663 0.4632283530058339 0.993128708047006 0 -6664 0.9890369491462321 0.795021106111624 0 -6665 0.01096673043453134 0.7950169939024253 0 -6666 0.7818039726819528 0.9128323330718211 0 -6667 0.2181960273169647 0.9128323330722391 0 -6668 0.6180960775241193 0.3211410643028442 0 -6669 0.5759029633252564 0.7848061163192063 0 -6670 0.5767710866569102 0.9329572356351843 0 -6671 0.6447927259300555 0.7705956701481573 0 -6672 0.4920707506303865 0.8931632314955096 0 -6673 0.4535657012785081 0.9923629698145433 0 -6674 0.1035738905163261 0.7419033417138603 0 -6675 0.7589331041921556 0.6448811075543798 0 -6676 0.2589926166868647 0.4827892951420782 0 -6677 0.5233618025110964 0.8559212489707267 0 -6678 0.8984357146933586 0.9227849132304884 0 -6679 0.1015642853061893 0.922784913230797 0 -6680 0.1257692483172366 0.5643369170351394 0 -6681 0.7819950081319638 0.7720081901171176 0 -6682 0.6545172036265318 0.978749538450675 0 -6683 0.6594427486070474 0.6264198144126385 0 -6684 0.05026697552918476 0.3725688700601562 0 -6685 0.8895665698007109 0.9610003689350206 0 -6686 0.110433430198788 0.9610003689351907 0 -6687 0.46287458511524 0.8094021376383657 0 -6688 0.52623086104219 0.891101987263157 0 -6689 0.1325395762173428 0.5927349741393546 0 -6690 0.0666023973662442 0.7176994533555564 0 -6691 0.336499730557603 0.7119119586440044 0 -6692 0.6301044124957059 0.2483494304044573 0 -6693 0.7521529323398101 0.7333988599868804 0 -6694 0.7114534060577399 0.9414667617735508 0 -6695 0.2885480795022679 0.9414645857235606 0 -6696 0.3591118478107062 0.5748983808146626 0 -6697 0.3794581542969546 0.215337261244833 0 -6698 0.04020686349237851 0.5950048183471306 0 -6699 0.6520862684904453 0.9512587514792796 0 -6700 0.3718978540230424 0.8224739067924446 0 -6701 0.4912237162632543 0.5203501846261633 0 -6702 0.3869477057984436 0.8067183202712913 0 -6703 0.4105057549863959 0.2827865743266195 0 -6704 0.7188992548130976 0.6713121261323364 0 -6705 0.9518029917683537 0.4723611151007208 0 -6706 0.6958080085884265 0.682139829225727 0 -6707 0.3174699357598571 0.9933846345230167 0 -6708 0.532929919802712 0.8492498010239146 0 -6709 0.3409378191974214 0.5633015709998594 0 -6710 0.5952173169110354 0.4572378164393982 0 -6711 0.4188248705478702 0.4219964170354077 0 -6712 0.7423863205436088 0.5045202626503871 0 -6713 0.3737432113843632 0.9450101173682854 0 -6714 0.6738160504315371 0.852892507097576 0 -6715 0.7623595904511784 0.256513771540922 0 -6716 0.6855250954916079 0.853013639357209 0 -6717 0.3278765277805963 0.851813599845383 0 -6718 0.2887627417805465 0.5384835137986849 0 -6719 0.445250489921874 0.2597719908003852 0 -6720 0.2985745350355736 0.7570652841767203 0 -6721 0.3965918714231317 0.6745138283471713 0 -6722 0.9825331779320585 0.9408466714078552 0 -6723 0.01746682206786064 0.9408466714080721 0 -6724 0.8998377965604341 0.3618542925084314 0 -6725 0.4065604282643566 0.4657040561570563 0 -6726 0.6485803848497385 0.9642123191632734 0 -6727 0.6646631116615228 0.9829072291997077 0 -6728 0.2441931771914914 0.759161220988726 0 -6729 0.6237820842813855 0.99363360273653 0 -6730 0.901859873228126 0.6455352018923922 0 -6731 0.8833265805442831 0.1265927288464145 0 -6732 0.7224777983477447 0.3222497569524588 0 -6733 0.5618969147919434 0.9313568900528848 0 -6734 0.7307582257381997 0.8151998574431921 0 -6735 0.06112130690077722 0.5336376188265215 0 -6736 0.671083979239405 0.5195597660151929 0 -6737 0.3213283729808458 0.2695602393956572 0 -6738 0.6570079905113704 0.8513465529153551 0 -6739 0.7011419891802748 0.06338544996809298 0 -6740 0.4280024374052326 0.540087924558 0 -6741 0.5948134582854714 0.8709183122508209 0 -6742 0.6199827086546055 0.5607026883303017 0 -6743 0.4098344983046094 0.3575515305845621 0 -6744 0.4581440599172949 0.9092610320808461 0 -6745 0.2097794009036742 0.2923538163955446 0 -6746 0.7772450721031398 0.5797883493216154 0 -6747 0.5152095980918072 0.7762441364787964 0 -6748 0.2261519406534068 0.707711738676303 0 -6749 0.7071637205907428 0.9301394357732056 0 -6750 0.2929104965171199 0.9301982692601207 0 -6751 0.6083099832819225 0.9290498007356207 0 -6752 0.9625053588938423 0.9317683408803619 0 -6753 0.03749464110598044 0.9317683408806964 0 -6754 0.2519706746465499 0.6213447915594859 0 -6755 0.5803896600689098 0.449106706775037 0 -6756 0.3463972086376353 0.8044853223463491 0 -6757 0.352663800758624 0.5910305477234539 0 -6758 0.6428795980413851 0.4228012905138283 0 -6759 0.8155135703622042 0.9093101575987248 0 -6760 0.1844864296369316 0.909310157599179 0 -6761 0.1678328485177288 0.7094559114035998 0 -6762 0.2136605026644176 0.2508995892772614 0 -6763 0.342822623894377 0.8512571567537235 0 -6764 0.3319599848745503 0.4309272411997039 0 -6765 0.9048422835836263 0.7488320786978414 0 -6766 0.916933162180348 0.7680292901322764 0 -6767 0.08255757053370799 0.7680882334054386 0 -6768 0.3026010153428899 0.2296963999450379 0 -6769 0.1018943207013485 0.021930455996072 0 -6770 0.9803649682392158 0.9547032653283458 0 -6771 0.01963503176067325 0.9547032653284789 0 -6772 0.4173579675547279 0.8735478603315705 0 -6773 0.1538764942748083 0.1002582655892602 0 -6774 0.4124349766942169 0.6577215443962121 0 -6775 0.8277571756969513 0.706115307637001 0 -6776 0.8598985650529303 0.1989053392290047 0 -6777 0.6850151382346902 0.1915776231253989 0 -6778 0.7290345090116577 0.3973863850750134 0 -6779 0.4586735315647807 0.949545108478282 0 -6780 0.349800339583509 0.7525838919642293 0 -6781 0.5410296781911862 0.8383132905313038 0 -6782 0.1156201233532829 0.3934436309027852 0 -6783 0.07934808366443438 0.3061393845230359 0 -6784 0.4046361612299036 0.97776788716368 0 -6785 0.8604485016841972 0.1099232119932427 0 -6786 0.8992351932434026 0.9127883229711975 0 -6787 0.100764806756148 0.9127883229715283 0 -6788 0.4233463628764834 0.4572124065595486 0 -6789 0.05740976093161634 0.2091861795772333 0 -6790 0.5155876580543718 0.7450259992394939 0 -6791 0.3252089519402985 0.9024068172035483 0 -6792 0.9199602664800051 0.8496780391850802 0 -6793 0.08003973351974161 0.8496780391854616 0 -6794 0.5622274229764801 0.9926837374498252 0 -6795 0.8897550831846748 0.9685496978647115 0 -6796 0.1102449168148263 0.9685496978648502 0 -6797 0.3017745862541619 0.9635311791214831 0 -6798 0.09502109108185126 0.1064423975467702 0 -6799 0.01622069216939914 0.4665540483538027 0 -6800 0.6588643572833839 0.7540580731813238 0 -6801 0.5619516540036378 0.8613614469056544 0 -6802 0.5706159749036831 0.8416214782444965 0 -6803 0.7904892999037734 0.7989565378477912 0 -6804 0.2080490447587144 0.7987590843925634 0 -6805 0.3647971374189607 0.6591589321628462 0 -6806 0.7853335658370393 0.07344613572966954 0 -6807 0.7930739229299689 0.5704025813694049 0 -6808 0.2388404337277757 0.7834971020069456 0 -6809 0.5223465334403157 0.7976109193073198 0 -6810 0.5049206049707629 0.8498228797023026 0 -6811 0.7097179827047446 0.877270579606622 0 -6812 0.2914959012247091 0.8781723971882532 0 -6813 0.6469128432066 0.9116822366817108 0 -6814 0.6650798110113629 0.9686876561214044 0 -6815 0.2085197514699737 0.764703348885112 0 -6816 0.6831089643982893 0.9697452431576961 0 -6817 0.3558417595316684 0.4354162256956124 0 -6818 0.1668726529308726 0.1521091256173084 0 -6819 0.4807050737686537 0.9755477481927397 0 -6820 0.6004809541322915 0.9588794822916107 0 -6821 0.9652659119419035 0.8375115346728885 0 -6822 0.03473408805813526 0.8375115346732529 0 -6823 0.7246821858193367 0.3006995368549166 0 -6824 0.2003294848873986 0.5783731580813557 0 -6825 0.6051416682464565 0.1671019932227034 0 -6826 0.5948100679461268 0.7949769616858279 0 -6827 0.8269710067689453 0.9443530929925135 0 -6828 0.1730289932302107 0.9443530929927816 0 -6829 0.5832613032204457 0.8576161856133688 0 -6830 0.7465664858146459 0.7884652409489441 0 -6831 0.7107318966585251 0.7269509291223657 0 -6832 0.3449100714118967 0.8777188562822584 0 -6833 0.423727675336217 0.9732642585492053 0 -6834 0.3538583949258162 0.0579128551780216 0 -6835 0.3402079553212328 0.9859243904577776 0 -6836 0.6588846266855704 0.8658122097075471 0 -6837 0.1188406485604429 0.6795013485358388 0 -6838 0.4436694132091898 0.8941034159572521 0 -6839 0.8372420105784895 0.9565895184844666 0 -6840 0.1627579894207511 0.9565895184846849 0 -6841 0.6703482771090359 0.7340026467072673 0 -6842 0.7622107525866266 0.5576160784273916 0 -6843 0.6115141005787006 0.7829170068460762 0 -6844 0.4004278830130605 0.8672879591025466 0 -6845 0.1859666182025478 0.66600658518501 0 -6846 0.8937582586603162 0.6188822512461543 0 -6847 0.7941484383949626 0.9591484231839131 0 -6848 0.2058515616040369 0.9591484231841161 0 -6849 0.3425890733058139 0.9494190361620773 0 -6850 0.341010704633642 0.8668499970500529 0 -6851 0.7184295608991159 0.5552759826384506 0 -6852 0.2682028032893441 0.8161732496084024 0 -6853 0.02231716424032599 0.2090477551965585 0 -6854 0.6353942501579778 0.9402496613779421 0 -6855 0.8859093443673145 0.8907638803217609 0 -6856 0.1140906556321759 0.8907638803222396 0 -6857 0.9840619579436671 0.4830777426841575 0 -6858 0.6457459206867735 0.9421596529098932 0 -6859 0.7145121736354604 0.7704389390371577 0 -6860 0.3717370633605831 0.6206036885405819 0 -6861 0.09097106369837873 0.7490132434965469 0 -6862 0.8258916957984384 0.9813953935612247 0 -6863 0.1741083042007426 0.98139539356132 0 -6864 0.9662919546109843 0.9760462582032425 0 -6865 0.03370804538887689 0.9760462582033287 0 -6866 0.3163927192646488 0.4910890885180618 0 -6867 0.7182110282624843 0.8700570185138722 0 -6868 0.4422994197913842 0.9094916100692993 0 -6869 0.282341095223438 0.8693478919265135 0 -6870 0.9444131310194506 0.07164717445536233 0 -6871 0.9587310866551868 0.9819026016004961 0 -6872 0.04126891334463132 0.981902601600569 0 -6873 0.324999999999193 0.9947434832496781 0 -6874 0.9029938010410632 0.8761649606763136 0 -6875 0.09700619895847593 0.876164960676818 0 -6876 0.4587445203388341 0.5169717784668301 0 -6877 0.9302216385609372 0.2155059067264443 0 -6878 0.7517260191199886 0.9389470498072769 0 -6879 0.2482739808787671 0.9389470498076 0 -6880 0.698352917761956 0.9635062058342826 0 -6881 0.5632955086964034 0.9725215938025416 0 -6882 0.757224642862057 0.6161679417604867 0 -6883 0.5302045553881035 0.8158399711420513 0 -6884 0.5814495057280464 0.2792721153958804 0 -6885 0.6232925723728394 0.7029143649470239 0 -6886 0.4476954214836478 0.6714163966906638 0 -6887 0.2909771854514417 0.3730759818895937 0 -6888 0.2071896777457166 0.7527878251878825 0 -6889 0.8798649044958593 0.5301340888974828 0 -6890 0.5259070022463388 0.7554785619125164 0 -6891 0.3693522621584778 0.35039984772135 0 -6892 0.4931536427206055 0.7233487344005428 0 -6893 0.6278501831965418 0.9622442200706115 0 -6894 0.4997962661269922 0.9264832997263849 0 -6895 0.598933072295362 0.9833281956740179 0 -6896 0.4721360591828087 0.8766964959106855 0 -6897 0.9940766167724617 0.9940854541448928 0 -6898 0.005923383227486876 0.9940854541449153 0 -6899 0.8761374176936352 0.1544572163509063 0 -6900 0.908772960886491 0.5474977125077283 0 -6901 0.3860531776682846 0.3868763090548055 0 -6902 0.588930707954072 0.9683619005881137 0 -6903 0.8669417921196676 0.9024465215931896 0 -6904 0.1330582078797185 0.9024465215936135 0 -6905 0.957505794180068 0.4284731129848685 0 -6906 0.0165758373571964 0.2640252395595565 0 -6907 0.7249307119908435 0.4926279194479312 0 -6908 0.9479228485807385 0.9933361663619699 0 -6909 0.05207715141902278 0.9933361663620051 0 -6910 0.839602156838228 0.6409409638797224 0 -6911 0.2018467404899029 0.706610279448832 0 -6912 0.7258034849925826 0.9939304226439105 0 -6913 0.2741959262936019 0.9939308064896882 0 -6914 0.8455833518701452 0.9692127015021581 0 -6915 0.1544166481291392 0.969212701502308 0 -6916 0.9549999999998791 0.9948182723071408 0 -6917 0.04499999999991076 0.9948182723071696 0 -6918 0.7447387860532401 0.3334441950757261 0 -6919 0.06793672689257146 0.1172413896250261 0 -6920 0.1785834430330775 0.6370276931458337 0 -6921 0.1901854048629482 0.7136846765650714 0 -6922 0.8810325354342584 0.7553888159567144 0 -6923 0.1999002653539884 0.08200463575744571 0 -6924 0.9778318076196332 0.9256486021750443 0 -6925 0.022168192380318 0.9256486021753272 0 -6926 0.9394234736923056 0.9286893899773139 0 -6927 0.06057652630741465 0.9286893899776602 0 -6928 0.885826109873656 0.9940698237866175 0 -6929 0.1141738901258306 0.9940698237866371 0 -6930 0.4201834143411851 0.8624802984511563 0 -6931 0.9831249004438398 0.1656047159753248 0 -6932 0.1013461851060371 0.5438455013019815 0 -6933 0.5678589423476813 0.9035408438357887 0 -6934 0.633799012783411 0.3576860418045682 0 -6935 0.515968038399224 0.07017383514301968 0 -6936 0.580155979149661 0.6731467271356988 0 -6937 0.5365653585170682 0.6177835000554653 0 -6938 0.711666410482567 0.61904464466156 0 -6939 0.9260915493752686 0.7179179520745446 0 -6940 0.9386542266650957 0.3429755060131074 0 -6941 0.5361446430829958 0.3575027815654246 0 -6942 0.9268127292239782 0.9935376419023252 0 -6943 0.07318727077568925 0.9935376419023575 0 -6944 0.8605363563392761 0.8334774991313469 0 -6945 0.139463643660086 0.8334774991321354 0 -6946 0.08818875022026124 0.6608347122434403 0 -6947 0.6909819564264047 0.5960408268170451 0 -6948 0.9093527511140528 0.8213763201355837 0 -6949 0.09064724888587261 0.821376320136006 0 -6950 0.67919961801942 0.7824700785904976 0 -6951 0.4654583305452509 0.9372386365793303 0 -6952 0.3071254396940266 0.4582742234811892 0 -6953 0.2184616781543798 0.2091488480151026 0 -$EndNodes -$Elements -13766 -1 1 2 14 7 4 239 -2 1 2 14 7 239 240 -3 1 2 14 7 240 241 -4 1 2 14 7 241 242 -5 1 2 14 7 242 243 -6 1 2 14 7 243 244 -7 1 2 14 7 244 245 -8 1 2 14 7 245 246 -9 1 2 14 7 246 247 -10 1 2 14 7 247 248 -11 1 2 14 7 248 249 -12 1 2 14 7 249 250 -13 1 2 14 7 250 251 -14 1 2 14 7 251 252 -15 1 2 14 7 252 253 -16 1 2 14 7 253 254 -17 1 2 14 7 254 255 -18 1 2 14 7 255 256 -19 1 2 14 7 256 257 -20 1 2 14 7 257 258 -21 1 2 14 7 258 259 -22 1 2 14 7 259 260 -23 1 2 14 7 260 261 -24 1 2 14 7 261 262 -25 1 2 14 7 262 263 -26 1 2 14 7 263 264 -27 1 2 14 7 264 265 -28 1 2 14 7 265 266 -29 1 2 14 7 266 267 -30 1 2 14 7 267 268 -31 1 2 14 7 268 269 -32 1 2 14 7 269 270 -33 1 2 14 7 270 271 -34 1 2 14 7 271 272 -35 1 2 14 7 272 273 -36 1 2 14 7 273 274 -37 1 2 14 7 274 275 -38 1 2 14 7 275 276 -39 1 2 14 7 276 277 -40 1 2 14 7 277 278 -41 1 2 14 7 278 279 -42 1 2 14 7 279 280 -43 1 2 14 7 280 281 -44 1 2 14 7 281 282 -45 1 2 14 7 282 283 -46 1 2 14 7 283 284 -47 1 2 14 7 284 285 -48 1 2 14 7 285 286 -49 1 2 14 7 286 287 -50 1 2 14 7 287 288 -51 1 2 14 7 288 289 -52 1 2 14 7 289 290 -53 1 2 14 7 290 291 -54 1 2 14 7 291 292 -55 1 2 14 7 292 293 -56 1 2 14 7 293 294 -57 1 2 14 7 294 295 -58 1 2 14 7 295 296 -59 1 2 14 7 296 297 -60 1 2 14 7 297 298 -61 1 2 14 7 298 299 -62 1 2 14 7 299 300 -63 1 2 14 7 300 301 -64 1 2 14 7 301 302 -65 1 2 14 7 302 303 -66 1 2 14 7 303 304 -67 1 2 14 7 304 305 -68 1 2 14 7 305 306 -69 1 2 14 7 306 307 -70 1 2 14 7 307 308 -71 1 2 14 7 308 309 -72 1 2 14 7 309 310 -73 1 2 14 7 310 311 -74 1 2 14 7 311 312 -75 1 2 14 7 312 313 -76 1 2 14 7 313 314 -77 1 2 14 7 314 315 -78 1 2 14 7 315 316 -79 1 2 14 7 316 317 -80 1 2 14 7 317 318 -81 1 2 14 7 318 319 -82 1 2 14 7 319 320 -83 1 2 14 7 320 321 -84 1 2 14 7 321 322 -85 1 2 14 7 322 323 -86 1 2 14 7 323 324 -87 1 2 14 7 324 325 -88 1 2 14 7 325 326 -89 1 2 14 7 326 327 -90 1 2 14 7 327 328 -91 1 2 14 7 328 329 -92 1 2 14 7 329 330 -93 1 2 14 7 330 331 -94 1 2 14 7 331 332 -95 1 2 14 7 332 333 -96 1 2 14 7 333 334 -97 1 2 14 7 334 335 -98 1 2 14 7 335 336 -99 1 2 14 7 336 337 -100 1 2 14 7 337 3 -101 2 2 12 9 3448 589 1338 -102 2 2 12 9 3016 478 1519 -103 2 2 12 9 3017 1520 479 -104 2 2 12 9 1457 589 3448 -105 2 2 12 9 1427 3016 1519 -106 2 2 12 9 1428 1520 3017 -107 2 2 12 9 1161 1683 2226 -108 2 2 12 9 2226 1683 537 -109 2 2 12 9 2900 1547 1716 -110 2 2 12 9 2901 1717 1548 -111 2 2 12 9 1757 2521 463 -112 2 2 12 9 2707 1691 339 -113 2 2 12 9 1469 1792 3397 -114 2 2 12 9 689 1547 2900 -115 2 2 12 9 690 2901 1548 -116 2 2 12 9 1289 3195 1989 -117 2 2 12 9 1235 1691 2707 -118 2 2 12 9 2521 1564 463 -119 2 2 12 9 3384 833 1522 -120 2 2 12 9 815 1459 3596 -121 2 2 12 9 816 3597 1460 -122 2 2 12 9 1497 3384 1522 -123 2 2 12 9 3642 1449 390 -124 2 2 12 9 3072 388 2197 -125 2 2 12 9 2150 758 3553 -126 2 2 12 9 3596 1459 1560 -127 2 2 12 9 3597 1561 1460 -128 2 2 12 9 3500 1579 1378 -129 2 2 12 9 302 303 1963 -130 2 2 12 9 1537 3642 390 -131 2 2 12 9 1479 1544 3520 -132 2 2 12 9 1507 383 3600 -133 2 2 12 9 613 3500 1378 -134 2 2 12 9 1792 599 3397 -135 2 2 12 9 1806 3180 1327 -136 2 2 12 9 1238 2714 1612 -137 2 2 12 9 303 2976 1963 -138 2 2 12 9 2685 798 1114 -139 2 2 12 9 2714 358 1612 -140 2 2 12 9 3488 1789 1506 -141 2 2 12 9 1949 685 2543 -142 2 2 12 9 3643 1405 679 -143 2 2 12 9 1684 428 2926 -144 2 2 12 9 2838 1629 843 -145 2 2 12 9 1418 3643 679 -146 2 2 12 9 798 1950 1114 -147 2 2 12 9 2639 723 1560 -148 2 2 12 9 2640 1561 724 -149 2 2 12 9 3520 1544 699 -150 2 2 12 9 3600 383 1317 -151 2 2 12 9 1989 3195 627 -152 2 2 12 9 1220 1886 2922 -153 2 2 12 9 1327 3180 612 -154 2 2 12 9 2543 685 1631 -155 2 2 12 9 1851 2860 929 -156 2 2 12 9 1059 3488 1506 -157 2 2 12 9 1310 3130 1556 -158 2 2 12 9 3382 709 1162 -159 2 2 12 9 261 2731 1843 -160 2 2 12 9 315 1844 2732 -161 2 2 12 9 3163 454 1888 -162 2 2 12 9 3164 1889 455 -163 2 2 12 9 760 2195 1133 -164 2 2 12 9 761 1134 2196 -165 2 2 12 9 576 2045 1512 -166 2 2 12 9 1773 1944 2999 -167 2 2 12 9 1033 2720 1997 -168 2 2 12 9 1034 2000 2721 -169 2 2 12 9 672 1617 1202 -170 2 2 12 9 345 1444 2323 -171 2 2 12 9 3116 1585 614 -172 2 2 12 9 3117 615 1586 -173 2 2 12 9 529 1191 1778 -174 2 2 12 9 638 1353 1564 -175 2 2 12 9 450 1619 1222 -176 2 2 12 9 649 1996 1210 -177 2 2 12 9 1422 1589 3013 -178 2 2 12 9 1775 723 2639 -179 2 2 12 9 1776 2640 724 -180 2 2 12 9 3341 2508 1081 -181 2 2 12 9 3342 1082 2509 -182 2 2 12 9 638 1351 2306 -183 2 2 12 9 786 1964 2278 -184 2 2 12 9 785 1609 2277 -185 2 2 12 9 786 2278 1610 -186 2 2 12 9 712 2535 1236 -187 2 2 12 9 908 1758 2018 -188 2 2 12 9 785 2277 1988 -189 2 2 12 9 672 1202 1641 -190 2 2 12 9 653 1860 1664 -191 2 2 12 9 1343 1585 3116 -192 2 2 12 9 1344 3117 1586 -193 2 2 12 9 605 1276 2437 -194 2 2 12 9 445 3113 1199 -195 2 2 12 9 1115 1373 2964 -196 2 2 12 9 1821 2218 3590 -197 2 2 12 9 775 1135 2139 -198 2 2 12 9 2461 2963 659 -199 2 2 12 9 1403 1684 2926 -200 2 2 12 9 284 285 1484 -201 2 2 12 9 850 1657 1724 -202 2 2 12 9 1306 1629 2838 -203 2 2 12 9 760 1133 2991 -204 2 2 12 9 638 2306 1353 -205 2 2 12 9 761 2992 1134 -206 2 2 12 9 2963 1527 659 -207 2 2 12 9 3553 758 1231 -208 2 2 12 9 1295 2860 1851 -209 2 2 12 9 671 1265 1584 -210 2 2 12 9 725 1549 1291 -211 2 2 12 9 474 1731 1614 -212 2 2 12 9 681 2854 1221 -213 2 2 12 9 1106 1965 2715 -214 2 2 12 9 967 2768 1329 -215 2 2 12 9 431 1693 1187 -216 2 2 12 9 423 1289 1989 -217 2 2 12 9 662 1453 1330 -218 2 2 12 9 1349 3072 2197 -219 2 2 12 9 717 3230 1209 -220 2 2 12 9 226 1682 3276 -221 2 2 12 9 1624 2259 2647 -222 2 2 12 9 1329 2944 3269 -223 2 2 12 9 838 1581 1356 -224 2 2 12 9 3130 609 1556 -225 2 2 12 9 758 1951 1231 -226 2 2 12 9 694 1265 2983 -227 2 2 12 9 788 1155 3495 -228 2 2 12 9 1162 709 2060 -229 2 2 12 9 709 1422 3013 -230 2 2 12 9 704 1683 2488 -231 2 2 12 9 593 1357 1793 -232 2 2 12 9 594 1794 1358 -233 2 2 12 9 671 2457 1265 -234 2 2 12 9 3350 1648 1867 -235 2 2 12 9 656 2218 1821 -236 2 2 12 9 401 1231 1951 -237 2 2 12 9 570 1275 3428 -238 2 2 12 9 689 1846 1167 -239 2 2 12 9 690 1168 1847 -240 2 2 12 9 624 1415 1391 -241 2 2 12 9 625 1392 1416 -242 2 2 12 9 1174 2609 2421 -243 2 2 12 9 451 1547 1313 -244 2 2 12 9 452 1314 1548 -245 2 2 12 9 1665 2280 2815 -246 2 2 12 9 542 1374 1987 -247 2 2 12 9 257 258 1322 -248 2 2 12 9 318 319 1323 -249 2 2 12 9 849 2825 1286 -250 2 2 12 9 798 1714 1462 -251 2 2 12 9 628 1991 1315 -252 2 2 12 9 608 1291 3393 -253 2 2 12 9 566 2179 1176 -254 2 2 12 9 300 2381 1475 -255 2 2 12 9 493 1467 2341 -256 2 2 12 9 541 1804 1187 -257 2 2 12 9 616 1914 2811 -258 2 2 12 9 606 1572 1355 -259 2 2 12 9 775 2308 1135 -260 2 2 12 9 350 2163 1278 -261 2 2 12 9 470 1648 1221 -262 2 2 12 9 1763 3239 2537 -263 2 2 12 9 1291 1549 3393 -264 2 2 12 9 969 1654 2758 -265 2 2 12 9 970 2759 1655 -266 2 2 12 9 2944 430 3269 -267 2 2 12 9 300 301 2381 -268 2 2 12 9 2922 1886 600 -269 2 2 12 9 556 2201 1573 -270 2 2 12 9 888 1490 1492 -271 2 2 12 9 229 230 1311 -272 2 2 12 9 946 2084 1627 -273 2 2 12 9 1324 3163 1888 -274 2 2 12 9 1325 1889 3164 -275 2 2 12 9 931 1512 2045 -276 2 2 12 9 862 1290 1987 -277 2 2 12 9 733 1694 1890 -278 2 2 12 9 734 1891 1695 -279 2 2 12 9 1461 3504 2079 -280 2 2 12 9 637 1434 1568 -281 2 2 12 9 1205 3276 1682 -282 2 2 12 9 1941 3228 2525 -283 2 2 12 9 1942 2526 3229 -284 2 2 12 9 1066 1941 2525 -285 2 2 12 9 1067 2526 1942 -286 2 2 12 9 529 1985 1191 -287 2 2 12 9 563 1752 1150 -288 2 2 12 9 754 1781 2119 -289 2 2 12 9 782 1181 2259 -290 2 2 12 9 870 1923 1866 -291 2 2 12 9 930 1966 1335 -292 2 2 12 9 541 1187 1993 -293 2 2 12 9 1645 3533 2866 -294 2 2 12 9 466 1724 1657 -295 2 2 12 9 837 1944 1773 -296 2 2 12 9 674 1749 1243 -297 2 2 12 9 694 2983 1312 -298 2 2 12 9 718 1739 1171 -299 2 2 12 9 616 3304 1914 -300 2 2 12 9 340 1270 2593 -301 2 2 12 9 292 293 1506 -302 2 2 12 9 505 1244 1835 -303 2 2 12 9 284 1484 2932 -304 2 2 12 9 772 1557 1754 -305 2 2 12 9 663 1710 2266 -306 2 2 12 9 664 2267 1711 -307 2 2 12 9 538 1188 2207 -308 2 2 12 9 493 2341 2686 -309 2 2 12 9 969 2839 1654 -310 2 2 12 9 970 1655 2840 -311 2 2 12 9 1099 2944 1329 -312 2 2 12 9 478 1502 1519 -313 2 2 12 9 479 1520 1503 -314 2 2 12 9 1698 2410 3081 -315 2 2 12 9 1103 2205 2807 -316 2 2 12 9 2411 1699 3082 -317 2 2 12 9 1502 2404 3608 -318 2 2 12 9 1503 3609 2405 -319 2 2 12 9 630 2047 1662 -320 2 2 12 9 631 1663 2048 -321 2 2 12 9 681 1221 1648 -322 2 2 12 9 679 1237 3062 -323 2 2 12 9 704 2488 1681 -324 2 2 12 9 539 1156 2286 -325 2 2 12 9 1389 3580 2393 -326 2 2 12 9 501 1627 2084 -327 2 2 12 9 233 2615 1232 -328 2 2 12 9 825 3515 1434 -329 2 2 12 9 787 3573 1177 -330 2 2 12 9 597 2062 1492 -331 2 2 12 9 849 1215 2466 -332 2 2 12 9 422 1433 1462 -333 2 2 12 9 399 3203 1850 -334 2 2 12 9 1372 3453 1815 -335 2 2 12 9 712 1236 2523 -336 2 2 12 9 733 1890 1550 -337 2 2 12 9 734 1551 1891 -338 2 2 12 9 456 1250 3301 -339 2 2 12 9 606 1244 1572 -340 2 2 12 9 538 2964 1373 -341 2 2 12 9 1404 2585 2353 -342 2 2 12 9 557 1204 1822 -343 2 2 12 9 3453 444 1815 -344 2 2 12 9 562 1229 1658 -345 2 2 12 9 564 1659 1230 -346 2 2 12 9 3583 1394 2990 -347 2 2 12 9 354 1645 2866 -348 2 2 12 9 2952 845 1642 -349 2 2 12 9 722 2131 1618 -350 2 2 12 9 442 2280 1665 -351 2 2 12 9 3533 1204 2866 -352 2 2 12 9 837 1282 2113 -353 2 2 12 9 422 1489 1530 -354 2 2 12 9 679 1666 1237 -355 2 2 12 9 792 3316 1336 -356 2 2 12 9 397 1203 2081 -357 2 2 12 9 790 1286 2204 -358 2 2 12 9 1412 3080 1919 -359 2 2 12 9 1008 3590 2218 -360 2 2 12 9 862 1987 1374 -361 2 2 12 9 749 1216 1931 -362 2 2 12 9 856 2202 1296 -363 2 2 12 9 695 1594 1381 -364 2 2 12 9 857 1297 2203 -365 2 2 12 9 721 1530 1489 -366 2 2 12 9 1215 1336 3316 -367 2 2 12 9 1381 1594 3576 -368 2 2 12 9 605 2437 1386 -369 2 2 12 9 434 1200 3287 -370 2 2 12 9 435 3288 1201 -371 2 2 12 9 1077 2219 1897 -372 2 2 12 9 1078 1898 2220 -373 2 2 12 9 391 2346 1374 -374 2 2 12 9 696 1462 1433 -375 2 2 12 9 412 2856 2393 -376 2 2 12 9 539 3389 1156 -377 2 2 12 9 2033 2508 3341 -378 2 2 12 9 2034 3342 2509 -379 2 2 12 9 345 2323 2532 -380 2 2 12 9 1396 2466 2342 -381 2 2 12 9 675 1316 1756 -382 2 2 12 9 1434 3515 1568 -383 2 2 12 9 892 1564 1353 -384 2 2 12 9 849 1396 2825 -385 2 2 12 9 40 2169 2126 -386 2 2 12 9 181 2127 2170 -387 2 2 12 9 3251 2523 668 -388 2 2 12 9 570 3428 1515 -389 2 2 12 9 1962 1555 3206 -390 2 2 12 9 1075 2119 1781 -391 2 2 12 9 695 1258 3072 -392 2 2 12 9 3617 561 2583 -393 2 2 12 9 718 1171 2247 -394 2 2 12 9 666 2489 1364 -395 2 2 12 9 873 1748 1255 -396 2 2 12 9 3627 1837 598 -397 2 2 12 9 1205 3222 2291 -398 2 2 12 9 538 2032 1188 -399 2 2 12 9 782 1887 1181 -400 2 2 12 9 749 2954 1216 -401 2 2 12 9 529 3376 1252 -402 2 2 12 9 692 1724 2670 -403 2 2 12 9 546 2626 1157 -404 2 2 12 9 547 1158 2627 -405 2 2 12 9 634 1262 2695 -406 2 2 12 9 1033 1997 2979 -407 2 2 12 9 1034 2980 2000 -408 2 2 12 9 863 1614 1731 -409 2 2 12 9 743 1199 1685 -410 2 2 12 9 910 1257 2714 -411 2 2 12 9 739 1519 1502 -412 2 2 12 9 740 1503 1520 -413 2 2 12 9 779 2073 1688 -414 2 2 12 9 426 1459 2301 -415 2 2 12 9 427 2302 1460 -416 2 2 12 9 888 1492 2062 -417 2 2 12 9 677 3136 1307 -418 2 2 12 9 592 1449 2596 -419 2 2 12 9 397 2190 1203 -420 2 2 12 9 293 2959 1506 -421 2 2 12 9 562 1924 1229 -422 2 2 12 9 564 1230 1925 -423 2 2 12 9 438 1492 1490 -424 2 2 12 9 555 2421 2609 -425 2 2 12 9 447 1356 1581 -426 2 2 12 9 403 1287 2023 -427 2 2 12 9 404 2024 1288 -428 2 2 12 9 608 2917 1417 -429 2 2 12 9 541 2633 1804 -430 2 2 12 9 882 1349 2197 -431 2 2 12 9 1017 1573 2201 -432 2 2 12 9 642 2254 2684 -433 2 2 12 9 1664 1860 2891 -434 2 2 12 9 408 1897 2219 -435 2 2 12 9 409 2220 1898 -436 2 2 12 9 546 1157 2255 -437 2 2 12 9 547 2256 1158 -438 2 2 12 9 443 1986 2099 -439 2 2 12 9 702 1723 1691 -440 2 2 12 9 1296 2202 3087 -441 2 2 12 9 1297 3088 2203 -442 2 2 12 9 1279 2523 3251 -443 2 2 12 9 670 1577 1372 -444 2 2 12 9 1309 2952 1642 -445 2 2 12 9 357 1243 1749 -446 2 2 12 9 395 1745 1214 -447 2 2 12 9 722 2485 3021 -448 2 2 12 9 1220 2670 1724 -449 2 2 12 9 1132 3029 2168 -450 2 2 12 9 362 2259 2247 -451 2 2 12 9 542 1162 2060 -452 2 2 12 9 288 289 1360 -453 2 2 12 9 1700 432 3033 -454 2 2 12 9 3034 433 1701 -455 2 2 12 9 357 2913 1186 -456 2 2 12 9 377 2524 3057 -457 2 2 12 9 634 3475 1262 -458 2 2 12 9 723 2410 1698 -459 2 2 12 9 724 1699 2411 -460 2 2 12 9 922 1624 2647 -461 2 2 12 9 1095 2537 3239 -462 2 2 12 9 457 2466 1215 -463 2 2 12 9 1004 1662 2047 -464 2 2 12 9 1005 2048 1663 -465 2 2 12 9 1001 2208 2360 -466 2 2 12 9 870 1866 1371 -467 2 2 12 9 1106 2968 1965 -468 2 2 12 9 512 1269 1789 -469 2 2 12 9 398 1219 1751 -470 2 2 12 9 854 1278 2163 -471 2 2 12 9 790 1447 1881 -472 2 2 12 9 632 1728 1256 -473 2 2 12 9 681 1648 3350 -474 2 2 12 9 1555 999 3206 -475 2 2 12 9 922 1684 1403 -476 2 2 12 9 1373 2841 1702 -477 2 2 12 9 620 1206 1838 -478 2 2 12 9 760 1574 1625 -479 2 2 12 9 761 1626 1575 -480 2 2 12 9 406 2883 1342 -481 2 2 12 9 434 1625 1574 -482 2 2 12 9 1064 1417 3047 -483 2 2 12 9 435 1575 1626 -484 2 2 12 9 439 1653 1516 -485 2 2 12 9 428 1684 1577 -486 2 2 12 9 563 1150 2324 -487 2 2 12 9 693 1394 3583 -488 2 2 12 9 3438 656 2109 -489 2 2 12 9 3608 2404 650 -490 2 2 12 9 3609 651 2405 -491 2 2 12 9 763 1516 1653 -492 2 2 12 9 1329 2768 2931 -493 2 2 12 9 662 1294 2804 -494 2 2 12 9 3576 1594 645 -495 2 2 12 9 1318 2266 3324 -496 2 2 12 9 1319 3325 2267 -497 2 2 12 9 997 2266 1710 -498 2 2 12 9 998 1711 2267 -499 2 2 12 9 3475 2050 1262 -500 2 2 12 9 966 1326 2777 -501 2 2 12 9 470 1221 2505 -502 2 2 12 9 930 2367 1966 -503 2 2 12 9 1304 3102 2077 -504 2 2 12 9 273 2059 2903 -505 2 2 12 9 572 2654 1241 -506 2 2 12 9 573 1242 2655 -507 2 2 12 9 477 1754 1557 -508 2 2 12 9 505 2723 1244 -509 2 2 12 9 1144 1417 2917 -510 2 2 12 9 722 3021 1630 -511 2 2 12 9 230 2076 1311 -512 2 2 12 9 639 1727 2257 -513 2 2 12 9 717 1209 1757 -514 2 2 12 9 434 2712 1200 -515 2 2 12 9 435 1201 2713 -516 2 2 12 9 1304 2020 3047 -517 2 2 12 9 387 2018 1758 -518 2 2 12 9 576 1237 1666 -519 2 2 12 9 3129 1504 696 -520 2 2 12 9 834 1691 1723 -521 2 2 12 9 689 1167 2364 -522 2 2 12 9 690 2365 1168 -523 2 2 12 9 424 1620 3003 -524 2 2 12 9 608 3168 1291 -525 2 2 12 9 3047 2020 1064 -526 2 2 12 9 1459 2754 2301 -527 2 2 12 9 1460 2302 2755 -528 2 2 12 9 900 2292 1225 -529 2 2 12 9 1215 3372 1336 -530 2 2 12 9 1103 3249 2205 -531 2 2 12 9 511 1827 1291 -532 2 2 12 9 1130 2388 2001 -533 2 2 12 9 1131 2002 2389 -534 2 2 12 9 358 1256 2624 -535 2 2 12 9 684 1763 2537 -536 2 2 12 9 1975 371 2605 -537 2 2 12 9 233 1232 1972 -538 2 2 12 9 2607 372 1976 -539 2 2 12 9 1804 2633 3375 -540 2 2 12 9 587 1212 1761 -541 2 2 12 9 588 1762 1213 -542 2 2 12 9 267 1917 2391 -543 2 2 12 9 834 1669 2027 -544 2 2 12 9 662 1330 1814 -545 2 2 12 9 837 2997 1282 -546 2 2 12 9 364 1400 1907 -547 2 2 12 9 646 1398 2065 -548 2 2 12 9 893 1909 1704 -549 2 2 12 9 894 1705 1911 -550 2 2 12 9 813 1769 1848 -551 2 2 12 9 1001 1688 2073 -552 2 2 12 9 447 1995 1713 -553 2 2 12 9 595 2264 1399 -554 2 2 12 9 506 1318 3324 -555 2 2 12 9 507 3325 1319 -556 2 2 12 9 788 2136 1155 -557 2 2 12 9 940 1532 2967 -558 2 2 12 9 793 2177 1258 -559 2 2 12 9 1181 2247 2259 -560 2 2 12 9 1003 2941 1332 -561 2 2 12 9 735 1785 3508 -562 2 2 12 9 361 3141 2074 -563 2 2 12 9 432 1700 1271 -564 2 2 12 9 433 1272 1701 -565 2 2 12 9 424 3003 2513 -566 2 2 12 9 697 1250 2575 -567 2 2 12 9 475 1861 2981 -568 2 2 12 9 476 2982 1862 -569 2 2 12 9 849 2919 1215 -570 2 2 12 9 542 1987 1162 -571 2 2 12 9 717 1531 3230 -572 2 2 12 9 444 1402 1815 -573 2 2 12 9 736 3509 1788 -574 2 2 12 9 353 2132 1979 -575 2 2 12 9 691 1702 2841 -576 2 2 12 9 624 1667 2304 -577 2 2 12 9 625 2305 1668 -578 2 2 12 9 620 1850 1206 -579 2 2 12 9 3080 1010 1919 -580 2 2 12 9 680 1280 2178 -581 2 2 12 9 1449 3642 2596 -582 2 2 12 9 617 1401 3625 -583 2 2 12 9 512 2049 1269 -584 2 2 12 9 1260 1975 2605 -585 2 2 12 9 1261 2607 1976 -586 2 2 12 9 445 1199 1937 -587 2 2 12 9 675 1693 1316 -588 2 2 12 9 867 1396 2342 -589 2 2 12 9 778 2081 1203 -590 2 2 12 9 1074 1379 1879 -591 2 2 12 9 683 1736 3564 -592 2 2 12 9 1007 1327 2800 -593 2 2 12 9 1417 3210 3047 -594 2 2 12 9 556 1573 2293 -595 2 2 12 9 1357 1700 3033 -596 2 2 12 9 1358 3034 1701 -597 2 2 12 9 646 2065 2824 -598 2 2 12 9 633 2756 3418 -599 2 2 12 9 577 1676 2166 -600 2 2 12 9 1127 2751 1540 -601 2 2 12 9 553 1268 2580 -602 2 2 12 9 1228 2393 2856 -603 2 2 12 9 681 1451 2854 -604 2 2 12 9 1705 3094 2835 -605 2 2 12 9 1071 1463 2583 -606 2 2 12 9 722 1630 2131 -607 2 2 12 9 1206 1850 3203 -608 2 2 12 9 874 1285 2569 -609 2 2 12 9 1216 15 2283 -610 2 2 12 9 2099 1986 3029 -611 2 2 12 9 3580 412 2393 -612 2 2 12 9 695 3072 1349 -613 2 2 12 9 492 2182 1652 -614 2 2 12 9 773 1704 1909 -615 2 2 12 9 774 1911 1705 -616 2 2 12 9 425 2315 1350 -617 2 2 12 9 1413 3564 1736 -618 2 2 12 9 360 2108 2870 -619 2 2 12 9 725 1291 1827 -620 2 2 12 9 397 2081 1806 -621 2 2 12 9 398 2542 1431 -622 2 2 12 9 580 2363 1366 -623 2 2 12 9 668 1236 1703 -624 2 2 12 9 1098 2124 2008 -625 2 2 12 9 812 1994 1208 -626 2 2 12 9 647 1287 1725 -627 2 2 12 9 648 1726 1288 -628 2 2 12 9 538 1373 1702 -629 2 2 12 9 3504 698 2079 -630 2 2 12 9 737 1427 1519 -631 2 2 12 9 738 1520 1428 -632 2 2 12 9 367 1613 1956 -633 2 2 12 9 449 1193 3126 -634 2 2 12 9 829 1223 1900 -635 2 2 12 9 830 1901 1224 -636 2 2 12 9 754 2119 1222 -637 2 2 12 9 797 1592 1785 -638 2 2 12 9 551 2373 1857 -639 2 2 12 9 552 1858 2374 -640 2 2 12 9 223 224 1390 -641 2 2 12 9 464 1362 1819 -642 2 2 12 9 465 1820 1363 -643 2 2 12 9 1470 3438 2109 -644 2 2 12 9 742 1544 1479 -645 2 2 12 9 395 1214 2285 -646 2 2 12 9 686 1484 2989 -647 2 2 12 9 566 1176 2455 -648 2 2 12 9 438 2185 1305 -649 2 2 12 9 910 2416 1257 -650 2 2 12 9 1150 1979 2132 -651 2 2 12 9 741 2312 1190 -652 2 2 12 9 558 2777 1326 -653 2 2 12 9 898 2539 2348 -654 2 2 12 9 1092 2257 1727 -655 2 2 12 9 814 1342 1604 -656 2 2 12 9 523 2008 2124 -657 2 2 12 9 671 2751 2457 -658 2 2 12 9 1245 2849 2080 -659 2 2 12 9 308 1998 2357 -660 2 2 12 9 679 3062 1418 -661 2 2 12 9 1305 2185 2371 -662 2 2 12 9 966 2210 1326 -663 2 2 12 9 663 1435 1710 -664 2 2 12 9 664 1711 1436 -665 2 2 12 9 677 3581 3136 -666 2 2 12 9 199 2354 1783 -667 2 2 12 9 601 1494 2213 -668 2 2 12 9 602 2214 1495 -669 2 2 12 9 519 2001 2388 -670 2 2 12 9 520 2389 2002 -671 2 2 12 9 780 3009 1269 -672 2 2 12 9 715 1589 1422 -673 2 2 12 9 829 3462 1223 -674 2 2 12 9 830 1224 3463 -675 2 2 12 9 898 2348 1731 -676 2 2 12 9 799 1788 1595 -677 2 2 12 9 3102 1118 2077 -678 2 2 12 9 834 2027 2426 -679 2 2 12 9 557 1822 1251 -680 2 2 12 9 1523 1837 3627 -681 2 2 12 9 432 1271 2745 -682 2 2 12 9 433 2746 1272 -683 2 2 12 9 1205 2291 3276 -684 2 2 12 9 805 1311 2076 -685 2 2 12 9 730 1679 3154 -686 2 2 12 9 731 3155 1680 -687 2 2 12 9 38 39 1384 -688 2 2 12 9 182 183 1385 -689 2 2 12 9 1687 2527 2934 -690 2 2 12 9 770 1819 1217 -691 2 2 12 9 1818 3129 696 -692 2 2 12 9 473 1298 2570 -693 2 2 12 9 771 1218 1820 -694 2 2 12 9 456 3301 1544 -695 2 2 12 9 545 3333 1931 -696 2 2 12 9 359 2279 1448 -697 2 2 12 9 377 3057 1922 -698 2 2 12 9 633 3511 2756 -699 2 2 12 9 1074 3091 1379 -700 2 2 12 9 1518 2883 2912 -701 2 2 12 9 666 3461 2489 -702 2 2 12 9 662 2804 1453 -703 2 2 12 9 1045 2304 1667 -704 2 2 12 9 1046 1668 2305 -705 2 2 12 9 273 274 2059 -706 2 2 12 9 445 1486 3113 -707 2 2 12 9 1651 2998 2671 -708 2 2 12 9 357 2675 1243 -709 2 2 12 9 1463 3617 2583 -710 2 2 12 9 1179 2273 3081 -711 2 2 12 9 686 2989 1707 -712 2 2 12 9 1180 3082 2274 -713 2 2 12 9 832 1984 1321 -714 2 2 12 9 488 1310 2398 -715 2 2 12 9 1443 3508 1785 -716 2 2 12 9 447 1581 1995 -717 2 2 12 9 260 261 1843 -718 2 2 12 9 315 316 1844 -719 2 2 12 9 754 1222 2676 -720 2 2 12 9 513 2478 3079 -721 2 2 12 9 1009 1431 2542 -722 2 2 12 9 862 1374 2346 -723 2 2 12 9 1706 2726 2750 -724 2 2 12 9 1444 1788 3509 -725 2 2 12 9 529 1252 1985 -726 2 2 12 9 355 1892 1266 -727 2 2 12 9 783 2117 2011 -728 2 2 12 9 356 1267 1893 -729 2 2 12 9 784 2012 2118 -730 2 2 12 9 787 1177 2194 -731 2 2 12 9 617 3625 1471 -732 2 2 12 9 568 1238 2178 -733 2 2 12 9 1313 1547 3309 -734 2 2 12 9 1132 2168 3399 -735 2 2 12 9 1314 3310 1548 -736 2 2 12 9 878 2353 2585 -737 2 2 12 9 1262 2064 2695 -738 2 2 12 9 398 2534 1219 -739 2 2 12 9 741 1190 1938 -740 2 2 12 9 605 1386 1674 -741 2 2 12 9 1211 1931 3333 -742 2 2 12 9 449 1756 1316 -743 2 2 12 9 439 1211 3138 -744 2 2 12 9 756 3279 1197 -745 2 2 12 9 757 1198 3280 -746 2 2 12 9 387 1505 2018 -747 2 2 12 9 360 3538 2108 -748 2 2 12 9 759 1247 2067 -749 2 2 12 9 350 1278 3409 -750 2 2 12 9 933 2624 1256 -751 2 2 12 9 464 1819 1796 -752 2 2 12 9 465 1797 1820 -753 2 2 12 9 425 1350 1677 -754 2 2 12 9 423 1989 1590 -755 2 2 12 9 357 1186 2228 -756 2 2 12 9 530 1396 2232 -757 2 2 12 9 1532 1715 2967 -758 2 2 12 9 894 3094 1705 -759 2 2 12 9 1025 2166 1676 -760 2 2 12 9 446 1365 2087 -761 2 2 12 9 1324 1888 3327 -762 2 2 12 9 1325 3328 1889 -763 2 2 12 9 1627 2402 2957 -764 2 2 12 9 636 1552 1880 -765 2 2 12 9 650 2025 3608 -766 2 2 12 9 651 3609 2026 -767 2 2 12 9 637 1568 3353 -768 2 2 12 9 1200 1857 2373 -769 2 2 12 9 1201 2374 1858 -770 2 2 12 9 636 1347 1746 -771 2 2 12 9 817 1969 1644 -772 2 2 12 9 2544 730 3154 -773 2 2 12 9 2545 3155 731 -774 2 2 12 9 859 1399 2264 -775 2 2 12 9 587 2103 1212 -776 2 2 12 9 588 1213 2104 -777 2 2 12 9 1002 1652 2182 -778 2 2 12 9 434 1615 1565 -779 2 2 12 9 435 1566 1616 -780 2 2 12 9 799 1525 2467 -781 2 2 12 9 1157 1843 2731 -782 2 2 12 9 1158 2732 1844 -783 2 2 12 9 467 2303 1361 -784 2 2 12 9 618 2899 1307 -785 2 2 12 9 1029 1806 2081 -786 2 2 12 9 899 1957 1754 -787 2 2 12 9 1573 2643 2293 -788 2 2 12 9 1003 1332 3268 -789 2 2 12 9 1001 1380 2208 -790 2 2 12 9 628 2795 1991 -791 2 2 12 9 649 1210 2425 -792 2 2 12 9 3134 447 1713 -793 2 2 12 9 364 1303 3166 -794 2 2 12 9 400 2625 1863 -795 2 2 12 9 338 1410 3326 -796 2 2 12 9 781 1866 1923 -797 2 2 12 9 908 1298 1758 -798 2 2 12 9 671 1540 2751 -799 2 2 12 9 672 1571 1617 -800 2 2 12 9 1483 2369 2736 -801 2 2 12 9 506 3045 1318 -802 2 2 12 9 507 1319 3046 -803 2 2 12 9 1148 1432 3195 -804 2 2 12 9 449 3123 1193 -805 2 2 12 9 743 1937 1199 -806 2 2 12 9 1043 1941 2110 -807 2 2 12 9 361 2074 2967 -808 2 2 12 9 1044 2111 1942 -809 2 2 12 9 618 3456 1453 -810 2 2 12 9 867 2232 1396 -811 2 2 12 9 431 1187 2236 -812 2 2 12 9 904 2213 1494 -813 2 2 12 9 905 1495 2214 -814 2 2 12 9 379 1567 1535 -815 2 2 12 9 401 2312 1231 -816 2 2 12 9 780 1269 2049 -817 2 2 12 9 632 1256 2035 -818 2 2 12 9 536 1865 2802 -819 2 2 12 9 309 2392 1998 -820 2 2 12 9 1133 1472 2991 -821 2 2 12 9 391 1404 2353 -822 2 2 12 9 1134 2992 1473 -823 2 2 12 9 908 2570 1298 -824 2 2 12 9 1579 2562 3526 -825 2 2 12 9 513 3079 1513 -826 2 2 12 9 481 1802 1609 -827 2 2 12 9 482 1610 1803 -828 2 2 12 9 505 2562 1579 -829 2 2 12 9 340 2578 1270 -830 2 2 12 9 440 2113 1282 -831 2 2 12 9 355 1266 2245 -832 2 2 12 9 356 2246 1267 -833 2 2 12 9 825 1434 2154 -834 2 2 12 9 709 2715 1422 -835 2 2 12 9 1178 3208 1602 -836 2 2 12 9 23 24 1720 -837 2 2 12 9 1367 2330 3197 -838 2 2 12 9 3298 572 1241 -839 2 2 12 9 1368 3198 2331 -840 2 2 12 9 3300 1242 573 -841 2 2 12 9 756 1197 2245 -842 2 2 12 9 757 2246 1198 -843 2 2 12 9 729 1264 2175 -844 2 2 12 9 756 3327 1888 -845 2 2 12 9 757 1889 3328 -846 2 2 12 9 381 2569 1285 -847 2 2 12 9 453 1251 2628 -848 2 2 12 9 344 1785 1592 -849 2 2 12 9 657 2546 1795 -850 2 2 12 9 875 2398 1310 -851 2 2 12 9 772 1754 1957 -852 2 2 12 9 339 2882 3013 -853 2 2 12 9 1235 2757 1691 -854 2 2 12 9 226 227 1682 -855 2 2 12 9 1299 3036 1977 -856 2 2 12 9 1300 1978 3037 -857 2 2 12 9 450 1222 2119 -858 2 2 12 9 2954 15 1216 -859 2 2 12 9 553 2733 1268 -860 2 2 12 9 737 1519 1636 -861 2 2 12 9 738 1637 1520 -862 2 2 12 9 26 27 1423 -863 2 2 12 9 2125 2417 376 -864 2 2 12 9 426 1560 1459 -865 2 2 12 9 427 1460 1561 -866 2 2 12 9 1332 2941 3256 -867 2 2 12 9 754 1545 1781 -868 2 2 12 9 652 1497 1522 -869 2 2 12 9 900 1225 2837 -870 2 2 12 9 787 2030 3573 -871 2 2 12 9 456 2575 1250 -872 2 2 12 9 500 2715 1965 -873 2 2 12 9 382 2158 1630 -874 2 2 12 9 2951 1922 1695 -875 2 2 12 9 766 2080 2849 -876 2 2 12 9 1096 2802 1865 -877 2 2 12 9 367 1956 1605 -878 2 2 12 9 456 3383 2933 -879 2 2 12 9 423 1369 2576 -880 2 2 12 9 925 2486 1407 -881 2 2 12 9 926 1408 2487 -882 2 2 12 9 770 1217 2875 -883 2 2 12 9 771 2876 1218 -884 2 2 12 9 781 1923 1425 -885 2 2 12 9 705 2818 1884 -886 2 2 12 9 626 1371 2175 -887 2 2 12 9 706 1885 2819 -888 2 2 12 9 449 1316 1826 -889 2 2 12 9 529 1639 3376 -890 2 2 12 9 598 1379 3091 -891 2 2 12 9 1161 1930 2488 -892 2 2 12 9 400 1934 2625 -893 2 2 12 9 358 3470 1256 -894 2 2 12 9 345 1595 1788 -895 2 2 12 9 439 2061 1211 -896 2 2 12 9 440 1282 3255 -897 2 2 12 9 1286 2825 2204 -898 2 2 12 9 344 1443 1785 -899 2 2 12 9 770 1345 1796 -900 2 2 12 9 3159 417 2268 -901 2 2 12 9 771 1797 1346 -902 2 2 12 9 1290 2820 1987 -903 2 2 12 9 406 1342 2144 -904 2 2 12 9 875 1310 2470 -905 2 2 12 9 3016 1897 943 -906 2 2 12 9 3017 944 1898 -907 2 2 12 9 650 2404 2677 -908 2 2 12 9 651 2678 2405 -909 2 2 12 9 788 3495 2031 -910 2 2 12 9 446 2087 1418 -911 2 2 12 9 407 1999 3001 -912 2 2 12 9 533 1631 2705 -913 2 2 12 9 694 2829 1265 -914 2 2 12 9 345 1788 1444 -915 2 2 12 9 387 2603 1505 -916 2 2 12 9 2615 235 1852 -917 2 2 12 9 343 2006 1345 -918 2 2 12 9 342 1346 2007 -919 2 2 12 9 1313 3309 3508 -920 2 2 12 9 1314 3509 3310 -921 2 2 12 9 2402 599 2957 -922 2 2 12 9 405 3047 3210 -923 2 2 12 9 450 2327 1619 -924 2 2 12 9 793 1258 2168 -925 2 2 12 9 755 1985 1252 -926 2 2 12 9 1182 3441 1536 -927 2 2 12 9 1910 2851 2706 -928 2 2 12 9 1175 2684 2254 -929 2 2 12 9 618 1453 3615 -930 2 2 12 9 662 3539 1294 -931 2 2 12 9 470 1255 2683 -932 2 2 12 9 616 1425 1923 -933 2 2 12 9 354 2413 2412 -934 2 2 12 9 198 199 1783 -935 2 2 12 9 251 1854 2275 -936 2 2 12 9 325 2276 1855 -937 2 2 12 9 1190 1795 2546 -938 2 2 12 9 2292 3408 1225 -939 2 2 12 9 388 1195 2250 -940 2 2 12 9 705 1734 2818 -941 2 2 12 9 706 2819 1735 -942 2 2 12 9 438 1305 2193 -943 2 2 12 9 191 192 1432 -944 2 2 12 9 812 1208 2093 -945 2 2 12 9 2362 961 3111 -946 2 2 12 9 1399 3408 2292 -947 2 2 12 9 1024 2883 1518 -948 2 2 12 9 463 1517 2602 -949 2 2 12 9 748 1487 2236 -950 2 2 12 9 705 1824 1367 -951 2 2 12 9 706 1368 1825 -952 2 2 12 9 3099 1018 1815 -953 2 2 12 9 1171 2606 2975 -954 2 2 12 9 755 1341 1983 -955 2 2 12 9 557 2462 1204 -956 2 2 12 9 352 2991 1472 -957 2 2 12 9 351 1473 2992 -958 2 2 12 9 827 2182 1370 -959 2 2 12 9 627 3195 1432 -960 2 2 12 9 3036 710 1977 -961 2 2 12 9 3037 1978 711 -962 2 2 12 9 457 1215 3316 -963 2 2 12 9 224 2291 1390 -964 2 2 12 9 417 3159 1454 -965 2 2 12 9 365 1554 2659 -966 2 2 12 9 605 2941 1276 -967 2 2 12 9 982 2793 1553 -968 2 2 12 9 988 2126 2169 -969 2 2 12 9 989 2170 2127 -970 2 2 12 9 606 1882 1244 -971 2 2 12 9 1380 3134 1713 -972 2 2 12 9 916 2951 1695 -973 2 2 12 9 705 1367 1734 -974 2 2 12 9 706 1735 1368 -975 2 2 12 9 823 2122 1391 -976 2 2 12 9 824 1392 2123 -977 2 2 12 9 593 1793 2942 -978 2 2 12 9 568 2368 1238 -979 2 2 12 9 594 2943 1794 -980 2 2 12 9 584 1311 2263 -981 2 2 12 9 746 1259 2955 -982 2 2 12 9 976 1526 2188 -983 2 2 12 9 381 1285 2494 -984 2 2 12 9 483 2384 2915 -985 2 2 12 9 942 1630 2158 -986 2 2 12 9 647 2023 1287 -987 2 2 12 9 648 1288 2024 -988 2 2 12 9 446 2369 1483 -989 2 2 12 9 1330 1453 3456 -990 2 2 12 9 896 1845 1770 -991 2 2 12 9 1208 2063 2805 -992 2 2 12 9 1536 3441 2907 -993 2 2 12 9 729 2439 1264 -994 2 2 12 9 391 1374 2491 -995 2 2 12 9 274 275 2212 -996 2 2 12 9 666 1364 3242 -997 2 2 12 9 250 251 2275 -998 2 2 12 9 325 326 2276 -999 2 2 12 9 714 2726 1706 -1000 2 2 12 9 373 2110 1941 -1001 2 2 12 9 374 1942 2111 -1002 2 2 12 9 537 1683 1461 -1003 2 2 12 9 450 2531 1932 -1004 2 2 12 9 1553 2793 3071 -1005 2 2 12 9 741 1938 1352 -1006 2 2 12 9 800 2371 2185 -1007 2 2 12 9 670 1372 1815 -1008 2 2 12 9 1235 2973 2757 -1009 2 2 12 9 703 2953 1506 -1010 2 2 12 9 403 2557 1287 -1011 2 2 12 9 404 1288 2558 -1012 2 2 12 9 925 1407 2464 -1013 2 2 12 9 926 2465 1408 -1014 2 2 12 9 748 3068 1351 -1015 2 2 12 9 474 2029 1731 -1016 2 2 12 9 578 3087 2202 -1017 2 2 12 9 801 1305 1840 -1018 2 2 12 9 579 2203 3088 -1019 2 2 12 9 2841 1992 921 -1020 2 2 12 9 458 2364 1481 -1021 2 2 12 9 459 1482 2365 -1022 2 2 12 9 546 2255 1271 -1023 2 2 12 9 547 1272 2256 -1024 2 2 12 9 1427 1897 3016 -1025 2 2 12 9 413 3175 1375 -1026 2 2 12 9 1428 3017 1898 -1027 2 2 12 9 645 1990 1375 -1028 2 2 12 9 668 2523 1236 -1029 2 2 12 9 741 1231 2312 -1030 2 2 12 9 472 1347 2861 -1031 2 2 12 9 1179 3369 2273 -1032 2 2 12 9 1180 2274 3370 -1033 2 2 12 9 3253 1757 463 -1034 2 2 12 9 778 1203 2207 -1035 2 2 12 9 1270 3247 2593 -1036 2 2 12 9 836 2928 1480 -1037 2 2 12 9 765 1670 1352 -1038 2 2 12 9 640 1602 3208 -1039 2 2 12 9 1336 2417 2125 -1040 2 2 12 9 597 3289 1361 -1041 2 2 12 9 927 1716 1980 -1042 2 2 12 9 928 1981 1717 -1043 2 2 12 9 1099 1329 2931 -1044 2 2 12 9 456 1739 3383 -1045 2 2 12 9 441 2488 1930 -1046 2 2 12 9 395 1747 1745 -1047 2 2 12 9 388 2177 1195 -1048 2 2 12 9 419 1870 1359 -1049 2 2 12 9 403 2464 1407 -1050 2 2 12 9 404 1408 2465 -1051 2 2 12 9 472 2394 1347 -1052 2 2 12 9 511 1291 2090 -1053 2 2 12 9 624 1391 2122 -1054 2 2 12 9 695 2429 1258 -1055 2 2 12 9 625 2123 1392 -1056 2 2 12 9 580 1903 1339 -1057 2 2 12 9 677 1307 2899 -1058 2 2 12 9 605 3256 2941 -1059 2 2 12 9 268 2311 1917 -1060 2 2 12 9 1480 2928 1706 -1061 2 2 12 9 458 1508 2364 -1062 2 2 12 9 459 2365 1509 -1063 2 2 12 9 1111 2412 2413 -1064 2 2 12 9 525 2336 1793 -1065 2 2 12 9 526 1794 2337 -1066 2 2 12 9 1876 2722 2799 -1067 2 2 12 9 417 1454 3039 -1068 2 2 12 9 354 1814 1330 -1069 2 2 12 9 903 2071 1713 -1070 2 2 12 9 691 1692 1702 -1071 2 2 12 9 359 1784 2279 -1072 2 2 12 9 840 2101 1439 -1073 2 2 12 9 841 1440 2102 -1074 2 2 12 9 623 2888 1342 -1075 2 2 12 9 274 2212 2059 -1076 2 2 12 9 365 2298 1333 -1077 2 2 12 9 1327 3286 2800 -1078 2 2 12 9 805 2263 1311 -1079 2 2 12 9 829 1609 1802 -1080 2 2 12 9 830 1803 1610 -1081 2 2 12 9 977 2562 1835 -1082 2 2 12 9 408 1439 2101 -1083 2 2 12 9 409 2102 1440 -1084 2 2 12 9 1052 1712 2428 -1085 2 2 12 9 386 2154 1434 -1086 2 2 12 9 488 1918 1310 -1087 2 2 12 9 766 1933 2080 -1088 2 2 12 9 885 2387 1414 -1089 2 2 12 9 1958 3146 2879 -1090 2 2 12 9 432 2745 3118 -1091 2 2 12 9 433 3119 2746 -1092 2 2 12 9 399 1850 2456 -1093 2 2 12 9 747 1567 1772 -1094 2 2 12 9 1402 3099 1815 -1095 2 2 12 9 1102 2671 2998 -1096 2 2 12 9 234 235 2615 -1097 2 2 12 9 685 1410 1690 -1098 2 2 12 9 1437 3608 2025 -1099 2 2 12 9 801 2193 1305 -1100 2 2 12 9 1438 2026 3609 -1101 2 2 12 9 975 1765 2513 -1102 2 2 12 9 739 3608 1437 -1103 2 2 12 9 739 1636 1519 -1104 2 2 12 9 423 2014 1289 -1105 2 2 12 9 892 1353 2498 -1106 2 2 12 9 740 1438 3609 -1107 2 2 12 9 740 1520 1637 -1108 2 2 12 9 3384 1955 1782 -1109 2 2 12 9 764 1617 1571 -1110 2 2 12 9 747 1535 1567 -1111 2 2 12 9 874 2085 1285 -1112 2 2 12 9 1100 1793 2336 -1113 2 2 12 9 973 2011 2117 -1114 2 2 12 9 1101 2337 1794 -1115 2 2 12 9 974 2118 2012 -1116 2 2 12 9 832 1321 2390 -1117 2 2 12 9 874 2569 1347 -1118 2 2 12 9 819 3457 1259 -1119 2 2 12 9 3460 958 1285 -1120 2 2 12 9 398 1751 1760 -1121 2 2 12 9 536 2020 1304 -1122 2 2 12 9 915 1694 1921 -1123 2 2 12 9 593 1407 2486 -1124 2 2 12 9 594 2487 1408 -1125 2 2 12 9 759 2620 1247 -1126 2 2 12 9 1172 2949 1651 -1127 2 2 12 9 918 1945 1895 -1128 2 2 12 9 560 2563 1518 -1129 2 2 12 9 919 1896 1946 -1130 2 2 12 9 375 1781 1545 -1131 2 2 12 9 542 2027 1374 -1132 2 2 12 9 1169 2705 1631 -1133 2 2 12 9 732 3453 1372 -1134 2 2 12 9 364 3166 1400 -1135 2 2 12 9 685 1859 1631 -1136 2 2 12 9 873 1255 2505 -1137 2 2 12 9 726 1380 1713 -1138 2 2 12 9 8 9 1464 -1139 2 2 12 9 1183 2828 3055 -1140 2 2 12 9 791 2112 2807 -1141 2 2 12 9 470 2505 1255 -1142 2 2 12 9 592 3633 1449 -1143 2 2 12 9 844 1963 2621 -1144 2 2 12 9 1784 3405 2896 -1145 2 2 12 9 770 1884 1345 -1146 2 2 12 9 1165 3353 1568 -1147 2 2 12 9 722 1618 1653 -1148 2 2 12 9 771 1346 1885 -1149 2 2 12 9 799 2467 2038 -1150 2 2 12 9 957 1805 2053 -1151 2 2 12 9 430 1480 1706 -1152 2 2 12 9 527 2508 2033 -1153 2 2 12 9 528 2034 2509 -1154 2 2 12 9 814 1348 3040 -1155 2 2 12 9 454 1367 1824 -1156 2 2 12 9 455 1825 1368 -1157 2 2 12 9 449 1826 1371 -1158 2 2 12 9 576 2269 1237 -1159 2 2 12 9 483 2915 1909 -1160 2 2 12 9 980 2934 2527 -1161 2 2 12 9 231 232 1500 -1162 2 2 12 9 645 1375 1771 -1163 2 2 12 9 2330 727 3197 -1164 2 2 12 9 3198 728 2331 -1165 2 2 12 9 674 1243 3631 -1166 2 2 12 9 692 1611 2227 -1167 2 2 12 9 699 1784 2896 -1168 2 2 12 9 1276 1932 2531 -1169 2 2 12 9 703 1738 2953 -1170 2 2 12 9 847 1857 1565 -1171 2 2 12 9 848 1566 1858 -1172 2 2 12 9 1462 1714 2406 -1173 2 2 12 9 434 3287 1625 -1174 2 2 12 9 435 1626 3288 -1175 2 2 12 9 1435 3565 2600 -1176 2 2 12 9 1436 2601 3566 -1177 2 2 12 9 810 1390 2291 -1178 2 2 12 9 1570 3415 3333 -1179 2 2 12 9 834 1723 1669 -1180 2 2 12 9 739 1502 3608 -1181 2 2 12 9 740 3609 1503 -1182 2 2 12 9 813 1848 1614 -1183 2 2 12 9 3277 777 1954 -1184 2 2 12 9 696 1433 1712 -1185 2 2 12 9 475 3121 1861 -1186 2 2 12 9 476 1862 3122 -1187 2 2 12 9 700 2171 1590 -1188 2 2 12 9 3274 1952 776 -1189 2 2 12 9 842 1470 2109 -1190 2 2 12 9 692 2227 1678 -1191 2 2 12 9 1138 2087 3235 -1192 2 2 12 9 196 197 1580 -1193 2 2 12 9 958 2726 1285 -1194 2 2 12 9 258 1868 1322 -1195 2 2 12 9 318 1323 1869 -1196 2 2 12 9 1373 1992 2841 -1197 2 2 12 9 874 1347 2394 -1198 2 2 12 9 431 1487 3230 -1199 2 2 12 9 534 1452 1686 -1200 2 2 12 9 917 2769 1467 -1201 2 2 12 9 747 1848 1769 -1202 2 2 12 9 901 1873 1541 -1203 2 2 12 9 902 1542 1874 -1204 2 2 12 9 1051 1484 1791 -1205 2 2 12 9 794 2053 1805 -1206 2 2 12 9 744 1565 1615 -1207 2 2 12 9 745 1616 1566 -1208 2 2 12 9 746 1810 2602 -1209 2 2 12 9 741 2008 1231 -1210 2 2 12 9 1395 3289 3521 -1211 2 2 12 9 945 2681 1423 -1212 2 2 12 9 1116 2659 1554 -1213 2 2 12 9 819 1259 3648 -1214 2 2 12 9 729 1826 1316 -1215 2 2 12 9 622 1478 2370 -1216 2 2 12 9 748 1351 2846 -1217 2 2 12 9 755 1252 2343 -1218 2 2 12 9 1810 3253 463 -1219 2 2 12 9 773 1864 1496 -1220 2 2 12 9 350 2390 1321 -1221 2 2 12 9 481 2325 2629 -1222 2 2 12 9 482 2630 2326 -1223 2 2 12 9 549 3191 1524 -1224 2 2 12 9 694 1956 1764 -1225 2 2 12 9 45 46 1465 -1226 2 2 12 9 175 176 1466 -1227 2 2 12 9 557 1251 3030 -1228 2 2 12 9 792 2125 2735 -1229 2 2 12 9 645 3507 1990 -1230 2 2 12 9 473 2844 1298 -1231 2 2 12 9 797 2836 1524 -1232 2 2 12 9 536 1304 2077 -1233 2 2 12 9 1184 3001 1999 -1234 2 2 12 9 386 1644 1969 -1235 2 2 12 9 1041 2080 1933 -1236 2 2 12 9 923 2600 3565 -1237 2 2 12 9 924 3566 2601 -1238 2 2 12 9 485 1770 1845 -1239 2 2 12 9 1051 2932 1484 -1240 2 2 12 9 407 2646 1999 -1241 2 2 12 9 849 1286 2456 -1242 2 2 12 9 1342 2883 1604 -1243 2 2 12 9 1410 1949 3326 -1244 2 2 12 9 1070 3362 1355 -1245 2 2 12 9 967 1329 2307 -1246 2 2 12 9 379 1535 2438 -1247 2 2 12 9 377 1828 2524 -1248 2 2 12 9 800 2018 1505 -1249 2 2 12 9 450 1932 2327 -1250 2 2 12 9 236 1736 2827 -1251 2 2 12 9 698 1852 2396 -1252 2 2 12 9 3039 1918 991 -1253 2 2 12 9 768 2557 1407 -1254 2 2 12 9 769 1408 2558 -1255 2 2 12 9 597 3521 3289 -1256 2 2 12 9 26 1423 1834 -1257 2 2 12 9 1058 1448 2226 -1258 2 2 12 9 721 1489 3242 -1259 2 2 12 9 921 1764 1956 -1260 2 2 12 9 23 1720 2694 -1261 2 2 12 9 864 2423 1485 -1262 2 2 12 9 689 1508 3309 -1263 2 2 12 9 690 3310 1509 -1264 2 2 12 9 863 2072 1614 -1265 2 2 12 9 543 1708 2440 -1266 2 2 12 9 439 3248 2061 -1267 2 2 12 9 544 2441 1709 -1268 2 2 12 9 569 1840 1305 -1269 2 2 12 9 497 2443 1759 -1270 2 2 12 9 343 1895 1945 -1271 2 2 12 9 406 1562 2370 -1272 2 2 12 9 342 1946 1896 -1273 2 2 12 9 736 1788 1732 -1274 2 2 12 9 599 1792 2957 -1275 2 2 12 9 497 2604 2443 -1276 2 2 12 9 3111 961 1578 -1277 2 2 12 9 843 1745 1747 -1278 2 2 12 9 1450 3159 2268 -1279 2 2 12 9 863 2158 2072 -1280 2 2 12 9 1370 2182 3498 -1281 2 2 12 9 956 2512 1514 -1282 2 2 12 9 381 2494 1382 -1283 2 2 12 9 713 1646 2068 -1284 2 2 12 9 839 2422 2475 -1285 2 2 12 9 546 1271 2215 -1286 2 2 12 9 547 2216 1272 -1287 2 2 12 9 399 1496 1864 -1288 2 2 12 9 654 2057 1696 -1289 2 2 12 9 655 1697 2058 -1290 2 2 12 9 852 1419 2281 -1291 2 2 12 9 853 2282 1420 -1292 2 2 12 9 702 2996 1723 -1293 2 2 12 9 956 1514 2260 -1294 2 2 12 9 735 1718 1785 -1295 2 2 12 9 1069 1596 2616 -1296 2 2 12 9 1682 3628 3187 -1297 2 2 12 9 660 1651 2949 -1298 2 2 12 9 1696 2057 2792 -1299 2 2 12 9 592 1441 1908 -1300 2 2 12 9 1697 2794 2058 -1301 2 2 12 9 389 2616 1596 -1302 2 2 12 9 233 234 2615 -1303 2 2 12 9 1049 3343 1446 -1304 2 2 12 9 796 1702 1692 -1305 2 2 12 9 1284 3013 2882 -1306 2 2 12 9 580 2772 2865 -1307 2 2 12 9 266 267 2391 -1308 2 2 12 9 309 310 2392 -1309 2 2 12 9 1014 2757 2973 -1310 2 2 12 9 1366 2363 3586 -1311 2 2 12 9 733 1550 2172 -1312 2 2 12 9 48 49 1598 -1313 2 2 12 9 172 173 1599 -1314 2 2 12 9 734 2173 1551 -1315 2 2 12 9 449 1371 1866 -1316 2 2 12 9 842 2805 2063 -1317 2 2 12 9 689 3309 1547 -1318 2 2 12 9 500 1974 1422 -1319 2 2 12 9 690 1548 3310 -1320 2 2 12 9 833 3384 1782 -1321 2 2 12 9 1216 2790 1931 -1322 2 2 12 9 269 270 1521 -1323 2 2 12 9 43 1533 1800 -1324 2 2 12 9 178 1801 1534 -1325 2 2 12 9 806 1890 1622 -1326 2 2 12 9 807 1623 1891 -1327 2 2 12 9 735 1508 1718 -1328 2 2 12 9 1517 3275 2602 -1329 2 2 12 9 1174 2524 1828 -1330 2 2 12 9 1475 2218 3438 -1331 2 2 12 9 976 2188 2518 -1332 2 2 12 9 481 2629 1802 -1333 2 2 12 9 482 1803 2630 -1334 2 2 12 9 736 1732 1509 -1335 2 2 12 9 726 1713 2071 -1336 2 2 12 9 368 2430 1395 -1337 2 2 12 9 986 1766 2082 -1338 2 2 12 9 646 3486 1398 -1339 2 2 12 9 987 2083 1767 -1340 2 2 12 9 451 1313 2434 -1341 2 2 12 9 732 1372 3264 -1342 2 2 12 9 452 2435 1314 -1343 2 2 12 9 584 2848 1311 -1344 2 2 12 9 3438 2218 656 -1345 2 2 12 9 570 2209 1275 -1346 2 2 12 9 709 3382 2715 -1347 2 2 12 9 915 1921 2417 -1348 2 2 12 9 702 1691 2757 -1349 2 2 12 9 1222 1619 3347 -1350 2 2 12 9 1205 1682 3187 -1351 2 2 12 9 43 44 1533 -1352 2 2 12 9 177 178 1534 -1353 2 2 12 9 453 2205 1251 -1354 2 2 12 9 1171 1739 2606 -1355 2 2 12 9 447 2073 1356 -1356 2 2 12 9 600 1886 1442 -1357 2 2 12 9 3560 2225 1006 -1358 2 2 12 9 392 1829 1419 -1359 2 2 12 9 393 1420 1830 -1360 2 2 12 9 1011 1452 2908 -1361 2 2 12 9 698 1689 2079 -1362 2 2 12 9 1334 3136 3581 -1363 2 2 12 9 653 1514 2512 -1364 2 2 12 9 845 1760 1751 -1365 2 2 12 9 797 2504 2836 -1366 2 2 12 9 845 1842 1760 -1367 2 2 12 9 1007 2880 1327 -1368 2 2 12 9 1406 2061 3248 -1369 2 2 12 9 750 2221 1829 -1370 2 2 12 9 751 1830 2222 -1371 2 2 12 9 1246 2865 2772 -1372 2 2 12 9 1138 1454 3159 -1373 2 2 12 9 583 2233 1317 -1374 2 2 12 9 767 1811 1960 -1375 2 2 12 9 509 2428 1712 -1376 2 2 12 9 522 2536 2348 -1377 2 2 12 9 721 3242 3112 -1378 2 2 12 9 746 2602 2658 -1379 2 2 12 9 1010 1876 2799 -1380 2 2 12 9 895 1359 2460 -1381 2 2 12 9 768 1407 2375 -1382 2 2 12 9 769 2376 1408 -1383 2 2 12 9 1024 1518 2563 -1384 2 2 12 9 496 1532 2380 -1385 2 2 12 9 598 1837 1379 -1386 2 2 12 9 795 1374 2027 -1387 2 2 12 9 458 1718 1508 -1388 2 2 12 9 1240 2896 2258 -1389 2 2 12 9 1186 2913 1638 -1390 2 2 12 9 590 2931 2768 -1391 2 2 12 9 1059 1506 2959 -1392 2 2 12 9 622 2370 1562 -1393 2 2 12 9 448 1764 1992 -1394 2 2 12 9 565 3055 2828 -1395 2 2 12 9 716 1860 1456 -1396 2 2 12 9 402 2527 1687 -1397 2 2 12 9 746 2098 1259 -1398 2 2 12 9 541 1926 2633 -1399 2 2 12 9 921 1992 1764 -1400 2 2 12 9 859 1894 1328 -1401 2 2 12 9 1715 2962 2730 -1402 2 2 12 9 469 1669 1723 -1403 2 2 12 9 459 1509 1732 -1404 2 2 12 9 933 1256 2463 -1405 2 2 12 9 680 2178 1612 -1406 2 2 12 9 1765 3367 2513 -1407 2 2 12 9 686 2307 1569 -1408 2 2 12 9 782 2147 1887 -1409 2 2 12 9 779 1356 2073 -1410 2 2 12 9 1501 1990 3507 -1411 2 2 12 9 1577 1684 3264 -1412 2 2 12 9 697 2279 1250 -1413 2 2 12 9 1209 3230 1487 -1414 2 2 12 9 694 1312 3204 -1415 2 2 12 9 1294 3539 2339 -1416 2 2 12 9 612 1423 2681 -1417 2 2 12 9 425 3469 2747 -1418 2 2 12 9 349 2005 1378 -1419 2 2 12 9 971 1429 2787 -1420 2 2 12 9 1447 3053 1881 -1421 2 2 12 9 610 1481 3258 -1422 2 2 12 9 611 3259 1482 -1423 2 2 12 9 210 2065 1398 -1424 2 2 12 9 1056 1419 1829 -1425 2 2 12 9 1214 1524 3191 -1426 2 2 12 9 1057 1830 1420 -1427 2 2 12 9 642 3362 2254 -1428 2 2 12 9 1491 2225 3560 -1429 2 2 12 9 533 2360 2208 -1430 2 2 12 9 725 1760 1842 -1431 2 2 12 9 889 1430 2191 -1432 2 2 12 9 749 1910 2954 -1433 2 2 12 9 712 1755 2535 -1434 2 2 12 9 306 307 1703 -1435 2 2 12 9 413 1375 3027 -1436 2 2 12 9 301 302 2381 -1437 2 2 12 9 339 3013 1589 -1438 2 2 12 9 1112 2735 2125 -1439 2 2 12 9 860 2377 1415 -1440 2 2 12 9 861 1416 2378 -1441 2 2 12 9 580 1366 2772 -1442 2 2 12 9 732 1488 3453 -1443 2 2 12 9 763 1653 1618 -1444 2 2 12 9 1088 2440 1708 -1445 2 2 12 9 1174 2421 3272 -1446 2 2 12 9 1089 1709 2441 -1447 2 2 12 9 1010 2244 1919 -1448 2 2 12 9 904 1904 1888 -1449 2 2 12 9 905 1889 1905 -1450 2 2 12 9 1454 1918 3039 -1451 2 2 12 9 522 1833 2536 -1452 2 2 12 9 1278 2517 2091 -1453 2 2 12 9 768 1287 2557 -1454 2 2 12 9 769 2558 1288 -1455 2 2 12 9 1257 3470 2714 -1456 2 2 12 9 1365 3235 2087 -1457 2 2 12 9 770 1796 1819 -1458 2 2 12 9 1185 1689 2963 -1459 2 2 12 9 771 1820 1797 -1460 2 2 12 9 713 2068 2966 -1461 2 2 12 9 375 1545 1894 -1462 2 2 12 9 657 1467 1730 -1463 2 2 12 9 642 1293 2183 -1464 2 2 12 9 929 2801 1851 -1465 2 2 12 9 440 3255 1539 -1466 2 2 12 9 2115 777 3277 -1467 2 2 12 9 729 1316 2549 -1468 2 2 12 9 2114 3274 776 -1469 2 2 12 9 756 1888 1904 -1470 2 2 12 9 425 2773 2315 -1471 2 2 12 9 757 1905 1889 -1472 2 2 12 9 212 213 1643 -1473 2 2 12 9 3265 674 1995 -1474 2 2 12 9 1006 2187 2264 -1475 2 2 12 9 765 1352 3536 -1476 2 2 12 9 1113 2902 2970 -1477 2 2 12 9 749 2851 1910 -1478 2 2 12 9 196 1580 3299 -1479 2 2 12 9 669 1276 3434 -1480 2 2 12 9 869 1752 1912 -1481 2 2 12 9 1070 1355 3027 -1482 2 2 12 9 695 1381 2429 -1483 2 2 12 9 1088 2929 2094 -1484 2 2 12 9 1089 2095 2930 -1485 2 2 12 9 791 2807 1962 -1486 2 2 12 9 1042 1913 2863 -1487 2 2 12 9 1371 1826 2175 -1488 2 2 12 9 599 2402 1790 -1489 2 2 12 9 1943 3332 763 -1490 2 2 12 9 860 1415 2304 -1491 2 2 12 9 861 2305 1416 -1492 2 2 12 9 790 2822 1286 -1493 2 2 12 9 650 3319 2025 -1494 2 2 12 9 651 2026 3320 -1495 2 2 12 9 1166 2824 2065 -1496 2 2 12 9 545 1570 3333 -1497 2 2 12 9 1248 3118 2745 -1498 2 2 12 9 1249 2746 3119 -1499 2 2 12 9 257 1322 2242 -1500 2 2 12 9 319 2243 1323 -1501 2 2 12 9 425 1677 3469 -1502 2 2 12 9 760 2137 1574 -1503 2 2 12 9 761 1575 2138 -1504 2 2 12 9 1808 2422 3110 -1505 2 2 12 9 1113 2970 2141 -1506 2 2 12 9 3554 531 2463 -1507 2 2 12 9 451 1997 2720 -1508 2 2 12 9 452 2721 2000 -1509 2 2 12 9 852 2325 1343 -1510 2 2 12 9 853 1344 2326 -1511 2 2 12 9 609 1454 3235 -1512 2 2 12 9 1011 2135 1452 -1513 2 2 12 9 1007 1650 3540 -1514 2 2 12 9 1167 3258 1481 -1515 2 2 12 9 1168 1482 3259 -1516 2 2 12 9 437 2963 1689 -1517 2 2 12 9 343 1345 2818 -1518 2 2 12 9 342 2819 1346 -1519 2 2 12 9 601 1301 2146 -1520 2 2 12 9 602 2148 1302 -1521 2 2 12 9 484 2978 2386 -1522 2 2 12 9 642 2108 1293 -1523 2 2 12 9 344 2801 1443 -1524 2 2 12 9 188 189 1646 -1525 2 2 12 9 2682 2071 903 -1526 2 2 12 9 1088 2581 2929 -1527 2 2 12 9 1089 2930 2582 -1528 2 2 12 9 856 1296 2391 -1529 2 2 12 9 580 1339 2363 -1530 2 2 12 9 366 1927 1445 -1531 2 2 12 9 857 2392 1297 -1532 2 2 12 9 624 2304 1415 -1533 2 2 12 9 625 1416 2305 -1534 2 2 12 9 1194 2074 3141 -1535 2 2 12 9 930 1335 2532 -1536 2 2 12 9 940 2380 1532 -1537 2 2 12 9 636 1880 1347 -1538 2 2 12 9 381 1382 2340 -1539 2 2 12 9 1723 2996 2165 -1540 2 2 12 9 933 3347 1619 -1541 2 2 12 9 862 3503 1290 -1542 2 2 12 9 1332 2071 2682 -1543 2 2 12 9 1138 3235 1454 -1544 2 2 12 9 748 2236 1804 -1545 2 2 12 9 302 1963 2381 -1546 2 2 12 9 308 309 1998 -1547 2 2 12 9 590 2787 1429 -1548 2 2 12 9 907 1878 2430 -1549 2 2 12 9 451 1716 1547 -1550 2 2 12 9 900 1559 2292 -1551 2 2 12 9 1115 1992 1373 -1552 2 2 12 9 794 1733 2105 -1553 2 2 12 9 452 1548 1717 -1554 2 2 12 9 2896 3207 2258 -1555 2 2 12 9 649 2813 1996 -1556 2 2 12 9 511 2090 2749 -1557 2 2 12 9 1050 2396 1852 -1558 2 2 12 9 1055 1887 2147 -1559 2 2 12 9 464 2221 1362 -1560 2 2 12 9 440 2397 2113 -1561 2 2 12 9 1552 2507 1880 -1562 2 2 12 9 465 1363 2222 -1563 2 2 12 9 1095 1940 2390 -1564 2 2 12 9 2025 475 2981 -1565 2 2 12 9 2026 2982 476 -1566 2 2 12 9 827 1370 1982 -1567 2 2 12 9 858 1742 2100 -1568 2 2 12 9 1437 2025 2981 -1569 2 2 12 9 1438 2982 2026 -1570 2 2 12 9 883 2534 1431 -1571 2 2 12 9 350 1321 2163 -1572 2 2 12 9 635 1430 3105 -1573 2 2 12 9 669 2437 1276 -1574 2 2 12 9 423 2576 3381 -1575 2 2 12 9 2882 834 1284 -1576 2 2 12 9 808 2082 1766 -1577 2 2 12 9 809 1767 2083 -1578 2 2 12 9 494 1622 1890 -1579 2 2 12 9 495 1891 1623 -1580 2 2 12 9 1395 2430 3289 -1581 2 2 12 9 1159 2981 1861 -1582 2 2 12 9 1160 1862 2982 -1583 2 2 12 9 232 1972 1500 -1584 2 2 12 9 646 1517 3486 -1585 2 2 12 9 1156 1580 2286 -1586 2 2 12 9 1097 2021 1591 -1587 2 2 12 9 665 1715 1532 -1588 2 2 12 9 1028 1865 2401 -1589 2 2 12 9 695 1349 1916 -1590 2 2 12 9 206 1351 3068 -1591 2 2 12 9 467 1877 2303 -1592 2 2 12 9 1244 3124 1835 -1593 2 2 12 9 534 2908 1452 -1594 2 2 12 9 1029 2081 2037 -1595 2 2 12 9 1590 2171 3048 -1596 2 2 12 9 3563 443 2099 -1597 2 2 12 9 574 1775 2868 -1598 2 2 12 9 575 2869 1776 -1599 2 2 12 9 1079 1790 2402 -1600 2 2 12 9 350 3409 1685 -1601 2 2 12 9 762 1908 3575 -1602 2 2 12 9 1266 2103 3335 -1603 2 2 12 9 1267 3336 2104 -1604 2 2 12 9 1056 1829 2221 -1605 2 2 12 9 288 1360 2237 -1606 2 2 12 9 1057 2222 1830 -1607 2 2 12 9 1413 1736 3303 -1608 2 2 12 9 380 2229 1331 -1609 2 2 12 9 289 2248 1360 -1610 2 2 12 9 1581 3265 1995 -1611 2 2 12 9 563 1912 1752 -1612 2 2 12 9 543 1582 1708 -1613 2 2 12 9 544 1709 1583 -1614 2 2 12 9 352 2410 1498 -1615 2 2 12 9 351 1499 2411 -1616 2 2 12 9 1248 3317 1679 -1617 2 2 12 9 1249 1680 3318 -1618 2 2 12 9 1728 3554 2463 -1619 2 2 12 9 236 237 1736 -1620 2 2 12 9 554 2091 2517 -1621 2 2 12 9 799 1732 1788 -1622 2 2 12 9 464 2288 2221 -1623 2 2 12 9 465 2222 2289 -1624 2 2 12 9 1064 2020 2749 -1625 2 2 12 9 2003 3604 811 -1626 2 2 12 9 855 1450 2268 -1627 2 2 12 9 595 2292 1559 -1628 2 2 12 9 838 1356 2823 -1629 2 2 12 9 1429 1959 3263 -1630 2 2 12 9 868 3289 2430 -1631 2 2 12 9 2056 2935 3254 -1632 2 2 12 9 1097 2303 1877 -1633 2 2 12 9 797 1785 1718 -1634 2 2 12 9 741 1352 2623 -1635 2 2 12 9 715 1915 1589 -1636 2 2 12 9 267 268 1917 -1637 2 2 12 9 364 1907 2334 -1638 2 2 12 9 419 1359 2135 -1639 2 2 12 9 1217 2868 1775 -1640 2 2 12 9 1218 1776 2869 -1641 2 2 12 9 578 1679 3317 -1642 2 2 12 9 579 3318 1680 -1643 2 2 12 9 595 1399 2292 -1644 2 2 12 9 412 1476 1957 -1645 2 2 12 9 462 1526 1807 -1646 2 2 12 9 818 1591 2021 -1647 2 2 12 9 1441 3575 1908 -1648 2 2 12 9 660 2998 1651 -1649 2 2 12 9 253 254 1587 -1650 2 2 12 9 322 323 1588 -1651 2 2 12 9 747 1772 1848 -1652 2 2 12 9 1293 2108 3538 -1653 2 2 12 9 505 1579 2723 -1654 2 2 12 9 686 1791 1484 -1655 2 2 12 9 17 18 1651 -1656 2 2 12 9 1050 2827 1736 -1657 2 2 12 9 3287 687 2195 -1658 2 2 12 9 3288 2196 688 -1659 2 2 12 9 354 1330 2413 -1660 2 2 12 9 49 2763 1598 -1661 2 2 12 9 172 1599 2764 -1662 2 2 12 9 971 2904 1429 -1663 2 2 12 9 1007 3540 2880 -1664 2 2 12 9 768 2797 1287 -1665 2 2 12 9 769 1288 2798 -1666 2 2 12 9 967 2307 1707 -1667 2 2 12 9 803 2772 2403 -1668 2 2 12 9 618 1307 2662 -1669 2 2 12 9 1435 2600 3610 -1670 2 2 12 9 1436 3611 2601 -1671 2 2 12 9 229 1311 2019 -1672 2 2 12 9 212 1643 3314 -1673 2 2 12 9 844 2218 1475 -1674 2 2 12 9 746 1445 1810 -1675 2 2 12 9 467 1361 2561 -1676 2 2 12 9 1012 2621 1963 -1677 2 2 12 9 881 1686 2257 -1678 2 2 12 9 759 3032 3313 -1679 2 2 12 9 364 2133 1303 -1680 2 2 12 9 653 1456 1860 -1681 2 2 12 9 635 1298 2191 -1682 2 2 12 9 445 1937 2147 -1683 2 2 12 9 814 2493 1348 -1684 2 2 12 9 1375 3175 1771 -1685 2 2 12 9 1070 3027 1375 -1686 2 2 12 9 601 2547 1301 -1687 2 2 12 9 693 1870 1394 -1688 2 2 12 9 602 1302 2548 -1689 2 2 12 9 484 1911 2978 -1690 2 2 12 9 1017 2908 2235 -1691 2 2 12 9 505 1835 2562 -1692 2 2 12 9 750 1708 1582 -1693 2 2 12 9 751 1583 1709 -1694 2 2 12 9 349 1378 2812 -1695 2 2 12 9 398 1431 2534 -1696 2 2 12 9 680 3127 1280 -1697 2 2 12 9 2035 3411 2572 -1698 2 2 12 9 394 2687 1727 -1699 2 2 12 9 755 2343 1341 -1700 2 2 12 9 854 2517 1278 -1701 2 2 12 9 608 1417 3168 -1702 2 2 12 9 1571 3563 2099 -1703 2 2 12 9 703 1506 1789 -1704 2 2 12 9 1467 2769 1730 -1705 2 2 12 9 618 3615 2899 -1706 2 2 12 9 1537 2815 3642 -1707 2 2 12 9 975 2358 1765 -1708 2 2 12 9 780 2039 3009 -1709 2 2 12 9 906 1442 1886 -1710 2 2 12 9 1625 3287 2195 -1711 2 2 12 9 1626 2196 3288 -1712 2 2 12 9 635 2191 1430 -1713 2 2 12 9 858 2419 1393 -1714 2 2 12 9 733 2172 1798 -1715 2 2 12 9 734 1799 2173 -1716 2 2 12 9 1546 3332 1943 -1717 2 2 12 9 558 1326 2918 -1718 2 2 12 9 767 1777 1774 -1719 2 2 12 9 529 3004 1639 -1720 2 2 12 9 825 1409 1961 -1721 2 2 12 9 627 2529 1989 -1722 2 2 12 9 952 1505 2603 -1723 2 2 12 9 1245 2080 3183 -1724 2 2 12 9 778 2037 2081 -1725 2 2 12 9 750 2447 1362 -1726 2 2 12 9 751 1363 2448 -1727 2 2 12 9 720 3232 1779 -1728 2 2 12 9 414 2968 2407 -1729 2 2 12 9 457 2342 2466 -1730 2 2 12 9 471 1692 2484 -1731 2 2 12 9 471 2484 1664 -1732 2 2 12 9 379 1811 1567 -1733 2 2 12 9 789 1783 2009 -1734 2 2 12 9 1051 2105 1733 -1735 2 2 12 9 906 2636 1442 -1736 2 2 12 9 569 1505 2528 -1737 2 2 12 9 834 2426 1284 -1738 2 2 12 9 686 1707 2307 -1739 2 2 12 9 1023 2357 1998 -1740 2 2 12 9 869 1530 1752 -1741 2 2 12 9 676 1576 2415 -1742 2 2 12 9 717 1445 1927 -1743 2 2 12 9 1310 1556 2470 -1744 2 2 12 9 1277 2113 2397 -1745 2 2 12 9 510 2085 1608 -1746 2 2 12 9 508 1381 2349 -1747 2 2 12 9 589 2036 1338 -1748 2 2 12 9 810 2291 3222 -1749 2 2 12 9 406 2370 2912 -1750 2 2 12 9 306 1703 3512 -1751 2 2 12 9 1095 2390 3395 -1752 2 2 12 9 492 3498 2182 -1753 2 2 12 9 1426 2734 3396 -1754 2 2 12 9 489 2217 1899 -1755 2 2 12 9 886 2402 1627 -1756 2 2 12 9 191 1432 3075 -1757 2 2 12 9 1054 2723 1579 -1758 2 2 12 9 1414 2387 3624 -1759 2 2 12 9 1384 2618 2355 -1760 2 2 12 9 1385 2356 2619 -1761 2 2 12 9 922 1403 2724 -1762 2 2 12 9 1355 3362 2183 -1763 2 2 12 9 1340 2813 3547 -1764 2 2 12 9 767 1772 1567 -1765 2 2 12 9 715 1673 1915 -1766 2 2 12 9 1535 3194 2438 -1767 2 2 12 9 870 1371 2270 -1768 2 2 12 9 473 1471 2300 -1769 2 2 12 9 762 1765 2791 -1770 2 2 12 9 407 1919 2244 -1771 2 2 12 9 461 1393 2419 -1772 2 2 12 9 3263 1959 436 -1773 2 2 12 9 766 1965 2968 -1774 2 2 12 9 1009 1827 2372 -1775 2 2 12 9 776 3297 1303 -1776 2 2 12 9 792 1336 2125 -1777 2 2 12 9 1148 3075 1432 -1778 2 2 12 9 746 2955 1445 -1779 2 2 12 9 498 1966 2367 -1780 2 2 12 9 719 1835 3124 -1781 2 2 12 9 574 3548 1775 -1782 2 2 12 9 575 1776 3549 -1783 2 2 12 9 574 2832 3548 -1784 2 2 12 9 575 3549 2834 -1785 2 2 12 9 1268 3306 2580 -1786 2 2 12 9 383 2490 1317 -1787 2 2 12 9 635 2492 1298 -1788 2 2 12 9 776 1303 2133 -1789 2 2 12 9 1011 2290 2135 -1790 2 2 12 9 864 2251 2423 -1791 2 2 12 9 907 2430 2753 -1792 2 2 12 9 1167 1481 2364 -1793 2 2 12 9 1168 2365 1482 -1794 2 2 12 9 1059 1737 2174 -1795 2 2 12 9 1143 2010 2339 -1796 2 2 12 9 869 2495 1433 -1797 2 2 12 9 567 2339 2010 -1798 2 2 12 9 1165 1914 3304 -1799 2 2 12 9 889 1783 2354 -1800 2 2 12 9 1156 3299 1580 -1801 2 2 12 9 1641 3626 2042 -1802 2 2 12 9 638 2846 1351 -1803 2 2 12 9 804 1774 1777 -1804 2 2 12 9 529 2359 3004 -1805 2 2 12 9 632 2035 2572 -1806 2 2 12 9 715 1422 1974 -1807 2 2 12 9 1033 2336 1980 -1808 2 2 12 9 193 1831 2579 -1809 2 2 12 9 1034 1981 2337 -1810 2 2 12 9 188 1646 3069 -1811 2 2 12 9 872 2340 1382 -1812 2 2 12 9 508 2429 1381 -1813 2 2 12 9 1040 3057 2524 -1814 2 2 12 9 1366 2403 2772 -1815 2 2 12 9 1244 2723 1572 -1816 2 2 12 9 186 187 1632 -1817 2 2 12 9 406 2144 1562 -1818 2 2 12 9 1146 2835 3094 -1819 2 2 12 9 1064 2090 1417 -1820 2 2 12 9 811 3604 1813 -1821 2 2 12 9 796 1960 1811 -1822 2 2 12 9 744 1800 1533 -1823 2 2 12 9 745 1534 1801 -1824 2 2 12 9 2734 499 3396 -1825 2 2 12 9 380 1331 2427 -1826 2 2 12 9 583 1317 3321 -1827 2 2 12 9 812 2174 1737 -1828 2 2 12 9 511 2372 1827 -1829 2 2 12 9 206 2306 1351 -1830 2 2 12 9 875 2470 1507 -1831 2 2 12 9 355 1600 1892 -1832 2 2 12 9 356 1893 1601 -1833 2 2 12 9 775 2972 1410 -1834 2 2 12 9 1058 2226 2871 -1835 2 2 12 9 3626 565 2042 -1836 2 2 12 9 888 2597 1490 -1837 2 2 12 9 1014 1513 2184 -1838 2 2 12 9 1040 2524 1823 -1839 2 2 12 9 717 2439 1531 -1840 2 2 12 9 730 1975 2938 -1841 2 2 12 9 731 2939 1976 -1842 2 2 12 9 569 1305 2371 -1843 2 2 12 9 474 1614 1848 -1844 2 2 12 9 1055 2147 1937 -1845 2 2 12 9 1042 3145 1913 -1846 2 2 12 9 1779 3232 2225 -1847 2 2 12 9 395 3011 1747 -1848 2 2 12 9 34 35 1672 -1849 2 2 12 9 612 2681 1327 -1850 2 2 12 9 1337 2756 3511 -1851 2 2 12 9 3059 873 1341 -1852 2 2 12 9 671 2003 1540 -1853 2 2 12 9 1716 2720 1980 -1854 2 2 12 9 1717 1981 2721 -1855 2 2 12 9 849 2466 1396 -1856 2 2 12 9 278 279 1635 -1857 2 2 12 9 375 2496 1781 -1858 2 2 12 9 39 2126 1384 -1859 2 2 12 9 182 1385 2127 -1860 2 2 12 9 1355 1572 2571 -1861 2 2 12 9 519 3081 2273 -1862 2 2 12 9 520 2274 3082 -1863 2 2 12 9 394 2879 3146 -1864 2 2 12 9 359 1448 3024 -1865 2 2 12 9 767 1567 1811 -1866 2 2 12 9 795 2036 1404 -1867 2 2 12 9 1080 3436 1768 -1868 2 2 12 9 1173 2870 2108 -1869 2 2 12 9 1260 2938 1975 -1870 2 2 12 9 415 1337 2145 -1871 2 2 12 9 1261 1976 2939 -1872 2 2 12 9 576 3363 2045 -1873 2 2 12 9 1176 2179 3131 -1874 2 2 12 9 454 2330 1367 -1875 2 2 12 9 455 1368 2331 -1876 2 2 12 9 499 1765 2358 -1877 2 2 12 9 1387 3446 3149 -1878 2 2 12 9 1388 3150 3447 -1879 2 2 12 9 223 1390 3236 -1880 2 2 12 9 953 2129 1854 -1881 2 2 12 9 954 1855 2130 -1882 2 2 12 9 697 2575 3474 -1883 2 2 12 9 685 1949 1410 -1884 2 2 12 9 628 1315 2423 -1885 2 2 12 9 1009 2045 1431 -1886 2 2 12 9 1045 2101 2161 -1887 2 2 12 9 1046 2162 2102 -1888 2 2 12 9 1514 3070 2260 -1889 2 2 12 9 365 1333 2809 -1890 2 2 12 9 2340 2042 3425 -1891 2 2 12 9 859 1328 2444 -1892 2 2 12 9 1079 1535 2550 -1893 2 2 12 9 453 2807 2205 -1894 2 2 12 9 38 1384 2355 -1895 2 2 12 9 183 2356 1385 -1896 2 2 12 9 748 1853 3068 -1897 2 2 12 9 27 2599 1423 -1898 2 2 12 9 779 2106 1356 -1899 2 2 12 9 474 1774 2029 -1900 2 2 12 9 1686 3291 2257 -1901 2 2 12 9 1299 2096 3036 -1902 2 2 12 9 1300 3037 2097 -1903 2 2 12 9 692 2670 1611 -1904 2 2 12 9 823 1854 2129 -1905 2 2 12 9 824 2130 1855 -1906 2 2 12 9 369 2016 1528 -1907 2 2 12 9 370 1529 2017 -1908 2 2 12 9 1446 3343 1993 -1909 2 2 12 9 1020 3642 2815 -1910 2 2 12 9 643 1643 3125 -1911 2 2 12 9 1342 2888 2144 -1912 2 2 12 9 945 1423 2599 -1913 2 2 12 9 18 3354 1651 -1914 2 2 12 9 563 1836 1650 -1915 2 2 12 9 1196 3125 1643 -1916 2 2 12 9 811 1540 2003 -1917 2 2 12 9 778 3307 3593 -1918 2 2 12 9 509 2800 3286 -1919 2 2 12 9 952 2528 1505 -1920 2 2 12 9 494 2223 1622 -1921 2 2 12 9 349 1442 2636 -1922 2 2 12 9 1130 2001 2718 -1923 2 2 12 9 495 1623 2224 -1924 2 2 12 9 895 2716 1359 -1925 2 2 12 9 1431 2045 3363 -1926 2 2 12 9 1131 2719 2002 -1927 2 2 12 9 2042 1108 3425 -1928 2 2 12 9 215 2847 2956 -1929 2 2 12 9 878 1393 2309 -1930 2 2 12 9 619 2472 1421 -1931 2 2 12 9 1001 2360 1688 -1932 2 2 12 9 885 1421 1953 -1933 2 2 12 9 874 1608 2085 -1934 2 2 12 9 941 2593 3247 -1935 2 2 12 9 623 1342 2631 -1936 2 2 12 9 593 2486 1357 -1937 2 2 12 9 594 1358 2487 -1938 2 2 12 9 1084 3036 2096 -1939 2 2 12 9 1085 2097 3037 -1940 2 2 12 9 759 2067 3032 -1941 2 2 12 9 934 1403 2926 -1942 2 2 12 9 819 1557 1939 -1943 2 2 12 9 536 2401 1865 -1944 2 2 12 9 1144 3210 1417 -1945 2 2 12 9 548 1593 2709 -1946 2 2 12 9 367 3575 1441 -1947 2 2 12 9 1029 1902 3180 -1948 2 2 12 9 1328 2309 2444 -1949 2 2 12 9 448 1584 1764 -1950 2 2 12 9 772 1957 1476 -1951 2 2 12 9 742 1479 2506 -1952 2 2 12 9 869 1912 2495 -1953 2 2 12 9 606 1355 3523 -1954 2 2 12 9 570 1455 2209 -1955 2 2 12 9 658 2815 1537 -1956 2 2 12 9 468 2241 2514 -1957 2 2 12 9 389 2999 1944 -1958 2 2 12 9 589 1393 2585 -1959 2 2 12 9 461 2444 2309 -1960 2 2 12 9 767 1774 1772 -1961 2 2 12 9 468 2403 1366 -1962 2 2 12 9 1238 1612 2178 -1963 2 2 12 9 362 2647 2259 -1964 2 2 12 9 842 3412 1470 -1965 2 2 12 9 1361 2303 3184 -1966 2 2 12 9 747 2550 1535 -1967 2 2 12 9 1902 2458 3180 -1968 2 2 12 9 1340 2241 2813 -1969 2 2 12 9 1258 2177 3072 -1970 2 2 12 9 662 1814 2164 -1971 2 2 12 9 1318 3045 2040 -1972 2 2 12 9 1319 2041 3046 -1973 2 2 12 9 1022 2475 2422 -1974 2 2 12 9 893 1704 3616 -1975 2 2 12 9 493 1970 1628 -1976 2 2 12 9 881 2228 1686 -1977 2 2 12 9 804 2379 2253 -1978 2 2 12 9 1049 1446 3151 -1979 2 2 12 9 442 2471 1456 -1980 2 2 12 9 893 3616 3093 -1981 2 2 12 9 418 1379 2506 -1982 2 2 12 9 906 1886 2424 -1983 2 2 12 9 762 2791 1908 -1984 2 2 12 9 732 2617 2433 -1985 2 2 12 9 352 1472 3483 -1986 2 2 12 9 351 3484 1473 -1987 2 2 12 9 814 2631 1342 -1988 2 2 12 9 361 1715 2730 -1989 2 2 12 9 193 194 1831 -1990 2 2 12 9 947 2734 1426 -1991 2 2 12 9 889 2009 1783 -1992 2 2 12 9 934 2970 1403 -1993 2 2 12 9 810 2612 1390 -1994 2 2 12 9 232 233 1972 -1995 2 2 12 9 1142 1595 3144 -1996 2 2 12 9 864 1485 2116 -1997 2 2 12 9 494 1890 1694 -1998 2 2 12 9 495 1695 1891 -1999 2 2 12 9 851 1331 2635 -2000 2 2 12 9 1110 3146 1958 -2001 2 2 12 9 431 1531 2549 -2002 2 2 12 9 1353 3599 2498 -2003 2 2 12 9 1345 2006 3639 -2004 2 2 12 9 1346 3640 2007 -2005 2 2 12 9 852 1343 2318 -2006 2 2 12 9 853 2319 1344 -2007 2 2 12 9 1092 1727 2687 -2008 2 2 12 9 611 1482 3277 -2009 2 2 12 9 502 2839 1977 -2010 2 2 12 9 503 1978 2840 -2011 2 2 12 9 750 1362 2221 -2012 2 2 12 9 751 2222 1363 -2013 2 2 12 9 610 3274 1481 -2014 2 2 12 9 783 2006 1947 -2015 2 2 12 9 784 1948 2007 -2016 2 2 12 9 1002 2329 1652 -2017 2 2 12 9 1471 3625 2300 -2018 2 2 12 9 851 2427 1331 -2019 2 2 12 9 537 1461 2079 -2020 2 2 12 9 1001 3134 1380 -2021 2 2 12 9 402 3110 2422 -2022 2 2 12 9 1685 2537 3395 -2023 2 2 12 9 1559 3368 2699 -2024 2 2 12 9 423 3048 1369 -2025 2 2 12 9 222 1411 2230 -2026 2 2 12 9 1030 2633 1926 -2027 2 2 12 9 626 2270 1371 -2028 2 2 12 9 392 1419 2318 -2029 2 2 12 9 393 2319 1420 -2030 2 2 12 9 469 2679 2345 -2031 2 2 12 9 1742 2777 2100 -2032 2 2 12 9 1266 1892 2103 -2033 2 2 12 9 1267 2104 1893 -2034 2 2 12 9 1235 2206 2973 -2035 2 2 12 9 1166 3314 1643 -2036 2 2 12 9 617 1490 2597 -2037 2 2 12 9 1341 873 2445 -2038 2 2 12 9 882 2442 1349 -2039 2 2 12 9 877 2736 2369 -2040 2 2 12 9 525 1980 2336 -2041 2 2 12 9 526 2337 1981 -2042 2 2 12 9 1688 2360 3143 -2043 2 2 12 9 981 1899 2217 -2044 2 2 12 9 589 2436 1393 -2045 2 2 12 9 1419 3644 2281 -2046 2 2 12 9 726 2071 1674 -2047 2 2 12 9 1420 2282 3645 -2048 2 2 12 9 9 2387 1464 -2049 2 2 12 9 369 1528 2692 -2050 2 2 12 9 370 2693 1529 -2051 2 2 12 9 1117 2935 2056 -2052 2 2 12 9 530 2825 1396 -2053 2 2 12 9 439 1516 3248 -2054 2 2 12 9 1084 3149 3446 -2055 2 2 12 9 1085 3447 3150 -2056 2 2 12 9 986 1598 2763 -2057 2 2 12 9 987 2764 1599 -2058 2 2 12 9 831 1369 2171 -2059 2 2 12 9 1199 2537 1685 -2060 2 2 12 9 1123 1465 3018 -2061 2 2 12 9 1124 3019 1466 -2062 2 2 12 9 415 2481 1337 -2063 2 2 12 9 2743 614 1384 -2064 2 2 12 9 2744 1385 615 -2065 2 2 12 9 42 43 1800 -2066 2 2 12 9 178 179 1801 -2067 2 2 12 9 790 2204 1447 -2068 2 2 12 9 418 3278 1379 -2069 2 2 12 9 878 2585 1393 -2070 2 2 12 9 31 3076 1504 -2071 2 2 12 9 1090 2040 3045 -2072 2 2 12 9 1091 3046 2041 -2073 2 2 12 9 416 2136 1424 -2074 2 2 12 9 831 3010 1369 -2075 2 2 12 9 806 1550 1890 -2076 2 2 12 9 898 1731 2029 -2077 2 2 12 9 604 3183 2080 -2078 2 2 12 9 807 1891 1551 -2079 2 2 12 9 383 1507 2470 -2080 2 2 12 9 442 2778 2471 -2081 2 2 12 9 840 2161 2101 -2082 2 2 12 9 841 2102 2162 -2083 2 2 12 9 408 2219 1439 -2084 2 2 12 9 409 1440 2220 -2085 2 2 12 9 875 1507 2717 -2086 2 2 12 9 921 1956 1613 -2087 2 2 12 9 1074 1879 3283 -2088 2 2 12 9 545 1931 2790 -2089 2 2 12 9 338 2308 1410 -2090 2 2 12 9 531 2211 1458 -2091 2 2 12 9 1226 2933 3383 -2092 2 2 12 9 539 2112 3389 -2093 2 2 12 9 461 2309 1393 -2094 2 2 12 9 609 2608 1556 -2095 2 2 12 9 589 1404 2036 -2096 2 2 12 9 2699 3368 347 -2097 2 2 12 9 837 2408 1944 -2098 2 2 12 9 659 1527 3473 -2099 2 2 12 9 1058 3024 1448 -2100 2 2 12 9 1823 2524 3272 -2101 2 2 12 9 811 1813 1836 -2102 2 2 12 9 775 1410 2308 -2103 2 2 12 9 1337 3514 2756 -2104 2 2 12 9 1118 3103 2077 -2105 2 2 12 9 1768 3436 2668 -2106 2 2 12 9 957 2053 1849 -2107 2 2 12 9 1745 3432 3532 -2108 2 2 12 9 767 1960 1777 -2109 2 2 12 9 653 3537 1514 -2110 2 2 12 9 1347 2569 1746 -2111 2 2 12 9 403 2023 3212 -2112 2 2 12 9 404 3213 2024 -2113 2 2 12 9 1159 3524 2016 -2114 2 2 12 9 1160 2017 3525 -2115 2 2 12 9 833 2284 1522 -2116 2 2 12 9 710 3413 1598 -2117 2 2 12 9 711 1599 3414 -2118 2 2 12 9 663 3565 1435 -2119 2 2 12 9 664 1436 3566 -2120 2 2 12 9 439 3138 1653 -2121 2 2 12 9 663 2758 1654 -2122 2 2 12 9 664 1655 2759 -2123 2 2 12 9 796 1692 1960 -2124 2 2 12 9 859 2264 2187 -2125 2 2 12 9 936 2845 1397 -2126 2 2 12 9 765 3536 1652 -2127 2 2 12 9 785 1541 1873 -2128 2 2 12 9 786 1874 1542 -2129 2 2 12 9 823 1391 2275 -2130 2 2 12 9 824 2276 1392 -2131 2 2 12 9 1076 3069 1646 -2132 2 2 12 9 1053 1611 2670 -2133 2 2 12 9 481 1609 1873 -2134 2 2 12 9 482 1874 1610 -2135 2 2 12 9 754 1458 3387 -2136 2 2 12 9 567 3071 2793 -2137 2 2 12 9 1729 2881 2950 -2138 2 2 12 9 1343 2325 1585 -2139 2 2 12 9 1344 1586 2326 -2140 2 2 12 9 369 2718 1636 -2141 2 2 12 9 370 1637 2719 -2142 2 2 12 9 446 2923 1365 -2143 2 2 12 9 1241 1838 3298 -2144 2 2 12 9 1242 3300 1839 -2145 2 2 12 9 754 2676 1458 -2146 2 2 12 9 843 1747 1970 -2147 2 2 12 9 1340 2514 2241 -2148 2 2 12 9 46 3018 1465 -2149 2 2 12 9 175 1466 3019 -2150 2 2 12 9 938 1947 2006 -2151 2 2 12 9 795 1404 2491 -2152 2 2 12 9 939 2007 1948 -2153 2 2 12 9 788 1424 2136 -2154 2 2 12 9 1751 3543 3458 -2155 2 2 12 9 814 1411 2631 -2156 2 2 12 9 1338 2345 2679 -2157 2 2 12 9 343 1945 2006 -2158 2 2 12 9 342 2007 1946 -2159 2 2 12 9 1747 3011 2530 -2160 2 2 12 9 1378 1579 3526 -2161 2 2 12 9 831 2171 1645 -2162 2 2 12 9 828 1650 1836 -2163 2 2 12 9 424 2457 2409 -2164 2 2 12 9 773 1496 2299 -2165 2 2 12 9 1119 2903 2059 -2166 2 2 12 9 1781 2496 3073 -2167 2 2 12 9 981 1917 2311 -2168 2 2 12 9 1006 1753 2187 -2169 2 2 12 9 462 2188 1526 -2170 2 2 12 9 483 2316 3089 -2171 2 2 12 9 484 3090 2317 -2172 2 2 12 9 781 1425 2595 -2173 2 2 12 9 345 3144 1595 -2174 2 2 12 9 901 2355 2618 -2175 2 2 12 9 902 2619 2356 -2176 2 2 12 9 3592 365 1405 -2177 2 2 12 9 422 2898 1433 -2178 2 2 12 9 1172 1651 3354 -2179 2 2 12 9 656 1821 2109 -2180 2 2 12 9 918 3063 1945 -2181 2 2 12 9 919 1946 3064 -2182 2 2 12 9 1299 1977 2839 -2183 2 2 12 9 1300 2840 1978 -2184 2 2 12 9 1147 3248 1516 -2185 2 2 12 9 851 2300 3625 -2186 2 2 12 9 1631 1859 2725 -2187 2 2 12 9 964 1494 2146 -2188 2 2 12 9 793 2168 3029 -2189 2 2 12 9 965 2148 1495 -2190 2 2 12 9 1430 1973 3105 -2191 2 2 12 9 502 1977 2082 -2192 2 2 12 9 503 2083 1978 -2193 2 2 12 9 675 1446 3480 -2194 2 2 12 9 1886 3252 2424 -2195 2 2 12 9 814 2230 1411 -2196 2 2 12 9 477 1557 2107 -2197 2 2 12 9 1098 2008 2623 -2198 2 2 12 9 1182 1536 3583 -2199 2 2 12 9 220 1348 2665 -2200 2 2 12 9 471 1960 1692 -2201 2 2 12 9 990 1556 2608 -2202 2 2 12 9 1080 1768 2075 -2203 2 2 12 9 719 1970 1747 -2204 2 2 12 9 3040 1348 220 -2205 2 2 12 9 619 1421 2586 -2206 2 2 12 9 1083 2457 2751 -2207 2 2 12 9 388 2250 2197 -2208 2 2 12 9 474 1848 1772 -2209 2 2 12 9 210 1398 3546 -2210 2 2 12 9 480 1872 1741 -2211 2 2 12 9 986 2082 1977 -2212 2 2 12 9 987 1978 2083 -2213 2 2 12 9 1576 3147 2415 -2214 2 2 12 9 1041 1933 2395 -2215 2 2 12 9 1100 2942 1793 -2216 2 2 12 9 1101 1794 2943 -2217 2 2 12 9 445 1543 2167 -2218 2 2 12 9 746 2658 2098 -2219 2 2 12 9 1056 2221 2288 -2220 2 2 12 9 1057 2289 2222 -2221 2 2 12 9 1041 2395 2262 -2222 2 2 12 9 359 1546 1943 -2223 2 2 12 9 903 1713 1995 -2224 2 2 12 9 817 1741 1969 -2225 2 2 12 9 1090 2449 2040 -2226 2 2 12 9 1091 2041 2450 -2227 2 2 12 9 1123 3618 1465 -2228 2 2 12 9 1124 1466 3619 -2229 2 2 12 9 1099 2338 1576 -2230 2 2 12 9 825 2154 1409 -2231 2 2 12 9 883 1431 3363 -2232 2 2 12 9 964 2692 1528 -2233 2 2 12 9 965 1529 2693 -2234 2 2 12 9 1183 1597 2828 -2235 2 2 12 9 474 1772 1774 -2236 2 2 12 9 1384 614 2618 -2237 2 2 12 9 1385 2619 615 -2238 2 2 12 9 430 2944 1480 -2239 2 2 12 9 1220 1724 3252 -2240 2 2 12 9 603 1403 2970 -2241 2 2 12 9 496 3450 1532 -2242 2 2 12 9 340 1522 2284 -2243 2 2 12 9 502 1654 2839 -2244 2 2 12 9 503 2840 1655 -2245 2 2 12 9 368 1395 2877 -2246 2 2 12 9 1022 2422 1808 -2247 2 2 12 9 1025 2483 3146 -2248 2 2 12 9 521 1618 2131 -2249 2 2 12 9 818 2229 1591 -2250 2 2 12 9 1142 3407 1595 -2251 2 2 12 9 814 3040 2230 -2252 2 2 12 9 1189 1999 2646 -2253 2 2 12 9 1107 2015 2421 -2254 2 2 12 9 726 2748 1380 -2255 2 2 12 9 713 2966 2014 -2256 2 2 12 9 367 1605 3575 -2257 2 2 12 9 672 1778 3322 -2258 2 2 12 9 679 1405 3468 -2259 2 2 12 9 466 3252 1724 -2260 2 2 12 9 1443 2801 2322 -2261 2 2 12 9 391 2491 1404 -2262 2 2 12 9 1045 1667 2101 -2263 2 2 12 9 1046 2102 1668 -2264 2 2 12 9 570 2400 1455 -2265 2 2 12 9 763 1618 2180 -2266 2 2 12 9 858 1393 2436 -2267 2 2 12 9 775 1841 1872 -2268 2 2 12 9 835 3485 1409 -2269 2 2 12 9 1071 2747 1463 -2270 2 2 12 9 1204 3533 1822 -2271 2 2 12 9 1023 1998 2231 -2272 2 2 12 9 819 2107 1557 -2273 2 2 12 9 880 1834 3035 -2274 2 2 12 9 737 2718 2001 -2275 2 2 12 9 738 2002 2719 -2276 2 2 12 9 613 1378 3499 -2277 2 2 12 9 683 1953 1563 -2278 2 2 12 9 45 1465 2271 -2279 2 2 12 9 176 2272 1466 -2280 2 2 12 9 538 1702 2032 -2281 2 2 12 9 1432 2579 2857 -2282 2 2 12 9 204 205 1853 -2283 2 2 12 9 686 1569 3476 -2284 2 2 12 9 936 1397 2478 -2285 2 2 12 9 889 2354 1430 -2286 2 2 12 9 192 2579 1432 -2287 2 2 12 9 601 2146 1494 -2288 2 2 12 9 1306 2669 2697 -2289 2 2 12 9 602 1495 2148 -2290 2 2 12 9 597 1361 3184 -2291 2 2 12 9 367 1514 3440 -2292 2 2 12 9 852 2318 1419 -2293 2 2 12 9 853 1420 2319 -2294 2 2 12 9 246 2377 1660 -2295 2 2 12 9 330 1661 2378 -2296 2 2 12 9 462 2550 1769 -2297 2 2 12 9 1214 1745 3532 -2298 2 2 12 9 485 2139 1770 -2299 2 2 12 9 1415 2377 3176 -2300 2 2 12 9 1416 3177 2378 -2301 2 2 12 9 587 3335 2103 -2302 2 2 12 9 913 2028 1596 -2303 2 2 12 9 588 2104 3336 -2304 2 2 12 9 1528 2016 3524 -2305 2 2 12 9 1529 3525 2017 -2306 2 2 12 9 12 2706 2153 -2307 2 2 12 9 396 2632 1996 -2308 2 2 12 9 574 2868 2447 -2309 2 2 12 9 575 2448 2869 -2310 2 2 12 9 857 2231 1998 -2311 2 2 12 9 525 1793 3173 -2312 2 2 12 9 526 3174 1794 -2313 2 2 12 9 1793 3571 3173 -2314 2 2 12 9 798 1504 3076 -2315 2 2 12 9 1794 3174 3572 -2316 2 2 12 9 850 2425 1657 -2317 2 2 12 9 805 2076 1500 -2318 2 2 12 9 1912 2800 2495 -2319 2 2 12 9 1678 2227 3510 -2320 2 2 12 9 778 3593 2037 -2321 2 2 12 9 855 3092 1450 -2322 2 2 12 9 1219 3543 1751 -2323 2 2 12 9 490 1633 2157 -2324 2 2 12 9 25 26 1834 -2325 2 2 12 9 764 1571 2099 -2326 2 2 12 9 282 283 1733 -2327 2 2 12 9 785 1873 1609 -2328 2 2 12 9 786 1610 1874 -2329 2 2 12 9 1128 3375 2633 -2330 2 2 12 9 369 1636 2016 -2331 2 2 12 9 514 3196 1881 -2332 2 2 12 9 370 2017 1637 -2333 2 2 12 9 825 1961 1779 -2334 2 2 12 9 1087 2706 2851 -2335 2 2 12 9 948 1867 1648 -2336 2 2 12 9 1274 3439 1939 -2337 2 2 12 9 999 2579 1831 -2338 2 2 12 9 468 1366 3586 -2339 2 2 12 9 375 1894 2187 -2340 2 2 12 9 754 3387 1545 -2341 2 2 12 9 847 1533 2271 -2342 2 2 12 9 848 2272 1534 -2343 2 2 12 9 449 3126 1756 -2344 2 2 12 9 1056 3644 1419 -2345 2 2 12 9 1057 1420 3645 -2346 2 2 12 9 847 2271 1465 -2347 2 2 12 9 848 1466 2272 -2348 2 2 12 9 1433 2495 1712 -2349 2 2 12 9 820 1439 2219 -2350 2 2 12 9 888 1920 3371 -2351 2 2 12 9 821 2220 1440 -2352 2 2 12 9 918 2654 3063 -2353 2 2 12 9 3510 2227 1139 -2354 2 2 12 9 919 3064 2655 -2355 2 2 12 9 1347 1880 2861 -2356 2 2 12 9 453 1555 1962 -2357 2 2 12 9 827 2870 2293 -2358 2 2 12 9 294 295 1737 -2359 2 2 12 9 1062 1991 2795 -2360 2 2 12 9 1064 2749 2090 -2361 2 2 12 9 961 2733 1906 -2362 2 2 12 9 472 1849 2053 -2363 2 2 12 9 877 1512 2698 -2364 2 2 12 9 365 2659 1405 -2365 2 2 12 9 488 2200 1918 -2366 2 2 12 9 679 2151 1666 -2367 2 2 12 9 828 1836 1813 -2368 2 2 12 9 240 241 1743 -2369 2 2 12 9 335 336 1744 -2370 2 2 12 9 500 1422 2715 -2371 2 2 12 9 576 1512 2269 -2372 2 2 12 9 472 2053 3574 -2373 2 2 12 9 997 1660 2142 -2374 2 2 12 9 998 2143 1661 -2375 2 2 12 9 991 2109 1821 -2376 2 2 12 9 514 2299 3196 -2377 2 2 12 9 888 3371 2597 -2378 2 2 12 9 369 2985 2718 -2379 2 2 12 9 370 2719 2986 -2380 2 2 12 9 705 1884 1606 -2381 2 2 12 9 732 2433 1488 -2382 2 2 12 9 994 2730 2962 -2383 2 2 12 9 706 1607 1885 -2384 2 2 12 9 1031 2152 1864 -2385 2 2 12 9 704 3433 1972 -2386 2 2 12 9 416 1424 2821 -2387 2 2 12 9 388 3072 2177 -2388 2 2 12 9 794 3492 1733 -2389 2 2 12 9 938 2451 2384 -2390 2 2 12 9 1212 2103 2784 -2391 2 2 12 9 442 1456 3544 -2392 2 2 12 9 939 2386 2452 -2393 2 2 12 9 1213 2786 2104 -2394 2 2 12 9 1147 1516 3473 -2395 2 2 12 9 493 2850 1467 -2396 2 2 12 9 969 2040 2096 -2397 2 2 12 9 970 2097 2041 -2398 2 2 12 9 28 29 2140 -2399 2 2 12 9 299 1470 3412 -2400 2 2 12 9 419 2135 2290 -2401 2 2 12 9 880 3035 2458 -2402 2 2 12 9 630 2332 2047 -2403 2 2 12 9 631 2048 2333 -2404 2 2 12 9 583 2189 2479 -2405 2 2 12 9 694 1605 1956 -2406 2 2 12 9 991 1918 2200 -2407 2 2 12 9 717 3253 1445 -2408 2 2 12 9 32 33 1950 -2409 2 2 12 9 885 3334 2387 -2410 2 2 12 9 674 3265 1749 -2411 2 2 12 9 412 2567 1476 -2412 2 2 12 9 981 2217 1917 -2413 2 2 12 9 531 1458 2676 -2414 2 2 12 9 969 2096 2839 -2415 2 2 12 9 970 2840 2097 -2416 2 2 12 9 720 1779 1961 -2417 2 2 12 9 581 2525 3228 -2418 2 2 12 9 582 3229 2526 -2419 2 2 12 9 798 1462 2906 -2420 2 2 12 9 1391 1415 2775 -2421 2 2 12 9 1392 2776 1416 -2422 2 2 12 9 1236 3512 1703 -2423 2 2 12 9 752 2784 2103 -2424 2 2 12 9 753 2104 2786 -2425 2 2 12 9 938 2006 1945 -2426 2 2 12 9 939 1946 2007 -2427 2 2 12 9 822 2075 1768 -2428 2 2 12 9 1273 1828 3419 -2429 2 2 12 9 1362 2447 2868 -2430 2 2 12 9 1363 2869 2448 -2431 2 2 12 9 269 1521 2311 -2432 2 2 12 9 856 1917 2217 -2433 2 2 12 9 339 1589 1915 -2434 2 2 12 9 1331 3249 3014 -2435 2 2 12 9 1151 3333 3415 -2436 2 2 12 9 1070 1375 2656 -2437 2 2 12 9 459 1732 2038 -2438 2 2 12 9 44 2271 1533 -2439 2 2 12 9 177 1534 2272 -2440 2 2 12 9 48 1598 2051 -2441 2 2 12 9 173 2052 1599 -2442 2 2 12 9 1066 2316 2320 -2443 2 2 12 9 1067 2321 2317 -2444 2 2 12 9 990 1483 3100 -2445 2 2 12 9 700 1645 2171 -2446 2 2 12 9 795 2491 1374 -2447 2 2 12 9 2300 3427 473 -2448 2 2 12 9 681 3065 1451 -2449 2 2 12 9 1318 2040 2758 -2450 2 2 12 9 1319 2759 2041 -2451 2 2 12 9 719 1628 1970 -2452 2 2 12 9 299 2564 1470 -2453 2 2 12 9 1355 2571 3027 -2454 2 2 12 9 653 2512 1456 -2455 2 2 12 9 2858 3490 392 -2456 2 2 12 9 469 2165 1553 -2457 2 2 12 9 2859 393 3491 -2458 2 2 12 9 285 2989 1484 -2459 2 2 12 9 898 3041 2539 -2460 2 2 12 9 444 2510 1402 -2461 2 2 12 9 859 2444 1399 -2462 2 2 12 9 1316 1693 2549 -2463 2 2 12 9 1077 2001 2273 -2464 2 2 12 9 1078 2274 2002 -2465 2 2 12 9 222 3236 1411 -2466 2 2 12 9 872 1382 2359 -2467 2 2 12 9 775 2139 1841 -2468 2 2 12 9 1176 2329 2240 -2469 2 2 12 9 694 3204 1605 -2470 2 2 12 9 1464 2387 3334 -2471 2 2 12 9 770 1606 1884 -2472 2 2 12 9 771 1885 1607 -2473 2 2 12 9 626 1476 2270 -2474 2 2 12 9 403 1407 2557 -2475 2 2 12 9 404 2558 1408 -2476 2 2 12 9 698 2615 1852 -2477 2 2 12 9 354 2412 1645 -2478 2 2 12 9 390 1449 2252 -2479 2 2 12 9 597 1492 2210 -2480 2 2 12 9 411 2240 2329 -2481 2 2 12 9 300 1475 2564 -2482 2 2 12 9 1120 2896 3405 -2483 2 2 12 9 1647 3373 3418 -2484 2 2 12 9 772 1476 2704 -2485 2 2 12 9 1320 2098 2658 -2486 2 2 12 9 661 2756 3514 -2487 2 2 12 9 1523 2975 1837 -2488 2 2 12 9 671 1584 2003 -2489 2 2 12 9 786 1632 1964 -2490 2 2 12 9 1671 2821 2826 -2491 2 2 12 9 835 1409 3402 -2492 2 2 12 9 1410 2972 1690 -2493 2 2 12 9 562 2960 1924 -2494 2 2 12 9 564 1925 2961 -2495 2 2 12 9 1138 3267 2087 -2496 2 2 12 9 431 2236 1487 -2497 2 2 12 9 1906 2733 2916 -2498 2 2 12 9 1187 1693 3480 -2499 2 2 12 9 1100 1600 3214 -2500 2 2 12 9 1101 3215 1601 -2501 2 2 12 9 696 2906 1462 -2502 2 2 12 9 1451 3065 2250 -2503 2 2 12 9 917 1628 1882 -2504 2 2 12 9 1352 1938 3536 -2505 2 2 12 9 1133 2960 1472 -2506 2 2 12 9 1134 1473 2961 -2507 2 2 12 9 782 3636 1543 -2508 2 2 12 9 185 2399 1542 -2509 2 2 12 9 1095 3395 2537 -2510 2 2 12 9 886 2553 1383 -2511 2 2 12 9 1119 3373 1647 -2512 2 2 12 9 612 3035 1423 -2513 2 2 12 9 304 1755 2976 -2514 2 2 12 9 431 2549 1693 -2515 2 2 12 9 1598 3413 2051 -2516 2 2 12 9 1599 2052 3414 -2517 2 2 12 9 590 1429 2338 -2518 2 2 12 9 1299 2839 2096 -2519 2 2 12 9 1300 2097 2840 -2520 2 2 12 9 366 1445 2955 -2521 2 2 12 9 716 1456 2471 -2522 2 2 12 9 1309 2673 2663 -2523 2 2 12 9 1107 2421 3160 -2524 2 2 12 9 553 1638 2916 -2525 2 2 12 9 969 2758 2040 -2526 2 2 12 9 1406 2851 2061 -2527 2 2 12 9 970 2041 2759 -2528 2 2 12 9 1944 2408 3052 -2529 2 2 12 9 1162 1987 2820 -2530 2 2 12 9 885 2586 1421 -2531 2 2 12 9 1227 2433 2617 -2532 2 2 12 9 353 3292 1540 -2533 2 2 12 9 408 2101 1667 -2534 2 2 12 9 409 1668 2102 -2535 2 2 12 9 725 3391 1549 -2536 2 2 12 9 1127 1540 3292 -2537 2 2 12 9 422 1462 2406 -2538 2 2 12 9 262 263 1786 -2539 2 2 12 9 313 314 1787 -2540 2 2 12 9 50 51 1766 -2541 2 2 12 9 170 171 1767 -2542 2 2 12 9 1255 1748 2479 -2543 2 2 12 9 657 2341 1467 -2544 2 2 12 9 815 2547 1459 -2545 2 2 12 9 816 1460 2548 -2546 2 2 12 9 1037 2644 1773 -2547 2 2 12 9 472 3574 2394 -2548 2 2 12 9 270 2696 1521 -2549 2 2 12 9 1178 1602 3474 -2550 2 2 12 9 446 1418 3062 -2551 2 2 12 9 569 3156 1840 -2552 2 2 12 9 1210 1996 2632 -2553 2 2 12 9 255 2043 2739 -2554 2 2 12 9 321 2740 2044 -2555 2 2 12 9 601 1459 2547 -2556 2 2 12 9 602 2548 1460 -2557 2 2 12 9 415 1493 2194 -2558 2 2 12 9 733 1921 1694 -2559 2 2 12 9 886 1383 2438 -2560 2 2 12 9 734 1695 1922 -2561 2 2 12 9 616 2811 1425 -2562 2 2 12 9 446 1483 2923 -2563 2 2 12 9 895 1593 1958 -2564 2 2 12 9 787 2194 1493 -2565 2 2 12 9 506 2161 3045 -2566 2 2 12 9 1028 2197 2250 -2567 2 2 12 9 507 3046 2162 -2568 2 2 12 9 554 1773 2644 -2569 2 2 12 9 697 1448 2279 -2570 2 2 12 9 641 3532 3432 -2571 2 2 12 9 1809 2830 2996 -2572 2 2 12 9 1013 2253 2379 -2573 2 2 12 9 385 2040 2449 -2574 2 2 12 9 591 2697 2669 -2575 2 2 12 9 384 2450 2041 -2576 2 2 12 9 835 1872 1841 -2577 2 2 12 9 637 3179 1434 -2578 2 2 12 9 1170 3440 1514 -2579 2 2 12 9 622 3161 1478 -2580 2 2 12 9 592 2260 1441 -2581 2 2 12 9 847 1465 2591 -2582 2 2 12 9 848 2592 1466 -2583 2 2 12 9 785 1988 1672 -2584 2 2 12 9 1125 2047 2332 -2585 2 2 12 9 1076 1964 1632 -2586 2 2 12 9 1126 2333 2048 -2587 2 2 12 9 835 1741 1872 -2588 2 2 12 9 717 1927 2439 -2589 2 2 12 9 964 3050 1494 -2590 2 2 12 9 1322 2660 2242 -2591 2 2 12 9 742 2975 2606 -2592 2 2 12 9 1323 2243 2661 -2593 2 2 12 9 965 1495 3051 -2594 2 2 12 9 923 2559 1743 -2595 2 2 12 9 924 1744 2560 -2596 2 2 12 9 840 1439 2641 -2597 2 2 12 9 841 2642 1440 -2598 2 2 12 9 1263 2734 2252 -2599 2 2 12 9 380 1591 2229 -2600 2 2 12 9 899 3023 2856 -2601 2 2 12 9 947 2252 2734 -2602 2 2 12 9 1500 1972 3433 -2603 2 2 12 9 1289 2014 2966 -2604 2 2 12 9 871 1455 2400 -2605 2 2 12 9 763 3332 1516 -2606 2 2 12 9 34 1672 3042 -2607 2 2 12 9 826 2866 2462 -2608 2 2 12 9 617 2597 1401 -2609 2 2 12 9 1281 1840 3156 -2610 2 2 12 9 473 3427 2009 -2611 2 2 12 9 947 1426 2766 -2612 2 2 12 9 253 1587 2088 -2613 2 2 12 9 323 2089 1588 -2614 2 2 12 9 352 3483 2410 -2615 2 2 12 9 351 2411 3484 -2616 2 2 12 9 1152 1903 2865 -2617 2 2 12 9 353 1540 2132 -2618 2 2 12 9 743 2091 2927 -2619 2 2 12 9 3364 2948 636 -2620 2 2 12 9 871 2657 1455 -2621 2 2 12 9 659 3473 1516 -2622 2 2 12 9 486 1725 2797 -2623 2 2 12 9 487 2798 1726 -2624 2 2 12 9 1322 2780 2660 -2625 2 2 12 9 1323 2661 2781 -2626 2 2 12 9 460 2225 1491 -2627 2 2 12 9 800 1505 2371 -2628 2 2 12 9 856 2391 1917 -2629 2 2 12 9 855 2157 1633 -2630 2 2 12 9 1569 2307 3269 -2631 2 2 12 9 877 2269 1512 -2632 2 2 12 9 675 1756 2947 -2633 2 2 12 9 424 2409 1620 -2634 2 2 12 9 982 1553 2165 -2635 2 2 12 9 887 2806 1780 -2636 2 2 12 9 1468 2612 2397 -2637 2 2 12 9 908 2018 1875 -2638 2 2 12 9 1798 2649 3426 -2639 2 2 12 9 441 1930 1602 -2640 2 2 12 9 705 1606 3066 -2641 2 2 12 9 706 3067 1607 -2642 2 2 12 9 389 1596 2028 -2643 2 2 12 9 1209 1487 3481 -2644 2 2 12 9 914 1915 1673 -2645 2 2 12 9 366 1939 3439 -2646 2 2 12 9 1268 3374 2352 -2647 2 2 12 9 1593 3487 2709 -2648 2 2 12 9 838 2199 2418 -2649 2 2 12 9 201 3231 1973 -2650 2 2 12 9 913 1596 2672 -2651 2 2 12 9 365 2809 1554 -2652 2 2 12 9 958 2186 1569 -2653 2 2 12 9 794 2105 3574 -2654 2 2 12 9 812 1737 1994 -2655 2 2 12 9 1255 2479 2189 -2656 2 2 12 9 637 2393 2265 -2657 2 2 12 9 385 2096 2040 -2658 2 2 12 9 810 2397 2612 -2659 2 2 12 9 384 2041 2097 -2660 2 2 12 9 788 2577 1424 -2661 2 2 12 9 406 2912 2883 -2662 2 2 12 9 644 3458 3543 -2663 2 2 12 9 1049 3151 1758 -2664 2 2 12 9 386 1434 3594 -2665 2 2 12 9 365 3592 2298 -2666 2 2 12 9 279 1971 1635 -2667 2 2 12 9 783 1947 2117 -2668 2 2 12 9 3550 2174 812 -2669 2 2 12 9 784 2118 1948 -2670 2 2 12 9 219 2665 3032 -2671 2 2 12 9 885 1414 2586 -2672 2 2 12 9 1326 2210 3026 -2673 2 2 12 9 1094 1675 3381 -2674 2 2 12 9 189 2068 1646 -2675 2 2 12 9 785 2469 1541 -2676 2 2 12 9 458 1481 2114 -2677 2 2 12 9 459 2115 1482 -2678 2 2 12 9 570 1515 3099 -2679 2 2 12 9 1597 2948 3364 -2680 2 2 12 9 883 1666 2151 -2681 2 2 12 9 789 2286 1580 -2682 2 2 12 9 1251 3641 2628 -2683 2 2 12 9 760 2991 1816 -2684 2 2 12 9 805 1500 3433 -2685 2 2 12 9 761 1817 2992 -2686 2 2 12 9 340 1670 2578 -2687 2 2 12 9 367 3070 1514 -2688 2 2 12 9 713 2014 1675 -2689 2 2 12 9 445 2167 1486 -2690 2 2 12 9 194 2054 1831 -2691 2 2 12 9 790 1496 2822 -2692 2 2 12 9 601 2754 1459 -2693 2 2 12 9 40 41 2169 -2694 2 2 12 9 180 181 2170 -2695 2 2 12 9 602 1460 2755 -2696 2 2 12 9 990 2923 1483 -2697 2 2 12 9 918 1895 2223 -2698 2 2 12 9 919 2224 1896 -2699 2 2 12 9 920 1468 2774 -2700 2 2 12 9 772 3178 1557 -2701 2 2 12 9 1072 2916 1638 -2702 2 2 12 9 413 3027 2571 -2703 2 2 12 9 869 1433 2898 -2704 2 2 12 9 1023 2231 1812 -2705 2 2 12 9 866 3114 1469 -2706 2 2 12 9 593 2375 1407 -2707 2 2 12 9 594 1408 2376 -2708 2 2 12 9 366 3439 1927 -2709 2 2 12 9 1262 2539 3041 -2710 2 2 12 9 607 3100 1483 -2711 2 2 12 9 770 2875 1606 -2712 2 2 12 9 771 1607 2876 -2713 2 2 12 9 3490 1829 392 -2714 2 2 12 9 3491 393 1830 -2715 2 2 12 9 917 1467 2850 -2716 2 2 12 9 922 2617 1684 -2717 2 2 12 9 1042 2974 1671 -2718 2 2 12 9 355 3214 1600 -2719 2 2 12 9 292 1506 2953 -2720 2 2 12 9 356 1601 3215 -2721 2 2 12 9 420 2172 1550 -2722 2 2 12 9 2250 3065 1028 -2723 2 2 12 9 231 1500 2076 -2724 2 2 12 9 580 2865 1903 -2725 2 2 12 9 884 1590 1989 -2726 2 2 12 9 421 1551 2173 -2727 2 2 12 9 1600 2979 1892 -2728 2 2 12 9 1601 1893 2980 -2729 2 2 12 9 609 3130 1454 -2730 2 2 12 9 1116 1554 2420 -2731 2 2 12 9 672 3322 1571 -2732 2 2 12 9 1275 2471 2778 -2733 2 2 12 9 36 1541 2469 -2734 2 2 12 9 739 2016 1636 -2735 2 2 12 9 740 1637 2017 -2736 2 2 12 9 1585 2893 2618 -2737 2 2 12 9 1586 2619 2894 -2738 2 2 12 9 855 1633 2297 -2739 2 2 12 9 992 2792 2057 -2740 2 2 12 9 1018 3099 1515 -2741 2 2 12 9 993 2058 2794 -2742 2 2 12 9 920 2888 1468 -2743 2 2 12 9 774 1705 2055 -2744 2 2 12 9 1137 1881 3053 -2745 2 2 12 9 255 256 2043 -2746 2 2 12 9 320 321 2044 -2747 2 2 12 9 826 2462 1877 -2748 2 2 12 9 1049 1758 2492 -2749 2 2 12 9 783 3639 2006 -2750 2 2 12 9 784 2007 3640 -2751 2 2 12 9 3537 1170 1514 -2752 2 2 12 9 1565 1857 2712 -2753 2 2 12 9 1566 2713 1858 -2754 2 2 12 9 1190 2546 1938 -2755 2 2 12 9 519 2273 2001 -2756 2 2 12 9 457 3384 1497 -2757 2 2 12 9 520 2002 2274 -2758 2 2 12 9 972 3271 1518 -2759 2 2 12 9 794 1805 3492 -2760 2 2 12 9 522 2050 2500 -2761 2 2 12 9 689 2364 1508 -2762 2 2 12 9 1196 2956 2847 -2763 2 2 12 9 690 1509 2365 -2764 2 2 12 9 627 1432 2857 -2765 2 2 12 9 890 2242 2660 -2766 2 2 12 9 891 2661 2243 -2767 2 2 12 9 440 2774 1468 -2768 2 2 12 9 589 2585 1404 -2769 2 2 12 9 846 2802 2977 -2770 2 2 12 9 1283 2927 2091 -2771 2 2 12 9 541 3343 1926 -2772 2 2 12 9 1256 1728 2463 -2773 2 2 12 9 844 1475 2381 -2774 2 2 12 9 201 202 3231 -2775 2 2 12 9 458 2504 1718 -2776 2 2 12 9 735 3508 3309 -2777 2 2 12 9 736 3310 3509 -2778 2 2 12 9 1039 1759 1928 -2779 2 2 12 9 542 2060 2426 -2780 2 2 12 9 434 2987 1615 -2781 2 2 12 9 435 1616 2988 -2782 2 2 12 9 438 1490 2185 -2783 2 2 12 9 457 1497 2342 -2784 2 2 12 9 786 1542 2399 -2785 2 2 12 9 596 2538 1808 -2786 2 2 12 9 560 1518 2287 -2787 2 2 12 9 210 211 2065 -2788 2 2 12 9 596 2663 2673 -2789 2 2 12 9 1043 2110 1802 -2790 2 2 12 9 741 2623 2008 -2791 2 2 12 9 1044 1803 2111 -2792 2 2 12 9 577 2799 2722 -2793 2 2 12 9 652 2614 1497 -2794 2 2 12 9 2161 3171 3045 -2795 2 2 12 9 2162 3046 3172 -2796 2 2 12 9 798 2906 1504 -2797 2 2 12 9 1039 1798 3426 -2798 2 2 12 9 787 1510 2565 -2799 2 2 12 9 864 2046 2984 -2800 2 2 12 9 788 2566 1511 -2801 2 2 12 9 1563 2396 3167 -2802 2 2 12 9 1264 1927 3439 -2803 2 2 12 9 1223 3461 2554 -2804 2 2 12 9 663 1654 3565 -2805 2 2 12 9 664 3566 1655 -2806 2 2 12 9 658 2075 1665 -2807 2 2 12 9 492 3536 1938 -2808 2 2 12 9 752 2979 1997 -2809 2 2 12 9 753 2000 2980 -2810 2 2 12 9 1461 1683 3237 -2811 2 2 12 9 744 1615 2033 -2812 2 2 12 9 745 2034 1616 -2813 2 2 12 9 1686 2228 3629 -2814 2 2 12 9 710 3466 1977 -2815 2 2 12 9 711 1978 3467 -2816 2 2 12 9 760 1625 2195 -2817 2 2 12 9 761 2196 1626 -2818 2 2 12 9 750 1582 2447 -2819 2 2 12 9 751 2448 1583 -2820 2 2 12 9 352 1498 3060 -2821 2 2 12 9 351 3061 1499 -2822 2 2 12 9 982 2996 2830 -2823 2 2 12 9 460 1491 3647 -2824 2 2 12 9 600 2192 1929 -2825 2 2 12 9 1284 2426 2060 -2826 2 2 12 9 872 1641 2042 -2827 2 2 12 9 483 3089 2117 -2828 2 2 12 9 484 2118 3090 -2829 2 2 12 9 488 3550 2093 -2830 2 2 12 9 1234 2233 3085 -2831 2 2 12 9 1208 3223 2063 -2832 2 2 12 9 1099 1576 3308 -2833 2 2 12 9 440 1468 2397 -2834 2 2 12 9 670 3254 2935 -2835 2 2 12 9 842 2063 3412 -2836 2 2 12 9 698 3504 2615 -2837 2 2 12 9 215 216 2847 -2838 2 2 12 9 900 3368 1559 -2839 2 2 12 9 1072 2418 2199 -2840 2 2 12 9 1191 3322 1778 -2841 2 2 12 9 303 304 2976 -2842 2 2 12 9 456 1544 2606 -2843 2 2 12 9 416 1671 2974 -2844 2 2 12 9 727 2330 3311 -2845 2 2 12 9 728 3312 2331 -2846 2 2 12 9 835 1969 1741 -2847 2 2 12 9 673 2297 1633 -2848 2 2 12 9 367 1441 3070 -2849 2 2 12 9 901 1541 3357 -2850 2 2 12 9 902 3358 1542 -2851 2 2 12 9 699 3301 1784 -2852 2 2 12 9 782 1624 3636 -2853 2 2 12 9 569 2371 1505 -2854 2 2 12 9 603 2724 1403 -2855 2 2 12 9 972 1478 3464 -2856 2 2 12 9 431 3230 1531 -2857 2 2 12 9 992 1798 2172 -2858 2 2 12 9 993 2173 1799 -2859 2 2 12 9 936 3419 1828 -2860 2 2 12 9 1359 1870 2460 -2861 2 2 12 9 1033 1600 2336 -2862 2 2 12 9 1140 2500 2050 -2863 2 2 12 9 415 2950 1493 -2864 2 2 12 9 1034 2337 1601 -2865 2 2 12 9 1022 1808 2538 -2866 2 2 12 9 1608 3574 2105 -2867 2 2 12 9 1025 3146 2166 -2868 2 2 12 9 589 1457 2436 -2869 2 2 12 9 636 2948 1552 -2870 2 2 12 9 640 2672 1596 -2871 2 2 12 9 414 1933 2968 -2872 2 2 12 9 836 1480 3431 -2873 2 2 12 9 764 2005 1617 -2874 2 2 12 9 627 2857 1555 -2875 2 2 12 9 1148 2966 2068 -2876 2 2 12 9 787 2552 1510 -2877 2 2 12 9 31 32 3076 -2878 2 2 12 9 1214 3532 1524 -2879 2 2 12 9 880 1902 2084 -2880 2 2 12 9 748 2846 1487 -2881 2 2 12 9 1306 2697 1629 -2882 2 2 12 9 1165 1568 3459 -2883 2 2 12 9 788 1511 2577 -2884 2 2 12 9 478 2404 1502 -2885 2 2 12 9 479 1503 2405 -2886 2 2 12 9 510 1608 2105 -2887 2 2 12 9 1652 2329 3131 -2888 2 2 12 9 343 1734 1895 -2889 2 2 12 9 368 1457 2753 -2890 2 2 12 9 29 3015 2140 -2891 2 2 12 9 342 1896 1735 -2892 2 2 12 9 626 2704 1476 -2893 2 2 12 9 901 2893 1873 -2894 2 2 12 9 902 1874 2894 -2895 2 2 12 9 1656 2174 3550 -2896 2 2 12 9 813 1614 2072 -2897 2 2 12 9 792 1782 1955 -2898 2 2 12 9 254 2739 1587 -2899 2 2 12 9 322 1588 2740 -2900 2 2 12 9 730 1935 1679 -2901 2 2 12 9 731 1680 1936 -2902 2 2 12 9 471 1777 1960 -2903 2 2 12 9 445 2147 1543 -2904 2 2 12 9 1574 2137 2920 -2905 2 2 12 9 1575 2921 2138 -2906 2 2 12 9 496 2380 1842 -2907 2 2 12 9 1083 2409 2457 -2908 2 2 12 9 513 1513 2973 -2909 2 2 12 9 670 3401 1577 -2910 2 2 12 9 866 1469 3397 -2911 2 2 12 9 999 2857 2579 -2912 2 2 12 9 530 2204 2825 -2913 2 2 12 9 946 1720 2084 -2914 2 2 12 9 789 1634 2286 -2915 2 2 12 9 1327 2880 1806 -2916 2 2 12 9 972 2370 1478 -2917 2 2 12 9 1339 3517 2905 -2918 2 2 12 9 1472 2382 3369 -2919 2 2 12 9 1473 3370 2383 -2920 2 2 12 9 901 2618 2893 -2921 2 2 12 9 902 2894 2619 -2922 2 2 12 9 1106 2407 2968 -2923 2 2 12 9 187 3069 1632 -2924 2 2 12 9 1114 1672 1988 -2925 2 2 12 9 1077 1897 2710 -2926 2 2 12 9 1078 2711 1898 -2927 2 2 12 9 304 2535 1755 -2928 2 2 12 9 1223 2554 1900 -2929 2 2 12 9 1224 1901 2555 -2930 2 2 12 9 820 2382 1439 -2931 2 2 12 9 821 1440 2383 -2932 2 2 12 9 349 2812 1442 -2933 2 2 12 9 846 2749 2020 -2934 2 2 12 9 1228 2265 2393 -2935 2 2 12 9 515 1640 2181 -2936 2 2 12 9 1011 2201 2638 -2937 2 2 12 9 462 3281 2550 -2938 2 2 12 9 986 2763 1766 -2939 2 2 12 9 987 1767 2764 -2940 2 2 12 9 1282 2997 2517 -2941 2 2 12 9 806 2862 1550 -2942 2 2 12 9 807 1551 2864 -2943 2 2 12 9 782 1543 2147 -2944 2 2 12 9 911 1574 2920 -2945 2 2 12 9 912 2921 1575 -2946 2 2 12 9 368 2742 1457 -2947 2 2 12 9 632 2066 1728 -2948 2 2 12 9 659 1516 3332 -2949 2 2 12 9 1255 2189 2683 -2950 2 2 12 9 983 2950 2881 -2951 2 2 12 9 1162 2407 3382 -2952 2 2 12 9 430 2750 1569 -2953 2 2 12 9 920 1562 2144 -2954 2 2 12 9 958 1569 2750 -2955 2 2 12 9 773 2299 1704 -2956 2 2 12 9 802 2632 1552 -2957 2 2 12 9 786 2399 1632 -2958 2 2 12 9 623 2612 1468 -2959 2 2 12 9 742 2506 1837 -2960 2 2 12 9 630 2660 2780 -2961 2 2 12 9 631 2781 2661 -2962 2 2 12 9 946 2694 1720 -2963 2 2 12 9 463 2843 1517 -2964 2 2 12 9 712 2863 1913 -2965 2 2 12 9 721 2887 1530 -2966 2 2 12 9 1900 2554 3152 -2967 2 2 12 9 1901 3153 2555 -2968 2 2 12 9 675 2947 1446 -2969 2 2 12 9 1151 3021 2485 -2970 2 2 12 9 811 2132 1540 -2971 2 2 12 9 727 2223 1895 -2972 2 2 12 9 728 1896 2224 -2973 2 2 12 9 819 3648 2287 -2974 2 2 12 9 477 3464 1984 -2975 2 2 12 9 704 3237 1683 -2976 2 2 12 9 1340 3552 3390 -2977 2 2 12 9 472 2861 1849 -2978 2 2 12 9 697 3043 1448 -2979 2 2 12 9 622 1562 2584 -2980 2 2 12 9 1233 3032 2665 -2981 2 2 12 9 897 3586 2363 -2982 2 2 12 9 647 1861 2023 -2983 2 2 12 9 739 1437 3534 -2984 2 2 12 9 648 2024 1862 -2985 2 2 12 9 740 3535 1438 -2986 2 2 12 9 390 2362 1537 -2987 2 2 12 9 488 2398 3550 -2988 2 2 12 9 675 3480 1693 -2989 2 2 12 9 791 1831 2054 -2990 2 2 12 9 600 1442 3435 -2991 2 2 12 9 515 2835 1640 -2992 2 2 12 9 246 247 2377 -2993 2 2 12 9 329 330 2378 -2994 2 2 12 9 1118 2116 3379 -2995 2 2 12 9 798 2685 1714 -2996 2 2 12 9 376 2417 1921 -2997 2 2 12 9 513 2897 3419 -2998 2 2 12 9 444 1558 2510 -2999 2 2 12 9 491 1812 2231 -3000 2 2 12 9 659 3332 1546 -3001 2 2 12 9 938 2384 1947 -3002 2 2 12 9 939 1948 2386 -3003 2 2 12 9 879 1538 2683 -3004 2 2 12 9 893 2320 2316 -3005 2 2 12 9 894 2317 2321 -3006 2 2 12 9 382 2072 2158 -3007 2 2 12 9 649 1907 3547 -3008 2 2 12 9 1276 2941 1932 -3009 2 2 12 9 468 1474 2403 -3010 2 2 12 9 1087 2153 2706 -3011 2 2 12 9 448 1992 2511 -3012 2 2 12 9 789 1580 2454 -3013 2 2 12 9 8 1464 3101 -3014 2 2 12 9 360 1982 1730 -3015 2 2 12 9 494 2666 2223 -3016 2 2 12 9 1157 2626 1843 -3017 2 2 12 9 1158 1844 2627 -3018 2 2 12 9 495 2224 2667 -3019 2 2 12 9 549 1524 2836 -3020 2 2 12 9 1114 3042 1672 -3021 2 2 12 9 696 1504 2906 -3022 2 2 12 9 1309 1642 2673 -3023 2 2 12 9 194 195 2054 -3024 2 2 12 9 737 2710 1427 -3025 2 2 12 9 738 1428 2711 -3026 2 2 12 9 3567 3200 1015 -3027 2 2 12 9 3568 1016 3201 -3028 2 2 12 9 820 3369 2382 -3029 2 2 12 9 821 2383 3370 -3030 2 2 12 9 729 2549 1531 -3031 2 2 12 9 1662 3121 2702 -3032 2 2 12 9 1663 2703 3122 -3033 2 2 12 9 3167 2396 1050 -3034 2 2 12 9 828 3540 1650 -3035 2 2 12 9 649 3547 2813 -3036 2 2 12 9 1154 1919 3001 -3037 2 2 12 9 819 1939 3457 -3038 2 2 12 9 1446 1993 3480 -3039 2 2 12 9 737 1636 2718 -3040 2 2 12 9 738 2719 1637 -3041 2 2 12 9 829 1802 2110 -3042 2 2 12 9 830 2111 1803 -3043 2 2 12 9 1228 2856 3023 -3044 2 2 12 9 518 2278 1964 -3045 2 2 12 9 422 3634 1489 -3046 2 2 12 9 682 2881 1729 -3047 2 2 12 9 640 2149 1602 -3048 2 2 12 9 1414 2895 2586 -3049 2 2 12 9 808 1743 2559 -3050 2 2 12 9 809 2560 1744 -3051 2 2 12 9 972 1518 2912 -3052 2 2 12 9 635 1926 2492 -3053 2 2 12 9 396 2507 1552 -3054 2 2 12 9 623 1468 2888 -3055 2 2 12 9 1077 2273 2219 -3056 2 2 12 9 1078 2220 2274 -3057 2 2 12 9 521 2180 1618 -3058 2 2 12 9 785 1672 2469 -3059 2 2 12 9 501 2084 1902 -3060 2 2 12 9 399 2822 1496 -3061 2 2 12 9 1429 2904 1959 -3062 2 2 12 9 935 1863 2055 -3063 2 2 12 9 619 2586 2895 -3064 2 2 12 9 735 3309 1508 -3065 2 2 12 9 1657 2425 3445 -3066 2 2 12 9 1780 2806 2580 -3067 2 2 12 9 829 2110 3462 -3068 2 2 12 9 830 3463 2111 -3069 2 2 12 9 736 1509 3310 -3070 2 2 12 9 36 3357 1541 -3071 2 2 12 9 185 1542 3358 -3072 2 2 12 9 202 203 2294 -3073 2 2 12 9 758 3305 1759 -3074 2 2 12 9 1021 2799 2533 -3075 2 2 12 9 617 1471 2653 -3076 2 2 12 9 763 2180 1943 -3077 2 2 12 9 801 1840 2664 -3078 2 2 12 9 638 1564 2521 -3079 2 2 12 9 935 2497 2022 -3080 2 2 12 9 942 2131 1630 -3081 2 2 12 9 1387 2373 3446 -3082 2 2 12 9 1388 3447 2374 -3083 2 2 12 9 729 1531 2439 -3084 2 2 12 9 517 1988 2277 -3085 2 2 12 9 950 2213 2155 -3086 2 2 12 9 951 2156 2214 -3087 2 2 12 9 665 1532 2414 -3088 2 2 12 9 1211 2061 1931 -3089 2 2 12 9 723 3596 1560 -3090 2 2 12 9 724 1561 3597 -3091 2 2 12 9 627 1555 2529 -3092 2 2 12 9 864 2984 2480 -3093 2 2 12 9 676 3308 1576 -3094 2 2 12 9 1400 3547 1907 -3095 2 2 12 9 795 2027 1669 -3096 2 2 12 9 1020 2815 2280 -3097 2 2 12 9 955 3526 2562 -3098 2 2 12 9 1038 2479 1748 -3099 2 2 12 9 950 2155 1824 -3100 2 2 12 9 951 1825 2156 -3101 2 2 12 9 7 3101 3261 -3102 2 2 12 9 977 1929 2192 -3103 2 2 12 9 1040 3545 1799 -3104 2 2 12 9 441 2520 1681 -3105 2 2 12 9 1250 1784 3301 -3106 2 2 12 9 31 1504 3129 -3107 2 2 12 9 295 1994 1737 -3108 2 2 12 9 1161 3043 1930 -3109 2 2 12 9 3510 364 2334 -3110 2 2 12 9 806 2502 1761 -3111 2 2 12 9 807 1762 2503 -3112 2 2 12 9 534 2235 2908 -3113 2 2 12 9 1340 3390 2514 -3114 2 2 12 9 396 2905 3517 -3115 2 2 12 9 1501 2522 3441 -3116 2 2 12 9 1613 3505 2841 -3117 2 2 12 9 1799 3545 2650 -3118 2 2 12 9 3505 691 2841 -3119 2 2 12 9 691 2484 1692 -3120 2 2 12 9 462 1769 2188 -3121 2 2 12 9 787 1493 2552 -3122 2 2 12 9 1221 3429 2505 -3123 2 2 12 9 865 1920 2062 -3124 2 2 12 9 862 2346 2066 -3125 2 2 12 9 829 2277 1609 -3126 2 2 12 9 614 1585 2618 -3127 2 2 12 9 830 1610 2278 -3128 2 2 12 9 615 2619 1586 -3129 2 2 12 9 1029 2037 1902 -3130 2 2 12 9 822 1665 2075 -3131 2 2 12 9 774 2055 1863 -3132 2 2 12 9 1326 3026 2193 -3133 2 2 12 9 426 2301 1606 -3134 2 2 12 9 427 1607 2302 -3135 2 2 12 9 548 3585 1593 -3136 2 2 12 9 1076 1632 3069 -3137 2 2 12 9 1269 3632 1789 -3138 2 2 12 9 759 1677 2620 -3139 2 2 12 9 1170 3537 1664 -3140 2 2 12 9 983 1493 2950 -3141 2 2 12 9 411 2234 1780 -3142 2 2 12 9 777 2115 3266 -3143 2 2 12 9 700 1822 3533 -3144 2 2 12 9 776 2568 2114 -3145 2 2 12 9 258 259 1868 -3146 2 2 12 9 317 318 1869 -3147 2 2 12 9 566 2455 1621 -3148 2 2 12 9 473 2570 1471 -3149 2 2 12 9 999 1555 2857 -3150 2 2 12 9 585 3187 3628 -3151 2 2 12 9 278 1635 3044 -3152 2 2 12 9 780 2049 3600 -3153 2 2 12 9 469 1723 2165 -3154 2 2 12 9 961 3220 1578 -3155 2 2 12 9 420 1550 2862 -3156 2 2 12 9 1603 2872 2845 -3157 2 2 12 9 421 2864 1551 -3158 2 2 12 9 617 3005 1490 -3159 2 2 12 9 466 2473 2424 -3160 2 2 12 9 847 2994 1533 -3161 2 2 12 9 848 1534 2995 -3162 2 2 12 9 795 1669 2345 -3163 2 2 12 9 827 1982 2870 -3164 2 2 12 9 1008 2157 2268 -3165 2 2 12 9 454 1824 2155 -3166 2 2 12 9 455 2156 1825 -3167 2 2 12 9 879 2874 1538 -3168 2 2 12 9 1166 1643 3613 -3169 2 2 12 9 790 3196 1496 -3170 2 2 12 9 607 1483 2736 -3171 2 2 12 9 475 2702 3121 -3172 2 2 12 9 476 3122 2703 -3173 2 2 12 9 1185 2079 1689 -3174 2 2 12 9 660 2949 1526 -3175 2 2 12 9 1383 3593 3307 -3176 2 2 12 9 726 1674 2092 -3177 2 2 12 9 39 40 2126 -3178 2 2 12 9 1478 1984 3464 -3179 2 2 12 9 181 182 2127 -3180 2 2 12 9 727 1622 2223 -3181 2 2 12 9 900 1883 2013 -3182 2 2 12 9 728 2224 1623 -3183 2 2 12 9 923 1743 2600 -3184 2 2 12 9 924 2601 1744 -3185 2 2 12 9 663 2266 2758 -3186 2 2 12 9 664 2759 2267 -3187 2 2 12 9 1507 3600 2049 -3188 2 2 12 9 808 1721 3243 -3189 2 2 12 9 809 3244 1722 -3190 2 2 12 9 1770 2139 2911 -3191 2 2 12 9 506 2540 2161 -3192 2 2 12 9 507 2162 2541 -3193 2 2 12 9 820 2219 2273 -3194 2 2 12 9 821 2274 2220 -3195 2 2 12 9 1424 2577 3074 -3196 2 2 12 9 920 1539 2584 -3197 2 2 12 9 1090 3171 1658 -3198 2 2 12 9 1091 1659 3172 -3199 2 2 12 9 1014 2973 1513 -3200 2 2 12 9 1204 2462 2866 -3201 2 2 12 9 1116 2420 2701 -3202 2 2 12 9 880 2084 1720 -3203 2 2 12 9 205 206 3068 -3204 2 2 12 9 1485 3379 2116 -3205 2 2 12 9 720 1961 1845 -3206 2 2 12 9 732 3264 1684 -3207 2 2 12 9 486 2797 2120 -3208 2 2 12 9 487 2121 2798 -3209 2 2 12 9 422 1530 2898 -3210 2 2 12 9 1049 2492 1926 -3211 2 2 12 9 1759 3305 1928 -3212 2 2 12 9 709 3013 2060 -3213 2 2 12 9 1073 1728 2066 -3214 2 2 12 9 1079 3194 1535 -3215 2 2 12 9 13 14 1910 -3216 2 2 12 9 1295 2925 2767 -3217 2 2 12 9 846 2977 2086 -3218 2 2 12 9 804 2029 1774 -3219 2 2 12 9 831 2181 1640 -3220 2 2 12 9 606 2198 1882 -3221 2 2 12 9 864 2480 2251 -3222 2 2 12 9 444 3211 1558 -3223 2 2 12 9 937 2826 2821 -3224 2 2 12 9 2115 3489 3266 -3225 2 2 12 9 1424 3074 2821 -3226 2 2 12 9 871 2510 1558 -3227 2 2 12 9 886 2438 3194 -3228 2 2 12 9 423 1590 3048 -3229 2 2 12 9 468 3417 1474 -3230 2 2 12 9 864 2116 2046 -3231 2 2 12 9 628 1999 2795 -3232 2 2 12 9 832 1940 2296 -3233 2 2 12 9 755 1983 3054 -3234 2 2 12 9 438 2193 3026 -3235 2 2 12 9 797 1524 3189 -3236 2 2 12 9 16 2671 2283 -3237 2 2 12 9 611 3074 2577 -3238 2 2 12 9 840 1658 3171 -3239 2 2 12 9 841 3172 1659 -3240 2 2 12 9 1115 2511 1992 -3241 2 2 12 9 1017 2201 2908 -3242 2 2 12 9 1510 3443 3385 -3243 2 2 12 9 1511 3386 3444 -3244 2 2 12 9 799 3188 1525 -3245 2 2 12 9 428 1577 3449 -3246 2 2 12 9 1183 2424 2473 -3247 2 2 12 9 1313 3561 3132 -3248 2 2 12 9 567 2010 1878 -3249 2 2 12 9 1314 3133 3562 -3250 2 2 12 9 407 3001 1919 -3251 2 2 12 9 1379 1837 2506 -3252 2 2 12 9 396 1552 2632 -3253 2 2 12 9 808 3243 1743 -3254 2 2 12 9 809 1744 3244 -3255 2 2 12 9 613 2176 3356 -3256 2 2 12 9 1260 3173 2938 -3257 2 2 12 9 1261 2939 3174 -3258 2 2 12 9 470 2683 1538 -3259 2 2 12 9 948 2910 3531 -3260 2 2 12 9 1582 3200 3567 -3261 2 2 12 9 1583 3568 3201 -3262 2 2 12 9 697 1930 3043 -3263 2 2 12 9 669 2328 1770 -3264 2 2 12 9 1098 2623 1670 -3265 2 2 12 9 512 2174 1656 -3266 2 2 12 9 948 3531 1867 -3267 2 2 12 9 1477 3356 2176 -3268 2 2 12 9 867 1620 2409 -3269 2 2 12 9 1675 2014 3381 -3270 2 2 12 9 876 1621 2455 -3271 2 2 12 9 958 2750 2726 -3272 2 2 12 9 921 1613 2841 -3273 2 2 12 9 653 1664 3537 -3274 2 2 12 9 549 2227 1611 -3275 2 2 12 9 389 1944 2616 -3276 2 2 12 9 1103 3014 3249 -3277 2 2 12 9 1111 2022 2497 -3278 2 2 12 9 539 2286 1634 -3279 2 2 12 9 963 2602 3275 -3280 2 2 12 9 1009 3630 1827 -3281 2 2 12 9 857 1998 2392 -3282 2 2 12 9 1051 1791 3477 -3283 2 2 12 9 1129 1763 3437 -3284 2 2 12 9 826 2164 1814 -3285 2 2 12 9 1271 1700 2215 -3286 2 2 12 9 1272 2216 1701 -3287 2 2 12 9 545 3635 1570 -3288 2 2 12 9 792 2735 1782 -3289 2 2 12 9 804 1777 2379 -3290 2 2 12 9 699 1544 3301 -3291 2 2 12 9 860 2142 1660 -3292 2 2 12 9 861 1661 2143 -3293 2 2 12 9 649 2425 1907 -3294 2 2 12 9 1352 1670 2623 -3295 2 2 12 9 1678 3510 2334 -3296 2 2 12 9 1015 3200 1816 -3297 2 2 12 9 1016 1817 3201 -3298 2 2 12 9 920 2584 1562 -3299 2 2 12 9 621 2845 2872 -3300 2 2 12 9 742 2606 1544 -3301 2 2 12 9 765 3131 2179 -3302 2 2 12 9 642 2993 2108 -3303 2 2 12 9 892 3546 3486 -3304 2 2 12 9 1186 1638 3345 -3305 2 2 12 9 1152 3044 1635 -3306 2 2 12 9 460 3459 3515 -3307 2 2 12 9 838 3265 1581 -3308 2 2 12 9 438 3026 1492 -3309 2 2 12 9 813 2518 2188 -3310 2 2 12 9 660 3020 1570 -3311 2 2 12 9 931 2134 2086 -3312 2 2 12 9 1052 2428 2140 -3313 2 2 12 9 695 3352 1594 -3314 2 2 12 9 1207 3285 1839 -3315 2 2 12 9 1203 3077 2964 -3316 2 2 12 9 515 2055 1705 -3317 2 2 12 9 480 2972 1872 -3318 2 2 12 9 801 2664 2013 -3319 2 2 12 9 402 2015 2527 -3320 2 2 12 9 1018 1515 2940 -3321 2 2 12 9 914 2206 2707 -3322 2 2 12 9 1100 2336 1600 -3323 2 2 12 9 1101 1601 2337 -3324 2 2 12 9 464 1796 2011 -3325 2 2 12 9 465 2012 1797 -3326 2 2 12 9 555 2482 1673 -3327 2 2 12 9 1284 2060 3013 -3328 2 2 12 9 340 2593 1522 -3329 2 2 12 9 1246 2772 2212 -3330 2 2 12 9 854 2163 3388 -3331 2 2 12 9 701 1635 2855 -3332 2 2 12 9 1020 2596 3642 -3333 2 2 12 9 847 1565 2994 -3334 2 2 12 9 848 2995 1566 -3335 2 2 12 9 478 2573 2129 -3336 2 2 12 9 479 2130 2574 -3337 2 2 12 9 1074 1558 3211 -3338 2 2 12 9 869 2898 1530 -3339 2 2 12 9 1268 2352 3306 -3340 2 2 12 9 815 1698 2388 -3341 2 2 12 9 673 2826 2298 -3342 2 2 12 9 816 2389 1699 -3343 2 2 12 9 341 3441 2522 -3344 2 2 12 9 887 1780 2234 -3345 2 2 12 9 909 1559 2699 -3346 2 2 12 9 621 1839 3285 -3347 2 2 12 9 776 2133 2568 -3348 2 2 12 9 796 2032 1702 -3349 2 2 12 9 904 1494 3454 -3350 2 2 12 9 876 2580 3306 -3351 2 2 12 9 905 3455 1495 -3352 2 2 12 9 1139 2568 2133 -3353 2 2 12 9 799 2038 1732 -3354 2 2 12 9 1318 2758 2266 -3355 2 2 12 9 1319 2267 2759 -3356 2 2 12 9 1196 1643 3104 -3357 2 2 12 9 896 1770 2328 -3358 2 2 12 9 565 2828 2042 -3359 2 2 12 9 488 2805 2200 -3360 2 2 12 9 1054 1572 2723 -3361 2 2 12 9 641 1629 3404 -3362 2 2 12 9 52 1721 3218 -3363 2 2 12 9 169 3219 1722 -3364 2 2 12 9 458 3348 2504 -3365 2 2 12 9 764 3499 2005 -3366 2 2 12 9 673 1671 2826 -3367 2 2 12 9 47 48 2051 -3368 2 2 12 9 173 174 2052 -3369 2 2 12 9 456 2606 1739 -3370 2 2 12 9 797 3189 1592 -3371 2 2 12 9 1073 2066 2346 -3372 2 2 12 9 684 3113 3185 -3373 2 2 12 9 1004 2023 1861 -3374 2 2 12 9 1005 1862 2024 -3375 2 2 12 9 1849 2861 3595 -3376 2 2 12 9 430 1569 3269 -3377 2 2 12 9 434 1565 2712 -3378 2 2 12 9 435 2713 1566 -3379 2 2 12 9 680 1619 2327 -3380 2 2 12 9 672 3238 1778 -3381 2 2 12 9 983 3028 1493 -3382 2 2 12 9 643 3613 1643 -3383 2 2 12 9 543 3200 1582 -3384 2 2 12 9 544 1583 3201 -3385 2 2 12 9 756 1904 3279 -3386 2 2 12 9 358 2714 3470 -3387 2 2 12 9 757 3280 1905 -3388 2 2 12 9 871 1558 2695 -3389 2 2 12 9 454 2155 1888 -3390 2 2 12 9 1060 1729 2145 -3391 2 2 12 9 455 1889 2156 -3392 2 2 12 9 855 2268 2157 -3393 2 2 12 9 488 2093 2805 -3394 2 2 12 9 1069 3522 1596 -3395 2 2 12 9 1357 2486 1700 -3396 2 2 12 9 1358 1701 2487 -3397 2 2 12 9 535 3429 2854 -3398 2 2 12 9 660 1526 3020 -3399 2 2 12 9 415 2145 1729 -3400 2 2 12 9 803 2212 2772 -3401 2 2 12 9 799 1595 3188 -3402 2 2 12 9 1054 2571 1572 -3403 2 2 12 9 917 1882 2198 -3404 2 2 12 9 1097 1591 3250 -3405 2 2 12 9 1207 3038 1934 -3406 2 2 12 9 911 2440 2094 -3407 2 2 12 9 912 2095 2441 -3408 2 2 12 9 641 1592 3189 -3409 2 2 12 9 1076 1646 2446 -3410 2 2 12 9 272 2903 1647 -3411 2 2 12 9 1013 2891 1860 -3412 2 2 12 9 976 3020 1526 -3413 2 2 12 9 729 2175 1826 -3414 2 2 12 9 1674 2071 3256 -3415 2 2 12 9 383 2470 1556 -3416 2 2 12 9 1108 2042 2828 -3417 2 2 12 9 937 2821 3074 -3418 2 2 12 9 1002 2643 1573 -3419 2 2 12 9 937 3008 2826 -3420 2 2 12 9 808 3218 1721 -3421 2 2 12 9 809 1722 3219 -3422 2 2 12 9 535 2445 3429 -3423 2 2 12 9 1014 1809 2757 -3424 2 2 12 9 1602 1930 3474 -3425 2 2 12 9 1012 1963 2976 -3426 2 2 12 9 347 2595 2699 -3427 2 2 12 9 817 2589 1741 -3428 2 2 12 9 1486 3185 3113 -3429 2 2 12 9 940 1549 2380 -3430 2 2 12 9 501 1902 2037 -3431 2 2 12 9 888 2062 1920 -3432 2 2 12 9 814 1604 2493 -3433 2 2 12 9 964 1528 2936 -3434 2 2 12 9 965 2937 1529 -3435 2 2 12 9 554 2517 2997 -3436 2 2 12 9 558 2837 2100 -3437 2 2 12 9 375 2187 1753 -3438 2 2 12 9 492 1652 3536 -3439 2 2 12 9 1052 3193 1712 -3440 2 2 12 9 644 3407 1642 -3441 2 2 12 9 833 1782 2124 -3442 2 2 12 9 1604 2883 1024 -3443 2 2 12 9 931 3302 1512 -3444 2 2 12 9 453 2628 1555 -3445 2 2 12 9 1014 2184 3442 -3446 2 2 12 9 644 3188 1595 -3447 2 2 12 9 1938 2546 3498 -3448 2 2 12 9 480 1690 2972 -3449 2 2 12 9 304 305 2535 -3450 2 2 12 9 1477 3202 3399 -3451 2 2 12 9 890 1662 2702 -3452 2 2 12 9 891 2703 1663 -3453 2 2 12 9 1184 2251 2480 -3454 2 2 12 9 646 2824 2315 -3455 2 2 12 9 1379 3278 1879 -3456 2 2 12 9 752 1892 2979 -3457 2 2 12 9 846 2086 2134 -3458 2 2 12 9 753 2980 1893 -3459 2 2 12 9 714 2928 1639 -3460 2 2 12 9 1225 2100 2837 -3461 2 2 12 9 276 277 2238 -3462 2 2 12 9 411 1780 2240 -3463 2 2 12 9 956 2596 2280 -3464 2 2 12 9 537 2871 2226 -3465 2 2 12 9 189 190 2068 -3466 2 2 12 9 2082 2559 3558 -3467 2 2 12 9 2083 3559 2560 -3468 2 2 12 9 1189 2795 1999 -3469 2 2 12 9 1121 2739 2043 -3470 2 2 12 9 1122 2044 2740 -3471 2 2 12 9 975 2513 3003 -3472 2 2 12 9 933 1619 2842 -3473 2 2 12 9 272 1647 3148 -3474 2 2 12 9 641 3432 1629 -3475 2 2 12 9 346 1856 2657 -3476 2 2 12 9 498 2475 1966 -3477 2 2 12 9 744 1533 2994 -3478 2 2 12 9 745 2995 1534 -3479 2 2 12 9 925 2215 1700 -3480 2 2 12 9 926 1701 2216 -3481 2 2 12 9 916 2872 1603 -3482 2 2 12 9 1507 2049 2717 -3483 2 2 12 9 1247 3465 2067 -3484 2 2 12 9 660 1570 2998 -3485 2 2 12 9 710 1598 3466 -3486 2 2 12 9 711 3467 1599 -3487 2 2 12 9 1053 2285 1611 -3488 2 2 12 9 895 2460 1593 -3489 2 2 12 9 186 1632 2399 -3490 2 2 12 9 595 1559 2634 -3491 2 2 12 9 851 1634 2300 -3492 2 2 12 9 1121 2025 3319 -3493 2 2 12 9 1122 3320 2026 -3494 2 2 12 9 469 1553 2679 -3495 2 2 12 9 346 2253 1856 -3496 2 2 12 9 197 2454 1580 -3497 2 2 12 9 703 1789 3632 -3498 2 2 12 9 523 2124 1782 -3499 2 2 12 9 820 2273 3369 -3500 2 2 12 9 821 3370 2274 -3501 2 2 12 9 457 3316 1955 -3502 2 2 12 9 749 2061 2851 -3503 2 2 12 9 1161 2488 1683 -3504 2 2 12 9 986 3466 1598 -3505 2 2 12 9 987 1599 3467 -3506 2 2 12 9 727 3311 1622 -3507 2 2 12 9 728 1623 3312 -3508 2 2 12 9 1172 3354 2159 -3509 2 2 12 9 680 2842 1619 -3510 2 2 12 9 800 1875 2018 -3511 2 2 12 9 1364 3112 3242 -3512 2 2 12 9 1378 3526 2812 -3513 2 2 12 9 801 2013 1883 -3514 2 2 12 9 241 2600 1743 -3515 2 2 12 9 335 1744 2601 -3516 2 2 12 9 642 2684 2993 -3517 2 2 12 9 583 3085 2233 -3518 2 2 12 9 1141 3404 1629 -3519 2 2 12 9 883 3363 1666 -3520 2 2 12 9 279 280 1971 -3521 2 2 12 9 359 3024 1546 -3522 2 2 12 9 1234 2039 2233 -3523 2 2 12 9 707 2745 2255 -3524 2 2 12 9 708 2256 2746 -3525 2 2 12 9 868 1878 2010 -3526 2 2 12 9 419 3165 1870 -3527 2 2 12 9 1282 2517 3255 -3528 2 2 12 9 808 1766 3218 -3529 2 2 12 9 809 3219 1767 -3530 2 2 12 9 844 2160 2218 -3531 2 2 12 9 904 2155 2213 -3532 2 2 12 9 905 2214 2156 -3533 2 2 12 9 984 2686 2341 -3534 2 2 12 9 518 1675 3153 -3535 2 2 12 9 719 3124 1628 -3536 2 2 12 9 1321 1984 3161 -3537 2 2 12 9 1235 2707 2206 -3538 2 2 12 9 1606 2301 3066 -3539 2 2 12 9 1607 3067 2302 -3540 2 2 12 9 673 1633 2889 -3541 2 2 12 9 1273 2609 1828 -3542 2 2 12 9 1065 3349 2249 -3543 2 2 12 9 638 3481 2846 -3544 2 2 12 9 683 1563 3167 -3545 2 2 12 9 920 2774 1539 -3546 2 2 12 9 1107 2527 2015 -3547 2 2 12 9 1557 3178 1939 -3548 2 2 12 9 1090 1658 2449 -3549 2 2 12 9 652 1522 3157 -3550 2 2 12 9 1091 2450 1659 -3551 2 2 12 9 831 1645 2412 -3552 2 2 12 9 636 1746 3364 -3553 2 2 12 9 854 3388 2474 -3554 2 2 12 9 1074 3283 1558 -3555 2 2 12 9 789 2454 1783 -3556 2 2 12 9 1333 2298 2826 -3557 2 2 12 9 481 1585 2325 -3558 2 2 12 9 482 2326 1586 -3559 2 2 12 9 859 2187 1894 -3560 2 2 12 9 804 2004 2029 -3561 2 2 12 9 221 222 2230 -3562 2 2 12 9 449 1866 3123 -3563 2 2 12 9 1545 3387 3400 -3564 2 2 12 9 1086 2616 1944 -3565 2 2 12 9 644 1642 3458 -3566 2 2 12 9 1317 2233 3600 -3567 2 2 12 9 764 2176 3499 -3568 2 2 12 9 909 2811 1914 -3569 2 2 12 9 434 1574 2987 -3570 2 2 12 9 435 2988 1575 -3571 2 2 12 9 772 2704 3178 -3572 2 2 12 9 1313 3132 2434 -3573 2 2 12 9 533 2543 1631 -3574 2 2 12 9 1314 2435 3133 -3575 2 2 12 9 1062 2709 2907 -3576 2 2 12 9 1133 1924 2960 -3577 2 2 12 9 1134 2961 1925 -3578 2 2 12 9 916 1603 2951 -3579 2 2 12 9 945 2140 2428 -3580 2 2 12 9 1207 3300 3038 -3581 2 2 12 9 932 2239 1833 -3582 2 2 12 9 1009 2542 3630 -3583 2 2 12 9 693 3487 2460 -3584 2 2 12 9 426 1606 2875 -3585 2 2 12 9 427 2876 1607 -3586 2 2 12 9 522 2348 2539 -3587 2 2 12 9 378 2668 1688 -3588 2 2 12 9 440 1539 2774 -3589 2 2 12 9 563 1650 3421 -3590 2 2 12 9 867 2614 1620 -3591 2 2 12 9 645 1594 3507 -3592 2 2 12 9 718 2247 3577 -3593 2 2 12 9 700 1590 2499 -3594 2 2 12 9 464 2011 2288 -3595 2 2 12 9 465 2289 2012 -3596 2 2 12 9 307 2357 1703 -3597 2 2 12 9 502 2082 3558 -3598 2 2 12 9 503 3559 2083 -3599 2 2 12 9 1022 1966 2475 -3600 2 2 12 9 3344 1604 1024 -3601 2 2 12 9 1038 1748 3120 -3602 2 2 12 9 657 1795 2341 -3603 2 2 12 9 239 3243 1721 -3604 2 2 12 9 337 1722 3244 -3605 2 2 12 9 42 1800 3083 -3606 2 2 12 9 179 3084 1801 -3607 2 2 12 9 371 3385 3443 -3608 2 2 12 9 744 2994 1565 -3609 2 2 12 9 372 3444 3386 -3610 2 2 12 9 745 1566 2995 -3611 2 2 12 9 760 1816 2137 -3612 2 2 12 9 761 2138 1817 -3613 2 2 12 9 283 2932 1733 -3614 2 2 12 9 843 1629 3432 -3615 2 2 12 9 997 3637 1660 -3616 2 2 12 9 998 1661 3638 -3617 2 2 12 9 1331 2229 3249 -3618 2 2 12 9 842 2109 2200 -3619 2 2 12 9 1142 1642 3407 -3620 2 2 12 9 1594 3352 2522 -3621 2 2 12 9 698 2396 1689 -3622 2 2 12 9 782 2259 1624 -3623 2 2 12 9 1864 2152 3203 -3624 2 2 12 9 1816 3200 2137 -3625 2 2 12 9 839 2475 1823 -3626 2 2 12 9 1817 2138 3201 -3627 2 2 12 9 518 3246 1675 -3628 2 2 12 9 831 1640 3010 -3629 2 2 12 9 640 1596 3522 -3630 2 2 12 9 914 1673 2482 -3631 2 2 12 9 1536 2907 2709 -3632 2 2 12 9 516 1887 3107 -3633 2 2 12 9 367 3440 1613 -3634 2 2 12 9 263 2515 1786 -3635 2 2 12 9 313 1787 2516 -3636 2 2 12 9 716 3403 1860 -3637 2 2 12 9 294 1737 2959 -3638 2 2 12 9 1361 3289 2561 -3639 2 2 12 9 851 2635 1634 -3640 2 2 12 9 295 296 1994 -3641 2 2 12 9 489 1899 3573 -3642 2 2 12 9 490 3145 1633 -3643 2 2 12 9 805 3433 1681 -3644 2 2 12 9 973 2288 2011 -3645 2 2 12 9 952 2947 1756 -3646 2 2 12 9 1002 1573 2752 -3647 2 2 12 9 974 2012 2289 -3648 2 2 12 9 796 1811 2459 -3649 2 2 12 9 286 3192 1707 -3650 2 2 12 9 907 1553 3071 -3651 2 2 12 9 21 3551 3114 -3652 2 2 12 9 1088 2094 2440 -3653 2 2 12 9 1089 2441 2095 -3654 2 2 12 9 702 2757 1809 -3655 2 2 12 9 1273 3419 2897 -3656 2 2 12 9 24 2385 1720 -3657 2 2 12 9 501 2553 1627 -3658 2 2 12 9 1425 2699 2595 -3659 2 2 12 9 1298 2492 1758 -3660 2 2 12 9 1117 3143 2360 -3661 2 2 12 9 845 3458 1642 -3662 2 2 12 9 719 1747 2530 -3663 2 2 12 9 1150 2887 1979 -3664 2 2 12 9 1593 2460 3487 -3665 2 2 12 9 1360 2248 2787 -3666 2 2 12 9 721 1979 2887 -3667 2 2 12 9 566 1621 2766 -3668 2 2 12 9 658 1537 3111 -3669 2 2 12 9 500 3205 1974 -3670 2 2 12 9 652 1620 2614 -3671 2 2 12 9 2522 3352 1109 -3672 2 2 12 9 244 2651 1710 -3673 2 2 12 9 332 1711 2652 -3674 2 2 12 9 922 2724 1624 -3675 2 2 12 9 947 1621 2352 -3676 2 2 12 9 732 1684 2617 -3677 2 2 12 9 1587 3319 2677 -3678 2 2 12 9 1588 2678 3320 -3679 2 2 12 9 646 3275 1517 -3680 2 2 12 9 1281 2595 2664 -3681 2 2 12 9 723 1698 3596 -3682 2 2 12 9 724 3597 1699 -3683 2 2 12 9 806 1622 2852 -3684 2 2 12 9 394 1727 2879 -3685 2 2 12 9 807 2853 1623 -3686 2 2 12 9 1412 2914 2831 -3687 2 2 12 9 1350 2315 2824 -3688 2 2 12 9 50 1766 2763 -3689 2 2 12 9 171 2764 1767 -3690 2 2 12 9 485 1841 2139 -3691 2 2 12 9 346 2064 3041 -3692 2 2 12 9 666 2554 3461 -3693 2 2 12 9 689 2900 1846 -3694 2 2 12 9 690 1847 2901 -3695 2 2 12 9 1060 2145 3022 -3696 2 2 12 9 802 1552 2948 -3697 2 2 12 9 213 3104 1643 -3698 2 2 12 9 665 2414 1687 -3699 2 2 12 9 1031 1864 2915 -3700 2 2 12 9 539 1634 2635 -3701 2 2 12 9 185 186 2399 -3702 2 2 12 9 713 2446 1646 -3703 2 2 12 9 1360 2768 2237 -3704 2 2 12 9 470 1538 2892 -3705 2 2 12 9 874 2394 1608 -3706 2 2 12 9 755 2078 1985 -3707 2 2 12 9 1877 2462 2909 -3708 2 2 12 9 1073 3115 2211 -3709 2 2 12 9 22 2694 1792 -3710 2 2 12 9 531 2676 3347 -3711 2 2 12 9 519 2388 1698 -3712 2 2 12 9 262 1786 2731 -3713 2 2 12 9 314 2732 1787 -3714 2 2 12 9 520 1699 2389 -3715 2 2 12 9 30 1818 3015 -3716 2 2 12 9 2265 3023 3584 -3717 2 2 12 9 558 2918 1883 -3718 2 2 12 9 1185 2871 2079 -3719 2 2 12 9 390 2352 3374 -3720 2 2 12 9 892 2843 1564 -3721 2 2 12 9 1094 3153 1675 -3722 2 2 12 9 822 2778 1665 -3723 2 2 12 9 907 2679 1553 -3724 2 2 12 9 687 1924 2195 -3725 2 2 12 9 441 1681 2488 -3726 2 2 12 9 688 2196 1925 -3727 2 2 12 9 652 3003 1620 -3728 2 2 12 9 1202 1617 3284 -3729 2 2 12 9 1336 3372 2762 -3730 2 2 12 9 373 3093 2690 -3731 2 2 12 9 892 2498 3546 -3732 2 2 12 9 374 2691 3094 -3733 2 2 12 9 1191 1985 2078 -3734 2 2 12 9 1065 3175 3349 -3735 2 2 12 9 876 2240 1780 -3736 2 2 12 9 508 3399 2168 -3737 2 2 12 9 798 3076 1950 -3738 2 2 12 9 383 1649 2490 -3739 2 2 12 9 1271 2255 2745 -3740 2 2 12 9 1272 2746 2256 -3741 2 2 12 9 836 3431 1719 -3742 2 2 12 9 827 2293 2643 -3743 2 2 12 9 1277 3187 2408 -3744 2 2 12 9 463 1564 2843 -3745 2 2 12 9 466 1657 2473 -3746 2 2 12 9 802 2473 3445 -3747 2 2 12 9 358 2624 1612 -3748 2 2 12 9 603 2970 2902 -3749 2 2 12 9 281 1805 2674 -3750 2 2 12 9 884 2499 1590 -3751 2 2 12 9 380 3380 1591 -3752 2 2 12 9 1256 3470 2035 -3753 2 2 12 9 1170 1664 2484 -3754 2 2 12 9 581 2281 3644 -3755 2 2 12 9 582 3645 2282 -3756 2 2 12 9 256 257 2242 -3757 2 2 12 9 319 320 2243 -3758 2 2 12 9 990 3002 1556 -3759 2 2 12 9 469 2345 1669 -3760 2 2 12 9 1164 2467 2420 -3761 2 2 12 9 722 1653 3138 -3762 2 2 12 9 659 1546 3296 -3763 2 2 12 9 940 3393 1549 -3764 2 2 12 9 244 1710 3602 -3765 2 2 12 9 332 3603 1711 -3766 2 2 12 9 826 1877 2453 -3767 2 2 12 9 1372 1577 3264 -3768 2 2 12 9 291 1738 3270 -3769 2 2 12 9 1027 2708 2019 -3770 2 2 12 9 839 2015 2422 -3771 2 2 12 9 1054 1579 3500 -3772 2 2 12 9 340 3528 1670 -3773 2 2 12 9 493 2838 1970 -3774 2 2 12 9 1265 2829 1584 -3775 2 2 12 9 1263 2252 3633 -3776 2 2 12 9 382 2518 2072 -3777 2 2 12 9 1017 3578 1573 -3778 2 2 12 9 705 3066 1824 -3779 2 2 12 9 706 1825 3067 -3780 2 2 12 9 382 1630 3021 -3781 2 2 12 9 616 2295 3304 -3782 2 2 12 9 2114 2568 3348 -3783 2 2 12 9 363 3120 1748 -3784 2 2 12 9 515 2181 2497 -3785 2 2 12 9 537 2079 2871 -3786 2 2 12 9 2145 3511 3022 -3787 2 2 12 9 813 2188 1769 -3788 2 2 12 9 930 2532 2323 -3789 2 2 12 9 460 3515 1779 -3790 2 2 12 9 865 3184 2303 -3791 2 2 12 9 346 2004 2253 -3792 2 2 12 9 281 3492 1805 -3793 2 2 12 9 517 2685 1988 -3794 2 2 12 9 1413 3261 3101 -3795 2 2 12 9 228 229 2019 -3796 2 2 12 9 1102 2283 2671 -3797 2 2 12 9 1207 1934 3323 -3798 2 2 12 9 985 1687 2414 -3799 2 2 12 9 673 2889 1671 -3800 2 2 12 9 909 2634 1559 -3801 2 2 12 9 641 3404 1592 -3802 2 2 12 9 426 2639 1560 -3803 2 2 12 9 344 1592 3406 -3804 2 2 12 9 427 1561 2640 -3805 2 2 12 9 1008 2218 2160 -3806 2 2 12 9 383 1556 3002 -3807 2 2 12 9 890 2660 1662 -3808 2 2 12 9 891 1663 2661 -3809 2 2 12 9 297 298 2063 -3810 2 2 12 9 516 2361 1871 -3811 2 2 12 9 837 1773 2997 -3812 2 2 12 9 555 2609 2482 -3813 2 2 12 9 378 1768 2668 -3814 2 2 12 9 604 2831 2914 -3815 2 2 12 9 672 1641 3238 -3816 2 2 12 9 35 2469 1672 -3817 2 2 12 9 1494 3050 3454 -3818 2 2 12 9 1495 3455 3051 -3819 2 2 12 9 510 1791 2186 -3820 2 2 12 9 883 2151 2701 -3821 2 2 12 9 1202 3626 1641 -3822 2 2 12 9 347 2664 2595 -3823 2 2 12 9 1842 2380 3391 -3824 2 2 12 9 532 1916 2442 -3825 2 2 12 9 1129 3437 2785 -3826 2 2 12 9 1145 2489 3461 -3827 2 2 12 9 911 3006 1615 -3828 2 2 12 9 912 1616 3007 -3829 2 2 12 9 774 1863 2625 -3830 2 2 12 9 834 2882 1691 -3831 2 2 12 9 872 3238 1641 -3832 2 2 12 9 911 2987 1574 -3833 2 2 12 9 912 1575 2988 -3834 2 2 12 9 7 8 3101 -3835 2 2 12 9 1152 1635 3587 -3836 2 2 12 9 286 1707 2989 -3837 2 2 12 9 860 1660 2377 -3838 2 2 12 9 861 2378 1661 -3839 2 2 12 9 1394 1870 3165 -3840 2 2 12 9 460 1779 2225 -3841 2 2 12 9 818 2205 3249 -3842 2 2 12 9 644 1595 3407 -3843 2 2 12 9 749 1931 2061 -3844 2 2 12 9 228 2019 2708 -3845 2 2 12 9 1103 2807 2112 -3846 2 2 12 9 591 2767 2925 -3847 2 2 12 9 838 2418 1749 -3848 2 2 12 9 1229 2449 1658 -3849 2 2 12 9 1230 1659 2450 -3850 2 2 12 9 1308 3224 2263 -3851 2 2 12 9 1037 2028 2361 -3852 2 2 12 9 493 2686 2838 -3853 2 2 12 9 968 1880 2507 -3854 2 2 12 9 517 3152 1714 -3855 2 2 12 9 932 2258 2239 -3856 2 2 12 9 441 3273 2520 -3857 2 2 12 9 946 2957 1792 -3858 2 2 12 9 752 2103 1892 -3859 2 2 12 9 753 1893 2104 -3860 2 2 12 9 1301 2985 2692 -3861 2 2 12 9 1302 2693 2986 -3862 2 2 12 9 1114 1988 2685 -3863 2 2 12 9 1065 2349 1771 -3864 2 2 12 9 629 3400 3387 -3865 2 2 12 9 512 1656 2717 -3866 2 2 12 9 1051 1733 2932 -3867 2 2 12 9 478 3016 2573 -3868 2 2 12 9 479 2574 3017 -3869 2 2 12 9 1568 3515 3459 -3870 2 2 12 9 904 1888 2155 -3871 2 2 12 9 905 2156 1889 -3872 2 2 12 9 1066 2320 1941 -3873 2 2 12 9 1067 1942 2321 -3874 2 2 12 9 1341 2445 1983 -3875 2 2 12 9 3319 650 2677 -3876 2 2 12 9 584 2263 3224 -3877 2 2 12 9 3320 2678 651 -3878 2 2 12 9 828 2190 3540 -3879 2 2 12 9 1657 3445 2473 -3880 2 2 12 9 880 1720 2385 -3881 2 2 12 9 386 2785 1644 -3882 2 2 12 9 1179 3081 2410 -3883 2 2 12 9 1180 2411 3082 -3884 2 2 12 9 496 2952 2727 -3885 2 2 12 9 553 2806 1638 -3886 2 2 12 9 991 2200 2109 -3887 2 2 12 9 1059 2959 1737 -3888 2 2 12 9 504 1906 2199 -3889 2 2 12 9 460 3647 1914 -3890 2 2 12 9 256 2242 2043 -3891 2 2 12 9 320 2044 2243 -3892 2 2 12 9 1273 2482 2609 -3893 2 2 12 9 198 1783 2454 -3894 2 2 12 9 898 2029 2004 -3895 2 2 12 9 847 2591 1857 -3896 2 2 12 9 848 1858 2592 -3897 2 2 12 9 942 2239 2131 -3898 2 2 12 9 714 1639 3004 -3899 2 2 12 9 768 2375 3293 -3900 2 2 12 9 769 3294 2376 -3901 2 2 12 9 684 3185 1644 -3902 2 2 12 9 570 3099 2400 -3903 2 2 12 9 935 2055 2497 -3904 2 2 12 9 658 1665 2815 -3905 2 2 12 9 1025 1676 2368 -3906 2 2 12 9 828 1813 2511 -3907 2 2 12 9 844 2621 2160 -3908 2 2 12 9 832 2296 2556 -3909 2 2 12 9 556 2638 2201 -3910 2 2 12 9 1120 1943 2180 -3911 2 2 12 9 420 2610 1696 -3912 2 2 12 9 421 1697 2611 -3913 2 2 12 9 451 2434 1997 -3914 2 2 12 9 452 2000 2435 -3915 2 2 12 9 1263 3633 1908 -3916 2 2 12 9 1354 2211 3115 -3917 2 2 12 9 1276 2531 3434 -3918 2 2 12 9 773 2915 1864 -3919 2 2 12 9 1031 2384 2451 -3920 2 2 12 9 1032 2452 2386 -3921 2 2 12 9 596 1808 2663 -3922 2 2 12 9 608 2074 2917 -3923 2 2 12 9 875 1656 2398 -3924 2 2 12 9 1349 2442 1916 -3925 2 2 12 9 514 1704 2299 -3926 2 2 12 9 511 2749 2134 -3927 2 2 12 9 1405 2659 3468 -3928 2 2 12 9 550 2420 2467 -3929 2 2 12 9 1021 2244 2799 -3930 2 2 12 9 692 1678 2924 -3931 2 2 12 9 984 2341 1795 -3932 2 2 12 9 252 253 2088 -3933 2 2 12 9 323 324 2089 -3934 2 2 12 9 620 1838 2762 -3935 2 2 12 9 630 1662 2660 -3936 2 2 12 9 668 1812 3251 -3937 2 2 12 9 631 2661 1663 -3938 2 2 12 9 1183 3260 1597 -3939 2 2 12 9 886 1627 2553 -3940 2 2 12 9 291 2953 1738 -3941 2 2 12 9 872 2359 1778 -3942 2 2 12 9 11 12 2153 -3943 2 2 12 9 1132 3399 3202 -3944 2 2 12 9 1187 1804 2236 -3945 2 2 12 9 1530 2887 1752 -3946 2 2 12 9 51 52 3218 -3947 2 2 12 9 169 170 3219 -3948 2 2 12 9 568 2178 3049 -3949 2 2 12 9 217 218 2067 -3950 2 2 12 9 674 2128 1995 -3951 2 2 12 9 246 1660 3637 -3952 2 2 12 9 330 3638 1661 -3953 2 2 12 9 829 1900 2277 -3954 2 2 12 9 830 2278 1901 -3955 2 2 12 9 947 2766 1621 -3956 2 2 12 9 605 1674 3256 -3957 2 2 12 9 931 2045 2372 -3958 2 2 12 9 32 1950 3076 -3959 2 2 12 9 260 1843 2688 -3960 2 2 12 9 316 2689 1844 -3961 2 2 12 9 450 2119 2531 -3962 2 2 12 9 200 3497 2354 -3963 2 2 12 9 882 2077 3103 -3964 2 2 12 9 911 1615 2987 -3965 2 2 12 9 912 2988 1616 -3966 2 2 12 9 529 1778 2359 -3967 2 2 12 9 448 3604 1584 -3968 2 2 12 9 563 2324 1836 -3969 2 2 12 9 680 1612 2842 -3970 2 2 12 9 383 3002 1649 -3971 2 2 12 9 555 1673 3160 -3972 2 2 12 9 806 1761 2862 -3973 2 2 12 9 1262 3041 2064 -3974 2 2 12 9 807 2864 1762 -3975 2 2 12 9 719 2530 1835 -3976 2 2 12 9 826 1814 2866 -3977 2 2 12 9 562 1658 2641 -3978 2 2 12 9 564 2642 1659 -3979 2 2 12 9 1333 2826 3008 -3980 2 2 12 9 714 1706 2928 -3981 2 2 12 9 823 2275 1854 -3982 2 2 12 9 824 1855 2276 -3983 2 2 12 9 6 2956 214 -3984 2 2 12 9 206 207 2306 -3985 2 2 12 9 382 2680 2518 -3986 2 2 12 9 835 1841 3485 -3987 2 2 12 9 35 36 2469 -3988 2 2 12 9 368 1742 2742 -3989 2 2 12 9 1172 2159 3598 -3990 2 2 12 9 1081 3083 1800 -3991 2 2 12 9 1082 1801 3084 -3992 2 2 12 9 806 2852 2502 -3993 2 2 12 9 807 2503 2853 -3994 2 2 12 9 678 2087 3267 -3995 2 2 12 9 1635 1971 2855 -3996 2 2 12 9 429 2830 1809 -3997 2 2 12 9 471 2379 1777 -3998 2 2 12 9 876 3306 1621 -3999 2 2 12 9 879 2490 1649 -4000 2 2 12 9 1098 2284 2124 -4001 2 2 12 9 1308 2149 3224 -4002 2 2 12 9 400 3323 1934 -4003 2 2 12 9 1250 2279 1784 -4004 2 2 12 9 14 15 2954 -4005 2 2 12 9 1306 2838 2686 -4006 2 2 12 9 375 1753 2496 -4007 2 2 12 9 502 3558 1654 -4008 2 2 12 9 503 1655 3559 -4009 2 2 12 9 1264 2439 1927 -4010 2 2 12 9 942 1833 2239 -4011 2 2 12 9 953 2677 2404 -4012 2 2 12 9 954 2405 2678 -4013 2 2 12 9 1111 2497 2181 -4014 2 2 12 9 1292 2899 3615 -4015 2 2 12 9 387 1758 3151 -4016 2 2 12 9 1093 1714 3152 -4017 2 2 12 9 1337 2481 3514 -4018 2 2 12 9 1203 2190 3077 -4019 2 2 12 9 549 1611 3191 -4020 2 2 12 9 870 2567 2295 -4021 2 2 12 9 490 1913 3145 -4022 2 2 12 9 995 3132 1696 -4023 2 2 12 9 996 1697 3133 -4024 2 2 12 9 202 2294 3231 -4025 2 2 12 9 1003 2327 1932 -4026 2 2 12 9 737 2001 2710 -4027 2 2 12 9 738 2711 2002 -4028 2 2 12 9 624 3493 1667 -4029 2 2 12 9 625 1668 3494 -4030 2 2 12 9 839 3272 2421 -4031 2 2 12 9 470 2892 1648 -4032 2 2 12 9 913 1871 2361 -4033 2 2 12 9 879 1649 2874 -4034 2 2 12 9 836 1719 2431 -4035 2 2 12 9 715 1974 2803 -4036 2 2 12 9 1263 2791 2734 -4037 2 2 12 9 950 2301 2754 -4038 2 2 12 9 951 2755 2302 -4039 2 2 12 9 1465 3618 2591 -4040 2 2 12 9 1466 2592 3619 -4041 2 2 12 9 822 1768 2779 -4042 2 2 12 9 843 3432 1745 -4043 2 2 12 9 1093 2406 1714 -4044 2 2 12 9 493 1628 2850 -4045 2 2 12 9 1350 3496 1677 -4046 2 2 12 9 494 1694 2587 -4047 2 2 12 9 616 1923 2295 -4048 2 2 12 9 495 2588 1695 -4049 2 2 12 9 925 1700 2486 -4050 2 2 12 9 742 1837 2975 -4051 2 2 12 9 926 2487 1701 -4052 2 2 12 9 881 2310 3097 -4053 2 2 12 9 22 23 2694 -4054 2 2 12 9 817 1644 3185 -4055 2 2 12 9 795 2345 2036 -4056 2 2 12 9 205 3068 1853 -4057 2 2 12 9 973 2525 2816 -4058 2 2 12 9 974 2817 2526 -4059 2 2 12 9 713 1675 2446 -4060 2 2 12 9 936 3506 1603 -4061 2 2 12 9 1013 1856 2253 -4062 2 2 12 9 1098 1670 3528 -4063 2 2 12 9 845 1751 3458 -4064 2 2 12 9 230 231 2076 -4065 2 2 12 9 1009 2372 2045 -4066 2 2 12 9 395 2285 3290 -4067 2 2 12 9 1027 3628 1682 -4068 2 2 12 9 357 1749 2418 -4069 2 2 12 9 1209 2521 1757 -4070 2 2 12 9 850 1724 2924 -4071 2 2 12 9 883 2701 2347 -4072 2 2 12 9 854 2474 3255 -4073 2 2 12 9 985 3110 1687 -4074 2 2 12 9 1141 1629 2697 -4075 2 2 12 9 1155 3251 1812 -4076 2 2 12 9 1077 2710 2001 -4077 2 2 12 9 1078 2002 2711 -4078 2 2 12 9 765 2578 1670 -4079 2 2 12 9 863 1731 2348 -4080 2 2 12 9 929 2366 2057 -4081 2 2 12 9 805 1681 2520 -4082 2 2 12 9 930 2058 2367 -4083 2 2 12 9 779 1688 2668 -4084 2 2 12 9 1055 3107 1887 -4085 2 2 12 9 1072 2199 1906 -4086 2 2 12 9 1285 2085 3460 -4087 2 2 12 9 868 2561 3289 -4088 2 2 12 9 971 1738 2904 -4089 2 2 12 9 678 3643 2087 -4090 2 2 12 9 591 2669 1832 -4091 2 2 12 9 700 2499 1822 -4092 2 2 12 9 550 2701 2420 -4093 2 2 12 9 811 1836 2324 -4094 2 2 12 9 1228 3023 2265 -4095 2 2 12 9 19 20 2159 -4096 2 2 12 9 704 1972 3237 -4097 2 2 12 9 1402 2400 3099 -4098 2 2 12 9 1069 3224 2149 -4099 2 2 12 9 522 2500 1833 -4100 2 2 12 9 562 2641 2382 -4101 2 2 12 9 564 2383 2642 -4102 2 2 12 9 1217 1775 2639 -4103 2 2 12 9 1218 2640 1776 -4104 2 2 12 9 349 3284 2005 -4105 2 2 12 9 483 2117 1947 -4106 2 2 12 9 484 1948 2118 -4107 2 2 12 9 363 2431 1719 -4108 2 2 12 9 995 1696 2610 -4109 2 2 12 9 1389 3304 2295 -4110 2 2 12 9 840 2641 1658 -4111 2 2 12 9 996 2611 1697 -4112 2 2 12 9 841 1659 2642 -4113 2 2 12 9 1020 2280 2596 -4114 2 2 12 9 917 2850 1628 -4115 2 2 12 9 532 3095 1916 -4116 2 2 12 9 1142 2673 1642 -4117 2 2 12 9 1512 3302 2698 -4118 2 2 12 9 1169 1631 2725 -4119 2 2 12 9 29 30 3015 -4120 2 2 12 9 1740 3478 2962 -4121 2 2 12 9 1137 3053 1979 -4122 2 2 12 9 481 2893 1585 -4123 2 2 12 9 482 1586 2894 -4124 2 2 12 9 20 21 3114 -4125 2 2 12 9 1007 3421 1650 -4126 2 2 12 9 535 1983 2445 -4127 2 2 12 9 633 3418 3373 -4128 2 2 12 9 665 1740 2962 -4129 2 2 12 9 577 2722 1676 -4130 2 2 12 9 1027 1682 2708 -4131 2 2 12 9 480 2589 2141 -4132 2 2 12 9 1033 2979 1600 -4133 2 2 12 9 1034 1601 2980 -4134 2 2 12 9 992 2057 2366 -4135 2 2 12 9 993 2367 2058 -4136 2 2 12 9 1028 3065 1865 -4137 2 2 12 9 592 1908 3633 -4138 2 2 12 9 990 1649 3002 -4139 2 2 12 9 525 2313 1980 -4140 2 2 12 9 526 1981 2314 -4141 2 2 12 9 927 2900 1716 -4142 2 2 12 9 928 1717 2901 -4143 2 2 12 9 1280 3049 2178 -4144 2 2 12 9 6 215 2956 -4145 2 2 12 9 514 3616 1704 -4146 2 2 12 9 1309 2727 2952 -4147 2 2 12 9 52 3588 1721 -4148 2 2 12 9 169 1722 3589 -4149 2 2 12 9 199 200 2354 -4150 2 2 12 9 1587 2739 3319 -4151 2 2 12 9 1588 3320 2740 -4152 2 2 12 9 1452 3291 1686 -4153 2 2 12 9 1449 3633 2252 -4154 2 2 12 9 995 1997 2434 -4155 2 2 12 9 700 3533 1645 -4156 2 2 12 9 850 2334 1907 -4157 2 2 12 9 996 2435 2000 -4158 2 2 12 9 398 1760 2542 -4159 2 2 12 9 967 1707 3192 -4160 2 2 12 9 572 2152 2451 -4161 2 2 12 9 607 2736 1750 -4162 2 2 12 9 822 2779 3428 -4163 2 2 12 9 985 2663 1808 -4164 2 2 12 9 391 2353 3115 -4165 2 2 12 9 239 1721 3588 -4166 2 2 12 9 337 3589 1722 -4167 2 2 12 9 1194 2917 2074 -4168 2 2 12 9 703 2904 1738 -4169 2 2 12 9 849 1850 2919 -4170 2 2 12 9 789 3427 1634 -4171 2 2 12 9 1068 2543 2208 -4172 2 2 12 9 12 13 2706 -4173 2 2 12 9 459 2038 3489 -4174 2 2 12 9 1119 1647 2903 -4175 2 2 12 9 222 223 3236 -4176 2 2 12 9 903 1995 2128 -4177 2 2 12 9 1593 3585 1958 -4178 2 2 12 9 1081 2508 2169 -4179 2 2 12 9 1082 2170 2509 -4180 2 2 12 9 654 1696 3132 -4181 2 2 12 9 655 3133 1697 -4182 2 2 12 9 521 2131 2239 -4183 2 2 12 9 251 3226 1854 -4184 2 2 12 9 325 1855 3227 -4185 2 2 12 9 610 2552 3028 -4186 2 2 12 9 339 1691 2882 -4187 2 2 12 9 1521 2890 2311 -4188 2 2 12 9 1068 1949 2543 -4189 2 2 12 9 519 1698 3081 -4190 2 2 12 9 520 3082 1699 -4191 2 2 12 9 701 3587 1635 -4192 2 2 12 9 506 2142 2540 -4193 2 2 12 9 507 2541 2143 -4194 2 2 12 9 948 1648 2892 -4195 2 2 12 9 1188 3307 2207 -4196 2 2 12 9 1225 2419 2100 -4197 2 2 12 9 430 1706 2750 -4198 2 2 12 9 946 1627 2957 -4199 2 2 12 9 873 3059 1748 -4200 2 2 12 9 1075 2531 2119 -4201 2 2 12 9 1430 2354 3497 -4202 2 2 12 9 895 1727 2716 -4203 2 2 12 9 1042 1671 2889 -4204 2 2 12 9 747 1769 2550 -4205 2 2 12 9 405 2046 2116 -4206 2 2 12 9 994 2962 3478 -4207 2 2 12 9 936 1603 2845 -4208 2 2 12 9 899 1754 2556 -4209 2 2 12 9 927 1980 2313 -4210 2 2 12 9 558 2100 2777 -4211 2 2 12 9 928 2314 1981 -4212 2 2 12 9 978 1975 2544 -4213 2 2 12 9 979 2545 1976 -4214 2 2 12 9 1543 2902 2167 -4215 2 2 12 9 1072 1638 2913 -4216 2 2 12 9 1360 2787 2768 -4217 2 2 12 9 486 3454 3050 -4218 2 2 12 9 437 1689 3482 -4219 2 2 12 9 487 3051 3455 -4220 2 2 12 9 683 3167 1736 -4221 2 2 12 9 1315 2965 3095 -4222 2 2 12 9 1435 3602 1710 -4223 2 2 12 9 1436 1711 3603 -4224 2 2 12 9 1047 2938 3173 -4225 2 2 12 9 1048 3174 2939 -4226 2 2 12 9 578 3154 1679 -4227 2 2 12 9 579 1680 3155 -4228 2 2 12 9 1427 2710 1897 -4229 2 2 12 9 1428 1898 2711 -4230 2 2 12 9 730 2544 1975 -4231 2 2 12 9 731 1976 2545 -4232 2 2 12 9 857 2203 2810 -4233 2 2 12 9 517 1714 2685 -4234 2 2 12 9 917 2198 2769 -4235 2 2 12 9 1232 3237 1972 -4236 2 2 12 9 1133 2195 1924 -4237 2 2 12 9 1134 1925 2196 -4238 2 2 12 9 1301 2547 2782 -4239 2 2 12 9 1302 2783 2548 -4240 2 2 12 9 402 1687 3110 -4241 2 2 12 9 556 2293 3225 -4242 2 2 12 9 483 1909 2316 -4243 2 2 12 9 484 2317 1911 -4244 2 2 12 9 276 2238 3420 -4245 2 2 12 9 15 16 2283 -4246 2 2 12 9 1640 2835 3366 -4247 2 2 12 9 963 2315 2773 -4248 2 2 12 9 587 1761 2502 -4249 2 2 12 9 1439 2382 2641 -4250 2 2 12 9 1440 2642 2383 -4251 2 2 12 9 588 2503 1762 -4252 2 2 12 9 17 1651 2671 -4253 2 2 12 9 281 282 3492 -4254 2 2 12 9 1012 1913 2621 -4255 2 2 12 9 1493 3028 2552 -4256 2 2 12 9 1112 2150 2735 -4257 2 2 12 9 1295 1851 2925 -4258 2 2 12 9 239 240 3243 -4259 2 2 12 9 336 337 3244 -4260 2 2 12 9 665 2934 1740 -4261 2 2 12 9 533 2208 2543 -4262 2 2 12 9 723 1775 3548 -4263 2 2 12 9 1445 3253 1810 -4264 2 2 12 9 724 3549 1776 -4265 2 2 12 9 1260 2605 2313 -4266 2 2 12 9 1261 2314 2607 -4267 2 2 12 9 441 1602 3273 -4268 2 2 12 9 857 2810 2231 -4269 2 2 12 9 685 1690 2700 -4270 2 2 12 9 550 2467 3529 -4271 2 2 12 9 1383 3307 3582 -4272 2 2 12 9 781 2595 3337 -4273 2 2 12 9 1031 2451 2152 -4274 2 2 12 9 925 2464 2737 -4275 2 2 12 9 1513 3079 3315 -4276 2 2 12 9 926 2738 2465 -4277 2 2 12 9 418 3423 3612 -4278 2 2 12 9 971 3270 1738 -4279 2 2 12 9 1539 3255 2474 -4280 2 2 12 9 1277 2408 2113 -4281 2 2 12 9 1525 3529 2467 -4282 2 2 12 9 480 1741 2589 -4283 2 2 12 9 471 1664 2891 -4284 2 2 12 9 1418 2087 3643 -4285 2 2 12 9 832 3430 1984 -4286 2 2 12 9 750 3490 1708 -4287 2 2 12 9 751 1709 3491 -4288 2 2 12 9 804 2253 2004 -4289 2 2 12 9 381 1746 2569 -4290 2 2 12 9 418 3612 2594 -4291 2 2 12 9 197 198 2454 -4292 2 2 12 9 856 2808 2202 -4293 2 2 12 9 442 1665 2778 -4294 2 2 12 9 720 3142 1753 -4295 2 2 12 9 758 1759 2443 -4296 2 2 12 9 1376 3293 2375 -4297 2 2 12 9 1377 2376 3294 -4298 2 2 12 9 756 2245 3327 -4299 2 2 12 9 895 2879 1727 -4300 2 2 12 9 757 3328 2246 -4301 2 2 12 9 838 1749 3265 -4302 2 2 12 9 984 1795 3098 -4303 2 2 12 9 2106 3436 3162 -4304 2 2 12 9 881 3097 2675 -4305 2 2 12 9 1856 3601 2657 -4306 2 2 12 9 1274 1939 3178 -4307 2 2 12 9 363 3059 2343 -4308 2 2 12 9 815 2782 2547 -4309 2 2 12 9 816 2548 2783 -4310 2 2 12 9 1060 3390 1729 -4311 2 2 12 9 1104 2350 3087 -4312 2 2 12 9 803 2059 2212 -4313 2 2 12 9 1105 3088 2351 -4314 2 2 12 9 218 219 3032 -4315 2 2 12 9 363 2343 2431 -4316 2 2 12 9 856 2217 2808 -4317 2 2 12 9 1129 3584 1763 -4318 2 2 12 9 952 1756 3126 -4319 2 2 12 9 715 3410 1673 -4320 2 2 12 9 984 1832 2669 -4321 2 2 12 9 557 3030 2021 -4322 2 2 12 9 1023 1812 3109 -4323 2 2 12 9 280 281 2674 -4324 2 2 12 9 1173 2293 2870 -4325 2 2 12 9 1576 2338 3263 -4326 2 2 12 9 408 1667 3377 -4327 2 2 12 9 409 3378 1668 -4328 2 2 12 9 1545 3400 1894 -4329 2 2 12 9 875 2717 1656 -4330 2 2 12 9 915 2587 1694 -4331 2 2 12 9 24 25 2385 -4332 2 2 12 9 916 1695 2588 -4333 2 2 12 9 259 260 2688 -4334 2 2 12 9 316 317 2689 -4335 2 2 12 9 796 2459 2032 -4336 2 2 12 9 862 2066 3503 -4337 2 2 12 9 1176 2240 2455 -4338 2 2 12 9 1248 1679 3118 -4339 2 2 12 9 1249 3119 1680 -4340 2 2 12 9 353 1979 3053 -4341 2 2 12 9 887 2235 3216 -4342 2 2 12 9 1045 2161 2540 -4343 2 2 12 9 1046 2541 2162 -4344 2 2 12 9 1233 3313 3032 -4345 2 2 12 9 882 2197 2401 -4346 2 2 12 9 815 3596 1698 -4347 2 2 12 9 990 3100 1649 -4348 2 2 12 9 816 1699 3597 -4349 2 2 12 9 536 2802 2020 -4350 2 2 12 9 826 2453 2164 -4351 2 2 12 9 1128 1853 3375 -4352 2 2 12 9 509 1712 2495 -4353 2 2 12 9 1447 3471 3292 -4354 2 2 12 9 1354 3115 2353 -4355 2 2 12 9 350 1685 3395 -4356 2 2 12 9 911 2920 2440 -4357 2 2 12 9 912 2441 2921 -4358 2 2 12 9 797 1718 2504 -4359 2 2 12 9 714 3004 2494 -4360 2 2 12 9 542 2426 2027 -4361 2 2 12 9 287 288 2237 -4362 2 2 12 9 416 2821 1671 -4363 2 2 12 9 977 2192 2562 -4364 2 2 12 9 1084 2096 3149 -4365 2 2 12 9 1085 3150 2097 -4366 2 2 12 9 1210 3445 2425 -4367 2 2 12 9 866 3397 1790 -4368 2 2 12 9 639 2716 1727 -4369 2 2 12 9 1472 2960 2382 -4370 2 2 12 9 1473 2383 2961 -4371 2 2 12 9 733 1798 3056 -4372 2 2 12 9 734 3057 1799 -4373 2 2 12 9 1538 3031 2892 -4374 2 2 12 9 499 2734 2791 -4375 2 2 12 9 585 2408 3187 -4376 2 2 12 9 1050 1736 3167 -4377 2 2 12 9 1132 2099 3029 -4378 2 2 12 9 628 2251 1999 -4379 2 2 12 9 854 3255 2517 -4380 2 2 12 9 942 2536 1833 -4381 2 2 12 9 379 2459 1811 -4382 2 2 12 9 369 2692 2985 -4383 2 2 12 9 370 2986 2693 -4384 2 2 12 9 436 2039 3147 -4385 2 2 12 9 992 2649 1798 -4386 2 2 12 9 993 1799 2650 -4387 2 2 12 9 36 37 3357 -4388 2 2 12 9 184 185 3358 -4389 2 2 12 9 534 1686 3629 -4390 2 2 12 9 44 45 2271 -4391 2 2 12 9 176 177 2272 -4392 2 2 12 9 289 290 2248 -4393 2 2 12 9 1102 2790 2283 -4394 2 2 12 9 810 3222 2397 -4395 2 2 12 9 498 1823 2475 -4396 2 2 12 9 997 1710 2651 -4397 2 2 12 9 998 2652 1711 -4398 2 2 12 9 540 2296 1940 -4399 2 2 12 9 1526 2949 1807 -4400 2 2 12 9 1113 2141 2589 -4401 2 2 12 9 368 2877 1742 -4402 2 2 12 9 980 1740 2934 -4403 2 2 12 9 882 2401 2077 -4404 2 2 12 9 1296 3087 2350 -4405 2 2 12 9 1297 2351 3088 -4406 2 2 12 9 227 2708 1682 -4407 2 2 12 9 1253 2770 2544 -4408 2 2 12 9 932 1833 2500 -4409 2 2 12 9 1254 2545 2771 -4410 2 2 12 9 1108 3364 1746 -4411 2 2 12 9 1558 3283 2695 -4412 2 2 12 9 1174 1828 2609 -4413 2 2 12 9 1295 2767 2604 -4414 2 2 12 9 701 1849 3595 -4415 2 2 12 9 209 210 3546 -4416 2 2 12 9 1128 3128 1853 -4417 2 2 12 9 684 1644 3437 -4418 2 2 12 9 590 2768 2787 -4419 2 2 12 9 16 17 2671 -4420 2 2 12 9 668 3109 1812 -4421 2 2 12 9 486 3279 1904 -4422 2 2 12 9 487 1905 3280 -4423 2 2 12 9 988 2169 2508 -4424 2 2 12 9 989 2509 2170 -4425 2 2 12 9 576 1666 3363 -4426 2 2 12 9 1357 3571 1793 -4427 2 2 12 9 1358 1794 3572 -4428 2 2 12 9 871 2064 2657 -4429 2 2 12 9 1229 1924 3620 -4430 2 2 12 9 1230 3621 1925 -4431 2 2 12 9 1287 2797 1725 -4432 2 2 12 9 1288 1726 2798 -4433 2 2 12 9 973 2816 2288 -4434 2 2 12 9 974 2289 2817 -4435 2 2 12 9 647 1725 2936 -4436 2 2 12 9 648 2937 1726 -4437 2 2 12 9 780 3600 2233 -4438 2 2 12 9 1184 1999 2251 -4439 2 2 12 9 971 2787 2248 -4440 2 2 12 9 1497 2614 2342 -4441 2 2 12 9 626 2175 3135 -4442 2 2 12 9 517 2277 1900 -4443 2 2 12 9 518 1901 2278 -4444 2 2 12 9 677 3315 3079 -4445 2 2 12 9 523 2735 2150 -4446 2 2 12 9 1182 3583 2990 -4447 2 2 12 9 25 1834 2385 -4448 2 2 12 9 607 3031 2874 -4449 2 2 12 9 946 1792 2694 -4450 2 2 12 9 451 2720 1716 -4451 2 2 12 9 765 1652 3131 -4452 2 2 12 9 452 1717 2721 -4453 2 2 12 9 399 2456 2822 -4454 2 2 12 9 817 3025 2589 -4455 2 2 12 9 1011 2638 2290 -4456 2 2 12 9 696 1712 3193 -4457 2 2 12 9 967 2237 2768 -4458 2 2 12 9 961 3374 2733 -4459 2 2 12 9 583 3321 2189 -4460 2 2 12 9 1498 2832 3060 -4461 2 2 12 9 1499 3061 2834 -4462 2 2 12 9 893 2316 1909 -4463 2 2 12 9 894 1911 2317 -4464 2 2 12 9 1487 2846 3481 -4465 2 2 12 9 704 1681 3433 -4466 2 2 12 9 1521 2696 3340 -4467 2 2 12 9 11 2153 3624 -4468 2 2 12 9 977 1835 2530 -4469 2 2 12 9 948 2892 3031 -4470 2 2 12 9 1053 2922 1929 -4471 2 2 12 9 1382 2494 3004 -4472 2 2 12 9 997 2142 3324 -4473 2 2 12 9 998 3325 2143 -4474 2 2 12 9 962 2443 2604 -4475 2 2 12 9 1528 3524 2936 -4476 2 2 12 9 1529 2937 3525 -4477 2 2 12 9 743 1685 3409 -4478 2 2 12 9 490 2157 2160 -4479 2 2 12 9 1252 2431 2343 -4480 2 2 12 9 1362 2868 1819 -4481 2 2 12 9 1486 3025 3185 -4482 2 2 12 9 1363 1820 2869 -4483 2 2 12 9 1538 2874 3031 -4484 2 2 12 9 780 2233 2039 -4485 2 2 12 9 1469 3114 3551 -4486 2 2 12 9 341 2907 3441 -4487 2 2 12 9 955 2812 3526 -4488 2 2 12 9 516 3086 1887 -4489 2 2 12 9 927 2313 2605 -4490 2 2 12 9 928 2607 2314 -4491 2 2 12 9 634 3283 1879 -4492 2 2 12 9 1159 1861 3524 -4493 2 2 12 9 1160 3525 1862 -4494 2 2 12 9 1137 1979 3112 -4495 2 2 12 9 1123 3413 1967 -4496 2 2 12 9 600 1929 2922 -4497 2 2 12 9 1124 1968 3414 -4498 2 2 12 9 833 2124 2284 -4499 2 2 12 9 880 2385 1834 -4500 2 2 12 9 966 2877 3521 -4501 2 2 12 9 1039 3056 1798 -4502 2 2 12 9 992 2172 2792 -4503 2 2 12 9 993 2794 2173 -4504 2 2 12 9 1040 1799 3057 -4505 2 2 12 9 1477 2176 3202 -4506 2 2 12 9 272 273 2903 -4507 2 2 12 9 1008 2160 2157 -4508 2 2 12 9 490 2621 1913 -4509 2 2 12 9 204 1853 3128 -4510 2 2 12 9 244 245 2651 -4511 2 2 12 9 331 332 2652 -4512 2 2 12 9 1336 2762 2417 -4513 2 2 12 9 532 2442 3103 -4514 2 2 12 9 1004 1861 3121 -4515 2 2 12 9 1005 3122 1862 -4516 2 2 12 9 634 2695 3283 -4517 2 2 12 9 800 3005 1875 -4518 2 2 12 9 870 2295 1923 -4519 2 2 12 9 887 3216 3345 -4520 2 2 12 9 504 2106 3162 -4521 2 2 12 9 1341 2343 3059 -4522 2 2 12 9 521 2239 2258 -4523 2 2 12 9 716 2209 3601 -4524 2 2 12 9 866 3217 1807 -4525 2 2 12 9 1109 1916 3095 -4526 2 2 12 9 243 244 3602 -4527 2 2 12 9 332 333 3603 -4528 2 2 12 9 1043 1802 2629 -4529 2 2 12 9 1044 2630 1803 -4530 2 2 12 9 1065 1771 3175 -4531 2 2 12 9 467 2453 1877 -4532 2 2 12 9 1173 3225 2293 -4533 2 2 12 9 1617 2005 3284 -4534 2 2 12 9 1038 2415 3085 -4535 2 2 12 9 448 2511 1813 -4536 2 2 12 9 1130 2718 2985 -4537 2 2 12 9 1131 2986 2719 -4538 2 2 12 9 251 252 3226 -4539 2 2 12 9 324 325 3227 -4540 2 2 12 9 1274 3178 2704 -4541 2 2 12 9 282 1733 3492 -4542 2 2 12 9 858 2742 1742 -4543 2 2 12 9 298 299 3412 -4544 2 2 12 9 1355 2183 3523 -4545 2 2 12 9 978 2030 2565 -4546 2 2 12 9 979 2566 2031 -4547 2 2 12 9 400 1863 2551 -4548 2 2 12 9 978 2544 2770 -4549 2 2 12 9 979 2771 2545 -4550 2 2 12 9 1386 3392 1674 -4551 2 2 12 9 497 1759 3426 -4552 2 2 12 9 682 1729 3390 -4553 2 2 12 9 1234 3085 2415 -4554 2 2 12 9 457 1955 3384 -4555 2 2 12 9 641 3189 3532 -4556 2 2 12 9 748 3375 1853 -4557 2 2 12 9 523 1782 2735 -4558 2 2 12 9 37 38 2355 -4559 2 2 12 9 183 184 2356 -4560 2 2 12 9 540 1763 3584 -4561 2 2 12 9 224 225 2291 -4562 2 2 12 9 764 2099 3202 -4563 2 2 12 9 1308 2520 3273 -4564 2 2 12 9 617 1875 3005 -4565 2 2 12 9 1092 2310 2257 -4566 2 2 12 9 268 269 2311 -4567 2 2 12 9 494 2587 2666 -4568 2 2 12 9 1075 1781 3073 -4569 2 2 12 9 495 2667 2588 -4570 2 2 12 9 1066 3089 2316 -4571 2 2 12 9 1067 2317 3090 -4572 2 2 12 9 286 287 3192 -4573 2 2 12 9 360 1730 2769 -4574 2 2 12 9 876 1780 2580 -4575 2 2 12 9 271 272 3148 -4576 2 2 12 9 1570 3020 3415 -4577 2 2 12 9 1015 3060 2832 -4578 2 2 12 9 1016 2834 3061 -4579 2 2 12 9 628 2423 2251 -4580 2 2 12 9 910 3579 2722 -4581 2 2 12 9 1033 1980 2720 -4582 2 2 12 9 1034 2721 1981 -4583 2 2 12 9 922 2647 2617 -4584 2 2 12 9 357 2228 2675 -4585 2 2 12 9 1676 2722 3579 -4586 2 2 12 9 1523 3361 2975 -4587 2 2 12 9 877 1750 2736 -4588 2 2 12 9 371 3443 1846 -4589 2 2 12 9 1264 3135 2175 -4590 2 2 12 9 372 1847 3444 -4591 2 2 12 9 387 3151 2603 -4592 2 2 12 9 1409 2154 3402 -4593 2 2 12 9 787 2565 2030 -4594 2 2 12 9 788 2031 2566 -4595 2 2 12 9 607 1750 3031 -4596 2 2 12 9 1263 1908 2791 -4597 2 2 12 9 1039 3426 1759 -4598 2 2 12 9 290 291 3270 -4599 2 2 12 9 716 2471 2209 -4600 2 2 12 9 1004 3121 1662 -4601 2 2 12 9 1005 1663 3122 -4602 2 2 12 9 373 1941 2320 -4603 2 2 12 9 374 2321 1942 -4604 2 2 12 9 420 1696 2792 -4605 2 2 12 9 1203 2964 2207 -4606 2 2 12 9 421 2794 1697 -4607 2 2 12 9 793 2476 2177 -4608 2 2 12 9 693 2460 1870 -4609 2 2 12 9 463 2602 1810 -4610 2 2 12 9 776 1952 3297 -4611 2 2 12 9 2295 2567 3580 -4612 2 2 12 9 524 2416 1876 -4613 2 2 12 9 508 2168 2429 -4614 2 2 12 9 30 3129 1818 -4615 2 2 12 9 644 3543 3188 -4616 2 2 12 9 1234 3147 2039 -4617 2 2 12 9 296 3223 1994 -4618 2 2 12 9 884 1989 2529 -4619 2 2 12 9 721 3112 1979 -4620 2 2 12 9 514 1881 3182 -4621 2 2 12 9 1367 3197 1734 -4622 2 2 12 9 669 1770 2911 -4623 2 2 12 9 1368 1735 3198 -4624 2 2 12 9 1147 3473 2472 -4625 2 2 12 9 1260 2313 3173 -4626 2 2 12 9 1261 3174 2314 -4627 2 2 12 9 415 1729 2950 -4628 2 2 12 9 945 3286 2681 -4629 2 2 12 9 373 2320 3093 -4630 2 2 12 9 743 3409 2091 -4631 2 2 12 9 374 3094 2321 -4632 2 2 12 9 394 3146 2483 -4633 2 2 12 9 877 2698 1750 -4634 2 2 12 9 687 3620 1924 -4635 2 2 12 9 688 1925 3621 -4636 2 2 12 9 962 2604 2767 -4637 2 2 12 9 1370 3365 1982 -4638 2 2 12 9 22 1792 3551 -4639 2 2 12 9 1216 2283 2790 -4640 2 2 12 9 1286 2822 2456 -4641 2 2 12 9 1277 2397 3222 -4642 2 2 12 9 1227 2617 2647 -4643 2 2 12 9 1061 3518 2069 -4644 2 2 12 9 1063 2070 3519 -4645 2 2 12 9 1149 3418 2756 -4646 2 2 12 9 361 2967 1715 -4647 2 2 12 9 1238 2368 3579 -4648 2 2 12 9 1510 3385 2565 -4649 2 2 12 9 1511 2566 3386 -4650 2 2 12 9 866 2159 3114 -4651 2 2 12 9 1339 1903 2468 -4652 2 2 12 9 1322 1868 2780 -4653 2 2 12 9 966 1742 2877 -4654 2 2 12 9 1323 2781 1869 -4655 2 2 12 9 991 1821 3039 -4656 2 2 12 9 817 3185 3025 -4657 2 2 12 9 535 2814 1983 -4658 2 2 12 9 1241 2666 2587 -4659 2 2 12 9 1242 2588 2667 -4660 2 2 12 9 238 3261 3303 -4661 2 2 12 9 1123 1967 3618 -4662 2 2 12 9 1124 3619 1968 -4663 2 2 12 9 1414 3624 2153 -4664 2 2 12 9 1188 2032 2459 -4665 2 2 12 9 937 1954 3008 -4666 2 2 12 9 665 1687 2934 -4667 2 2 12 9 9 10 2387 -4668 2 2 12 9 1301 2692 2146 -4669 2 2 12 9 1302 2148 2693 -4670 2 2 12 9 1217 2639 2875 -4671 2 2 12 9 1218 2876 2640 -4672 2 2 12 9 647 3524 1861 -4673 2 2 12 9 648 1862 3525 -4674 2 2 12 9 718 1871 2501 -4675 2 2 12 9 591 1832 2767 -4676 2 2 12 9 1584 2829 1764 -4677 2 2 12 9 1315 1991 2965 -4678 2 2 12 9 240 1743 3243 -4679 2 2 12 9 336 3244 1744 -4680 2 2 12 9 881 2257 2310 -4681 2 2 12 9 1155 1812 3495 -4682 2 2 12 9 1443 2322 3561 -4683 2 2 12 9 1444 3562 2323 -4684 2 2 12 9 1281 2664 1840 -4685 2 2 12 9 499 2791 1765 -4686 2 2 12 9 515 2497 2055 -4687 2 2 12 9 890 2043 2242 -4688 2 2 12 9 891 2243 2044 -4689 2 2 12 9 759 3469 1677 -4690 2 2 12 9 371 1846 2605 -4691 2 2 12 9 372 2607 1847 -4692 2 2 12 9 307 308 2357 -4693 2 2 12 9 1179 2410 3483 -4694 2 2 12 9 1180 3484 2411 -4695 2 2 12 9 866 1790 3217 -4696 2 2 12 9 264 265 2350 -4697 2 2 12 9 311 312 2351 -4698 2 2 12 9 1047 1935 2938 -4699 2 2 12 9 1048 2939 1936 -4700 2 2 12 9 515 1705 2835 -4701 2 2 12 9 645 1771 3576 -4702 2 2 12 9 665 2962 1715 -4703 2 2 12 9 692 2924 1724 -4704 2 2 12 9 1150 1752 2887 -4705 2 2 12 9 344 3406 1851 -4706 2 2 12 9 701 2468 1903 -4707 2 2 12 9 880 2458 1902 -4708 2 2 12 9 654 2322 2057 -4709 2 2 12 9 655 2058 2323 -4710 2 2 12 9 1019 1983 2814 -4711 2 2 12 9 868 2430 1878 -4712 2 2 12 9 903 2128 2682 -4713 2 2 12 9 654 3561 2322 -4714 2 2 12 9 1234 2415 3147 -4715 2 2 12 9 655 2323 3562 -4716 2 2 12 9 963 2658 2602 -4717 2 2 12 9 957 1849 2855 -4718 2 2 12 9 1262 2050 2539 -4719 2 2 12 9 1178 3474 2575 -4720 2 2 12 9 976 3415 3020 -4721 2 2 12 9 1093 3152 2554 -4722 2 2 12 9 1094 2555 3153 -4723 2 2 12 9 668 1703 3109 -4724 2 2 12 9 491 3495 1812 -4725 2 2 12 9 1455 3601 2209 -4726 2 2 12 9 1278 2091 3409 -4727 2 2 12 9 959 2885 2332 -4728 2 2 12 9 960 2333 2886 -4729 2 2 12 9 962 1951 2443 -4730 2 2 12 9 378 1688 3143 -4731 2 2 12 9 950 1824 3066 -4732 2 2 12 9 951 3067 1825 -4733 2 2 12 9 551 1857 2591 -4734 2 2 12 9 552 2592 1858 -4735 2 2 12 9 972 2912 2370 -4736 2 2 12 9 957 2674 1805 -4737 2 2 12 9 791 2054 3389 -4738 2 2 12 9 297 2063 3223 -4739 2 2 12 9 1676 3579 2368 -4740 2 2 12 9 1088 1708 2858 -4741 2 2 12 9 1089 2859 1709 -4742 2 2 12 9 966 2777 1742 -4743 2 2 12 9 1280 3127 2335 -4744 2 2 12 9 1049 1926 3343 -4745 2 2 12 9 620 2762 3372 -4746 2 2 12 9 723 3548 2410 -4747 2 2 12 9 724 2411 3549 -4748 2 2 12 9 948 3031 1750 -4749 2 2 12 9 1030 2294 2633 -4750 2 2 12 9 496 1842 2952 -4751 2 2 12 9 538 2207 2964 -4752 2 2 12 9 1037 1773 2999 -4753 2 2 12 9 1167 1846 3443 -4754 2 2 12 9 1168 3444 1847 -4755 2 2 12 9 980 3205 1740 -4756 2 2 12 9 51 3218 1766 -4757 2 2 12 9 170 1767 3219 -4758 2 2 12 9 832 2556 3430 -4759 2 2 12 9 1515 3428 2779 -4760 2 2 12 9 935 2551 1863 -4761 2 2 12 9 900 2837 1883 -4762 2 2 12 9 1052 2140 3015 -4763 2 2 12 9 1253 2544 3154 -4764 2 2 12 9 1254 3155 2545 -4765 2 2 12 9 1096 2977 2802 -4766 2 2 12 9 844 2381 1963 -4767 2 2 12 9 414 2395 1933 -4768 2 2 12 9 1096 1867 3531 -4769 2 2 12 9 981 2890 1899 -4770 2 2 12 9 1412 3158 3080 -4771 2 2 12 9 381 3425 1746 -4772 2 2 12 9 849 2456 1850 -4773 2 2 12 9 363 1748 3059 -4774 2 2 12 9 483 1947 2384 -4775 2 2 12 9 578 2202 3154 -4776 2 2 12 9 579 3155 2203 -4777 2 2 12 9 484 2386 1948 -4778 2 2 12 9 1177 3573 1899 -4779 2 2 12 9 1395 3521 2877 -4780 2 2 12 9 554 2997 1773 -4781 2 2 12 9 1037 2361 2884 -4782 2 2 12 9 532 3103 3379 -4783 2 2 12 9 694 1764 2829 -4784 2 2 12 9 557 2021 2909 -4785 2 2 12 9 1755 3472 2976 -4786 2 2 12 9 949 2262 2395 -4787 2 2 12 9 647 2936 3524 -4788 2 2 12 9 648 3525 2937 -4789 2 2 12 9 701 2855 1849 -4790 2 2 12 9 1174 3272 2524 -4791 2 2 12 9 1498 2410 3548 -4792 2 2 12 9 1499 3549 2411 -4793 2 2 12 9 667 2576 3010 -4794 2 2 12 9 343 2818 1734 -4795 2 2 12 9 342 1735 2819 -4796 2 2 12 9 380 1920 3380 -4797 2 2 12 9 657 1730 3365 -4798 2 2 12 9 27 28 2599 -4799 2 2 12 9 1446 2603 3151 -4800 2 2 12 9 344 1851 2801 -4801 2 2 12 9 1298 2844 2191 -4802 2 2 12 9 910 1876 2416 -4803 2 2 12 9 925 2737 2215 -4804 2 2 12 9 1017 2235 2234 -4805 2 2 12 9 926 2216 2738 -4806 2 2 12 9 363 1719 3120 -4807 2 2 12 9 417 3039 1821 -4808 2 2 12 9 1521 3340 2890 -4809 2 2 12 9 597 3184 2062 -4810 2 2 12 9 1212 3338 1761 -4811 2 2 12 9 685 2700 1859 -4812 2 2 12 9 1213 1762 3339 -4813 2 2 12 9 730 2938 1935 -4814 2 2 12 9 731 1936 2939 -4815 2 2 12 9 1251 1822 3641 -4816 2 2 12 9 832 2390 1940 -4817 2 2 12 9 718 3383 1739 -4818 2 2 12 9 717 1757 3253 -4819 2 2 12 9 1115 2964 3077 -4820 2 2 12 9 1239 2504 3348 -4821 2 2 12 9 684 3437 1763 -4822 2 2 12 9 962 2767 1832 -4823 2 2 12 9 1241 3501 1838 -4824 2 2 12 9 802 3445 2632 -4825 2 2 12 9 913 2361 2028 -4826 2 2 12 9 1242 1839 3502 -4827 2 2 12 9 428 2725 1859 -4828 2 2 12 9 397 1806 2880 -4829 2 2 12 9 19 2159 3354 -4830 2 2 12 9 1225 3408 2419 -4831 2 2 12 9 577 2533 2799 -4832 2 2 12 9 1527 2472 3473 -4833 2 2 12 9 1061 2929 2581 -4834 2 2 12 9 1063 2582 2930 -4835 2 2 12 9 940 2967 2074 -4836 2 2 12 9 743 2927 1937 -4837 2 2 12 9 1208 1994 3223 -4838 2 2 12 9 1838 3501 2762 -4839 2 2 12 9 850 1907 2425 -4840 2 2 12 9 599 1790 3397 -4841 2 2 12 9 47 2051 3018 -4842 2 2 12 9 174 3019 2052 -4843 2 2 12 9 378 2779 1768 -4844 2 2 12 9 623 3530 2612 -4845 2 2 12 9 872 1778 3238 -4846 2 2 12 9 1239 2836 2504 -4847 2 2 12 9 1141 1851 3406 -4848 2 2 12 9 480 3106 1690 -4849 2 2 12 9 758 2443 1951 -4850 2 2 12 9 1073 3554 1728 -4851 2 2 12 9 839 2421 2015 -4852 2 2 12 9 1266 3327 2245 -4853 2 2 12 9 1267 2246 3328 -4854 2 2 12 9 190 3075 2068 -4855 2 2 12 9 1159 2016 3534 -4856 2 2 12 9 1160 3535 2017 -4857 2 2 12 9 948 1750 2910 -4858 2 2 12 9 712 2523 2863 -4859 2 2 12 9 1012 2976 3472 -4860 2 2 12 9 947 2352 2252 -4861 2 2 12 9 1137 3182 1881 -4862 2 2 12 9 793 1986 2476 -4863 2 2 12 9 1311 2848 2019 -4864 2 2 12 9 1338 2036 2345 -4865 2 2 12 9 208 209 2498 -4866 2 2 12 9 352 1816 2991 -4867 2 2 12 9 351 2992 1817 -4868 2 2 12 9 1195 2177 2476 -4869 2 2 12 9 219 220 2665 -4870 2 2 12 9 872 2042 2340 -4871 2 2 12 9 1501 3441 3257 -4872 2 2 12 9 1217 1819 2868 -4873 2 2 12 9 1218 2869 1820 -4874 2 2 12 9 1109 3095 2965 -4875 2 2 12 9 661 1899 2890 -4876 2 2 12 9 291 292 2953 -4877 2 2 12 9 1171 2975 3361 -4878 2 2 12 9 1389 3353 3304 -4879 2 2 12 9 867 2409 2232 -4880 2 2 12 9 896 3142 1845 -4881 2 2 12 9 386 1969 3402 -4882 2 2 12 9 514 3182 2489 -4883 2 2 12 9 285 286 2989 -4884 2 2 12 9 927 2605 1846 -4885 2 2 12 9 1279 2590 2974 -4886 2 2 12 9 928 1847 2607 -4887 2 2 12 9 1006 3232 1753 -4888 2 2 12 9 959 2780 1868 -4889 2 2 12 9 960 1869 2781 -4890 2 2 12 9 1103 2112 3014 -4891 2 2 12 9 908 1875 2653 -4892 2 2 12 9 682 3390 3552 -4893 2 2 12 9 953 1854 3226 -4894 2 2 12 9 954 3227 1855 -4895 2 2 12 9 617 2653 1875 -4896 2 2 12 9 901 3357 2355 -4897 2 2 12 9 902 2356 3358 -4898 2 2 12 9 486 2120 3279 -4899 2 2 12 9 487 3280 2121 -4900 2 2 12 9 1028 2401 2197 -4901 2 2 12 9 354 2866 1814 -4902 2 2 12 9 988 2069 3518 -4903 2 2 12 9 989 3519 2070 -4904 2 2 12 9 1202 3284 2636 -4905 2 2 12 9 1628 3124 1882 -4906 2 2 12 9 959 1843 2626 -4907 2 2 12 9 960 2627 1844 -4908 2 2 12 9 1253 3154 2202 -4909 2 2 12 9 1254 2203 3155 -4910 2 2 12 9 725 3630 1760 -4911 2 2 12 9 811 2324 2132 -4912 2 2 12 9 1423 3035 1834 -4913 2 2 12 9 352 3060 1816 -4914 2 2 12 9 351 1817 3061 -4915 2 2 12 9 681 1865 3065 -4916 2 2 12 9 1150 2132 2324 -4917 2 2 12 9 1108 1746 3425 -4918 2 2 12 9 1018 3254 1815 -4919 2 2 12 9 1123 3018 2051 -4920 2 2 12 9 1124 2052 3019 -4921 2 2 12 9 945 2428 3286 -4922 2 2 12 9 1114 1950 3042 -4923 2 2 12 9 1148 2068 3075 -4924 2 2 12 9 913 2501 1871 -4925 2 2 12 9 436 1959 3009 -4926 2 2 12 9 1270 2179 3398 -4927 2 2 12 9 750 1829 3490 -4928 2 2 12 9 751 3491 1830 -4929 2 2 12 9 486 3050 1725 -4930 2 2 12 9 487 1726 3051 -4931 2 2 12 9 953 2404 2129 -4932 2 2 12 9 954 2130 2405 -4933 2 2 12 9 929 2057 2322 -4934 2 2 12 9 930 2323 2058 -4935 2 2 12 9 1222 3347 2676 -4936 2 2 12 9 1185 2963 2461 -4937 2 2 12 9 866 1807 3598 -4938 2 2 12 9 402 2422 2015 -4939 2 2 12 9 504 2199 2823 -4940 2 2 12 9 1070 2656 2254 -4941 2 2 12 9 1350 3613 3496 -4942 2 2 12 9 959 2626 2885 -4943 2 2 12 9 960 2886 2627 -4944 2 2 12 9 981 2311 2890 -4945 2 2 12 9 956 2260 2596 -4946 2 2 12 9 710 3036 1967 -4947 2 2 12 9 711 1968 3037 -4948 2 2 12 9 661 2890 3340 -4949 2 2 12 9 1014 3442 1809 -4950 2 2 12 9 1413 3303 3261 -4951 2 2 12 9 1335 1966 2538 -4952 2 2 12 9 1120 3405 1943 -4953 2 2 12 9 1202 2636 2344 -4954 2 2 12 9 341 1991 2907 -4955 2 2 12 9 264 2350 2515 -4956 2 2 12 9 312 2516 2351 -4957 2 2 12 9 500 1740 3205 -4958 2 2 12 9 669 2911 3569 -4959 2 2 12 9 777 3266 2809 -4960 2 2 12 9 1010 3080 1876 -4961 2 2 12 9 959 2688 1843 -4962 2 2 12 9 960 1844 2689 -4963 2 2 12 9 527 2069 2508 -4964 2 2 12 9 528 2509 2070 -4965 2 2 12 9 192 193 2579 -4966 2 2 12 9 744 3341 1800 -4967 2 2 12 9 745 1801 3342 -4968 2 2 12 9 712 3472 1755 -4969 2 2 12 9 339 1915 2707 -4970 2 2 12 9 237 3303 1736 -4971 2 2 12 9 858 2100 2419 -4972 2 2 12 9 1621 3306 2352 -4973 2 2 12 9 907 3071 1878 -4974 2 2 12 9 462 1807 3217 -4975 2 2 12 9 997 2651 3637 -4976 2 2 12 9 259 2688 1868 -4977 2 2 12 9 998 3638 2652 -4978 2 2 12 9 317 1869 2689 -4979 2 2 12 9 1108 2828 3364 -4980 2 2 12 9 720 1753 3232 -4981 2 2 12 9 1578 3190 3111 -4982 2 2 12 9 500 3478 1740 -4983 2 2 12 9 1019 2476 1986 -4984 2 2 12 9 1097 2909 2021 -4985 2 2 12 9 359 3405 1784 -4986 2 2 12 9 225 3276 2291 -4987 2 2 12 9 1382 3004 2359 -4988 2 2 12 9 1128 2633 2294 -4989 2 2 12 9 1597 3364 2828 -4990 2 2 12 9 1795 3646 3098 -4991 2 2 12 9 1119 2059 3078 -4992 2 2 12 9 852 2629 2325 -4993 2 2 12 9 853 2326 2630 -4994 2 2 12 9 1412 1919 2914 -4995 2 2 12 9 498 3545 1823 -4996 2 2 12 9 1104 2515 2350 -4997 2 2 12 9 1105 2351 2516 -4998 2 2 12 9 1279 2863 2523 -4999 2 2 12 9 696 3193 1818 -5000 2 2 12 9 1211 3333 2485 -5001 2 2 12 9 263 264 2515 -5002 2 2 12 9 312 313 2516 -5003 2 2 12 9 33 3042 1950 -5004 2 2 12 9 1135 2911 2139 -5005 2 2 12 9 1369 3010 2576 -5006 2 2 12 9 715 2803 3410 -5007 2 2 12 9 1364 2489 3182 -5008 2 2 12 9 5 7 3261 -5009 2 2 12 9 446 3062 2369 -5010 2 2 12 9 512 2717 2049 -5011 2 2 12 9 999 1831 3206 -5012 2 2 12 9 837 2113 2408 -5013 2 2 12 9 418 2506 3423 -5014 2 2 12 9 1164 2038 2467 -5015 2 2 12 9 1237 2369 3062 -5016 2 2 12 9 1040 1823 3545 -5017 2 2 12 9 1111 2413 2022 -5018 2 2 12 9 949 2395 2945 -5019 2 2 12 9 1615 3006 2033 -5020 2 2 12 9 1616 2034 3007 -5021 2 2 12 9 936 1828 3506 -5022 2 2 12 9 938 1945 3063 -5023 2 2 12 9 939 3064 1946 -5024 2 2 12 9 1120 3207 2896 -5025 2 2 12 9 1190 3646 1795 -5026 2 2 12 9 536 2077 2401 -5027 2 2 12 9 559 2254 2656 -5028 2 2 12 9 1032 2625 1934 -5029 2 2 12 9 658 3111 3190 -5030 2 2 12 9 1140 2594 2500 -5031 2 2 12 9 887 2234 2235 -5032 2 2 12 9 931 2372 2134 -5033 2 2 12 9 566 3398 2179 -5034 2 2 12 9 803 3078 2059 -5035 2 2 12 9 669 3569 2437 -5036 2 2 12 9 801 1883 2918 -5037 2 2 12 9 838 2823 2199 -5038 2 2 12 9 1554 2809 3266 -5039 2 2 12 9 448 1813 3604 -5040 2 2 12 9 10 3624 2387 -5041 2 2 12 9 1149 3148 3418 -5042 2 2 12 9 1084 1967 3036 -5043 2 2 12 9 1085 3037 1968 -5044 2 2 12 9 726 2092 2748 -5045 2 2 12 9 686 3476 1791 -5046 2 2 12 9 30 31 3129 -5047 2 2 12 9 670 1815 3254 -5048 2 2 12 9 899 2856 1957 -5049 2 2 12 9 845 2952 1842 -5050 2 2 12 9 1268 2733 3374 -5051 2 2 12 9 1283 2091 2644 -5052 2 2 12 9 5 3261 238 -5053 2 2 12 9 2198 3538 2769 -5054 2 2 12 9 217 2067 3465 -5055 2 2 12 9 766 2849 1965 -5056 2 2 12 9 390 2252 2352 -5057 2 2 12 9 985 2414 3450 -5058 2 2 12 9 1079 3281 1790 -5059 2 2 12 9 511 2134 2372 -5060 2 2 12 9 1031 2915 2384 -5061 2 2 12 9 914 2707 1915 -5062 2 2 12 9 707 1786 3240 -5063 2 2 12 9 986 1977 3466 -5064 2 2 12 9 987 3467 1978 -5065 2 2 12 9 708 3241 1787 -5066 2 2 12 9 985 3450 2727 -5067 2 2 12 9 1730 1982 3365 -5068 2 2 12 9 898 2004 3041 -5069 2 2 12 9 1200 2712 1857 -5070 2 2 12 9 1201 1858 2713 -5071 2 2 12 9 1647 3418 3148 -5072 2 2 12 9 778 2207 3307 -5073 2 2 12 9 1384 2126 2743 -5074 2 2 12 9 1385 2744 2127 -5075 2 2 12 9 1050 1852 2827 -5076 2 2 12 9 661 3514 1899 -5077 2 2 12 9 461 3408 2444 -5078 2 2 12 9 949 2572 3411 -5079 2 2 12 9 1047 3033 1935 -5080 2 2 12 9 1048 1936 3034 -5081 2 2 12 9 873 2505 3429 -5082 2 2 12 9 968 2861 1880 -5083 2 2 12 9 1237 2269 2369 -5084 2 2 12 9 539 3014 2112 -5085 2 2 12 9 1164 3489 2038 -5086 2 2 12 9 512 1789 3488 -5087 2 2 12 9 377 3506 1828 -5088 2 2 12 9 416 2974 2590 -5089 2 2 12 9 762 3367 1765 -5090 2 2 12 9 603 3636 2724 -5091 2 2 12 9 481 1873 2893 -5092 2 2 12 9 482 2894 1874 -5093 2 2 12 9 524 1876 3080 -5094 2 2 12 9 934 1859 2700 -5095 2 2 12 9 540 3239 1763 -5096 2 2 12 9 1176 3131 2329 -5097 2 2 12 9 904 3454 1904 -5098 2 2 12 9 905 1905 3455 -5099 2 2 12 9 1518 3271 2287 -5100 2 2 12 9 621 2872 1839 -5101 2 2 12 9 510 3477 1791 -5102 2 2 12 9 555 3160 2421 -5103 2 2 12 9 477 3430 1754 -5104 2 2 12 9 299 300 2564 -5105 2 2 12 9 237 238 3303 -5106 2 2 12 9 775 1872 2972 -5107 2 2 12 9 899 2296 3023 -5108 2 2 12 9 558 1883 2837 -5109 2 2 12 9 673 2298 2297 -5110 2 2 12 9 1121 3556 2025 -5111 2 2 12 9 1122 2026 3557 -5112 2 2 12 9 1152 3587 1903 -5113 2 2 12 9 429 1809 3442 -5114 2 2 12 9 825 1779 3515 -5115 2 2 12 9 604 2080 2831 -5116 2 2 12 9 1037 2999 2028 -5117 2 2 12 9 1127 3292 3471 -5118 2 2 12 9 1022 2538 1966 -5119 2 2 12 9 1624 2724 3636 -5120 2 2 12 9 620 2919 1850 -5121 2 2 12 9 1055 1937 2927 -5122 2 2 12 9 634 1879 3475 -5123 2 2 12 9 988 2508 2069 -5124 2 2 12 9 989 2070 2509 -5125 2 2 12 9 1019 3054 1983 -5126 2 2 12 9 959 1868 2688 -5127 2 2 12 9 960 2689 1869 -5128 2 2 12 9 399 1864 3203 -5129 2 2 12 9 426 2875 2639 -5130 2 2 12 9 427 2640 2876 -5131 2 2 12 9 1113 2167 2902 -5132 2 2 12 9 1320 2958 2098 -5133 2 2 12 9 1062 2907 1991 -5134 2 2 12 9 1292 3605 2184 -5135 2 2 12 9 1015 1816 3060 -5136 2 2 12 9 1016 3061 1817 -5137 2 2 12 9 408 3377 1897 -5138 2 2 12 9 409 1898 3378 -5139 2 2 12 9 560 2098 2958 -5140 2 2 12 9 601 2213 2754 -5141 2 2 12 9 602 2755 2214 -5142 2 2 12 9 1786 3330 2731 -5143 2 2 12 9 1787 2732 3331 -5144 2 2 12 9 478 2129 2404 -5145 2 2 12 9 479 2405 2130 -5146 2 2 12 9 241 242 2600 -5147 2 2 12 9 334 335 2601 -5148 2 2 12 9 1291 3168 2090 -5149 2 2 12 9 21 22 3551 -5150 2 2 12 9 1294 2339 2793 -5151 2 2 12 9 1076 3246 1964 -5152 2 2 12 9 485 3485 1841 -5153 2 2 12 9 800 2185 3005 -5154 2 2 12 9 424 2513 2983 -5155 2 2 12 9 918 2223 2666 -5156 2 2 12 9 919 2667 2224 -5157 2 2 12 9 1181 3577 2247 -5158 2 2 12 9 683 3334 1953 -5159 2 2 12 9 1177 2481 2194 -5160 2 2 12 9 432 1935 3033 -5161 2 2 12 9 433 3034 1936 -5162 2 2 12 9 1025 2368 2519 -5163 2 2 12 9 1345 3639 1796 -5164 2 2 12 9 1346 1797 3640 -5165 2 2 12 9 781 3123 1866 -5166 2 2 12 9 889 2844 2009 -5167 2 2 12 9 1587 2677 2088 -5168 2 2 12 9 1588 2089 2678 -5169 2 2 12 9 836 3376 2928 -5170 2 2 12 9 1139 2227 3108 -5171 2 2 12 9 1039 1928 3346 -5172 2 2 12 9 752 1997 2784 -5173 2 2 12 9 460 1914 3459 -5174 2 2 12 9 753 2786 2000 -5175 2 2 12 9 1110 2533 2166 -5176 2 2 12 9 504 2823 2106 -5177 2 2 12 9 208 2498 3599 -5178 2 2 12 9 1421 2472 3591 -5179 2 2 12 9 1081 1800 3341 -5180 2 2 12 9 1082 3342 1801 -5181 2 2 12 9 468 3586 2241 -5182 2 2 12 9 386 3402 2154 -5183 2 2 12 9 654 3132 3561 -5184 2 2 12 9 863 2348 2536 -5185 2 2 12 9 655 3562 3133 -5186 2 2 12 9 975 2261 2358 -5187 2 2 12 9 1052 3015 1818 -5188 2 2 12 9 195 3299 2054 -5189 2 2 12 9 949 2945 2572 -5190 2 2 12 9 510 3460 2085 -5191 2 2 12 9 1153 2297 2298 -5192 2 2 12 9 1345 1884 2818 -5193 2 2 12 9 1346 2819 1885 -5194 2 2 12 9 995 2610 2784 -5195 2 2 12 9 1141 2925 1851 -5196 2 2 12 9 996 2786 2611 -5197 2 2 12 9 1469 3551 1792 -5198 2 2 12 9 1398 3486 3546 -5199 2 2 12 9 504 3162 3220 -5200 2 2 12 9 359 1943 3405 -5201 2 2 12 9 768 2120 2797 -5202 2 2 12 9 769 2798 2121 -5203 2 2 12 9 220 221 3040 -5204 2 2 12 9 530 2232 2645 -5205 2 2 12 9 818 2021 3030 -5206 2 2 12 9 957 1971 2674 -5207 2 2 12 9 1219 2534 2347 -5208 2 2 12 9 424 2983 2457 -5209 2 2 12 9 910 2722 1876 -5210 2 2 12 9 1478 3161 1984 -5211 2 2 12 9 932 2500 2594 -5212 2 2 12 9 28 2140 2599 -5213 2 2 12 9 1061 3116 3518 -5214 2 2 12 9 1063 3519 3117 -5215 2 2 12 9 1479 3423 2506 -5216 2 2 12 9 941 2358 2261 -5217 2 2 12 9 702 1809 2996 -5218 2 2 12 9 813 2072 2518 -5219 2 2 12 9 942 2158 2536 -5220 2 2 12 9 1032 1934 3038 -5221 2 2 12 9 1071 2958 3516 -5222 2 2 12 9 860 2304 2540 -5223 2 2 12 9 861 2541 2305 -5224 2 2 12 9 1243 2741 3631 -5225 2 2 12 9 701 1903 3587 -5226 2 2 12 9 1052 1818 3193 -5227 2 2 12 9 1212 2784 2610 -5228 2 2 12 9 1213 2611 2786 -5229 2 2 12 9 1639 2928 3376 -5230 2 2 12 9 1281 3337 2595 -5231 2 2 12 9 1072 1906 2916 -5232 2 2 12 9 380 2427 3371 -5233 2 2 12 9 1339 2905 2363 -5234 2 2 12 9 1246 3420 2238 -5235 2 2 12 9 691 3505 2484 -5236 2 2 12 9 1111 2181 2412 -5237 2 2 12 9 1155 2136 2590 -5238 2 2 12 9 1013 3403 1856 -5239 2 2 12 9 1796 3639 2011 -5240 2 2 12 9 1797 2012 3640 -5241 2 2 12 9 1258 2429 2168 -5242 2 2 12 9 791 3206 1831 -5243 2 2 12 9 1175 2648 2684 -5244 2 2 12 9 1397 2845 3513 -5245 2 2 12 9 681 3350 1865 -5246 2 2 12 9 1454 3130 1918 -5247 2 2 12 9 1206 3298 1838 -5248 2 2 12 9 1207 1839 3300 -5249 2 2 12 9 878 3355 2353 -5250 2 2 12 9 765 2179 2578 -5251 2 2 12 9 280 2674 1971 -5252 2 2 12 9 718 3577 1871 -5253 2 2 12 9 1121 3319 2739 -5254 2 2 12 9 1122 2740 3320 -5255 2 2 12 9 577 2166 2533 -5256 2 2 12 9 808 2559 2082 -5257 2 2 12 9 809 2083 2560 -5258 2 2 12 9 524 3080 3158 -5259 2 2 12 9 516 1871 3086 -5260 2 2 12 9 1156 2054 3299 -5261 2 2 12 9 405 3210 2046 -5262 2 2 12 9 831 2412 2181 -5263 2 2 12 9 1375 1990 2656 -5264 2 2 12 9 748 1804 3375 -5265 2 2 12 9 1029 3180 1806 -5266 2 2 12 9 417 1821 3590 -5267 2 2 12 9 567 1878 3071 -5268 2 2 12 9 13 1910 2706 -5269 2 2 12 9 1181 1887 3086 -5270 2 2 12 9 235 2827 1852 -5271 2 2 12 9 897 2905 1996 -5272 2 2 12 9 338 2092 3392 -5273 2 2 12 9 348 2698 3302 -5274 2 2 12 9 1501 3257 1990 -5275 2 2 12 9 710 1967 3413 -5276 2 2 12 9 711 3414 1968 -5277 2 2 12 9 466 2424 3252 -5278 2 2 12 9 1177 1899 3514 -5279 2 2 12 9 985 1808 3110 -5280 2 2 12 9 554 2644 2091 -5281 2 2 12 9 725 1827 3630 -5282 2 2 12 9 522 2539 2050 -5283 2 2 12 9 1399 2444 3408 -5284 2 2 12 9 227 228 2708 -5285 2 2 12 9 1294 2793 2830 -5286 2 2 12 9 934 2926 1859 -5287 2 2 12 9 428 1859 2926 -5288 2 2 12 9 1480 3308 3431 -5289 2 2 12 9 415 2194 2481 -5290 2 2 12 9 1019 2814 2476 -5291 2 2 12 9 852 2281 2629 -5292 2 2 12 9 853 2630 2282 -5293 2 2 12 9 1068 2748 2092 -5294 2 2 12 9 1578 3220 3162 -5295 2 2 12 9 49 50 2763 -5296 2 2 12 9 171 172 2764 -5297 2 2 12 9 1383 3582 2438 -5298 2 2 12 9 927 1846 2900 -5299 2 2 12 9 928 2901 1847 -5300 2 2 12 9 401 3098 3646 -5301 2 2 12 9 1335 3262 3144 -5302 2 2 12 9 720 1845 3142 -5303 2 2 12 9 531 3347 2463 -5304 2 2 12 9 414 2407 2820 -5305 2 2 12 9 412 1957 2856 -5306 2 2 12 9 429 2184 3605 -5307 2 2 12 9 540 1940 3239 -5308 2 2 12 9 1027 2019 2848 -5309 2 2 12 9 897 1996 2813 -5310 2 2 12 9 935 2022 2662 -5311 2 2 12 9 982 2830 2793 -5312 2 2 12 9 1678 2334 2924 -5313 2 2 12 9 1451 2250 3209 -5314 2 2 12 9 707 3330 1786 -5315 2 2 12 9 708 1787 3331 -5316 2 2 12 9 980 2803 1974 -5317 2 2 12 9 877 2369 2269 -5318 2 2 12 9 549 3108 2227 -5319 2 2 12 9 1125 2737 2464 -5320 2 2 12 9 1126 2465 2738 -5321 2 2 12 9 822 3428 2778 -5322 2 2 12 9 962 1832 3137 -5323 2 2 12 9 666 3242 2788 -5324 2 2 12 9 863 2536 2158 -5325 2 2 12 9 1223 2690 3461 -5326 2 2 12 9 270 271 2696 -5327 2 2 12 9 725 1842 3391 -5328 2 2 12 9 790 1881 3196 -5329 2 2 12 9 14 2954 1910 -5330 2 2 12 9 1118 3102 2116 -5331 2 2 12 9 1275 2209 2471 -5332 2 2 12 9 1308 2263 2520 -5333 2 2 12 9 739 3534 2016 -5334 2 2 12 9 740 2017 3535 -5335 2 2 12 9 1143 2164 2453 -5336 2 2 12 9 1041 2831 2080 -5337 2 2 12 9 1140 3475 1879 -5338 2 2 12 9 1092 2637 2310 -5339 2 2 12 9 1265 2457 2983 -5340 2 2 12 9 513 2206 2897 -5341 2 2 12 9 995 2784 1997 -5342 2 2 12 9 996 2000 2786 -5343 2 2 12 9 389 2028 2999 -5344 2 2 12 9 350 3395 2390 -5345 2 2 12 9 1096 1865 3350 -5346 2 2 12 9 1244 1882 3124 -5347 2 2 12 9 701 3595 2468 -5348 2 2 12 9 984 3098 1832 -5349 2 2 12 9 815 2388 2782 -5350 2 2 12 9 816 2783 2389 -5351 2 2 12 9 1145 2690 3093 -5352 2 2 12 9 416 2590 2136 -5353 2 2 12 9 1146 3094 2691 -5354 2 2 12 9 1143 3614 2010 -5355 2 2 12 9 1004 3212 2023 -5356 2 2 12 9 703 1959 2904 -5357 2 2 12 9 1005 2024 3213 -5358 2 2 12 9 1312 2983 2513 -5359 2 2 12 9 562 2382 2960 -5360 2 2 12 9 564 2961 2383 -5361 2 2 12 9 1000 2684 2648 -5362 2 2 12 9 1097 1877 2909 -5363 2 2 12 9 868 2010 2561 -5364 2 2 12 9 485 1845 3416 -5365 2 2 12 9 245 246 3637 -5366 2 2 12 9 330 331 3638 -5367 2 2 12 9 1146 2691 3555 -5368 2 2 12 9 1003 1932 2941 -5369 2 2 12 9 1501 3507 2522 -5370 2 2 12 9 1098 3528 2284 -5371 2 2 12 9 1162 2820 2407 -5372 2 2 12 9 561 3221 2493 -5373 2 2 12 9 1335 2538 3262 -5374 2 2 12 9 1106 2715 3382 -5375 2 2 12 9 1195 3209 2250 -5376 2 2 12 9 1563 3422 3482 -5377 2 2 12 9 1188 3582 3307 -5378 2 2 12 9 572 3298 2152 -5379 2 2 12 9 405 2116 3102 -5380 2 2 12 9 774 2978 1911 -5381 2 2 12 9 768 3293 2120 -5382 2 2 12 9 769 2121 3294 -5383 2 2 12 9 567 2793 2339 -5384 2 2 12 9 1369 3048 2171 -5385 2 2 12 9 1154 2914 1919 -5386 2 2 12 9 1734 3197 1895 -5387 2 2 12 9 533 2705 2360 -5388 2 2 12 9 1735 1896 3198 -5389 2 2 12 9 1447 2204 3471 -5390 2 2 12 9 1117 2360 2705 -5391 2 2 12 9 377 2951 3506 -5392 2 2 12 9 1165 3459 1914 -5393 2 2 12 9 1027 2432 2765 -5394 2 2 12 9 983 1952 3028 -5395 2 2 12 9 1476 2567 2270 -5396 2 2 12 9 878 2477 3355 -5397 2 2 12 9 1083 2232 2409 -5398 2 2 12 9 261 262 2731 -5399 2 2 12 9 314 315 2732 -5400 2 2 12 9 568 2519 2368 -5401 2 2 12 9 254 255 2739 -5402 2 2 12 9 321 322 2740 -5403 2 2 12 9 766 2968 1933 -5404 2 2 12 9 878 2309 2477 -5405 2 2 12 9 635 3105 1926 -5406 2 2 12 9 1146 3555 3366 -5407 2 2 12 9 510 2186 3460 -5408 2 2 12 9 1563 1953 3422 -5409 2 2 12 9 727 1895 3197 -5410 2 2 12 9 860 2540 2142 -5411 2 2 12 9 861 2143 2541 -5412 2 2 12 9 728 3198 1896 -5413 2 2 12 9 211 3314 2065 -5414 2 2 12 9 565 2344 3055 -5415 2 2 12 9 1232 2615 3504 -5416 2 2 12 9 1007 2800 1912 -5417 2 2 12 9 1144 2046 3210 -5418 2 2 12 9 1083 2645 2232 -5419 2 2 12 9 346 2657 2064 -5420 2 2 12 9 1312 2513 3367 -5421 2 2 12 9 994 1965 2849 -5422 2 2 12 9 1021 3058 2646 -5423 2 2 12 9 1401 3371 2427 -5424 2 2 12 9 1329 3269 2307 -5425 2 2 12 9 1182 3257 3441 -5426 2 2 12 9 783 2011 3639 -5427 2 2 12 9 784 3640 2012 -5428 2 2 12 9 1195 2476 2814 -5429 2 2 12 9 843 1970 2838 -5430 2 2 12 9 453 1962 2807 -5431 2 2 12 9 839 1823 3272 -5432 2 2 12 9 889 2191 2844 -5433 2 2 12 9 823 2573 2122 -5434 2 2 12 9 824 2123 2574 -5435 2 2 12 9 1045 2540 2304 -5436 2 2 12 9 1046 2305 2541 -5437 2 2 12 9 540 3584 3023 -5438 2 2 12 9 486 1904 3454 -5439 2 2 12 9 487 3455 1905 -5440 2 2 12 9 1220 3252 1886 -5441 2 2 12 9 376 1921 3346 -5442 2 2 12 9 1675 3246 2446 -5443 2 2 12 9 609 3235 2608 -5444 2 2 12 9 957 2855 1971 -5445 2 2 12 9 1095 3239 1940 -5446 2 2 12 9 1524 3532 3189 -5447 2 2 12 9 338 3326 2092 -5448 2 2 12 9 667 3010 3366 -5449 2 2 12 9 733 3056 1921 -5450 2 2 12 9 1679 1935 3118 -5451 2 2 12 9 1680 3119 1936 -5452 2 2 12 9 734 1922 3057 -5453 2 2 12 9 559 2656 1990 -5454 2 2 12 9 1080 3162 3436 -5455 2 2 12 9 1156 3389 2054 -5456 2 2 12 9 1584 3604 2003 -5457 2 2 12 9 248 249 2775 -5458 2 2 12 9 327 328 2776 -5459 2 2 12 9 941 2261 3157 -5460 2 2 12 9 899 2556 2296 -5461 2 2 12 9 909 2699 2811 -5462 2 2 12 9 900 2013 3368 -5463 2 2 12 9 235 236 2827 -5464 2 2 12 9 611 2577 3259 -5465 2 2 12 9 909 1914 3647 -5466 2 2 12 9 639 2257 3291 -5467 2 2 12 9 1525 3188 3543 -5468 2 2 12 9 385 3149 2096 -5469 2 2 12 9 384 2097 3150 -5470 2 2 12 9 823 2129 2573 -5471 2 2 12 9 824 2574 2130 -5472 2 2 12 9 596 3262 2538 -5473 2 2 12 9 1032 2386 2978 -5474 2 2 12 9 1554 3266 2420 -5475 2 2 12 9 1043 3228 1941 -5476 2 2 12 9 1044 1942 3229 -5477 2 2 12 9 1043 2629 2281 -5478 2 2 12 9 1640 3366 3010 -5479 2 2 12 9 1044 2282 2630 -5480 2 2 12 9 1328 1894 3400 -5481 2 2 12 9 773 1909 2915 -5482 2 2 12 9 618 2662 2022 -5483 2 2 12 9 610 3028 1952 -5484 2 2 12 9 606 3523 2198 -5485 2 2 12 9 1569 2186 3476 -5486 2 2 12 9 610 3258 2552 -5487 2 2 12 9 1153 2298 3592 -5488 2 2 12 9 990 2608 2923 -5489 2 2 12 9 377 1922 2951 -5490 2 2 12 9 1068 3326 1949 -5491 2 2 12 9 1380 2748 2208 -5492 2 2 12 9 1405 2878 3592 -5493 2 2 12 9 697 3474 1930 -5494 2 2 12 9 429 2804 2830 -5495 2 2 12 9 509 2495 2800 -5496 2 2 12 9 1928 3527 3346 -5497 2 2 12 9 514 2489 3616 -5498 2 2 12 9 489 2030 2770 -5499 2 2 12 9 491 2771 2031 -5500 2 2 12 9 1486 2167 3025 -5501 2 2 12 9 1253 2808 2770 -5502 2 2 12 9 527 2033 3006 -5503 2 2 12 9 528 3007 2034 -5504 2 2 12 9 1070 2254 3362 -5505 2 2 12 9 1166 2065 3314 -5506 2 2 12 9 1283 2644 2884 -5507 2 2 12 9 876 2455 2240 -5508 2 2 12 9 207 3599 2306 -5509 2 2 12 9 1191 2078 3563 -5510 2 2 12 9 611 1954 3074 -5511 2 2 12 9 695 1916 3352 -5512 2 2 12 9 1146 3366 2835 -5513 2 2 12 9 652 2261 3003 -5514 2 2 12 9 1390 2612 3530 -5515 2 2 12 9 1430 3497 1973 -5516 2 2 12 9 275 276 3420 -5517 2 2 12 9 846 2020 2802 -5518 2 2 12 9 1132 3202 2099 -5519 2 2 12 9 871 2695 2064 -5520 2 2 12 9 1094 3381 2576 -5521 2 2 12 9 865 3380 1920 -5522 2 2 12 9 943 1897 3377 -5523 2 2 12 9 944 3378 1898 -5524 2 2 12 9 1703 2357 3109 -5525 2 2 12 9 518 1964 3246 -5526 2 2 12 9 46 47 3018 -5527 2 2 12 9 174 175 3019 -5528 2 2 12 9 955 2562 2192 -5529 2 2 12 9 937 3074 1954 -5530 2 2 12 9 943 2122 2573 -5531 2 2 12 9 944 2574 2123 -5532 2 2 12 9 347 2013 2664 -5533 2 2 12 9 1539 2474 2584 -5534 2 2 12 9 988 3518 2743 -5535 2 2 12 9 989 2744 3519 -5536 2 2 12 9 1489 2788 3242 -5537 2 2 12 9 1474 3373 3078 -5538 2 2 12 9 1279 3251 2590 -5539 2 2 12 9 1189 2646 3058 -5540 2 2 12 9 33 34 3042 -5541 2 2 12 9 1339 2468 3517 -5542 2 2 12 9 931 2086 3302 -5543 2 2 12 9 1603 3506 2951 -5544 2 2 12 9 818 3030 2205 -5545 2 2 12 9 527 2929 2069 -5546 2 2 12 9 528 2070 2930 -5547 2 2 12 9 1058 2871 2461 -5548 2 2 12 9 805 2520 2263 -5549 2 2 12 9 923 3565 3558 -5550 2 2 12 9 924 3559 3566 -5551 2 2 12 9 940 2074 3393 -5552 2 2 12 9 918 2666 2654 -5553 2 2 12 9 919 2655 2667 -5554 2 2 12 9 870 2270 2567 -5555 2 2 12 9 475 2025 2702 -5556 2 2 12 9 476 2703 2026 -5557 2 2 12 9 1206 2152 3298 -5558 2 2 12 9 571 2310 2637 -5559 2 2 12 9 527 3006 2094 -5560 2 2 12 9 528 2095 3007 -5561 2 2 12 9 187 188 3069 -5562 2 2 12 9 1425 2811 2699 -5563 2 2 12 9 378 3143 2056 -5564 2 2 12 9 707 2728 2745 -5565 2 2 12 9 708 2746 2729 -5566 2 2 12 9 895 1958 2879 -5567 2 2 12 9 1348 2493 3221 -5568 2 2 12 9 1012 3472 1913 -5569 2 2 12 9 360 2870 1982 -5570 2 2 12 9 1458 2211 3451 -5571 2 2 12 9 1086 1944 3052 -5572 2 2 12 9 892 3486 2843 -5573 2 2 12 9 945 2599 2140 -5574 2 2 12 9 1021 2533 2613 -5575 2 2 12 9 1197 2120 3293 -5576 2 2 12 9 1198 3294 2121 -5577 2 2 12 9 1753 3142 2496 -5578 2 2 12 9 828 2511 3077 -5579 2 2 12 9 190 191 3075 -5580 2 2 12 9 41 42 3083 -5581 2 2 12 9 179 180 3084 -5582 2 2 12 9 1226 2501 2672 -5583 2 2 12 9 884 2628 3641 -5584 2 2 12 9 1270 2578 2179 -5585 2 2 12 9 1402 2510 2400 -5586 2 2 12 9 850 2924 2334 -5587 2 2 12 9 407 2244 2646 -5588 2 2 12 9 976 2518 2680 -5589 2 2 12 9 1353 2306 3599 -5590 2 2 12 9 586 2873 2480 -5591 2 2 12 9 1397 3079 2478 -5592 2 2 12 9 961 1906 3220 -5593 2 2 12 9 1035 3163 3233 -5594 2 2 12 9 213 214 3104 -5595 2 2 12 9 1036 3234 3164 -5596 2 2 12 9 1446 2947 2603 -5597 2 2 12 9 242 3610 2600 -5598 2 2 12 9 334 2601 3611 -5599 2 2 12 9 1452 3351 3291 -5600 2 2 12 9 962 3137 1951 -5601 2 2 12 9 400 2551 3136 -5602 2 2 12 9 1254 2771 2810 -5603 2 2 12 9 1164 2420 3266 -5604 2 2 12 9 1030 1926 3105 -5605 2 2 12 9 347 3368 2013 -5606 2 2 12 9 1365 2608 3235 -5607 2 2 12 9 1845 1961 3416 -5608 2 2 12 9 712 1913 3472 -5609 2 2 12 9 1381 3576 2349 -5610 2 2 12 9 203 204 3128 -5611 2 2 12 9 1338 2679 3448 -5612 2 2 12 9 913 2672 2501 -5613 2 2 12 9 1457 2742 2436 -5614 2 2 12 9 2128 3282 2682 -5615 2 2 12 9 1350 2824 3613 -5616 2 2 12 9 1498 3548 2832 -5617 2 2 12 9 1499 2834 3549 -5618 2 2 12 9 1328 2477 2309 -5619 2 2 12 9 283 284 2932 -5620 2 2 12 9 1165 3304 3353 -5621 2 2 12 9 1026 2637 2687 -5622 2 2 12 9 953 3226 2088 -5623 2 2 12 9 954 2089 3227 -5624 2 2 12 9 492 1938 3498 -5625 2 2 12 9 489 2770 2808 -5626 2 2 12 9 396 1996 2905 -5627 2 2 12 9 551 3618 1967 -5628 2 2 12 9 552 1968 3619 -5629 2 2 12 9 504 3220 1906 -5630 2 2 12 9 1140 1879 3278 -5631 2 2 12 9 1175 3329 3165 -5632 2 2 12 9 1003 3127 2327 -5633 2 2 12 9 827 2643 2182 -5634 2 2 12 9 293 294 2959 -5635 2 2 12 9 871 2400 2510 -5636 2 2 12 9 964 2146 2692 -5637 2 2 12 9 965 2693 2148 -5638 2 2 12 9 988 2743 2126 -5639 2 2 12 9 989 2127 2744 -5640 2 2 12 9 600 3435 2192 -5641 2 2 12 9 473 2009 2844 -5642 2 2 12 9 1013 1860 3403 -5643 2 2 12 9 1186 3629 2228 -5644 2 2 12 9 201 1973 3497 -5645 2 2 12 9 683 3564 3334 -5646 2 2 12 9 1387 3620 3169 -5647 2 2 12 9 1388 3170 3621 -5648 2 2 12 9 432 3118 1935 -5649 2 2 12 9 433 1936 3119 -5650 2 2 12 9 967 3192 2237 -5651 2 2 12 9 978 2770 2030 -5652 2 2 12 9 979 2031 2771 -5653 2 2 12 9 1053 1929 3290 -5654 2 2 12 9 980 1974 3205 -5655 2 2 12 9 490 2160 2621 -5656 2 2 12 9 1071 2583 2563 -5657 2 2 12 9 1192 2128 3631 -5658 2 2 12 9 1389 2393 3353 -5659 2 2 12 9 341 2965 1991 -5660 2 2 12 9 1007 1912 3421 -5661 2 2 12 9 1024 2563 2583 -5662 2 2 12 9 1116 2701 2151 -5663 2 2 12 9 1035 2502 2852 -5664 2 2 12 9 1036 2853 2503 -5665 2 2 12 9 1959 3632 3009 -5666 2 2 12 9 1293 2198 3523 -5667 2 2 12 9 1184 2480 2873 -5668 2 2 12 9 1294 2830 2804 -5669 2 2 12 9 1068 2208 2748 -5670 2 2 12 9 883 2347 2534 -5671 2 2 12 9 277 3044 2238 -5672 2 2 12 9 535 2854 3209 -5673 2 2 12 9 819 3271 2107 -5674 2 2 12 9 524 2262 2867 -5675 2 2 12 9 1197 3359 2245 -5676 2 2 12 9 1198 2246 3360 -5677 2 2 12 9 953 2088 2677 -5678 2 2 12 9 954 2678 2089 -5679 2 2 12 9 983 3297 1952 -5680 2 2 12 9 491 2810 2771 -5681 2 2 12 9 592 2596 2260 -5682 2 2 12 9 851 3625 2427 -5683 2 2 12 9 973 2117 3089 -5684 2 2 12 9 974 3090 2118 -5685 2 2 12 9 1084 3446 1967 -5686 2 2 12 9 1085 1968 3447 -5687 2 2 12 9 959 2332 2780 -5688 2 2 12 9 960 2781 2333 -5689 2 2 12 9 517 1900 3152 -5690 2 2 12 9 842 2200 2805 -5691 2 2 12 9 518 3153 1901 -5692 2 2 12 9 971 2248 3270 -5693 2 2 12 9 1489 3634 2788 -5694 2 2 12 9 1248 2745 2728 -5695 2 2 12 9 1249 2729 2746 -5696 2 2 12 9 581 2816 2525 -5697 2 2 12 9 582 2526 2817 -5698 2 2 12 9 1110 2613 2533 -5699 2 2 12 9 195 196 3299 -5700 2 2 12 9 1401 2427 3625 -5701 2 2 12 9 934 3106 2141 -5702 2 2 12 9 1037 2884 2644 -5703 2 2 12 9 443 3563 2078 -5704 2 2 12 9 1117 2056 3143 -5705 2 2 12 9 1417 2090 3168 -5706 2 2 12 9 593 2942 2375 -5707 2 2 12 9 978 3385 1975 -5708 2 2 12 9 594 2376 2943 -5709 2 2 12 9 979 1976 3386 -5710 2 2 12 9 1414 2153 2895 -5711 2 2 12 9 497 2366 2860 -5712 2 2 12 9 613 3499 2176 -5713 2 2 12 9 1308 3273 2149 -5714 2 2 12 9 792 1955 3316 -5715 2 2 12 9 1023 3109 2357 -5716 2 2 12 9 1241 2654 2666 -5717 2 2 12 9 401 1951 3137 -5718 2 2 12 9 1242 2667 2655 -5719 2 2 12 9 211 212 3314 -5720 2 2 12 9 420 2792 2172 -5721 2 2 12 9 421 2173 2794 -5722 2 2 12 9 248 2775 3176 -5723 2 2 12 9 328 3177 2776 -5724 2 2 12 9 1021 2646 2244 -5725 2 2 12 9 703 3632 1959 -5726 2 2 12 9 777 3008 1954 -5727 2 2 12 9 1109 3352 1916 -5728 2 2 12 9 1119 3078 3373 -5729 2 2 12 9 624 2122 3493 -5730 2 2 12 9 625 3494 2123 -5731 2 2 12 9 1185 2461 2871 -5732 2 2 12 9 1513 3315 2184 -5733 2 2 12 9 1027 2765 3628 -5734 2 2 12 9 18 19 3354 -5735 2 2 12 9 4 239 3588 -5736 2 2 12 9 3 3589 337 -5737 2 2 12 9 277 278 3044 -5738 2 2 12 9 1086 2432 2622 -5739 2 2 12 9 563 3421 1912 -5740 2 2 12 9 658 3190 2075 -5741 2 2 12 9 595 2634 3560 -5742 2 2 12 9 1488 3091 3211 -5743 2 2 12 9 1208 2805 2093 -5744 2 2 12 9 1079 2550 3281 -5745 2 2 12 9 4 3588 52 -5746 2 2 12 9 3 169 3589 -5747 2 2 12 9 265 266 3606 -5748 2 2 12 9 310 311 3607 -5749 2 2 12 9 977 3011 1929 -5750 2 2 12 9 1110 1958 3585 -5751 2 2 12 9 621 3513 2845 -5752 2 2 12 9 674 3631 2128 -5753 2 2 12 9 368 2753 2430 -5754 2 2 12 9 1120 2180 3207 -5755 2 2 12 9 1061 2069 2929 -5756 2 2 12 9 1000 2648 2290 -5757 2 2 12 9 1063 2930 2070 -5758 2 2 12 9 200 201 3497 -5759 2 2 12 9 881 2675 2228 -5760 2 2 12 9 355 2245 3359 -5761 2 2 12 9 380 3371 1920 -5762 2 2 12 9 356 3360 2246 -5763 2 2 12 9 1320 3516 2958 -5764 2 2 12 9 1448 3043 2226 -5765 2 2 12 9 1136 3096 3181 -5766 2 2 12 9 1401 2597 3371 -5767 2 2 12 9 207 208 3599 -5768 2 2 12 9 10 11 3624 -5769 2 2 12 9 584 2622 2432 -5770 2 2 12 9 896 3073 2496 -5771 2 2 12 9 801 2918 2193 -5772 2 2 12 9 949 2867 2262 -5773 2 2 12 9 1074 3211 3091 -5774 2 2 12 9 994 3478 1965 -5775 2 2 12 9 1310 1918 3130 -5776 2 2 12 9 1113 2589 3025 -5777 2 2 12 9 461 2419 3408 -5778 2 2 12 9 436 3009 2039 -5779 2 2 12 9 879 2683 2189 -5780 2 2 12 9 1307 3136 2551 -5781 2 2 12 9 1481 3274 2114 -5782 2 2 12 9 1482 2115 3277 -5783 2 2 12 9 1822 2499 3641 -5784 2 2 12 9 789 2009 3427 -5785 2 2 12 9 994 2849 2730 -5786 2 2 12 9 1421 3422 1953 -5787 2 2 12 9 846 2134 2749 -5788 2 2 12 9 1441 2260 3070 -5789 2 2 12 9 938 3063 2451 -5790 2 2 12 9 939 2452 3064 -5791 2 2 12 9 992 2366 2649 -5792 2 2 12 9 993 2650 2367 -5793 2 2 12 9 378 2056 2940 -5794 2 2 12 9 1075 3073 2328 -5795 2 2 12 9 553 2580 2806 -5796 2 2 12 9 1674 3392 2092 -5797 2 2 12 9 500 1965 3478 -5798 2 2 12 9 1096 3350 1867 -5799 2 2 12 9 216 217 3465 -5800 2 2 12 9 1517 2843 3486 -5801 2 2 12 9 1096 3531 2977 -5802 2 2 12 9 1092 2687 2637 -5803 2 2 12 9 249 250 3622 -5804 2 2 12 9 326 327 3623 -5805 2 2 12 9 437 3482 3422 -5806 2 2 12 9 1356 2106 2823 -5807 2 2 12 9 835 3402 1969 -5808 2 2 12 9 1451 3209 2854 -5809 2 2 12 9 1000 2290 2638 -5810 2 2 12 9 346 3041 2004 -5811 2 2 12 9 1081 2169 3083 -5812 2 2 12 9 1082 3084 2170 -5813 2 2 12 9 858 2436 2742 -5814 2 2 12 9 610 1952 3274 -5815 2 2 12 9 1354 3451 2211 -5816 2 2 12 9 1080 2075 3190 -5817 2 2 12 9 497 2860 2604 -5818 2 2 12 9 611 3277 1954 -5819 2 2 12 9 225 226 3276 -5820 2 2 12 9 667 2555 2576 -5821 2 2 12 9 1025 2519 2483 -5822 2 2 12 9 972 3464 2107 -5823 2 2 12 9 1555 2628 2529 -5824 2 2 12 9 968 3517 2468 -5825 2 2 12 9 956 2280 3544 -5826 2 2 12 9 1259 2098 3648 -5827 2 2 12 9 1149 3340 2696 -5828 2 2 12 9 247 248 3176 -5829 2 2 12 9 328 329 3177 -5830 2 2 12 9 676 3431 3308 -5831 2 2 12 9 1807 2949 3598 -5832 2 2 12 9 1145 3093 3616 -5833 2 2 12 9 1002 2182 2643 -5834 2 2 12 9 559 1990 3257 -5835 2 2 12 9 1245 2730 2849 -5836 2 2 12 9 366 3457 1939 -5837 2 2 12 9 1492 3026 2210 -5838 2 2 12 9 885 1953 3334 -5839 2 2 12 9 419 2290 2648 -5840 2 2 12 9 1280 2335 2969 -5841 2 2 12 9 1786 2515 3240 -5842 2 2 12 9 1787 3241 2516 -5843 2 2 12 9 1527 2963 3591 -5844 2 2 12 9 436 3147 3263 -5845 2 2 12 9 1612 2624 2842 -5846 2 2 12 9 348 2086 2977 -5847 2 2 12 9 1094 2576 2555 -5848 2 2 12 9 397 2880 3540 -5849 2 2 12 9 866 3598 2159 -5850 2 2 12 9 551 1967 3446 -5851 2 2 12 9 552 3447 1968 -5852 2 2 12 9 296 297 3223 -5853 2 2 12 9 1285 2726 2494 -5854 2 2 12 9 1019 1986 3394 -5855 2 2 12 9 941 3157 2593 -5856 2 2 12 9 1002 2752 2329 -5857 2 2 12 9 1152 2238 3044 -5858 2 2 12 9 657 3365 2546 -5859 2 2 12 9 1491 3560 2634 -5860 2 2 12 9 546 2215 2737 -5861 2 2 12 9 547 2738 2216 -5862 2 2 12 9 622 2584 2474 -5863 2 2 12 9 443 2078 3394 -5864 2 2 12 9 1510 2552 3258 -5865 2 2 12 9 961 2362 3374 -5866 2 2 12 9 41 3083 2169 -5867 2 2 12 9 180 2170 3084 -5868 2 2 12 9 1376 2375 2942 -5869 2 2 12 9 1377 2943 2376 -5870 2 2 12 9 1415 3176 2775 -5871 2 2 12 9 1416 2776 3177 -5872 2 2 12 9 513 3419 2478 -5873 2 2 12 9 1188 2459 3582 -5874 2 2 12 9 1210 2632 3445 -5875 2 2 12 9 716 3601 3403 -5876 2 2 12 9 1065 3356 3479 -5877 2 2 12 9 1511 3259 2577 -5878 2 2 12 9 1030 3105 1973 -5879 2 2 12 9 443 3394 1986 -5880 2 2 12 9 1026 2483 2519 -5881 2 2 12 9 1164 3266 3489 -5882 2 2 12 9 1061 2760 3116 -5883 2 2 12 9 1063 3117 2761 -5884 2 2 12 9 349 2636 3284 -5885 2 2 12 9 1172 3598 2949 -5886 2 2 12 9 1488 2433 3091 -5887 2 2 12 9 385 2449 3139 -5888 2 2 12 9 384 3140 2450 -5889 2 2 12 9 793 3029 1986 -5890 2 2 12 9 612 3180 2458 -5891 2 2 12 9 524 2867 2416 -5892 2 2 12 9 516 2884 2361 -5893 2 2 12 9 911 2094 3006 -5894 2 2 12 9 912 3007 2095 -5895 2 2 12 9 553 2916 2733 -5896 2 2 12 9 1576 3263 3147 -5897 2 2 12 9 541 1993 3343 -5898 2 2 12 9 1047 3173 3571 -5899 2 2 12 9 1048 3572 3174 -5900 2 2 12 9 791 1962 3206 -5901 2 2 12 9 477 1984 3430 -5902 2 2 12 9 1253 2202 2808 -5903 2 2 12 9 1001 2073 3134 -5904 2 2 12 9 471 2891 2379 -5905 2 2 12 9 573 3038 3300 -5906 2 2 12 9 1144 2984 2046 -5907 2 2 12 9 1335 3144 2532 -5908 2 2 12 9 819 2287 3271 -5909 2 2 12 9 629 2477 3400 -5910 2 2 12 9 1087 2895 2153 -5911 2 2 12 9 906 2344 2636 -5912 2 2 12 9 867 2342 2614 -5913 2 2 12 9 865 2062 3184 -5914 2 2 12 9 1246 2238 2865 -5915 2 2 12 9 1112 1928 3305 -5916 2 2 12 9 1139 3108 2568 -5917 2 2 12 9 1622 3311 2852 -5918 2 2 12 9 855 2297 3092 -5919 2 2 12 9 1623 2853 3312 -5920 2 2 12 9 755 3054 2078 -5921 2 2 12 9 275 3420 2212 -5922 2 2 12 9 1359 2716 3351 -5923 2 2 12 9 1254 2810 2203 -5924 2 2 12 9 392 2318 2760 -5925 2 2 12 9 393 2761 2319 -5926 2 2 12 9 410 2969 2335 -5927 2 2 12 9 1136 3181 2598 -5928 2 2 12 9 920 2144 2888 -5929 2 2 12 9 1654 3558 3565 -5930 2 2 12 9 1655 3566 3559 -5931 2 2 12 9 1602 2149 3273 -5932 2 2 12 9 527 2094 2929 -5933 2 2 12 9 528 2930 2095 -5934 2 2 12 9 966 3521 2210 -5935 2 2 12 9 1257 3411 2035 -5936 2 2 12 9 1018 2940 2056 -5937 2 2 12 9 376 3346 3527 -5938 2 2 12 9 1856 3403 3601 -5939 2 2 12 9 982 2165 2996 -5940 2 2 12 9 643 3125 2620 -5941 2 2 12 9 907 3448 2679 -5942 2 2 12 9 491 2031 3495 -5943 2 2 12 9 1112 3527 1928 -5944 2 2 12 9 1142 3144 3262 -5945 2 2 12 9 722 3138 2485 -5946 2 2 12 9 1452 2135 3351 -5947 2 2 12 9 897 2363 2905 -5948 2 2 12 9 305 306 3512 -5949 2 2 12 9 447 3134 2073 -5950 2 2 12 9 489 3573 2030 -5951 2 2 12 9 568 2789 2519 -5952 2 2 12 9 242 243 3610 -5953 2 2 12 9 333 334 3611 -5954 2 2 12 9 1157 3330 2255 -5955 2 2 12 9 1158 2256 3331 -5956 2 2 12 9 1343 3116 2760 -5957 2 2 12 9 934 2141 2970 -5958 2 2 12 9 1344 2761 3117 -5959 2 2 12 9 1030 1973 3231 -5960 2 2 12 9 218 3032 2067 -5961 2 2 12 9 914 2897 2206 -5962 2 2 12 9 950 2754 2213 -5963 2 2 12 9 951 2214 2755 -5964 2 2 12 9 437 3591 2963 -5965 2 2 12 9 560 3648 2098 -5966 2 2 12 9 1026 2687 2483 -5967 2 2 12 9 521 3207 2180 -5968 2 2 12 9 1370 2546 3365 -5969 2 2 12 9 1229 3139 2449 -5970 2 2 12 9 1230 2450 3140 -5971 2 2 12 9 1027 2848 2432 -5972 2 2 12 9 1239 2568 3108 -5973 2 2 12 9 897 2813 2241 -5974 2 2 12 9 1113 3025 2167 -5975 2 2 12 9 559 3329 2254 -5976 2 2 12 9 1328 3400 2477 -5977 2 2 12 9 1573 3578 2752 -5978 2 2 12 9 1409 3416 1961 -5979 2 2 12 9 423 3381 2014 -5980 2 2 12 9 639 3291 3351 -5981 2 2 12 9 523 3553 2008 -5982 2 2 12 9 1231 2008 3553 -5983 2 2 12 9 1211 2485 3138 -5984 2 2 12 9 550 2347 2701 -5985 2 2 12 9 1257 2035 3470 -5986 2 2 12 9 906 3055 2344 -5987 2 2 12 9 1326 2193 2918 -5988 2 2 12 9 497 2649 2366 -5989 2 2 12 9 498 2367 2650 -5990 2 2 12 9 956 3544 2512 -5991 2 2 12 9 411 2329 2752 -5992 2 2 12 9 1006 2225 3232 -5993 2 2 12 9 1456 2512 3544 -5994 2 2 12 9 884 2529 2628 -5995 2 2 12 9 908 2653 2570 -5996 2 2 12 9 744 2033 3341 -5997 2 2 12 9 745 3342 2034 -5998 2 2 12 9 1394 3165 3329 -5999 2 2 12 9 1003 3268 2335 -6000 2 2 12 9 1053 3290 2285 -6001 2 2 12 9 707 2255 3330 -6002 2 2 12 9 708 3331 2256 -6003 2 2 12 9 1010 2799 2244 -6004 2 2 12 9 203 3128 2294 -6005 2 2 12 9 1464 3334 3564 -6006 2 2 12 9 1035 3311 2330 -6007 2 2 12 9 1036 2331 3312 -6008 2 2 12 9 1307 2551 2662 -6009 2 2 12 9 557 2909 2462 -6010 2 2 12 9 639 3351 2716 -6011 2 2 12 9 598 3091 2433 -6012 2 2 12 9 1011 2908 2201 -6013 2 2 12 9 371 1975 3385 -6014 2 2 12 9 372 3386 1976 -6015 2 2 12 9 623 2631 3530 -6016 2 2 12 9 348 3302 2086 -6017 2 2 12 9 758 2150 3305 -6018 2 2 12 9 1056 2288 2816 -6019 2 2 12 9 1057 2817 2289 -6020 2 2 12 9 513 2973 2206 -6021 2 2 12 9 1173 2108 2993 -6022 2 2 12 9 489 2808 2217 -6023 2 2 12 9 410 3268 2682 -6024 2 2 12 9 1152 2865 2238 -6025 2 2 12 9 1153 3092 2297 -6026 2 2 12 9 2025 3556 2702 -6027 2 2 12 9 2026 2703 3557 -6028 2 2 12 9 1490 3005 2185 -6029 2 2 12 9 394 2483 2687 -6030 2 2 12 9 1220 2922 2670 -6031 2 2 12 9 1121 2043 3556 -6032 2 2 12 9 1122 3557 2044 -6033 2 2 12 9 1128 2294 3128 -6034 2 2 12 9 420 3338 2610 -6035 2 2 12 9 480 2141 3106 -6036 2 2 12 9 491 2231 2810 -6037 2 2 12 9 421 2611 3339 -6038 2 2 12 9 1068 2092 3326 -6039 2 2 12 9 1332 3256 2071 -6040 2 2 12 9 1649 3100 2874 -6041 2 2 12 9 1026 2598 2637 -6042 2 2 12 9 1175 2254 3329 -6043 2 2 12 9 632 3503 2066 -6044 2 2 12 9 456 2933 2575 -6045 2 2 12 9 1109 2965 2522 -6046 2 2 12 9 828 3077 2190 -6047 2 2 12 9 915 2417 2762 -6048 2 2 12 9 265 3606 2350 -6049 2 2 12 9 311 2351 3607 -6050 2 2 12 9 252 2088 3226 -6051 2 2 12 9 324 3227 2089 -6052 2 2 12 9 906 2424 3055 -6053 2 2 12 9 608 3393 2074 -6054 2 2 12 9 1536 2709 3487 -6055 2 2 12 9 543 2920 2137 -6056 2 2 12 9 544 2138 2921 -6057 2 2 12 9 890 3556 2043 -6058 2 2 12 9 891 2044 3557 -6059 2 2 12 9 1187 3480 1993 -6060 2 2 12 9 516 3107 2884 -6061 2 2 12 9 1343 2760 2318 -6062 2 2 12 9 1344 2319 2761 -6063 2 2 12 9 1125 2332 2885 -6064 2 2 12 9 1126 2886 2333 -6065 2 2 12 9 1251 2205 3030 -6066 2 2 12 9 1088 2858 2581 -6067 2 2 12 9 1089 2582 2859 -6068 2 2 12 9 1447 3292 3053 -6069 2 2 12 9 630 2780 2332 -6070 2 2 12 9 631 2333 2781 -6071 2 2 12 9 298 3412 2063 -6072 2 2 12 9 935 2662 2551 -6073 2 2 12 9 1104 3317 2728 -6074 2 2 12 9 1105 2729 3318 -6075 2 2 12 9 1107 2803 2527 -6076 2 2 12 9 1247 2620 3125 -6077 2 2 12 9 1474 3078 2403 -6078 2 2 12 9 20 3114 2159 -6079 2 2 12 9 1437 2981 3534 -6080 2 2 12 9 1438 3535 2982 -6081 2 2 12 9 1471 2570 2653 -6082 2 2 12 9 915 2762 3501 -6083 2 2 12 9 637 2265 3179 -6084 2 2 12 9 1004 2047 3212 -6085 2 2 12 9 1005 3213 2048 -6086 2 2 12 9 1112 3305 2150 -6087 2 2 12 9 684 2537 3113 -6088 2 2 12 9 980 2527 2803 -6089 2 2 12 9 764 3202 2176 -6090 2 2 12 9 1283 2884 3107 -6091 2 2 12 9 1110 2166 3146 -6092 2 2 12 9 1477 3479 3356 -6093 2 2 12 9 633 3373 3022 -6094 2 2 12 9 1139 2133 3510 -6095 2 2 12 9 2010 3614 2561 -6096 2 2 12 9 1086 2765 2432 -6097 2 2 12 9 779 2668 3436 -6098 2 2 12 9 1069 2616 2622 -6099 2 2 12 9 1130 2782 2388 -6100 2 2 12 9 1131 2389 2783 -6101 2 2 12 9 646 2315 3275 -6102 2 2 12 9 530 3471 2204 -6103 2 2 12 9 932 3612 2258 -6104 2 2 12 9 1376 2942 3214 -6105 2 2 12 9 1377 3215 2943 -6106 2 2 12 9 414 2820 2945 -6107 2 2 12 9 1192 3282 2128 -6108 2 2 12 9 1324 3233 3163 -6109 2 2 12 9 1325 3164 3234 -6110 2 2 12 9 1226 2672 3208 -6111 2 2 12 9 1474 3022 3373 -6112 2 2 12 9 1100 3214 2942 -6113 2 2 12 9 1527 3591 2472 -6114 2 2 12 9 1101 2943 3215 -6115 2 2 12 9 941 3396 2358 -6116 2 2 12 9 1233 2665 3221 -6117 2 2 12 9 1127 2645 2751 -6118 2 2 12 9 1411 3530 2631 -6119 2 2 12 9 1611 2285 3191 -6120 2 2 12 9 1791 3476 2186 -6121 2 2 12 9 1378 2005 3499 -6122 2 2 12 9 571 2637 2598 -6123 2 2 12 9 1018 2056 3254 -6124 2 2 12 9 794 3574 2053 -6125 2 2 12 9 1090 3045 3171 -6126 2 2 12 9 1091 3172 3046 -6127 2 2 12 9 1348 3221 2665 -6128 2 2 12 9 1026 2789 2598 -6129 2 2 12 9 396 3517 2507 -6130 2 2 12 9 929 2860 2366 -6131 2 2 12 9 1041 2262 3158 -6132 2 2 12 9 791 3389 2112 -6133 2 2 12 9 896 2496 3142 -6134 2 2 12 9 392 2760 2581 -6135 2 2 12 9 393 2582 2761 -6136 2 2 12 9 1608 2394 3574 -6137 2 2 12 9 1123 2051 3413 -6138 2 2 12 9 1124 3414 2052 -6139 2 2 12 9 477 2107 3464 -6140 2 2 12 9 618 2022 3456 -6141 2 2 12 9 687 3169 3620 -6142 2 2 12 9 688 3621 3170 -6143 2 2 12 9 362 2247 3361 -6144 2 2 12 9 1051 3477 2105 -6145 2 2 12 9 1332 2682 3268 -6146 2 2 12 9 714 2494 2726 -6147 2 2 12 9 1083 2751 2645 -6148 2 2 12 9 1320 2658 2773 -6149 2 2 12 9 1221 2854 3429 -6150 2 2 12 9 973 3089 2525 -6151 2 2 12 9 974 2526 3090 -6152 2 2 12 9 929 2322 2801 -6153 2 2 12 9 353 3053 3292 -6154 2 2 12 9 1129 3179 2265 -6155 2 2 12 9 1275 2778 3428 -6156 2 2 12 9 607 2874 3100 -6157 2 2 12 9 666 2788 2554 -6158 2 2 12 9 376 3527 2125 -6159 2 2 12 9 1006 2264 3560 -6160 2 2 12 9 1032 3038 2452 -6161 2 2 12 9 1290 3503 2572 -6162 2 2 12 9 341 2522 2965 -6163 2 2 12 9 626 3135 2704 -6164 2 2 12 9 1296 2350 3606 -6165 2 2 12 9 1297 3607 2351 -6166 2 2 12 9 1161 2226 3043 -6167 2 2 12 9 1429 3263 2338 -6168 2 2 12 9 1140 2050 3475 -6169 2 2 12 9 1086 2622 2616 -6170 2 2 12 9 584 2432 2848 -6171 2 2 12 9 1463 2747 3469 -6172 2 2 12 9 1003 2335 3127 -6173 2 2 12 9 1125 3541 2047 -6174 2 2 12 9 1126 2048 3542 -6175 2 2 12 9 1337 3511 2145 -6176 2 2 12 9 574 2447 3567 -6177 2 2 12 9 836 2431 3376 -6178 2 2 12 9 575 3568 2448 -6179 2 2 12 9 643 3496 3613 -6180 2 2 12 9 590 2338 2931 -6181 2 2 12 9 392 2581 2858 -6182 2 2 12 9 393 2859 2582 -6183 2 2 12 9 1178 2575 2933 -6184 2 2 12 9 1199 3113 2537 -6185 2 2 12 9 818 3249 2229 -6186 2 2 12 9 1026 2519 2789 -6187 2 2 12 9 501 2037 3593 -6188 2 2 12 9 1320 2773 3516 -6189 2 2 12 9 1391 2775 3622 -6190 2 2 12 9 1392 3623 2776 -6191 2 2 12 9 1306 2686 2669 -6192 2 2 12 9 1196 2847 3125 -6193 2 2 12 9 1030 3231 2294 -6194 2 2 12 9 972 2107 3271 -6195 2 2 12 9 540 3023 2296 -6196 2 2 12 9 676 3424 3431 -6197 2 2 12 9 1054 2249 3349 -6198 2 2 12 9 506 3324 2142 -6199 2 2 12 9 507 2143 3325 -6200 2 2 12 9 524 3158 2262 -6201 2 2 12 9 1112 2125 3527 -6202 2 2 12 9 1175 3165 2648 -6203 2 2 12 9 1104 3087 3317 -6204 2 2 12 9 1105 3318 3088 -6205 2 2 12 9 679 3468 2151 -6206 2 2 12 9 1197 3279 2120 -6207 2 2 12 9 1198 2121 3280 -6208 2 2 12 9 543 2440 2920 -6209 2 2 12 9 544 2921 2441 -6210 2 2 12 9 1062 2795 2833 -6211 2 2 12 9 1206 3203 2152 -6212 2 2 12 9 1247 3125 2847 -6213 2 2 12 9 1331 3014 2635 -6214 2 2 12 9 1485 2423 3295 -6215 2 2 12 9 1200 2373 3169 -6216 2 2 12 9 1201 3170 2374 -6217 2 2 12 9 1364 3182 3112 -6218 2 2 12 9 652 3157 2261 -6219 2 2 12 9 585 3052 2408 -6220 2 2 12 9 950 3066 2301 -6221 2 2 12 9 951 2302 3067 -6222 2 2 12 9 1116 2151 3468 -6223 2 2 12 9 1240 2258 3612 -6224 2 2 12 9 250 2275 3622 -6225 2 2 12 9 326 3623 2276 -6226 2 2 12 9 1169 2935 2705 -6227 2 2 12 9 840 3171 2161 -6228 2 2 12 9 841 2162 3172 -6229 2 2 12 9 1725 3050 2936 -6230 2 2 12 9 1726 2937 3051 -6231 2 2 12 9 411 3578 2234 -6232 2 2 12 9 1055 2927 3107 -6233 2 2 12 9 539 2635 3014 -6234 2 2 12 9 1035 2330 3163 -6235 2 2 12 9 1036 3164 2331 -6236 2 2 12 9 1013 2379 2891 -6237 2 2 12 9 812 2093 3550 -6238 2 2 12 9 1038 3424 2415 -6239 2 2 12 9 1069 2149 3522 -6240 2 2 12 9 1359 3351 2135 -6241 2 2 12 9 1097 3250 2303 -6242 2 2 12 9 952 3126 2528 -6243 2 2 12 9 1290 2945 2820 -6244 2 2 12 9 569 2528 3156 -6245 2 2 12 9 1171 3361 2247 -6246 2 2 12 9 975 3003 2261 -6247 2 2 12 9 1141 2697 2925 -6248 2 2 12 9 1061 2581 2760 -6249 2 2 12 9 1063 2761 2582 -6250 2 2 12 9 1239 3108 2836 -6251 2 2 12 9 1147 2472 3186 -6252 2 2 12 9 1035 3233 2502 -6253 2 2 12 9 1036 2503 3234 -6254 2 2 12 9 640 3208 2672 -6255 2 2 12 9 1157 2731 3330 -6256 2 2 12 9 1158 3331 2732 -6257 2 2 12 9 379 3582 2459 -6258 2 2 12 9 338 3245 2308 -6259 2 2 12 9 632 2572 3503 -6260 2 2 12 9 985 2727 2663 -6261 2 2 12 9 458 2114 3348 -6262 2 2 12 9 357 2418 2913 -6263 2 2 12 9 622 3388 3161 -6264 2 2 12 9 287 2237 3192 -6265 2 2 12 9 543 2137 3200 -6266 2 2 12 9 1093 2554 2788 -6267 2 2 12 9 544 3201 2138 -6268 2 2 12 9 1594 2522 3507 -6269 2 2 12 9 221 2230 3040 -6270 2 2 12 9 364 3510 2133 -6271 2 2 12 9 1043 2281 3228 -6272 2 2 12 9 1309 2663 2727 -6273 2 2 12 9 1044 3229 2282 -6274 2 2 12 9 964 2936 3050 -6275 2 2 12 9 1292 2184 3315 -6276 2 2 12 9 965 3051 2937 -6277 2 2 12 9 1038 3085 2479 -6278 2 2 12 9 1136 2598 2789 -6279 2 2 12 9 1170 2484 3505 -6280 2 2 12 9 1273 2897 2482 -6281 2 2 12 9 414 2945 2395 -6282 2 2 12 9 247 3176 2377 -6283 2 2 12 9 329 2378 3177 -6284 2 2 12 9 586 2480 2984 -6285 2 2 12 9 523 2150 3553 -6286 2 2 12 9 949 3411 2867 -6287 2 2 12 9 510 2105 3477 -6288 2 2 12 9 662 2164 3539 -6289 2 2 12 9 1315 3295 2423 -6290 2 2 12 9 603 2902 3636 -6291 2 2 12 9 1189 2833 2795 -6292 2 2 12 9 1135 2308 3245 -6293 2 2 12 9 373 3462 2110 -6294 2 2 12 9 374 2111 3463 -6295 2 2 12 9 640 3522 2149 -6296 2 2 12 9 1054 3500 2249 -6297 2 2 12 9 914 2482 2897 -6298 2 2 12 9 1137 3112 3182 -6299 2 2 12 9 977 2530 3011 -6300 2 2 12 9 629 3451 3355 -6301 2 2 12 9 984 2669 2686 -6302 2 2 12 9 385 3139 3149 -6303 2 2 12 9 384 3150 3140 -6304 2 2 12 9 963 2773 2658 -6305 2 2 12 9 1321 3388 2163 -6306 2 2 12 9 1099 2931 2338 -6307 2 2 12 9 682 3166 2881 -6308 2 2 12 9 619 3186 2472 -6309 2 2 12 9 1327 2681 3286 -6310 2 2 12 9 1065 2249 3356 -6311 2 2 12 9 1295 2604 2860 -6312 2 2 12 9 417 3590 2268 -6313 2 2 12 9 779 3436 2106 -6314 2 2 12 9 934 2700 3106 -6315 2 2 12 9 549 2836 3108 -6316 2 2 12 9 548 3058 2613 -6317 2 2 12 9 1257 2416 2867 -6318 2 2 12 9 1072 2913 2418 -6319 2 2 12 9 1719 3431 3424 -6320 2 2 12 9 879 2189 3321 -6321 2 2 12 9 680 2327 3127 -6322 2 2 12 9 266 2391 3606 -6323 2 2 12 9 310 3607 2392 -6324 2 2 12 9 1455 2657 3601 -6325 2 2 12 9 1274 2704 3135 -6326 2 2 12 9 1771 2349 3576 -6327 2 2 12 9 1024 2583 3344 -6328 2 2 12 9 381 2340 3425 -6329 2 2 12 9 1480 2944 3308 -6330 2 2 12 9 1515 2779 2940 -6331 2 2 12 9 429 3442 2184 -6332 2 2 12 9 1252 3376 2431 -6333 2 2 12 9 1412 2831 3158 -6334 2 2 12 9 556 3225 2638 -6335 2 2 12 9 1059 2174 3488 -6336 2 2 12 9 1071 2563 2958 -6337 2 2 12 9 571 2741 3097 -6338 2 2 12 9 1115 3077 2511 -6339 2 2 12 9 534 3216 2235 -6340 2 2 12 9 1241 2587 3501 -6341 2 2 12 9 1242 3502 2588 -6342 2 2 12 9 572 3063 2654 -6343 2 2 12 9 573 2655 3064 -6344 2 2 12 9 1136 3049 2969 -6345 2 2 12 9 290 3270 2248 -6346 2 2 12 9 893 3093 2320 -6347 2 2 12 9 894 2321 3094 -6348 2 2 12 9 459 3489 2115 -6349 2 2 12 9 1125 2885 2737 -6350 2 2 12 9 1126 2738 2886 -6351 2 2 12 9 943 3493 2122 -6352 2 2 12 9 944 2123 3494 -6353 2 2 12 9 1280 2969 3049 -6354 2 2 12 9 581 3228 2281 -6355 2 2 12 9 582 2282 3229 -6356 2 2 12 9 1656 3550 2398 -6357 2 2 12 9 548 2833 3058 -6358 2 2 12 9 1183 3055 2424 -6359 2 2 12 9 249 3622 2775 -6360 2 2 12 9 327 2776 3623 -6361 2 2 12 9 762 3575 3204 -6362 2 2 12 9 1510 3258 3443 -6363 2 2 12 9 1511 3444 3259 -6364 2 2 12 9 1406 3248 3186 -6365 2 2 12 9 568 3049 2789 -6366 2 2 12 9 1549 3391 2380 -6367 2 2 12 9 1079 2402 3194 -6368 2 2 12 9 559 2990 3329 -6369 2 2 12 9 803 2403 3078 -6370 2 2 12 9 1604 3344 2493 -6371 2 2 12 9 1021 2613 3058 -6372 2 2 12 9 571 3097 2310 -6373 2 2 12 9 659 3296 2461 -6374 2 2 12 9 612 2458 3035 -6375 2 2 12 9 1239 3348 2568 -6376 2 2 12 9 865 2303 3250 -6377 2 2 12 9 1283 3107 2927 -6378 2 2 12 9 550 3529 2347 -6379 2 2 12 9 1227 3627 2433 -6380 2 2 12 9 598 2433 3627 -6381 2 2 12 9 613 3356 2249 -6382 2 2 12 9 391 3115 2346 -6383 2 2 12 9 591 2925 2697 -6384 2 2 12 9 1750 2698 2910 -6385 2 2 12 9 955 2192 3435 -6386 2 2 12 9 1193 3156 2528 -6387 2 2 12 9 454 3163 2330 -6388 2 2 12 9 455 2331 3164 -6389 2 2 12 9 1293 3523 2183 -6390 2 2 12 9 1321 3161 3388 -6391 2 2 12 9 397 3540 2190 -6392 2 2 12 9 707 3240 2728 -6393 2 2 12 9 708 2729 3241 -6394 2 2 12 9 923 3558 2559 -6395 2 2 12 9 924 2560 3559 -6396 2 2 12 9 1102 3635 2790 -6397 2 2 12 9 521 2258 3207 -6398 2 2 12 9 1496 3196 2299 -6399 2 2 12 9 1154 3000 2914 -6400 2 2 12 9 468 2514 3417 -6401 2 2 12 9 896 2328 3073 -6402 2 2 12 9 597 2210 3521 -6403 2 2 12 9 642 2183 3362 -6404 2 2 12 9 1073 2346 3115 -6405 2 2 12 9 629 3355 2477 -6406 2 2 12 9 1246 2212 3420 -6407 2 2 12 9 1143 3539 2164 -6408 2 2 12 9 560 2958 2563 -6409 2 2 12 9 1243 3097 2741 -6410 2 2 12 9 1543 3636 2902 -6411 2 2 12 9 997 3324 2266 -6412 2 2 12 9 998 2267 3325 -6413 2 2 12 9 561 2493 3344 -6414 2 2 12 9 525 3173 2313 -6415 2 2 12 9 526 2314 3174 -6416 2 2 12 9 1269 3009 3632 -6417 2 2 12 9 1387 3149 3139 -6418 2 2 12 9 1388 3140 3150 -6419 2 2 12 9 1163 3012 3141 -6420 2 2 12 9 573 2452 3038 -6421 2 2 12 9 361 2730 2946 -6422 2 2 12 9 1224 2555 3555 -6423 2 2 12 9 943 2573 3016 -6424 2 2 12 9 944 3017 2574 -6425 2 2 12 9 531 3554 2211 -6426 2 2 12 9 774 2625 2978 -6427 2 2 12 9 1065 3479 2349 -6428 2 2 12 9 548 2709 2833 -6429 2 2 12 9 1000 2993 2684 -6430 2 2 12 9 933 2842 2624 -6431 2 2 12 9 1605 3204 3575 -6432 2 2 12 9 963 3275 2315 -6433 2 2 12 9 1073 2211 3554 -6434 2 2 12 9 1303 2881 3166 -6435 2 2 12 9 1214 3191 2285 -6436 2 2 12 9 1387 3169 2373 -6437 2 2 12 9 1388 2374 3170 -6438 2 2 12 9 1921 3056 3346 -6439 2 2 12 9 882 3103 2442 -6440 2 2 12 9 1062 2833 2709 -6441 2 2 12 9 1017 2234 3578 -6442 2 2 12 9 1147 3186 3248 -6443 2 2 12 9 1406 3570 2851 -6444 2 2 12 9 512 3488 2174 -6445 2 2 12 9 613 2249 3500 -6446 2 2 12 9 572 2451 3063 -6447 2 2 12 9 1279 2974 2863 -6448 2 2 12 9 573 3064 2452 -6449 2 2 12 9 566 2766 3398 -6450 2 2 12 9 1453 3605 3615 -6451 2 2 12 9 1087 2851 3570 -6452 2 2 12 9 382 3021 2680 -6453 2 2 12 9 1365 2923 2608 -6454 2 2 12 9 1209 3481 2521 -6455 2 2 12 9 1537 2362 3111 -6456 2 2 12 9 886 3194 2402 -6457 2 2 12 9 802 3260 2473 -6458 2 2 12 9 1167 3443 3258 -6459 2 2 12 9 1168 3259 3444 -6460 2 2 12 9 952 2603 2947 -6461 2 2 12 9 1333 3008 2809 -6462 2 2 12 9 583 2479 3085 -6463 2 2 12 9 340 2284 3528 -6464 2 2 12 9 1056 2816 3644 -6465 2 2 12 9 1057 3645 2817 -6466 2 2 12 9 1394 3329 2990 -6467 2 2 12 9 718 2501 3383 -6468 2 2 12 9 638 2521 3481 -6469 2 2 12 9 574 3567 2832 -6470 2 2 12 9 575 2834 3568 -6471 2 2 12 9 958 3460 2186 -6472 2 2 12 9 425 3516 2773 -6473 2 2 12 9 978 2565 3385 -6474 2 2 12 9 979 3386 2566 -6475 2 2 12 9 1290 2572 2945 -6476 2 2 12 9 1130 2985 2782 -6477 2 2 12 9 1131 2783 2986 -6478 2 2 12 9 1426 3398 2766 -6479 2 2 12 9 1219 2347 3529 -6480 2 2 12 9 619 3570 3186 -6481 2 2 12 9 1154 2796 3000 -6482 2 2 12 9 915 3501 2587 -6483 2 2 12 9 916 2588 3502 -6484 2 2 12 9 622 2474 3388 -6485 2 2 12 9 1032 2978 2625 -6486 2 2 12 9 546 2885 2626 -6487 2 2 12 9 547 2627 2886 -6488 2 2 12 9 1194 3141 3012 -6489 2 2 12 9 1042 2863 2974 -6490 2 2 12 9 1760 3630 2542 -6491 2 2 12 9 410 2335 3268 -6492 2 2 12 9 546 2737 2885 -6493 2 2 12 9 547 2886 2738 -6494 2 2 12 9 348 2910 2698 -6495 2 2 12 9 897 2241 3586 -6496 2 2 12 9 1186 3345 3216 -6497 2 2 12 9 667 3555 2555 -6498 2 2 12 9 305 3512 2535 -6499 2 2 12 9 586 2984 2971 -6500 2 2 12 9 1008 2268 3590 -6501 2 2 12 9 1054 3349 2571 -6502 2 2 12 9 586 2796 2873 -6503 2 2 12 9 1293 3538 2198 -6504 2 2 12 9 1117 2705 2935 -6505 2 2 12 9 1317 2490 3321 -6506 2 2 12 9 467 3614 2453 -6507 2 2 12 9 1354 3355 3451 -6508 2 2 12 9 444 3453 3211 -6509 2 2 12 9 995 2434 3132 -6510 2 2 12 9 996 3133 2435 -6511 2 2 12 9 1634 3427 2300 -6512 2 2 12 9 1076 2446 3246 -6513 2 2 12 9 532 3379 3295 -6514 2 2 12 9 1053 2670 2922 -6515 2 2 12 9 530 2645 3471 -6516 2 2 12 9 1086 3052 2765 -6517 2 2 12 9 983 2881 3297 -6518 2 2 12 9 1192 3181 3096 -6519 2 2 12 9 1245 2946 2730 -6520 2 2 12 9 345 2532 3144 -6521 2 2 12 9 1154 3001 2873 -6522 2 2 12 9 2078 3054 3394 -6523 2 2 12 9 1154 2873 2796 -6524 2 2 12 9 1151 2680 3021 -6525 2 2 12 9 1000 2638 3225 -6526 2 2 12 9 565 3626 2344 -6527 2 2 12 9 534 3629 3216 -6528 2 2 12 9 1075 2328 3434 -6529 2 2 12 9 1832 3098 3137 -6530 2 2 12 9 1491 2634 3647 -6531 2 2 12 9 586 3012 2796 -6532 2 2 12 9 1071 3516 2747 -6533 2 2 12 9 1193 3337 3156 -6534 2 2 12 9 777 2809 3008 -6535 2 2 12 9 1140 3278 2594 -6536 2 2 12 9 1301 2782 2985 -6537 2 2 12 9 1302 2986 2783 -6538 2 2 12 9 1183 2473 3260 -6539 2 2 12 9 401 3137 3098 -6540 2 2 12 9 1144 2917 2971 -6541 2 2 12 9 499 2358 3396 -6542 2 2 12 9 390 3374 2362 -6543 2 2 12 9 1149 2696 3148 -6544 2 2 12 9 1633 3145 2889 -6545 2 2 12 9 401 3646 2312 -6546 2 2 12 9 1442 2812 3435 -6547 2 2 12 9 1106 3382 2407 -6548 2 2 12 9 378 2940 2779 -6549 2 2 12 9 1066 2525 3089 -6550 2 2 12 9 1067 3090 2526 -6551 2 2 12 9 1485 3295 3379 -6552 2 2 12 9 637 3353 2393 -6553 2 2 12 9 1212 2610 3338 -6554 2 2 12 9 1213 3339 2611 -6555 2 2 12 9 508 2349 3479 -6556 2 2 12 9 1193 2528 3126 -6557 2 2 12 9 1461 3237 3504 -6558 2 2 12 9 1226 3383 2501 -6559 2 2 12 9 909 3647 2634 -6560 2 2 12 9 1240 3612 3423 -6561 2 2 12 9 1391 3622 2275 -6562 2 2 12 9 1392 2276 3623 -6563 2 2 12 9 1354 2353 3355 -6564 2 2 12 9 1144 2971 2984 -6565 2 2 12 9 1303 3297 2881 -6566 2 2 12 9 669 3434 2328 -6567 2 2 12 9 428 3449 2725 -6568 2 2 12 9 509 3286 2428 -6569 2 2 12 9 595 3560 2264 -6570 2 2 12 9 37 2355 3357 -6571 2 2 12 9 184 3358 2356 -6572 2 2 12 9 1129 2265 3584 -6573 2 2 12 9 887 3345 2806 -6574 2 2 12 9 1236 2535 3512 -6575 2 2 12 9 1102 2998 3635 -6576 2 2 12 9 386 3594 2785 -6577 2 2 12 9 551 3446 2373 -6578 2 2 12 9 552 2374 3447 -6579 2 2 12 9 619 2895 3570 -6580 2 2 12 9 1450 3452 3267 -6581 2 2 12 9 1038 3120 3424 -6582 2 2 12 9 587 2502 3233 -6583 2 2 12 9 588 3234 2503 -6584 2 2 12 9 1463 3469 3313 -6585 2 2 12 9 1488 3211 3453 -6586 2 2 12 9 1194 2971 2917 -6587 2 2 12 9 1151 2485 3333 -6588 2 2 12 9 879 3321 2490 -6589 2 2 12 9 422 2406 3634 -6590 2 2 12 9 1110 3585 2613 -6591 2 2 12 9 560 2287 3648 -6592 2 2 12 9 1389 2295 3580 -6593 2 2 12 9 941 3247 3396 -6594 2 2 12 9 1093 3634 2406 -6595 2 2 12 9 1522 2593 3157 -6596 2 2 12 9 1689 2396 3482 -6597 2 2 12 9 584 3224 2622 -6598 2 2 12 9 604 2914 3000 -6599 2 2 12 9 1058 2461 3296 -6600 2 2 12 9 1163 3000 2796 -6601 2 2 12 9 1202 2344 3626 -6602 2 2 12 9 442 3544 2280 -6603 2 2 12 9 1281 3156 3337 -6604 2 2 12 9 1754 3430 2556 -6605 2 2 12 9 1143 2339 3539 -6606 2 2 12 9 1153 2878 3452 -6607 2 2 12 9 571 2598 3181 -6608 2 2 12 9 676 2415 3424 -6609 2 2 12 9 678 2878 3643 -6610 2 2 12 9 1397 3581 3079 -6611 2 2 12 9 1190 2312 3646 -6612 2 2 12 9 418 2594 3278 -6613 2 2 12 9 571 3181 2741 -6614 2 2 12 9 1532 3450 2414 -6615 2 2 12 9 1563 3482 2396 -6616 2 2 12 9 968 3595 2861 -6617 2 2 12 9 1304 3047 3102 -6618 2 2 12 9 955 3435 2812 -6619 2 2 12 9 873 3429 2445 -6620 2 2 12 9 1178 2933 3208 -6621 2 2 12 9 933 2463 3347 -6622 2 2 12 9 759 3313 3469 -6623 2 2 12 9 1142 3262 2673 -6624 2 2 12 9 413 3349 3175 -6625 2 2 12 9 1232 3504 3237 -6626 2 2 12 9 1163 2796 3012 -6627 2 2 12 9 1257 2867 3411 -6628 2 2 12 9 1592 3404 3406 -6629 2 2 12 9 1690 3106 2700 -6630 2 2 12 9 1453 2804 3605 -6631 2 2 12 9 677 2899 3315 -6632 2 2 12 9 2022 2413 3456 -6633 2 2 12 9 1163 3141 2946 -6634 2 2 12 9 1169 3401 2935 -6635 2 2 12 9 936 2478 3419 -6636 2 2 12 9 1184 2873 3001 -6637 2 2 12 9 271 3148 2696 -6638 2 2 12 9 586 2971 3012 -6639 2 2 12 9 1015 2832 3567 -6640 2 2 12 9 1016 3568 2834 -6641 2 2 12 9 1638 2806 3345 -6642 2 2 12 9 678 3267 3452 -6643 2 2 12 9 1289 2966 3195 -6644 2 2 12 9 1387 3139 3620 -6645 2 2 12 9 1388 3621 3140 -6646 2 2 12 9 677 3079 3581 -6647 2 2 12 9 1155 2590 3251 -6648 2 2 12 9 1227 3199 3627 -6649 2 2 12 9 1143 2453 3614 -6650 2 2 12 9 1189 3058 2833 -6651 2 2 12 9 1227 2647 3199 -6652 2 2 12 9 585 2765 3052 -6653 2 2 12 9 1243 2675 3097 -6654 2 2 12 9 1135 3569 2911 -6655 2 2 12 9 1405 3643 2878 -6656 2 2 12 9 1000 3225 2993 -6657 2 2 12 9 1104 2728 3240 -6658 2 2 12 9 1105 3241 2729 -6659 2 2 12 9 1060 2514 3390 -6660 2 2 12 9 419 2648 3165 -6661 2 2 12 9 1104 3240 2515 -6662 2 2 12 9 1105 2516 3241 -6663 2 2 12 9 1107 3410 2803 -6664 2 2 12 9 1194 3012 2971 -6665 2 2 12 9 633 3022 3511 -6666 2 2 12 9 1296 3606 2391 -6667 2 2 12 9 1297 2392 3607 -6668 2 2 12 9 1069 2622 3224 -6669 2 2 12 9 1292 3615 3605 -6670 2 2 12 9 410 2682 3282 -6671 2 2 12 9 1125 2464 3541 -6672 2 2 12 9 1126 3542 2465 -6673 2 2 12 9 1060 3417 2514 -6674 2 2 12 9 405 3102 3047 -6675 2 2 12 9 1163 2946 3183 -6676 2 2 12 9 1582 3567 2447 -6677 2 2 12 9 1583 2448 3568 -6678 2 2 12 9 968 2507 3517 -6679 2 2 12 9 1673 3410 3160 -6680 2 2 12 9 1761 3338 2862 -6681 2 2 12 9 1762 2864 3339 -6682 2 2 12 9 1192 2741 3181 -6683 2 2 12 9 559 3257 2990 -6684 2 2 12 9 497 3426 2649 -6685 2 2 12 9 1177 3514 2481 -6686 2 2 12 9 498 2650 3545 -6687 2 2 12 9 1145 3616 2489 -6688 2 2 12 9 535 3209 2814 -6689 2 2 12 9 1141 3406 3404 -6690 2 2 12 9 362 3199 2647 -6691 2 2 12 9 1477 3399 3479 -6692 2 2 12 9 400 3136 3323 -6693 2 2 12 9 1136 2789 3049 -6694 2 2 12 9 214 2956 3104 -6695 2 2 12 9 1929 3011 3290 -6696 2 2 12 9 1200 3169 3287 -6697 2 2 12 9 1201 3288 3170 -6698 2 2 12 9 411 2752 3578 -6699 2 2 12 9 1334 3323 3136 -6700 2 2 12 9 1330 3456 2413 -6701 2 2 12 9 1248 2728 3317 -6702 2 2 12 9 1249 3318 2729 -6703 2 2 12 9 1578 3162 3190 -6704 2 2 12 9 596 2673 3262 -6705 2 2 12 9 1386 3245 3392 -6706 2 2 12 9 1292 3315 2899 -6707 2 2 12 9 379 2438 3582 -6708 2 2 12 9 410 3096 2969 -6709 2 2 12 9 1386 2437 3569 -6710 2 2 12 9 1523 3627 3199 -6711 2 2 12 9 1196 3104 2956 -6712 2 2 12 9 1136 2969 3096 -6713 2 2 12 9 501 3593 2553 -6714 2 2 12 9 403 3541 2464 -6715 2 2 12 9 404 2465 3542 -6716 2 2 12 9 1245 3183 2946 -6717 2 2 12 9 413 2571 3349 -6718 2 2 12 9 1169 2725 3449 -6719 2 2 12 9 1376 3359 3293 -6720 2 2 12 9 1377 3294 3360 -6721 2 2 12 9 1042 2889 3145 -6722 2 2 12 9 1458 3451 3387 -6723 2 2 12 9 1041 3158 2831 -6724 2 2 12 9 508 3479 3399 -6725 2 2 12 9 561 3344 2583 -6726 2 2 12 9 1536 3487 3583 -6727 2 2 12 9 412 3580 2567 -6728 2 2 12 9 1151 3415 2680 -6729 2 2 12 9 1677 3496 2620 -6730 2 2 12 9 373 2690 3462 -6731 2 2 12 9 374 3463 2691 -6732 2 2 12 9 532 3295 3095 -6733 2 2 12 9 395 3290 3011 -6734 2 2 12 9 1075 3434 2531 -6735 2 2 12 9 1277 3222 3187 -6736 2 2 12 9 1457 3448 2753 -6737 2 2 12 9 643 2620 3496 -6738 2 2 12 9 1118 3379 3103 -6739 2 2 12 9 1376 3214 3359 -6740 2 2 12 9 1377 3360 3215 -6741 2 2 12 9 1357 3033 3571 -6742 2 2 12 9 1358 3572 3034 -6743 2 2 12 9 361 2946 3141 -6744 2 2 12 9 1270 3398 3247 -6745 2 2 12 9 1153 3452 3092 -6746 2 2 12 9 338 3392 3245 -6747 2 2 12 9 360 2769 3538 -6748 2 2 12 9 629 3387 3451 -6749 2 2 12 9 661 3340 2756 -6750 2 2 12 9 1047 3571 3033 -6751 2 2 12 9 1048 3034 3572 -6752 2 2 12 9 1240 3520 2896 -6753 2 2 12 9 209 3546 2498 -6754 2 2 12 9 693 3583 3487 -6755 2 2 12 9 1197 3293 3359 -6756 2 2 12 9 1198 3360 3294 -6757 2 2 12 9 1195 2814 3209 -6758 2 2 12 9 1525 3543 3529 -6759 2 2 12 9 1383 2553 3593 -6760 2 2 12 9 682 3552 3166 -6761 2 2 12 9 976 2680 3415 -6762 2 2 12 9 1080 3190 3162 -6763 2 2 12 9 1370 3498 2546 -6764 2 2 12 9 968 2468 3595 -6765 2 2 12 9 1470 2564 3438 -6766 2 2 12 9 1149 2756 3340 -6767 2 2 12 9 1035 2852 3311 -6768 2 2 12 9 1036 3312 2853 -6769 2 2 12 9 1226 3208 2933 -6770 2 2 12 9 1708 3490 2858 -6771 2 2 12 9 1709 2859 3491 -6772 2 2 12 9 699 2896 3520 -6773 2 2 12 9 551 2591 3618 -6774 2 2 12 9 552 3619 2592 -6775 2 2 12 9 604 3000 3183 -6776 2 2 12 9 1219 3529 3543 -6777 2 2 12 9 1475 3438 2564 -6778 2 2 12 9 1223 3462 2690 -6779 2 2 12 9 1224 2691 3463 -6780 2 2 12 9 548 2613 3585 -6781 2 2 12 9 1193 3123 3337 -6782 2 2 12 9 467 2561 3614 -6783 2 2 12 9 1148 3195 2966 -6784 2 2 12 9 1523 3199 3361 -6785 2 2 12 9 1315 3095 3295 -6786 2 2 12 9 1163 3183 3000 -6787 2 2 12 9 1274 3135 3439 -6788 2 2 12 9 355 3359 3214 -6789 2 2 12 9 356 3215 3360 -6790 2 2 12 9 1312 3367 3204 -6791 2 2 12 9 1205 3187 3222 -6792 2 2 12 9 1127 3471 2645 -6793 2 2 12 9 1400 3166 3552 -6794 2 2 12 9 216 3465 2847 -6795 2 2 12 9 884 3641 2499 -6796 2 2 12 9 1426 3247 3398 -6797 2 2 12 9 907 2753 3448 -6798 2 2 12 9 1597 3260 2948 -6799 2 2 12 9 1173 2993 3225 -6800 2 2 12 9 1093 2788 3634 -6801 2 2 12 9 910 2714 3579 -6802 2 2 12 9 802 2948 3260 -6803 2 2 12 9 245 3637 2651 -6804 2 2 12 9 331 2652 3638 -6805 2 2 12 9 1145 3461 2690 -6806 2 2 12 9 1099 3308 2944 -6807 2 2 12 9 932 2594 3612 -6808 2 2 12 9 890 2702 3556 -6809 2 2 12 9 891 3557 2703 -6810 2 2 12 9 1474 3417 3022 -6811 2 2 12 9 1116 3468 2659 -6812 2 2 12 9 916 3502 2872 -6813 2 2 12 9 420 2862 3338 -6814 2 2 12 9 421 3339 2864 -6815 2 2 12 9 1472 3369 3483 -6816 2 2 12 9 1473 3484 3370 -6817 2 2 12 9 762 3204 3367 -6818 2 2 12 9 1182 2990 3257 -6819 2 2 12 9 1215 2919 3372 -6820 2 2 12 9 1386 3569 3245 -6821 2 2 12 9 496 2727 3450 -6822 2 2 12 9 1406 3186 3570 -6823 2 2 12 9 1546 3024 3296 -6824 2 2 12 9 678 3452 2878 -6825 2 2 12 9 1613 3440 3505 -6826 2 2 12 9 410 3282 3096 -6827 2 2 12 9 425 2747 3516 -6828 2 2 12 9 1179 3483 3369 -6829 2 2 12 9 1180 3370 3484 -6830 2 2 12 9 1644 2785 3437 -6831 2 2 12 9 1207 3323 3285 -6832 2 2 12 9 1224 3555 2691 -6833 2 2 12 9 667 3366 3555 -6834 2 2 12 9 1247 2847 3465 -6835 2 2 12 9 670 2935 3401 -6836 2 2 12 9 1839 2872 3502 -6837 2 2 12 9 620 3372 2919 -6838 2 2 12 9 1233 3221 3617 -6839 2 2 12 9 1238 3579 2714 -6840 2 2 12 9 545 2790 3635 -6841 2 2 12 9 687 3287 3169 -6842 2 2 12 9 688 3170 3288 -6843 2 2 12 9 1138 3159 3267 -6844 2 2 12 9 1060 3022 3417 -6845 2 2 12 9 1450 3267 3159 -6846 2 2 12 9 1233 3617 3313 -6847 2 2 12 9 1266 3335 3327 -6848 2 2 12 9 1267 3328 3336 -6849 2 2 12 9 1019 3394 3054 -6850 2 2 12 9 366 2955 3457 -6851 2 2 12 9 1135 3245 3569 -6852 2 2 12 9 1039 3346 3056 -6853 2 2 12 9 1170 3505 3440 -6854 2 2 12 9 614 2743 3518 -6855 2 2 12 9 615 3519 2744 -6856 2 2 12 9 1058 3296 3024 -6857 2 2 12 9 1192 3096 3282 -6858 2 2 12 9 614 3518 3116 -6859 2 2 12 9 615 3117 3519 -6860 2 2 12 9 348 2977 3531 -6861 2 2 12 9 1571 3322 3563 -6862 2 2 12 9 1421 3591 3422 -6863 2 2 12 9 1334 3285 3323 -6864 2 2 12 9 429 3605 2804 -6865 2 2 12 9 1790 3281 3217 -6866 2 2 12 9 1129 2785 3594 -6867 2 2 12 9 1153 3592 2878 -6868 2 2 12 9 781 3337 3123 -6869 2 2 12 9 1324 3327 3335 -6870 2 2 12 9 1325 3336 3328 -6871 2 2 12 9 578 3317 3087 -6872 2 2 12 9 579 3088 3318 -6873 2 2 12 9 1411 3236 3530 -6874 2 2 12 9 1192 3631 2741 -6875 2 2 12 9 1390 3530 3236 -6876 2 2 12 9 585 3628 2765 -6877 2 2 12 9 1871 3577 3086 -6878 2 2 12 9 362 3361 3199 -6879 2 2 12 9 1087 3570 2895 -6880 2 2 12 9 437 3422 3591 -6881 2 2 12 9 1166 3613 2824 -6882 2 2 12 9 1107 3160 3410 -6883 2 2 12 9 1719 3424 3120 -6884 2 2 12 9 1324 3335 3233 -6885 2 2 12 9 1325 3234 3336 -6886 2 2 12 9 1450 3092 3452 -6887 2 2 12 9 485 3416 3485 -6888 2 2 12 9 462 3217 3281 -6889 2 2 12 9 1259 3457 2955 -6890 2 2 12 9 1264 3439 3135 -6891 2 2 12 9 2047 3541 3212 -6892 2 2 12 9 2048 3213 3542 -6893 2 2 12 9 865 3250 3380 -6894 2 2 12 9 587 3233 3335 -6895 2 2 12 9 588 3336 3234 -6896 2 2 12 9 1591 3380 3250 -6897 2 2 12 9 348 3531 2910 -6898 2 2 12 9 581 3644 2816 -6899 2 2 12 9 582 2817 3645 -6900 2 2 12 9 1181 3086 3577 -6901 2 2 12 9 403 3212 3541 -6902 2 2 12 9 404 3542 3213 -6903 2 2 12 9 1159 3534 2981 -6904 2 2 12 9 1160 2982 3535 -6905 2 2 12 9 621 3285 3513 -6906 2 2 12 9 1426 3396 3247 -6907 2 2 12 9 1464 3564 3101 -6908 2 2 12 9 1409 3485 3416 -6909 2 2 12 9 1570 3635 2998 -6910 2 2 12 9 1413 3101 3564 -6911 2 2 12 9 1434 3179 3594 -6912 2 2 12 9 1169 3449 3401 -6913 2 2 12 9 943 3377 3493 -6914 2 2 12 9 944 3494 3378 -6915 2 2 12 9 1334 3513 3285 -6916 2 2 12 9 1667 3493 3377 -6917 2 2 12 9 1668 3378 3494 -6918 2 2 12 9 1229 3620 3139 -6919 2 2 12 9 1230 3140 3621 -6920 2 2 12 9 1577 3401 3449 -6921 2 2 12 9 1129 3594 3179 -6922 2 2 12 9 561 3617 3221 -6923 2 2 12 9 1191 3563 3322 -6924 2 2 12 9 1463 3313 3617 -6925 2 2 12 9 1340 3547 3552 -6926 2 2 12 9 1186 3216 3629 -6927 2 2 12 9 1240 3423 3520 -6928 2 2 12 9 1479 3520 3423 -6929 2 2 12 9 1313 3508 3561 -6930 2 2 12 9 1314 3562 3509 -6931 2 2 12 9 243 3602 3610 -6932 2 2 12 9 333 3611 3603 -6933 2 2 12 9 1400 3552 3547 -6934 2 2 12 9 1334 3581 3513 -6935 2 2 12 9 1443 3561 3508 -6936 2 2 12 9 1444 3509 3562 -6937 2 2 12 9 1397 3513 3581 -6938 2 2 12 9 1435 3610 3602 -6939 2 2 12 9 1436 3603 3611 -6940 2 2 13 11 6754 3899 4643 -6941 2 2 13 11 6325 3789 4827 -6942 2 2 13 11 6326 4828 3790 -6943 2 2 13 11 4769 3899 6754 -6944 2 2 13 11 4741 6325 4827 -6945 2 2 13 11 4742 4828 6326 -6946 2 2 13 11 4469 4994 5539 -6947 2 2 13 11 6465 4881 4039 -6948 2 2 13 11 5539 4994 3847 -6949 2 2 13 11 6217 4855 5027 -6950 2 2 13 11 6218 5028 4856 -6951 2 2 13 11 5066 5829 3774 -6952 2 2 13 11 6107 4090 4935 -6953 2 2 13 11 4698 4881 6465 -6954 2 2 13 11 6025 5002 3650 -6955 2 2 13 11 4782 5101 6705 -6956 2 2 13 11 3999 4855 6217 -6957 2 2 13 11 4000 6218 4856 -6958 2 2 13 11 5089 3840 5587 -6959 2 2 13 11 4594 6501 5305 -6960 2 2 13 11 4543 5002 6025 -6961 2 2 13 11 5829 4873 3774 -6962 2 2 13 11 6693 4148 4831 -6963 2 2 13 11 6209 4103 4940 -6964 2 2 13 11 4634 6107 4935 -6965 2 2 13 11 4128 4771 6903 -6966 2 2 13 11 4129 6904 4772 -6967 2 2 13 11 4808 6693 4831 -6968 2 2 13 11 6947 4762 3701 -6969 2 2 13 11 5465 4068 6859 -6970 2 2 13 11 6903 4771 4868 -6971 2 2 13 11 6904 4869 4772 -6972 2 2 13 11 4657 6209 4940 -6973 2 2 13 11 6802 4888 4687 -6974 2 2 13 11 4846 6947 3701 -6975 2 2 13 11 4501 5089 5587 -6976 2 2 13 11 4790 4852 6823 -6977 2 2 13 11 3922 6802 4687 -6978 2 2 13 11 4622 4878 6342 -6979 2 2 13 11 5715 5071 4131 -6980 2 2 13 11 5101 3909 6705 -6981 2 2 13 11 6510 5331 3754 -6982 2 2 13 11 6485 4632 5117 -6983 2 2 13 11 4544 6032 4923 -6984 2 2 13 11 6001 4111 4423 -6985 2 2 13 11 6032 3669 4923 -6986 2 2 13 11 5267 3994 5848 -6987 2 2 13 11 6241 4995 3739 -6988 2 2 13 11 6342 4878 3923 -6989 2 2 13 11 6155 4943 4158 -6990 2 2 13 11 4111 5268 4423 -6991 2 2 13 11 5953 4033 4868 -6992 2 2 13 11 5954 4869 4034 -6993 2 2 13 11 4575 5071 5715 -6994 2 2 13 11 6823 4852 4009 -6995 2 2 13 11 6501 3938 5305 -6996 2 2 13 11 4530 5201 6238 -6997 2 2 13 11 3921 4632 6485 -6998 2 2 13 11 5848 3994 4945 -6999 2 2 13 11 5165 6180 4243 -7000 2 2 13 11 6691 4019 4470 -7001 2 2 13 11 315 6049 5157 -7002 2 2 13 11 261 5158 6050 -7003 2 2 13 11 6468 3765 5203 -7004 2 2 13 11 6469 5204 3766 -7005 2 2 13 11 4070 5509 4441 -7006 2 2 13 11 4071 4442 5510 -7007 2 2 13 11 5084 5261 6311 -7008 2 2 13 11 4340 6037 5313 -7009 2 2 13 11 4341 5316 6038 -7010 2 2 13 11 3985 4928 4512 -7011 2 2 13 11 3656 4757 5637 -7012 2 2 13 11 6422 4895 3924 -7013 2 2 13 11 6423 3925 4896 -7014 2 2 13 11 3950 4659 4873 -7015 2 2 13 11 3761 4930 4531 -7016 2 2 13 11 3963 5312 4520 -7017 2 2 13 11 4737 4899 6322 -7018 2 2 13 11 5086 4033 5953 -7019 2 2 13 11 5087 5954 4034 -7020 2 2 13 11 6648 5815 4389 -7021 2 2 13 11 6649 4390 5816 -7022 2 2 13 11 3950 4656 5617 -7023 2 2 13 11 4098 5279 5591 -7024 2 2 13 11 4097 4920 5590 -7025 2 2 13 11 4098 5591 4921 -7026 2 2 13 11 4222 5067 5335 -7027 2 2 13 11 4097 5590 5304 -7028 2 2 13 11 3985 4512 4954 -7029 2 2 13 11 3967 5176 4976 -7030 2 2 13 11 4647 4895 6422 -7031 2 2 13 11 4648 6423 4896 -7032 2 2 13 11 3915 4582 5743 -7033 2 2 13 11 3756 6419 4509 -7034 2 2 13 11 4424 4678 6276 -7035 2 2 13 11 289 4712 290 -7036 2 2 13 11 4086 4443 5454 -7037 2 2 13 11 5769 6275 3972 -7038 2 2 13 11 4716 4995 6241 -7039 2 2 13 11 291 4793 292 -7040 2 2 13 11 4164 4968 5034 -7041 2 2 13 11 3781 4881 4698 -7042 2 2 13 11 275 4721 276 -7043 2 2 13 11 4130 6744 4562 -7044 2 2 13 11 4612 4943 6155 -7045 2 2 13 11 4070 4441 6303 -7046 2 2 13 11 3950 5617 4659 -7047 2 2 13 11 4071 6304 4442 -7048 2 2 13 11 6275 4836 3972 -7049 2 2 13 11 6859 4068 4540 -7050 2 2 13 11 4601 6180 5165 -7051 2 2 13 11 277 4797 278 -7052 2 2 13 11 4345 5248 5249 -7053 2 2 13 11 3984 4571 4894 -7054 2 2 13 11 4035 4858 4596 -7055 2 2 13 11 3785 5041 4925 -7056 2 2 13 11 4413 5280 6033 -7057 2 2 13 11 3742 5004 4496 -7058 2 2 13 11 3734 4594 5305 -7059 2 2 13 11 3975 4764 4635 -7060 2 2 13 11 4027 6536 4519 -7061 2 2 13 11 3998 4551 5107 -7062 2 2 13 11 110 4993 6581 -7063 2 2 13 11 4937 5571 5961 -7064 2 2 13 11 4689 5331 6510 -7065 2 2 13 11 4152 4890 4662 -7066 2 2 13 11 4068 5269 4540 -7067 2 2 13 11 4004 4571 6293 -7068 2 2 13 11 4100 4463 6797 -7069 2 2 13 11 4470 4019 5379 -7070 2 2 13 11 4019 4737 6322 -7071 2 2 13 11 4014 4994 5795 -7072 2 2 13 11 3902 4663 5102 -7073 2 2 13 11 3903 5103 4664 -7074 2 2 13 11 3984 5765 4571 -7075 2 2 13 11 3712 4540 5269 -7076 2 2 13 11 3882 4581 6736 -7077 2 2 13 11 3999 5160 4475 -7078 2 2 13 11 4000 4476 5161 -7079 2 2 13 11 3934 4731 4703 -7080 2 2 13 11 3935 4704 4732 -7081 2 2 13 11 4483 5917 5728 -7082 2 2 13 11 3762 4855 4618 -7083 2 2 13 11 3763 4619 4856 -7084 2 2 13 11 4977 5593 6130 -7085 2 2 13 11 3853 4681 5303 -7086 2 2 13 11 318 4627 319 -7087 2 2 13 11 257 4628 258 -7088 2 2 13 11 4163 6139 4591 -7089 2 2 13 11 4111 5025 4774 -7090 2 2 13 11 4270 4590 6146 -7091 2 2 13 11 3995 4634 5301 -7092 2 2 13 11 3939 5307 4620 -7093 2 2 13 11 3917 4596 6702 -7094 2 2 13 11 3878 5495 4485 -7095 2 2 13 11 3803 4780 5655 -7096 2 2 13 11 3851 5115 4496 -7097 2 2 13 11 3926 5228 6126 -7098 2 2 13 11 3916 4882 4661 -7099 2 2 13 11 4086 5618 4443 -7100 2 2 13 11 3661 5477 4584 -7101 2 2 13 11 5074 6545 5843 -7102 2 2 13 11 4596 4858 6702 -7103 2 2 13 11 4280 4965 6074 -7104 2 2 13 11 4281 6075 4966 -7105 2 2 13 11 5201 3910 6238 -7106 2 2 13 11 3868 5513 4883 -7107 2 2 13 11 4092 4682 4891 -7108 2 2 13 11 4201 4801 4803 -7109 2 2 13 11 3998 5749 4551 -7110 2 2 13 11 113 114 4616 -7111 2 2 13 11 4259 5402 4941 -7112 2 2 13 11 4629 6468 5203 -7113 2 2 13 11 4630 5204 6469 -7114 2 2 13 11 4175 4595 5303 -7115 2 2 13 11 4044 5006 5205 -7116 2 2 13 11 4045 5206 5007 -7117 2 2 13 11 4773 6806 5397 -7118 2 2 13 11 3948 4746 4877 -7119 2 2 13 11 4515 6581 4993 -7120 2 2 13 11 5257 6534 5832 -7121 2 2 13 11 5258 5833 6535 -7122 2 2 13 11 4374 5257 5832 -7123 2 2 13 11 4375 5833 5258 -7124 2 2 13 11 5929 4472 3862 -7125 2 2 13 11 3875 5062 4457 -7126 2 2 13 11 4065 5092 5433 -7127 2 2 13 11 4094 4490 5571 -7128 2 2 13 11 4183 5237 5181 -7129 2 2 13 11 4244 5281 4640 -7130 2 2 13 11 3851 4496 5309 -7131 2 2 13 11 4958 6837 6185 -7132 2 2 13 11 3777 5034 4968 -7133 2 2 13 11 4130 4870 6744 -7134 2 2 13 11 4151 5261 5084 -7135 2 2 13 11 3822 5249 5248 -7136 2 2 13 11 3986 5060 4549 -7137 2 2 13 11 4004 6293 4617 -7138 2 2 13 11 4028 5049 4479 -7139 2 2 13 11 3926 6610 5228 -7140 2 2 13 11 3651 4576 5899 -7141 2 2 13 11 3815 4550 5147 -7142 2 2 13 11 292 4793 6245 -7143 2 2 13 11 4083 4865 5064 -7144 2 2 13 11 3976 5020 5580 -7145 2 2 13 11 3977 5581 5021 -7146 2 2 13 11 3848 4498 5519 -7147 2 2 13 11 3803 5655 6002 -7148 2 2 13 11 4280 6156 4965 -7149 2 2 13 11 4281 4966 6157 -7150 2 2 13 11 3823 5107 4551 -7151 2 2 13 11 278 4797 6269 -7152 2 2 13 11 3789 4813 4827 -7153 2 2 13 11 3790 4828 4814 -7154 2 2 13 11 5010 5719 6386 -7155 2 2 13 11 4410 5517 6123 -7156 2 2 13 11 5720 5011 6387 -7157 2 2 13 11 4130 4562 6189 -7158 2 2 13 11 3860 5071 5751 -7159 2 2 13 11 4813 5712 6914 -7160 2 2 13 11 4814 6915 5713 -7161 2 2 13 11 4191 5642 5289 -7162 2 2 13 11 3941 5366 4974 -7163 2 2 13 11 3942 4975 5367 -7164 2 2 13 11 4014 5795 4992 -7165 2 2 13 11 3849 4464 5599 -7166 2 2 13 11 4701 6887 5702 -7167 2 2 13 11 3674 4636 5895 -7168 2 2 13 11 3811 4941 5402 -7169 2 2 13 11 117 5926 4541 -7170 2 2 13 11 4140 6817 4746 -7171 2 2 13 11 4099 6880 4486 -7172 2 2 13 11 3676 5050 5172 -7173 2 2 13 11 3906 5381 4803 -7174 2 2 13 11 4163 4525 5774 -7175 2 2 13 11 3733 4745 4774 -7176 2 2 13 11 3710 6509 5164 -7177 2 2 13 11 4677 6758 5128 -7178 2 2 13 11 4044 5205 4860 -7179 2 2 13 11 4045 4861 5206 -7180 2 2 13 11 3767 4557 6607 -7181 2 2 13 11 3916 4550 4882 -7182 2 2 13 11 3848 6276 4678 -7183 2 2 13 11 4719 5889 5666 -7184 2 2 13 11 3869 4514 5134 -7185 2 2 13 11 6758 3755 5128 -7186 2 2 13 11 3874 4538 4969 -7187 2 2 13 11 3876 4970 4539 -7188 2 2 13 11 6890 4706 6302 -7189 2 2 13 11 3665 4958 6185 -7190 2 2 13 11 6265 4159 4955 -7191 2 2 13 11 4472 5775 3862 -7192 2 2 13 11 4032 5447 4929 -7193 2 2 13 11 3753 5593 4977 -7194 2 2 13 11 6837 4514 6185 -7195 2 2 13 11 4151 4587 5427 -7196 2 2 13 11 3733 4800 4839 -7197 2 2 13 11 4105 6624 4641 -7198 2 2 13 11 3708 4513 5399 -7199 2 2 13 11 4102 4591 5516 -7200 2 2 13 11 4727 6385 5232 -7201 2 2 13 11 4175 5303 4681 -7202 2 2 13 11 4060 4526 5245 -7203 2 2 13 11 4169 5514 4602 -7204 2 2 13 11 4005 4904 4691 -7205 2 2 13 11 4170 4603 5515 -7206 2 2 13 11 4031 4839 4800 -7207 2 2 13 11 4525 4641 6624 -7208 2 2 13 11 4691 4904 6883 -7209 2 2 13 11 3915 5743 4697 -7210 2 2 13 11 3746 4510 6591 -7211 2 2 13 11 3747 6592 4511 -7212 2 2 13 11 4385 5532 5212 -7213 2 2 13 11 4386 5213 5533 -7214 2 2 13 11 3702 5660 4681 -7215 2 2 13 11 4006 4774 4745 -7216 2 2 13 11 3723 6175 5702 -7217 2 2 13 11 3849 6698 4464 -7218 2 2 13 11 5352 5815 6648 -7219 2 2 13 11 5353 6649 5816 -7220 2 2 13 11 3656 5637 5840 -7221 2 2 13 11 4708 5774 5656 -7222 2 2 13 11 3987 4621 5065 -7223 2 2 13 11 4480 5751 5071 -7224 2 2 13 11 4746 6817 4877 -7225 2 2 13 11 4206 4873 4659 -7226 2 2 13 11 4163 4708 6139 -7227 2 2 13 11 3694 4891 4682 -7228 2 2 13 11 156 5486 5441 -7229 2 2 13 11 65 5442 5487 -7230 2 2 13 11 3882 6736 4823 -7231 2 2 13 11 5278 4864 6513 -7232 2 2 13 11 4383 5433 5092 -7233 2 2 13 11 4005 4564 6378 -7234 2 2 13 11 6923 3873 5887 -7235 2 2 13 11 3991 6529 4653 -7236 2 2 13 11 4028 4479 5560 -7237 2 2 13 11 3979 5796 4669 -7238 2 2 13 11 6934 5149 3908 -7239 2 2 13 11 4515 6528 5604 -7240 2 2 13 11 3848 5351 4498 -7241 2 2 13 11 4094 5202 4490 -7242 2 2 13 11 4060 6266 4526 -7243 2 2 13 11 4002 5034 5985 -7244 2 2 13 11 3857 5939 4465 -7245 2 2 13 11 3858 4466 5940 -7246 2 2 13 11 3945 4568 6013 -7247 2 2 13 11 4340 5313 6288 -7248 2 2 13 11 4341 6289 5316 -7249 2 2 13 11 4176 4925 5041 -7250 2 2 13 11 4054 4509 4996 -7251 2 2 13 11 4224 4563 6032 -7252 2 2 13 11 4050 4827 4813 -7253 2 2 13 11 4051 4814 4828 -7254 2 2 13 11 4091 5391 4999 -7255 2 2 13 11 3737 4771 5612 -7256 2 2 13 11 3738 5613 4772 -7257 2 2 13 11 4201 4803 5381 -7258 2 2 13 11 3988 6441 4613 -7259 2 2 13 11 3991 4636 6529 -7260 2 2 13 11 3901 4762 5902 -7261 2 2 13 11 3708 5504 4513 -7262 2 2 13 11 3874 5238 4538 -7263 2 2 13 11 3876 4539 5239 -7264 2 2 13 11 3749 4803 4801 -7265 2 2 13 11 3867 5728 5917 -7266 2 2 13 11 3757 4662 4890 -7267 2 2 13 11 3714 4592 5341 -7268 2 2 13 11 3715 5342 4593 -7269 2 2 13 11 3917 6233 4733 -7270 2 2 13 11 3851 5946 5115 -7271 2 2 13 11 4325 4883 5513 -7272 2 2 13 11 3955 5565 6000 -7273 2 2 13 11 4976 5176 6208 -7274 2 2 13 11 3719 5212 5532 -7275 2 2 13 11 3720 5533 5213 -7276 2 2 13 11 3857 4465 5566 -7277 2 2 13 11 3858 5567 4466 -7278 2 2 13 11 4012 5033 5002 -7279 2 2 13 11 4602 5514 6391 -7280 2 2 13 11 4603 6392 5515 -7281 2 2 13 11 3823 4551 5358 -7282 2 2 13 11 3983 4886 4677 -7283 2 2 13 11 4615 6265 4955 -7284 2 2 13 11 3668 4549 5060 -7285 2 2 13 11 3706 5057 4524 -7286 2 2 13 11 4032 5792 6330 -7287 2 2 13 11 4530 5985 5034 -7288 2 2 13 11 3673 5571 5560 -7289 2 2 13 11 3853 4470 5379 -7290 2 2 13 11 6341 5012 3744 -7291 2 2 13 11 6343 3745 5013 -7292 2 2 13 11 3668 6229 4495 -7293 2 2 13 11 4359 5340 5419 -7294 2 2 13 11 3688 5831 6366 -7295 2 2 13 11 3945 6778 4568 -7296 2 2 13 11 4033 5719 5010 -7297 2 2 13 11 4034 5011 5720 -7298 2 2 13 11 4236 4937 5961 -7299 2 2 13 11 4404 5843 6545 -7300 2 2 13 11 3768 5774 4525 -7301 2 2 13 11 4196 5838 5395 -7302 2 2 13 11 4314 4974 5366 -7303 2 2 13 11 4315 5367 4975 -7304 2 2 13 11 4311 5520 5671 -7305 2 2 13 11 4183 5181 4676 -7306 2 2 13 11 4413 6280 5280 -7307 2 2 13 11 3709 4529 5061 -7308 2 2 13 11 4168 4584 5477 -7309 2 2 13 11 4102 4760 5196 -7310 2 2 13 11 3943 5038 4561 -7311 2 2 13 11 4090 5362 4600 -7312 2 2 13 11 4864 4309 6513 -7313 2 2 13 11 4236 4995 4716 -7314 2 2 13 11 4075 4988 4718 -7315 2 2 13 11 4678 6158 5014 -7316 2 2 13 11 3930 4516 5150 -7317 2 2 13 11 4070 4884 4938 -7318 2 2 13 11 4071 4939 4885 -7319 2 2 13 11 3717 6201 4646 -7320 2 2 13 11 3746 4938 4884 -7321 2 2 13 11 4372 4733 6355 -7322 2 2 13 11 3747 4885 4939 -7323 2 2 13 11 3750 4964 4824 -7324 2 2 13 11 3739 4995 4886 -7325 2 2 13 11 3875 4457 5638 -7326 2 2 13 11 4003 4706 6890 -7327 2 2 13 11 6914 5712 3964 -7328 2 2 13 11 6915 3965 5713 -7329 2 2 13 11 4073 4824 4964 -7330 2 2 13 11 3975 4599 6120 -7331 2 2 13 11 6883 4904 3958 -7332 2 2 13 11 4623 5580 6631 -7333 2 2 13 11 4624 6632 5581 -7334 2 2 13 11 4307 5580 5020 -7335 2 2 13 11 4308 5021 5581 -7336 2 2 13 11 6778 5368 4568 -7337 2 2 13 11 4278 4631 6093 -7338 2 2 13 11 4244 5678 5281 -7339 2 2 13 11 4610 6408 5395 -7340 2 2 13 11 303 5378 6220 -7341 2 2 13 11 3884 5970 4547 -7342 2 2 13 11 3885 4548 5971 -7343 2 2 13 11 3788 5064 4865 -7344 2 2 13 11 3676 5172 4686 -7345 2 2 13 11 3815 6040 4550 -7346 2 2 13 11 4451 4733 6233 -7347 2 2 13 11 4032 6330 4944 -7348 2 2 13 11 114 5394 4616 -7349 2 2 13 11 3951 5037 5569 -7350 2 2 13 11 4027 4519 5066 -7351 2 2 13 11 3746 6030 4510 -7352 2 2 13 11 3747 4511 6031 -7353 2 2 13 11 4610 5337 6355 -7354 2 2 13 11 3698 5335 5067 -7355 2 2 13 11 6435 4815 4006 -7356 2 2 13 11 4149 5002 5033 -7357 2 2 13 11 3999 4475 5675 -7358 2 2 13 11 4000 5676 4476 -7359 2 2 13 11 3735 4931 6314 -7360 2 2 13 11 3917 6473 4596 -7361 2 2 13 11 5337 4372 6355 -7362 2 2 13 11 4771 6070 5612 -7363 2 2 13 11 4772 5613 6071 -7364 2 2 13 11 4214 5605 4534 -7365 2 2 13 11 4525 6681 4641 -7366 2 2 13 11 4410 6555 5517 -7367 2 2 13 11 4023 6043 5905 -7368 2 2 13 11 4438 5697 5317 -7369 2 2 13 11 4439 5318 5698 -7370 2 2 13 11 3669 4561 5936 -7371 2 2 13 11 4023 5905 4936 -7372 2 2 13 11 3993 5074 5843 -7373 2 2 13 11 5914 5293 3682 -7374 2 2 13 11 117 4541 5287 -7375 2 2 13 11 5916 3683 5294 -7376 2 2 13 11 5115 5946 6684 -7377 2 2 13 11 3897 4522 5072 -7378 2 2 13 11 3898 5073 4523 -7379 2 2 13 11 309 5231 5700 -7380 2 2 13 11 4149 4980 5345 -7381 2 2 13 11 3975 4635 5127 -7382 2 2 13 11 4151 6309 4587 -7383 2 2 13 11 3675 4713 5222 -7384 2 2 13 11 3959 4710 5383 -7385 2 2 13 11 4207 5224 5015 -7386 2 2 13 11 4208 5016 5226 -7387 2 2 13 11 4126 5080 5162 -7388 2 2 13 11 4311 4999 5391 -7389 2 2 13 11 3757 5311 5024 -7390 2 2 13 11 3904 5578 4711 -7391 2 2 13 11 3816 4623 6631 -7392 2 2 13 11 3817 6632 4624 -7393 2 2 13 11 4100 5451 4463 -7394 2 2 13 11 4252 4841 6279 -7395 2 2 13 11 4490 5560 5571 -7396 2 2 13 11 4313 6254 4638 -7397 2 2 13 11 4046 5096 6811 -7398 2 2 13 11 3672 6446 5392 -7399 2 2 13 11 3821 5419 5340 -7400 2 2 13 11 3744 5012 4577 -7401 2 2 13 11 3745 4578 5013 -7402 2 2 13 11 3735 6314 5820 -7403 2 2 13 11 4007 4557 5880 -7404 2 2 13 11 3786 5177 6290 -7405 2 2 13 11 3787 6291 5178 -7406 2 2 13 11 4163 6235 4525 -7407 2 2 13 11 4636 5233 5895 -7408 2 2 13 11 3853 5303 4470 -7409 2 2 13 11 4027 4840 6536 -7410 2 2 13 11 3755 4715 5128 -7411 2 2 13 11 4047 6812 5099 -7412 2 2 13 11 3664 5448 5297 -7413 2 2 13 11 4001 5014 6158 -7414 2 2 13 11 3934 4978 5615 -7415 2 2 13 11 3935 5616 4979 -7416 2 2 13 11 3930 5164 4516 -7417 2 2 13 11 6385 4319 5232 -7418 2 2 13 11 3989 4585 5494 -7419 2 2 13 11 4762 6947 5902 -7420 2 2 13 11 3927 4714 6932 -7421 2 2 13 11 4566 5293 5914 -7422 2 2 13 11 4567 5916 5294 -7423 2 2 13 11 3756 4509 5253 -7424 2 2 13 11 3987 5004 4621 -7425 2 2 13 11 4180 4708 5656 -7426 2 2 13 11 4089 5399 4513 -7427 2 2 13 11 4382 4688 5194 -7428 2 2 13 11 3992 5047 6870 -7429 2 2 13 11 4318 4632 6117 -7430 2 2 13 11 4590 5403 6146 -7431 2 2 13 11 4733 6516 6355 -7432 2 2 13 11 3868 4883 5606 -7433 2 2 13 11 4663 5012 6341 -7434 2 2 13 11 4664 6343 5013 -7435 2 2 13 11 3959 5383 6138 -7436 2 2 13 11 3944 6072 6727 -7437 2 2 13 11 3888 4986 5481 -7438 2 2 13 11 4435 6067 4848 -7439 2 2 13 11 3865 4574 5884 -7440 2 2 13 11 4537 5702 6175 -7441 2 2 13 11 5016 6397 6151 -7442 2 2 13 11 4379 4776 5887 -7443 2 2 13 11 4032 4944 5447 -7444 2 2 13 11 4516 5164 6509 -7445 2 2 13 11 4187 4590 5873 -7446 2 2 13 11 3998 4657 5749 -7447 2 2 13 11 4526 131 5596 -7448 2 2 13 11 6887 3723 5702 -7449 2 2 13 11 4005 6378 4654 -7450 2 2 13 11 3802 5498 4963 -7451 2 2 13 11 4084 5015 5224 -7452 2 2 13 11 4085 5226 5016 -7453 2 2 13 11 3736 5627 4655 -7454 2 2 13 11 4728 6870 5047 -7455 2 2 13 11 289 5362 4712 -7456 2 2 13 11 3671 5422 6190 -7457 2 2 13 11 3708 5399 5117 -7458 2 2 13 11 3891 5674 4671 -7459 2 2 13 11 4406 5439 5324 -7460 2 2 13 11 3960 4592 5035 -7461 2 2 13 11 3961 5036 4593 -7462 2 2 13 11 3848 4678 5014 -7463 2 2 13 11 5397 6806 4008 -7464 2 2 13 11 4125 4518 5310 -7465 2 2 13 11 4048 4741 4827 -7466 2 2 13 11 4049 4828 4742 -7467 2 2 13 11 3678 4924 5273 -7468 2 2 13 11 3760 4503 6432 -7469 2 2 13 11 273 6147 5156 -7470 2 2 13 11 4144 4532 5215 -7471 2 2 13 11 4145 5216 4533 -7472 2 2 13 11 4065 5433 4531 -7473 2 2 13 11 4110 4902 5096 -7474 2 2 13 11 3863 5682 5173 -7475 2 2 13 11 3864 5174 5683 -7476 2 2 13 11 107 108 4702 -7477 2 2 13 11 3775 4667 5132 -7478 2 2 13 11 3776 5133 4668 -7479 2 2 13 11 4053 4852 4790 -7480 2 2 13 11 3706 4524 5598 -7481 2 2 13 11 3878 4485 5763 -7482 2 2 13 11 3749 5501 4611 -7483 2 2 13 11 4224 5724 4563 -7484 2 2 13 11 4457 5297 5448 -7485 2 2 13 11 4052 5623 4500 -7486 2 2 13 11 3870 6093 4631 -7487 2 2 13 11 4212 5845 5661 -7488 2 2 13 11 4401 5569 5037 -7489 2 2 13 11 4127 4646 4915 -7490 2 2 13 11 3834 5324 5439 -7491 2 2 13 11 3984 6067 5765 -7492 2 2 13 11 4552 6168 5398 -7493 2 2 13 11 4611 5501 5681 -7494 2 2 13 11 4278 5523 4631 -7495 2 2 13 11 3976 4747 5020 -7496 2 2 13 11 3977 5021 4748 -7497 2 2 13 11 3988 6888 6441 -7498 2 2 13 11 83 5667 5094 -7499 2 2 13 11 3911 4805 5527 -7500 2 2 13 11 3912 5528 4806 -7501 2 2 13 11 3830 5317 5697 -7502 2 2 13 11 3831 5698 5318 -7503 2 2 13 11 4092 5358 4551 -7504 2 2 13 11 4024 4899 4737 -7505 2 2 13 11 4144 6766 4532 -7506 2 2 13 11 4145 4533 6767 -7507 2 2 13 11 4212 5661 5041 -7508 2 2 13 11 3860 5751 4940 -7509 2 2 13 11 4112 5099 4905 -7510 2 2 13 11 6408 4426 5395 -7511 2 2 13 11 4149 5345 5733 -7512 2 2 13 11 3869 5134 4558 -7513 2 2 13 11 4832 5149 6934 -7514 2 2 13 11 3744 4577 6062 -7515 2 2 13 11 3745 6064 4578 -7516 2 2 13 11 4515 5604 6581 -7517 2 2 13 11 4118 4616 5394 -7518 2 2 13 11 4041 4990 6459 -7519 2 2 13 11 4042 6460 4991 -7520 2 2 13 11 154 155 4695 -7521 2 2 13 11 66 67 4696 -7522 2 2 13 11 4998 5834 6247 -7523 2 2 13 11 4679 6575 5929 -7524 2 2 13 11 4081 5132 4527 -7525 2 2 13 11 5131 6435 4006 -7526 2 2 13 11 3784 4604 5875 -7527 2 2 13 11 4082 4528 5133 -7528 2 2 13 11 3767 6607 4852 -7529 2 2 13 11 3856 6640 5245 -7530 2 2 13 11 3670 5592 4761 -7531 2 2 13 11 3688 6366 5236 -7532 2 2 13 11 3944 6814 6072 -7533 2 2 13 11 4382 6395 4688 -7534 2 2 13 11 4826 6201 6228 -7535 2 2 13 11 3979 6765 5796 -7536 2 2 13 11 3975 6120 4764 -7537 2 2 13 11 4353 5615 4978 -7538 2 2 13 11 4354 4979 5616 -7539 2 2 13 11 302 5378 303 -7540 2 2 13 11 3756 4795 6419 -7541 2 2 13 11 3709 5892 4529 -7542 2 2 13 11 3852 5762 4935 -7543 2 2 13 11 4962 6310 5986 -7544 2 2 13 11 3668 5990 4549 -7545 2 2 13 11 4776 6923 5887 -7546 2 2 13 11 4488 5585 6386 -7547 2 2 13 11 4489 6387 5586 -7548 2 2 13 11 4147 5302 4626 -7549 2 2 13 11 4756 6811 5096 -7550 2 2 13 11 3995 5301 4947 -7551 2 2 13 11 3757 4890 5311 -7552 2 2 13 11 315 5157 316 -7553 2 2 13 11 260 5158 261 -7554 2 2 13 11 4065 4531 5991 -7555 2 2 13 11 3824 5785 6384 -7556 2 2 13 11 4175 4681 5660 -7557 2 2 13 11 3962 5108 4753 -7558 2 2 13 11 3907 4680 5575 -7559 2 2 13 11 4757 5099 6812 -7560 2 2 13 11 3666 5207 4572 -7561 2 2 13 11 4095 5431 5327 -7562 2 2 13 11 3667 4573 5208 -7563 2 2 13 11 4096 5328 5432 -7564 2 2 13 11 4099 4486 5508 -7565 2 2 13 11 3927 6932 4783 -7566 2 2 13 11 3880 4544 5494 -7567 2 2 13 11 4618 4855 6614 -7568 2 2 13 11 4619 6615 4856 -7569 2 2 13 11 4190 5666 5889 -7570 2 2 13 11 4568 5382 6013 -7571 2 2 13 11 4052 4500 5254 -7572 2 2 13 11 3799 5707 4622 -7573 2 2 13 11 3915 4697 4984 -7574 2 2 13 11 4521 5245 6640 -7575 2 2 13 11 3760 5065 4621 -7576 2 2 13 11 3750 4521 6443 -7577 2 2 13 11 4066 6583 4507 -7578 2 2 13 11 4067 4508 6584 -7579 2 2 13 11 4196 5125 5838 -7580 2 2 13 11 3698 4816 5335 -7581 2 2 13 11 3671 6843 5422 -7582 2 2 13 11 4069 4554 5385 -7583 2 2 13 11 3661 4584 6719 -7584 2 2 13 11 4246 5936 4561 -7585 2 2 13 11 3775 5132 5105 -7586 2 2 13 11 3776 5106 5133 -7587 2 2 13 11 3736 4655 4987 -7588 2 2 13 11 3734 5305 4900 -7589 2 2 13 11 3668 4495 5541 -7590 2 2 13 11 3841 4708 5546 -7591 2 2 13 11 4841 5026 6279 -7592 2 2 13 11 4208 6397 5016 -7593 2 2 13 11 4332 5481 4986 -7594 2 2 13 11 4629 5203 6634 -7595 2 2 13 11 4630 6635 5204 -7596 2 2 13 11 4941 5710 6270 -7597 2 2 13 11 3947 4862 5195 -7598 2 2 13 11 3964 5343 6914 -7599 2 2 13 11 3965 6915 5344 -7600 2 2 13 11 3948 4877 6659 -7601 2 2 13 11 4510 5173 5682 -7602 2 2 13 11 4511 5683 5174 -7603 2 2 13 11 3947 4651 5058 -7604 2 2 13 11 4132 5284 4957 -7605 2 2 13 11 5849 4041 6459 -7606 2 2 13 11 5850 6460 4042 -7607 2 2 13 11 4172 4711 5578 -7608 2 2 13 11 3897 5417 4522 -7609 2 2 13 11 3898 4523 5418 -7610 2 2 13 11 4312 4963 5498 -7611 2 2 13 11 4880 6629 6688 -7612 2 2 13 11 3746 4926 4874 -7613 2 2 13 11 3747 4875 4927 -7614 2 2 13 11 4112 4834 5775 -7615 2 2 13 11 4465 5157 6049 -7616 2 2 13 11 4466 6050 5158 -7617 2 2 13 11 3778 5614 4666 -7618 2 2 13 11 3928 6216 4613 -7619 2 2 13 11 4335 5117 5399 -7620 2 2 13 11 4213 5274 5064 -7621 2 2 13 11 4883 5957 5606 -7622 2 2 13 11 3674 6894 4636 -7623 2 2 13 11 4313 4638 6574 -7624 2 2 13 11 4311 4690 5520 -7625 2 2 13 11 3939 6112 5307 -7626 2 2 13 11 3963 4520 5732 -7627 2 2 13 11 6439 3757 5024 -7628 2 2 13 11 3675 4609 6471 -7629 2 2 13 11 3711 5938 5179 -7630 2 2 13 11 3649 4725 6633 -7631 2 2 13 11 4093 5181 5237 -7632 2 2 13 11 5185 6360 5924 -7633 2 2 13 11 4222 4604 5067 -7634 2 2 13 11 3984 4848 6067 -7635 2 2 13 11 3985 4880 4928 -7636 2 2 13 11 3816 6353 4623 -7637 2 2 13 11 3817 4624 6354 -7638 2 2 13 11 4455 4744 6501 -7639 2 2 13 11 3760 6428 4503 -7640 2 2 13 11 4054 5253 4509 -7641 2 2 13 11 4351 5257 5424 -7642 2 2 13 11 3672 5392 6279 -7643 2 2 13 11 4352 5425 5258 -7644 2 2 13 11 3928 6761 4764 -7645 2 2 13 11 4180 5546 4708 -7646 2 2 13 11 3742 4496 5549 -7647 2 2 13 11 4218 5527 4805 -7648 2 2 13 11 4219 4806 5528 -7649 2 2 13 11 3690 4876 4844 -7650 2 2 13 11 3712 5623 4540 -7651 2 2 13 11 3943 4561 5354 -7652 2 2 13 11 267 5701 5314 -7653 2 2 13 11 4026 5185 5924 -7654 2 2 13 11 4441 4784 6303 -7655 2 2 13 11 3702 4719 5666 -7656 2 2 13 11 4442 6304 4785 -7657 2 2 13 11 4222 5875 4604 -7658 2 2 13 11 4888 5867 6829 -7659 2 2 13 11 3824 6384 4821 -7660 2 2 13 11 3792 5113 4920 -7661 2 2 13 11 3793 4921 5114 -7662 2 2 13 11 3815 5867 4888 -7663 2 2 13 11 3651 5882 4576 -7664 2 2 13 11 3751 5427 4587 -7665 2 2 13 11 3666 4572 5557 -7666 2 2 13 11 3667 5558 4573 -7667 2 2 13 11 4140 4746 5470 -7668 2 2 13 11 4019 6033 4737 -7669 2 2 13 11 4487 6515 4913 -7670 2 2 13 11 139 140 5030 -7671 2 2 13 11 4672 5645 6503 -7672 2 2 13 11 6604 3884 4547 -7673 2 2 13 11 4673 6504 5646 -7674 2 2 13 11 6606 4548 3885 -7675 2 2 13 11 4066 4507 5557 -7676 2 2 13 11 4067 5558 4508 -7677 2 2 13 11 4040 4570 5491 -7678 2 2 13 11 4066 6634 5203 -7679 2 2 13 11 4067 5204 6635 -7680 2 2 13 11 3692 5873 4590 -7681 2 2 13 11 3764 4558 5941 -7682 2 2 13 11 3655 5096 4902 -7683 2 2 13 11 3970 5851 5104 -7684 2 2 13 11 4636 6894 5044 -7685 2 2 13 11 4418 4940 5751 -7686 2 2 13 11 4083 5064 5274 -7687 2 2 13 11 3650 6200 6322 -7688 2 2 13 11 4543 6073 5002 -7689 2 2 13 11 110 111 4993 -7690 2 2 13 11 4605 6345 5295 -7691 2 2 13 11 4606 5296 6346 -7692 2 2 13 11 3761 4531 5433 -7693 2 2 13 11 6266 131 4526 -7694 2 2 13 11 3865 6051 4574 -7695 2 2 13 11 4048 4827 4950 -7696 2 2 13 11 4049 4951 4828 -7697 2 2 13 11 142 143 4738 -7698 2 2 13 11 5440 5725 3687 -7699 2 2 13 11 3737 4868 4771 -7700 2 2 13 11 3738 4772 4869 -7701 2 2 13 11 4638 6254 6563 -7702 2 2 13 11 4065 4853 5092 -7703 2 2 13 11 3966 4808 4831 -7704 2 2 13 11 4214 4534 6153 -7705 2 2 13 11 4099 5349 6880 -7706 2 2 13 11 3767 5880 4557 -7707 2 2 13 11 3810 6033 5280 -7708 2 2 13 11 3693 5473 4944 -7709 2 2 13 11 6263 5236 5007 -7710 2 2 13 11 4077 5398 6168 -7711 2 2 13 11 3678 5273 4916 -7712 2 2 13 11 4013 5798 4693 -7713 2 2 13 11 3767 6692 6246 -7714 2 2 13 11 3734 4674 5881 -7715 2 2 13 11 4239 5793 4722 -7716 2 2 13 11 4240 4723 5794 -7717 2 2 13 11 4081 4527 6194 -7718 2 2 13 11 4082 6195 4528 -7719 2 2 13 11 4093 5237 4739 -7720 2 2 13 11 4189 4622 5707 -7721 2 2 13 11 4015 6133 5199 -7722 2 2 13 11 3936 4676 5491 -7723 2 2 13 11 4016 5200 6134 -7724 2 2 13 11 3760 4621 5138 -7725 2 2 13 11 4414 4935 5762 -7726 2 2 13 11 3908 4688 6395 -7727 2 2 13 11 4469 5244 5795 -7728 2 2 13 11 6575 4472 5929 -7729 2 2 13 11 3711 5250 5938 -7730 2 2 13 11 3669 6774 4561 -7731 2 2 13 11 3656 4905 5099 -7732 2 2 13 11 3750 5380 4521 -7733 2 2 13 11 3751 4587 6562 -7734 2 2 13 11 4591 6139 5516 -7735 2 2 13 11 3655 4756 5096 -7736 2 2 13 11 4081 4649 5105 -7737 2 2 13 11 4082 5106 4650 -7738 2 2 13 11 4595 6135 5303 -7739 2 2 13 11 3717 4646 5459 -7740 2 2 13 11 6325 5212 4256 -7741 2 2 13 11 6326 4257 5213 -7742 2 2 13 11 3964 5712 5992 -7743 2 2 13 11 3965 5993 5713 -7744 2 2 13 11 4100 6797 5350 -7745 2 2 13 11 3718 5315 6313 -7746 2 2 13 11 3844 4945 6022 -7747 2 2 13 11 4004 6142 4571 -7748 2 2 13 11 3656 5099 4757 -7749 2 2 13 11 3698 5912 4816 -7750 2 2 13 11 5926 119 5166 -7751 2 2 13 11 3754 4880 6688 -7752 2 2 13 11 3654 5322 4649 -7753 2 2 13 11 3653 4650 5323 -7754 2 2 13 11 4618 6614 6811 -7755 2 2 13 11 4619 6812 6615 -7756 2 2 13 11 5710 3909 6270 -7757 2 2 13 11 3716 6355 6516 -7758 2 2 13 11 3761 5641 4930 -7759 2 2 13 11 4491 6747 4845 -7760 2 2 13 11 5225 6171 6024 -7761 2 2 13 11 4484 6000 5565 -7762 2 2 13 11 3928 4764 6921 -7763 2 2 13 11 3975 6845 4599 -7764 2 2 13 11 3926 4739 5237 -7765 2 2 13 11 3665 5722 5721 -7766 2 2 13 11 82 83 5094 -7767 2 2 13 11 325 5168 5588 -7768 2 2 13 11 251 5589 5169 -7769 2 2 13 11 4500 5104 5851 -7770 2 2 13 11 5605 6718 4534 -7771 2 2 13 11 4015 5045 6133 -7772 2 2 13 11 4016 6134 5046 -7773 2 2 13 11 3749 4611 5507 -7774 2 2 13 11 4026 4562 5526 -7775 2 2 13 11 75 76 4744 -7776 2 2 13 11 5673 4273 6417 -7777 2 2 13 11 4711 6718 5605 -7778 2 2 13 11 4331 6201 4826 -7779 2 2 13 11 3774 4825 5911 -7780 2 2 13 11 3822 5248 4596 -7781 2 2 13 11 4125 5396 4518 -7782 2 2 13 11 4059 4798 5549 -7783 2 2 13 11 4015 5136 4672 -7784 2 2 13 11 4016 4673 5137 -7785 2 2 13 11 6405 4326 5128 -7786 2 2 13 11 4039 5892 4729 -7787 2 2 13 11 4479 5915 6286 -7788 2 2 13 11 3869 5770 4514 -7789 2 2 13 11 3662 6303 4784 -7790 2 2 13 11 3663 4785 6304 -7791 2 2 13 11 4142 5498 4675 -7792 2 2 13 11 3995 5620 4712 -7793 2 2 13 11 3938 6501 4744 -7794 2 2 13 11 6345 4020 5295 -7795 2 2 13 11 6346 5296 4021 -7796 2 2 13 11 3768 4525 6624 -7797 2 2 13 11 108 5604 4702 -7798 2 2 13 11 3915 6254 4582 -7799 2 2 13 11 3759 5632 4670 -7800 2 2 13 11 4293 6110 4863 -7801 2 2 13 11 4300 5441 5486 -7802 2 2 13 11 4301 5487 5442 -7803 2 2 13 11 3916 5197 4550 -7804 2 2 13 11 4690 6439 5024 -7805 2 2 13 11 4230 6263 5007 -7806 2 2 13 11 4015 4672 5045 -7807 2 2 13 11 4016 5046 4673 -7808 2 2 13 11 4138 5437 4703 -7809 2 2 13 11 4139 4704 5438 -7810 2 2 13 11 3902 5102 6255 -7811 2 2 13 11 3880 5679 4544 -7812 2 2 13 11 3903 6256 5103 -7813 2 2 13 11 3894 4616 5577 -7814 2 2 13 11 4057 4565 6267 -7815 2 2 13 11 4287 4835 5503 -7816 2 2 13 11 4189 5779 4622 -7817 2 2 13 11 3692 4590 5801 -7818 2 2 13 11 3794 5692 6231 -7819 2 2 13 11 4255 4944 5473 -7820 2 2 13 11 3960 5341 4592 -7821 2 2 13 11 3961 4593 5342 -7822 2 2 13 11 3998 5626 4721 -7823 2 2 13 11 4635 4764 6761 -7824 2 2 13 11 4210 5159 5081 -7825 2 2 13 11 4845 6747 6223 -7826 2 2 13 11 4040 5745 4570 -7827 2 2 13 11 3702 4681 5797 -7828 2 2 13 11 301 5525 302 -7829 2 2 13 11 3979 4669 6548 -7830 2 2 13 11 325 5588 326 -7831 2 2 13 11 250 5589 251 -7832 2 2 13 11 3962 4971 4765 -7833 2 2 13 11 4026 5573 4562 -7834 2 2 13 11 3684 5424 5257 -7835 2 2 13 11 3685 5258 5425 -7836 2 2 13 11 3847 4994 4773 -7837 2 2 13 11 3761 5839 5246 -7838 2 2 13 11 4863 6110 6377 -7839 2 2 13 11 4052 5254 4658 -7840 2 2 13 11 4113 5681 5501 -7841 2 2 13 11 3983 4677 5128 -7842 2 2 13 11 4543 6285 6073 -7843 2 2 13 11 275 5559 4721 -7844 2 2 13 11 3714 5862 4592 -7845 2 2 13 11 3715 4593 5863 -7846 2 2 13 11 4239 4722 5772 -7847 2 2 13 11 4240 5773 4723 -7848 2 2 13 11 4059 6374 4656 -7849 2 2 13 11 3785 5348 5041 -7850 2 2 13 11 3889 6391 5514 -7851 2 2 13 11 4114 4611 5152 -7852 2 2 13 11 3890 5515 6392 -7853 2 2 13 11 6158 5308 4235 -7854 2 2 13 11 3769 5675 4791 -7855 2 2 13 11 3770 4792 5676 -7856 2 2 13 11 3857 5566 4577 -7857 2 2 13 11 3858 4578 5567 -7858 2 2 13 11 4741 5212 6325 -7859 2 2 13 11 3724 6480 4683 -7860 2 2 13 11 4742 6326 5213 -7861 2 2 13 11 4186 4775 5260 -7862 2 2 13 11 3958 5306 4683 -7863 2 2 13 11 4052 4540 5623 -7864 2 2 13 11 3783 4651 6181 -7865 2 2 13 11 4488 6678 5585 -7866 2 2 13 11 4489 5586 6679 -7867 2 2 13 11 4035 4596 5248 -7868 2 2 13 11 6560 5066 3774 -7869 2 2 13 11 4689 6047 5331 -7870 2 2 13 11 4089 4513 5519 -7871 2 2 13 11 4576 6553 5899 -7872 2 2 13 11 4076 4981 4658 -7873 2 2 13 11 3953 4913 6515 -7874 2 2 13 11 4641 5725 5440 -7875 2 2 13 11 3906 6593 4666 -7876 2 2 13 11 4241 5027 5298 -7877 2 2 13 11 4242 5299 5028 -7878 2 2 13 11 3767 5049 6692 -7879 2 2 13 11 3752 5795 5244 -7880 2 2 13 11 3706 5059 5057 -7881 2 2 13 11 3730 5184 4665 -7882 2 2 13 11 3714 5772 4722 -7883 2 2 13 11 3715 4723 5773 -7884 2 2 13 11 3783 5703 4651 -7885 2 2 13 11 3822 4596 5406 -7886 2 2 13 11 3934 4703 5437 -7887 2 2 13 11 4005 5736 4564 -7888 2 2 13 11 3935 5438 4704 -7889 2 2 13 11 3891 5218 4644 -7890 2 2 13 11 3988 4613 6216 -7891 2 2 13 11 3915 6563 6254 -7892 2 2 13 11 308 5622 5231 -7893 2 2 13 11 3769 4817 5675 -7894 2 2 13 11 3770 5676 4818 -7895 2 2 13 11 4420 5721 5722 -7896 2 2 13 11 3836 5651 5102 -7897 2 2 13 11 3837 5103 5652 -7898 2 2 13 11 4131 5347 4767 -7899 2 2 13 11 5191 6039 6116 -7900 2 2 13 11 3665 5127 4635 -7901 2 2 13 11 4217 5389 5024 -7902 2 2 13 11 4001 5003 5014 -7903 2 2 13 11 3670 5095 5592 -7904 2 2 13 11 4156 5415 4751 -7905 2 2 13 11 4157 4752 5416 -7906 2 2 13 11 3933 6206 4646 -7907 2 2 13 11 3799 4622 5292 -7908 2 2 13 11 302 5525 5378 -7909 2 2 13 11 4632 6590 6117 -7910 2 2 13 11 4118 5577 4616 -7911 2 2 13 11 4144 4920 5113 -7912 2 2 13 11 4145 5114 4921 -7913 2 2 13 11 4288 5867 5147 -7914 2 2 13 11 3719 4751 5415 -7915 2 2 13 11 3720 5416 4752 -7916 2 2 13 11 4360 5022 5735 -7917 2 2 13 11 3697 5470 4746 -7918 2 2 13 11 4518 6161 5372 -7919 2 2 13 11 4077 5247 5398 -7920 2 2 13 11 4198 5695 4730 -7921 2 2 13 11 5275 6451 6197 -7922 2 2 13 11 3744 6062 6424 -7923 2 2 13 11 3745 6425 6064 -7924 2 2 13 11 3710 5164 5764 -7925 2 2 13 11 4013 4689 6510 -7926 2 2 13 11 4058 4876 5083 -7927 2 2 13 11 4715 6405 5128 -7928 2 2 13 11 4409 5986 6310 -7929 2 2 13 11 118 119 5926 -7930 2 2 13 11 3994 4725 5001 -7931 2 2 13 11 4749 6914 5343 -7932 2 2 13 11 4114 5507 4611 -7933 2 2 13 11 4750 5344 6915 -7934 2 2 13 11 4286 5076 5820 -7935 2 2 13 11 4050 6914 4749 -7936 2 2 13 11 4050 4950 4827 -7937 2 2 13 11 3734 5330 4594 -7938 2 2 13 11 4206 4659 5806 -7939 2 2 13 11 4051 4750 6915 -7940 2 2 13 11 4051 4828 4951 -7941 2 2 13 11 6693 5272 5093 -7942 2 2 13 11 4074 4928 4880 -7943 2 2 13 11 4058 4844 4876 -7944 2 2 13 11 4187 5403 4590 -7945 2 2 13 11 4407 5102 5651 -7946 2 2 13 11 4283 5327 5431 -7947 2 2 13 11 4408 5652 5103 -7948 2 2 13 11 4284 5432 5328 -7949 2 2 13 11 4147 4626 5699 -7950 2 2 13 11 4187 5873 4651 -7951 2 2 13 11 4134 6762 4565 -7952 2 2 13 11 3709 5061 5070 -7953 2 2 13 11 3846 5337 4610 -7954 2 2 13 11 4229 5006 5235 -7955 2 2 13 11 3902 4722 5793 -7956 2 2 13 11 3903 5794 4723 -7957 2 2 13 11 4069 5932 4554 -7958 2 2 13 11 4481 6261 4962 -7959 2 2 13 11 4232 5263 5210 -7960 2 2 13 11 3872 5868 4826 -7961 2 2 13 11 4233 5211 5264 -7962 2 2 13 11 3846 5260 5828 -7963 2 2 13 11 3686 5092 4853 -7964 2 2 13 11 3853 5345 4681 -7965 2 2 13 11 4153 5423 4765 -7966 2 2 13 11 4477 6022 4945 -7967 2 2 13 11 4043 6758 4677 -7968 2 2 13 11 3675 6471 4713 -7969 2 2 13 11 3994 5175 4945 -7970 2 2 13 11 3862 6162 5929 -7971 2 2 13 11 4036 4690 5024 -7972 2 2 13 11 124 125 4777 -7973 2 2 13 11 4492 6141 6364 -7974 2 2 13 11 273 5156 274 -7975 2 2 13 11 4104 5426 6123 -7976 2 2 13 11 3901 6938 4762 -7977 2 2 13 11 5095 6715 6213 -7978 2 2 13 11 4191 5153 5642 -7979 2 2 13 11 4081 5199 4649 -7980 2 2 13 11 4473 6659 4877 -7981 2 2 13 11 4032 4929 4964 -7982 2 2 13 11 4082 4650 5200 -7983 2 2 13 11 4112 5775 5357 -7984 2 2 13 11 4269 5116 5371 -7985 2 2 13 11 3838 5815 5352 -7986 2 2 13 11 3839 5353 5816 -7987 2 2 13 11 4127 4652 6348 -7988 2 2 13 11 3981 4767 5017 -7989 2 2 13 11 3765 4672 5136 -7990 2 2 13 11 3766 5137 4673 -7991 2 2 13 11 3818 5153 5118 -7992 2 2 13 11 3760 5138 4676 -7993 2 2 13 11 3794 6231 5224 -7994 2 2 13 11 4291 6247 5834 -7995 2 2 13 11 4154 5172 5050 -7996 2 2 13 11 115 116 4811 -7997 2 2 13 11 3958 4683 5082 -7998 2 2 13 11 5645 4037 6503 -7999 2 2 13 11 6504 4038 5646 -8000 2 2 13 11 3986 4549 6937 -8001 2 2 13 11 4002 4922 5540 -8002 2 2 13 11 4009 5095 6213 -8003 2 2 13 11 4582 5246 5839 -8004 2 2 13 11 4161 5173 4874 -8005 2 2 13 11 4162 4875 5174 -8006 2 2 13 11 4774 5025 5714 -8007 2 2 13 11 3746 6591 4938 -8008 2 2 13 11 3747 4939 6592 -8009 2 2 13 11 4747 6871 5909 -8010 2 2 13 11 4748 5910 6872 -8011 2 2 13 11 4123 4702 5604 -8012 2 2 13 11 4879 6724 6640 -8013 2 2 13 11 4149 5033 4980 -8014 2 2 13 11 4050 4813 6914 -8015 2 2 13 11 4051 6915 4814 -8016 2 2 13 11 4126 5162 4925 -8017 2 2 13 11 4006 4745 5022 -8018 2 2 13 11 3709 5070 6400 -8019 2 2 13 11 3786 6426 5177 -8020 2 2 13 11 3787 5178 6427 -8021 2 2 13 11 4010 5488 4900 -8022 2 2 13 11 6579 5270 4087 -8023 2 2 13 11 4002 5540 4989 -8024 2 2 13 11 80 81 4889 -8025 2 2 13 11 4270 6043 4590 -8026 2 2 13 11 318 5182 4627 -8027 2 2 13 11 258 4628 5183 -8028 2 2 13 11 4678 5308 6158 -8029 2 2 13 11 4187 4651 5703 -8030 2 2 13 11 3742 4798 6536 -8031 2 2 13 11 3845 4763 4997 -8032 2 2 13 11 4231 6084 4780 -8033 2 2 13 11 4058 5162 5080 -8034 2 2 13 11 4366 4797 5107 -8035 2 2 13 11 3995 4793 5620 -8036 2 2 13 11 4215 5188 4849 -8037 2 2 13 11 4216 4850 5189 -8038 2 2 13 11 3962 4765 5423 -8039 2 2 13 11 4107 5371 5116 -8040 2 2 13 11 4336 5828 5260 -8041 2 2 13 11 4055 4874 4926 -8042 2 2 13 11 4056 4927 4875 -8043 2 2 13 11 4057 5122 5911 -8044 2 2 13 11 4052 5324 4540 -8045 2 2 13 11 4707 6593 6824 -8046 2 2 13 11 4680 6713 5575 -8047 2 2 13 11 4258 5997 4738 -8048 2 2 13 11 4134 4565 6953 -8049 2 2 13 11 4040 5138 4621 -8050 2 2 13 11 3932 4789 5680 -8051 2 2 13 11 3998 4797 5626 -8052 2 2 13 11 4059 4656 6165 -8053 2 2 13 11 5122 6560 3774 -8054 2 2 13 11 4084 5180 4807 -8055 2 2 13 11 3661 5699 4626 -8056 2 2 13 11 3792 5639 5942 -8057 2 2 13 11 3793 5943 5640 -8058 2 2 13 11 3861 6497 4833 -8059 2 2 13 11 4004 5273 5075 -8060 2 2 13 11 161 162 4778 -8061 2 2 13 11 59 60 4779 -8062 2 2 13 11 3869 4558 6339 -8063 2 2 13 11 4105 5440 6053 -8064 2 2 13 11 3958 6809 5306 -8065 2 2 13 11 3784 6163 4604 -8066 2 2 13 11 4110 6152 4833 -8067 2 2 13 11 3846 4610 5395 -8068 2 2 13 11 4493 6313 5315 -8069 2 2 13 11 3697 4957 5284 -8070 2 2 13 11 4348 5398 5247 -8071 2 2 13 11 4013 6431 4689 -8072 2 2 13 11 4237 5909 6871 -8073 2 2 13 11 4238 6872 5910 -8074 2 2 13 11 3796 5081 5159 -8075 2 2 13 11 4359 6245 4793 -8076 2 2 13 11 3718 5960 5315 -8077 2 2 13 11 4163 4591 5764 -8078 2 2 13 11 4646 6201 4915 -8079 2 2 13 11 4725 5267 6633 -8080 2 2 13 11 4378 6669 4661 -8081 2 2 13 11 4366 6269 4797 -8082 2 2 13 11 3690 4844 5744 -8083 2 2 13 11 3688 5139 5831 -8084 2 2 13 11 4113 5335 4816 -8085 2 2 13 11 3761 5246 5641 -8086 2 2 13 11 120 5047 6140 -8087 2 2 13 11 4008 5166 5705 -8088 2 2 13 11 4079 5862 4722 -8089 2 2 13 11 4080 4723 5863 -8090 2 2 13 11 3906 6824 6593 -8091 2 2 13 11 142 4738 5146 -8092 2 2 13 11 4367 4761 5539 -8093 2 2 13 11 3822 5406 6176 -8094 2 2 13 11 4031 4800 6548 -8095 2 2 13 11 4235 5075 5273 -8096 2 2 13 11 139 5030 6011 -8097 2 2 13 11 4177 5730 4794 -8098 2 2 13 11 4088 5262 6557 -8099 2 2 13 11 3999 4817 6614 -8100 2 2 13 11 4000 6615 4818 -8101 2 2 13 11 4176 5390 4925 -8102 2 2 13 11 3854 5018 5746 -8103 2 2 13 11 3750 6554 5380 -8104 2 2 13 11 3855 5747 5019 -8105 2 2 13 11 3881 5152 4611 -8106 2 2 13 11 3807 5750 5069 -8107 2 2 13 11 3654 5210 5263 -8108 2 2 13 11 3717 4871 5680 -8109 2 2 13 11 3653 5264 5211 -8110 2 2 13 11 4047 5099 5042 -8111 2 2 13 11 3909 5101 6270 -8112 2 2 13 11 3807 5913 5750 -8113 2 2 13 11 6417 4273 4887 -8114 2 2 13 11 4158 5057 5059 -8115 2 2 13 11 4176 5473 5390 -8116 2 2 13 11 4675 5498 6800 -8117 2 2 13 11 4268 5819 4822 -8118 2 2 13 11 3692 5801 4692 -8119 2 2 13 11 4022 4959 5386 -8120 2 2 13 11 4155 5729 5783 -8121 2 2 13 11 3857 4577 5529 -8122 2 2 13 11 3858 5530 4578 -8123 2 2 13 11 3710 4807 5180 -8124 2 2 13 11 3968 5376 5008 -8125 2 2 13 11 3969 5009 5377 -8126 2 2 13 11 4166 4734 5594 -8127 2 2 13 11 4167 5595 4735 -8128 2 2 13 11 4012 6308 5033 -8129 2 2 13 11 4268 4822 5572 -8130 2 2 13 11 4046 5029 5096 -8131 2 2 13 11 4377 4906 5927 -8132 2 2 13 11 4993 6935 6493 -8133 2 2 13 11 3973 4962 6261 -8134 2 2 13 11 5008 5376 6109 -8135 2 2 13 11 3901 4754 5223 -8136 2 2 13 11 5009 6111 5377 -8137 2 2 13 11 3700 5927 4906 -8138 2 2 13 11 5070 5994 6400 -8139 2 2 13 11 117 118 5926 -8140 2 2 13 11 4357 6650 4759 -8141 2 2 13 11 4109 5014 5003 -8142 2 2 13 11 4589 6322 6200 -8143 2 2 13 11 3891 6087 6184 -8144 2 2 13 11 309 5700 310 -8145 2 2 13 11 266 5701 267 -8146 2 2 13 11 4322 6073 6285 -8147 2 2 13 11 4671 5674 6893 -8148 2 2 13 11 4044 4860 5489 -8149 2 2 13 11 164 165 4909 -8150 2 2 13 11 56 57 4910 -8151 2 2 13 11 4045 5490 4861 -8152 2 2 13 11 3760 4676 5181 -8153 2 2 13 11 3999 6614 4855 -8154 2 2 13 11 3810 5290 4737 -8155 2 2 13 11 4000 4856 6615 -8156 2 2 13 11 4148 6693 5093 -8157 2 2 13 11 4526 6106 5245 -8158 2 2 13 11 306 4830 307 -8159 2 2 13 11 4191 5118 5153 -8160 2 2 13 11 159 4842 5111 -8161 2 2 13 11 62 5112 4843 -8162 2 2 13 11 4119 5205 4933 -8163 2 2 13 11 4120 4934 5206 -8164 2 2 13 11 4046 4817 5029 -8165 2 2 13 11 4092 4551 5436 -8166 2 2 13 11 4825 6580 5911 -8167 2 2 13 11 4483 5831 5139 -8168 2 2 13 11 4287 5503 5825 -8169 2 2 13 11 3792 5942 5113 -8170 2 2 13 11 3793 5114 5943 -8171 2 2 13 11 4047 5042 4818 -8172 2 2 13 11 4039 4729 6465 -8173 2 2 13 11 4036 5024 5389 -8174 2 2 13 11 5292 6297 4285 -8175 2 2 13 11 3679 5737 4707 -8176 2 2 13 11 4298 5077 5400 -8177 2 2 13 11 3959 6789 4710 -8178 2 2 13 11 4299 5401 5078 -8179 2 2 13 11 3762 4618 5740 -8180 2 2 13 11 4043 4677 6572 -8181 2 2 13 11 3763 5741 4619 -8182 2 2 13 11 3894 6167 4616 -8183 2 2 13 11 3882 5522 4581 -8184 2 2 13 11 4019 6691 6033 -8185 2 2 13 11 4229 5235 5725 -8186 2 2 13 11 4012 5002 6073 -8187 2 2 13 11 4531 4930 6654 -8188 2 2 13 11 4515 4993 6493 -8189 2 2 13 11 159 160 4842 -8190 2 2 13 11 61 62 4843 -8191 2 2 13 11 3764 5517 4558 -8192 2 2 13 11 4479 5049 5915 -8193 2 2 13 11 3757 5391 4662 -8194 2 2 13 11 3910 5201 4755 -8195 2 2 13 11 6866 5538 4317 -8196 2 2 13 11 3703 5141 4734 -8197 2 2 13 11 3704 4735 5142 -8198 2 2 13 11 4320 4763 6224 -8199 2 2 13 11 4008 5000 5397 -8200 2 2 13 11 4639 6441 6888 -8201 2 2 13 11 3967 4822 5819 -8202 2 2 13 11 4159 5070 5061 -8203 2 2 13 11 4110 5812 6152 -8204 2 2 13 11 4159 5155 5070 -8205 2 2 13 11 4318 6198 4632 -8206 2 2 13 11 4720 5380 6554 -8207 2 2 13 11 4061 5534 5141 -8208 2 2 13 11 4062 5142 5535 -8209 2 2 13 11 4553 6184 6087 -8210 2 2 13 11 4078 5123 5276 -8211 2 2 13 11 3820 5735 5022 -8212 2 2 13 11 3833 5842 5661 -8213 2 2 13 11 4031 6548 6418 -8214 2 2 13 11 4057 5911 5974 -8215 2 2 13 11 4319 5191 6116 -8216 2 2 13 11 4209 4665 5768 -8217 2 2 13 11 4079 4722 5684 -8218 2 2 13 11 4080 5685 4723 -8219 2 2 13 11 4331 4826 5868 -8220 2 2 13 11 3806 4841 5689 -8221 2 2 13 11 3908 5149 4688 -8222 2 2 13 11 4108 4681 5345 -8223 2 2 13 11 3991 5233 4636 -8224 2 2 13 11 3769 5029 4817 -8225 2 2 13 11 3952 4686 5172 -8226 2 2 13 11 4546 6213 5570 -8227 2 2 13 11 4495 6229 4952 -8228 2 2 13 11 3932 5680 4871 -8229 2 2 13 11 3758 5075 5308 -8230 2 2 13 11 3741 5053 4936 -8231 2 2 13 11 3759 4870 5632 -8232 2 2 13 11 3877 6364 6141 -8233 2 2 13 11 4025 5176 4768 -8234 2 2 13 11 3713 5834 4998 -8235 2 2 13 11 4057 5413 4565 -8236 2 2 13 11 3851 5240 5946 -8237 2 2 13 11 4235 5308 5075 -8238 2 2 13 11 4013 6510 4829 -8239 2 2 13 11 4172 5209 4633 -8240 2 2 13 11 5026 6274 6048 -8241 2 2 13 11 3780 4980 5033 -8242 2 2 13 11 3770 4818 5042 -8243 2 2 13 11 4039 4881 6292 -8244 2 2 13 11 4246 4561 5771 -8245 2 2 13 11 3989 5494 4923 -8246 2 2 13 11 5076 6675 5820 -8247 2 2 13 11 4094 5462 5202 -8248 2 2 13 11 4091 4662 5391 -8249 2 2 13 11 4812 5306 6809 -8250 2 2 13 11 4886 4995 6572 -8251 2 2 13 11 4007 5592 4557 -8252 2 2 13 11 4519 6536 4798 -8253 2 2 13 11 4004 4617 6511 -8254 2 2 13 11 4599 6845 5653 -8255 2 2 13 11 3921 4738 5997 -8256 2 2 13 11 3736 6773 6065 -8257 2 2 13 11 3660 5321 4687 -8258 2 2 13 11 4760 6363 5196 -8259 2 2 13 11 3919 4791 6566 -8260 2 2 13 11 3920 6567 4792 -8261 2 2 13 11 94 5383 4710 -8262 2 2 13 11 4364 4734 5141 -8263 2 2 13 11 4524 4833 6497 -8264 2 2 13 11 4365 5142 4735 -8265 2 2 13 11 3955 6669 5565 -8266 2 2 13 11 4802 5538 6866 -8267 2 2 13 11 3844 5671 5520 -8268 2 2 13 11 4035 5070 5155 -8269 2 2 13 11 4202 4743 5505 -8270 2 2 13 11 4060 5225 6266 -8271 2 2 13 11 4153 5372 6161 -8272 2 2 13 11 3724 4683 6337 -8273 2 2 13 11 3650 6322 4899 -8274 2 2 13 11 4023 5659 4692 -8275 2 2 13 11 4421 6053 5440 -8276 2 2 13 11 4173 5686 4731 -8277 2 2 13 11 4174 4732 5687 -8278 2 2 13 11 3891 4671 6087 -8279 2 2 13 11 4043 4799 6758 -8280 2 2 13 11 4073 4964 4929 -8281 2 2 13 11 4396 5746 5018 -8282 2 2 13 11 4483 5728 6577 -8283 2 2 13 11 4397 5019 5747 -8284 2 2 13 11 4319 5556 5232 -8285 2 2 13 11 4218 5219 5203 -8286 2 2 13 11 4219 5204 5220 -8287 2 2 13 11 3833 5145 5842 -8288 2 2 13 11 4584 5824 5407 -8289 2 2 13 11 4079 4592 5862 -8290 2 2 13 11 4080 5863 4593 -8291 2 2 13 11 4563 6774 6032 -8292 2 2 13 11 3995 6107 4634 -8293 2 2 13 11 4081 5105 5132 -8294 2 2 13 11 4494 5000 6275 -8295 2 2 13 11 4082 5133 5106 -8296 2 2 13 11 4022 5386 6278 -8297 2 2 13 11 3686 4853 5209 -8298 2 2 13 11 4039 5023 5892 -8299 2 2 13 11 3970 4780 5040 -8300 2 2 13 11 3955 4598 5499 -8301 2 2 13 11 4243 6118 5165 -8302 2 2 13 11 3751 6562 4847 -8303 2 2 13 11 3923 6609 4796 -8304 2 2 13 11 4040 4621 5854 -8305 2 2 13 11 5428 6579 4087 -8306 2 2 13 11 4066 5203 5219 -8307 2 2 13 11 3736 6088 5627 -8308 2 2 13 11 4067 5220 5204 -8309 2 2 13 11 96 97 4956 -8310 2 2 13 11 6573 3986 5311 -8311 2 2 13 11 4317 5502 5578 -8312 2 2 13 11 4076 4658 6841 -8313 2 2 13 11 4422 6219 6282 -8314 2 2 13 11 4090 4712 5362 -8315 2 2 13 11 4060 6171 5225 -8316 2 2 13 11 80 4889 6605 -8317 2 2 13 11 3982 4582 6740 -8318 2 2 13 11 4182 5062 5227 -8319 2 2 13 11 4378 4661 6337 -8320 2 2 13 11 4005 4691 5736 -8321 2 2 13 11 4396 6243 5409 -8322 2 2 13 11 4397 5410 6244 -8323 2 2 13 11 4104 6123 5278 -8324 2 2 13 11 4497 4796 6609 -8325 2 2 13 11 4676 5138 5491 -8326 2 2 13 11 3909 5710 5100 -8327 2 2 13 11 5259 6639 4073 -8328 2 2 13 11 4173 4731 5615 -8329 2 2 13 11 4174 5616 4732 -8330 2 2 13 11 4102 6136 4591 -8331 2 2 13 11 3964 6627 5343 -8332 2 2 13 11 3965 5344 6628 -8333 2 2 13 11 4474 6138 5383 -8334 2 2 13 11 3856 4879 6640 -8335 2 2 13 11 4555 6424 6062 -8336 2 2 13 11 4556 6064 6425 -8337 2 2 13 11 319 4627 5554 -8338 2 2 13 11 257 5555 4628 -8339 2 2 13 11 3736 4987 6773 -8340 2 2 13 11 4070 5452 4884 -8341 2 2 13 11 4071 4885 5453 -8342 2 2 13 11 5120 5729 6416 -8343 2 2 13 11 4422 6282 5456 -8344 2 2 13 11 6860 3842 5771 -8345 2 2 13 11 3762 5313 6037 -8346 2 2 13 11 3763 6038 5316 -8347 2 2 13 11 4166 5639 4647 -8348 2 2 13 11 4167 4648 5640 -8349 2 2 13 11 4320 5450 4763 -8350 2 2 13 11 4318 4961 6846 -8351 2 2 13 11 4475 6566 4791 -8352 2 2 13 11 4476 4792 6567 -8353 2 2 13 11 3748 6275 5000 -8354 2 2 13 11 3654 4649 6133 -8355 2 2 13 11 3653 6134 4650 -8356 2 2 13 11 3911 4607 5461 -8357 2 2 13 11 3862 5023 6162 -8358 2 2 13 11 3912 5463 4608 -8359 2 2 13 11 3795 6287 5694 -8360 2 2 13 11 3955 5422 4598 -8361 2 2 13 11 3655 6118 4756 -8362 2 2 13 11 72 73 4959 -8363 2 2 13 11 5998 5389 4217 -8364 2 2 13 11 5429 4088 6557 -8365 2 2 13 11 4396 5885 6243 -8366 2 2 13 11 4397 6244 5886 -8367 2 2 13 11 4169 4602 5700 -8368 2 2 13 11 3891 4644 5674 -8369 2 2 13 11 3677 5241 4758 -8370 2 2 13 11 4170 5701 4603 -8371 2 2 13 11 4013 6600 5798 -8372 2 2 13 11 4796 6297 5292 -8373 2 2 13 11 3934 5615 4731 -8374 2 2 13 11 3935 4732 5616 -8375 2 2 13 11 4497 6609 5632 -8376 2 2 13 11 4504 5392 6446 -8377 2 2 13 11 4244 4640 5840 -8378 2 2 13 11 4252 5689 4841 -8379 2 2 13 11 3947 5195 4651 -8380 2 2 13 11 3692 4692 5654 -8381 2 2 13 11 5033 6308 5480 -8382 2 2 13 11 4246 6654 4930 -8383 2 2 13 11 4175 6805 4595 -8384 2 2 13 11 4638 5389 5998 -8385 2 2 13 11 4059 5549 5115 -8386 2 2 13 11 267 5314 268 -8387 2 2 13 11 4221 5193 5737 -8388 2 2 13 11 3762 5027 4855 -8389 2 2 13 11 4214 4867 5605 -8390 2 2 13 11 4424 5308 4678 -8391 2 2 13 11 4107 5043 5419 -8392 2 2 13 11 3763 4856 5028 -8393 2 2 13 11 6213 6514 5570 -8394 2 2 13 11 3963 6129 5312 -8395 2 2 13 11 3995 5340 4793 -8396 2 2 13 11 4358 5705 5166 -8397 2 2 13 11 4363 5202 5462 -8398 2 2 13 11 3775 5534 4667 -8399 2 2 13 11 3751 5706 5427 -8400 2 2 13 11 4862 5814 5195 -8401 2 2 13 11 3776 4668 5535 -8402 2 2 13 11 4404 5256 5699 -8403 2 2 13 11 5343 3786 6290 -8404 2 2 13 11 5344 6291 3787 -8405 2 2 13 11 4462 5156 6147 -8406 2 2 13 11 4142 4675 5300 -8407 2 2 13 11 4171 5054 5414 -8408 2 2 13 11 4749 5343 6290 -8409 2 2 13 11 4750 6291 5344 -8410 2 2 13 11 3661 4626 5477 -8411 2 2 13 11 3946 4743 6411 -8412 2 2 13 11 3982 5743 4582 -8413 2 2 13 11 3734 5881 6690 -8414 2 2 13 11 6200 4149 4589 -8415 2 2 13 11 4121 5400 5077 -8416 2 2 13 11 4122 5078 5401 -8417 2 2 13 11 3804 4933 5205 -8418 2 2 13 11 3991 4870 5233 -8419 2 2 13 11 3805 5206 4934 -8420 2 2 13 11 4707 5737 6593 -8421 2 2 13 11 4467 6290 5177 -8422 2 2 13 11 4468 5178 6291 -8423 2 2 13 11 116 5287 4811 -8424 2 2 13 11 3959 4825 6789 -8425 2 2 13 11 4464 4889 5599 -8426 2 2 13 11 4405 5338 4901 -8427 2 2 13 11 4039 6292 6162 -8428 2 2 13 11 3978 5026 4841 -8429 2 2 13 11 4005 4654 5230 -8430 2 2 13 11 90 4656 6374 -8431 2 2 13 11 3781 5696 4857 -8432 2 2 13 11 3778 5192 5614 -8433 2 2 13 11 4550 6429 5147 -8434 2 2 13 11 3743 4680 5436 -8435 2 2 13 11 3845 6224 4763 -8436 2 2 13 11 4335 5399 5356 -8437 2 2 13 11 4900 5488 6356 -8438 2 2 13 11 3886 5086 6187 -8439 2 2 13 11 3887 6188 5087 -8440 2 2 13 11 4387 5100 5710 -8441 2 2 13 11 4253 4857 5696 -8442 2 2 13 11 3661 6719 4996 -8443 2 2 13 11 4072 5223 6882 -8444 2 2 13 11 4572 5417 6642 -8445 2 2 13 11 4573 6643 5418 -8446 2 2 13 11 4364 5141 5534 -8447 2 2 13 11 4365 5535 5142 -8448 2 2 13 11 3949 6529 5044 -8449 2 2 13 11 4728 5047 6608 -8450 2 2 13 11 3691 5542 4637 -8451 2 2 13 11 4890 6573 5311 -8452 2 2 13 11 3875 5227 5062 -8453 2 2 13 11 3854 4892 5018 -8454 2 2 13 11 3855 5019 4893 -8455 2 2 13 11 3662 5719 4809 -8456 2 2 13 11 3663 4810 5720 -8457 2 2 13 11 4555 6625 4990 -8458 2 2 13 11 4556 4991 6626 -8459 2 2 13 11 5038 6860 5771 -8460 2 2 13 11 120 121 5047 -8461 2 2 13 11 3998 6209 4657 -8462 2 2 13 11 4013 4693 6672 -8463 2 2 13 11 3866 5407 5824 -8464 2 2 13 11 4112 5042 5099 -8465 2 2 13 11 3775 5601 5534 -8466 2 2 13 11 3776 5535 5602 -8467 2 2 13 11 5319 6910 4124 -8468 2 2 13 11 3904 5605 4867 -8469 2 2 13 11 4152 4662 6137 -8470 2 2 13 11 4181 6593 5737 -8471 2 2 13 11 5375 6248 6561 -8472 2 2 13 11 4405 5614 5192 -8473 2 2 13 11 4110 5096 5029 -8474 2 2 13 11 4052 4658 5935 -8475 2 2 13 11 4024 5229 4899 -8476 2 2 13 11 308 5231 309 -8477 2 2 13 11 3675 5222 5649 -8478 2 2 13 11 3730 4665 5450 -8479 2 2 13 11 4527 6187 5086 -8480 2 2 13 11 4528 5087 6188 -8481 2 2 13 11 3889 4990 6625 -8482 2 2 13 11 3890 6626 4991 -8483 2 2 13 11 3904 4711 5605 -8484 2 2 13 11 3723 4787 5274 -8485 2 2 13 11 3773 4835 5119 -8486 2 2 13 11 4133 4901 5338 -8487 2 2 13 11 268 5314 6090 -8488 2 2 13 11 4414 5053 5934 -8489 2 2 13 11 4754 6882 5223 -8490 2 2 13 11 3973 6310 4962 -8491 2 2 13 11 322 4897 323 -8492 2 2 13 11 253 4898 254 -8493 2 2 13 11 4058 5083 5162 -8494 2 2 13 11 4598 5422 6843 -8495 2 2 13 11 3815 4888 6040 -8496 2 2 13 11 3741 5934 5053 -8497 2 2 13 11 133 134 4962 -8498 2 2 13 11 4358 6140 5047 -8499 2 2 13 11 6591 3996 5509 -8500 2 2 13 11 6592 5510 3997 -8501 2 2 13 11 3665 4635 5722 -8502 2 2 13 11 165 6079 4909 -8503 2 2 13 11 56 4910 6080 -8504 2 2 13 11 4318 6846 6198 -8505 2 2 13 11 4079 6114 4592 -8506 2 2 13 11 4080 4593 6115 -8507 2 2 13 11 4116 6087 5711 -8508 2 2 13 11 3928 4613 5977 -8509 2 2 13 11 4747 5909 6916 -8510 2 2 13 11 4748 6917 5910 -8511 2 2 13 11 3937 4698 6465 -8512 2 2 13 11 113 4616 5336 -8513 2 2 13 11 96 4956 6621 -8514 2 2 13 11 4057 4758 5122 -8515 2 2 13 11 3778 4666 5866 -8516 2 2 13 11 4195 4997 5569 -8517 2 2 13 11 4069 6340 6620 -8518 2 2 13 11 4092 5436 4680 -8519 2 2 13 11 3675 5449 4609 -8520 2 2 13 11 3967 4768 5176 -8521 2 2 13 11 3946 4604 5505 -8522 2 2 13 11 3756 5253 5462 -8523 2 2 13 11 4127 5800 4652 -8524 2 2 13 11 4683 6480 5082 -8525 2 2 13 11 4378 6337 4683 -8526 2 2 13 11 4414 6226 5053 -8527 2 2 13 11 3911 5852 4607 -8528 2 2 13 11 4003 5184 4706 -8529 2 2 13 11 3912 4608 5853 -8530 2 2 13 11 3998 5107 4797 -8531 2 2 13 11 3795 5226 6287 -8532 2 2 13 11 4325 6224 5548 -8533 2 2 13 11 3815 5147 5867 -8534 2 2 13 11 4061 5018 4892 -8535 2 2 13 11 4075 4936 5053 -8536 2 2 13 11 4062 4893 5019 -8537 2 2 13 11 3660 4687 6127 -8538 2 2 13 11 3989 6433 4585 -8539 2 2 13 11 3674 5798 4988 -8540 2 2 13 11 5354 6721 5877 -8541 2 2 13 11 3705 6003 5037 -8542 2 2 13 11 4026 4775 5573 -8543 2 2 13 11 4168 5824 4584 -8544 2 2 13 11 3917 4733 6473 -8545 2 2 13 11 4780 6084 5040 -8546 2 2 13 11 3928 6921 6216 -8547 2 2 13 11 4846 6130 6947 -8548 2 2 13 11 4286 5670 5076 -8549 2 2 13 11 4220 4755 5201 -8550 2 2 13 11 4938 6591 5509 -8551 2 2 13 11 4939 5510 6592 -8552 2 2 13 11 3946 5505 4743 -8553 2 2 13 11 4171 5727 4705 -8554 2 2 13 11 4090 4600 5633 -8555 2 2 13 11 4044 5489 5109 -8556 2 2 13 11 4045 5110 5490 -8557 2 2 13 11 4854 6639 5259 -8558 2 2 13 11 3870 4631 6234 -8559 2 2 13 11 4078 5088 5085 -8560 2 2 13 11 3741 5301 4634 -8561 2 2 13 11 3937 6465 4729 -8562 2 2 13 11 4140 4724 5277 -8563 2 2 13 11 3938 5836 5305 -8564 2 2 13 11 4264 4816 5912 -8565 2 2 13 11 4552 5398 6489 -8566 2 2 13 11 4089 5356 5399 -8567 2 2 13 11 4061 5754 4667 -8568 2 2 13 11 4062 4668 5755 -8569 2 2 13 11 4030 6539 5090 -8570 2 2 13 11 3725 6280 5716 -8571 2 2 13 11 3768 5656 5774 -8572 2 2 13 11 3782 5003 5791 -8573 2 2 13 11 3782 5791 4976 -8574 2 2 13 11 3690 5123 4876 -8575 2 2 13 11 4101 5094 5325 -8576 2 2 13 11 4359 5419 5043 -8577 2 2 13 11 4220 5950 4755 -8578 2 2 13 11 3881 4816 5835 -8579 2 2 13 11 4149 5733 4589 -8580 2 2 13 11 4182 4839 5062 -8581 2 2 13 11 4027 4758 5241 -8582 2 2 13 11 4583 5427 5706 -8583 2 2 13 11 3821 5403 4919 -8584 2 2 13 11 3819 4691 5662 -8585 2 2 13 11 3899 5355 4643 -8586 2 2 13 11 4600 5362 6564 -8587 2 2 13 11 4123 5604 6528 -8588 2 2 13 11 3717 5680 6228 -8589 2 2 13 11 4404 5699 6703 -8590 2 2 13 11 3802 6800 5498 -8591 2 2 13 11 4740 6052 6704 -8592 2 2 13 11 3800 5531 5214 -8593 2 2 13 11 4199 5710 4941 -8594 2 2 13 11 75 4744 6380 -8595 2 2 13 11 4362 6040 4888 -8596 2 2 13 11 4730 5695 6931 -8597 2 2 13 11 4695 5930 5668 -8598 2 2 13 11 4696 5669 5931 -8599 2 2 13 11 4236 4716 6041 -8600 2 2 13 11 4661 6669 5499 -8601 2 2 13 11 4645 6129 6854 -8602 2 2 13 11 4078 5083 4876 -8603 2 2 13 11 4024 4983 5229 -8604 2 2 13 11 4844 6499 5744 -8605 2 2 13 11 4183 4676 5582 -8606 2 2 13 11 3784 4783 5611 -8607 2 2 13 11 4072 5076 6108 -8608 2 2 13 11 3718 5232 5556 -8609 2 2 13 11 3772 4705 5727 -8610 2 2 13 11 4077 5280 6280 -8611 2 2 13 11 4087 6603 4609 -8612 2 2 13 11 4414 6559 6226 -8613 2 2 13 11 4105 4641 5440 -8614 2 2 13 11 4455 6380 4744 -8615 2 2 13 11 4057 6267 4758 -8616 2 2 13 11 3808 5281 5678 -8617 2 2 13 11 4029 5147 6429 -8618 2 2 13 11 3886 6855 5086 -8619 2 2 13 11 3887 5087 6856 -8620 2 2 13 11 3886 6148 6855 -8621 2 2 13 11 3887 6856 6150 -8622 2 2 13 11 4574 6612 5884 -8623 2 2 13 11 3946 5799 4604 -8624 2 2 13 11 4366 5483 5048 -8625 2 2 13 11 4087 4609 5449 -8626 2 2 13 11 4320 5603 5450 -8627 2 2 13 11 4177 5562 5730 -8628 2 2 13 11 4221 5737 6069 -8629 2 2 13 11 4475 4791 5675 -8630 2 2 13 11 4476 5676 4792 -8631 2 2 13 11 4450 5326 5653 -8632 2 2 13 11 4636 5044 6529 -8633 2 2 13 11 4182 5802 4745 -8634 2 2 13 11 3879 5653 5326 -8635 2 2 13 11 4473 5228 6610 -8636 2 2 13 11 4202 5094 5667 -8637 2 2 13 11 4125 5048 5483 -8638 2 2 13 11 4464 6605 4889 -8639 2 2 13 11 4954 6933 5361 -8640 2 2 13 11 3950 6165 4656 -8641 2 2 13 11 4117 5085 5088 -8642 2 2 13 11 3943 5354 5877 -8643 2 2 13 11 4372 5337 6176 -8644 2 2 13 11 4024 4737 5290 -8645 2 2 13 11 4340 5651 5298 -8646 2 2 13 11 77 5143 5883 -8647 2 2 13 11 4341 5299 5652 -8648 2 2 13 11 72 4959 6375 -8649 2 2 13 11 4185 5654 4692 -8650 2 2 13 11 3819 5736 4691 -8651 2 2 13 11 4349 4988 5798 -8652 2 2 13 11 4347 6366 5831 -8653 2 2 13 11 4671 5711 6087 -8654 2 2 13 11 3743 6713 4680 -8655 2 2 13 11 3918 6406 4908 -8656 2 2 13 11 4550 6040 4882 -8657 2 2 13 11 70 71 4946 -8658 2 2 13 11 3717 5459 4871 -8659 2 2 13 11 4453 6151 6397 -8660 2 2 13 11 4372 5406 4733 -8661 2 2 13 11 6910 5126 4124 -8662 2 2 13 11 4109 5276 5123 -8663 2 2 13 11 4055 5111 4842 -8664 2 2 13 11 4056 4843 5112 -8665 2 2 13 11 6052 3809 6704 -8666 2 2 13 11 3691 4637 5734 -8667 2 2 13 11 90 5617 4656 -8668 2 2 13 11 3666 4911 5207 -8669 2 2 13 11 3667 5208 4912 -8670 2 2 13 11 4086 6284 4725 -8671 2 2 13 11 4367 5539 6191 -8672 2 2 13 11 6933 3877 5361 -8673 2 2 13 11 4201 5903 4801 -8674 2 2 13 11 4322 4821 5500 -8675 2 2 13 11 4347 5831 5135 -8676 2 2 13 11 4027 5745 4840 -8677 2 2 13 11 4041 5293 6251 -8678 2 2 13 11 4042 6252 5294 -8679 2 2 13 11 3995 4947 5340 -8680 2 2 13 11 3881 4611 5681 -8681 2 2 13 11 3785 4925 5162 -8682 2 2 13 11 4363 5462 5253 -8683 2 2 13 11 5090 6539 5538 -8684 2 2 13 11 4622 5779 4878 -8685 2 2 13 11 3706 6320 5059 -8686 2 2 13 11 150 151 4982 -8687 2 2 13 11 4130 5233 4870 -8688 2 2 13 11 3921 5997 4632 -8689 2 2 13 11 4642 6072 6814 -8690 2 2 13 11 3984 5319 4848 -8691 2 2 13 11 5027 6037 5298 -8692 2 2 13 11 5028 5299 6038 -8693 2 2 13 11 4163 5774 4708 -8694 2 2 13 11 297 4949 298 -8695 2 2 13 11 3686 5803 5092 -8696 2 2 13 11 155 5441 4695 -8697 2 2 13 11 66 4696 5442 -8698 2 2 13 11 4480 6012 5170 -8699 2 2 13 11 4661 4882 5876 -8700 2 2 13 11 4153 4765 6673 -8701 2 2 13 11 3830 6386 5585 -8702 2 2 13 11 3831 5586 6387 -8703 2 2 13 11 3705 6197 6451 -8704 2 2 13 11 3670 4761 6333 -8705 2 2 13 11 4078 4876 5123 -8706 2 2 13 11 4108 5355 4719 -8707 2 2 13 11 4388 6742 5079 -8708 2 2 13 11 4482 6190 5422 -8709 2 2 13 11 4566 6251 5293 -8710 2 2 13 11 3727 4642 5460 -8711 2 2 13 11 4567 5294 6252 -8712 2 2 13 11 4485 5495 6436 -8713 2 2 13 11 3765 5645 4672 -8714 2 2 13 11 3766 4673 5646 -8715 2 2 13 11 3809 5076 5670 -8716 2 2 13 11 4699 6752 6453 -8717 2 2 13 11 4700 6454 6753 -8718 2 2 13 11 107 4702 6542 -8719 2 2 13 11 4265 5445 5168 -8720 2 2 13 11 4266 5169 5446 -8721 2 2 13 11 4007 5880 6777 -8722 2 2 13 11 3994 5267 4725 -8723 2 2 13 11 3952 5937 4686 -8724 2 2 13 11 4462 5948 5466 -8725 2 2 13 11 4023 6616 5659 -8726 2 2 13 11 3939 4620 5730 -8727 2 2 13 11 4100 4717 5451 -8728 2 2 13 11 4353 5415 5475 -8729 2 2 13 11 4354 5476 5416 -8730 2 2 13 11 4822 6376 5572 -8731 2 2 13 11 5654 5361 6733 -8732 2 2 13 11 4172 4633 5752 -8733 2 2 13 11 4400 5005 5185 -8734 2 2 13 11 3860 5466 5948 -8735 2 2 13 11 4387 4844 5855 -8736 2 2 13 11 3764 6123 5517 -8737 2 2 13 11 154 4695 5668 -8738 2 2 13 11 67 5669 4696 -8739 2 2 13 11 4059 5167 6374 -8740 2 2 13 11 143 5907 4738 -8741 2 2 13 11 4091 5420 4662 -8742 2 2 13 11 3785 5085 5348 -8743 2 2 13 11 3962 5423 5108 -8744 2 2 13 11 4997 6596 5569 -8745 2 2 13 11 4605 5411 6345 -8746 2 2 13 11 4606 6346 5412 -8747 2 2 13 11 4002 5985 4922 -8748 2 2 13 11 4138 5168 5445 -8749 2 2 13 11 4139 5446 5169 -8750 2 2 13 11 3728 5170 6012 -8751 2 2 13 11 3680 5333 4837 -8752 2 2 13 11 3681 4838 5334 -8753 2 2 13 11 4759 6650 5309 -8754 2 2 13 11 4327 6947 6130 -8755 2 2 13 11 4270 4947 5301 -8756 2 2 13 11 3956 4956 6430 -8757 2 2 13 11 4646 6206 5459 -8758 2 2 13 11 4258 4738 5907 -8759 2 2 13 11 134 6660 4962 -8760 2 2 13 11 3875 5148 4961 -8761 2 2 13 11 4092 5921 4682 -8762 2 2 13 11 4505 6430 4956 -8763 2 2 13 11 3781 4698 5696 -8764 2 2 13 11 4124 4848 5319 -8765 2 2 13 11 4089 6613 6900 -8766 2 2 13 11 3820 6117 6590 -8767 2 2 13 11 4264 5835 4816 -8768 2 2 13 11 3804 5536 4933 -8769 2 2 13 11 4775 5924 5260 -8770 2 2 13 11 3660 4755 5950 -8771 2 2 13 11 4438 5317 6035 -8772 2 2 13 11 3805 4934 5537 -8773 2 2 13 11 4209 6034 4665 -8774 2 2 13 11 4439 6036 5318 -8775 2 2 13 11 5361 4416 6733 -8776 2 2 13 11 99 6166 6268 -8777 2 2 13 11 4190 4705 5619 -8778 2 2 13 11 3929 5780 4736 -8779 2 2 13 11 4311 5671 4999 -8780 2 2 13 11 4198 4736 5271 -8781 2 2 13 11 4187 4919 5403 -8782 2 2 13 11 4254 5899 6553 -8783 2 2 13 11 3933 4646 5944 -8784 2 2 13 11 3902 5793 4663 -8785 2 2 13 11 3903 4664 5794 -8786 2 2 13 11 4392 6345 5411 -8787 2 2 13 11 4393 5412 6346 -8788 2 2 13 11 4069 5385 6340 -8789 2 2 13 11 4247 4716 6241 -8790 2 2 13 11 4134 4865 5255 -8791 2 2 13 11 4451 6516 4733 -8792 2 2 13 11 3859 4903 6027 -8793 2 2 13 11 3678 6882 4754 -8794 2 2 13 11 4335 5217 6485 -8795 2 2 13 11 4633 5619 5752 -8796 2 2 13 11 3758 4894 5075 -8797 2 2 13 11 4083 5274 4787 -8798 2 2 13 11 4053 4790 5813 -8799 2 2 13 11 4182 5227 5802 -8800 2 2 13 11 3916 4661 6826 -8801 2 2 13 11 3882 4766 5522 -8802 2 2 13 11 3971 6130 4846 -8803 2 2 13 11 3779 5553 5821 -8804 2 2 13 11 4023 4692 5801 -8805 2 2 13 11 3700 6311 5261 -8806 2 2 13 11 3899 4705 5889 -8807 2 2 13 11 3962 4753 6264 -8808 2 2 13 11 3772 5752 5619 -8809 2 2 13 11 4078 5085 5083 -8810 2 2 13 11 3779 5711 4671 -8811 2 2 13 11 4544 4923 5494 -8812 2 2 13 11 3673 5961 5571 -8813 2 2 13 11 4666 5614 6490 -8814 2 2 13 11 4058 5855 4844 -8815 2 2 13 11 5217 5766 6485 -8816 2 2 13 11 4645 5553 6129 -8817 2 2 13 11 3975 5127 5479 -8818 2 2 13 11 4623 6353 5359 -8819 2 2 13 11 4624 5360 6354 -8820 2 2 13 11 4329 5783 5729 -8821 2 2 13 11 290 4712 5620 -8822 2 2 13 11 3699 5289 5642 -8823 2 2 13 11 4207 5015 6922 -8824 2 2 13 11 3803 5285 4942 -8825 2 2 13 11 4195 5541 4997 -8826 2 2 13 11 4117 5688 5564 -8827 2 2 13 11 4357 4759 6455 -8828 2 2 13 11 3753 5778 4768 -8829 2 2 13 11 4207 6922 6396 -8830 2 2 13 11 3729 4688 5813 -8831 2 2 13 11 4220 5201 5731 -8832 2 2 13 11 4072 6108 5223 -8833 2 2 13 11 4043 5928 5739 -8834 2 2 13 11 3662 4784 6786 -8835 2 2 13 11 3663 6787 4785 -8836 2 2 13 11 4127 5944 4646 -8837 2 2 13 11 3672 5026 6048 -8838 2 2 13 11 77 78 5143 -8839 2 2 13 11 4260 6052 4740 -8840 2 2 13 11 4202 5325 5094 -8841 2 2 13 11 4247 6282 4716 -8842 2 2 13 11 4123 5922 4702 -8843 2 2 13 11 116 117 5287 -8844 2 2 13 11 4449 4905 6449 -8845 2 2 13 11 4075 4718 6616 -8846 2 2 13 11 4177 4794 5430 -8847 2 2 13 11 3804 5205 5006 -8848 2 2 13 11 3805 5007 5206 -8849 2 2 13 11 4165 4637 5949 -8850 2 2 13 11 4419 6451 5275 -8851 2 2 13 11 3742 4840 5854 -8852 2 2 13 11 4659 6906 5806 -8853 2 2 13 11 4649 5322 6944 -8854 2 2 13 11 4650 6945 5323 -8855 2 2 13 11 4166 4647 5630 -8856 2 2 13 11 4167 5631 4648 -8857 2 2 13 11 4670 5632 6609 -8858 2 2 13 11 4401 5037 6003 -8859 2 2 13 11 3812 6156 5295 -8860 2 2 13 11 3813 5296 6157 -8861 2 2 13 11 4130 5444 4693 -8862 2 2 13 11 276 4721 5626 -8863 2 2 13 11 4061 4667 5534 -8864 2 2 13 11 4062 5535 4668 -8865 2 2 13 11 3919 6579 4791 -8866 2 2 13 11 4095 5322 5265 -8867 2 2 13 11 4096 5266 5323 -8868 2 2 13 11 4312 5644 4963 -8869 2 2 13 11 4783 6932 5611 -8870 2 2 13 11 4165 5734 4637 -8871 2 2 13 11 3847 4773 5397 -8872 2 2 13 11 4311 6439 4690 -8873 2 2 13 11 3713 6416 5729 -8874 2 2 13 11 4996 5843 6703 -8875 2 2 13 11 4867 6676 6016 -8876 2 2 13 11 3734 6356 4674 -8877 2 2 13 11 106 4726 5543 -8878 2 2 13 11 4337 5946 5240 -8879 2 2 13 11 3936 5582 4676 -8880 2 2 13 11 3703 4734 5630 -8881 2 2 13 11 3704 5631 4735 -8882 2 2 13 11 3780 5995 5658 -8883 2 2 13 11 3741 4634 5934 -8884 2 2 13 11 5054 6093 5414 -8885 2 2 13 11 4572 5207 5417 -8886 2 2 13 11 4573 5418 5208 -8887 2 2 13 11 4543 5518 6285 -8888 2 2 13 11 4474 6621 4956 -8889 2 2 13 11 3927 4801 5903 -8890 2 2 13 11 3836 5298 5651 -8891 2 2 13 11 3837 5652 5299 -8892 2 2 13 11 4999 5671 6448 -8893 2 2 13 11 4292 5214 5531 -8894 2 2 13 11 3998 4721 6209 -8895 2 2 13 11 3995 4712 6107 -8896 2 2 13 11 3899 5742 4705 -8897 2 2 13 11 4734 6948 5594 -8898 2 2 13 11 4036 5389 4984 -8899 2 2 13 11 4735 5595 6949 -8900 2 2 13 11 125 5695 4777 -8901 2 2 13 11 3680 4837 6009 -8902 2 2 13 11 3681 6010 4838 -8903 2 2 13 11 3920 4792 6557 -8904 2 2 13 11 4425 6248 5375 -8905 2 2 13 11 3841 6139 4708 -8906 2 2 13 11 3750 4824 6554 -8907 2 2 13 11 4392 6453 6752 -8908 2 2 13 11 4393 6753 6454 -8909 2 2 13 11 4298 4909 6079 -8910 2 2 13 11 4299 6080 4910 -8911 2 2 13 11 4146 4674 5488 -8912 2 2 13 11 4509 5843 4996 -8913 2 2 13 11 4431 4778 6327 -8914 2 2 13 11 4432 6328 4779 -8915 2 2 13 11 3727 5788 4642 -8916 2 2 13 11 6060 3924 4695 -8917 2 2 13 11 6061 4696 3925 -8918 2 2 13 11 158 159 5111 -8919 2 2 13 11 62 63 5112 -8920 2 2 13 11 4102 5516 4760 -8921 2 2 13 11 3729 6582 4688 -8922 2 2 13 11 4190 5889 4705 -8923 2 2 13 11 147 6381 4815 -8924 2 2 13 11 4398 5359 6353 -8925 2 2 13 11 4399 6354 5360 -8926 2 2 13 11 4146 6319 4674 -8927 2 2 13 11 4119 4860 5205 -8928 2 2 13 11 4212 5041 5348 -8929 2 2 13 11 3914 6489 5398 -8930 2 2 13 11 4120 5206 4861 -8931 2 2 13 11 4285 5108 5423 -8932 2 2 13 11 3753 6094 5778 -8933 2 2 13 11 4156 5475 5415 -8934 2 2 13 11 4157 5416 5476 -8935 2 2 13 11 3719 5532 4751 -8936 2 2 13 11 3720 4752 5533 -8937 2 2 13 11 3699 6378 6810 -8938 2 2 13 11 4130 4693 5895 -8939 2 2 13 11 4235 5273 4924 -8940 2 2 13 11 4382 5194 6587 -8941 2 2 13 11 3856 5245 6106 -8942 2 2 13 11 3649 5618 4725 -8943 2 2 13 11 3842 5524 4770 -8944 2 2 13 11 4535 6246 6692 -8945 2 2 13 11 3849 5426 6698 -8946 2 2 13 11 3772 5619 4705 -8947 2 2 13 11 3899 4719 5355 -8948 2 2 13 11 4092 4680 5921 -8949 2 2 13 11 6016 6676 3658 -8950 2 2 13 11 4151 5717 5261 -8951 2 2 13 11 3972 4836 6776 -8952 2 2 13 11 4367 6333 4761 -8953 2 2 13 11 5135 5831 6577 -8954 2 2 13 11 4124 5126 5148 -8955 2 2 13 11 3991 4653 6951 -8956 2 2 13 11 4086 4725 5618 -8957 2 2 13 11 4642 6816 6072 -8958 2 2 13 11 4426 6409 5395 -8959 2 2 13 11 5079 6742 5983 -8960 2 2 13 11 4269 5371 5163 -8961 2 2 13 11 5057 6738 6836 -8962 2 2 13 11 4078 5276 5088 -8963 2 2 13 11 3967 6842 4822 -8964 2 2 13 11 4651 5873 5058 -8965 2 2 13 11 3714 5341 6518 -8966 2 2 13 11 3715 6519 5342 -8967 2 2 13 11 4467 6827 5333 -8968 2 2 13 11 4468 5334 6828 -8969 2 2 13 11 4148 5597 4831 -8970 2 2 13 11 4020 6722 4909 -8971 2 2 13 11 4021 4910 6723 -8972 2 2 13 11 3976 6871 4747 -8973 2 2 13 11 3977 4748 6872 -8974 2 2 13 11 3750 6443 4964 -8975 2 2 13 11 3976 6074 4965 -8976 2 2 13 11 3977 4966 6075 -8977 2 2 13 11 4109 5003 5276 -8978 2 2 13 11 4172 5578 5502 -8979 2 2 13 11 4192 6063 5050 -8980 2 2 13 11 4249 6164 4709 -8981 2 2 13 11 4076 6841 4963 -8982 2 2 13 11 4097 4849 5188 -8983 2 2 13 11 4098 5189 4850 -8984 2 2 13 11 4138 4703 5588 -8985 2 2 13 11 4139 5589 4704 -8986 2 2 13 11 4384 6375 4959 -8987 2 2 13 11 3918 4908 6401 -8988 2 2 13 11 4767 5347 6873 -8989 2 2 13 11 4361 4922 5985 -8990 2 2 13 11 3792 4920 5188 -8991 2 2 13 11 3793 5189 4921 -8992 2 2 13 11 4065 4770 6696 -8993 2 2 13 11 3879 6377 6110 -8994 2 2 13 11 5039 6199 6262 -8995 2 2 13 11 4647 5639 4895 -8996 2 2 13 11 4648 4896 5640 -8997 2 2 13 11 3680 6035 4950 -8998 2 2 13 11 3681 4951 6036 -8999 2 2 13 11 4547 5150 6604 -9000 2 2 13 11 4372 6176 5406 -9001 2 2 13 11 4548 6606 5151 -9002 2 2 13 11 4065 5991 4770 -9003 2 2 13 11 4158 5059 5285 -9004 2 2 13 11 4645 5821 5553 -9005 2 2 13 11 162 6327 4778 -9006 2 2 13 11 59 4779 6328 -9007 2 2 13 11 4250 5265 5322 -9008 2 2 13 11 4108 4719 5797 -9009 2 2 13 11 4251 5323 5266 -9010 2 2 13 11 5061 6850 6763 -9011 2 2 13 11 3923 4878 5920 -9012 2 2 13 11 4127 4726 5944 -9013 2 2 13 11 4643 5658 5995 -9014 2 2 13 11 3654 5263 5322 -9015 2 2 13 11 3653 5323 5264 -9016 2 2 13 11 5059 6320 5837 -9017 2 2 13 11 4687 4888 6829 -9018 2 2 13 11 4146 5488 4958 -9019 2 2 13 11 4143 4961 5148 -9020 2 2 13 11 3743 4657 5999 -9021 2 2 13 11 3735 5765 5718 -9022 2 2 13 11 4084 4807 5610 -9023 2 2 13 11 4427 6220 5378 -9024 2 2 13 11 5092 5803 6379 -9025 2 2 13 11 4292 5231 5622 -9026 2 2 13 11 4317 5063 5502 -9027 2 2 13 11 3773 5503 4835 -9028 2 2 13 11 3794 5628 6393 -9029 2 2 13 11 3795 6394 5629 -9030 2 2 13 11 4093 4739 5901 -9031 2 2 13 11 3656 6449 4905 -9032 2 2 13 11 4215 5668 5930 -9033 2 2 13 11 4216 5931 5669 -9034 2 2 13 11 3733 6215 4745 -9035 2 2 13 11 4481 4962 6660 -9036 2 2 13 11 4232 6370 5263 -9037 2 2 13 11 4233 5264 6371 -9038 2 2 13 11 4605 5295 6156 -9039 2 2 13 11 4606 6157 5296 -9040 2 2 13 11 4454 6554 4824 -9041 2 2 13 11 4165 5611 6932 -9042 2 2 13 11 4945 5175 6042 -9043 2 2 13 11 4276 4805 5461 -9044 2 2 13 11 4277 5463 4806 -9045 2 2 13 11 4743 5288 6411 -9046 2 2 13 11 3812 5295 5400 -9047 2 2 13 11 3813 5401 5296 -9048 2 2 13 11 3987 4759 6782 -9049 2 2 13 11 5201 6558 5731 -9050 2 2 13 11 4127 5543 4726 -9051 2 2 13 11 4297 5920 4878 -9052 2 2 13 11 3907 4682 5921 -9053 2 2 13 11 3788 4865 5421 -9054 2 2 13 11 3676 4686 5521 -9055 2 2 13 11 4406 5324 5935 -9056 2 2 13 11 4491 4845 6890 -9057 2 2 13 11 104 4652 5980 -9058 2 2 13 11 3782 5276 5003 -9059 2 2 13 11 4388 5079 5393 -9060 2 2 13 11 4029 5285 5059 -9061 2 2 13 11 6348 4652 104 -9062 2 2 13 11 3929 4736 5891 -9063 2 2 13 11 4391 5765 6067 -9064 2 2 13 11 3759 4670 6412 -9065 2 2 13 11 3785 5162 5083 -9066 2 2 13 11 94 4710 6853 -9067 2 2 13 11 3791 5187 5052 -9068 2 2 13 11 4298 5400 5295 -9069 2 2 13 11 4299 5296 5401 -9070 2 2 13 11 4348 5247 5704 -9071 2 2 13 11 4407 6255 5102 -9072 2 2 13 11 4408 5103 6256 -9073 2 2 13 11 3756 4851 5482 -9074 2 2 13 11 4057 5974 5413 -9075 2 2 13 11 4364 5534 5601 -9076 2 2 13 11 4365 5602 5535 -9077 2 2 13 11 4348 5704 5576 -9078 2 2 13 11 3670 4854 5259 -9079 2 2 13 11 4217 5024 5311 -9080 2 2 13 11 4132 5052 5284 -9081 2 2 13 11 4398 5756 5359 -9082 2 2 13 11 4399 5360 5757 -9083 2 2 13 11 4431 6924 4778 -9084 2 2 13 11 4432 4779 6925 -9085 2 2 13 11 4189 4891 5779 -9086 2 2 13 11 4140 5470 4724 -9087 2 2 13 11 3743 5749 4657 -9088 2 2 13 11 4276 6009 4837 -9089 2 2 13 11 4277 4838 6010 -9090 2 2 13 11 4492 4907 6141 -9091 2 2 13 11 3937 6296 4698 -9092 2 2 13 11 3785 5083 5085 -9093 2 2 13 11 4695 3924 5930 -9094 2 2 13 11 4696 5931 3925 -9095 2 2 13 11 4530 5034 6558 -9096 2 2 13 11 3913 4716 6282 -9097 2 2 13 11 3806 6756 4841 -9098 2 2 13 11 3651 4831 5597 -9099 2 2 13 11 3812 4965 6156 -9100 2 2 13 11 3813 6157 4966 -9101 2 2 13 11 4196 5748 6362 -9102 2 2 13 11 3679 4707 6196 -9103 2 2 13 11 4329 5729 5120 -9104 2 2 13 11 4332 5790 6451 -9105 2 2 13 11 3832 4929 5447 -9106 2 2 13 11 4133 5542 4901 -9107 2 2 13 11 4718 5659 6616 -9108 2 2 13 11 4721 5559 6209 -9109 2 2 13 11 4449 6717 4905 -9110 2 2 13 11 4127 6348 5543 -9111 2 2 13 11 4499 5315 5960 -9112 2 2 13 11 4415 5332 5728 -9113 2 2 13 11 4036 6066 4690 -9114 2 2 13 11 4022 6278 5330 -9115 2 2 13 11 3678 4916 6882 -9116 2 2 13 11 3985 5089 6629 -9117 2 2 13 11 5050 6063 5575 -9118 2 2 13 11 3777 6558 5034 -9119 2 2 13 11 4756 6118 5636 -9120 2 2 13 11 3702 5797 4719 -9121 2 2 13 11 4353 4978 5415 -9122 2 2 13 11 4354 5416 4979 -9123 2 2 13 11 3882 5709 4766 -9124 2 2 13 11 4191 4689 6431 -9125 2 2 13 11 3694 4682 5904 -9126 2 2 13 11 4073 4929 5496 -9127 2 2 13 11 4359 4793 5340 -9128 2 2 13 11 4171 4705 5742 -9129 2 2 13 11 4086 5154 5187 -9130 2 2 13 11 4150 6788 4724 -9131 2 2 13 11 4106 5331 6047 -9132 2 2 13 11 4379 6065 4776 -9133 2 2 13 11 4514 6837 5134 -9134 2 2 13 11 4330 5314 5544 -9135 2 2 13 11 4134 5421 4865 -9136 2 2 13 11 4193 5146 6344 -9137 2 2 13 11 4048 6035 5317 -9138 2 2 13 11 4049 5318 6036 -9139 2 2 13 11 4189 6128 4891 -9140 2 2 13 11 3922 4687 6801 -9141 2 2 13 11 3992 5271 4872 -9142 2 2 13 11 161 4778 5583 -9143 2 2 13 11 60 5584 4779 -9144 2 2 13 11 3848 5014 5351 -9145 2 2 13 11 4744 5883 6177 -9146 2 2 13 11 88 89 5167 -9147 2 2 13 11 4249 4709 5785 -9148 2 2 13 11 4202 5667 4743 -9149 2 2 13 11 76 5883 4744 -9150 2 2 13 11 3911 5461 4805 -9151 2 2 13 11 4612 5984 6015 -9152 2 2 13 11 3912 4806 5463 -9153 2 2 13 11 3906 4666 6490 -9154 2 2 13 11 3678 4822 6746 -9155 2 2 13 11 4166 5630 4734 -9156 2 2 13 11 4167 4735 5631 -9157 2 2 13 11 330 5686 4972 -9158 2 2 13 11 246 4973 5687 -9159 2 2 13 11 3773 5855 5080 -9160 2 2 13 11 4524 5057 6836 -9161 2 2 13 11 3796 5454 5081 -9162 2 2 13 11 4731 5686 6481 -9163 2 2 13 11 4732 6482 5687 -9164 2 2 13 11 3897 6642 5417 -9165 2 2 13 11 4227 5346 4906 -9166 2 2 13 11 3898 5418 6643 -9167 2 2 13 11 4837 5333 6827 -9168 2 2 13 11 4838 6828 5334 -9169 2 2 13 11 128 6024 5468 -9170 2 2 13 11 3707 5945 5312 -9171 2 2 13 11 3886 6187 5754 -9172 2 2 13 11 3887 5755 6188 -9173 2 2 13 11 4170 5544 5314 -9174 2 2 13 11 3836 5102 6478 -9175 2 2 13 11 3837 6479 5103 -9176 2 2 13 11 5102 6878 6478 -9177 2 2 13 11 4111 4815 6381 -9178 2 2 13 11 5103 6479 6879 -9179 2 2 13 11 4164 5732 4968 -9180 2 2 13 11 4118 5394 4811 -9181 2 2 13 11 5227 6117 5802 -9182 2 2 13 11 4989 5540 6813 -9183 2 2 13 11 3821 5340 4947 -9184 2 2 13 11 3907 5921 4680 -9185 2 2 13 11 4089 6900 5356 -9186 2 2 13 11 4100 5890 4717 -9187 2 2 13 11 4529 6850 5061 -9188 2 2 13 11 141 142 5146 -9189 2 2 13 11 293 5043 294 -9190 2 2 13 11 4097 5188 4920 -9191 2 2 13 11 4098 4921 5189 -9192 2 2 13 11 4436 6684 5946 -9193 2 2 13 11 3680 4950 5333 -9194 2 2 13 11 3825 6502 5196 -9195 2 2 13 11 3681 5334 4951 -9196 2 2 13 11 4140 5277 5090 -9197 2 2 13 11 4395 6024 6171 -9198 2 2 13 11 4580 6745 5255 -9199 2 2 13 11 4309 5883 5143 -9200 2 2 13 11 3779 4671 6893 -9201 2 2 13 11 3686 5209 5502 -9202 2 2 13 11 4065 6696 4853 -9203 2 2 13 11 4161 4842 5583 -9204 2 2 13 11 4162 5584 4843 -9205 2 2 13 11 3760 6432 5065 -9206 2 2 13 11 3818 5118 5444 -9207 2 2 13 11 4364 6948 4734 -9208 2 2 13 11 4365 4735 6949 -9209 2 2 13 11 4161 5583 4778 -9210 2 2 13 11 4162 4779 5584 -9211 2 2 13 11 4745 5802 5022 -9212 2 2 13 11 4135 4751 5532 -9213 2 2 13 11 4201 5234 6680 -9214 2 2 13 11 4136 5533 4752 -9215 2 2 13 11 4232 5970 6370 -9216 2 2 13 11 6813 5540 4446 -9217 2 2 13 11 4233 6371 5971 -9218 2 2 13 11 4651 5195 6181 -9219 2 2 13 11 291 5620 4793 -9220 2 2 13 11 3764 4864 5278 -9221 2 2 13 11 4142 6190 5606 -9222 2 2 13 11 279 5048 280 -9223 2 2 13 11 4370 5307 6112 -9224 2 2 13 11 4273 6051 5221 -9225 2 2 13 11 3783 5163 5371 -9226 2 2 13 11 4654 6362 5748 -9227 2 2 13 11 4143 5148 5126 -9228 2 2 13 11 335 5055 336 -9229 2 2 13 11 240 5056 241 -9230 2 2 13 11 3810 4737 6033 -9231 2 2 13 11 4103 6209 5559 -9232 2 2 13 11 3783 5371 6881 -9233 2 2 13 11 4307 4972 5457 -9234 2 2 13 11 4308 5458 4973 -9235 2 2 13 11 3825 5610 6502 -9236 2 2 13 11 4201 6680 5903 -9237 2 2 13 11 3680 6298 6035 -9238 2 2 13 11 3681 6036 6299 -9239 2 2 13 11 4015 5199 4917 -9240 2 2 13 11 4043 5739 4799 -9241 2 2 13 11 4304 6048 6274 -9242 2 2 13 11 4016 4918 5200 -9243 2 2 13 11 4338 5467 5180 -9244 2 2 13 11 4014 6739 5287 -9245 2 2 13 11 277 5626 4797 -9246 2 2 13 11 4107 6794 5043 -9247 2 2 13 11 4250 5758 5692 -9248 2 2 13 11 4522 5417 6100 -9249 2 2 13 11 3753 4768 6851 -9250 2 2 13 11 4251 5694 5759 -9251 2 2 13 11 4523 6102 5418 -9252 2 2 13 11 4454 4824 6776 -9253 2 2 13 11 3803 6169 4780 -9254 2 2 13 11 4280 5359 5411 -9255 2 2 13 11 4281 5412 5360 -9256 2 2 13 11 144 145 5455 -9257 2 2 13 11 3730 5450 5603 -9258 2 2 13 11 4193 6344 5766 -9259 2 2 13 11 4575 5715 6571 -9260 2 2 13 11 3941 5647 5366 -9261 2 2 13 11 3942 5367 5648 -9262 2 2 13 11 4004 4916 5273 -9263 2 2 13 11 4027 6560 4758 -9264 2 2 13 11 148 149 5268 -9265 2 2 13 11 4198 6641 5695 -9266 2 2 13 11 3986 6573 5060 -9267 2 2 13 11 3723 5871 4787 -9268 2 2 13 11 4292 5531 5231 -9269 2 2 13 11 3842 4770 5991 -9270 2 2 13 11 4280 5411 6156 -9271 2 2 13 11 4281 6157 5412 -9272 2 2 13 11 4030 5090 5277 -9273 2 2 13 11 3892 5832 6534 -9274 2 2 13 11 3893 6535 5833 -9275 2 2 13 11 4111 4774 6222 -9276 2 2 13 11 4703 4731 6091 -9277 2 2 13 11 4704 6092 4732 -9278 2 2 13 11 4090 6107 4712 -9279 2 2 13 11 4063 6100 5417 -9280 2 2 13 11 4064 5418 6102 -9281 2 2 13 11 4250 5322 5263 -9282 2 2 13 11 4251 5264 5323 -9283 2 2 13 11 4185 4692 5963 -9284 2 2 13 11 4137 5393 5079 -9285 2 2 13 11 4579 5139 6728 -9286 2 2 13 11 4667 5754 6187 -9287 2 2 13 11 4668 6188 5755 -9288 2 2 13 11 307 4830 5622 -9289 2 2 13 11 4169 5231 5531 -9290 2 2 13 11 3650 4899 5229 -9291 2 2 13 11 4637 6555 6323 -9292 2 2 13 11 4458 6640 6724 -9293 2 2 13 11 4378 4683 5972 -9294 2 2 13 11 3770 5042 5357 -9295 2 2 13 11 160 5583 4842 -9296 2 2 13 11 61 4843 5584 -9297 2 2 13 11 164 4909 5369 -9298 2 2 13 11 57 5370 4910 -9299 2 2 13 11 3907 5908 4682 -9300 2 2 13 11 4374 5628 5634 -9301 2 2 13 11 4375 5635 5629 -9302 2 2 13 11 4010 4958 5488 -9303 2 2 13 11 4108 5797 4681 -9304 2 2 13 11 5611 6735 3784 -9305 2 2 13 11 3699 6810 5289 -9306 2 2 13 11 4623 5359 6074 -9307 2 2 13 11 4624 6075 5360 -9308 2 2 13 11 4029 4942 5285 -9309 2 2 13 11 4661 5876 6337 -9310 2 2 13 11 3967 5819 4768 -9311 2 2 13 11 6178 6792 3703 -9312 2 2 13 11 3780 5480 4863 -9313 2 2 13 11 6179 3704 6793 -9314 2 2 13 11 4212 6349 5845 -9315 2 2 13 11 3755 5817 4715 -9316 2 2 13 11 4172 5752 4711 -9317 2 2 13 11 4621 5004 5854 -9318 2 2 13 11 4385 5317 5585 -9319 2 2 13 11 4386 5586 5318 -9320 2 2 13 11 106 6542 4726 -9321 2 2 13 11 4086 5454 5154 -9322 2 2 13 11 4529 5892 5023 -9323 2 2 13 11 4485 5644 5552 -9324 2 2 13 11 4004 6511 4916 -9325 2 2 13 11 4777 5695 6641 -9326 2 2 13 11 4081 4917 5199 -9327 2 2 13 11 4082 5200 4918 -9328 2 2 13 11 3936 4787 5582 -9329 2 2 13 11 3714 4722 5862 -9330 2 2 13 11 3715 5863 4723 -9331 2 2 13 11 4008 5926 5166 -9332 2 2 13 11 3665 5721 4958 -9333 2 2 13 11 3701 4762 5563 -9334 2 2 13 11 3906 4803 5523 -9335 2 2 13 11 3937 4729 6145 -9336 2 2 13 11 3722 5552 5644 -9337 2 2 13 11 4428 6213 6715 -9338 2 2 13 11 4960 6682 6727 -9339 2 2 13 11 4083 4787 6021 -9340 2 2 13 11 4625 5413 5974 -9341 2 2 13 11 3974 6072 6816 -9342 2 2 13 11 4832 6286 5149 -9343 2 2 13 11 3984 4894 5319 -9344 2 2 13 11 4098 4946 5279 -9345 2 2 13 11 4150 4724 6711 -9346 2 2 13 11 4725 6284 5001 -9347 2 2 13 11 3874 6272 5238 -9348 2 2 13 11 3876 5239 6273 -9349 2 2 13 11 3742 5549 4798 -9350 2 2 13 11 5221 6051 6232 -9351 2 2 13 11 4191 6047 4689 -9352 2 2 13 11 4496 5004 6782 -9353 2 2 13 11 4407 4911 6520 -9354 2 2 13 11 4408 6521 4912 -9355 2 2 13 11 4006 6222 4774 -9356 2 2 13 11 4231 4942 5197 -9357 2 2 13 11 4658 5254 6841 -9358 2 2 13 11 4441 6272 4784 -9359 2 2 13 11 4442 4785 6273 -9360 2 2 13 11 4094 6941 4851 -9361 2 2 13 11 69 5708 4850 -9362 2 2 13 11 4404 6703 5843 -9363 2 2 13 11 4199 5858 4694 -9364 2 2 13 11 4427 6682 4960 -9365 2 2 13 11 3921 6344 4738 -9366 2 2 13 11 3742 5854 5004 -9367 2 2 13 11 4909 6722 5369 -9368 2 2 13 11 4910 5370 6723 -9369 2 2 13 11 4605 6156 5411 -9370 2 2 13 11 4606 5412 6157 -9371 2 2 13 11 3677 4758 6267 -9372 2 2 13 11 4025 4768 5778 -9373 2 2 13 11 4615 5988 5978 -9374 2 2 13 11 4415 5728 6464 -9375 2 2 13 11 3865 4952 6232 -9376 2 2 13 11 4280 6074 5359 -9377 2 2 13 11 4720 6171 5380 -9378 2 2 13 11 4281 5360 6075 -9379 2 2 13 11 5261 5717 6361 -9380 2 2 13 11 4400 4908 6406 -9381 2 2 13 11 4470 5303 6135 -9382 2 2 13 11 4198 5891 4736 -9383 2 2 13 11 4536 5739 5928 -9384 2 2 13 11 3664 6597 4848 -9385 2 2 13 11 3719 5415 4978 -9386 2 2 13 11 3720 4979 5416 -9387 2 2 13 11 4035 6700 4858 -9388 2 2 13 11 4435 4848 6597 -9389 2 2 13 11 3733 4774 5714 -9390 2 2 13 11 3694 5779 4891 -9391 2 2 13 11 4103 5466 4940 -9392 2 2 13 11 313 5097 314 -9393 2 2 13 11 262 5098 263 -9394 2 2 13 11 166 167 5077 -9395 2 2 13 11 54 55 5078 -9396 2 2 13 11 3970 5655 4780 -9397 2 2 13 11 4128 5852 4771 -9398 2 2 13 11 4129 4772 5853 -9399 2 2 13 11 4344 5958 5084 -9400 2 2 13 11 3783 6881 5703 -9401 2 2 13 11 306 6014 4830 -9402 2 2 13 11 4487 4913 6777 -9403 2 2 13 11 3881 6461 5152 -9404 2 2 13 11 4520 5312 5945 -9405 2 2 13 11 321 5363 6056 -9406 2 2 13 11 255 6057 5364 -9407 2 2 13 11 3911 4771 5852 -9408 2 2 13 11 3912 5853 4772 -9409 2 2 13 11 3727 4804 5508 -9410 2 2 13 11 4044 5235 5006 -9411 2 2 13 11 4199 4694 5744 -9412 2 2 13 11 4045 5007 5236 -9413 2 2 13 11 4718 4988 5786 -9414 2 2 13 11 3926 6126 4739 -9415 2 2 13 11 3840 5659 4718 -9416 2 2 13 11 4209 4903 5275 -9417 2 2 13 11 3676 5485 5050 -9418 2 2 13 11 4099 5508 4804 -9419 2 2 13 11 3816 5475 6353 -9420 2 2 13 11 3817 6354 5476 -9421 2 2 13 11 3920 4717 5890 -9422 2 2 13 11 3866 5084 5958 -9423 2 2 13 11 4007 4761 5592 -9424 2 2 13 11 3954 6836 6738 -9425 2 2 13 11 5121 6143 6308 -9426 2 2 13 11 4321 5564 5688 -9427 2 2 13 11 3695 5359 5756 -9428 2 2 13 11 3900 6015 5984 -9429 2 2 13 11 3696 5757 5360 -9430 2 2 13 11 4150 5187 5154 -9431 2 2 13 11 3948 6484 4746 -9432 2 2 13 11 4478 6746 4822 -9433 2 2 13 11 3932 6466 4789 -9434 2 2 13 11 3901 5572 4754 -9435 2 2 13 11 3659 5185 5005 -9436 2 2 13 11 4161 4778 5897 -9437 2 2 13 11 4162 5898 4779 -9438 2 2 13 11 4097 5304 4982 -9439 2 2 13 11 4074 4880 5469 -9440 2 2 13 11 4433 5366 5647 -9441 2 2 13 11 4384 5279 4946 -9442 2 2 13 11 4434 5648 5367 -9443 2 2 13 11 4150 5052 5187 -9444 2 2 13 11 4027 5241 5745 -9445 2 2 13 11 4276 6358 4805 -9446 2 2 13 11 4627 5975 5554 -9447 2 2 13 11 4053 6286 5915 -9448 2 2 13 11 4628 5555 5976 -9449 2 2 13 11 4277 4806 6359 -9450 2 2 13 11 4237 5864 5055 -9451 2 2 13 11 4238 5056 5865 -9452 2 2 13 11 4156 4751 5955 -9453 2 2 13 11 4157 5956 4752 -9454 2 2 13 11 4569 6052 5563 -9455 2 2 13 11 3691 4901 5542 -9456 2 2 13 11 4213 6332 6175 -9457 2 2 13 11 4260 5563 6052 -9458 2 2 13 11 6833 4125 5483 -9459 2 2 13 11 4811 5287 6739 -9460 2 2 13 11 4594 5330 6278 -9461 2 2 13 11 4184 4766 5709 -9462 2 2 13 11 4073 6639 4824 -9463 2 2 13 11 150 4982 6350 -9464 2 2 13 11 4141 6185 5770 -9465 2 2 13 11 3927 5903 4714 -9466 2 2 13 11 4586 5152 6461 -9467 2 2 13 11 3784 6735 5325 -9468 2 2 13 11 4260 4740 6082 -9469 2 2 13 11 323 4897 5404 -9470 2 2 13 11 253 5405 4898 -9471 2 2 13 11 3662 6786 5719 -9472 2 2 13 11 3663 5720 6787 -9473 2 2 13 11 4460 5218 6184 -9474 2 2 13 11 3664 4848 5448 -9475 2 2 13 11 4054 5407 6242 -9476 2 2 13 11 6670 6260 3947 -9477 2 2 13 11 4184 5973 4766 -9478 2 2 13 11 3972 6776 4824 -9479 2 2 13 11 3797 5035 6114 -9480 2 2 13 11 3798 6115 5036 -9481 2 2 13 11 4627 6096 5975 -9482 2 2 13 11 4628 5976 6097 -9483 2 2 13 11 274 5156 5559 -9484 2 2 13 11 3771 5538 4802 -9485 2 2 13 11 4497 6779 4796 -9486 2 2 13 11 4113 4816 5681 -9487 2 2 13 11 4169 5700 5231 -9488 2 2 13 11 4125 5310 5048 -9489 2 2 13 11 3987 5065 6259 -9490 2 2 13 11 3735 5718 4931 -9491 2 2 13 11 4293 4863 5480 -9492 2 2 13 11 4200 6122 5091 -9493 2 2 13 11 4781 5922 5706 -9494 2 2 13 11 4192 5050 5485 -9495 2 2 13 11 4222 5335 5190 -9496 2 2 13 11 5109 5964 6734 -9497 2 2 13 11 3752 5244 4913 -9498 2 2 13 11 4015 4917 6372 -9499 2 2 13 11 4092 4891 5358 -9500 2 2 13 11 3754 5469 4880 -9501 2 2 13 11 4016 6373 4918 -9502 2 2 13 11 3700 4906 5346 -9503 2 2 13 11 4519 4798 6783 -9504 2 2 13 11 3728 5451 6450 -9505 2 2 13 11 4228 5229 4983 -9506 2 2 13 11 3677 5255 6745 -9507 2 2 13 11 4574 6683 5665 -9508 2 2 13 11 4903 6790 6027 -9509 2 2 13 11 4729 5892 3709 -9510 2 2 13 11 4152 5512 5726 -9511 2 2 13 11 85 6538 5288 -9512 2 2 13 11 4227 4906 5987 -9513 2 2 13 11 4107 5419 6881 -9514 2 2 13 11 3948 5702 5579 -9515 2 2 13 11 3695 5411 5359 -9516 2 2 13 11 4123 5706 5922 -9517 2 2 13 11 3696 5360 5412 -9518 2 2 13 11 3717 6228 6201 -9519 2 2 13 11 3957 6763 6850 -9520 2 2 13 11 4357 6455 5067 -9521 2 2 13 11 3697 4746 6901 -9522 2 2 13 11 297 5286 4949 -9523 2 2 13 11 4095 5265 5431 -9524 2 2 13 11 4096 5432 5266 -9525 2 2 13 11 103 5980 6340 -9526 2 2 13 11 4198 4730 5891 -9527 2 2 13 11 4631 5523 6336 -9528 2 2 13 11 4403 4985 6690 -9529 2 2 13 11 73 5386 4959 -9530 2 2 13 11 4316 6008 5568 -9531 2 2 13 11 4097 5777 4849 -9532 2 2 13 11 3769 4791 5428 -9533 2 2 13 11 3770 5429 4792 -9534 2 2 13 11 3882 4823 6405 -9535 2 2 13 11 4907 6260 6670 -9536 2 2 13 11 4600 5568 6008 -9537 2 2 13 11 4101 5599 4889 -9538 2 2 13 11 4558 6946 5941 -9539 2 2 13 11 4070 6303 5129 -9540 2 2 13 11 4118 4811 6739 -9541 2 2 13 11 4071 5130 6304 -9542 2 2 13 11 3651 4981 5882 -9543 2 2 13 11 3678 6376 4822 -9544 2 2 13 11 4022 5330 4985 -9545 2 2 13 11 3756 5482 4795 -9546 2 2 13 11 78 5373 5143 -9547 2 2 13 11 4102 4807 6136 -9548 2 2 13 11 3911 6070 4771 -9549 2 2 13 11 156 157 5486 -9550 2 2 13 11 64 65 5487 -9551 2 2 13 11 3912 4772 6071 -9552 2 2 13 11 4232 5210 5536 -9553 2 2 13 11 4233 5537 5211 -9554 2 2 13 11 4234 4781 6089 -9555 2 2 13 11 4083 6483 4865 -9556 2 2 13 11 4380 6232 4952 -9557 2 2 13 11 3724 6337 5876 -9558 2 2 13 11 4182 4745 6215 -9559 2 2 13 11 4330 5544 5124 -9560 2 2 13 11 4179 6420 4782 -9561 2 2 13 11 3902 5684 4722 -9562 2 2 13 11 3903 4723 5685 -9563 2 2 13 11 3677 6745 5241 -9564 2 2 13 11 4568 5845 6349 -9565 2 2 13 11 4081 6194 4917 -9566 2 2 13 11 4082 4918 6195 -9567 2 2 13 11 6792 5141 3703 -9568 2 2 13 11 6793 3704 5142 -9569 2 2 13 11 4231 4780 6169 -9570 2 2 13 11 4236 5928 4995 -9571 2 2 13 11 3666 6520 4911 -9572 2 2 13 11 3667 4912 6521 -9573 2 2 13 11 4026 5924 4775 -9574 2 2 13 11 3731 5489 4860 -9575 2 2 13 11 115 4811 5394 -9576 2 2 13 11 3891 6184 5218 -9577 2 2 13 11 4197 4900 5305 -9578 2 2 13 11 3732 4861 5490 -9579 2 2 13 11 4911 6288 5207 -9580 2 2 13 11 4912 5208 6289 -9581 2 2 13 11 3985 6629 4880 -9582 2 2 13 11 4581 5778 6094 -9583 2 2 13 11 152 4849 5777 -9584 2 2 13 11 6688 4501 5587 -9585 2 2 13 11 4050 5333 4950 -9586 2 2 13 11 4051 4951 5334 -9587 2 2 13 11 4895 6210 5930 -9588 2 2 13 11 4896 5931 6211 -9589 2 2 13 11 4302 6109 5376 -9590 2 2 13 11 4326 6405 4823 -9591 2 2 13 11 4303 5377 6111 -9592 2 2 13 11 3840 4718 5786 -9593 2 2 13 11 4234 6206 4781 -9594 2 2 13 11 3860 4940 5466 -9595 2 2 13 11 4085 5016 5374 -9596 2 2 13 11 4445 5196 6363 -9597 2 2 13 11 320 5363 321 -9598 2 2 13 11 255 5364 256 -9599 2 2 13 11 4141 5770 5192 -9600 2 2 13 11 4357 5067 5799 -9601 2 2 13 11 4095 6944 5322 -9602 2 2 13 11 4096 5323 6945 -9603 2 2 13 11 6842 4478 4822 -9604 2 2 13 11 4874 5173 6030 -9605 2 2 13 11 4875 6031 5174 -9606 2 2 13 11 4500 5851 5254 -9607 2 2 13 11 3830 5585 5317 -9608 2 2 13 11 3768 6693 4808 -9609 2 2 13 11 3831 5318 5586 -9610 2 2 13 11 3920 6456 4717 -9611 2 2 13 11 4282 6576 4826 -9612 2 2 13 11 4107 5116 6794 -9613 2 2 13 11 3833 5368 5808 -9614 2 2 13 11 3999 5675 4817 -9615 2 2 13 11 4829 6688 5587 -9616 2 2 13 11 4505 6268 6166 -9617 2 2 13 11 4000 4818 5676 -9618 2 2 13 11 3938 4744 6177 -9619 2 2 13 11 3907 4859 5908 -9620 2 2 13 11 3674 5895 5798 -9621 2 2 13 11 4204 5554 5975 -9622 2 2 13 11 4205 5976 5555 -9623 2 2 13 11 3751 6089 4781 -9624 2 2 13 11 3899 5889 4719 -9625 2 2 13 11 4588 6242 5407 -9626 2 2 13 11 3851 6650 5240 -9627 2 2 13 11 3981 6571 5715 -9628 2 2 13 11 4561 5038 5771 -9629 2 2 13 11 3846 5395 5838 -9630 2 2 13 11 85 86 6538 -9631 2 2 13 11 4153 6673 5372 -9632 2 2 13 11 3769 5812 5029 -9633 2 2 13 11 4046 6811 6614 -9634 2 2 13 11 4047 6615 6812 -9635 2 2 13 11 4346 5069 5242 -9636 2 2 13 11 3853 5379 5733 -9637 2 2 13 11 3746 6300 4926 -9638 2 2 13 11 3747 4927 6301 -9639 2 2 13 11 4717 6450 5451 -9640 2 2 13 11 3749 4801 5501 -9641 2 2 13 11 3768 4808 5656 -9642 2 2 13 11 4098 4850 5708 -9643 2 2 13 11 3905 5844 5120 -9644 2 2 13 11 3872 4826 5600 -9645 2 2 13 11 94 95 5383 -9646 2 2 13 11 3905 5978 5988 -9647 2 2 13 11 4351 5424 5113 -9648 2 2 13 11 4052 5935 5324 -9649 2 2 13 11 4352 5114 5425 -9650 2 2 13 11 3888 6116 6039 -9651 2 2 13 11 3966 5925 4808 -9652 2 2 13 11 5475 6476 6353 -9653 2 2 13 11 5476 6354 6477 -9654 2 2 13 11 4111 6222 4815 -9655 2 2 13 11 4346 5109 6734 -9656 2 2 13 11 3799 5292 5493 -9657 2 2 13 11 4099 4819 5869 -9658 2 2 13 11 4177 5365 6295 -9659 2 2 13 11 4100 5870 4820 -9660 2 2 13 11 4872 5705 6472 -9661 2 2 13 11 4194 5805 5937 -9662 2 2 13 11 4570 5241 6745 -9663 2 2 13 11 4532 6765 5859 -9664 2 2 13 11 3976 4965 6871 -9665 2 2 13 11 3977 6872 4966 -9666 2 2 13 11 3971 5393 4977 -9667 2 2 13 11 3802 6841 5254 -9668 2 2 13 11 4063 6288 5313 -9669 2 2 13 11 4064 5316 6289 -9670 2 2 13 11 4773 4994 6543 -9671 2 2 13 11 4055 4926 5352 -9672 2 2 13 11 4056 5353 4927 -9673 2 2 13 11 4997 5541 6936 -9674 2 2 13 11 4967 6833 5483 -9675 2 2 13 11 4131 4767 5715 -9676 2 2 13 11 4020 6770 5295 -9677 2 2 13 11 4021 5296 6771 -9678 2 2 13 11 4070 4938 5509 -9679 2 2 13 11 4071 5510 4939 -9680 2 2 13 11 4061 4892 5754 -9681 2 2 13 11 4062 5755 4893 -9682 2 2 13 11 3662 4809 6368 -9683 2 2 13 11 3663 6369 4810 -9684 2 2 13 11 4293 6308 6143 -9685 2 2 13 11 3771 4802 6952 -9686 2 2 13 11 3910 5506 5243 -9687 2 2 13 11 4589 5733 5379 -9688 2 2 13 11 6400 4729 3709 -9689 2 2 13 11 4185 4954 5361 -9690 2 2 13 11 4285 5493 5292 -9691 2 2 13 11 3794 6393 5431 -9692 2 2 13 11 3795 5432 6394 -9693 2 2 13 11 3981 5715 4767 -9694 2 2 13 11 3751 4781 5706 -9695 2 2 13 11 4253 6296 5140 -9696 2 2 13 11 3983 6561 6248 -9697 2 2 13 11 4008 6806 5926 -9698 2 2 13 11 99 100 6166 -9699 2 2 13 11 4214 6676 4867 -9700 2 2 13 11 4186 6896 4775 -9701 2 2 13 11 4380 5726 5512 -9702 2 2 13 11 4501 6629 5089 -9703 2 2 13 11 3767 4852 5915 -9704 2 2 13 11 4037 5645 6617 -9705 2 2 13 11 4038 6618 5646 -9706 2 2 13 11 4150 5284 5052 -9707 2 2 13 11 3678 4754 6376 -9708 2 2 13 11 4215 4849 6664 -9709 2 2 13 11 4216 6665 4850 -9710 2 2 13 11 4009 6607 5095 -9711 2 2 13 11 4094 4937 6941 -9712 2 2 13 11 3881 5681 4816 -9713 2 2 13 11 3913 6041 4716 -9714 2 2 13 11 4282 4789 6768 -9715 2 2 13 11 3742 6536 4840 -9716 2 2 13 11 4302 5109 5489 -9717 2 2 13 11 4303 5490 5110 -9718 2 2 13 11 4249 6728 5139 -9719 2 2 13 11 4665 5184 5768 -9720 2 2 13 11 274 5559 275 -9721 2 2 13 11 4340 4911 5651 -9722 2 2 13 11 4447 5808 5368 -9723 2 2 13 11 3727 6262 4804 -9724 2 2 13 11 4341 5652 4912 -9725 2 2 13 11 4686 5937 5805 -9726 2 2 13 11 3799 5396 6833 -9727 2 2 13 11 4329 5120 5844 -9728 2 2 13 11 4919 6881 5419 -9729 2 2 13 11 4332 6451 5481 -9730 2 2 13 11 3899 4769 5742 -9731 2 2 13 11 3947 6260 4862 -9732 2 2 13 11 3953 5987 4906 -9733 2 2 13 11 3725 5247 6280 -9734 2 2 13 11 5249 6844 6145 -9735 2 2 13 11 4074 5321 4928 -9736 2 2 13 11 4297 6401 4908 -9737 2 2 13 11 3938 6177 4864 -9738 2 2 13 11 4455 6278 5386 -9739 2 2 13 11 4099 5857 4819 -9740 2 2 13 11 147 148 6381 -9741 2 2 13 11 4524 6836 4833 -9742 2 2 13 11 4193 5217 5402 -9743 2 2 13 11 4059 6165 4798 -9744 2 2 13 11 4518 5372 6537 -9745 2 2 13 11 4612 6015 4943 -9746 2 2 13 11 4473 4877 6764 -9747 2 2 13 11 4100 4820 5890 -9748 2 2 13 11 3789 5712 4813 -9749 2 2 13 11 3790 4814 5713 -9750 2 2 13 11 3821 4919 5419 -9751 2 2 13 11 4963 5644 6436 -9752 2 2 13 11 4501 6688 6629 -9753 2 2 13 11 4497 5632 6951 -9754 2 2 13 11 3654 5045 5210 -9755 2 2 13 11 3679 4769 6069 -9756 2 2 13 11 145 6324 5455 -9757 2 2 13 11 3653 5211 5046 -9758 2 2 13 11 3936 6021 4787 -9759 2 2 13 11 4215 6210 5188 -9760 2 2 13 11 4216 5189 6211 -9761 2 2 13 11 4126 4925 5390 -9762 2 2 13 11 4105 5093 5272 -9763 2 2 13 11 322 6056 4897 -9764 2 2 13 11 254 4898 6057 -9765 2 2 13 11 4041 5251 4990 -9766 2 2 13 11 4042 4991 5252 -9767 2 2 13 11 3782 5088 5276 -9768 2 2 13 11 3756 5462 4851 -9769 2 2 13 11 4884 5452 6236 -9770 2 2 13 11 4885 6237 5453 -9771 2 2 13 11 3806 5689 5155 -9772 2 2 13 11 4391 5718 5765 -9773 2 2 13 11 3824 4821 6285 -9774 2 2 13 11 4075 6894 4988 -9775 2 2 13 11 3983 6710 4886 -9776 2 2 13 11 4179 4782 6705 -9777 2 2 13 11 4203 5908 4859 -9778 2 2 13 11 3962 6264 4971 -9779 2 2 13 11 4309 6177 5883 -9780 2 2 13 11 3841 5516 6139 -9781 2 2 13 11 4259 5030 5402 -9782 2 2 13 11 4101 4948 5599 -9783 2 2 13 11 4632 6198 5117 -9784 2 2 13 11 4282 5680 4789 -9785 2 2 13 11 4644 6820 6221 -9786 2 2 13 11 4784 5690 6678 -9787 2 2 13 11 4785 6679 5691 -9788 2 2 13 11 4215 5930 6210 -9789 2 2 13 11 4216 6211 5931 -9790 2 2 13 11 4413 5716 6280 -9791 2 2 13 11 71 6375 4946 -9792 2 2 13 11 4423 4982 5304 -9793 2 2 13 11 4385 5212 6028 -9794 2 2 13 11 4386 6029 5213 -9795 2 2 13 11 4532 5859 5215 -9796 2 2 13 11 4533 5216 5860 -9797 2 2 13 11 4135 5690 4751 -9798 2 2 13 11 4136 4752 5691 -9799 2 2 13 11 3660 6127 4755 -9800 2 2 13 11 4537 5579 5702 -9801 2 2 13 11 3826 4953 5497 -9802 2 2 13 11 4320 5513 5952 -9803 2 2 13 11 3773 6585 5855 -9804 2 2 13 11 4298 6079 5077 -9805 2 2 13 11 4299 5078 6080 -9806 2 2 13 11 4587 6309 5824 -9807 2 2 13 11 4119 6182 4860 -9808 2 2 13 11 4120 4861 6183 -9809 2 2 13 11 3923 4796 6342 -9810 2 2 13 11 4094 4851 5462 -9811 2 2 13 11 4225 4884 6236 -9812 2 2 13 11 4226 6237 4885 -9813 2 2 13 11 3679 6059 4769 -9814 2 2 13 11 3943 5384 5038 -9815 2 2 13 11 3972 4824 6639 -9816 2 2 13 11 4294 6262 6199 -9817 2 2 13 11 4470 5716 6691 -9818 2 2 13 11 4013 4829 6600 -9819 2 2 13 11 4234 4871 5459 -9820 2 2 13 11 4084 5610 5015 -9821 2 2 13 11 4115 5945 4862 -9822 2 2 13 11 4098 5708 4946 -9823 2 2 13 11 3933 5922 4781 -9824 2 2 13 11 4053 5813 5149 -9825 2 2 13 11 3941 5975 6096 -9826 2 2 13 11 3942 6097 5976 -9827 2 2 13 11 4259 6011 5030 -9828 2 2 13 11 3774 6160 4825 -9829 2 2 13 11 4345 5249 6145 -9830 2 2 13 11 4031 6205 4839 -9831 2 2 13 11 5215 5859 6457 -9832 2 2 13 11 5216 6458 5860 -9833 2 2 13 11 3987 6259 4759 -9834 2 2 13 11 4458 6330 5792 -9835 2 2 13 11 4124 5448 4848 -9836 2 2 13 11 4037 5536 5210 -9837 2 2 13 11 4038 5211 5537 -9838 2 2 13 11 4134 6953 5600 -9839 2 2 13 11 3788 6768 5302 -9840 2 2 13 11 4014 6543 4994 -9841 2 2 13 11 4645 6858 6699 -9842 2 2 13 11 3783 6181 5163 -9843 2 2 13 11 3991 5632 4870 -9844 2 2 13 11 4007 6351 4761 -9845 2 2 13 11 3932 4871 5888 -9846 2 2 13 11 4270 5301 5905 -9847 2 2 13 11 4542 6340 5980 -9848 2 2 13 11 4211 6893 5674 -9849 2 2 13 11 4693 5798 5895 -9850 2 2 13 11 3960 5177 5341 -9851 2 2 13 11 4050 4749 6839 -9852 2 2 13 11 3961 5342 5178 -9853 2 2 13 11 4051 6840 4750 -9854 2 2 13 11 4075 6616 4936 -9855 2 2 13 11 3701 5673 4846 -9856 2 2 13 11 3987 6782 5004 -9857 2 2 13 11 4104 5143 5373 -9858 2 2 13 11 3910 4755 6741 -9859 2 2 13 11 3826 6151 4953 -9860 2 2 13 11 329 5686 330 -9861 2 2 13 11 246 5687 247 -9862 2 2 13 11 4426 5430 6687 -9863 2 2 13 11 4111 6001 5025 -9864 2 2 13 11 3687 5725 5235 -9865 2 2 13 11 3824 6214 6728 -9866 2 2 13 11 3755 4866 5817 -9867 2 2 13 11 3801 5124 5544 -9868 2 2 13 11 3972 6639 4854 -9869 2 2 13 11 4250 5692 5265 -9870 2 2 13 11 4251 5266 5694 -9871 2 2 13 11 4207 5634 5628 -9872 2 2 13 11 4208 5629 5635 -9873 2 2 13 11 4192 6292 4881 -9874 2 2 13 11 3693 5390 5473 -9875 2 2 13 11 3963 5222 6854 -9876 2 2 13 11 4582 6254 5246 -9877 2 2 13 11 3779 4786 5711 -9878 2 2 13 11 4395 5468 6024 -9879 2 2 13 11 3758 5308 5818 -9880 2 2 13 11 4101 4889 5761 -9881 2 2 13 11 124 4777 6407 -9882 2 2 13 11 3671 5300 5040 -9883 2 2 13 11 3799 6833 5707 -9884 2 2 13 11 3804 5981 5536 -9885 2 2 13 11 4465 5939 5157 -9886 2 2 13 11 4466 5158 5940 -9887 2 2 13 11 3805 5537 5982 -9888 2 2 13 11 3861 4833 6152 -9889 2 2 13 11 4423 6350 4982 -9890 2 2 13 11 4006 4815 6222 -9891 2 2 13 11 4615 4955 5988 -9892 2 2 13 11 78 79 5373 -9893 2 2 13 11 4048 6028 4741 -9894 2 2 13 11 4049 4742 6029 -9895 2 2 13 11 6874 6506 4323 -9896 2 2 13 11 6875 4324 6507 -9897 2 2 13 11 4135 6678 5690 -9898 2 2 13 11 4136 5691 6679 -9899 2 2 13 11 4040 5854 4840 -9900 2 2 13 11 4974 6426 6019 -9901 2 2 13 11 4975 6020 6427 -9902 2 2 13 11 6472 5705 4358 -9903 2 2 13 11 4143 6846 4961 -9904 2 2 13 11 4908 6868 6412 -9905 2 2 13 11 3963 6854 6129 -9906 2 2 13 11 4634 4935 5934 -9907 2 2 13 11 4461 5232 6313 -9908 2 2 13 11 4134 5255 6762 -9909 2 2 13 11 4759 5309 6782 -9910 2 2 13 11 4048 4950 6035 -9911 2 2 13 11 4049 6036 4951 -9912 2 2 13 11 4144 5113 5424 -9913 2 2 13 11 4145 5425 5114 -9914 2 2 13 11 4537 6175 6332 -9915 2 2 13 11 4753 5108 5969 -9916 2 2 13 11 3829 5591 5279 -9917 2 2 13 11 3733 6939 4800 -9918 2 2 13 11 3990 6199 5039 -9919 2 2 13 11 3953 5464 4913 -9920 2 2 13 11 4730 6212 5891 -9921 2 2 13 11 4121 5055 5864 -9922 2 2 13 11 4122 5865 5056 -9923 2 2 13 11 4282 4826 6228 -9924 2 2 13 11 3946 5240 5799 -9925 2 2 13 11 3707 5814 4862 -9926 2 2 13 11 3933 4781 6206 -9927 2 2 13 11 4385 5585 5532 -9928 2 2 13 11 4386 5533 5586 -9929 2 2 13 11 3832 5496 4929 -9930 2 2 13 11 4097 4982 5777 -9931 2 2 13 11 3811 5402 5217 -9932 2 2 13 11 3710 6136 4807 -9933 2 2 13 11 4248 5179 5374 -9934 2 2 13 11 3929 5891 6212 -9935 2 2 13 11 4046 6614 4817 -9936 2 2 13 11 4968 5732 6751 -9937 2 2 13 11 5091 6122 5884 -9938 2 2 13 11 4144 5424 6766 -9939 2 2 13 11 4145 6767 5425 -9940 2 2 13 11 4047 4818 6615 -9941 2 2 13 11 152 6664 4849 -9942 2 2 13 11 69 4850 6665 -9943 2 2 13 11 86 87 5607 -9944 2 2 13 11 4068 6611 5069 -9945 2 2 13 11 4328 6116 5841 -9946 2 2 13 11 3927 4783 5968 -9947 2 2 13 11 4073 5496 5259 -9948 2 2 13 11 4114 5152 5979 -9949 2 2 13 11 3950 4873 5829 -9950 2 2 13 11 4248 5804 5339 -9951 2 2 13 11 4255 5447 4944 -9952 2 2 13 11 4699 5682 6752 -9953 2 2 13 11 4657 4940 5999 -9954 2 2 13 11 4700 6753 5683 -9955 2 2 13 11 3799 5493 6161 -9956 2 2 13 11 4040 4840 5745 -9957 2 2 13 11 3828 5304 5590 -9958 2 2 13 11 4262 5527 5471 -9959 2 2 13 11 4263 5472 5528 -9960 2 2 13 11 3978 4841 5723 -9961 2 2 13 11 4521 5380 5245 -9962 2 2 13 11 4033 6903 4868 -9963 2 2 13 11 4034 4869 6904 -9964 2 2 13 11 3938 4864 5836 -9965 2 2 13 11 4177 6295 5787 -9966 2 2 13 11 4713 6854 5222 -9967 2 2 13 11 4366 5107 6784 -9968 2 2 13 11 4108 5345 4980 -9969 2 2 13 11 4075 5044 6894 -9970 2 2 13 11 4327 6130 5593 -9971 2 2 13 11 4267 6829 5867 -9972 2 2 13 11 6868 3759 6412 -9973 2 2 13 11 280 5048 5310 -9974 2 2 13 11 4262 5471 5136 -9975 2 2 13 11 4263 5137 5472 -9976 2 2 13 11 123 6407 6569 -9977 2 2 13 11 4288 5243 5506 -9978 2 2 13 11 4347 6852 5110 -9979 2 2 13 11 3752 5827 4992 -9980 2 2 13 11 4557 5095 6607 -9981 2 2 13 11 147 4815 6435 -9982 2 2 13 11 4469 6351 5244 -9983 2 2 13 11 4088 5429 6575 -9984 2 2 13 11 6813 3675 5649 -9985 2 2 13 11 4119 5810 5072 -9986 2 2 13 11 4120 5073 5811 -9987 2 2 13 11 3845 5548 6224 -9988 2 2 13 11 4645 6699 5821 -9989 2 2 13 11 4253 6103 4857 -9990 2 2 13 11 3707 6221 6820 -9991 2 2 13 11 4812 5830 6747 -9992 2 2 13 11 4924 6807 6158 -9993 2 2 13 11 5110 6852 5965 -9994 2 2 13 11 6807 4001 6158 -9995 2 2 13 11 4001 5791 5003 -9996 2 2 13 11 3773 5080 5503 -9997 2 2 13 11 4099 4804 5857 -9998 2 2 13 11 4178 5234 5381 -9999 2 2 13 11 4175 5660 5384 -10000 2 2 13 11 4144 5590 4920 -10001 2 2 13 11 3924 4895 5930 -10002 2 2 13 11 4145 4921 5591 -10003 2 2 13 11 3925 5931 4896 -10004 2 2 13 11 4335 5356 5217 -10005 2 2 13 11 4137 4977 5393 -10006 2 2 13 11 4085 5374 5179 -10007 2 2 13 11 4631 6336 5507 -10008 2 2 13 11 3737 5612 4917 -10009 2 2 13 11 3738 4918 5613 -10010 2 2 13 11 3859 6892 4903 -10011 2 2 13 11 4384 4946 6375 -10012 2 2 13 11 4069 4987 5932 -10013 2 2 13 11 4478 6842 4976 -10014 2 2 13 11 4294 4804 6262 -10015 2 2 13 11 3722 5547 5091 -10016 2 2 13 11 4075 6226 5044 -10017 2 2 13 11 4010 5134 6837 -10018 2 2 13 11 4087 5872 5428 -10019 2 2 13 11 317 5182 318 -10020 2 2 13 11 258 5183 259 -10021 2 2 13 11 3878 5763 4932 -10022 2 2 13 11 3784 5875 4783 -10023 2 2 13 11 4309 4864 6177 -10024 2 2 13 11 3895 6493 6935 -10025 2 2 13 11 3907 6063 4859 -10026 2 2 13 11 298 4949 6352 -10027 2 2 13 11 3780 5033 5480 -10028 2 2 13 11 4273 6526 4887 -10029 2 2 13 11 3731 4860 6182 -10030 2 2 13 11 4914 6192 6164 -10031 2 2 13 11 3732 6183 4861 -10032 2 2 13 11 3927 6315 4801 -10033 2 2 13 11 3777 5781 5731 -10034 2 2 13 11 4161 6306 4842 -10035 2 2 13 11 4162 4843 6307 -10036 2 2 13 11 4108 4980 5658 -10037 2 2 13 11 4142 5300 6190 -10038 2 2 13 11 3765 5136 5471 -10039 2 2 13 11 3766 5472 5137 -10040 2 2 13 11 3799 6161 5396 -10041 2 2 13 11 4474 4956 6919 -10042 2 2 13 11 4102 6502 4807 -10043 2 2 13 11 3786 6019 6426 -10044 2 2 13 11 3787 6427 6020 -10045 2 2 13 11 4494 5397 5000 -10046 2 2 13 11 3973 6261 4835 -10047 2 2 13 11 4694 6900 6613 -10048 2 2 13 11 4036 4984 5408 -10049 2 2 13 11 155 156 5441 -10050 2 2 13 11 4789 5302 6768 -10051 2 2 13 11 65 66 5442 -10052 2 2 13 11 3918 4857 6103 -10053 2 2 13 11 4037 4933 5536 -10054 2 2 13 11 4214 5198 5329 -10055 2 2 13 11 4038 5537 4934 -10056 2 2 13 11 4336 5924 6360 -10057 2 2 13 11 4237 5055 5909 -10058 2 2 13 11 4238 5910 5056 -10059 2 2 13 11 3976 5580 6074 -10060 2 2 13 11 3977 6075 5581 -10061 2 2 13 11 4121 5031 6549 -10062 2 2 13 11 4122 6550 5032 -10063 2 2 13 11 5081 5454 6227 -10064 2 2 13 11 3816 5846 5475 -10065 2 2 13 11 3817 5476 5847 -10066 2 2 13 11 5429 6791 6575 -10067 2 2 13 11 4135 5532 5585 -10068 2 2 13 11 4136 5586 5533 -10069 2 2 13 11 4075 5053 6226 -10070 2 2 13 11 4234 4847 5888 -10071 2 2 13 11 4398 6476 4969 -10072 2 2 13 11 4399 4970 6477 -10073 2 2 13 11 4322 6285 4821 -10074 2 2 13 11 4514 5770 6185 -10075 2 2 13 11 4350 5929 6162 -10076 2 2 13 11 4193 5402 5030 -10077 2 2 13 11 4349 6600 5587 -10078 2 2 13 11 89 90 6374 -10079 2 2 13 11 4480 5071 6012 -10080 2 2 13 11 4794 6687 5430 -10081 2 2 13 11 4030 5277 5159 -10082 2 2 13 11 4043 6572 4995 -10083 2 2 13 11 3797 6114 5434 -10084 2 2 13 11 3798 5435 6115 -10085 2 2 13 11 3733 4839 6215 -10086 2 2 13 11 4357 5799 5240 -10087 2 2 13 11 5069 6611 5242 -10088 2 2 13 11 4019 6322 5379 -10089 2 2 13 11 4381 5038 5384 -10090 2 2 13 11 3659 6772 5478 -10091 2 2 13 11 4387 6499 4844 -10092 2 2 13 11 129 130 5225 -10093 2 2 13 11 4601 6240 6083 -10094 2 2 13 11 4117 5348 5085 -10095 2 2 13 11 4146 5497 4953 -10096 2 2 13 11 3916 5511 5197 -10097 2 2 13 11 4177 5787 5562 -10098 2 2 13 11 3755 6517 4866 -10099 2 2 13 11 4184 5817 4866 -10100 2 2 13 11 4199 5744 6499 -10101 2 2 13 11 3734 4900 6356 -10102 2 2 13 11 3779 6726 4786 -10103 2 2 13 11 4177 5430 5365 -10104 2 2 13 11 3939 5315 6112 -10105 2 2 13 11 4418 6023 5291 -10106 2 2 13 11 4147 5256 5609 -10107 2 2 13 11 3749 5507 6336 -10108 2 2 13 11 4110 4833 6495 -10109 2 2 13 11 132 5986 5596 -10110 2 2 13 11 4156 4969 6476 -10111 2 2 13 11 4157 6477 4970 -10112 2 2 13 11 4424 5818 5308 -10113 2 2 13 11 4325 5513 6224 -10114 2 2 13 11 4819 6749 6694 -10115 2 2 13 11 4820 6695 6750 -10116 2 2 13 11 4154 5575 6713 -10117 2 2 13 11 4112 6494 4834 -10118 2 2 13 11 3739 4886 6755 -10119 2 2 13 11 4492 5731 5781 -10120 2 2 13 11 4618 6867 6437 -10121 2 2 13 11 3879 5326 5193 -10122 2 2 13 11 4619 6438 6869 -10123 2 2 13 11 4253 5696 6296 -10124 2 2 13 11 3718 6313 5232 -10125 2 2 13 11 4688 5149 5813 -10126 2 2 13 11 3707 4862 5945 -10127 2 2 13 11 4121 6549 5055 -10128 2 2 13 11 4122 5056 6550 -10129 2 2 13 11 3922 5492 6662 -10130 2 2 13 11 4566 6478 6251 -10131 2 2 13 11 4567 6252 6479 -10132 2 2 13 11 4892 6506 6874 -10133 2 2 13 11 4893 6875 6507 -10134 2 2 13 11 4767 6707 5017 -10135 2 2 13 11 4007 5244 6351 -10136 2 2 13 11 3982 5643 5081 -10137 2 2 13 11 3823 4967 5483 -10138 2 2 13 11 4406 5935 4981 -10139 2 2 13 11 4788 6662 5492 -10140 2 2 13 11 4180 4931 5718 -10141 2 2 13 11 4985 5330 6690 -10142 2 2 13 11 4188 4932 5763 -10143 2 2 13 11 4235 4924 6158 -10144 2 2 13 11 3967 4976 6842 -10145 2 2 13 11 3861 5540 4922 -10146 2 2 13 11 3700 5261 5927 -10147 2 2 13 11 4410 6323 6555 -10148 2 2 13 11 4420 5339 5804 -10149 2 2 13 11 3849 5599 4948 -10150 2 2 13 11 4275 5911 6580 -10151 2 2 13 11 4170 5314 5701 -10152 2 2 13 11 4437 5074 6743 -10153 2 2 13 11 4141 5479 5127 -10154 2 2 13 11 4577 5012 5529 -10155 2 2 13 11 4578 5530 5013 -10156 2 2 13 11 3856 6940 4879 -10157 2 2 13 11 4105 6053 5093 -10158 2 2 13 11 4026 5526 6838 -10159 2 2 13 11 4117 5088 5688 -10160 2 2 13 11 4090 5633 4935 -10161 2 2 13 11 4009 4852 6607 -10162 2 2 13 11 4173 5457 4972 -10163 2 2 13 11 4174 4973 5458 -10164 2 2 13 11 3963 5732 5222 -10165 2 2 13 11 4658 4981 5935 -10166 2 2 13 11 4989 6813 5649 -10167 2 2 13 11 4323 6506 5129 -10168 2 2 13 11 4324 5130 6507 -10169 2 2 13 11 4297 4908 6412 -10170 2 2 13 11 4234 5888 4871 -10171 2 2 13 11 4316 4971 6264 -10172 2 2 13 11 3931 6164 6192 -10173 2 2 13 11 4053 5915 4852 -10174 2 2 13 11 4076 6436 5495 -10175 2 2 13 11 3759 6744 4870 -10176 2 2 13 11 3955 6305 5422 -10177 2 2 13 11 4206 6853 6789 -10178 2 2 13 11 4495 4952 6652 -10179 2 2 13 11 4460 6352 4949 -10180 2 2 13 11 3771 6764 6817 -10181 2 2 13 11 4152 6573 4890 -10182 2 2 13 11 3749 6336 4803 -10183 2 2 13 11 4126 5825 5503 -10184 2 2 13 11 3973 6329 4879 -10185 2 2 13 11 4360 5735 5455 -10186 2 2 13 11 4005 6658 4904 -10187 2 2 13 11 4517 6589 5151 -10188 2 2 13 11 4513 6382 6276 -10189 2 2 13 11 3826 5374 5016 -10190 2 2 13 11 4192 4881 6017 -10191 2 2 13 11 3791 6284 5187 -10192 2 2 13 11 4114 5979 5329 -10193 2 2 13 11 3713 5332 5834 -10194 2 2 13 11 4326 4823 6253 -10195 2 2 13 11 4228 5518 6025 -10196 2 2 13 11 4407 5651 4911 -10197 2 2 13 11 4408 4912 5652 -10198 2 2 13 11 3775 5105 5327 -10199 2 2 13 11 3776 5328 5106 -10200 2 2 13 11 3867 5789 4983 -10201 2 2 13 11 4589 5379 6322 -10202 2 2 13 11 3651 5899 4831 -10203 2 2 13 11 4553 6087 5525 -10204 2 2 13 11 4168 5477 6697 -10205 2 2 13 11 4011 4949 6174 -10206 2 2 13 11 4327 5902 6947 -10207 2 2 13 11 4161 4874 6306 -10208 2 2 13 11 4162 6307 4875 -10209 2 2 13 11 3789 5878 5445 -10210 2 2 13 11 3790 5446 5879 -10211 2 2 13 11 4382 4866 6517 -10212 2 2 13 11 4182 6215 4839 -10213 2 2 13 11 3852 4935 5633 -10214 2 2 13 11 4574 5665 6612 -10215 2 2 13 11 4128 5010 5697 -10216 2 2 13 11 4129 5698 5011 -10217 2 2 13 11 3652 6747 5830 -10218 2 2 13 11 4200 5091 5547 -10219 2 2 13 11 4223 4867 6016 -10220 2 2 13 11 3931 5151 6589 -10221 2 2 13 11 4087 5449 5872 -10222 2 2 13 11 4109 5351 5014 -10223 2 2 13 11 4218 4805 6759 -10224 2 2 13 11 4188 5884 6612 -10225 2 2 13 11 4219 6760 4806 -10226 2 2 13 11 4446 5872 5449 -10227 2 2 13 11 4112 5357 5042 -10228 2 2 13 11 4623 6074 5580 -10229 2 2 13 11 4624 5581 6075 -10230 2 2 13 11 4505 4956 6410 -10231 2 2 13 11 4210 5081 5643 -10232 2 2 13 11 3877 6141 5361 -10233 2 2 13 11 4362 4882 6040 -10234 2 2 13 11 3954 4943 6714 -10235 2 2 13 11 168 5031 6524 -10236 2 2 13 11 53 6525 5032 -10237 2 2 13 11 4462 5466 5156 -10238 2 2 13 11 3769 6655 5812 -10239 2 2 13 11 4074 6801 5321 -10240 2 2 13 11 163 164 5369 -10241 2 2 13 11 57 58 5370 -10242 2 2 13 11 3767 5915 5049 -10243 2 2 13 11 4110 6495 4902 -10244 2 2 13 11 4381 5384 5660 -10245 2 2 13 11 3993 6419 6491 -10246 2 2 13 11 4314 5341 5177 -10247 2 2 13 11 4315 5178 5342 -10248 2 2 13 11 5163 6181 6902 -10249 2 2 13 11 3746 4874 6030 -10250 2 2 13 11 3747 6031 4875 -10251 2 2 13 11 3989 4930 5641 -10252 2 2 13 11 3985 6544 5089 -10253 2 2 13 11 3918 6121 4857 -10254 2 2 13 11 4294 6338 4804 -10255 2 2 13 11 3956 6919 4956 -10256 2 2 13 11 3854 6506 4892 -10257 2 2 13 11 3855 4893 6507 -10258 2 2 13 11 4829 5587 6600 -10259 2 2 13 11 4066 5219 6583 -10260 2 2 13 11 4160 6176 5337 -10261 2 2 13 11 3669 6032 6774 -10262 2 2 13 11 4067 6584 5220 -10263 2 2 13 11 4184 4866 6013 -10264 2 2 13 11 3765 5471 5203 -10265 2 2 13 11 4368 5039 5460 -10266 2 2 13 11 3766 5204 5472 -10267 2 2 13 11 4418 5291 5999 -10268 2 2 13 11 3743 5999 5291 -10269 2 2 13 11 4377 6825 4906 -10270 2 2 13 11 4663 5793 5012 -10271 2 2 13 11 4664 5013 5794 -10272 2 2 13 11 3973 4835 6329 -10273 2 2 13 11 3727 5460 5039 -10274 2 2 13 11 4116 5525 6087 -10275 2 2 13 11 4112 4905 6494 -10276 2 2 13 11 4362 5876 4882 -10277 2 2 13 11 4231 5197 5511 -10278 2 2 13 11 5478 6772 6930 -10279 2 2 13 11 4405 4901 6556 -10280 2 2 13 11 4517 6347 5250 -10281 2 2 13 11 4225 5746 5409 -10282 2 2 13 11 4226 5410 5747 -10283 2 2 13 11 3954 4902 6495 -10284 2 2 13 11 4384 4959 5753 -10285 2 2 13 11 304 6220 4960 -10286 2 2 13 11 4321 6208 5176 -10287 2 2 13 11 4287 6329 4835 -10288 2 2 13 11 4040 5491 5138 -10289 2 2 13 11 4984 5389 6563 -10290 2 2 13 11 4416 5361 6141 -10291 2 2 13 11 4312 5957 4883 -10292 2 2 13 11 4121 6524 5031 -10293 2 2 13 11 4122 5032 6525 -10294 2 2 13 11 4322 5121 6073 -10295 2 2 13 11 4103 5156 5466 -10296 2 2 13 11 4913 5244 6777 -10297 2 2 13 11 3658 5901 6016 -10298 2 2 13 11 4132 5896 5052 -10299 2 2 13 11 4795 6491 6419 -10300 2 2 13 11 4252 4858 5689 -10301 2 2 13 11 3811 5217 5356 -10302 2 2 13 11 4201 5381 5234 -10303 2 2 13 11 4891 6128 5358 -10304 2 2 13 11 4127 4915 5800 -10305 2 2 13 11 4276 4837 6249 -10306 2 2 13 11 4277 6250 4838 -10307 2 2 13 11 3866 5824 6309 -10308 2 2 13 11 3870 6153 5414 -10309 2 2 13 11 3686 5502 5063 -10310 2 2 13 11 3802 4963 6841 -10311 2 2 13 11 4360 6498 5022 -10312 2 2 13 11 3957 6717 4955 -10313 2 2 13 11 4203 4859 6294 -10314 2 2 13 11 4148 5093 5439 -10315 2 2 13 11 4915 6201 4331 -10316 2 2 13 11 3764 5941 4864 -10317 2 2 13 11 4322 5500 6748 -10318 2 2 13 11 3957 6494 4905 -10319 2 2 13 11 5254 5851 6800 -10320 2 2 13 11 3791 5001 6284 -10321 2 2 13 11 4788 6508 6708 -10322 2 2 13 11 4203 6294 6121 -10323 2 2 13 11 4204 4974 6019 -10324 2 2 13 11 4205 6020 4975 -10325 2 2 13 11 4493 5562 5787 -10326 2 2 13 11 3959 6138 5627 -10327 2 2 13 11 4688 6582 5194 -10328 2 2 13 11 4063 5207 6288 -10329 2 2 13 11 4064 6289 5208 -10330 2 2 13 11 4534 5414 6153 -10331 2 2 13 11 299 5550 300 -10332 2 2 13 11 3722 5091 5552 -10333 2 2 13 11 4268 5902 5593 -10334 2 2 13 11 3847 6191 5539 -10335 2 2 13 11 73 74 5386 -10336 2 2 13 11 5400 5864 6864 -10337 2 2 13 11 5401 6865 5865 -10338 2 2 13 11 4499 6112 5315 -10339 2 2 13 11 4429 6056 5363 -10340 2 2 13 11 4430 5364 6057 -10341 2 2 13 11 3781 6017 4881 -10342 2 2 13 11 4286 5820 6314 -10343 2 2 13 11 4246 4930 6159 -10344 2 2 13 11 304 4960 6452 -10345 2 2 13 11 3954 6738 4943 -10346 2 2 13 11 285 4971 6154 -10347 2 2 13 11 3657 5171 5973 -10348 2 2 13 11 3808 5783 5281 -10349 2 2 13 11 4055 4842 6306 -10350 2 2 13 11 4056 6307 4843 -10351 2 2 13 11 4239 5529 5012 -10352 2 2 13 11 4240 5013 5530 -10353 2 2 13 11 4230 6192 4914 -10354 2 2 13 11 4554 6769 5385 -10355 2 2 13 11 3973 4879 6310 -10356 2 2 13 11 4020 4909 6770 -10357 2 2 13 11 4021 6771 4910 -10358 2 2 13 11 3694 4878 5779 -10359 2 2 13 11 4361 5598 4922 -10360 2 2 13 11 4209 5768 4903 -10361 2 2 13 11 70 4946 5708 -10362 2 2 13 11 3904 4867 5947 -10363 2 2 13 11 4165 4948 5611 -10364 2 2 13 11 4429 5343 6627 -10365 2 2 13 11 4430 6628 5344 -10366 2 2 13 11 5484 6708 6677 -10367 2 2 13 11 3780 4863 5995 -10368 2 2 13 11 3657 5564 5171 -10369 2 2 13 11 269 6090 5017 -10370 2 2 13 11 81 5761 4889 -10371 2 2 13 11 3834 5439 5093 -10372 2 2 13 11 4135 5585 6678 -10373 2 2 13 11 4136 6679 5586 -10374 2 2 13 11 3768 6624 5272 -10375 2 2 13 11 4060 5380 6171 -10376 2 2 13 11 4469 5795 4994 -10377 2 2 13 11 4298 6770 4909 -10378 2 2 13 11 4299 4910 6771 -10379 2 2 13 11 3741 4936 5905 -10380 2 2 13 11 4037 6617 4933 -10381 2 2 13 11 4038 4934 6618 -10382 2 2 13 11 4481 6660 5474 -10383 2 2 13 11 3989 6159 4930 -10384 2 2 13 11 4113 5190 5335 -10385 2 2 13 11 4669 6418 6548 -10386 2 2 13 11 4687 6829 6127 -10387 2 2 13 11 4114 5329 5198 -10388 2 2 13 11 3781 4857 6294 -10389 2 2 13 11 3676 5521 6500 -10390 2 2 13 11 335 5909 5055 -10391 2 2 13 11 241 5056 5910 -10392 2 2 13 11 3955 6000 6305 -10393 2 2 13 11 4448 6714 4943 -10394 2 2 13 11 296 5286 297 -10395 2 2 13 11 3670 6333 4854 -10396 2 2 13 11 4017 6062 5566 -10397 2 2 13 11 4018 5567 6064 -10398 2 2 13 11 4181 5193 5326 -10399 2 2 13 11 3730 6470 5184 -10400 2 2 13 11 4587 5824 6562 -10401 2 2 13 11 4121 5077 6524 -10402 2 2 13 11 4122 6525 5078 -10403 2 2 13 11 4218 5471 5527 -10404 2 2 13 11 4219 5528 5472 -10405 2 2 13 11 4295 6002 5655 -10406 2 2 13 11 3822 6176 5545 -10407 2 2 13 11 3829 4985 6458 -10408 2 2 13 11 4029 6429 4942 -10409 2 2 13 11 4626 5302 6466 -10410 2 2 13 11 4543 6025 5518 -10411 2 2 13 11 4917 5612 6372 -10412 2 2 13 11 5118 6672 5444 -10413 2 2 13 11 4918 6373 5613 -10414 2 2 13 11 4579 5917 5139 -10415 2 2 13 11 4373 6656 5561 -10416 2 2 13 11 3950 6783 6165 -10417 2 2 13 11 3992 4872 6472 -10418 2 2 13 11 4234 6089 4847 -10419 2 2 13 11 4415 5834 5332 -10420 2 2 13 11 4865 6483 5255 -10421 2 2 13 11 4398 4969 5756 -10422 2 2 13 11 3966 4831 6462 -10423 2 2 13 11 4399 5757 4970 -10424 2 2 13 11 4146 4958 5721 -10425 2 2 13 11 3947 5058 6670 -10426 2 2 13 11 4168 6697 5782 -10427 2 2 13 11 4382 6587 4866 -10428 2 2 13 11 4101 5761 5094 -10429 2 2 13 11 3792 4895 5639 -10430 2 2 13 11 3793 5640 4896 -10431 2 2 13 11 4172 5502 5209 -10432 2 2 13 11 4117 5320 5348 -10433 2 2 13 11 105 106 5543 -10434 2 2 13 11 3760 5181 6428 -10435 2 2 13 11 4853 6696 6709 -10436 2 2 13 11 3862 6832 5023 -10437 2 2 13 11 4394 5927 5261 -10438 2 2 13 11 3957 4955 6763 -10439 2 2 13 11 4074 5492 6801 -10440 2 2 13 11 4223 6126 5228 -10441 2 2 13 11 3746 4884 6300 -10442 2 2 13 11 3747 6301 4885 -10443 2 2 13 11 4083 6021 6483 -10444 2 2 13 11 4618 6437 5740 -10445 2 2 13 11 3844 5848 4945 -10446 2 2 13 11 4619 5741 6438 -10447 2 2 13 11 4370 6027 6223 -10448 2 2 13 11 4441 5238 6272 -10449 2 2 13 11 4330 6090 5314 -10450 2 2 13 11 4442 6273 5239 -10451 2 2 13 11 4230 4914 6263 -10452 2 2 13 11 4258 5455 5735 -10453 2 2 13 11 4517 6606 6347 -10454 2 2 13 11 4245 5551 5145 -10455 2 2 13 11 4003 6790 5768 -10456 2 2 13 11 3737 4917 6194 -10457 2 2 13 11 3738 6195 4918 -10458 2 2 13 11 4154 5050 5575 -10459 2 2 13 11 3743 5291 6713 -10460 2 2 13 11 3833 5661 5845 -10461 2 2 13 11 3689 5983 4999 -10462 2 2 13 11 3751 4847 6089 -10463 2 2 13 11 3875 4961 6730 -10464 2 2 13 11 4180 5925 4931 -10465 2 2 13 11 3958 4904 6809 -10466 2 2 13 11 4028 5560 6884 -10467 2 2 13 11 4010 4900 5807 -10468 2 2 13 11 3775 5327 5601 -10469 2 2 13 11 3776 5602 5328 -10470 2 2 13 11 3812 5400 6864 -10471 2 2 13 11 3813 6865 5401 -10472 2 2 13 11 4329 5281 5783 -10473 2 2 13 11 6651 4915 4331 -10474 2 2 13 11 3970 5104 5655 -10475 2 2 13 11 337 6549 5031 -10476 2 2 13 11 239 5032 6550 -10477 2 2 13 11 158 5111 6388 -10478 2 2 13 11 63 6389 5112 -10479 2 2 13 11 3682 6694 6749 -10480 2 2 13 11 4055 6306 4874 -10481 2 2 13 11 3683 6750 6695 -10482 2 2 13 11 4056 4875 6307 -10483 2 2 13 11 4070 5129 5452 -10484 2 2 13 11 4071 5453 5130 -10485 2 2 13 11 293 6245 5043 -10486 2 2 13 11 4158 4943 6738 -10487 2 2 13 11 4307 6942 4972 -10488 2 2 13 11 4308 4973 6943 -10489 2 2 13 11 4637 5542 6555 -10490 2 2 13 11 4449 4955 6717 -10491 2 2 13 11 4904 6658 5830 -10492 2 2 13 11 4008 5705 5000 -10493 2 2 13 11 4094 5571 4937 -10494 2 2 13 11 5180 5467 6509 -10495 2 2 13 11 5129 6506 5452 -10496 2 2 13 11 4155 5783 5135 -10497 2 2 13 11 5130 5453 6507 -10498 2 2 13 11 3829 6552 4985 -10499 2 2 13 11 4146 4953 6319 -10500 2 2 13 11 3953 4906 6825 -10501 2 2 13 11 4228 4983 5789 -10502 2 2 13 11 4845 6223 6027 -10503 2 2 13 11 3827 5202 6414 -10504 2 2 13 11 3678 6746 4924 -10505 2 2 13 11 280 5310 281 -10506 2 2 13 11 313 5822 5097 -10507 2 2 13 11 263 5098 5823 -10508 2 2 13 11 4857 6121 6294 -10509 2 2 13 11 279 6269 5048 -10510 2 2 13 11 4025 6712 5176 -10511 2 2 13 11 4666 6593 5866 -10512 2 2 13 11 4165 5949 4948 -10513 2 2 13 11 3800 5214 6880 -10514 2 2 13 11 4118 6739 4992 -10515 2 2 13 11 4297 4878 6335 -10516 2 2 13 11 4283 5601 5327 -10517 2 2 13 11 4264 6259 5065 -10518 2 2 13 11 4312 4883 6068 -10519 2 2 13 11 4284 5328 5602 -10520 2 2 13 11 4153 5493 5423 -10521 2 2 13 11 4109 5123 5767 -10522 2 2 13 11 4221 4863 6377 -10523 2 2 13 11 3781 6294 4859 -10524 2 2 13 11 137 6857 6420 -10525 2 2 13 11 4396 5409 5746 -10526 2 2 13 11 4397 5747 5410 -10527 2 2 13 11 4012 6073 5121 -10528 2 2 13 11 4579 6728 6214 -10529 2 2 13 11 140 5693 5030 -10530 2 2 13 11 3811 5858 4941 -10531 2 2 13 11 4739 6016 5901 -10532 2 2 13 11 4604 5799 5067 -10533 2 2 13 11 4425 6448 5671 -10534 2 2 13 11 4159 6763 4955 -10535 2 2 13 11 4029 5059 5837 -10536 2 2 13 11 4457 6205 5297 -10537 2 2 13 11 4903 5768 6790 -10538 2 2 13 11 4031 5297 6205 -10539 2 2 13 11 3878 4932 6082 -10540 2 2 13 11 3971 4846 6417 -10541 2 2 13 11 3810 6512 5290 -10542 2 2 13 11 3966 4931 5925 -10543 2 2 13 11 5830 6658 4417 -10544 2 2 13 11 332 5966 5020 -10545 2 2 13 11 244 5021 5967 -10546 2 2 13 11 4236 6041 4937 -10547 2 2 13 11 4260 4932 5665 -10548 2 2 13 11 4043 4995 5928 -10549 2 2 13 11 4897 6627 5992 -10550 2 2 13 11 4898 5993 6628 -10551 2 2 13 11 3959 6580 4825 -10552 2 2 13 11 4586 5901 5979 -10553 2 2 13 11 4033 5010 6903 -10554 2 2 13 11 4034 6904 5011 -10555 2 2 13 11 4119 4933 6172 -10556 2 2 13 11 3705 5037 6197 -10557 2 2 13 11 4120 6173 4934 -10558 2 2 13 11 4727 6230 6144 -10559 2 2 13 11 4655 5627 6138 -10560 2 2 13 11 166 5077 6079 -10561 2 2 13 11 55 6080 5078 -10562 2 2 13 11 3796 5154 5454 -10563 2 2 13 11 3657 5382 6349 -10564 2 2 13 11 3979 5859 6765 -10565 2 2 13 11 3999 6217 5160 -10566 2 2 13 11 4000 5161 6218 -10567 2 2 13 11 4368 5460 6331 -10568 2 2 13 11 4115 4862 6260 -10569 2 2 13 11 97 6410 4956 -10570 2 2 13 11 3978 5723 4998 -10571 2 2 13 11 4338 5180 6231 -10572 2 2 13 11 271 5347 272 -10573 2 2 13 11 3849 4948 5949 -10574 2 2 13 11 69 70 5708 -10575 2 2 13 11 4022 5753 4959 -10576 2 2 13 11 4187 5703 4919 -10577 2 2 13 11 5192 5770 6225 -10578 2 2 13 11 4381 6421 5524 -10579 2 2 13 11 4336 5260 5924 -10580 2 2 13 11 138 6011 5101 -10581 2 2 13 11 3842 5991 6654 -10582 2 2 13 11 3830 5697 5010 -10583 2 2 13 11 314 5097 6049 -10584 2 2 13 11 262 6050 5098 -10585 2 2 13 11 3831 5011 5698 -10586 2 2 13 11 146 5131 6324 -10587 2 2 13 11 5579 6332 6891 -10588 2 2 13 11 3870 6234 5198 -10589 2 2 13 11 4494 6191 5397 -10590 2 2 13 11 3701 5665 6683 -10591 2 2 13 11 4206 6160 4873 -10592 2 2 13 11 4403 6458 4985 -10593 2 2 13 11 4137 6094 4977 -10594 2 2 13 11 4221 5995 4863 -10595 2 2 13 11 3996 5238 5509 -10596 2 2 13 11 3752 4992 5795 -10597 2 2 13 11 3997 5510 5239 -10598 2 2 13 11 3818 6189 5573 -10599 2 2 13 11 4480 6619 5751 -10600 2 2 13 11 3966 6314 4931 -10601 2 2 13 11 4512 4928 6588 -10602 2 2 13 11 4641 6681 6078 -10603 2 2 13 11 3684 6396 6006 -10604 2 2 13 11 4206 5806 6853 -10605 2 2 13 11 3685 6007 6397 -10606 2 2 13 11 4373 6480 6656 -10607 2 2 13 11 4188 5552 5091 -10608 2 2 13 11 3819 6708 5484 -10609 2 2 13 11 4111 6381 5268 -10610 2 2 13 11 3781 4859 6017 -10611 2 2 13 11 4577 5566 6062 -10612 2 2 13 11 4578 6064 5567 -10613 2 2 13 11 4679 6500 5521 -10614 2 2 13 11 4142 5606 5957 -10615 2 2 13 11 4583 6493 5717 -10616 2 2 13 11 3774 4873 6160 -10617 2 2 13 11 3777 4968 5781 -10618 2 2 13 11 4186 5125 5642 -10619 2 2 13 11 4115 5781 6751 -10620 2 2 13 11 3669 5936 4923 -10621 2 2 13 11 288 5362 289 -10622 2 2 13 11 3913 6282 6219 -10623 2 2 13 11 295 5116 5989 -10624 2 2 13 11 4197 5807 4900 -10625 2 2 13 11 3691 6689 4901 -10626 2 2 13 11 4561 6774 5354 -10627 2 2 13 11 4418 6619 6023 -10628 2 2 13 11 4478 4976 5791 -10629 2 2 13 11 3892 5594 6948 -10630 2 2 13 11 3893 6949 5595 -10631 2 2 13 11 319 5554 320 -10632 2 2 13 11 256 5555 257 -10633 2 2 13 11 3780 5658 4980 -10634 2 2 13 11 4032 4964 6443 -10635 2 2 13 11 3972 4854 6602 -10636 2 2 13 11 4252 6702 4858 -10637 2 2 13 11 332 5020 6908 -10638 2 2 13 11 244 6909 5021 -10639 2 2 13 11 4141 5192 5760 -10640 2 2 13 11 4677 4886 6572 -10641 2 2 13 11 4349 5786 4988 -10642 2 2 13 11 4334 6026 5336 -10643 2 2 13 11 4155 5332 5729 -10644 2 2 13 11 4362 4888 6802 -10645 2 2 13 11 3651 6831 4981 -10646 2 2 13 11 3803 6155 5285 -10647 2 2 13 11 4571 6142 4894 -10648 2 2 13 11 282 5372 283 -10649 2 2 13 11 4569 5563 6938 -10650 2 2 13 11 3693 5825 5390 -10651 2 2 13 11 4325 6885 4883 -10652 2 2 13 11 4015 6372 5136 -10653 2 2 13 11 4016 5137 6373 -10654 2 2 13 11 3693 4944 6330 -10655 2 2 13 11 3926 5608 6610 -10656 2 2 13 11 5428 5872 6655 -10657 2 2 13 11 3826 5497 5804 -10658 2 2 13 11 3847 5397 6191 -10659 2 2 13 11 5460 6814 6331 -10660 2 2 13 11 4126 5503 5080 -10661 2 2 13 11 4244 5840 5637 -10662 2 2 13 11 3771 6817 5090 -10663 2 2 13 11 4178 6490 5614 -10664 2 2 13 11 3657 5320 5564 -10665 2 2 13 11 295 6794 5116 -10666 2 2 13 11 3828 6001 5304 -10667 2 2 13 11 4728 6569 6407 -10668 2 2 13 11 112 113 5336 -10669 2 2 13 11 4409 5596 5986 -10670 2 2 13 11 4517 5250 6630 -10671 2 2 13 11 4296 4998 5723 -10672 2 2 13 11 4223 5947 4867 -10673 2 2 13 11 3954 6714 4902 -10674 2 2 13 11 3737 5953 4868 -10675 2 2 13 11 3655 4902 6716 -10676 2 2 13 11 3738 4869 5954 -10677 2 2 13 11 4204 5975 4974 -10678 2 2 13 11 4205 4975 5976 -10679 2 2 13 11 269 5017 6707 -10680 2 2 13 11 3827 5672 5186 -10681 2 2 13 11 4529 5023 6832 -10682 2 2 13 11 4151 5084 6309 -10683 2 2 13 11 3867 5917 5789 -10684 2 2 13 11 3689 5079 5983 -10685 2 2 13 11 3914 6144 6230 -10686 2 2 13 11 3985 4954 6544 -10687 2 2 13 11 151 5777 4982 -10688 2 2 13 11 4805 6358 6759 -10689 2 2 13 11 4806 6760 6359 -10690 2 2 13 11 4512 6933 4954 -10691 2 2 13 11 3658 5979 5901 -10692 2 2 13 11 5155 5689 6700 -10693 2 2 13 11 3843 5230 5748 -10694 2 2 13 11 4437 6743 6101 -10695 2 2 13 11 4452 5796 6765 -10696 2 2 13 11 4225 6316 4926 -10697 2 2 13 11 4226 4927 6317 -10698 2 2 13 11 4085 5179 5938 -10699 2 2 13 11 4149 6200 5002 -10700 2 2 13 11 4185 6544 4954 -10701 2 2 13 11 3754 5331 5469 -10702 2 2 13 11 4225 6300 4884 -10703 2 2 13 11 4226 4885 6301 -10704 2 2 13 11 123 124 6407 -10705 2 2 13 11 4270 5905 6043 -10706 2 2 13 11 4460 4949 6895 -10707 2 2 13 11 4173 4972 5686 -10708 2 2 13 11 4174 5687 4973 -10709 2 2 13 11 4706 5184 6470 -10710 2 2 13 11 3771 5090 5538 -10711 2 2 13 11 4133 5517 6555 -10712 2 2 13 11 3957 4905 6717 -10713 2 2 13 11 4060 5245 5380 -10714 2 2 13 11 112 5336 6026 -10715 2 2 13 11 4088 6575 5521 -10716 2 2 13 11 4410 6123 5426 -10717 2 2 13 11 3900 6083 6240 -10718 2 2 13 11 4152 5726 5060 -10719 2 2 13 11 3818 5444 6189 -10720 2 2 13 11 4538 5756 4969 -10721 2 2 13 11 4539 4970 5757 -10722 2 2 13 11 4614 6530 5577 -10723 2 2 13 11 4344 5346 5672 -10724 2 2 13 11 3803 6002 6155 -10725 2 2 13 11 4279 5195 5814 -10726 2 2 13 11 3828 6457 5025 -10727 2 2 13 11 4245 5570 5551 -10728 2 2 13 11 3752 6578 5827 -10729 2 2 13 11 4259 6270 5101 -10730 2 2 13 11 4063 5417 5207 -10731 2 2 13 11 4064 5208 5418 -10732 2 2 13 11 4607 6298 6009 -10733 2 2 13 11 4608 6010 6299 -10734 2 2 13 11 4423 5304 6001 -10735 2 2 13 11 4373 5662 5082 -10736 2 2 13 11 3940 6709 6696 -10737 2 2 13 11 4359 5043 6245 -10738 2 2 13 11 3789 6325 5878 -10739 2 2 13 11 3790 5879 6326 -10740 2 2 13 11 4877 6817 6764 -10741 2 2 13 11 4218 5203 5471 -10742 2 2 13 11 4219 5472 5204 -10743 2 2 13 11 4374 5634 5257 -10744 2 2 13 11 4375 5258 5635 -10745 2 2 13 11 6627 3964 5992 -10746 2 2 13 11 3894 5577 6530 -10747 2 2 13 11 6628 5993 3965 -10748 2 2 13 11 3674 4988 6894 -10749 2 2 13 11 4143 5504 6846 -10750 2 2 13 11 4564 6810 6378 -10751 2 2 13 11 4968 6751 5781 -10752 2 2 13 11 4193 5030 5693 -10753 2 2 13 11 285 6663 4971 -10754 2 2 13 11 3697 6101 4957 -10755 2 2 13 11 4488 6386 5719 -10756 2 2 13 11 4489 5720 6387 -10757 2 2 13 11 3806 6265 6044 -10758 2 2 13 11 4366 5048 6269 -10759 2 2 13 11 3823 6128 4967 -10760 2 2 13 11 3865 6122 4952 -10761 2 2 13 11 3814 5221 5512 -10762 2 2 13 11 3771 6952 5228 -10763 2 2 13 11 320 5554 5363 -10764 2 2 13 11 256 5364 5555 -10765 2 2 13 11 4579 5789 5917 -10766 2 2 13 11 82 5094 5761 -10767 2 2 13 11 4575 5874 6012 -10768 2 2 13 11 4212 5348 5320 -10769 2 2 13 11 4161 5897 5173 -10770 2 2 13 11 4162 5174 5898 -10771 2 2 13 11 3694 6335 4878 -10772 2 2 13 11 4255 5551 5447 -10773 2 2 13 11 4079 5684 6598 -10774 2 2 13 11 4080 6599 5685 -10775 2 2 13 11 3993 6491 4957 -10776 2 2 13 11 3882 6405 5709 -10777 2 2 13 11 4248 5374 5804 -10778 2 2 13 11 3971 4977 6130 -10779 2 2 13 11 4480 6849 6619 -10780 2 2 13 11 4332 4986 5679 -10781 2 2 13 11 4143 5126 5818 -10782 2 2 13 11 4147 5609 5861 -10783 2 2 13 11 3868 5952 5513 -10784 2 2 13 11 4428 5259 5496 -10785 2 2 13 11 3731 5918 5008 -10786 2 2 13 11 3732 5009 5919 -10787 2 2 13 11 3762 5740 5313 -10788 2 2 13 11 3763 5316 5741 -10789 2 2 13 11 4569 6938 5223 -10790 2 2 13 11 4660 5524 6421 -10791 2 2 13 11 4582 5839 6740 -10792 2 2 13 11 4084 6231 5180 -10793 2 2 13 11 4338 5692 5758 -10794 2 2 13 11 4339 5759 5694 -10795 2 2 13 11 3905 5120 5978 -10796 2 2 13 11 3917 5392 6233 -10797 2 2 13 11 4654 5748 5230 -10798 2 2 13 11 4285 5423 5493 -10799 2 2 13 11 3825 5015 5610 -10800 2 2 13 11 3699 5642 5125 -10801 2 2 13 11 4328 5556 6116 -10802 2 2 13 11 4002 4989 6239 -10803 2 2 13 11 4189 5707 4967 -10804 2 2 13 11 4295 5655 5104 -10805 2 2 13 11 323 5404 324 -10806 2 2 13 11 252 5405 253 -10807 2 2 13 11 3930 5150 6078 -10808 2 2 13 11 3941 4974 5975 -10809 2 2 13 11 3942 5976 4975 -10810 2 2 13 11 4492 6568 4907 -10811 2 2 13 11 4199 4941 5858 -10812 2 2 13 11 127 128 5468 -10813 2 2 13 11 4400 6868 4908 -10814 2 2 13 11 4440 6708 6508 -10815 2 2 13 11 4496 5115 5549 -10816 2 2 13 11 4839 6205 5062 -10817 2 2 13 11 167 168 6524 -10818 2 2 13 11 53 54 6525 -10819 2 2 13 11 4575 6012 5071 -10820 2 2 13 11 3880 5494 6357 -10821 2 2 13 11 101 102 5385 -10822 2 2 13 11 3986 5443 5311 -10823 2 2 13 11 330 4972 6942 -10824 2 2 13 11 246 6943 4973 -10825 2 2 13 11 4144 5215 5590 -10826 2 2 13 11 5017 6090 6594 -10827 2 2 13 11 4145 5591 5216 -10828 2 2 13 11 4260 6082 4932 -10829 2 2 13 11 3915 4984 6563 -10830 2 2 13 11 148 5268 6381 -10831 2 2 13 11 316 5157 6004 -10832 2 2 13 11 260 6005 5158 -10833 2 2 13 11 3761 5433 5839 -10834 2 2 13 11 4679 5521 6575 -10835 2 2 13 11 84 6799 5667 -10836 2 2 13 11 4196 5395 6409 -10837 2 2 13 11 4225 4926 6300 -10838 2 2 13 11 4226 6301 4927 -10839 2 2 13 11 3758 6910 4894 -10840 2 2 13 11 3875 5638 5148 -10841 2 2 13 11 3989 4923 6159 -10842 2 2 13 11 3867 4983 6464 -10843 2 2 13 11 4119 5072 6182 -10844 2 2 13 11 4568 6349 5382 -10845 2 2 13 11 4120 6183 5073 -10846 2 2 13 11 4029 5837 5147 -10847 2 2 13 11 4141 5127 6185 -10848 2 2 13 11 3981 5124 6571 -10849 2 2 13 11 3874 4969 5955 -10850 2 2 13 11 3876 5956 4970 -10851 2 2 13 11 4138 5588 5168 -10852 2 2 13 11 4139 5169 5589 -10853 2 2 13 11 1 6268 98 -10854 2 2 13 11 90 91 5617 -10855 2 2 13 11 3693 5996 5825 -10856 2 2 13 11 4150 5154 6788 -10857 2 2 13 11 151 152 5777 -10858 2 2 13 11 3679 5054 6059 -10859 2 2 13 11 4481 5474 6905 -10860 2 2 13 11 4389 6388 5111 -10861 2 2 13 11 4390 5112 6389 -10862 2 2 13 11 4119 6172 5810 -10863 2 2 13 11 4120 5811 6173 -10864 2 2 13 11 4949 5286 6174 -10865 2 2 13 11 3740 6143 5121 -10866 2 2 13 11 3782 5688 5088 -10867 2 2 13 11 4188 6612 4932 -10868 2 2 13 11 4406 5597 5439 -10869 2 2 13 11 4614 5464 6530 -10870 2 2 13 11 3711 6630 5250 -10871 2 2 13 11 4557 5592 5095 -10872 2 2 13 11 130 131 6266 -10873 2 2 13 11 4612 6155 6002 -10874 2 2 13 11 3686 5063 5803 -10875 2 2 13 11 3812 6864 4965 -10876 2 2 13 11 3813 4966 6865 -10877 2 2 13 11 4570 5745 5241 -10878 2 2 13 11 4255 5145 5551 -10879 2 2 13 11 4265 5992 5712 -10880 2 2 13 11 4266 5713 5993 -10881 2 2 13 11 4420 5804 5497 -10882 2 2 13 11 4597 6216 6921 -10883 2 2 13 11 3860 5948 5071 -10884 2 2 13 11 3698 5067 6455 -10885 2 2 13 11 4402 5025 6457 -10886 2 2 13 11 4642 5788 6816 -10887 2 2 13 11 4513 5504 6382 -10888 2 2 13 11 3861 4922 6497 -10889 2 2 13 11 4183 5871 5608 -10890 2 2 13 11 3821 4947 6146 -10891 2 2 13 11 6594 6090 4330 -10892 2 2 13 11 4305 6437 5008 -10893 2 2 13 11 4306 5009 6438 -10894 2 2 13 11 86 5607 6538 -10895 2 2 13 11 4313 5641 5246 -10896 2 2 13 11 4048 5317 6028 -10897 2 2 13 11 4049 6029 5318 -10898 2 2 13 11 3934 6795 4978 -10899 2 2 13 11 3935 4979 6796 -10900 2 2 13 11 4186 5838 5125 -10901 2 2 13 11 4155 6577 5728 -10902 2 2 13 11 4459 6487 6559 -10903 2 2 13 11 4227 5186 5672 -10904 2 2 13 11 4024 5290 6119 -10905 2 2 13 11 4569 6108 6052 -10906 2 2 13 11 4023 4936 6616 -10907 2 2 13 11 4414 5934 4935 -10908 2 2 13 11 4262 5612 6070 -10909 2 2 13 11 4263 6071 5613 -10910 2 2 13 11 4778 6924 5897 -10911 2 2 13 11 4779 5898 6925 -10912 2 2 13 11 4137 5079 6095 -10913 2 2 13 11 4158 6738 5057 -10914 2 2 13 11 4402 5714 5025 -10915 2 2 13 11 3803 4942 6169 -10916 2 2 13 11 4655 6798 4987 -10917 2 2 13 11 3804 5006 5893 -10918 2 2 13 11 3926 5237 5608 -10919 2 2 13 11 3805 5894 5007 -10920 2 2 13 11 284 6673 6663 -10921 2 2 13 11 4239 5012 5793 -10922 2 2 13 11 4053 5149 6286 -10923 2 2 13 11 4240 5794 5013 -10924 2 2 13 11 4195 5621 6402 -10925 2 2 13 11 138 139 6011 -10926 2 2 13 11 4132 4957 6491 -10927 2 2 13 11 4108 5658 5355 -10928 2 2 13 11 89 6374 5167 -10929 2 2 13 11 4283 5832 6131 -10930 2 2 13 11 4284 6132 5833 -10931 2 2 13 11 4022 4985 5753 -10932 2 2 13 11 4249 6808 4914 -10933 2 2 13 11 4321 5171 5564 -10934 2 2 13 11 4406 4981 6831 -10935 2 2 13 11 4159 5061 6763 -10936 2 2 13 11 114 115 5394 -10937 2 2 13 11 3706 5598 6595 -10938 2 2 13 11 4334 6935 4993 -10939 2 2 13 11 3668 5060 5726 -10940 2 2 13 11 4519 5829 5066 -10941 2 2 13 11 4164 5034 6239 -10942 2 2 13 11 4168 5782 6562 -10943 2 2 13 11 4296 6416 4998 -10944 2 2 13 11 4448 4943 6015 -10945 2 2 13 11 4385 6028 5317 -10946 2 2 13 11 4386 5318 6029 -10947 2 2 13 11 4076 5882 4981 -10948 2 2 13 11 4176 5041 5661 -10949 2 2 13 11 4243 5677 5376 -10950 2 2 13 11 4118 4992 5827 -10951 2 2 13 11 4244 5377 5678 -10952 2 2 13 11 4091 4999 5983 -10953 2 2 13 11 4363 6414 5202 -10954 2 2 13 11 4380 5512 5221 -10955 2 2 13 11 4181 5866 6593 -10956 2 2 13 11 3900 5984 5144 -10957 2 2 13 11 4010 5807 5134 -10958 2 2 13 11 4124 5148 5638 -10959 2 2 13 11 4537 6332 5579 -10960 2 2 13 11 4400 5185 6838 -10961 2 2 13 11 135 136 5474 -10962 2 2 13 11 4014 5287 6543 -10963 2 2 13 11 4715 5709 6405 -10964 2 2 13 11 4377 6530 5464 -10965 2 2 13 11 3833 5808 5145 -10966 2 2 13 11 3874 5955 5690 -10967 2 2 13 11 3876 5691 5956 -10968 2 2 13 11 4527 5086 5953 -10969 2 2 13 11 4528 5954 5087 -10970 2 2 13 11 3660 6588 5321 -10971 2 2 13 11 3794 5431 5265 -10972 2 2 13 11 3795 5266 5432 -10973 2 2 13 11 4305 5008 5918 -10974 2 2 13 11 4701 6610 5608 -10975 2 2 13 11 4156 5955 4969 -10976 2 2 13 11 4306 5919 5009 -10977 2 2 13 11 4157 4970 5956 -10978 2 2 13 11 4327 5593 5902 -10979 2 2 13 11 4231 6169 4942 -10980 2 2 13 11 3843 6398 5230 -10981 2 2 13 11 4449 5988 4955 -10982 2 2 13 11 4400 6406 5005 -10983 2 2 13 11 4477 4945 6042 -10984 2 2 13 11 4463 6571 5124 -10985 2 2 13 11 3728 6012 5874 -10986 2 2 13 11 4765 4971 6663 -10987 2 2 13 11 145 146 6324 -10988 2 2 13 11 5051 6780 6274 -10989 2 2 13 11 4445 6363 5297 -10990 2 2 13 11 3792 6210 4895 -10991 2 2 13 11 3793 4896 6211 -10992 2 2 13 11 4418 5999 4940 -10993 2 2 13 11 136 137 6420 -10994 2 2 13 11 4318 6730 4961 -10995 2 2 13 11 3944 6727 6682 -10996 2 2 13 11 3978 5051 6274 -10997 2 2 13 11 3888 6039 4986 -10998 2 2 13 11 4334 4993 6026 -10999 2 2 13 11 3791 5896 5456 -11000 2 2 13 11 4340 6288 4911 -11001 2 2 13 11 4341 4912 6289 -11002 2 2 13 11 4302 5376 5677 -11003 2 2 13 11 4303 5678 5377 -11004 2 2 13 11 3901 5223 6938 -11005 2 2 13 11 3836 5624 5298 -11006 2 2 13 11 3837 5299 5625 -11007 2 2 13 11 4241 6217 5027 -11008 2 2 13 11 4242 5028 6218 -11009 2 2 13 11 4585 6357 5494 -11010 2 2 13 11 1 99 6268 -11011 2 2 13 11 3825 6922 5015 -11012 2 2 13 11 4615 6044 6265 -11013 2 2 13 11 168 6897 5031 -11014 2 2 13 11 53 5032 6898 -11015 2 2 13 11 83 84 5667 -11016 2 2 13 11 4897 6056 6627 -11017 2 2 13 11 4898 6628 6057 -11018 2 2 13 11 4763 6596 4997 -11019 2 2 13 11 4762 6938 5563 -11020 2 2 13 11 4305 5313 5740 -11021 2 2 13 11 4010 6837 4958 -11022 2 2 13 11 4164 5649 5222 -11023 2 2 13 11 4306 5741 5316 -11024 2 2 13 11 4459 6559 5762 -11025 2 2 13 11 3884 5467 5758 -11026 2 2 13 11 4137 6095 6736 -11027 2 2 13 11 4296 5978 5120 -11028 2 2 13 11 3702 5666 6421 -11029 2 2 13 11 337 5031 6897 -11030 2 2 13 11 239 6898 5032 -11031 2 2 13 11 4504 6233 5392 -11032 2 2 13 11 4163 5164 6235 -11033 2 2 13 11 290 5620 291 -11034 2 2 13 11 4101 6735 4948 -11035 2 2 13 11 4376 5848 5520 -11036 2 2 13 11 128 129 6024 -11037 2 2 13 11 3770 5357 6791 -11038 2 2 13 11 4427 4960 6220 -11039 2 2 13 11 106 107 6542 -11040 2 2 13 11 4217 5311 5443 -11041 2 2 13 11 4903 6892 5275 -11042 2 2 13 11 4389 5815 5486 -11043 2 2 13 11 4390 5487 5816 -11044 2 2 13 11 3968 5008 6437 -11045 2 2 13 11 3969 6438 5009 -11046 2 2 13 11 3832 5447 5551 -11047 2 2 13 11 325 6532 5168 -11048 2 2 13 11 251 5169 6533 -11049 2 2 13 11 3919 5857 6338 -11050 2 2 13 11 3650 5002 6200 -11051 2 2 13 11 3741 5905 5301 -11052 2 2 13 11 4830 6207 5622 -11053 2 2 13 11 4376 5267 5848 -11054 2 2 13 11 3830 5010 6386 -11055 2 2 13 11 3831 6387 5011 -11056 2 2 13 11 4011 6895 4949 -11057 2 2 13 11 3816 5457 5846 -11058 2 2 13 11 3817 5847 5458 -11059 2 2 13 11 4103 5559 5156 -11060 2 2 13 11 4498 6613 5519 -11061 2 2 13 11 4534 5727 5414 -11062 2 2 13 11 4259 4941 6270 -11063 2 2 13 11 4316 6154 4971 -11064 2 2 13 11 4383 5839 5433 -11065 2 2 13 11 4743 5667 6799 -11066 2 2 13 11 3846 5828 5337 -11067 2 2 13 11 4209 5037 6034 -11068 2 2 13 11 276 5626 277 -11069 2 2 13 11 4058 5080 5855 -11070 2 2 13 11 3716 5365 5430 -11071 2 2 13 11 4253 6318 5005 -11072 2 2 13 11 4253 5005 6103 -11073 2 2 13 11 4304 6274 6780 -11074 2 2 13 11 4249 4914 6164 -11075 2 2 13 11 4213 5064 5861 -11076 2 2 13 11 4241 5298 5624 -11077 2 2 13 11 3870 5414 6093 -11078 2 2 13 11 4242 5625 5299 -11079 2 2 13 11 4289 5293 5849 -11080 2 2 13 11 4290 5850 5294 -11081 2 2 13 11 4851 6219 5482 -11082 2 2 13 11 4380 4952 6229 -11083 2 2 13 11 3797 6759 6358 -11084 2 2 13 11 3748 5000 6785 -11085 2 2 13 11 3798 6359 6760 -11086 2 2 13 11 3992 6472 5047 -11087 2 2 13 11 4350 6500 5929 -11088 2 2 13 11 4620 6277 6398 -11089 2 2 13 11 4747 6908 5020 -11090 2 2 13 11 4748 5021 6909 -11091 2 2 13 11 4355 6251 6478 -11092 2 2 13 11 4356 6479 6252 -11093 2 2 13 11 3889 6459 4990 -11094 2 2 13 11 3890 4991 6460 -11095 2 2 13 11 4741 6028 5212 -11096 2 2 13 11 4742 5213 6029 -11097 2 2 13 11 4506 5249 5545 -11098 2 2 13 11 4041 5849 5293 -11099 2 2 13 11 4042 5294 5850 -11100 2 2 13 11 4170 5515 6125 -11101 2 2 13 11 3828 5025 6001 -11102 2 2 13 11 4231 5511 6084 -11103 2 2 13 11 4541 6543 5287 -11104 2 2 13 11 4186 5153 6896 -11105 2 2 13 11 4441 5509 5238 -11106 2 2 13 11 4270 6146 4947 -11107 2 2 13 11 4442 5239 5510 -11108 2 2 13 11 4607 5852 6098 -11109 2 2 13 11 4608 6099 5853 -11110 2 2 13 11 3713 4998 6416 -11111 2 2 13 11 3868 5606 6531 -11112 2 2 13 11 3937 6844 5140 -11113 2 2 13 11 3794 5224 5628 -11114 2 2 13 11 4154 6023 5172 -11115 2 2 13 11 3795 5629 5226 -11116 2 2 13 11 300 5550 6729 -11117 2 2 13 11 131 132 5596 -11118 2 2 13 11 4953 6151 6674 -11119 2 2 13 11 4275 5627 6088 -11120 2 2 13 11 3897 5072 5810 -11121 2 2 13 11 4751 5690 5955 -11122 2 2 13 11 4752 5956 5691 -11123 2 2 13 11 3898 5811 5073 -11124 2 2 13 11 133 4962 5986 -11125 2 2 13 11 294 6794 295 -11126 2 2 13 11 4804 6338 5857 -11127 2 2 13 11 4421 5465 6053 -11128 2 2 13 11 4601 5165 6240 -11129 2 2 13 11 336 6549 337 -11130 2 2 13 11 239 6550 240 -11131 2 2 13 11 3978 6247 5051 -11132 2 2 13 11 3844 5520 5848 -11133 2 2 13 11 4033 5086 6855 -11134 2 2 13 11 4758 6560 5122 -11135 2 2 13 11 4034 6856 5087 -11136 2 2 13 11 4566 5914 5624 -11137 2 2 13 11 4567 5625 5916 -11138 2 2 13 11 3752 4913 6578 -11139 2 2 13 11 4170 6125 5544 -11140 2 2 13 11 3994 5001 6018 -11141 2 2 13 11 3862 5775 6832 -11142 2 2 13 11 4694 6613 6889 -11143 2 2 13 11 3840 5089 5963 -11144 2 2 13 11 4093 5901 6644 -11145 2 2 13 11 4338 5758 5467 -11146 2 2 13 11 4239 5772 6054 -11147 2 2 13 11 4821 6384 6622 -11148 2 2 13 11 4679 5929 6500 -11149 2 2 13 11 4240 6055 5773 -11150 2 2 13 11 3729 6732 6918 -11151 2 2 13 11 4847 6562 5782 -11152 2 2 13 11 4583 5717 5427 -11153 2 2 13 11 4834 6832 5775 -11154 2 2 13 11 3791 5052 5896 -11155 2 2 13 11 3782 4976 6208 -11156 2 2 13 11 4147 6737 5302 -11157 2 2 13 11 4061 6792 5018 -11158 2 2 13 11 4062 5019 6793 -11159 2 2 13 11 4117 5564 5320 -11160 2 2 13 11 3692 5058 5873 -11161 2 2 13 11 3729 6918 5900 -11162 2 2 13 11 81 82 5761 -11163 2 2 13 11 4169 6124 5514 -11164 2 2 13 11 3753 4977 6094 -11165 2 2 13 11 4030 6447 5063 -11166 2 2 13 11 4068 5069 5750 -11167 2 2 13 11 4684 6598 5684 -11168 2 2 13 11 4685 5685 6599 -11169 2 2 13 11 4066 5557 6634 -11170 2 2 13 11 4039 6162 5023 -11171 2 2 13 11 4209 6197 5037 -11172 2 2 13 11 4067 6635 5558 -11173 2 2 13 11 4152 5060 6573 -11174 2 2 13 11 4295 5104 6404 -11175 2 2 13 11 5420 6742 6467 -11176 2 2 13 11 4195 6402 5990 -11177 2 2 13 11 5171 6907 5973 -11178 2 2 13 11 3822 5545 5249 -11179 2 2 13 11 4580 5255 6483 -11180 2 2 13 11 4128 6098 5852 -11181 2 2 13 11 4129 5853 6099 -11182 2 2 13 11 4368 6699 5039 -11183 2 2 13 11 4411 5663 6391 -11184 2 2 13 11 4116 5378 5525 -11185 2 2 13 11 4412 6392 5664 -11186 2 2 13 11 102 103 6340 -11187 2 2 13 11 4169 5531 6124 -11188 2 2 13 11 4437 6891 5074 -11189 2 2 13 11 4264 5065 6432 -11190 2 2 13 11 4024 6720 4983 -11191 2 2 13 11 4295 5144 5984 -11192 2 2 13 11 3869 6339 5338 -11193 2 2 13 11 295 5989 296 -11194 2 2 13 11 4482 5606 6190 -11195 2 2 13 11 3719 4978 6685 -11196 2 2 13 11 3720 6686 4979 -11197 2 2 13 11 4853 6709 5209 -11198 2 2 13 11 3694 5904 5068 -11199 2 2 13 11 4229 5893 5006 -11200 2 2 13 11 140 141 5693 -11201 2 2 13 11 4230 5007 5894 -11202 2 2 13 11 316 6004 317 -11203 2 2 13 11 259 6005 260 -11204 2 2 13 11 4109 5767 5351 -11205 2 2 13 11 4175 5384 6805 -11206 2 2 13 11 4506 5140 6844 -11207 2 2 13 11 4485 5552 5763 -11208 2 2 13 11 4555 4990 6424 -11209 2 2 13 11 4556 6425 4991 -11210 2 2 13 11 3664 5297 6363 -11211 2 2 13 11 4200 5548 6522 -11212 2 2 13 11 4440 5469 5331 -11213 2 2 13 11 4353 5475 5846 -11214 2 2 13 11 4354 5847 5476 -11215 2 2 13 11 4542 6620 6340 -11216 2 2 13 11 4128 6903 5010 -11217 2 2 13 11 4129 5011 6904 -11218 2 2 13 11 4141 5760 5479 -11219 2 2 13 11 4436 5167 6684 -11220 2 2 13 11 3820 5022 5802 -11221 2 2 13 11 4760 6775 6597 -11222 2 2 13 11 4660 6421 5666 -11223 2 2 13 11 3661 4996 6703 -11224 2 2 13 11 4225 6236 5746 -11225 2 2 13 11 4226 5747 6237 -11226 2 2 13 11 4110 5029 5812 -11227 2 2 13 11 3853 5733 5345 -11228 2 2 13 11 4186 5642 5153 -11229 2 2 13 11 4288 5506 5867 -11230 2 2 13 11 4392 5411 6453 -11231 2 2 13 11 4393 6454 5412 -11232 2 2 13 11 4520 6751 5732 -11233 2 2 13 11 4179 6705 5100 -11234 2 2 13 11 3951 6034 5037 -11235 2 2 13 11 4784 6272 5690 -11236 2 2 13 11 4785 5691 6273 -11237 2 2 13 11 4044 5109 6365 -11238 2 2 13 11 4045 6366 5110 -11239 2 2 13 11 3809 6052 6108 -11240 2 2 13 11 3895 5717 6493 -11241 2 2 13 11 4358 5047 6472 -11242 2 2 13 11 3939 5562 5315 -11243 2 2 13 11 4168 6562 5824 -11244 2 2 13 11 4255 5842 5145 -11245 2 2 13 11 3690 5767 5123 -11246 2 2 13 11 3680 6009 6298 -11247 2 2 13 11 3681 6299 6010 -11248 2 2 13 11 4302 5964 5109 -11249 2 2 13 11 4303 5110 5965 -11250 2 2 13 11 152 153 6664 -11251 2 2 13 11 68 69 6665 -11252 2 2 13 11 3845 4997 6936 -11253 2 2 13 11 160 161 5583 -11254 2 2 13 11 60 61 5584 -11255 2 2 13 11 3659 5005 6318 -11256 2 2 13 11 4409 6106 5596 -11257 2 2 13 11 4123 6528 5706 -11258 2 2 13 11 3808 5135 5783 -11259 2 2 13 11 4307 5020 5966 -11260 2 2 13 11 4308 5967 5021 -11261 2 2 13 11 3850 5609 5256 -11262 2 2 13 11 4835 6261 5119 -11263 2 2 13 11 4189 4967 6128 -11264 2 2 13 11 4422 5456 5896 -11265 2 2 13 11 3679 6196 5054 -11266 2 2 13 11 4291 5051 6247 -11267 2 2 13 11 4602 6391 5663 -11268 2 2 13 11 4603 5664 6392 -11269 2 2 13 11 268 6090 269 -11270 2 2 13 11 111 6026 4993 -11271 2 2 13 11 4559 6085 5849 -11272 2 2 13 11 4245 5145 5808 -11273 2 2 13 11 4560 5850 6086 -11274 2 2 13 11 4416 6670 5058 -11275 2 2 13 11 4866 6587 6013 -11276 2 2 13 11 4483 5139 5917 -11277 2 2 13 11 4601 6083 5913 -11278 2 2 13 11 4131 5071 5948 -11279 2 2 13 11 4011 5163 6902 -11280 2 2 13 11 93 94 6853 -11281 2 2 13 11 4436 6434 5167 -11282 2 2 13 11 3993 4957 6743 -11283 2 2 13 11 132 133 5986 -11284 2 2 13 11 3797 6583 5219 -11285 2 2 13 11 3798 5220 6584 -11286 2 2 13 11 4300 5486 5815 -11287 2 2 13 11 4301 5816 5487 -11288 2 2 13 11 4663 6878 5102 -11289 2 2 13 11 4664 5103 6879 -11290 2 2 13 11 3949 5044 6226 -11291 2 2 13 11 4184 5382 5973 -11292 2 2 13 11 4538 5238 6926 -11293 2 2 13 11 4539 6927 5239 -11294 2 2 13 11 4592 6114 5035 -11295 2 2 13 11 4593 5036 6115 -11296 2 2 13 11 4283 6131 5601 -11297 2 2 13 11 4284 5602 6132 -11298 2 2 13 11 3960 5035 6249 -11299 2 2 13 11 3961 6250 5036 -11300 2 2 13 11 4185 5963 5089 -11301 2 2 13 11 4493 5315 5562 -11302 2 2 13 11 4808 5925 5656 -11303 2 2 13 11 3936 5491 6440 -11304 2 2 13 11 3828 5590 5215 -11305 2 2 13 11 3829 5216 5591 -11306 2 2 13 11 3988 6622 6384 -11307 2 2 13 11 3834 6053 5465 -11308 2 2 13 11 4491 6890 6302 -11309 2 2 13 11 141 5146 5693 -11310 2 2 13 11 4259 5101 6011 -11311 2 2 13 11 286 5568 287 -11312 2 2 13 11 3762 6037 5027 -11313 2 2 13 11 4076 4963 6436 -11314 2 2 13 11 3763 5028 6038 -11315 2 2 13 11 3710 5764 6136 -11316 2 2 13 11 4132 6334 5896 -11317 2 2 13 11 285 6154 286 -11318 2 2 13 11 4186 5260 5838 -11319 2 2 13 11 4320 5952 5603 -11320 2 2 13 11 4006 5022 6498 -11321 2 2 13 11 4273 6683 6051 -11322 2 2 13 11 4809 6148 6368 -11323 2 2 13 11 4810 6369 6150 -11324 2 2 13 11 4207 5628 5224 -11325 2 2 13 11 4208 5226 5629 -11326 2 2 13 11 4798 6165 6783 -11327 2 2 13 11 4014 4992 6739 -11328 2 2 13 11 4830 6014 6647 -11329 2 2 13 11 127 5468 6931 -11330 2 2 13 11 4288 5147 5837 -11331 2 2 13 11 4361 6238 5243 -11332 2 2 13 11 4307 5457 6631 -11333 2 2 13 11 4308 6632 5458 -11334 2 2 13 11 4274 5750 5913 -11335 2 2 13 11 4837 6827 6249 -11336 2 2 13 11 4838 6250 6828 -11337 2 2 13 11 4054 4996 6719 -11338 2 2 13 11 4667 6187 5132 -11339 2 2 13 11 4795 6334 6491 -11340 2 2 13 11 4668 5133 6188 -11341 2 2 13 11 4782 6420 6857 -11342 2 2 13 11 3652 6223 6747 -11343 2 2 13 11 4267 6127 6829 -11344 2 2 13 11 4285 6297 5108 -11345 2 2 13 11 3827 6390 5202 -11346 2 2 13 11 4241 5624 5914 -11347 2 2 13 11 4242 5916 5625 -11348 2 2 13 11 3945 6587 5194 -11349 2 2 13 11 3726 5969 5108 -11350 2 2 13 11 4467 5177 6827 -11351 2 2 13 11 4468 6828 5178 -11352 2 2 13 11 4445 5297 6418 -11353 2 2 13 11 4431 6722 5282 -11354 2 2 13 11 3910 5243 6238 -11355 2 2 13 11 4432 5283 6723 -11356 2 2 13 11 4148 5439 5597 -11357 2 2 13 11 4193 5693 5146 -11358 2 2 13 11 4278 6196 6824 -11359 2 2 13 11 4346 6365 5109 -11360 2 2 13 11 4302 5489 6109 -11361 2 2 13 11 4303 6111 5490 -11362 2 2 13 11 4347 5110 6366 -11363 2 2 13 11 4788 5492 6508 -11364 2 2 13 11 303 6220 304 -11365 2 2 13 11 88 5167 6434 -11366 2 2 13 11 331 5966 332 -11367 2 2 13 11 244 5967 245 -11368 2 2 13 11 4641 6078 5725 -11369 2 2 13 11 3843 5748 6409 -11370 2 2 13 11 4314 5177 6426 -11371 2 2 13 11 4315 6427 5178 -11372 2 2 13 11 3945 6013 6587 -11373 2 2 13 11 4113 6315 5190 -11374 2 2 13 11 4183 5608 5237 -11375 2 2 13 11 4200 6522 6652 -11376 2 2 13 11 3814 5420 6467 -11377 2 2 13 11 4203 5068 5904 -11378 2 2 13 11 3832 5551 5570 -11379 2 2 13 11 4025 5522 6907 -11380 2 2 13 11 4179 6523 5119 -11381 2 2 13 11 4417 5230 6398 -11382 2 2 13 11 332 6908 333 -11383 2 2 13 11 243 6909 244 -11384 2 2 13 11 4351 5113 5942 -11385 2 2 13 11 4352 5943 5114 -11386 2 2 13 11 4373 5082 6480 -11387 2 2 13 11 3778 5760 5192 -11388 2 2 13 11 4482 6531 5606 -11389 2 2 13 11 4928 5321 6588 -11390 2 2 13 11 3758 5818 5126 -11391 2 2 13 11 283 6673 284 -11392 2 2 13 11 4438 6035 6298 -11393 2 2 13 11 4439 6299 6036 -11394 2 2 13 11 324 6532 325 -11395 2 2 13 11 251 6533 252 -11396 2 2 13 11 4580 6483 6021 -11397 2 2 13 11 4350 6162 6292 -11398 2 2 13 11 294 5043 6794 -11399 2 2 13 11 4171 6059 5054 -11400 2 2 13 11 4661 5499 6826 -11401 2 2 13 11 4289 5349 5869 -11402 2 2 13 11 4290 5870 5350 -11403 2 2 13 11 4191 6431 5118 -11404 2 2 13 11 3711 5179 5856 -11405 2 2 13 11 4289 5849 6085 -11406 2 2 13 11 4290 6086 5850 -11407 2 2 13 11 4697 6701 4984 -11408 2 2 13 11 3807 5069 6734 -11409 2 2 13 11 3990 5039 6699 -11410 2 2 13 11 3768 5272 6693 -11411 2 2 13 11 3954 6495 6836 -11412 2 2 13 11 4059 6684 5167 -11413 2 2 13 11 3834 5093 6053 -11414 2 2 13 11 153 154 5668 -11415 2 2 13 11 67 68 5669 -11416 2 2 13 11 3850 5074 6891 -11417 2 2 13 11 108 109 5604 -11418 2 2 13 11 4614 5827 6578 -11419 2 2 13 11 3818 5573 6896 -11420 2 2 13 11 3927 5190 6315 -11421 2 2 13 11 4154 5291 6023 -11422 2 2 13 11 4401 5621 5569 -11423 2 2 13 11 307 5622 308 -11424 2 2 13 11 3804 5893 5981 -11425 2 2 13 11 4383 5092 6379 -11426 2 2 13 11 3805 5982 5894 -11427 2 2 13 11 272 5347 6147 -11428 2 2 13 11 4374 6393 5628 -11429 2 2 13 11 4375 5629 6394 -11430 2 2 13 11 3671 5040 6084 -11431 2 2 13 11 4196 6362 5125 -11432 2 2 13 11 4188 5091 5884 -11433 2 2 13 11 304 6452 305 -11434 2 2 13 11 4879 6329 6724 -11435 2 2 13 11 4323 6368 6148 -11436 2 2 13 11 4324 6150 6369 -11437 2 2 13 11 3939 5730 5562 -11438 2 2 13 11 4224 6886 6039 -11439 2 2 13 11 4340 5298 6037 -11440 2 2 13 11 4341 6038 5299 -11441 2 2 13 11 4236 5961 5928 -11442 2 2 13 11 3668 5541 5990 -11443 2 2 13 11 4986 6039 6886 -11444 2 2 13 11 4832 6668 6286 -11445 2 2 13 11 3682 6749 5160 -11446 2 2 13 11 4570 6440 5491 -11447 2 2 13 11 3683 5161 6750 -11448 2 2 13 11 3698 6455 5912 -11449 2 2 13 11 4724 5470 6711 -11450 2 2 13 11 4099 5869 5349 -11451 2 2 13 11 4100 5350 5870 -11452 2 2 13 11 4569 5223 6108 -11453 2 2 13 11 4346 6734 5069 -11454 2 2 13 11 4025 5778 5522 -11455 2 2 13 11 4314 6426 4974 -11456 2 2 13 11 4315 4975 6427 -11457 2 2 13 11 3684 5257 5634 -11458 2 2 13 11 3685 5635 5258 -11459 2 2 13 11 3731 5008 6109 -11460 2 2 13 11 4513 6276 5519 -11461 2 2 13 11 3732 6111 5009 -11462 2 2 13 11 4003 5768 5184 -11463 2 2 13 11 3774 5911 5122 -11464 2 2 13 11 4087 5270 6603 -11465 2 2 13 11 5608 5871 6887 -11466 2 2 13 11 281 5310 6537 -11467 2 2 13 11 3835 5724 5191 -11468 2 2 13 11 3819 5484 5736 -11469 2 2 13 11 146 6435 5131 -11470 2 2 13 11 3957 6850 6494 -11471 2 2 13 11 4197 5305 5836 -11472 2 2 13 11 3694 5068 6335 -11473 2 2 13 11 4031 6418 5297 -11474 2 2 13 11 3825 5196 6488 -11475 2 2 13 11 4672 6503 5045 -11476 2 2 13 11 3982 5081 6227 -11477 2 2 13 11 4673 5046 6504 -11478 2 2 13 11 4454 6776 5780 -11479 2 2 13 11 4035 5994 5070 -11480 2 2 13 11 4566 5624 6478 -11481 2 2 13 11 4567 6479 5625 -11482 2 2 13 11 3727 5039 6262 -11483 2 2 13 11 4258 6590 5997 -11484 2 2 13 11 3684 5634 6396 -11485 2 2 13 11 4054 6719 5407 -11486 2 2 13 11 3685 6397 5635 -11487 2 2 13 11 3705 6451 5790 -11488 2 2 13 11 3996 6926 5238 -11489 2 2 13 11 3997 5239 6927 -11490 2 2 13 11 4274 5913 6083 -11491 2 2 13 11 4675 6671 5300 -11492 2 2 13 11 138 5101 6857 -11493 2 2 13 11 4526 5596 6106 -11494 2 2 13 11 4591 6136 5764 -11495 2 2 13 11 4192 5485 6292 -11496 2 2 13 11 4583 5706 6528 -11497 2 2 13 11 4536 5928 5961 -11498 2 2 13 11 4369 6821 5387 -11499 2 2 13 11 4371 5388 6822 -11500 2 2 13 11 4456 6727 6072 -11501 2 2 13 11 3672 6279 5026 -11502 2 2 13 11 4544 5679 6886 -11503 2 2 13 11 4819 6694 5869 -11504 2 2 13 11 4820 5870 6695 -11505 2 2 13 11 4179 5474 6420 -11506 2 2 13 11 4644 5218 5776 -11507 2 2 13 11 4627 5182 6096 -11508 2 2 13 11 4278 5054 6196 -11509 2 2 13 11 4628 6097 5183 -11510 2 2 13 11 4132 6491 6334 -11511 2 2 13 11 4547 5981 5893 -11512 2 2 13 11 4548 5894 5982 -11513 2 2 13 11 122 6569 6608 -11514 2 2 13 11 4431 5282 6924 -11515 2 2 13 11 4432 6925 5283 -11516 2 2 13 11 4730 6931 5468 -11517 2 2 13 11 4498 5351 5767 -11518 2 2 13 11 4130 5895 5233 -11519 2 2 13 11 3978 4998 6247 -11520 2 2 13 11 125 126 5695 -11521 2 2 13 11 4607 6009 5461 -11522 2 2 13 11 4608 5463 6010 -11523 2 2 13 11 4527 5953 6194 -11524 2 2 13 11 4528 6195 5954 -11525 2 2 13 11 3960 6827 5177 -11526 2 2 13 11 3961 5178 6828 -11527 2 2 13 11 271 6873 5347 -11528 2 2 13 11 4028 5186 5809 -11529 2 2 13 11 3900 5144 6083 -11530 2 2 13 11 4894 6142 5075 -11531 2 2 13 11 3726 5108 6297 -11532 2 2 13 11 4620 5307 6277 -11533 2 2 13 11 336 5055 6549 -11534 2 2 13 11 240 6550 5056 -11535 2 2 13 11 4195 5569 5621 -11536 2 2 13 11 4463 5124 6797 -11537 2 2 13 11 4756 5636 6867 -11538 2 2 13 11 4757 6869 5637 -11539 2 2 13 11 4586 5979 5152 -11540 2 2 13 11 4775 6896 5573 -11541 2 2 13 11 3809 6108 5076 -11542 2 2 13 11 3826 5804 5374 -11543 2 2 13 11 4204 5363 5554 -11544 2 2 13 11 4205 5555 5364 -11545 2 2 13 11 4069 6773 4987 -11546 2 2 13 11 3682 5160 5914 -11547 2 2 13 11 3683 5916 5161 -11548 2 2 13 11 4488 5719 6786 -11549 2 2 13 11 4489 6787 5720 -11550 2 2 13 11 4179 5100 6523 -11551 2 2 13 11 311 5663 312 -11552 2 2 13 11 264 5664 265 -11553 2 2 13 11 4355 5251 6251 -11554 2 2 13 11 4356 6252 5252 -11555 2 2 13 11 3826 5016 6151 -11556 2 2 13 11 3958 5082 6883 -11557 2 2 13 11 3978 6274 5026 -11558 2 2 13 11 4002 6239 5034 -11559 2 2 13 11 4457 5062 6205 -11560 2 2 13 11 3655 6716 5165 -11561 2 2 13 11 4011 5776 5218 -11562 2 2 13 11 4193 5766 5217 -11563 2 2 13 11 3968 5636 5376 -11564 2 2 13 11 3969 5377 5637 -11565 2 2 13 11 288 6564 5362 -11566 2 2 13 11 4181 5737 5193 -11567 2 2 13 11 4217 5443 5998 -11568 2 2 13 11 3968 6867 5636 -11569 2 2 13 11 3969 5637 6869 -11570 2 2 13 11 4275 5974 5911 -11571 2 2 13 11 4269 5163 6174 -11572 2 2 13 11 4568 5368 5845 -11573 2 2 13 11 282 6537 5372 -11574 2 2 13 11 4487 6777 5880 -11575 2 2 13 11 4287 6724 6329 -11576 2 2 13 11 4402 6457 5859 -11577 2 2 13 11 4403 5860 6458 -11578 2 2 13 11 3801 6797 5124 -11579 2 2 13 11 4766 6907 5522 -11580 2 2 13 11 4345 6400 5994 -11581 2 2 13 11 4584 5407 6719 -11582 2 2 13 11 4271 6203 5647 -11583 2 2 13 11 4272 5648 6204 -11584 2 2 13 11 4274 5269 5750 -11585 2 2 13 11 3689 4999 6448 -11586 2 2 13 11 3981 5017 6594 -11587 2 2 13 11 4262 5136 6372 -11588 2 2 13 11 4263 6373 5137 -11589 2 2 13 11 3863 5173 5897 -11590 2 2 13 11 3864 5898 5174 -11591 2 2 13 11 4282 6228 5680 -11592 2 2 13 11 4269 5989 5116 -11593 2 2 13 11 4104 5373 6698 -11594 2 2 13 11 4194 5262 5805 -11595 2 2 13 11 4986 6886 5679 -11596 2 2 13 11 4396 5018 6178 -11597 2 2 13 11 4397 6179 5019 -11598 2 2 13 11 4278 6093 5054 -11599 2 2 13 11 4585 6433 5650 -11600 2 2 13 11 4357 5240 6650 -11601 2 2 13 11 3930 6078 6681 -11602 2 2 13 11 4033 6855 5719 -11603 2 2 13 11 4034 5720 6856 -11604 2 2 13 11 3937 6145 6844 -11605 2 2 13 11 4337 5607 5946 -11606 2 2 13 11 4859 6063 6017 -11607 2 2 13 11 3806 5155 6265 -11608 2 2 13 11 3848 5519 6276 -11609 2 2 13 11 4344 5084 6311 -11610 2 2 13 11 4475 5160 6749 -11611 2 2 13 11 4476 6750 5161 -11612 2 2 13 11 4291 6512 5051 -11613 2 2 13 11 167 6524 5077 -11614 2 2 13 11 54 5078 6525 -11615 2 2 13 11 4194 5170 6450 -11616 2 2 13 11 4147 5861 6737 -11617 2 2 13 11 4823 6736 6095 -11618 2 2 13 11 4248 5856 5179 -11619 2 2 13 11 4214 6153 5198 -11620 2 2 13 11 4360 5455 6324 -11621 2 2 13 11 4559 5849 6459 -11622 2 2 13 11 4560 6460 5850 -11623 2 2 13 11 3725 5704 5247 -11624 2 2 13 11 4292 6207 5214 -11625 2 2 13 11 4297 6335 5068 -11626 2 2 13 11 4727 6463 6385 -11627 2 2 13 11 3692 6733 5058 -11628 2 2 13 11 4163 5764 5164 -11629 2 2 13 11 3794 5265 5692 -11630 2 2 13 11 3889 5514 6459 -11631 2 2 13 11 3890 6460 5515 -11632 2 2 13 11 3795 5694 5266 -11633 2 2 13 11 4486 6880 5214 -11634 2 2 13 11 4707 6824 6196 -11635 2 2 13 11 3866 6309 5084 -11636 2 2 13 11 4344 5672 6202 -11637 2 2 13 11 3843 6409 6687 -11638 2 2 13 11 4004 5075 6142 -11639 2 2 13 11 4192 6017 6063 -11640 2 2 13 11 3869 5338 6225 -11641 2 2 13 11 4261 5576 5704 -11642 2 2 13 11 3960 6249 6827 -11643 2 2 13 11 3961 6828 6250 -11644 2 2 13 11 4011 6174 5163 -11645 2 2 13 11 4483 6577 5831 -11646 2 2 13 11 4809 5719 6855 -11647 2 2 13 11 4810 6856 5720 -11648 2 2 13 11 269 6707 270 -11649 2 2 13 11 3980 5881 6319 -11650 2 2 13 11 3654 6133 5045 -11651 2 2 13 11 3653 5046 6134 -11652 2 2 13 11 3691 5234 6689 -11653 2 2 13 11 3970 5040 6671 -11654 2 2 13 11 143 144 5907 -11655 2 2 13 11 4759 5912 6455 -11656 2 2 13 11 3655 5165 6118 -11657 2 2 13 11 4604 6163 5505 -11658 2 2 13 11 4224 5191 5724 -11659 2 2 13 11 4239 6054 5529 -11660 2 2 13 11 4325 5548 5547 -11661 2 2 13 11 4240 5530 6055 -11662 2 2 13 11 4830 6647 6207 -11663 2 2 13 11 3906 6490 5381 -11664 2 2 13 11 4522 6645 5072 -11665 2 2 13 11 3994 6018 5175 -11666 2 2 13 11 4523 5073 6646 -11667 2 2 13 11 4041 6251 5251 -11668 2 2 13 11 4042 5252 6252 -11669 2 2 13 11 4558 5134 6946 -11670 2 2 13 11 4147 5699 5256 -11671 2 2 13 11 4028 6692 5049 -11672 2 2 13 11 4027 5066 6560 -11673 2 2 13 11 4424 6276 6382 -11674 2 2 13 11 4545 5812 6655 -11675 2 2 13 11 3993 6743 5074 -11676 2 2 13 11 4274 6083 5144 -11677 2 2 13 11 4547 6803 5150 -11678 2 2 13 11 4115 6751 5945 -11679 2 2 13 11 4227 5672 5346 -11680 2 2 13 11 4548 5151 6804 -11681 2 2 13 11 3739 6042 5175 -11682 2 2 13 11 4518 6537 5310 -11683 2 2 13 11 4203 6121 5068 -11684 2 2 13 11 3708 5117 6198 -11685 2 2 13 11 135 5474 6660 -11686 2 2 13 11 4534 6718 5727 -11687 2 2 13 11 3888 5841 6116 -11688 2 2 13 11 4836 5780 6776 -11689 2 2 13 11 4369 6243 5885 -11690 2 2 13 11 4371 5886 6244 -11691 2 2 13 11 4252 6279 5392 -11692 2 2 13 11 4054 6242 5253 -11693 2 2 13 11 5150 6803 6078 -11694 2 2 13 11 4164 5222 5732 -11695 2 2 13 11 3909 5100 6705 -11696 2 2 13 11 163 5369 6327 -11697 2 2 13 11 58 6328 5370 -11698 2 2 13 11 4253 5140 6318 -11699 2 2 13 11 3689 6095 5079 -11700 2 2 13 11 3933 6834 5922 -11701 2 2 13 11 4185 5089 6544 -11702 2 2 13 11 4545 6152 5812 -11703 2 2 13 11 4448 5165 6716 -11704 2 2 13 11 3791 6413 5001 -11705 2 2 13 11 4068 5750 5269 -11706 2 2 13 11 4381 6860 5038 -11707 2 2 13 11 4155 5728 5332 -11708 2 2 13 11 4572 6634 5557 -11709 2 2 13 11 4573 5558 6635 -11710 2 2 13 11 74 6380 5386 -11711 2 2 13 11 4467 5333 6839 -11712 2 2 13 11 3840 5786 5587 -11713 2 2 13 11 4468 6840 5334 -11714 2 2 13 11 4260 5665 5563 -11715 2 2 13 11 4445 6488 5196 -11716 2 2 13 11 4616 6167 5336 -11717 2 2 13 11 4643 5355 5658 -11718 2 2 13 11 92 93 5806 -11719 2 2 13 11 3662 5129 6303 -11720 2 2 13 11 3663 6304 5130 -11721 2 2 13 11 103 104 5980 -11722 2 2 13 11 4185 5361 5654 -11723 2 2 13 11 4812 6747 6565 -11724 2 2 13 11 4527 5132 6187 -11725 2 2 13 11 4528 6188 5133 -11726 2 2 13 11 4417 6398 6277 -11727 2 2 13 11 3974 5214 6207 -11728 2 2 13 11 4479 6286 6668 -11729 2 2 13 11 4701 6659 6610 -11730 2 2 13 11 4180 5718 5546 -11731 2 2 13 11 4210 6447 5159 -11732 2 2 13 11 3697 5284 6711 -11733 2 2 13 11 3825 6488 5796 -11734 2 2 13 11 4241 5914 5160 -11735 2 2 13 11 4242 5161 5916 -11736 2 2 13 11 4317 6539 5063 -11737 2 2 13 11 4271 6096 5182 -11738 2 2 13 11 4272 5183 6097 -11739 2 2 13 11 4410 5426 6323 -11740 2 2 13 11 4222 5190 5968 -11741 2 2 13 11 3990 6699 6858 -11742 2 2 13 11 4265 5168 6532 -11743 2 2 13 11 4266 6533 5169 -11744 2 2 13 11 3927 5968 5190 -11745 2 2 13 11 4215 6664 5668 -11746 2 2 13 11 4216 5669 6665 -11747 2 2 13 11 3797 5434 6583 -11748 2 2 13 11 3798 6584 5435 -11749 2 2 13 11 3665 6185 5127 -11750 2 2 13 11 4300 5387 6821 -11751 2 2 13 11 4301 6822 5388 -11752 2 2 13 11 4512 6588 5950 -11753 2 2 13 11 4942 6429 5197 -11754 2 2 13 11 4271 5157 5939 -11755 2 2 13 11 4272 5940 5158 -11756 2 2 13 11 4559 6459 5514 -11757 2 2 13 11 4560 5515 6460 -11758 2 2 13 11 4124 5638 5448 -11759 2 2 13 11 4738 6344 5146 -11760 2 2 13 11 3662 6368 5129 -11761 2 2 13 11 3663 5130 6369 -11762 2 2 13 11 4457 5448 5638 -11763 2 2 13 11 4416 5058 6733 -11764 2 2 13 11 4326 6561 5128 -11765 2 2 13 11 3952 5172 6023 -11766 2 2 13 11 4431 6327 5369 -11767 2 2 13 11 4432 5370 6328 -11768 2 2 13 11 4258 5735 6590 -11769 2 2 13 11 4423 5268 6350 -11770 2 2 13 11 4455 5386 6380 -11771 2 2 13 11 4227 5809 5186 -11772 2 2 13 11 4576 5495 6706 -11773 2 2 13 11 4061 5141 6792 -11774 2 2 13 11 4062 6793 5142 -11775 2 2 13 11 3797 6358 5035 -11776 2 2 13 11 3798 5036 6359 -11777 2 2 13 11 4297 5068 6401 -11778 2 2 13 11 4265 5712 5445 -11779 2 2 13 11 4266 5446 5713 -11780 2 2 13 11 4243 5376 5636 -11781 2 2 13 11 4244 5637 5377 -11782 2 2 13 11 4013 6672 6431 -11783 2 2 13 11 4531 6654 5991 -11784 2 2 13 11 4494 6275 5769 -11785 2 2 13 11 4349 5587 5786 -11786 2 2 13 11 4179 5119 6905 -11787 2 2 13 11 4194 6450 6456 -11788 2 2 13 11 3713 5729 5332 -11789 2 2 13 11 3814 5512 6137 -11790 2 2 13 11 4378 5972 5565 -11791 2 2 13 11 4655 6919 6798 -11792 2 2 13 11 4271 5939 6203 -11793 2 2 13 11 4272 6204 5940 -11794 2 2 13 11 4292 5622 6207 -11795 2 2 13 11 4330 5124 6594 -11796 2 2 13 11 4268 5572 5902 -11797 2 2 13 11 4020 6345 5282 -11798 2 2 13 11 4021 5283 6346 -11799 2 2 13 11 3974 6207 6647 -11800 2 2 13 11 4322 6748 5121 -11801 2 2 13 11 4728 6608 6569 -11802 2 2 13 11 4640 5281 5844 -11803 2 2 13 11 4428 6715 5259 -11804 2 2 13 11 4512 5950 5657 -11805 2 2 13 11 3652 5307 6223 -11806 2 2 13 11 312 5663 5822 -11807 2 2 13 11 264 5823 5664 -11808 2 2 13 11 3810 5051 6512 -11809 2 2 13 11 3982 6227 6876 -11810 2 2 13 11 4319 6385 5191 -11811 2 2 13 11 4271 6004 5157 -11812 2 2 13 11 4272 5158 6005 -11813 2 2 13 11 3838 5387 5815 -11814 2 2 13 11 3839 5816 5388 -11815 2 2 13 11 76 77 5883 -11816 2 2 13 11 4055 6648 5111 -11817 2 2 13 11 4056 5112 6649 -11818 2 2 13 11 3650 5229 6025 -11819 2 2 13 11 121 6608 5047 -11820 2 2 13 11 4171 5414 5727 -11821 2 2 13 11 4932 6612 5665 -11822 2 2 13 11 4221 6377 5193 -11823 2 2 13 11 3773 5119 6523 -11824 2 2 13 11 4307 5966 6942 -11825 2 2 13 11 317 6004 5182 -11826 2 2 13 11 4308 6943 5967 -11827 2 2 13 11 259 5183 6005 -11828 2 2 13 11 4416 6141 6670 -11829 2 2 13 11 4030 5063 6539 -11830 2 2 13 11 4887 6496 6417 -11831 2 2 13 11 3810 6780 5051 -11832 2 2 13 11 4405 6225 5338 -11833 2 2 13 11 3670 6715 5095 -11834 2 2 13 11 109 6581 5604 -11835 2 2 13 11 4436 5946 5607 -11836 2 2 13 11 4907 6670 6141 -11837 2 2 13 11 5104 6950 6404 -11838 2 2 13 11 4427 5378 6383 -11839 2 2 13 11 4166 5942 5639 -11840 2 2 13 11 4167 5640 5943 -11841 2 2 13 11 4727 5232 6230 -11842 2 2 13 11 3937 5140 6296 -11843 2 2 13 11 3808 6852 5135 -11844 2 2 13 11 4191 5289 6047 -11845 2 2 13 11 4411 5822 5663 -11846 2 2 13 11 4412 5664 5823 -11847 2 2 13 11 4088 5805 5262 -11848 2 2 13 11 4006 6498 5131 -11849 2 2 13 11 4521 6640 5792 -11850 2 2 13 11 312 5822 313 -11851 2 2 13 11 263 5823 264 -11852 2 2 13 11 149 6350 5268 -11853 2 2 13 11 4443 6227 5454 -11854 2 2 13 11 4674 6319 5881 -11855 2 2 13 11 4024 6119 6720 -11856 2 2 13 11 4669 5796 6488 -11857 2 2 13 11 2 123 6569 -11858 2 2 13 11 4309 5143 6513 -11859 2 2 13 11 4151 5427 5717 -11860 2 2 13 11 3729 5813 6732 -11861 2 2 13 11 4472 5357 5775 -11862 2 2 13 11 4347 5135 6852 -11863 2 2 13 11 4420 5722 5339 -11864 2 2 13 11 4261 5704 6257 -11865 2 2 13 11 4926 6316 5352 -11866 2 2 13 11 4927 5353 6317 -11867 2 2 13 11 4249 5139 6808 -11868 2 2 13 11 4250 5263 6370 -11869 2 2 13 11 3823 5358 6128 -11870 2 2 13 11 4251 6371 5264 -11871 2 2 13 11 5118 6431 6672 -11872 2 2 13 11 4428 6514 6213 -11873 2 2 13 11 4500 6950 5104 -11874 2 2 13 11 3846 5838 5260 -11875 2 2 13 11 3871 5565 5972 -11876 2 2 13 11 4339 5938 5250 -11877 2 2 13 11 3971 6417 6496 -11878 2 2 13 11 4447 5900 5808 -11879 2 2 13 11 4200 5547 5548 -11880 2 2 13 11 4074 5469 6508 -11881 2 2 13 11 3981 6594 5124 -11882 2 2 13 11 3878 6706 5495 -11883 2 2 13 11 4116 6383 5378 -11884 2 2 13 11 3982 6876 5743 -11885 2 2 13 11 4114 5198 6234 -11886 2 2 13 11 4152 6137 5512 -11887 2 2 13 11 3758 5126 6910 -11888 2 2 13 11 126 6931 5695 -11889 2 2 13 11 4456 6452 6727 -11890 2 2 13 11 4392 5282 6345 -11891 2 2 13 11 4393 6346 5283 -11892 2 2 13 11 4036 5408 6066 -11893 2 2 13 11 146 147 6435 -11894 2 2 13 11 3983 5128 6561 -11895 2 2 13 11 3818 6896 5153 -11896 2 2 13 11 4213 6175 5274 -11897 2 2 13 11 4159 6265 5155 -11898 2 2 13 11 4574 6051 6683 -11899 2 2 13 11 4588 5407 5958 -11900 2 2 13 11 2 6569 122 -11901 2 2 13 11 5511 6843 6084 -11902 2 2 13 11 101 5385 6769 -11903 2 2 13 11 4077 6168 5280 -11904 2 2 13 11 3701 5563 5665 -11905 2 2 13 11 4296 5723 6756 -11906 2 2 13 11 4387 6585 5100 -11907 2 2 13 11 4338 6231 5692 -11908 2 2 13 11 4228 6025 5229 -11909 2 2 13 11 4345 5994 5248 -11910 2 2 13 11 4017 5097 6546 -11911 2 2 13 11 4298 5295 6770 -11912 2 2 13 11 4299 6771 5296 -11913 2 2 13 11 4018 6547 5098 -11914 2 2 13 11 4296 6756 6044 -11915 2 2 13 11 5040 5300 6671 -11916 2 2 13 11 4212 5320 6349 -11917 2 2 13 11 4510 6030 5173 -11918 2 2 13 11 4511 5174 6031 -11919 2 2 13 11 4960 6727 6452 -11920 2 2 13 11 4089 5519 6613 -11921 2 2 13 11 4695 5441 6060 -11922 2 2 13 11 4696 6061 5442 -11923 2 2 13 11 4358 5166 6140 -11924 2 2 13 11 4692 5659 5963 -11925 2 2 13 11 4194 5937 5170 -11926 2 2 13 11 3974 6816 5214 -11927 2 2 13 11 3699 5125 6362 -11928 2 2 13 11 3772 6718 5752 -11929 2 2 13 11 4261 5877 6721 -11930 2 2 13 11 4355 6341 5251 -11931 2 2 13 11 4356 5252 6343 -11932 2 2 13 11 4753 5969 6623 -11933 2 2 13 11 284 6663 285 -11934 2 2 13 11 4279 6181 5195 -11935 2 2 13 11 3849 6323 5426 -11936 2 2 13 11 4472 6791 5357 -11937 2 2 13 11 3688 6808 5139 -11938 2 2 13 11 4072 6675 5076 -11939 2 2 13 11 3913 6941 6041 -11940 2 2 13 11 3792 5188 6210 -11941 2 2 13 11 3793 6211 5189 -11942 2 2 13 11 3835 5191 6385 -11943 2 2 13 11 4247 5175 6018 -11944 2 2 13 11 3850 6545 5074 -11945 2 2 13 11 4160 5337 5828 -11946 2 2 13 11 4485 6436 5644 -11947 2 2 13 11 4218 6759 5219 -11948 2 2 13 11 4219 5220 6760 -11949 2 2 13 11 4826 6576 5600 -11950 2 2 13 11 3931 6192 5151 -11951 2 2 13 11 3867 6464 5728 -11952 2 2 13 11 3788 6737 5064 -11953 2 2 13 11 121 122 6608 -11954 2 2 13 11 4086 5187 6284 -11955 2 2 13 11 4213 5609 6332 -11956 2 2 13 11 3870 5198 6153 -11957 2 2 13 11 4429 6862 5343 -11958 2 2 13 11 4430 5344 6863 -11959 2 2 13 11 4460 6895 5218 -11960 2 2 13 11 3740 5121 6748 -11961 2 2 13 11 4035 5248 5994 -11962 2 2 13 11 4140 5090 6817 -11963 2 2 13 11 3914 5398 6144 -11964 2 2 13 11 4344 6311 5346 -11965 2 2 13 11 4435 6597 6775 -11966 2 2 13 11 4329 5844 5281 -11967 2 2 13 11 4937 6041 6941 -11968 2 2 13 11 3930 6235 5164 -11969 2 2 13 11 4363 5253 6242 -11970 2 2 13 11 4336 5478 5828 -11971 2 2 13 11 3945 5194 6778 -11972 2 2 13 11 4300 5815 5387 -11973 2 2 13 11 4301 5388 5816 -11974 2 2 13 11 4271 5182 6004 -11975 2 2 13 11 4272 6005 5183 -11976 2 2 13 11 3710 5180 6509 -11977 2 2 13 11 3737 6194 5953 -11978 2 2 13 11 3823 6784 5107 -11979 2 2 13 11 3738 5954 6195 -11980 2 2 13 11 4422 5482 6219 -11981 2 2 13 11 4625 6271 5413 -11982 2 2 13 11 4370 6223 5307 -11983 2 2 13 11 4597 6911 5500 -11984 2 2 13 11 4323 5129 6368 -11985 2 2 13 11 4324 6369 5130 -11986 2 2 13 11 3719 6685 5212 -11987 2 2 13 11 3720 5213 6686 -11988 2 2 13 11 3920 5262 6456 -11989 2 2 13 11 3872 5413 6271 -11990 2 2 13 11 3911 5527 6070 -11991 2 2 13 11 3912 6071 5528 -11992 2 2 13 11 5097 6637 6049 -11993 2 2 13 11 5098 6050 6638 -11994 2 2 13 11 3789 5445 5712 -11995 2 2 13 11 3790 5713 5446 -11996 2 2 13 11 334 5909 335 -11997 2 2 13 11 241 5910 242 -11998 2 2 13 11 4596 6473 5406 -11999 2 2 13 11 4765 6663 6673 -12000 2 2 13 11 4463 5451 5874 -12001 2 2 13 11 137 138 6857 -12002 2 2 13 11 4599 5653 6110 -12003 2 2 13 11 4384 6552 5279 -12004 2 2 13 11 3796 6788 5154 -12005 2 2 13 11 287 5568 6564 -12006 2 2 13 11 4113 5501 6315 -12007 2 2 13 11 4551 5749 5436 -12008 2 2 13 11 3735 5820 6293 -12009 2 2 13 11 4232 5536 5981 -12010 2 2 13 11 4233 5982 5537 -12011 2 2 13 11 4490 6884 5560 -12012 2 2 13 11 3992 6641 5271 -12013 2 2 13 11 4486 5788 5508 -12014 2 2 13 11 3744 5251 6341 -12015 2 2 13 11 3745 6343 5252 -12016 2 2 13 11 4332 5679 5826 -12017 2 2 13 11 4649 6944 5105 -12018 2 2 13 11 4650 5106 6945 -12019 2 2 13 11 4093 6428 5181 -12020 2 2 13 11 4202 6163 5325 -12021 2 2 13 11 4897 5992 5404 -12022 2 2 13 11 4898 5405 5993 -12023 2 2 13 11 4446 5540 6415 -12024 2 2 13 11 4346 5242 6653 -12025 2 2 13 11 4063 5313 6100 -12026 2 2 13 11 3771 5228 6764 -12027 2 2 13 11 4064 6102 5316 -12028 2 2 13 11 4419 5841 5481 -12029 2 2 13 11 3814 6137 5420 -12030 2 2 13 11 92 5806 6906 -12031 2 2 13 11 3743 5436 5749 -12032 2 2 13 11 4736 5780 6899 -12033 2 2 13 11 4389 5111 6648 -12034 2 2 13 11 4390 6649 5112 -12035 2 2 13 11 3779 6893 5553 -12036 2 2 13 11 3697 6711 5470 -12037 2 2 13 11 3968 6437 6867 -12038 2 2 13 11 4176 5661 5842 -12039 2 2 13 11 3969 6869 6438 -12040 2 2 13 11 4286 5574 5670 -12041 2 2 13 11 4360 6324 5131 -12042 2 2 13 11 79 6605 5373 -12043 2 2 13 11 4261 6257 5877 -12044 2 2 13 11 4649 5199 6133 -12045 2 2 13 11 4650 6134 5200 -12046 2 2 13 11 4305 5918 6100 -12047 2 2 13 11 4448 6240 5165 -12048 2 2 13 11 4306 6102 5919 -12049 2 2 13 11 4782 6857 5101 -12050 2 2 13 11 4710 6789 6853 -12051 2 2 13 11 3814 6467 6526 -12052 2 2 13 11 3670 5259 6715 -12053 2 2 13 11 4079 5434 6114 -12054 2 2 13 11 4080 6115 5435 -12055 2 2 13 11 104 105 6348 -12056 2 2 13 11 3841 5546 5959 -12057 2 2 13 11 4133 5338 6339 -12058 2 2 13 11 4269 5286 5989 -12059 2 2 13 11 3735 6293 5765 -12060 2 2 13 11 4224 6039 5191 -12061 2 2 13 11 4789 6466 5302 -12062 2 2 13 11 4245 5808 5900 -12063 2 2 13 11 144 5455 5907 -12064 2 2 13 11 4369 6422 6821 -12065 2 2 13 11 4371 6822 6423 -12066 2 2 13 11 4790 6732 5813 -12067 2 2 13 11 4254 5670 5574 -12068 2 2 13 11 4012 5121 6308 -12069 2 2 13 11 4126 5390 5825 -12070 2 2 13 11 4255 5473 5842 -12071 2 2 13 11 4339 5250 6347 -12072 2 2 13 11 4379 6271 6818 -12073 2 2 13 11 4173 5615 5846 -12074 2 2 13 11 4174 5847 5616 -12075 2 2 13 11 4549 6058 6937 -12076 2 2 13 11 4011 5218 6895 -12077 2 2 13 11 4360 5131 6498 -12078 2 2 13 11 4522 6100 5918 -12079 2 2 13 11 4523 5919 6102 -12080 2 2 13 11 4459 6623 5969 -12081 2 2 13 11 4586 6644 5901 -12082 2 2 13 11 4380 5221 6232 -12083 2 2 13 11 3691 5734 6680 -12084 2 2 13 11 4644 6221 5674 -12085 2 2 13 11 4553 6729 5550 -12086 2 2 13 11 4001 6807 5791 -12087 2 2 13 11 4420 5497 5721 -12088 2 2 13 11 4321 6712 5171 -12089 2 2 13 11 5105 6944 5327 -12090 2 2 13 11 5106 5328 6945 -12091 2 2 13 11 4564 5736 5484 -12092 2 2 13 11 4104 6513 5143 -12093 2 2 13 11 4484 5962 6000 -12094 2 2 13 11 4709 6164 6815 -12095 2 2 13 11 4516 6604 5150 -12096 2 2 13 11 4517 5151 6606 -12097 2 2 13 11 4190 6661 5666 -12098 2 2 13 11 4076 5495 5882 -12099 2 2 13 11 296 5989 5286 -12100 2 2 13 11 4028 6884 5186 -12101 2 2 13 11 4429 6627 6056 -12102 2 2 13 11 4430 6057 6628 -12103 2 2 13 11 3888 5481 5841 -12104 2 2 13 11 4121 5864 5400 -12105 2 2 13 11 4122 5401 5865 -12106 2 2 13 11 3835 6385 6463 -12107 2 2 13 11 3827 5186 6390 -12108 2 2 13 11 4464 5373 6605 -12109 2 2 13 11 3716 6516 5365 -12110 2 2 13 11 4146 5721 5497 -12111 2 2 13 11 4683 5306 5972 -12112 2 2 13 11 4059 5115 6684 -12113 2 2 13 11 4335 6485 5117 -12114 2 2 13 11 3879 5193 6377 -12115 2 2 13 11 129 5225 6024 -12116 2 2 13 11 4490 5202 6390 -12117 2 2 13 11 119 6140 5166 -12118 2 2 13 11 4211 6221 5312 -12119 2 2 13 11 3649 5408 6701 -12120 2 2 13 11 4812 6565 5306 -12121 2 2 13 11 4020 5282 6722 -12122 2 2 13 11 4021 6723 5283 -12123 2 2 13 11 4480 5170 6849 -12124 2 2 13 11 3777 5731 6558 -12125 2 2 13 11 3728 5874 5451 -12126 2 2 13 11 4486 5214 6816 -12127 2 2 13 11 4296 5120 6416 -12128 2 2 13 11 3866 5958 5407 -12129 2 2 13 11 3833 5845 5368 -12130 2 2 13 11 4711 5752 6718 -12131 2 2 13 11 111 112 6026 -12132 2 2 13 11 4599 6110 6143 -12133 2 2 13 11 4247 6241 5175 -12134 2 2 13 11 3739 5175 6241 -12135 2 2 13 11 3727 5508 5788 -12136 2 2 13 11 4166 5594 5942 -12137 2 2 13 11 4167 5943 5595 -12138 2 2 13 11 4376 6066 5408 -12139 2 2 13 11 4887 6526 6467 -12140 2 2 13 11 165 166 6079 -12141 2 2 13 11 55 56 6080 -12142 2 2 13 11 4694 6889 5744 -12143 2 2 13 11 4241 5160 6217 -12144 2 2 13 11 4160 5828 5478 -12145 2 2 13 11 4242 6218 5161 -12146 2 2 13 11 3712 6404 6950 -12147 2 2 13 11 4640 6570 6449 -12148 2 2 13 11 4030 5159 6447 -12149 2 2 13 11 3842 6654 5771 -12150 2 2 13 11 3725 5716 6135 -12151 2 2 13 11 3723 5274 6175 -12152 2 2 13 11 3740 5500 6911 -12153 2 2 13 11 3850 5256 6545 -12154 2 2 13 11 4334 5336 6167 -12155 2 2 13 11 4211 5312 6129 -12156 2 2 13 11 4248 5339 5977 -12157 2 2 13 11 4293 6143 6110 -12158 2 2 13 11 4989 5649 6239 -12159 2 2 13 11 3728 6450 5170 -12160 2 2 13 11 4017 6637 5097 -12161 2 2 13 11 4018 5098 6638 -12162 2 2 13 11 4291 6119 5290 -12163 2 2 13 11 3861 6415 5540 -12164 2 2 13 11 4433 6054 5772 -12165 2 2 13 11 4434 5773 6055 -12166 2 2 13 11 4137 6736 6094 -12167 2 2 13 11 4274 5144 6442 -12168 2 2 13 11 3979 6548 6104 -12169 2 2 13 11 4176 5842 5473 -12170 2 2 13 11 4532 6006 6765 -12171 2 2 13 11 305 6014 306 -12172 2 2 13 11 4035 5155 6700 -12173 2 2 13 11 4686 5805 5521 -12174 2 2 13 11 4102 5196 6502 -12175 2 2 13 11 130 6266 5225 -12176 2 2 13 11 4426 6408 5430 -12177 2 2 13 11 4581 5522 5778 -12178 2 2 13 11 4614 5577 5827 -12179 2 2 13 11 4506 6772 5140 -12180 2 2 13 11 4050 6839 5333 -12181 2 2 13 11 4051 5334 6840 -12182 2 2 13 11 4450 5479 5760 -12183 2 2 13 11 4622 6342 5292 -12184 2 2 13 11 4348 6144 5398 -12185 2 2 13 11 4447 6778 5194 -12186 2 2 13 11 4401 5951 5621 -12187 2 2 13 11 4571 5765 6293 -12188 2 2 13 11 3824 5518 6214 -12189 2 2 13 11 4305 6100 5313 -12190 2 2 13 11 4306 5316 6102 -12191 2 2 13 11 3700 5346 6311 -12192 2 2 13 11 3661 6703 5699 -12193 2 2 13 11 4550 5197 6429 -12194 2 2 13 11 4011 6902 5776 -12195 2 2 13 11 4295 6404 5144 -12196 2 2 13 11 4128 5697 6098 -12197 2 2 13 11 4129 6099 5698 -12198 2 2 13 11 4452 6006 6396 -12199 2 2 13 11 4453 6397 6007 -12200 2 2 13 11 4450 6920 5326 -12201 2 2 13 11 4314 6518 5341 -12202 2 2 13 11 4315 5342 6519 -12203 2 2 13 11 4026 6838 5185 -12204 2 2 13 11 4617 6293 5820 -12205 2 2 13 11 4600 6564 5568 -12206 2 2 13 11 3874 5690 6272 -12207 2 2 13 11 3876 6273 5691 -12208 2 2 13 11 4310 6000 5962 -12209 2 2 13 11 4405 5192 6225 -12210 2 2 13 11 4181 5326 5866 -12211 2 2 13 11 3796 5159 6725 -12212 2 2 13 11 330 6942 331 -12213 2 2 13 11 245 6943 246 -12214 2 2 13 11 4453 6007 6861 -12215 2 2 13 11 4313 5246 6254 -12216 2 2 13 11 4812 6809 5830 -12217 2 2 13 11 4406 6831 5597 -12218 2 2 13 11 4470 6135 5716 -12219 2 2 13 11 3873 6527 5800 -12220 2 2 13 11 4640 5844 6570 -12221 2 2 13 11 4413 6033 6691 -12222 2 2 13 11 4872 6731 6785 -12223 2 2 13 11 4498 6889 6613 -12224 2 2 13 11 3884 6604 5467 -12225 2 2 13 11 4575 6571 5874 -12226 2 2 13 11 3716 5430 6408 -12227 2 2 13 11 4085 6287 5226 -12228 2 2 13 11 4079 6598 5434 -12229 2 2 13 11 4080 5435 6599 -12230 2 2 13 11 3879 6110 5653 -12231 2 2 13 11 4674 6356 5488 -12232 2 2 13 11 4461 6230 5232 -12233 2 2 13 11 5045 6503 5210 -12234 2 2 13 11 3844 6022 5671 -12235 2 2 13 11 5046 5211 6504 -12236 2 2 13 11 4760 5516 6775 -12237 2 2 13 11 4425 5671 6022 -12238 2 2 13 11 3688 6263 6808 -12239 2 2 13 11 4106 6047 5289 -12240 2 2 13 11 4473 6764 5228 -12241 2 2 13 11 4334 5738 6081 -12242 2 2 13 11 4294 5270 6338 -12243 2 2 13 11 4787 5871 5582 -12244 2 2 13 11 4190 5784 6661 -12245 2 2 13 11 4391 5546 5718 -12246 2 2 13 11 314 6049 315 -12247 2 2 13 11 261 6050 262 -12248 2 2 13 11 3880 5826 5679 -12249 2 2 13 11 321 6056 322 -12250 2 2 13 11 254 6057 255 -12251 2 2 13 11 4077 6280 5247 -12252 2 2 13 11 3991 6951 5632 -12253 2 2 13 11 4190 5619 5784 -12254 2 2 13 11 4682 5908 5904 -12255 2 2 13 11 3946 6411 5240 -12256 2 2 13 11 4453 6861 6674 -12257 2 2 13 11 4872 5271 6731 -12258 2 2 13 11 4037 5210 6503 -12259 2 2 13 11 4173 5846 5457 -12260 2 2 13 11 4174 5458 5847 -12261 2 2 13 11 4038 6504 5211 -12262 2 2 13 11 95 6621 5383 -12263 2 2 13 11 3877 5657 6364 -12264 2 2 13 11 4541 5926 6806 -12265 2 2 13 11 4318 6117 5227 -12266 2 2 13 11 4451 5365 6516 -12267 2 2 13 11 4391 5959 5546 -12268 2 2 13 11 3657 5973 5382 -12269 2 2 13 11 4617 5820 6675 -12270 2 2 13 11 4304 5280 6168 -12271 2 2 13 11 4328 6367 5960 -12272 2 2 13 11 4714 6680 5734 -12273 2 2 13 11 4491 6565 6747 -12274 2 2 13 11 4095 5327 6944 -12275 2 2 13 11 4096 6945 5328 -12276 2 2 13 11 4158 5285 6155 -12277 2 2 13 11 3764 5278 6123 -12278 2 2 13 11 4155 5135 6577 -12279 2 2 13 11 4202 5505 6163 -12280 2 2 13 11 4138 5878 5437 -12281 2 2 13 11 4139 5438 5879 -12282 2 2 13 11 4353 5846 5615 -12283 2 2 13 11 4354 5616 5847 -12284 2 2 13 11 3850 6891 6332 -12285 2 2 13 11 3797 5219 6759 -12286 2 2 13 11 3798 6760 5220 -12287 2 2 13 11 4530 6558 5201 -12288 2 2 13 11 3687 5235 6653 -12289 2 2 13 11 4985 6552 5753 -12290 2 2 13 11 4269 6174 5286 -12291 2 2 13 11 4404 6545 5256 -12292 2 2 13 11 4833 6836 6495 -12293 2 2 13 11 3649 6633 5408 -12294 2 2 13 11 3980 6319 6674 -12295 2 2 13 11 4044 6365 5235 -12296 2 2 13 11 4990 5251 6424 -12297 2 2 13 11 4991 6425 5252 -12298 2 2 13 11 4045 5236 6366 -12299 2 2 13 11 3871 5972 5306 -12300 2 2 13 11 4388 6467 6742 -12301 2 2 13 11 4464 6698 5373 -12302 2 2 13 11 4894 6910 5319 -12303 2 2 13 11 327 6091 328 -12304 2 2 13 11 248 6092 249 -12305 2 2 13 11 4254 5574 6462 -12306 2 2 13 11 4213 5861 5609 -12307 2 2 13 11 3920 5890 6567 -12308 2 2 13 11 4223 6016 6126 -12309 2 2 13 11 4214 5329 6676 -12310 2 2 13 11 119 120 6140 -12311 2 2 13 11 4223 5228 6952 -12312 2 2 13 11 3951 5569 6596 -12313 2 2 13 11 4834 6494 6850 -12314 2 2 13 11 3695 6453 5411 -12315 2 2 13 11 3696 5412 6454 -12316 2 2 13 11 4138 5445 5878 -12317 2 2 13 11 4139 5879 5446 -12318 2 2 13 11 3905 6570 5844 -12319 2 2 13 11 4339 5694 6287 -12320 2 2 13 11 4351 6534 5257 -12321 2 2 13 11 4352 5258 6535 -12322 2 2 13 11 3821 6146 5403 -12323 2 2 13 11 4351 5942 5594 -12324 2 2 13 11 4953 6674 6319 -12325 2 2 13 11 4352 5595 5943 -12326 2 2 13 11 4633 5209 6709 -12327 2 2 13 11 4084 5224 6231 -12328 2 2 13 11 3928 5977 5339 -12329 2 2 13 11 3919 6338 5270 -12330 2 2 13 11 3916 6826 5511 -12331 2 2 13 11 3919 6566 5857 -12332 2 2 13 11 3688 5236 6263 -12333 2 2 13 11 4376 6633 5267 -12334 2 2 13 11 4690 6066 5520 -12335 2 2 13 11 3659 6360 5185 -12336 2 2 13 11 4007 6777 5244 -12337 2 2 13 11 4088 5521 5805 -12338 2 2 13 11 3740 6120 6143 -12339 2 2 13 11 3820 5802 6117 -12340 2 2 13 11 5242 6830 6653 -12341 2 2 13 11 3825 5796 6922 -12342 2 2 13 11 272 6147 273 -12343 2 2 13 11 3800 5349 6085 -12344 2 2 13 11 3801 6086 5350 -12345 2 2 13 11 4795 5482 6334 -12346 2 2 13 11 4559 6124 6085 -12347 2 2 13 11 3838 5352 6316 -12348 2 2 13 11 3839 6317 5353 -12349 2 2 13 11 4506 6844 5249 -12350 2 2 13 11 4378 5565 6669 -12351 2 2 13 11 4474 5383 6621 -12352 2 2 13 11 4588 5958 6202 -12353 2 2 13 11 4188 5763 5552 -12354 2 2 13 11 91 6906 5617 -12355 2 2 13 11 4005 5230 6658 -12356 2 2 13 11 4453 6674 6151 -12357 2 2 13 11 3966 5574 6314 -12358 2 2 13 11 4702 5922 6834 -12359 2 2 13 11 4743 6799 5288 -12360 2 2 13 11 300 6729 301 -12361 2 2 13 11 4184 6013 5382 -12362 2 2 13 11 4403 6690 5881 -12363 2 2 13 11 4178 6689 5234 -12364 2 2 13 11 4256 5212 6685 -12365 2 2 13 11 4257 6686 5213 -12366 2 2 13 11 4203 5904 5908 -12367 2 2 13 11 3829 5279 6552 -12368 2 2 13 11 162 163 6327 -12369 2 2 13 11 58 59 6328 -12370 2 2 13 11 4267 5867 5506 -12371 2 2 13 11 4106 6810 5484 -12372 2 2 13 11 4256 5437 5878 -12373 2 2 13 11 4257 5879 5438 -12374 2 2 13 11 3658 5329 5979 -12375 2 2 13 11 4847 5782 5888 -12376 2 2 13 11 4300 6821 6060 -12377 2 2 13 11 4301 6061 6822 -12378 2 2 13 11 3759 5526 6744 -12379 2 2 13 11 4800 6104 6548 -12380 2 2 13 11 4786 6682 6383 -12381 2 2 13 11 4499 5960 6367 -12382 2 2 13 11 149 150 6350 -12383 2 2 13 11 4644 5776 6820 -12384 2 2 13 11 4914 6808 6263 -12385 2 2 13 11 4133 6339 5517 -12386 2 2 13 11 3838 6243 5387 -12387 2 2 13 11 3839 5388 6244 -12388 2 2 13 11 4367 6191 5769 -12389 2 2 13 11 4118 5827 5577 -12390 2 2 13 11 4237 6871 6864 -12391 2 2 13 11 4238 6865 6872 -12392 2 2 13 11 4252 5392 6702 -12393 2 2 13 11 4232 5981 5970 -12394 2 2 13 11 4233 5971 5982 -12395 2 2 13 11 4183 5582 5871 -12396 2 2 13 11 3786 5343 6019 -12397 2 2 13 11 3787 6020 5344 -12398 2 2 13 11 4516 5467 6604 -12399 2 2 13 11 3883 5621 5951 -12400 2 2 13 11 3838 6316 5409 -12401 2 2 13 11 3839 5410 6317 -12402 2 2 13 11 4194 6456 5262 -12403 2 2 13 11 71 72 6375 -12404 2 2 13 11 4739 6126 6016 -12405 2 2 13 11 3689 6448 5375 -12406 2 2 13 11 4017 6045 6062 -12407 2 2 13 11 4018 6064 6046 -12408 2 2 13 11 4209 5275 6197 -12409 2 2 13 11 4652 5800 6527 -12410 2 2 13 11 3671 6190 5300 -12411 2 2 13 11 4770 5524 6757 -12412 2 2 13 11 4394 5261 6361 -12413 2 2 13 11 4206 6789 6160 -12414 2 2 13 11 4258 5907 5455 -12415 2 2 13 11 5347 6835 6147 -12416 2 2 13 11 4328 5841 5923 -12417 2 2 13 11 4507 5434 6598 -12418 2 2 13 11 4508 6599 5435 -12419 2 2 13 11 5063 6447 5803 -12420 2 2 13 11 4143 5818 6382 -12421 2 2 13 11 74 75 6380 -12422 2 2 13 11 157 158 6388 -12423 2 2 13 11 63 64 6389 -12424 2 2 13 11 4535 5809 5987 -12425 2 2 13 11 4197 5941 6946 -12426 2 2 13 11 4576 5882 5495 -12427 2 2 13 11 4715 5817 5709 -12428 2 2 13 11 3852 6819 6623 -12429 2 2 13 11 4153 6161 5493 -12430 2 2 13 11 4164 6239 5649 -12431 2 2 13 11 3718 5556 5960 -12432 2 2 13 11 4287 5825 5996 -12433 2 2 13 11 4659 5617 6906 -12434 2 2 13 11 3896 6193 5787 -12435 2 2 13 11 4709 6384 5785 -12436 2 2 13 11 4273 5221 6526 -12437 2 2 13 11 4342 6468 6540 -12438 2 2 13 11 97 98 6410 -12439 2 2 13 11 4343 6541 6469 -12440 2 2 13 11 4759 6259 5912 -12441 2 2 13 11 334 6916 5909 -12442 2 2 13 11 242 5910 6917 -12443 2 2 13 11 4653 6170 6951 -12444 2 2 13 11 4763 6657 6596 -12445 2 2 13 11 4274 6442 5269 -12446 2 2 13 11 3711 5856 6441 -12447 2 2 13 11 4560 6086 6125 -12448 2 2 13 11 4337 5240 6411 -12449 2 2 13 11 3658 6676 5329 -12450 2 2 13 11 5159 5277 6725 -12451 2 2 13 11 4691 6883 5662 -12452 2 2 13 11 87 88 6434 -12453 2 2 13 11 4643 5995 6754 -12454 2 2 13 11 4227 5987 5809 -12455 2 2 13 11 4769 6059 5742 -12456 2 2 13 11 5443 6586 5998 -12457 2 2 13 11 4655 6138 6919 -12458 2 2 13 11 4809 6855 6148 -12459 2 2 13 11 4810 6150 6856 -12460 2 2 13 11 4633 5784 5619 -12461 2 2 13 11 292 6245 293 -12462 2 2 13 11 4473 6610 6659 -12463 2 2 13 11 4333 5951 6003 -12464 2 2 13 11 3907 5575 6063 -12465 2 2 13 11 4265 6532 5404 -12466 2 2 13 11 4266 5405 6533 -12467 2 2 13 11 3802 5254 6800 -12468 2 2 13 11 3800 6085 6124 -12469 2 2 13 11 3707 5312 6221 -12470 2 2 13 11 3863 6924 5282 -12471 2 2 13 11 3864 5283 6925 -12472 2 2 13 11 4693 5444 6672 -12473 2 2 13 11 3814 6526 5221 -12474 2 2 13 11 4447 5194 6582 -12475 2 2 13 11 278 6269 279 -12476 2 2 13 11 3923 5920 6609 -12477 2 2 13 11 4484 6636 6470 -12478 2 2 13 11 4313 6433 5641 -12479 2 2 13 11 4142 5957 5498 -12480 2 2 13 11 4184 5709 5817 -12481 2 2 13 11 4276 5461 6009 -12482 2 2 13 11 4277 6010 5463 -12483 2 2 13 11 4300 6060 5441 -12484 2 2 13 11 4301 5442 6061 -12485 2 2 13 11 3910 6741 5506 -12486 2 2 13 11 3784 5325 6163 -12487 2 2 13 11 4321 5176 6712 -12488 2 2 13 11 4495 6936 5541 -12489 2 2 13 11 4297 6412 5920 -12490 2 2 13 11 85 5288 6799 -12491 2 2 13 11 3992 6870 6641 -12492 2 2 13 11 4699 6926 6474 -12493 2 2 13 11 4700 6475 6927 -12494 2 2 13 11 3744 6424 5251 -12495 2 2 13 11 3745 5252 6425 -12496 2 2 13 11 3840 5963 5659 -12497 2 2 13 11 4289 6085 5349 -12498 2 2 13 11 4290 5350 6086 -12499 2 2 13 11 4361 5243 6595 -12500 2 2 13 11 4291 5290 6512 -12501 2 2 13 11 4379 5887 5868 -12502 2 2 13 11 4502 5443 6937 -12503 2 2 13 11 4701 5702 6659 -12504 2 2 13 11 3652 6277 5307 -12505 2 2 13 11 4318 5227 6730 -12506 2 2 13 11 4331 5868 5887 -12507 2 2 13 11 4342 5810 6172 -12508 2 2 13 11 4343 6173 5811 -12509 2 2 13 11 4598 5511 6826 -12510 2 2 13 11 4493 5787 6193 -12511 2 2 13 11 4599 6143 6120 -12512 2 2 13 11 4376 5520 6066 -12513 2 2 13 11 299 6352 5550 -12514 2 2 13 11 4134 6576 5421 -12515 2 2 13 11 3949 6226 6559 -12516 2 2 13 11 3835 5576 6186 -12517 2 2 13 11 4507 6666 5557 -12518 2 2 13 11 4508 5558 6667 -12519 2 2 13 11 4265 5404 5992 -12520 2 2 13 11 4266 5993 5405 -12521 2 2 13 11 4294 6603 5270 -12522 2 2 13 11 3801 6125 6086 -12523 2 2 13 11 3901 5902 5572 -12524 2 2 13 11 4165 6932 5734 -12525 2 2 13 11 4283 5431 6393 -12526 2 2 13 11 4284 6394 5432 -12527 2 2 13 11 4392 6752 5282 -12528 2 2 13 11 4440 5331 6677 -12529 2 2 13 11 4393 5283 6753 -12530 2 2 13 11 4562 6744 5526 -12531 2 2 13 11 4271 5647 6096 -12532 2 2 13 11 4272 6097 5648 -12533 2 2 13 11 3828 5215 6457 -12534 2 2 13 11 3829 6458 5216 -12535 2 2 13 11 4106 6677 5331 -12536 2 2 13 11 4800 6939 6104 -12537 2 2 13 11 4555 6062 6045 -12538 2 2 13 11 4556 6046 6064 -12539 2 2 13 11 4316 5568 6154 -12540 2 2 13 11 3892 6131 5832 -12541 2 2 13 11 3893 5833 6132 -12542 2 2 13 11 4419 5923 5841 -12543 2 2 13 11 79 80 6605 -12544 2 2 13 11 4714 5734 6932 -12545 2 2 13 11 4247 6413 5456 -12546 2 2 13 11 4344 6202 5958 -12547 2 2 13 11 4425 5375 6448 -12548 2 2 13 11 4733 5406 6473 -12549 2 2 13 11 3902 6255 5684 -12550 2 2 13 11 4289 6694 5293 -12551 2 2 13 11 3903 5685 6256 -12552 2 2 13 11 4290 5294 6695 -12553 2 2 13 11 4730 5468 6212 -12554 2 2 13 11 3807 5677 6180 -12555 2 2 13 11 4717 6456 6450 -12556 2 2 13 11 3922 6801 5492 -12557 2 2 13 11 4614 6578 5464 -12558 2 2 13 11 4105 5272 6624 -12559 2 2 13 11 4547 5970 5981 -12560 2 2 13 11 3712 5269 6442 -12561 2 2 13 11 4548 5982 5971 -12562 2 2 13 11 95 96 6621 -12563 2 2 13 11 3731 6109 5489 -12564 2 2 13 11 3732 5490 6111 -12565 2 2 13 11 328 6091 6481 -12566 2 2 13 11 248 6482 6092 -12567 2 2 13 11 4564 5484 6810 -12568 2 2 13 11 4328 5960 5556 -12569 2 2 13 11 4417 6658 5230 -12570 2 2 13 11 4427 6383 6682 -12571 2 2 13 11 3934 5437 6795 -12572 2 2 13 11 3935 6796 5438 -12573 2 2 13 11 4494 5769 6191 -12574 2 2 13 11 4821 6622 5500 -12575 2 2 13 11 4334 6081 6935 -12576 2 2 13 11 134 135 6660 -12577 2 2 13 11 3 337 6897 -12578 2 2 13 11 4 6898 239 -12579 2 2 13 11 298 6352 299 -12580 2 2 13 11 4394 5738 5933 -12581 2 2 13 11 3875 6730 5227 -12582 2 2 13 11 3971 6496 5393 -12583 2 2 13 11 3904 5947 6866 -12584 2 2 13 11 4799 6395 6517 -12585 2 2 13 11 4387 5855 6585 -12586 2 2 13 11 3 6897 168 -12587 2 2 13 11 4 53 6898 -12588 2 2 13 11 4518 5396 6161 -12589 2 2 13 11 310 6912 311 -12590 2 2 13 11 265 6913 266 -12591 2 2 13 11 4288 6320 5243 -12592 2 2 13 11 4419 5275 6892 -12593 2 2 13 11 3931 6815 6164 -12594 2 2 13 11 4440 6508 5469 -12595 2 2 13 11 3986 6937 5443 -12596 2 2 13 11 3679 6069 5737 -12597 2 2 13 11 4428 5496 6514 -12598 2 2 13 11 4369 5387 6243 -12599 2 2 13 11 4310 5962 5603 -12600 2 2 13 11 4371 6244 5388 -12601 2 2 13 11 4349 5798 6600 -12602 2 2 13 11 84 85 6799 -12603 2 2 13 11 4195 5990 5541 -12604 2 2 13 11 3666 5557 6666 -12605 2 2 13 11 3691 6680 5234 -12606 2 2 13 11 3667 6667 5558 -12607 2 2 13 11 4625 6818 6271 -12608 2 2 13 11 4761 6351 5539 -12609 2 2 13 11 4444 6399 6486 -12610 2 2 13 11 4714 5903 6680 -12611 2 2 13 11 91 92 6906 -12612 2 2 13 11 126 127 6931 -12613 2 2 13 11 4796 5292 6342 -12614 2 2 13 11 3894 5933 5738 -12615 2 2 13 11 3852 5633 6008 -12616 2 2 13 11 4210 6379 5803 -12617 2 2 13 11 4114 6234 5507 -12618 2 2 13 11 4261 6186 5576 -12619 2 2 13 11 4382 6517 6395 -12620 2 2 13 11 4304 6780 5280 -12621 2 2 13 11 4562 5573 6189 -12622 2 2 13 11 4422 5896 6334 -12623 2 2 13 11 3772 5727 6718 -12624 2 2 13 11 4613 6441 5856 -12625 2 2 13 11 4791 6579 5428 -12626 2 2 13 11 5134 5807 6946 -12627 2 2 13 11 3920 6557 5262 -12628 2 2 13 11 4101 5325 6735 -12629 2 2 13 11 4792 5429 6557 -12630 2 2 13 11 4304 6168 6048 -12631 2 2 13 11 4736 6731 5271 -12632 2 2 13 11 4754 5572 6376 -12633 2 2 13 11 4250 6370 5758 -12634 2 2 13 11 4251 5759 6371 -12635 2 2 13 11 4302 5677 5964 -12636 2 2 13 11 4303 5965 5678 -12637 2 2 13 11 3689 5375 6253 -12638 2 2 13 11 4383 6379 5643 -12639 2 2 13 11 3865 5884 6122 -12640 2 2 13 11 4984 6701 5408 -12641 2 2 13 11 3810 5280 6780 -12642 2 2 13 11 4670 6609 5920 -12643 2 2 13 11 100 101 6769 -12644 2 2 13 11 4825 6160 6789 -12645 2 2 13 11 4401 6003 5951 -12646 2 2 13 11 326 6928 327 -12647 2 2 13 11 249 6929 250 -12648 2 2 13 11 3748 6785 6731 -12649 2 2 13 11 4662 5420 6137 -12650 2 2 13 11 4150 6711 5284 -12651 2 2 13 11 4310 5603 5952 -12652 2 2 13 11 3657 6349 5320 -12653 2 2 13 11 4389 5486 6388 -12654 2 2 13 11 4390 6389 5487 -12655 2 2 13 11 4171 5742 6059 -12656 2 2 13 11 3919 5270 6579 -12657 2 2 13 11 4660 6757 5524 -12658 2 2 13 11 4388 5393 6496 -12659 2 2 13 11 3807 6180 5913 -12660 2 2 13 11 109 110 6581 -12661 2 2 13 11 3980 5860 5881 -12662 2 2 13 11 4332 5826 5790 -12663 2 2 13 11 4282 6768 5421 -12664 2 2 13 11 4864 5941 5836 -12665 2 2 13 11 4279 6820 5776 -12666 2 2 13 11 4268 5593 6851 -12667 2 2 13 11 4565 5413 6953 -12668 2 2 13 11 4456 6647 6014 -12669 2 2 13 11 328 6481 329 -12670 2 2 13 11 247 6482 248 -12671 2 2 13 11 5119 6261 6905 -12672 2 2 13 11 4452 6396 6922 -12673 2 2 13 11 4312 5498 5957 -12674 2 2 13 11 3871 5306 6565 -12675 2 2 13 11 4552 6048 6168 -12676 2 2 13 11 3677 6762 5255 -12677 2 2 13 11 4803 6336 5523 -12678 2 2 13 11 4198 5271 6641 -12679 2 2 13 11 3730 5603 5962 -12680 2 2 13 11 4585 5650 6281 -12681 2 2 13 11 5097 5822 6546 -12682 2 2 13 11 5098 6547 5823 -12683 2 2 13 11 4836 6275 6899 -12684 2 2 13 11 4923 5936 6159 -12685 2 2 13 11 4403 5881 5860 -12686 2 2 13 11 3708 6198 6846 -12687 2 2 13 11 4179 6905 5474 -12688 2 2 13 11 3863 5282 6752 -12689 2 2 13 11 3864 6753 5283 -12690 2 2 13 11 4590 6043 5801 -12691 2 2 13 11 281 6537 282 -12692 2 2 13 11 4472 6575 6791 -12693 2 2 13 11 4254 6462 5899 -12694 2 2 13 11 4312 6068 5644 -12695 2 2 13 11 4460 5550 6352 -12696 2 2 13 11 3970 6671 5851 -12697 2 2 13 11 4802 6866 5947 -12698 2 2 13 11 3857 5529 6054 -12699 2 2 13 11 3858 6055 5530 -12700 2 2 13 11 3932 5888 5782 -12701 2 2 13 11 4819 5857 6566 -12702 2 2 13 11 4273 5673 6683 -12703 2 2 13 11 157 6388 5486 -12704 2 2 13 11 64 5487 6389 -12705 2 2 13 11 4684 5684 6255 -12706 2 2 13 11 4685 6256 5685 -12707 2 2 13 11 4731 6481 6091 -12708 2 2 13 11 4732 6092 6482 -12709 2 2 13 11 3824 6728 5785 -12710 2 2 13 11 4498 5767 6889 -12711 2 2 13 11 4520 5945 6751 -12712 2 2 13 11 4025 6907 6712 -12713 2 2 13 11 4373 6662 6781 -12714 2 2 13 11 4130 6189 5444 -12715 2 2 13 11 4337 6411 5288 -12716 2 2 13 11 4820 6567 5890 -12717 2 2 13 11 287 6564 288 -12718 2 2 13 11 4333 5790 5826 -12719 2 2 13 11 4369 6076 6422 -12720 2 2 13 11 4371 6423 6077 -12721 2 2 13 11 3660 5950 6588 -12722 2 2 13 11 4481 6905 6261 -12723 2 2 13 11 4799 5739 6395 -12724 2 2 13 11 3695 5756 6444 -12725 2 2 13 11 3696 6445 5757 -12726 2 2 13 11 3921 6485 5766 -12727 2 2 13 11 3835 6186 5724 -12728 2 2 13 11 3827 6202 5672 -12729 2 2 13 11 4225 5409 6316 -12730 2 2 13 11 4226 6317 5410 -12731 2 2 13 11 3865 6232 6051 -12732 2 2 13 11 3851 5309 6650 -12733 2 2 13 11 4355 6478 6878 -12734 2 2 13 11 4356 6879 6479 -12735 2 2 13 11 4104 5278 6513 -12736 2 2 13 11 3788 5302 6737 -12737 2 2 13 11 4559 5514 6124 -12738 2 2 13 11 4311 5391 6439 -12739 2 2 13 11 3782 6208 5688 -12740 2 2 13 11 3885 6347 6606 -12741 2 2 13 11 4451 6295 5365 -12742 2 2 13 11 4640 6449 5840 -12743 2 2 13 11 4134 5600 6576 -12744 2 2 13 11 3940 5784 6709 -12745 2 2 13 11 4395 6212 5468 -12746 2 2 13 11 4220 5657 5950 -12747 2 2 13 11 4180 5656 5925 -12748 2 2 13 11 4178 5381 6490 -12749 2 2 13 11 4553 5550 6184 -12750 2 2 13 11 4421 5242 6611 -12751 2 2 13 11 4446 6415 5872 -12752 2 2 13 11 4933 6617 6172 -12753 2 2 13 11 4934 6173 6618 -12754 2 2 13 11 301 6729 5525 -12755 2 2 13 11 4665 6034 6657 -12756 2 2 13 11 4560 6125 5515 -12757 2 2 13 11 3703 5630 6076 -12758 2 2 13 11 3704 6077 5631 -12759 2 2 13 11 3721 6281 5650 -12760 2 2 13 11 4444 6486 5906 -12761 2 2 13 11 4234 5459 6206 -12762 2 2 13 11 4965 6864 6871 -12763 2 2 13 11 4966 6872 6865 -12764 2 2 13 11 4913 5464 6578 -12765 2 2 13 11 3838 5409 6243 -12766 2 2 13 11 3839 6244 5410 -12767 2 2 13 11 4278 6824 5523 -12768 2 2 13 11 4563 6721 5354 -12769 2 2 13 11 4326 6253 5375 -12770 2 2 13 11 3687 6653 6830 -12771 2 2 13 11 5171 6712 6907 -12772 2 2 13 11 4293 5480 6308 -12773 2 2 13 11 3956 6430 5932 -12774 2 2 13 11 4221 6754 5995 -12775 2 2 13 11 3801 5350 6797 -12776 2 2 13 11 4421 6830 5242 -12777 2 2 13 11 4449 6449 6570 -12778 2 2 13 11 4032 6443 5792 -12779 2 2 13 11 4763 5450 6657 -12780 2 2 13 11 4211 5674 6221 -12781 2 2 13 11 4600 6008 5633 -12782 2 2 13 11 3757 6439 5391 -12783 2 2 13 11 3800 6880 5349 -12784 2 2 13 11 3880 6105 5826 -12785 2 2 13 11 333 6916 334 -12786 2 2 13 11 242 6917 243 -12787 2 2 13 11 270 6873 271 -12788 2 2 13 11 4465 6637 5566 -12789 2 2 13 11 4466 5567 6638 -12790 2 2 13 11 4647 6422 6076 -12791 2 2 13 11 4247 5456 6282 -12792 2 2 13 11 4648 6077 6423 -12793 2 2 13 11 4337 5288 6538 -12794 2 2 13 11 102 6340 5385 -12795 2 2 13 11 4106 5289 6810 -12796 2 2 13 11 4228 6214 5518 -12797 2 2 13 11 4262 6070 5527 -12798 2 2 13 11 4263 5528 6071 -12799 2 2 13 11 3748 6899 6275 -12800 2 2 13 11 3872 6953 5413 -12801 2 2 13 11 4333 6003 5790 -12802 2 2 13 11 3832 6514 5496 -12803 2 2 13 11 4675 5851 6671 -12804 2 2 13 11 4538 6444 5756 -12805 2 2 13 11 4539 5757 6445 -12806 2 2 13 11 4334 6167 5738 -12807 2 2 13 11 4545 5872 6415 -12808 2 2 13 11 4211 6129 5553 -12809 2 2 13 11 4422 6334 5482 -12810 2 2 13 11 3871 6636 5565 -12811 2 2 13 11 4633 6709 5784 -12812 2 2 13 11 4883 6885 6068 -12813 2 2 13 11 4724 6725 5277 -12814 2 2 13 11 3734 6690 5330 -12815 2 2 13 11 3951 6596 6657 -12816 2 2 13 11 3834 6859 5324 -12817 2 2 13 11 4540 5324 6859 -12818 2 2 13 11 4521 5792 6443 -12819 2 2 13 11 4563 5354 6774 -12820 2 2 13 11 4220 6364 5657 -12821 2 2 13 11 4631 5507 6234 -12822 2 2 13 11 3807 5964 5677 -12823 2 2 13 11 3808 5678 5965 -12824 2 2 13 11 4268 6851 5819 -12825 2 2 13 11 3722 5644 6068 -12826 2 2 13 11 4317 5538 6539 -12827 2 2 13 11 4768 5819 6851 -12828 2 2 13 11 4197 5836 5941 -12829 2 2 13 11 4222 5968 5875 -12830 2 2 13 11 3726 6170 6403 -12831 2 2 13 11 4055 5352 6648 -12832 2 2 13 11 4056 6649 5353 -12833 2 2 13 11 4706 6470 6636 -12834 2 2 13 11 4313 6574 5650 -12835 2 2 13 11 4361 6595 5598 -12836 2 2 13 11 4017 5566 6637 -12837 2 2 13 11 4018 6638 5567 -12838 2 2 13 11 4319 6116 5556 -12839 2 2 13 11 3726 6403 5969 -12840 2 2 13 11 87 6434 5607 -12841 2 2 13 11 4777 6641 6870 -12842 2 2 13 11 4342 6617 5645 -12843 2 2 13 11 4343 5646 6618 -12844 2 2 13 11 4613 5856 5977 -12845 2 2 13 11 3869 6225 5770 -12846 2 2 13 11 3951 6657 6034 -12847 2 2 13 11 3908 6395 5739 -12848 2 2 13 11 4320 6224 5513 -12849 2 2 13 11 3682 5293 6694 -12850 2 2 13 11 286 6154 5568 -12851 2 2 13 11 3683 6695 5294 -12852 2 2 13 11 3933 5944 6834 -12853 2 2 13 11 3659 5478 6360 -12854 2 2 13 11 4068 5465 6611 -12855 2 2 13 11 4364 5601 6131 -12856 2 2 13 11 4365 6132 5602 -12857 2 2 13 11 3824 6285 5518 -12858 2 2 13 11 4482 5422 6305 -12859 2 2 13 11 3800 6124 5531 -12860 2 2 13 11 3721 6574 5998 -12861 2 2 13 11 4460 6184 5550 -12862 2 2 13 11 4506 5545 6930 -12863 2 2 13 11 5343 6862 6019 -12864 2 2 13 11 5344 6020 6863 -12865 2 2 13 11 4801 6315 5501 -12866 2 2 13 11 3705 5790 6003 -12867 2 2 13 11 283 5372 6673 -12868 2 2 13 11 4530 6238 5985 -12869 2 2 13 11 4429 5363 6862 -12870 2 2 13 11 4430 6863 5364 -12871 2 2 13 11 4154 6713 5291 -12872 2 2 13 11 4160 5545 6176 -12873 2 2 13 11 4436 5607 6434 -12874 2 2 13 11 3731 6645 5918 -12875 2 2 13 11 3791 5456 6413 -12876 2 2 13 11 3801 5544 6125 -12877 2 2 13 11 3732 5919 6646 -12878 2 2 13 11 4376 5408 6633 -12879 2 2 13 11 4440 6677 6708 -12880 2 2 13 11 4638 6563 5389 -12881 2 2 13 11 4333 5906 5951 -12882 2 2 13 11 4484 5565 6636 -12883 2 2 13 11 3943 6805 5384 -12884 2 2 13 11 3767 6246 5880 -12885 2 2 13 11 4417 6277 5830 -12886 2 2 13 11 4143 6382 5504 -12887 2 2 13 11 4229 5725 6078 -12888 2 2 13 11 311 6912 5663 -12889 2 2 13 11 265 5664 6913 -12890 2 2 13 11 324 5404 6532 -12891 2 2 13 11 252 6533 5405 -12892 2 2 13 11 4220 5731 6364 -12893 2 2 13 11 3917 6702 5392 -12894 2 2 13 11 4845 6027 6790 -12895 2 2 13 11 3854 6236 5452 -12896 2 2 13 11 3855 5453 6237 -12897 2 2 13 11 4204 6862 5363 -12898 2 2 13 11 4205 5364 6863 -12899 2 2 13 11 4496 6782 5309 -12900 2 2 13 11 3827 6414 6202 -12901 2 2 13 11 4647 6076 5630 -12902 2 2 13 11 4648 5631 6077 -12903 2 2 13 11 4433 5647 6203 -12904 2 2 13 11 4434 6204 5648 -12905 2 2 13 11 4558 5517 6339 -12906 2 2 13 11 4396 6178 5885 -12907 2 2 13 11 4397 5886 6179 -12908 2 2 13 11 4350 5485 6500 -12909 2 2 13 11 4760 6597 6363 -12910 2 2 13 11 3941 6096 5647 -12911 2 2 13 11 3942 5648 6097 -12912 2 2 13 11 4248 5977 5856 -12913 2 2 13 11 4411 6625 6045 -12914 2 2 13 11 4412 6046 6626 -12915 2 2 13 11 4415 6119 5834 -12916 2 2 13 11 4554 5932 6430 -12917 2 2 13 11 4786 6383 5711 -12918 2 2 13 11 4336 6360 5478 -12919 2 2 13 11 4653 6403 6170 -12920 2 2 13 11 136 6420 5474 -12921 2 2 13 11 4749 6290 6839 -12922 2 2 13 11 4750 6840 6291 -12923 2 2 13 11 4783 5875 5968 -12924 2 2 13 11 4229 6078 6803 -12925 2 2 13 11 3948 5579 6484 -12926 2 2 13 11 4314 5366 6518 -12927 2 2 13 11 4315 6519 5367 -12928 2 2 13 11 4421 6611 5465 -12929 2 2 13 11 3993 5843 6419 -12930 2 2 13 11 4291 5834 6119 -12931 2 2 13 11 4074 6508 5492 -12932 2 2 13 11 4588 6202 6414 -12933 2 2 13 11 4753 6623 6819 -12934 2 2 13 11 4419 5481 6451 -12935 2 2 13 11 4788 6781 6662 -12936 2 2 13 11 3944 6682 6331 -12937 2 2 13 11 4446 5449 6813 -12938 2 2 13 11 5326 6920 5866 -12939 2 2 13 11 4394 6081 5738 -12940 2 2 13 11 4350 6292 5485 -12941 2 2 13 11 4091 5983 6742 -12942 2 2 13 11 4377 5927 5933 -12943 2 2 13 11 4438 6098 5697 -12944 2 2 13 11 4439 5698 6099 -12945 2 2 13 11 3959 5627 6580 -12946 2 2 13 11 3841 6775 5516 -12947 2 2 13 11 4245 6918 5570 -12948 2 2 13 11 4160 6930 5545 -12949 2 2 13 11 4684 6255 6520 -12950 2 2 13 11 4685 6521 6256 -12951 2 2 13 11 3725 6135 6257 -12952 2 2 13 11 4502 6586 5443 -12953 2 2 13 11 4629 6540 6468 -12954 2 2 13 11 4630 6469 6541 -12955 2 2 13 11 4535 5987 6515 -12956 2 2 13 11 4786 6331 6682 -12957 2 2 13 11 4407 6520 6255 -12958 2 2 13 11 4836 6899 5780 -12959 2 2 13 11 4408 6256 6521 -12960 2 2 13 11 4254 6704 5670 -12961 2 2 13 11 4542 5980 6527 -12962 2 2 13 11 4435 5959 6067 -12963 2 2 13 11 4726 6834 5944 -12964 2 2 13 11 4922 5598 6497 -12965 2 2 13 11 4687 5321 6801 -12966 2 2 13 11 3883 5951 5906 -12967 2 2 13 11 4326 5375 6561 -12968 2 2 13 11 4107 6881 5371 -12969 2 2 13 11 4398 6353 6476 -12970 2 2 13 11 4399 6477 6354 -12971 2 2 13 11 4652 6527 5980 -12972 2 2 13 11 4333 6105 5906 -12973 2 2 13 11 3707 6820 5814 -12974 2 2 13 11 4243 6180 5677 -12975 2 2 13 11 4348 5576 6463 -12976 2 2 13 11 4104 6698 5426 -12977 2 2 13 11 4210 5803 6447 -12978 2 2 13 11 3703 6076 5885 -12979 2 2 13 11 3704 5886 6077 -12980 2 2 13 11 4919 5703 6881 -12981 2 2 13 11 4431 5369 6722 -12982 2 2 13 11 4432 6723 5370 -12983 2 2 13 11 3788 5421 6768 -12984 2 2 13 11 3676 6500 5485 -12985 2 2 13 11 3928 5339 6761 -12986 2 2 13 11 3996 6474 6926 -12987 2 2 13 11 3997 6927 6475 -12988 2 2 13 11 3673 5560 6668 -12989 2 2 13 11 4638 5998 6574 -12990 2 2 13 11 4023 5801 6043 -12991 2 2 13 11 4391 6067 5959 -12992 2 2 13 11 4625 5974 6088 -12993 2 2 13 11 4283 6393 5832 -12994 2 2 13 11 4284 5833 6394 -12995 2 2 13 11 4243 5636 6118 -12996 2 2 13 11 3664 6363 6597 -12997 2 2 13 11 4437 6484 5579 -12998 2 2 13 11 4581 6094 6736 -12999 2 2 13 11 3979 6104 5859 -13000 2 2 13 11 3687 6830 5440 -13001 2 2 13 11 4317 5578 6866 -13002 2 2 13 11 4339 6347 5759 -13003 2 2 13 11 4595 6805 5877 -13004 2 2 13 11 3652 5830 6277 -13005 2 2 13 11 3936 6440 6021 -13006 2 2 13 11 4602 5663 6912 -13007 2 2 13 11 4603 6913 5664 -13008 2 2 13 11 4469 5539 6351 -13009 2 2 13 11 4447 5368 6778 -13010 2 2 13 11 4394 5933 5927 -13011 2 2 13 11 3894 5738 6167 -13012 2 2 13 11 4776 6065 6773 -13013 2 2 13 11 4131 6835 5347 -13014 2 2 13 11 4313 5650 6433 -13015 2 2 13 11 4433 6847 5366 -13016 2 2 13 11 4434 5367 6848 -13017 2 2 13 11 4642 6814 5460 -13018 2 2 13 11 4106 5484 6677 -13019 2 2 13 11 3886 5754 6874 -13020 2 2 13 11 3887 6875 5755 -13021 2 2 13 11 4125 6833 5396 -13022 2 2 13 11 3956 6798 6919 -13023 2 2 13 11 3703 5885 6178 -13024 2 2 13 11 3704 6179 5886 -13025 2 2 13 11 4487 5880 6246 -13026 2 2 13 11 4509 6419 5843 -13027 2 2 13 11 4133 6555 5542 -13028 2 2 13 11 4333 5826 6105 -13029 2 2 13 11 3811 5356 6900 -13030 2 2 13 11 4625 6088 6818 -13031 2 2 13 11 4703 6091 6928 -13032 2 2 13 11 4704 6929 6092 -13033 2 2 13 11 4612 6002 5984 -13034 2 2 13 11 4505 6166 6430 -13035 2 2 13 11 4337 6538 5607 -13036 2 2 13 11 4282 5421 6576 -13037 2 2 13 11 3852 6008 6819 -13038 2 2 13 11 3850 6332 5609 -13039 2 2 13 11 4362 5561 6656 -13040 2 2 13 11 3816 6631 5457 -13041 2 2 13 11 3817 5458 6632 -13042 2 2 13 11 3835 6463 5576 -13043 2 2 13 11 4421 5440 6830 -13044 2 2 13 11 5068 6121 6401 -13045 2 2 13 11 4484 6470 5962 -13046 2 2 13 11 4411 6391 6625 -13047 2 2 13 11 4412 6626 6392 -13048 2 2 13 11 4507 6583 5434 -13049 2 2 13 11 4508 5435 6584 -13050 2 2 13 11 3854 5746 6236 -13051 2 2 13 11 3855 6237 5747 -13052 2 2 13 11 4370 6112 6149 -13053 2 2 13 11 4516 6509 5467 -13054 2 2 13 11 4554 6430 6166 -13055 2 2 13 11 4637 6323 5949 -13056 2 2 13 11 4794 5730 6601 -13057 2 2 13 11 4510 5682 6474 -13058 2 2 13 11 4511 6475 5683 -13059 2 2 13 11 4669 6488 6418 -13060 2 2 13 11 3966 6462 5574 -13061 2 2 13 11 3895 6361 5717 -13062 2 2 13 11 4262 6372 5612 -13063 2 2 13 11 4263 5613 6373 -13064 2 2 13 11 4546 5570 6918 -13065 2 2 13 11 326 5588 6928 -13066 2 2 13 11 250 6929 5589 -13067 2 2 13 11 4477 6248 6022 -13068 2 2 13 11 4156 6476 5475 -13069 2 2 13 11 4157 5476 6477 -13070 2 2 13 11 5035 6358 6249 -13071 2 2 13 11 5036 6250 6359 -13072 2 2 13 11 3722 6885 5547 -13073 2 2 13 11 4363 6242 6414 -13074 2 2 13 11 3849 5949 6323 -13075 2 2 13 11 4342 5645 6468 -13076 2 2 13 11 4343 6469 5646 -13077 2 2 13 11 4321 5688 6208 -13078 2 2 13 11 4377 5464 6825 -13079 2 2 13 11 4665 6657 5450 -13080 2 2 13 11 4405 6556 5614 -13081 2 2 13 11 4264 6432 5835 -13082 2 2 13 11 4595 6257 6135 -13083 2 2 13 11 3881 5835 6461 -13084 2 2 13 11 4479 6668 5560 -13085 2 2 13 11 4286 6314 5574 -13086 2 2 13 11 4448 6015 6240 -13087 2 2 13 11 4369 5885 6076 -13088 2 2 13 11 4371 6077 5886 -13089 2 2 13 11 4545 6415 6152 -13090 2 2 13 11 4454 5780 6492 -13091 2 2 13 11 4342 6540 5810 -13092 2 2 13 11 4343 5811 6541 -13093 2 2 13 11 3949 6559 6487 -13094 2 2 13 11 3953 6515 5987 -13095 2 2 13 11 4465 6049 6637 -13096 2 2 13 11 4466 6638 6050 -13097 2 2 13 11 3690 6889 5767 -13098 2 2 13 11 3649 6551 5618 -13099 2 2 13 11 3943 5877 6805 -13100 2 2 13 11 4296 6044 5978 -13101 2 2 13 11 3769 5428 6655 -13102 2 2 13 11 3668 5726 6229 -13103 2 2 13 11 3932 6697 6466 -13104 2 2 13 11 3854 5452 6506 -13105 2 2 13 11 4402 5859 6104 -13106 2 2 13 11 3855 6507 5453 -13107 2 2 13 11 5170 5937 6849 -13108 2 2 13 11 3952 6023 6619 -13109 2 2 13 11 4904 5830 6809 -13110 2 2 13 11 4729 6400 6145 -13111 2 2 13 11 105 5543 6348 -13112 2 2 13 11 3675 6813 5449 -13113 2 2 13 11 4351 5594 6534 -13114 2 2 13 11 4615 5978 6044 -13115 2 2 13 11 4352 6535 5595 -13116 2 2 13 11 4276 6249 6358 -13117 2 2 13 11 4597 5500 6622 -13118 2 2 13 11 4277 6359 6250 -13119 2 2 13 11 4444 5906 6105 -13120 2 2 13 11 4478 5791 6807 -13121 2 2 13 11 4579 6214 5789 -13122 2 2 13 11 3725 6257 5704 -13123 2 2 13 11 329 6481 5686 -13124 2 2 13 11 247 5687 6482 -13125 2 2 13 11 3896 5787 6295 -13126 2 2 13 11 3834 5465 6859 -13127 2 2 13 11 4261 6721 6186 -13128 2 2 13 11 3952 6849 5937 -13129 2 2 13 11 3975 5479 6845 -13130 2 2 13 11 4620 6601 5730 -13131 2 2 13 11 3913 6219 6941 -13132 2 2 13 11 4499 6149 6112 -13133 2 2 13 11 4443 5618 6551 -13134 2 2 13 11 3684 6766 5424 -13135 2 2 13 11 3699 6362 6378 -13136 2 2 13 11 3685 5425 6767 -13137 2 2 13 11 3953 6825 5464 -13138 2 2 13 11 4362 6802 5561 -13139 2 2 13 11 4228 5789 6214 -13140 2 2 13 11 4445 6418 6488 -13141 2 2 13 11 4288 5837 6320 -13142 2 2 13 11 3940 6757 6661 -13143 2 2 13 11 4295 5984 6002 -13144 2 2 13 11 3695 6444 6453 -13145 2 2 13 11 3696 6454 6445 -13146 2 2 13 11 4275 6088 5974 -13147 2 2 13 11 4626 6697 5477 -13148 2 2 13 11 3990 6471 6199 -13149 2 2 13 11 3929 6492 5780 -13150 2 2 13 11 4632 5997 6590 -13151 2 2 13 11 4373 5561 6662 -13152 2 2 13 11 4601 5913 6180 -13153 2 2 13 11 4091 6742 5420 -13154 2 2 13 11 4247 6018 6413 -13155 2 2 13 11 3861 6152 6415 -13156 2 2 13 11 4459 5969 6403 -13157 2 2 13 11 3859 6367 5923 -13158 2 2 13 11 4563 5724 6186 -13159 2 2 13 11 4380 6229 5726 -13160 2 2 13 11 4366 6784 5483 -13161 2 2 13 11 3989 5641 6433 -13162 2 2 13 11 310 5700 6912 -13163 2 2 13 11 266 6913 5701 -13164 2 2 13 11 4766 5973 6907 -13165 2 2 13 11 4580 6021 6440 -13166 2 2 13 11 5082 5662 6883 -13167 2 2 13 11 4331 5887 6651 -13168 2 2 13 11 3692 5654 6733 -13169 2 2 13 11 4823 6095 6253 -13170 2 2 13 11 3740 6748 5500 -13171 2 2 13 11 4727 6144 6463 -13172 2 2 13 11 3868 6531 5952 -13173 2 2 13 11 4379 5868 6271 -13174 2 2 13 11 3883 6058 6402 -13175 2 2 13 11 4424 6382 5818 -13176 2 2 13 11 3845 6522 5548 -13177 2 2 13 11 4547 5893 6803 -13178 2 2 13 11 4548 6804 5894 -13179 2 2 13 11 3884 6370 5970 -13180 2 2 13 11 3885 5971 6371 -13181 2 2 13 11 4444 6357 6281 -13182 2 2 13 11 3918 6401 6121 -13183 2 2 13 11 4207 6396 5634 -13184 2 2 13 11 4208 5635 6397 -13185 2 2 13 11 3770 6791 5429 -13186 2 2 13 11 4433 6203 6054 -13187 2 2 13 11 4434 6055 6204 -13188 2 2 13 11 4256 6795 5437 -13189 2 2 13 11 4257 5438 6796 -13190 2 2 13 11 4585 6281 6357 -13191 2 2 13 11 3892 6534 5594 -13192 2 2 13 11 3893 5595 6535 -13193 2 2 13 11 4506 6930 6772 -13194 2 2 13 11 3859 6149 6367 -13195 2 2 13 11 4492 6364 5731 -13196 2 2 13 11 327 6928 6091 -13197 2 2 13 11 249 6092 6929 -13198 2 2 13 11 4072 6882 6511 -13199 2 2 13 11 4819 6566 6749 -13200 2 2 13 11 4820 6750 6567 -13201 2 2 13 11 4720 6554 6492 -13202 2 2 13 11 3880 6357 6105 -13203 2 2 13 11 4858 6700 5689 -13204 2 2 13 11 4967 5707 6833 -13205 2 2 13 11 4387 5710 6499 -13206 2 2 13 11 3871 6302 6636 -13207 2 2 13 11 4116 5711 6383 -13208 2 2 13 11 4915 6651 5800 -13209 2 2 13 11 4698 6296 5696 -13210 2 2 13 11 4400 5526 6868 -13211 2 2 13 11 4328 5923 6367 -13212 2 2 13 11 3883 6402 5621 -13213 2 2 13 11 3972 6602 5769 -13214 2 2 13 11 3921 5766 6344 -13215 2 2 13 11 4545 6655 5872 -13216 2 2 13 11 4178 5614 6556 -13217 2 2 13 11 4588 6414 6242 -13218 2 2 13 11 4536 6934 5739 -13219 2 2 13 11 3908 5739 6934 -13220 2 2 13 11 3922 6662 5561 -13221 2 2 13 11 3702 6421 5660 -13222 2 2 13 11 3900 6240 6015 -13223 2 2 13 11 4267 5506 6741 -13224 2 2 13 11 4503 6461 5835 -13225 2 2 13 11 3765 6468 5645 -13226 2 2 13 11 3766 5646 6469 -13227 2 2 13 11 4598 6826 5499 -13228 2 2 13 11 4626 6466 6697 -13229 2 2 13 11 3708 6846 5504 -13230 2 2 13 11 4017 6546 6045 -13231 2 2 13 11 4018 6046 6547 -13232 2 2 13 11 4237 6864 5864 -13233 2 2 13 11 4238 5865 6865 -13234 2 2 13 11 4409 6940 6106 -13235 2 2 13 11 3832 5570 6514 -13236 2 2 13 11 4807 6502 5610 -13237 2 2 13 11 4461 6312 6230 -13238 2 2 13 11 3779 5821 6726 -13239 2 2 13 11 4210 5643 6379 -13240 2 2 13 11 3906 5523 6824 -13241 2 2 13 11 3955 5499 6669 -13242 2 2 13 11 4381 5660 6421 -13243 2 2 13 11 3940 6661 5784 -13244 2 2 13 11 4553 5525 6729 -13245 2 2 13 11 4450 6845 5479 -13246 2 2 13 11 3872 6271 5868 -13247 2 2 13 11 4549 6402 6058 -13248 2 2 13 11 4851 6941 6219 -13249 2 2 13 11 4307 6631 5580 -13250 2 2 13 11 4308 5581 6632 -13251 2 2 13 11 3873 5800 6651 -13252 2 2 13 11 3836 6478 5624 -13253 2 2 13 11 3837 5625 6479 -13254 2 2 13 11 4699 6453 6444 -13255 2 2 13 11 4700 6445 6454 -13256 2 2 13 11 4471 6321 6446 -13257 2 2 13 11 3885 5759 6347 -13258 2 2 13 11 3672 6048 6258 -13259 2 2 13 11 4533 5860 6861 -13260 2 2 13 11 4256 5878 6325 -13261 2 2 13 11 4257 6326 5879 -13262 2 2 13 11 3842 6860 5524 -13263 2 2 13 11 4085 5938 6287 -13264 2 2 13 11 4373 6781 5662 -13265 2 2 13 11 4654 6378 6362 -13266 2 2 13 11 3859 6027 6149 -13267 2 2 13 11 4310 6305 6000 -13268 2 2 13 11 4246 6159 5936 -13269 2 2 13 11 3759 6868 5526 -13270 2 2 13 11 4916 6511 6882 -13271 2 2 13 11 4275 6580 5627 -13272 2 2 13 11 4381 5524 6860 -13273 2 2 13 11 4609 6199 6471 -13274 2 2 13 11 4524 6497 5598 -13275 2 2 13 11 4699 6474 5682 -13276 2 2 13 11 4700 5683 6475 -13277 2 2 13 11 5235 6365 6653 -13278 2 2 13 11 4196 6409 5748 -13279 2 2 13 11 3823 5483 6784 -13280 2 2 13 11 4370 6149 6027 -13281 2 2 13 11 4325 5547 6885 -13282 2 2 13 11 4454 6492 6554 -13283 2 2 13 11 4720 6877 6171 -13284 2 2 13 11 3922 5561 6802 -13285 2 2 13 11 3884 5758 6370 -13286 2 2 13 11 3885 6371 5759 -13287 2 2 13 11 3878 6082 6706 -13288 2 2 13 11 4764 6911 6921 -13289 2 2 13 11 4395 6171 6877 -13290 2 2 13 11 3693 6330 5996 -13291 2 2 13 11 4519 6783 5829 -13292 2 2 13 11 4846 5673 6417 -13293 2 2 13 11 4199 6499 5710 -13294 2 2 13 11 4115 6568 5781 -13295 2 2 13 11 4475 6749 6566 -13296 2 2 13 11 4476 6567 6750 -13297 2 2 13 11 4264 5912 6259 -13298 2 2 13 11 3651 5597 6831 -13299 2 2 13 11 4364 6131 6948 -13300 2 2 13 11 4365 6949 6132 -13301 2 2 13 11 4706 6636 6302 -13302 2 2 13 11 4028 5809 6692 -13303 2 2 13 11 3950 5829 6783 -13304 2 2 13 11 3886 6874 6148 -13305 2 2 13 11 3887 6150 6875 -13306 2 2 13 11 3736 6818 6088 -13307 2 2 13 11 4160 5478 6930 -13308 2 2 13 11 4289 5869 6694 -13309 2 2 13 11 4290 6695 5870 -13310 2 2 13 11 4595 5877 6257 -13311 2 2 13 11 4438 6298 6098 -13312 2 2 13 11 4439 6099 6299 -13313 2 2 13 11 4740 6706 6082 -13314 2 2 13 11 3929 6877 6492 -13315 2 2 13 11 4461 6113 6312 -13316 2 2 13 11 4229 6803 5893 -13317 2 2 13 11 4230 5894 6804 -13318 2 2 13 11 4653 6529 6487 -13319 2 2 13 11 3932 5782 6697 -13320 2 2 13 11 4339 6287 5938 -13321 2 2 13 11 3857 6203 5939 -13322 2 2 13 11 3858 5940 6204 -13323 2 2 13 11 4504 6446 6321 -13324 2 2 13 11 3721 5650 6574 -13325 2 2 13 11 3857 6054 6203 -13326 2 2 13 11 3858 6204 6055 -13327 2 2 13 11 4211 5553 6893 -13328 2 2 13 11 4495 6652 6522 -13329 2 2 13 11 3980 6861 5860 -13330 2 2 13 11 3896 6295 6283 -13331 2 2 13 11 4362 6656 5876 -13332 2 2 13 11 3896 6113 6193 -13333 2 2 13 11 4598 6843 5511 -13334 2 2 13 11 4425 6022 6248 -13335 2 2 13 11 3778 6920 5760 -13336 2 2 13 11 4400 6838 5526 -13337 2 2 13 11 4660 6661 6757 -13338 2 2 13 11 3755 6758 6517 -13339 2 2 13 11 4305 5740 6437 -13340 2 2 13 11 4306 6438 5741 -13341 2 2 13 11 4948 6735 5611 -13342 2 2 13 11 4384 5753 6552 -13343 2 2 13 11 3843 6687 6601 -13344 2 2 13 11 4361 5985 6238 -13345 2 2 13 11 3841 5959 6775 -13346 2 2 13 11 4394 6361 6081 -13347 2 2 13 11 4294 6199 6603 -13348 2 2 13 11 4502 6486 6399 -13349 2 2 13 11 4552 6258 6048 -13350 2 2 13 11 3656 5840 6449 -13351 2 2 13 11 4461 6313 6193 -13352 2 2 13 11 4461 6193 6113 -13353 2 2 13 11 4458 5996 6330 -13354 2 2 13 11 4310 5952 6531 -13355 2 2 13 11 3877 6933 5657 -13356 2 2 13 11 3845 6936 6522 -13357 2 2 13 11 4383 5643 6740 -13358 2 2 13 11 5144 6404 6442 -13359 2 2 13 11 4802 5947 6952 -13360 2 2 13 11 3896 6321 6113 -13361 2 2 13 11 4379 6818 6065 -13362 2 2 13 11 4503 6644 6461 -13363 2 2 13 11 4447 6582 5900 -13364 2 2 13 11 4607 6098 6298 -13365 2 2 13 11 4608 6299 6099 -13366 2 2 13 11 4492 5781 6568 -13367 2 2 13 11 3712 6442 6404 -13368 2 2 13 11 4451 6233 6283 -13369 2 2 13 11 3809 5670 6704 -13370 2 2 13 11 3701 6683 5673 -13371 2 2 13 11 4456 6014 6452 -13372 2 2 13 11 3712 6950 5623 -13373 2 2 13 11 4755 6127 6741 -13374 2 2 13 11 4462 6147 6835 -13375 2 2 13 11 4413 6691 5716 -13376 2 2 13 11 3689 6253 6095 -13377 2 2 13 11 4374 5832 6393 -13378 2 2 13 11 4375 6394 5833 -13379 2 2 13 11 4794 6601 6687 -13380 2 2 13 11 3948 6659 5702 -13381 2 2 13 11 4522 5918 6645 -13382 2 2 13 11 4523 6646 5919 -13383 2 2 13 11 3819 5662 6781 -13384 2 2 13 11 4503 5835 6432 -13385 2 2 13 11 4773 6543 6806 -13386 2 2 13 11 4535 6692 5809 -13387 2 2 13 11 4223 6952 5947 -13388 2 2 13 11 4546 6918 6732 -13389 2 2 13 11 4703 6928 5588 -13390 2 2 13 11 4704 5589 6929 -13391 2 2 13 11 4660 5666 6661 -13392 2 2 13 11 4451 6283 6295 -13393 2 2 13 11 4609 6603 6199 -13394 2 2 13 11 3982 6740 5643 -13395 2 2 13 11 3739 6755 6042 -13396 2 2 13 11 3820 6590 5735 -13397 2 2 13 11 3904 6866 5578 -13398 2 2 13 11 3949 6487 6529 -13399 2 2 13 11 153 5668 6664 -13400 2 2 13 11 68 6665 5669 -13401 2 2 13 11 4437 5579 6891 -13402 2 2 13 11 4200 6652 6122 -13403 2 2 13 11 3852 6623 5762 -13404 2 2 13 11 4409 6310 6940 -13405 2 2 13 11 3697 6901 6101 -13406 2 2 13 11 3863 6752 5682 -13407 2 2 13 11 3864 5683 6753 -13408 2 2 13 11 3929 6212 6877 -13409 2 2 13 11 4670 5920 6412 -13410 2 2 13 11 3897 5810 6540 -13411 2 2 13 11 3898 6541 5811 -13412 2 2 13 11 4776 6773 6620 -13413 2 2 13 11 4414 5762 6559 -13414 2 2 13 11 4799 6517 6758 -13415 2 2 13 11 4504 6283 6233 -13416 2 2 13 11 4458 5792 6640 -13417 2 2 13 11 3733 5714 6939 -13418 2 2 13 11 4419 6892 5923 -13419 2 2 13 11 3872 5600 6953 -13420 2 2 13 11 4701 5608 6887 -13421 2 2 13 11 4254 6553 6704 -13422 2 2 13 11 4402 6939 5714 -13423 2 2 13 11 4831 5899 6462 -13424 2 2 13 11 5000 5705 6785 -13425 2 2 13 11 3894 6530 5933 -13426 2 2 13 11 3914 6230 6312 -13427 2 2 13 11 4367 5769 6602 -13428 2 2 13 11 4471 6312 6113 -13429 2 2 13 11 4512 5657 6933 -13430 2 2 13 11 3753 6851 5593 -13431 2 2 13 11 4586 6461 6644 -13432 2 2 13 11 5064 6737 5861 -13433 2 2 13 11 4450 5653 6845 -13434 2 2 13 11 3883 5906 6486 -13435 2 2 13 11 4709 6888 6384 -13436 2 2 13 11 4418 5751 6619 -13437 2 2 13 11 4500 5623 6950 -13438 2 2 13 11 3729 5900 6582 -13439 2 2 13 11 3883 6486 6058 -13440 2 2 13 11 4841 6756 5723 -13441 2 2 13 11 4872 6785 5705 -13442 2 2 13 11 4279 6902 6181 -13443 2 2 13 11 4610 6355 6408 -13444 2 2 13 11 4267 6741 6127 -13445 2 2 13 11 4459 5762 6623 -13446 2 2 13 11 4487 6246 6515 -13447 2 2 13 11 4246 5771 6654 -13448 2 2 13 11 3918 6103 6406 -13449 2 2 13 11 4069 6620 6773 -13450 2 2 13 11 4449 6570 5988 -13451 2 2 13 11 3724 6656 6480 -13452 2 2 13 11 4541 6806 6543 -13453 2 2 13 11 4471 6113 6321 -13454 2 2 13 11 4563 6186 6721 -13455 2 2 13 11 4902 6714 6716 -13456 2 2 13 11 5001 6413 6018 -13457 2 2 13 11 4764 6120 6911 -13458 2 2 13 11 3988 6216 6622 -13459 2 2 13 11 5339 5722 6761 -13460 2 2 13 11 4471 6446 6258 -13461 2 2 13 11 4477 6710 6248 -13462 2 2 13 11 4249 5785 6728 -13463 2 2 13 11 4493 6193 6313 -13464 2 2 13 11 305 6452 6014 -13465 2 2 13 11 3896 6283 6321 -13466 2 2 13 11 4323 6148 6874 -13467 2 2 13 11 4324 6875 6150 -13468 2 2 13 11 4952 6122 6652 -13469 2 2 13 11 4463 5874 6571 -13470 2 2 13 11 5005 6406 6103 -13471 2 2 13 11 4594 6278 6501 -13472 2 2 13 11 4699 6444 6926 -13473 2 2 13 11 4700 6927 6445 -13474 2 2 13 11 3988 6384 6888 -13475 2 2 13 11 4536 6505 6934 -13476 2 2 13 11 4450 5760 6920 -13477 2 2 13 11 4499 6367 6149 -13478 2 2 13 11 4536 5961 6505 -13479 2 2 13 11 3895 6081 6361 -13480 2 2 13 11 4549 5990 6402 -13481 2 2 13 11 4443 6876 6227 -13482 2 2 13 11 4310 6531 6305 -13483 2 2 13 11 4411 6045 6546 -13484 2 2 13 11 4412 6547 6046 -13485 2 2 13 11 4368 5821 6699 -13486 2 2 13 11 3730 5962 6470 -13487 2 2 13 11 4411 6546 5822 -13488 2 2 13 11 4412 5823 6547 -13489 2 2 13 11 4415 6720 6119 -13490 2 2 13 11 4504 6321 6283 -13491 2 2 13 11 3944 6331 6814 -13492 2 2 13 11 4602 6912 5700 -13493 2 2 13 11 4603 5701 6913 -13494 2 2 13 11 4377 5933 6530 -13495 2 2 13 11 4597 6921 6911 -13496 2 2 13 11 3721 5998 6586 -13497 2 2 13 11 4433 5772 6847 -13498 2 2 13 11 4434 6848 5773 -13499 2 2 13 11 4368 6726 5821 -13500 2 2 13 11 3716 6408 6355 -13501 2 2 13 11 4471 6258 6489 -13502 2 2 13 11 4892 6874 5754 -13503 2 2 13 11 4893 5755 6875 -13504 2 2 13 11 4279 5814 6820 -13505 2 2 13 11 4983 6720 6464 -13506 2 2 13 11 5072 6645 6182 -13507 2 2 13 11 5073 6183 6646 -13508 2 2 13 11 4502 6058 6486 -13509 2 2 13 11 3871 6565 6302 -13510 2 2 13 11 3952 6619 6849 -13511 2 2 13 11 3807 6734 5964 -13512 2 2 13 11 4486 6816 5788 -13513 2 2 13 11 3808 5965 6852 -13514 2 2 13 11 4452 6922 5796 -13515 2 2 13 11 4448 6716 6714 -13516 2 2 13 11 3673 6505 5961 -13517 2 2 13 11 4788 6708 6781 -13518 2 2 13 11 3711 6441 6630 -13519 2 2 13 11 4444 6105 6357 -13520 2 2 13 11 98 6268 6410 -13521 2 2 13 11 5243 6320 6595 -13522 2 2 13 11 4510 6474 6591 -13523 2 2 13 11 4511 6592 6475 -13524 2 2 13 11 3722 6068 6885 -13525 2 2 13 11 4639 6630 6441 -13526 2 2 13 11 4635 6761 5722 -13527 2 2 13 11 4555 6045 6625 -13528 2 2 13 11 4556 6626 6046 -13529 2 2 13 11 4887 6467 6496 -13530 2 2 13 11 3905 5988 6570 -13531 2 2 13 11 4697 6551 6701 -13532 2 2 13 11 4597 6622 6216 -13533 2 2 13 11 4345 6145 6400 -13534 2 2 13 11 3690 5744 6889 -13535 2 2 13 11 3721 6399 6281 -13536 2 2 13 11 4697 5743 6876 -13537 2 2 13 11 4832 6934 6505 -13538 2 2 13 11 4505 6410 6268 -13539 2 2 13 11 4444 6281 6399 -13540 2 2 13 11 3811 6900 5858 -13541 2 2 13 11 3714 6847 5772 -13542 2 2 13 11 3715 5773 6848 -13543 2 2 13 11 4552 6489 6258 -13544 2 2 13 11 3724 5876 6656 -13545 2 2 13 11 4477 6042 6755 -13546 2 2 13 11 4684 6666 6598 -13547 2 2 13 11 4685 6599 6667 -13548 2 2 13 11 4770 6757 6696 -13549 2 2 13 11 4348 6463 6144 -13550 2 2 13 11 3819 6781 6708 -13551 2 2 13 11 3873 6651 5887 -13552 2 2 13 11 4845 6790 6890 -13553 2 2 13 11 3723 6887 5871 -13554 2 2 13 11 4458 6724 5996 -13555 2 2 13 11 4987 6798 5932 -13556 2 2 13 11 3684 6006 6766 -13557 2 2 13 11 3685 6767 6007 -13558 2 2 13 11 3843 6601 6398 -13559 2 2 13 11 3706 6595 6320 -13560 2 2 13 11 4383 6740 5839 -13561 2 2 13 11 4583 6528 6493 -13562 2 2 13 11 4769 6754 6069 -13563 2 2 13 11 3956 5932 6798 -13564 2 2 13 11 4426 6687 6409 -13565 2 2 13 11 4684 6520 6666 -13566 2 2 13 11 4685 6667 6521 -13567 2 2 13 11 4663 6341 6878 -13568 2 2 13 11 4664 6879 6343 -13569 2 2 13 11 3672 6258 6446 -13570 2 2 13 11 4576 6706 6553 -13571 2 2 13 11 3649 6701 6551 -13572 2 2 13 11 3671 6084 6843 -13573 2 2 13 11 3940 6696 6757 -13574 2 2 13 11 3974 6647 6072 -13575 2 2 13 11 4355 6878 6341 -13576 2 2 13 11 4356 6343 6879 -13577 2 2 13 11 4546 6823 6213 -13578 2 2 13 11 93 6853 5806 -13579 2 2 13 11 4003 6890 6790 -13580 2 2 13 11 4507 6598 6666 -13581 2 2 13 11 4508 6667 6599 -13582 2 2 13 11 4131 5948 6835 -13583 2 2 13 11 4834 6850 6832 -13584 2 2 13 11 4694 5858 6900 -13585 2 2 13 11 3990 6858 6471 -13586 2 2 13 11 4287 5996 6724 -13587 2 2 13 11 4388 6496 6467 -13588 2 2 13 11 4675 6800 5851 -13589 2 2 13 11 4279 5776 6902 -13590 2 2 13 11 4456 6072 6647 -13591 2 2 13 11 4316 6819 6008 -13592 2 2 13 11 4653 6487 6403 -13593 2 2 13 11 4342 6172 6617 -13594 2 2 13 11 4343 6618 6173 -13595 2 2 13 11 4535 6515 6246 -13596 2 2 13 11 5018 6792 6178 -13597 2 2 13 11 5019 6179 6793 -13598 2 2 13 11 4009 6213 6823 -13599 2 2 13 11 3863 5897 6924 -13600 2 2 13 11 3864 6925 5898 -13601 2 2 13 11 3914 6312 6489 -13602 2 2 13 11 4529 6832 6850 -13603 2 2 13 11 4532 6766 6006 -13604 2 2 13 11 4533 6007 6767 -13605 2 2 13 11 3859 5923 6892 -13606 2 2 13 11 4503 6428 6644 -13607 2 2 13 11 3778 5866 6920 -13608 2 2 13 11 4455 6501 6278 -13609 2 2 13 11 4832 6505 6668 -13610 2 2 13 11 4620 6398 6601 -13611 2 2 13 11 4471 6489 6312 -13612 2 2 13 11 4462 6835 5948 -13613 2 2 13 11 4497 6170 6779 -13614 2 2 13 11 4580 6440 6745 -13615 2 2 13 11 3666 6666 6520 -13616 2 2 13 11 3667 6521 6667 -13617 2 2 13 11 4617 6675 6511 -13618 2 2 13 11 4515 6493 6528 -13619 2 2 13 11 4435 6775 5959 -13620 2 2 13 11 4459 6403 6487 -13621 2 2 13 11 4713 6471 6858 -13622 2 2 13 11 100 6769 6166 -13623 2 2 13 11 4197 6946 5807 -13624 2 2 13 11 4740 6553 6706 -13625 2 2 13 11 4221 6069 6754 -13626 2 2 13 11 4907 6568 6260 -13627 2 2 13 11 3726 6297 6779 -13628 2 2 13 11 4482 6305 6531 -13629 2 2 13 11 4402 6104 6939 -13630 2 2 13 11 4224 6032 6886 -13631 2 2 13 11 4115 6260 6568 -13632 2 2 13 11 331 6942 5966 -13633 2 2 13 11 245 5967 6943 -13634 2 2 13 11 4452 6765 6006 -13635 2 2 13 11 4796 6779 6297 -13636 2 2 13 11 4245 5900 6918 -13637 2 2 13 11 4204 6019 6862 -13638 2 2 13 11 4205 6863 6020 -13639 2 2 13 11 4786 6726 6331 -13640 2 2 13 11 4230 6804 6192 -13641 2 2 13 11 3731 6182 6645 -13642 2 2 13 11 3732 6646 6183 -13643 2 2 13 11 4784 6678 6786 -13644 2 2 13 11 4785 6787 6679 -13645 2 2 13 11 4072 6511 6675 -13646 2 2 13 11 4491 6302 6565 -13647 2 2 13 11 4525 6235 6681 -13648 2 2 13 11 4697 6876 6551 -13649 2 2 13 11 3806 6044 6756 -13650 2 2 13 11 4720 6492 6877 -13651 2 2 13 11 4854 6333 6602 -13652 2 2 13 11 4924 6746 6807 -13653 2 2 13 11 3721 6586 6399 -13654 2 2 13 11 3736 6065 6818 -13655 2 2 13 11 4488 6786 6678 -13656 2 2 13 11 4489 6679 6787 -13657 2 2 13 11 4316 6264 6819 -13658 2 2 13 11 4957 6101 6743 -13659 2 2 13 11 4517 6630 6589 -13660 2 2 13 11 4533 6861 6007 -13661 2 2 13 11 3980 6674 6861 -13662 2 2 13 11 4554 6166 6769 -13663 2 2 13 11 3983 6248 6710 -13664 2 2 13 11 5151 6192 6804 -13665 2 2 13 11 3930 6681 6235 -13666 2 2 13 11 4542 6527 6923 -13667 2 2 13 11 4544 6886 6032 -13668 2 2 13 11 3856 6106 6940 -13669 2 2 13 11 3726 6779 6170 -13670 2 2 13 11 3996 6591 6474 -13671 2 2 13 11 3997 6475 6592 -13672 2 2 13 11 4368 6331 6726 -13673 2 2 13 11 4542 6923 6620 -13674 2 2 13 11 4572 6642 6634 -13675 2 2 13 11 4573 6635 6643 -13676 2 2 13 11 3677 6267 6762 -13677 2 2 13 11 5140 6772 6318 -13678 2 2 13 11 4443 6551 6876 -13679 2 2 13 11 4346 6653 6365 -13680 2 2 13 11 4478 6807 6746 -13681 2 2 13 11 3924 6060 6821 -13682 2 2 13 11 3925 6822 6061 -13683 2 2 13 11 4367 6602 6333 -13684 2 2 13 11 3659 6318 6772 -13685 2 2 13 11 4502 6399 6586 -13686 2 2 13 11 3924 6821 6422 -13687 2 2 13 11 3925 6423 6822 -13688 2 2 13 11 4736 6899 6731 -13689 2 2 13 11 4639 6589 6630 -13690 2 2 13 11 3740 6911 6120 -13691 2 2 13 11 5100 6585 6523 -13692 2 2 13 11 4437 6101 6901 -13693 2 2 13 11 4093 6644 6428 -13694 2 2 13 11 4629 6634 6642 -13695 2 2 13 11 4630 6643 6635 -13696 2 2 13 11 3889 6625 6391 -13697 2 2 13 11 3890 6392 6626 -13698 2 2 13 11 4726 6542 6834 -13699 2 2 13 11 4502 6937 6058 -13700 2 2 13 11 4702 6834 6542 -13701 2 2 13 11 3895 6935 6081 -13702 2 2 13 11 5186 6884 6390 -13703 2 2 13 11 3673 6668 6505 -13704 2 2 13 11 4395 6877 6212 -13705 2 2 13 11 3748 6731 6899 -13706 2 2 13 11 4829 6510 6688 -13707 2 2 13 11 4474 6919 6138 -13708 2 2 13 11 4415 6464 6720 -13709 2 2 13 11 270 6707 6873 -13710 2 2 13 11 4629 6642 6540 -13711 2 2 13 11 4630 6541 6643 -13712 2 2 13 11 3796 6725 6788 -13713 2 2 13 11 3773 6523 6585 -13714 2 2 13 11 4565 6762 6267 -13715 2 2 13 11 4570 6745 6440 -13716 2 2 13 11 4753 6819 6264 -13717 2 2 13 11 5366 6847 6518 -13718 2 2 13 11 5367 6519 6848 -13719 2 2 13 11 4178 6556 6689 -13720 2 2 13 11 3897 6540 6642 -13721 2 2 13 11 3898 6643 6541 -13722 2 2 13 11 4901 6689 6556 -13723 2 2 13 11 4497 6951 6170 -13724 2 2 13 11 3892 6948 6131 -13725 2 2 13 11 3893 6132 6949 -13726 2 2 13 11 4490 6390 6884 -13727 2 2 13 11 3714 6518 6847 -13728 2 2 13 11 3715 6848 6519 -13729 2 2 13 11 3754 6688 6510 -13730 2 2 13 11 4467 6839 6290 -13731 2 2 13 11 4468 6291 6840 -13732 2 2 13 11 4767 6873 6707 -13733 2 2 13 11 3931 6589 6815 -13734 2 2 13 11 4740 6704 6553 -13735 2 2 13 11 4777 6870 6407 -13736 2 2 13 11 4724 6788 6725 -13737 2 2 13 11 4879 6940 6310 -13738 2 2 13 11 4728 6407 6870 -13739 2 2 13 11 4746 6484 6901 -13740 2 2 13 11 4477 6755 6710 -13741 2 2 13 11 4256 6685 6795 -13742 2 2 13 11 4257 6796 6686 -13743 2 2 13 11 4639 6815 6589 -13744 2 2 13 11 4978 6795 6685 -13745 2 2 13 11 4979 6686 6796 -13746 2 2 13 11 4538 6926 6444 -13747 2 2 13 11 4539 6445 6927 -13748 2 2 13 11 4886 6710 6755 -13749 2 2 13 11 4437 6901 6484 -13750 2 2 13 11 3873 6923 6527 -13751 2 2 13 11 4776 6620 6923 -13752 2 2 13 11 4645 6854 6858 -13753 2 2 13 11 4495 6522 6936 -13754 2 2 13 11 4546 6732 6823 -13755 2 2 13 11 4790 6823 6732 -13756 2 2 13 11 4618 6811 6867 -13757 2 2 13 11 4619 6869 6812 -13758 2 2 13 11 333 6908 6916 -13759 2 2 13 11 243 6917 6909 -13760 2 2 13 11 4713 6858 6854 -13761 2 2 13 11 4639 6888 6815 -13762 2 2 13 11 4756 6867 6811 -13763 2 2 13 11 4757 6812 6869 -13764 2 2 13 11 4709 6815 6888 -13765 2 2 13 11 4747 6916 6908 -13766 2 2 13 11 4748 6909 6917 -$EndElements diff --git a/test/mixeddimension/facet/1p_1p/matrixproblem.hh b/test/mixeddimension/facet/1p_1p/matrixproblem.hh deleted file mode 100644 index 056ca01aeefa3284aaedd20bad2bec8955a6fcf3..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p_1p/matrixproblem.hh +++ /dev/null @@ -1,210 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief A test problem for the one-phase model: - * water is flowing from bottom to top through and around a low permeable lens. - */ -#ifndef DUMUX_1PMATRIX_PROBLEM_HH -#define DUMUX_1PMATRIX_PROBLEM_HH - -#include <dumux/mixeddimension/facet/mpfa/properties.hh> -#include <dumux/mixeddimension/subproblemproperties.hh> - -#include <dumux/porousmediumflow/1p/model.hh> -#include <dumux/porousmediumflow/implicit/problem.hh> - -#include <dumux/material/components/unit.hh> -#include <dumux/material/fluidsystems/liquidphase.hh> -#include <dumux/material/fluidsystems/1p.hh> - -#include "matrixspatialparams.hh" - -namespace Dumux -{ -template <class TypeTag> -class OnePMpfaMatrixProblem; - -namespace Properties -{ -NEW_TYPE_TAG(OnePMatrixProblem, INHERITS_FROM(OneP)); -NEW_TYPE_TAG(OnePCCMpfaMatrixProblem, INHERITS_FROM(FacetCouplingBulkMpfaModel, OnePMatrixProblem)); - -// the fluid system -SET_PROP(OnePFractureProblem, FluidSystem) -{ - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using type = FluidSystems::OneP<Scalar, FluidSystems::LiquidPhase<Scalar, Components::Constant<1, Scalar> > >; -}; - -// Set the problem property -SET_TYPE_PROP(OnePMatrixProblem, Problem, OnePMpfaMatrixProblem<TypeTag>); - -// Set the spatial parameters -SET_TYPE_PROP(OnePMatrixProblem, SpatialParams, OnePMatrixSpatialParams<TypeTag>); - -// Linear solver settings -SET_TYPE_PROP(OnePMatrixProblem, LinearSolver, SuperLUBackend<TypeTag>); - -// Enable gravity -SET_BOOL_PROP(OnePMatrixProblem, ProblemEnableGravity, false); - -// change mpfa method -//SET_PROP(OnePMatrixProblem, MpfaMethod) { static const MpfaMethods value = MpfaMethods::lMethod; }; -} - -/*! - * \ingroup OnePModel - * \ingroup ImplicitTestProblems - * \brief Test problem for the one-phase model - */ - -template <class TypeTag> -class OnePMpfaMatrixProblem : public ImplicitPorousMediaProblem<TypeTag> -{ - using ParentType = ImplicitPorousMediaProblem<TypeTag>; - - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using Intersection = typename GridView::Intersection; - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using Indices = typename GET_PROP_TYPE(TypeTag, Indices); - using TimeManager = typename GET_PROP_TYPE(TypeTag, TimeManager); - using BoundaryTypes = typename GET_PROP_TYPE(TypeTag, BoundaryTypes); - using PrimaryVariables = typename GET_PROP_TYPE(TypeTag, PrimaryVariables); - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - using SubControlVolume = typename GET_PROP_TYPE(TypeTag, SubControlVolume); - using SubControlVolumeFace = typename GET_PROP_TYPE(TypeTag, SubControlVolumeFace); - using ElementVolumeVariables = typename GET_PROP_TYPE(TypeTag, ElementVolumeVariables); - - using GlobalProblemTypeTag = typename GET_PROP_TYPE(TypeTag, GlobalProblemTypeTag); - using CouplingManager = typename GET_PROP_TYPE(GlobalProblemTypeTag, CouplingManager); - - enum - { - conti0EqIdx = Indices::conti0EqIdx, - pressureIdx = Indices::pressureIdx - }; - - static constexpr int numEq = GET_PROP_VALUE(TypeTag, NumEq); - static constexpr int dim = GridView::dimension; - static constexpr int dimWorld = GridView::dimensionworld; - - using GlobalPosition = Dune::FieldVector<Scalar, dimWorld>; - - -public: - OnePMpfaMatrixProblem(TimeManager &timeManager, const GridView &gridView) - : ParentType(timeManager, gridView) - { - name_ = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, std::string, Problem, Name) + "_matrix"; - eps_ = 1e-6; - } - - /*! - * \brief The problem name. - * - * This is used as a prefix for files generated by the simulation. - */ - const std::string& name() const - { return name_; } - - /*! - * \brief Return the temperature within the domain in [K]. - * - * This problem assumes a temperature of 10 degrees Celsius. - */ - Scalar temperature() const - { return 273.15 + 10; } - - /*! - * \brief Return the sources within the domain. - */ - PrimaryVariables sourceAtPos(const GlobalPosition& globalPos) const - { return PrimaryVariables(0.0); } - - /*! - * \brief Specifies which kind of boundary condition should be - * used for which equation on a given boundary control volume. - */ - BoundaryTypes boundaryTypes(const Element& element, const SubControlVolumeFace& scvf) const - { - BoundaryTypes values; - const auto globalPos = scvf.ipGlobal(); - - values.setAllNeumann(); - if (globalPos[1] < eps_ || globalPos[1] > this->bBoxMax()[1] - eps_) - values.setAllDirichlet(); - - if (couplingManager().isInteriorBoundary(element, scvf)) - values.setAllNeumann(); - - return values; - } - - /*! - * \brief Specifies if a given intersection is on an interior boundary - */ - bool isInteriorBoundary(const Element& element, const Intersection& is) const - { return couplingManager().isInteriorBoundary(element, is); } - - /*! - * \brief Evaluate the boundary conditions for a dirichlet - * control volume. - */ - PrimaryVariables dirichletAtPos(const GlobalPosition& globalPos) const - { - PrimaryVariables values; - values[pressureIdx] = 1.0 + 0.5*globalPos[1]; - return values; - } - - /*! - * \brief Evaluate the boundary conditions for a neumann - * boundary segment. - */ - PrimaryVariables neumannAtPos(const GlobalPosition& globalPos) const - { return PrimaryVariables(0.0); } - - /*! - * \brief Evaluate the initial value for a control volume. - */ - PrimaryVariables initialAtPos(const GlobalPosition& globalPos) const - { - Scalar p = 1.0 + globalPos[1]/this->bBoxMax()[1]; - return PrimaryVariables(p); - } - - //! Set the coupling manager - void setCouplingManager(std::shared_ptr<CouplingManager> cm) - { couplingManager_ = cm; } - - //! Get the coupling manager - const CouplingManager& couplingManager() const - { return *couplingManager_; } - -private: - std::string name_; - Scalar eps_; - std::shared_ptr<CouplingManager> couplingManager_; -}; -} //end namespace - -#endif diff --git a/test/mixeddimension/facet/1p_1p/matrixspatialparams.hh b/test/mixeddimension/facet/1p_1p/matrixspatialparams.hh deleted file mode 100644 index 138b36a64aa332474e9ca4e34fb9da84fe7fc85b..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p_1p/matrixspatialparams.hh +++ /dev/null @@ -1,86 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief The spatial parameters class for the matrix problem - */ -#ifndef DUMUX_1P_MATRIX_SPATIALPARAMS_HH -#define DUMUX_1P_MATRIX_SPATIALPARAMS_HH - -#include <dumux/material/spatialparams/fv1p.hh> - -namespace Dumux -{ - -/*! - * \ingroup OnePModel - * \ingroup ImplicitTestProblems - * - * \brief The spatial parameters class for the matrix problem - */ -template<class TypeTag> -class OnePMatrixSpatialParams : public FVSpatialParamsOneP<TypeTag> -{ - using ParentType = FVSpatialParamsOneP<TypeTag>; - - using Scalar = typename GET_PROP_TYPE(TypeTag, Scalar); - using Problem = typename GET_PROP_TYPE(TypeTag, Problem); - using GridView = typename GET_PROP_TYPE(TypeTag, GridView); - using Element = typename GridView::template Codim<0>::Entity; - using FVElementGeometry = typename GET_PROP_TYPE(TypeTag, FVElementGeometry); - - static constexpr int dimWorld = GridView::dimensionworld; - using GlobalPosition = Dune::FieldVector<Scalar,dimWorld>; - - using Tensor = Dune::FieldMatrix<Scalar, dimWorld, dimWorld>; - -public: - using PermeabilityType = Tensor; - - OnePMatrixSpatialParams(const Problem& problem, const GridView& gridView) - : ParentType(problem, gridView) - { - Scalar permeability = GET_RUNTIME_PARAM_FROM_GROUP(TypeTag, Scalar, SpatialParams, MatrixPermeability); - - K_[0][0] = permeability; - K_[1][1] = permeability; - K_[0][1] = 0.; - K_[1][0] = 0.; - } - - /*! - * \brief Return the intrinsic permeability for the given position in [m^2]. - */ - Tensor permeabilityAtPos(const GlobalPosition& globalPos) const - { return K_; } - - /*! - * \brief Define the porosity in [-]. - */ - Scalar porosityAtPos(const GlobalPosition& globalPos) const - { return 0.25; } - - -private: - Tensor K_; -}; -} //end namespace - -#endif diff --git a/test/mixeddimension/facet/1p_1p/test_fracture_1p_1p.cc b/test/mixeddimension/facet/1p_1p/test_fracture_1p_1p.cc deleted file mode 100644 index 23f7457e3297c6759efc4dc3e97030df8cf29447..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p_1p/test_fracture_1p_1p.cc +++ /dev/null @@ -1,45 +0,0 @@ -// -*- mode: C++; tab-width: 4; indent-tabs-mode: nil; c-basic-offset: 4 -*- -// vi: set et ts=4 sw=4 sts=4: -/***************************************************************************** - * See the file COPYING for full copying permissions. * - * * - * This program is free software: you can redistribute it and/or modify * - * it under the terms of the GNU General Public License as published by * - * the Free Software Foundation, either version 2 of the License, or * - * (at your option) any later version. * - * * - * This program is distributed in the hope that it will be useful, * - * but WITHOUT ANY WARRANTY; without even the implied warranty of * - * MERCHANTABILITY or FITNESS FOR A PARTICULAR PURPOSE. See the * - * GNU General Public License for more details. * - * * - * You should have received a copy of the GNU General Public License * - * along with this program. If not, see <http://www.gnu.org/licenses/>. * - *****************************************************************************/ -/*! - * \file - * - * \brief test for the 1d 3d cell-centered coupled model - */ -#include "config.h" -#include "1d2dtestproblem.hh" -#include <dumux/mixeddimension/facet/start.hh> - -/*! - * \brief Provides an interface for customizing error messages associated with - * reading in parameters. - * - * \param progName The name of the program, that was tried to be started. - * \param errorMsg The error message that was issued by the start function. - * Comprises the thing that went wrong and a general help message. - */ -void usage(const char *progName, const std::string &errorMsg) -{ - // TODO -} - -int main(int argc, char** argv) -{ - using ProblemTypeTag = TTAG(OnePFacetCoupling); - return Dumux::start<ProblemTypeTag>(argc, argv, usage); -} diff --git a/test/mixeddimension/facet/1p_1p/test_fracture_1p_1p.input b/test/mixeddimension/facet/1p_1p/test_fracture_1p_1p.input deleted file mode 100644 index 96b275c2da7a92e80d075c9f2309629f156c2e7e..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/1p_1p/test_fracture_1p_1p.input +++ /dev/null @@ -1,33 +0,0 @@ -[TimeManager] -DtInitial = 1 # [s] -TEnd = 1 # [s] -MaxTimeStepSize = 1 -DtInitialBulkProblem = 1 # [s] -DtInitialLowDimProblem = 1 # [s] -EpisodeTime = 1 # [s] - -[Grid] -File = ./grids/simplefracture_long.msh - -[Problem] -Name = test_1dfracture - -[MixedDimension] -UseIterativeSolver = False - -[IterativeAlgorithm] -MaxIterations = 100 -Tolerance = 1.0e-8 -Verbose = 1 - -[SpatialParams] -FractureAperture = 1e-1 # [m] -FracturePermeability = 1e-15 # [m^2] -MatrixPermeability = 1e-14 # [m^2] - -[Vtk] -AddVelocity = False - -[Newton] -MaxRelativeShift = 1e-5 -MaxSteps = 20 diff --git a/test/mixeddimension/facet/CMakeLists.txt b/test/mixeddimension/facet/CMakeLists.txt deleted file mode 100644 index 414572638497a6f9403cd690015c101d7e0b59a7..0000000000000000000000000000000000000000 --- a/test/mixeddimension/facet/CMakeLists.txt +++ /dev/null @@ -1,2 +0,0 @@ -add_subdirectory("1p_1p") -add_subdirectory("1p2c_1p2c") \ No newline at end of file